SDT-base
Contents
 
Functions
   
PDF
Index
Chapter 1 Preface
Preface
Contact information
Getting started by area
Area 1: Experimental modal analysis
Area 2: Test/analysis correlation
Area 3: Basic finite element analysis
Area 4: Advanced FE analysis (model reduction, component mode synthesis, families of models)
Key notions in SDT architecture
functions, commands
command string and structure options (CAM,Cam,RO)
Stack
GUI Graphical User Interfaces
pointers (and global variables)
Database nodes : structures used for typical data
Typesetting conventions and scientific notations
Other toolboxes from SDTools
Licensing utilities
Installation procedure (SDT >= 7.2)
Floating license installation
Floating license usage
Release notes for SDT and FEMLink 7.5
Key features
Notes by MATLAB release
Detail by function
Developer notes
Release notes for SDT and FEMLink 7.4
Key features
Notes by MATLAB release
Release notes for SDT and FEMLink 7.3
Key features
Notes by MATLAB release
Release notes for SDT and FEMLink 7.1
Key features
Detail by function
Notes by MATLAB release
Release notes for SDT and FEMLink 7.0
Key features
Detail by function
Notes by MATLAB release
Chapter 2 Modal test tutorial
Modal test tutorial
iiplot figure tutorial
The main figure
Toolbar
Interactivity: keyboard, scroll, mouse
Context menus
The curve stack
Handling what you display, axes and channel tabs
Channel tab usage
Handling displayed units and labels
SDT 5 compatibility
iiplot for signal processing
iiplot FAQ
Identification of modal properties (Id dock)
Interactive data loading
Opening and description of used data
General process
Importing FRF data
Write a script to build a transfer structure
Data acquisition
Pole initialization (IdAlt and IdMain filling)
External pole estimation
LSCF
Single pole estimate
Band to pole estimate
Direct system parameter identification algorithm
Orthogonal polynomial identification algorithm
Identification options
Estimate shapes from poles
Broadband, narrowband, ... selecting the strategy
Qual
: Estimation of pole and shape quality
When
id_rc
fails
Update poles
Eup : for a clean measurement with multiple poles
Eopt : for a band with few poles
EupSeq and EoptSeq : sequential narrowband pole updating
Example for practice
Background theory
Identification by block
Data format
Example for practice
Display shapes : geometry declaration, pre-test
Modal test geometry declaration
Sensor/shaker configurations
Animating test data, operational deflection shapes
MIMO, Reciprocity, State-space, ...
Multiplicity (minimal state-space model)
Reciprocal models of structures
Normal mode form
Modal damping assumption
Non proportional damping assumption
Chapter 3 Test/analysis correlation tutorial
Test/analysis correlation tutorial
Topology correlation and test preparation
Defining sensors in the FEM model : data handling
Test and FEM coordinate systems
Sensor/shaker placement
Test/analysis correlation
Shape based criteria
Energy based criteria
Correlation of FRFs
Expansion methods
Underlying theory for expansion methods
Basic interpolation methods for unmeasured DOFs
Subspace based expansion methods
Model based expansion methods
Structural dynamic modification
SDT numerical experiments (DOE)
RunCfg : execution of computations
Virtual testing
Chapter 4 FEM tutorial
FEM tutorial
FE mesh declaration
Direct declaration of geometry (truss example)
Building models with feutil
Building models with femesh
Automated meshing capabilities
Importing models from other codes
Importing model matrices from other codes
The feplot interface
The main feplot figure
Toolbar
Interactivity : keyboard, mouse, scroll
Menus and context menu
Viewing stack entries
Pointers to the figure and the model
The property figure
GUI based mesh editing
Viewing shapes
Superposing shapes
Element selections
Viewing property colors
Viewing colors at nodes
Viewing colors at elements
feplot FAQ
Other information needed to specify a problem
Material and element properties
Other information stored in the stack
Cases GUI
Boundary conditions and constraints
Loads
Sensor and wireframe geometry definition formats
Sensors tab
Nodes and Elements
Example
URN based handling of sensors
Mesh cut selections
Sensor GUI, a simple example
Sensors : reference information
Topology correlation and observation matrix
SensMatch
Sens, observation
DofLoadSensDof
Animation of sensor wire-frame models
Obsolete
Sensors : Data structure and init commands
SensDof Data structure
SensDof init commands
rel
general
trans
dof
triax,
laser
strain,stress
resultant
Stress observation
Building view mesh
Building and using a selection for stress observation
Observing resultant fields
Computing/post-processing the response
Simulate GUI
Static responses
Normal modes (partial eigenvalue solution)
State space and other modal models
Time computation
Manipulating large finite element models
Optimized assembly strategies
Chapter 5 Structural dynamic concepts
Structural dynamic concepts
I/O shape matrices
Normal mode models
Damping
Viscous damping in the normal mode model form
Viscous damping in finite element models
Hysteretic damping in finite element models
State space models
Complex mode models
Pole/residue models
Parametric transfer function
Non-parametric transfer function
Chapter 6 Advanced FEM tools
Advanced FEM tools
FEM problem formulations
3D elasticity
2D elasticity
Acoustics
Classical lamination theory
Piezo-electric volumes
Piezo-electric shells
Geometric non-linearity
Thermal pre-stress
Hyperelasticity
Gyroscopic effects
Centrifugal follower forces
Poroelastic materials
Heat equation
Test case
Model reduction theory
General framework
Normal mode models
Static correction to normal mode models
Static correction with rigid body modes
Other standard reduction bases
Substructuring
Reduction for parameterized problems
Superelements and CMS
Superelements in a model
SE data structure reference
Opt
Node
K{i},Klab{i},DOF
Elt, Node, il, pl
TR
An example of SE use for CMS
Obsolete superelement information
Sensors and superelements
Superelement import
Generic representations in SDT
NASTRAN Craig-Bampton example
Free mode using NASTRAN
Abaqus Craig-Bampton example
Free mode using ABAQUS
ANSYS Craig-Bampton example
Model parameterization
Parametric models, zCoef
par
zCoef
Reduced parametric models
upcom
parameterization for full order models
Getting started with
upcom
Reduction for variable models
Predictions of the response using
upcom
Finite element model updating
Error localization/parameter selection
Update based on frequencies
Update based on FRF
Handling models with piezoelectric materials
Chapter 7 Developer information
Developer information
Nodes
Node matrix
Coordinate system handling
Model description matrices
Material property matrices and stack entries
Element property matrices and stack entries
DOF definition vector
FEM model structure
FEM stack and case entries
FEM result data structure
Curves and data sets
Multi-dim curve
tdof (outputs), DOF, dof (input/output pair)
FEM Result
Inputs
Response data associated with inputs and outputs
Shapes at IO pairs
DOF selection
Node selection
Element selection
Defining fields trough tables, expressions, ...
Constraint and fixed boundary condition handling
Theory and basic example
Local coordinates
Enforced displacement
Resolution as MPC and penalization transformation
Low level examples
Internal data structure reference
Element functions and C functionality
Standard names in assembly routines
Case.GroupInfo cell array
Element constants data structure
Creating new elements (advanced tutorial)
Generic compiled linear and non-linear elements
What is done in the element function
What is done in the property function
BuidConstit
Const
Subtype
database
dbval
PropertyUnitType
Compiled element families in of_mk
Generic multi-physic linear elements
Phases in of_mk.c matrix integration
Generic RHS computations
Large transformation linear elasticity
Hyperelasticity
Non-linear iterations, what is done in
of_mk
Element function command reference
General element information
call,matcall
dof, dofcall
edge,face,patch,line,sci_face
integinfo, BuildConstit
node
prop
parent
rhscall
Matrix, load and stress computations
Variable names and programming rules (syntax)
Variable naming conventions
GetData: model input parsing and dereference object copies
Coding style
Input parsing conventions, ParamEdit
Input parsing conventions, urnPar
Commands associated to project application functions
wd,fname
view
im
Commands associated to tutorials
Criteria with CritFcn
Legacy information
Legacy 2D elements
Rules for elements in
of_mk_subs
hexa8, hexa20
penta6, penta15
tetra4, tetra10
q4p (plane stress/strain)
q4p axisymmetric
q5p (plane stress/strain)
q8p (plane stress/strain)
q8p axisymmetric
t3p (plane stress/strain)
t3p axisymmetric
t6p (plane stress/strain)
t6p axisymmetric
Chapter 8 GUI and reporting tools
GUI and reporting tools
Formatting MATLAB graphics and output figures
Formatting operations with
objSet
Persistent data in
Project
OsDic
dictionary of names styles
File name generation with
objString
Image generation with
ImWrite
SDT Tabs
Project
FEMLink
Mode
TestBas : position test versus FEM
StabD : stabilization diagram
Ident : pole tuning
MAC : Modal Assurance Criterion display
Handling data in the GUI format
Parameter/button structure (CinCell)
DefBut : parameter/button defaults
Reference button file in CSV format
Data storage and access
Initializing the GUI figure
Handling the data java pointer
Recovering data from java objects
Displaying data in the GUI figure
Tweaking display
Defining an exploration tree
Finding
CinCell
buttons in the GUI with
getCell
Generic URN conventions
Format dependent string conversion (urnCb, urnVal)
Search for graphical objects by name
sdth.urn
Specification of graphical objects (urnObj)
Report generation
String conversion DOE events (urnSig)
Interactivity specification with URN
Interactivity scenario
Interactivity URN
User interaction
Busy Window
Handling tabs
Handling dependencies
Dialogs
File input dialog
Selection in a tree dialog
Check list dialog
Chapter 9 Element reference
Element reference
bar1
beam1, beam1t
beam1
beam1t
celas,cbush
celas
cbush
dktp
fsc
AddFluid
AddCoupling
SolveMVR[,-direct]
SolveEig
hexa8, penta6, tetra4, and other 3D volumes
integrules
Gauss
bar1,beam1,beam3
t3p,t6p
q4p, q5p, q8p
tetra4,tetra10
penta6, penta15
hexa8, hexa20, hexa21, hexa27
BuildNDN
mass1,mass2
m_elastic
Database,
Dbval
] [-unit TY] [,MatiD]] Name
1 : standard isotropic
2 : acoustic fluid
3 : 3-D anisotropic solid
4 : 2-D anisotropic solid
5 : shell orthotropic material
6 : Orthotropic material
m_heat
Database,Dbval] [-unit TY] [,MatiD]] Name
1 : Heat equation material
m_hyper
1 : Nominal hyperelastic material
m_piezo
[
Database
,
Dbval
] [-unit TY] [,MatiD]] Name
Patch
1 : Simplified 3D piezoelectric properties
2 : General 3D piezo
3 : General 3D piezo, e matrix
p_beam
Database,Dbval, ...
Show3D,MAP ...
format description and subtypes
1 : standard
3 : Cross section database
p_heat
Database,Dbval] ...
Heat equation element properties
1 : Volume element for heat diffusion (dimension DIM)
2 : Surface element for heat exchange (dimension DIM-1)
SetFace
2Dvalidation
p_pml,d_pml
addPML
1 Time domain formulation
2 Frequency domain formulation
p_shell
Database,Dbval, ...
Shell format description and subtypes
1 : standard isotropic
2 : composite
setTheta
p_solid
Database, Dbval, Default, ...
1 : 3D volume element
2 : 2D volume element
3 : ND-1 coupling element
p_spring
Database,Dbval] ...
1 : standard
2 : bush
p_super
Database,Dbval] ...
1 : simple weighting coefficients
2 : matrix type redefinition and weighting coefficients
p_piezo
ElectrodeMPC
ElectrodeSensQ
ElectrodeDOF
ElectrodeView ...
Electrode2Case
ElectrodeInit
Tab
View
Shell element properties
quad4, quadb, mitc4
quad4
quadb
q4p, q8p, t3p, t6p and other 2D volumes
rigid
tria3, tria6
Chapter 10 Function reference
Function reference
abaqus
read[*.fil, *.inp, *.mtx, *.dat]
Build[model,case,contact,...]
Resolve
write
JobWrite
JobOpt
conv
splitcelas
uniquematpro
AssembleUserElements
odb2sdt
odb2sdt.py reference
Examples
ans2sdt
Build[Up,ContactMPC]
def
conv
read
ESLread
JobOpt
Write
basis
nodebas [nodeGlob,bas]=basis('nodebas',model)
bas bas=basis('bas',bas)
trans[ ,t][ ,l][,e] cGL= basis('trans [ ,t][ ,l][,e]',bas,node,DOF)
gnode:nodeGlobal = basis('gnode',bas,nodeLocal)
[p,nodeL] = basis(node)
rotate
p = basis(x,y)
comgui,cingui
ImCrop
ImWrite, ...
ImFtitle, ...
ImInfo
dock
guifeplot,iiplot
objSet (handle formatting)
objString (string generation for title and file)
ParamEdit
def.Legend
PlotWd
FitLabel
commode
comstr
Cam,string istrue=comstr(Cam,'string')
Cam,string,format [opt,CAM,Cam]=comstr(CAM,'string','format')
CAM,ind [CAM,Cam] = comstr(CAM,ind)
-1 opt = comstr(CAM,[-1 default])
-3 date = comstr(CAM,[-3])
-4 CAM = comstr(CAM,[-4
nc
])
-5 comstr(Matrix,[-5 fid],'format')
-7 st1=comstr(st1,-7,'string')
-17
Tab, comstr(tt,-17,'type')
-38 [i0,st2]=comstr(st1,-38)
curvemodel
db, phaseb
ex2sdt
read[*.cff, *.gid]
ConvertAsMat
UIScan
TextOp4
fe2ss
SysDef
Free [ , Float] [ , -dterm]
EigOpt
CraigBampton
nm
Low level input format
fecom
AddNode,Line
Anim[,One][,Time,Freq,Static][,col][nCycle
i
, Start
i
, Step]
AnimMovie
step
cax
i
, ca+
ch[,c] [
i
,+,-,+
i
,-
i
],
ColorData [,sel
i
] [
Type
] [,-alpha
i
]
Color [,sel
i
] [Edge ..., Face ..., Legend]
ColorBar,
ColorMap
ColorAlpha
ColorScale
Cursor
ga
i
go
i
LabFcn
Legend,
Head
, ImWrite
Info
InitDef[ , Back]
load,
InitModel
InitSens
Plot
Pro
Renderer[Opengl,zBuffer,Painters][,default]
Save, FileExport
Scale [ ,Def
s
, Dof
i
, equal, match, max, one]
Sel [
ElementSelectors
, GroupAll, Reset, ResetNew ElementSelectors]
SetObjectcf.o(1)= ...
fecom
SetObjset
i
[,ty
j
] ...
Show [patch,line,sensor,arrow, ...]
Sub [
i j
], SubIso, SubStep
Text [off, Node [,
Select
], Dof
d
]
TitOpt [ ,c]
i
Triax [ , On, Off]
Undef [ , Dot, Line, None]
View [...]
femesh
;
Add FEel
i
FEel
j
, AddSel
AddNode [,New] [, From i] [,epsl
val
]
AddTest [,-EGID
i
][,
NodeShift
,Merge,Combine]
Divide
div1 div2 div3
DivideInGroups
DivideGroup
i ElementSelectors
Extrude
nRep tx ty tz
FindElt
ElementSelectors
FindNode
Selectors
Info [ ,FEel
i
, Node
i
]
Join [,el0] [group
i
,
EName
]
Model [,0]
ObjectBeamLine
i
, ObjectMass
i
ObjectHoleInPlate
ObjectHoleInBlock
Object[Quad,Beam,Hexa]
MatId ProId
Object [Arc, Annulus, Circle,Cylinder,Disk]
Optim [Model, NodeNum, EltCheck]
Orient, Orient
i
[ , n
nx ny nz
]
Plot [Elt, El0]
Lin2quad, Quad2Lin, Quad2Tria, etc.
RefineBeam
l
Remove[Elt,El0]
ElementSelectors
RepeatSel
nITE tx ty tz
Rev
nDiv OrigID Ang nx ny nz
RotateSel
OrigID Ang nx ny nz
Sel [Elt,El0]
ElementSelectors
SelGroup
i
, SelNode
i
SetGroup [
i
,
name
] [Mat
j
, Pro
k
, EGID
e
, Name
s
]
SymSel
OrigID nx ny nz
Test
TransSel
tx ty tz
UnJoin
Gp1 Gp2
feutil
Advanced
AddElt
AddNode[,New] [, From
i
] [,epsl
val
]
AddSet[NodeId, EltId, FaceId, EdgeId]
AddTest[,-EGID
i
][,
NodeShift
,Merge,Combine]
Divide
div1 div2 div3
DivideInGroups
DivideGroup
i ElementSelectors
EltId
EltSetReplace
Extrude
nRep tx ty tz
GetDof
ElementSelectors
FindElt
ElementSelectors
FindNode
Selectors
GetEdge[Line,Patch]
GetElemF
Get[Line,Patch]
GetNode
Selectors
GetNormal[Elt,Node][,Map],GetCG
Info[ ,Elt, Node
i
]
Join[group
i
,
EltName
]
Matid,
ProId
,
MPID
Node[
trans
,
rot
,
mir
,
DefShift
]
ObjectBeamLine
i
, ObjectMass
i
ObjectHoleInPlate
ObjectHoleInBlock
Object[Quad,Beam,Hexa]
MatId ProId
Object[Arc, Annulus, Circle, Cylinder, Disk]
ObjectDivide
Optim[Model, NodeNum, EltCheck]
Orient, Orient
i
[ , n
nx ny nz
]
Quad2Lin,
Lin2Quad
, Quad2Tria, etc.
RefineCell, Beam
l
, ToQuad
RefineLine
lc
RemoveElt
ElementSelectors
Remove [Pro, Mat]
MatId, ProId
Renumber
RepeatSel
nITE tx ty tz
Rev
nDiv OrigID Ang nx ny nz
RotateNode
OrigID Ang nx ny nz
SelElt
ElementSelectors
SetSel[Mat
j
, Pro
k
]
SetGroup[
i
,
n
ame] [Mat
j
, Pro
k
, EGID
e
, Name
s
]
SetPro,
SetMat
,
GetPro
,
GetMat
GetIl,
GetPl
StringDOF
SymSel
OrigID nx ny nz
Trace2Elt
TransSel
tx ty tz
UnJoin
Gp1 Gp2
feutila
RotateSel
OrigID Ang nx ny nz
feutilb
AddNode
CaseC2SE
CaseL2G
CombineModel
GeoLineTopo, ...
GeoFindCircle, ...
GeoFindSphere
GeomRB,[Mass,ByParts,Beam1]
GetUsedNodes
Match
MeasThick,Show
MpcFromMatch
PlaceInDof
SeparateByMat,Pro
SubModel
SurfaceAsQuad[,Group]
SurfaceSplitDef
SurfVisible
SurfWjNode
TKT[,dTKT,TKTSolve]
Write
@levNodeCon
@unConSel
feplot
mesh
arrow
text
mdl
data
def
sel
sens
fesuper
F ...
Get,Set ...
Damp
SEDef
SEBuildSel
SE ...
SEAdd ...
SEAssemble ...
SEDispatch ...
SEDofShow
SEInitCoef ...
SEIntNode ...
SESelAsSE ...
SERemove
SERenumber
s_
fjlock
fjlock
.delete[,.close]
.file
.lock(
flag
)
.lockWait(
fname,flag,icmax,dt
)
.locked
.setFile
.setUseNIO(
flag
)
.tmpFile
fe_c
Example
fe_case
Get,
T
,
Set
,
Remove
,
Reset
...
AutoSPC
Assemble
Build
Sec
epsl
d
ConnectionEqualDOF
ConnectionPivot
ConnectionSurface
ConnectionScrew
cyclic (SDT)
FixDof
map
MPC
par (SDT)
RBE3 (SDT)
rigid
Sens ... (SDT)
un=0
SetCurve
Examples
fe_caseg
Assemble
StressCut
Change[,set]
Par[Mat,Pro,SE,Init,Set,2Case]
StressObserve
ZoomClip
fe_ceig
fe_coor
fe_curve
Commands
bandpass
Unit f_min f_max
datatype [,cell]
getCurve,Id,IdNew
h1h2
input_channels
noise
plot
resspectrum [
True, Pseudo
] [
Abs., Rel.
] [
Disp., Vel., Acc.
]
returny
set
Test ...
testframe
timefreq
Window ...
fe_cyclic
Assemble [,-struct]
Build ...
LoadCentrifugal
Eig
Omega[,Group,GroupSet]
fe_def
CleanEntry
DefEigOpt
DefFreq, Freq
Exp
SubDef,
SubDof
,
SubCh
fe_eig
Example
fe_exp
SE reduced superelements for expansion
MDRE, MDRE-WE
Static
Dynamic
Subspace, Modal, Serep
fe_gmsh
Tab
Example
Add...
config
Ver
Read
Write
fe_load
curve
DofLoad,
DofSet
FVol
FSurf
fe_mat
Convert,Unit
GetPl
GetIl
Get[Mat,Pro]
Set[Mat,Pro]
Type
ElemP
fe_mknl, fe_mk
Init
Assemble [ , NoT]
MatType: matrix identifiers
NodePos
nd
OrientMap
of_mk
obsolete
fe_norm
fe_quality
Degenerate
Jacobian
AspectRatio
MaxIntAng
GammaK
MidNodeEgde
MaxAngleMid2Edge
Taper
Skew
Wrap
RadiusEdge
Sliver
FaceAspect
Unstraight
RadiusCircum
lab[...]
meas[...]
view[...]
MeshDim
print
CleanNJStraight
clear[...]
fe_range
Build[R,
stra
,URN]
DirScan
fname [,LabCell,Labdef]
GeneLoop
labFcn
Loop
Res
Sel
Stats
Simple
UI Tree
Val
ValCell
fe_reduc
Static, CraigBampton
Free ...
dynamic
w
flex [,nr]
rb
obsoletem,k,mdof (obsolete format)
fe_sens
InAcceptable
InGetDn
indep
mseq
ma[,mmif]
basis
SensMatch, sens, ...
tdof, ...
links
WireExp
MeshGrid
MeshProject
MeshSensAsMPC
MeshSub
fe_simul
fe_stress
Ener [m,k]
ElementSelection
feplot
Stress
CritFcn
fe_time
Solvers and options
TimeOpt
Input and output options
Cleanup
newmark
dg
NLNewmark
staticNewton
numerical damping for Newmark, HHT-alpha schemes
Theta
Euler
of_time
lininterp
interp
-1
idcom
e [ ,
i w
]
ea
er [num
i
, f
w
]
est[ ,FullBand,LocalBand,LocalPole]
eup
dstep fstep
[local, num
i
, iter
j
]
eopt [local, num
i
, seq]
find
f
i
dspi
nm
mass
i
poly
nn nd
Table,Tex] IIpo
idopt
id_dspi
id_nor
id_poly
id_rc, id_rcopt
xf
w
po, new_po
IDopt
dstep, fstep (for id_rc)
step, indpo (for id_rcopt)
res
xe
id_rm
PermuteIO
FixSign
Mass
iicom
command;
cax
i
, ca+
ch+, ch-, ch[+,-]
i
: next/previous
ch
i
, chc
i
, chall, ... select channel
Cursor,
ods
Curve [Init,Load,Save,Reset, ...]
Dock Id, MAC, TestBas
ga
i
head [Main,Text,Clear]
IIx
Data set selection
iicom
IIx:
name
[On,Off,Only], cIIx ...
Polar
PoleLine [ ,c] [ ,3], IIpo, ...
ImWrite, ...
Pro
Show plot type
SubSave, SubSet
SubToFig
Sub
plot init
TitOpt [ ,c]
i
, title and label options
Scale :
xlin
,
xlog
...
Limits :
wmin
, xlim, xmin, xmax, wmo, w0, ...
iimouse
On,Off
clip [Start,Undo]
zoom
Cursor
Interactions
move
text
view,cv
iiplot
ci : handle
PlotInfo
Type
DimPos and channel
TypeIDcom
ii_cost
ii_mac
Options ... [Plot,Table,Tex,Thtml]
Data fields
MAC [,M] [ ,PairA,PairB,AutoA, ...] ...
MACCo [ ,M] [,
ns
]
MacM ...
COMAC [ ,M][,A,B][,N][,S][,E] [,sort]
POC [,Pair[A,B]] ...
Rel [,scaled][,m]
VC
va,vb,sens
m,k,kd
mc
T
ii_mmif
MMIF
CMIF
AMIF
SUM, SUMI, SUMA
NODEMIF
Stats
Signal processing
Integrate,
DoubleInt
,
Vel
,
Acc
FFT,
FFTShock
,
IFFT
,
IFFTShock
BandPass
OctGen,
Octave
ii_plp
plp
.ID PoleLine
Call from iiplot
Legend
PlotSubMark
spy
TickFcn
ColorMap[,RO]
Cb
ii_poest
ii_pof
lsutil
edge[cut, sellevellines, self2, gensel]
eltset
gen[-max]
cut[,face2tria]
mpid
surf[,stream,frompoly,remesh,fromrectmesh]
nasread
Bulk file
OUTPUT2 binary
BuildUp,BuildOrLoad
OUTPUT4 binary
.f06 output (obsolete)
naswrite
EditBulk
model
node,elt
dmig
job
Wop4
WriteFreqLoad
Write[Curve,Set,SetC,Uset]
WritePLIL
nor2res, nor2ss, nor2xf
DEF,MODEL
Examples
om,ga,pb,cp
w,ind,fc,OutputCmd
res
ss
xf
lab_in,lab_out
Theory
of2vtk
FileName
model
vali
ofact
umfpack
mklserv_utils
spfmex
sp_util
verbose
_sel
method
fact
solve
clear
silent
perm2sdt
filesModel files
Merging model
Result files
Matrix files
polytec
ReadMesh
ReadList
ReadSignal
ReadFastScan
ReadImg
ReadInfo
ToMat
psi2nor
qbode
res2nor
res2ss, ss2res
ss
res
res2tf, res2xf
rms
samcef
read
write
conv
sd_pref
sdt_dialogs
getfile,
putfile
,
getdir
picklist
dlg
setlines
sdtcheck
path
patchJavaPath[,set]
patchFile[,set]
patchMkl[,path,_rt]
SdtRootDir
sdtdef
info
in
SDT preferences
FEMLink preferences
OpenFEM preferences
sdth
fileutil
GetData,-mdl,-rec,-warndel
os, cf.os_, cf.osd_
urn
urn.nmap
findobj[,_sub,...]
sdthdf
hdfReadRef
hdfdbsave
hdfmodelsave
hdfmodel
hdfclose
ioClearCache,ioLoad, ...
compare
pointerList[sortm,-mb]
sdtm
pause
save,-safe
urn , urnCb, urnValG, urnObj ...
busyWindow
range
store
to ...
node ...
sdtroot, sdt_locale
Init
Set
PARAM
OsDic
@sfield
sdtsys
CfgRange
Step
UrnSig signal generation nomenclature
sdtweb
OpenFileAtTag
Utils
_taglist
sp_util
stack_get,stack_set,stack_rm
ufread
15 Grid point
55 Analysis data at node
58 Function at nodal DOF
82, Trace Line
151, Header
780, 2412, Elements
773, 1710 Material Database
772, 788, 789, 2437, Element Properties
2414, Analysis data
ufwrite
upcom
Clear, Load
File
, Save
File
Assemble [,m,k] [,coef
cur
],[,delta
i
][,NoT][,Point]
ComputeMode [ ,full,reduced] [,
eig_opt
]
ComputeModal [ ,full,reduced]
Ener [m, k]
Fix
Get
femesh
IndInElt
Info [ ,par,elt]
Opt
Par [add
type values
,reset]
ParCoef
ParRed
ParTable
PlotElt
Profile [,fix]
SensMode [,reduced]
SetNominal [ , t
groups
]
Up.copt
Up.mind, Up.file, Up.wd, mi, me, ki, ke
Up.Node, Up.Elt, Up.pl, Up.il, Up.DOF, Up.Stack
Up.sens
up_freq, up_ifreq
up_ixf
v_handle
vhandle.matrix
mtimes
gemm
vhandle.nmap
Map:Nodes
list
append,missing
renumber
invMap
.DeepCopy
.getStruct
.getController()
vhandle.tab
xfopt
_FunType, _DataType, _FieldType
Bibliography
Index