MIDAS  0.75
 All Classes Namespaces Files Functions Variables Enumerations Enumerator Friends Macros
Classes | Enumerations | Functions | Variables
midaspace Namespace Reference

Classes

struct  FiniteElementTypeSet
 tato struktura by mela obsahovat vsechny potrebne informace pro urceni konkretni implementace konecneho prvku More...
 
class  Attribute
 
class  LoadTimeFunction
 
class  ProblemAnalysis
 
class  CrossSection
 
class  Material
 
class  BoundaryCond
 
class  Assign
 
class  AssignFix
 
class  AssignBC
 
class  ABC_NLoad
 
class  ABC_CELoad
 
class  ABC_CFLoad
 
class  ABC_CBLoad
 
class  Attributes
 
class  CellAttribs
 
class  FacedgeAttribs
 
class  EdgeAttribs
 
class  FaceAttribs
 
class  ElemAttribs
 assignment of attributes to element More...
 
class  FElemAttribs
 
class  GelemAttribs
 
class  PointAttribs
 
class  RANAttribs
 
class  HNAttribs
 
class  Cell
 
class  Facedge
 
class  Edge
 
class  Face
 
class  Element
 
class  Gelement
 
class  PolyLine
 
class  Line
 
class  PolygonMdl
 
class  FElement
 
class  Beam
 
class  Triangle
 
class  Quadrangle
 
class  Tetra
 
class  Brick
 
class  ComponentGeometry
 

*** *** *** *** CLASS ComponentGeometry *** *** *** ***


More...
 
class  ComponentGeometry1D
 

*** *** *** *** CLASS ComponentGeometry 1D *** *** *** ***


More...
 
class  ComponentGeometry1Dpoly
 
class  ComponentGeometry2D
 

*** *** *** *** CLASS ComponentGeometry 2D *** *** *** ***


More...
 
class  ComponentGeometry2Dtriangle
 
class  ComponentGeometry2Dquadrangle
 
class  ComponentGeometry2Dpolygon
 
class  ComponentGeometry3D
 

*** *** *** *** CLASS ComponentGeometry 3D *** *** *** ***


More...
 
class  ComponentGeometry3Dhexahedron
 quadrilateral convex hexahedron More...
 
class  ComponentGeometry3Dtetrahedron
 tetrahedron More...
 
class  DuplicatePoints
 

*** *** *** *** CLASS MESHGEOMETRY *** *** *** ***


More...
 
class  GeometryComponent
 

*** *** *** *** CLASS COMPONENT *** *** *** ***


More...
 
struct  Predp
 special one time format for bridge in Melnik More...
 
class  Geometry
 Geometry description. More...
 
class  Model
 
class  Mesh
 
class  Point
 
class  Vertex
 
class  Node
 
class  HangingNode
 
class  RigidArmNode
 
class  Problem
 Problem description. More...
 
class  ProblemSubject
 
class  GeometrySubject
 
class  GeomCompSubject
 
class  PointDOFsAttributes
 Base class for management of DOF (Degrees Of Freedom) attributes at a node. More...
 
class  PointDOFsBCPM
 Derived class for management of boundary conditions and physical meanings of DOFs (Degrees Of Freedom) at a node. More...
 
class  PointDOFsRANHN
 Derived class for management of RAN (rigid arm node) or HN (hanging node) connection of DOFs (Degrees Of Freedom) at a node. More...
 
class  PointDOFsCondense
 Derived class for management of condensed DOFs (Degrees Of Freedom) at a node. More...
 
class  FiLe
 
class  LocalCoordSystem
 Local coordinate system. More...
 
class  LCS_pure
 Local coordinate system defined by 2 vectors. More...
 
class  LCS_beam
 Local coordinate system at beam element. More...
 
class  AdaptivityParameters
 
class  StdoutDriver
 
struct  Elem3D
 
struct  PoinT
 
struct  VectoR
 
struct  MatriX
 
class  Array
 
class  Array1d
 
class  Xscal
 
class  Dscal
 
class  Xvctr
 
class  Lvctr
 
class  Dvctr
 
class  Xmtrx
 
class  Lmtrx
 
class  Dmtrx
 
class  GPA
 GPA - Generic Pointer Array, template class manages 1d array of pointers to objects of type T. More...
 
class  Stream
 

Enumerations

enum  classID {
  classVoid, classComponentGeometry, classComponentGeometry1D, classComponentGeometry1Dpoly,
  classComponentGeometry2D, classComponentGeometry2Dtriangle, classComponentGeometry2Dquadrangle, classComponentGeometry2Dpolygon,
  classComponentGeometry3D, classComponentGeometry3Dhexahedron, classComponentGeometry3Dtetrahedron, classVertex,
  classNode, classHangingNode, classRigidArmNode, classEdge,
  classFace, classPolyLine, classLine, classPolygonMdl,
  classBeam, classTriangle, classQuadrangle, classBrick,
  classTetra, classModel, classMesh, classAttribute,
  classProblemAnalysis, classCrossSection, classMaterial, classBoundaryCond,
  classABC_NLoad, classABC_CELoad, classABC_CFLoad, classABC_CBLoad,
  classElemAttribs, classGelemAttribs, classFEelemAttribs, classPointAttribs,
  classRANAttribs, classHNAttribs
}
 Type introduced to distinguish between classes. More...
 
enum  Solver { SOL_Void, SOL_OOFEM, SOL_SIFEL, SOL_ANSYS }
 Solver. More...
 
enum  MeshGenerator { MGT_Void, MGT_T3d }
 type of mesh generator More...
 
enum  RVType {
  RVT_Void, RVTstrn, RVTstrs, RVTstrn_displ,
  RVTstrn_rotat, RVTstrs_displ, RVTstrs_rotat, RVTstrn_displ_local_main,
  RVTstrn_rotat_local_main, RVTstrs_displ_local_main, RVTstrs_rotat_local_main, RVTstrs_grad
}
 Result variable type. More...
 
enum  VTKdataset { VTKDS_Void, VTKDS_polydata, VTKDS_unstruct }
 VTK data set. More...
 
enum  ResultTypesAtNode {
  RTN_displacement, RTN_reaction, RTN_transpunknowns, RTN_ada_refder,
  RTN_ada_h_act, RTN_ada_h_new, cRTN
}
 Result type at node. More...
 
enum  ResultTypesAtElem {
  RTE_global_strain, RTE_global_stress, RTE_localOO_strain, RTE_localOO_stress,
  RTE_layered_strain, RTE_layered_stress, RTE_plaststrain, RTE_gradient,
  RTE_fluxes, RTE_ada_error_pct_l, RTE_ada_error_pct_g, RTE_ada_h_act,
  RTE_ada_h_new, RTE_ada_normal, RTE_ada_eia, cRTE,
  RTE_Void
}
 Result type at element. More...
 
enum  StiffMatrixType { SMT_Void, SMT_initial, SMT_tangent }
 Stiffness matrix type. More...
 
enum  LinearSolverType { LST_Void, LST_ldl, LST_gauss }
 Linear solver type. More...
 
enum  SPRpatchType { SPRPT_Void, SPRPT_2d }
 typ spr patche, závisí na typu/geometrii elementů More...
 
enum  PAGroup { PAG_Void, PAG_mechanics, PAG_transport }
 The group of problem analysis. More...
 
enum  PAType {
  PAT_Void, PAT_OOFEM, PAT_SIFEL, PAT_static_linear_adapt,
  PAT_static_linear, PAT_static_nonlinear, PAT_dynamic_PNlDEI, PAT_stability_linear,
  PAT_stationary, PAT_nonstationary, cPAT
}
 
enum  CrossSectType {
  CST_Void, CST_OOFEM, CST_SIFEL, CST_SimpleCS,
  CST_LayeredCS, CST_FiberedCS, CST_Truss, CST_2d,
  CST_3d, CST_Beam, CST_Rectangle, CST_Rectangle_tube,
  CST_Circle, CST_Circle_tube, CST_Circle_cable, CST_1d_rolled,
  cCrossSectTypes
}
 
enum  MaterialType {
  MAT_Void, MAT_OOFEM, MAT_SIFEL, MAT_IsoLE,
  MAT_IsoTrans, MAT_RIGID, MAT_j2mat, cMaterialTypes
}
 
enum  BCType {
  BC_Void, BC_OOFEM, BC_SIFEL, BC_PV,
  BC_NL, BC_CEL, BC_CFL, BC_CBL,
  BC_DW, cBCTypes
}
 
enum  MMprocessing { MMP_Void, MMP_primary, MMP_secondary, MMP_RFbyHN }
 
enum  femFileFormat {
  FFF_Void, FFF_VTK, FFF_VTP, FFF_VTU,
  FFF_UNV, FFF_JKTK, FFF_T3d, FFF_ANSYS,
  FFF_OOFEM, FFF_SIFEL, FFF_MIDAS, FFF_POLYLINE,
  FFF_VTX, FFF_MELNIK, FFF_VLNA
}
 
enum  DOFtype {
  DOF_Void =0, DOF_Dx =1, DOF_Dy =2, DOF_Dz =3,
  DOF_Rx =4, DOF_Ry =5, DOF_Rz =6, DOF_Tm =7
}
 DOF type == physical meaning of dof; see help.txt. More...
 
enum  DOFsPerNode {
  DPN_Void, DPN_Dxy_R___, DPN_Dxy_R__z, DPN_D__zRxy_,
  DPN_DxyzR___, DPN_DxyzRxyz, DPN_TR_1, DPN_TR_2
}
 
enum  CellGeometry {
  CG_Void, CG_Line, CG_PolyLine, CG_Triangle,
  CG_Quadrangle, CG_Polygon, CG_Tetrahedron, CG_Hexahedron,
  CG_Wedge, CG_Pyramid, cCG
}
 
enum  VTKPDtopology {
  VTKPD_Void =0, VTKPD_VERTICE =1, VTKPD_LINE =2, VTKPD_POLYGON =3,
  VTKPD_TRIANGLE_STRIP =4
}
 VTK type of cell topology for POLYDATA. More...
 
enum  FEApproximation {
  FEA_Void, FEA_default, FEA_linear, FEA_bilinear,
  FEA_133133
}
 finite element approximation More...
 
enum  SStype {
  SST_Void, SST_truss, SST_beam, SST_plstress,
  SST_plstrain, SST_plate, SST_3dshell, SST_3d,
  SST_transp2d, cSSTypes
}
 type of stress/strain state of element; especially results depends on this variable => described at Mesh :: print_results More...
 
enum  FiniteElementType {
  FET_Void, FET_OOFEM_Truss2d, FET_OOFEM_Truss3d, FET_OOFEM_LiBeam3d,
  FET_OOFEM_LiBeam3dNL, FET_OOFEM_Beam2d, FET_OOFEM_Beam3d, FET_OOFEM_TrPlaneStrain,
  FET_OOFEM_Quad1PlaneStrain, FET_OOFEM_TrPlaneStress2d, FET_OOFEM_PlaneStress2d, FET_OOFEM_TrPlaneStress2dRot,
  FET_OOFEM_Tr_Shell01, FET_OOFEM_RerShell, FET_OOFEM_LSpace, FET_OOFEM_QTrSpace,
  FET_SIFEL_bar3d, FET_SIFEL_beam3d, FET_SIFEL_planeelementlt, FET_SIFEL_planeelementlq,
  FET_SIFEL_linearhex, FET_SIFEL_trlint, FET_SIFEL_quadlint, FET_ANSYS_start,
  FET_ANSYS_BEAM188, FET_ANSYS_SHELL181, FET_ANSYS_end
}
 
enum  IntPointSet {
  IPS_Void, IPS_1D_1ip, IPS_1D_exact, IPS_2D_3v_1ip,
  IPS_2D_3v_3ip, IPS_2D_3v_4ip, IPS_2D_3v_shell, IPS_2D_4v_4ip,
  IPS_3D_8v_8ip
}
 
enum  ASGType {
  ASG_non, ASG_prop, ASG_id, ASG_coord,
  ASG_faceprop
}
 
enum  ElAttLevel {
  EAL_Void, EAL_direct, EAL_property, EAL_geometry,
  EAL_subdom, EAL_domain
}
 
enum  VTKrange {
  VTKR_void, VTKR_points, VTKR_cells, VTKR_lines,
  VTKR_polygs, VTKR_pred, VTKR_pd, VTKR_cd,
  VTKR_scals
}
 
enum  OperationMode {
  OM_Void, OM_Convert, OM_Design2design, OM_Design2solver,
  OM_Solver2design, OM_Test
}
 
enum  BlockName {
  BN_Void, BN_COMM, BN_OFN, BN_ANAL,
  BN_DOMN, BN_OUTP, BN_CS, BN_MAT,
  BN_BC, BN_PV, BN_NODES, BN_ELEMS,
  BN_NL, BN_CEL, BN_CFL, BN_CBL,
  BN_HN, BN_RAN, BN_LTF, BN_EXTRCT,
  BN_FIXED
}
 
enum  ProbDescBoolOpt {
  PDBO_allElemsProp1, PDBO_BondEndRFran, PDBO_uncfrd, PDBO_MultipNode,
  PDBO_MultipElem, PDBO_preserveGeom, PDBO_RIGIDmatToRAN, PDBO_divideQuads,
  PDBO_hingedBeamToTruss, PDBO_tmpFileWrite2hdd, PDBO_cutRF, PDBO_OUT_print_property,
  PDBO_OUT_print_parent_property, PDBO_OUT_print_model_parent, PDBO_OUT_print_CSusage, PDBO_OUT_Test,
  PDBO_OUT_MeshQual, PDBO_OUT_MeshStats, PDBO_OUT_origelemid, PDBO_OUT_CabTenOnly,
  PDBO_OUT_charVTK, PDBO_OUT_solverINctrl, PDBO_OUT_args, PDBO_P_mesh_quads,
  PDBO_P_rershell, PDBO_P_dw, PDBO_P_refder, PDBO_ansys,
  PDBO_stability, PDBO_Vlna, PDBO_melnik, cPDBO
}
 ProbDesc Boolean Option. More...
 
enum  LCSdirection { LCSd_Void, LCSd_xy, LCSd_xz }
 
enum  LCStype {
  LCSt_Void, LCSt_NodeID, LCSt_NodeProp, LCSt_NodeCoords,
  LCSt_Vector
}
 
enum  ADPArameters { ADOA_Void, ADPA_ZZ, ADPA_SPR }
 Adaptivity paramaters. More...
 
enum  SODenum {
  SODE_Void, SODE_start_blue_arrow, SODE_row, SODE_end,
  SODE_end_green_ok, SODE_green_ok
}
 
enum  arrayClassType { DvctrClass, LvctrClass, DscalClass }
 
enum  arrayTypedef { ATlong, ATdouble }
 
enum  ETCLR {
  ETC_VOID, ETC_B_BLACK, ETC_D_BLACK, ETC_B_RED,
  ETC_D_RED, ETC_B_GREEN, ETC_D_GREEN, ETC_B_YELLOW,
  ETC_D_YELLOW, ETC_B_BLUE, ETC_D_BLUE, ETC_B_VIOLET,
  ETC_D_VIOLET, ETC_B_CYAN, ETC_D_CYAN, ETC_B_WHITE,
  ETC_D_WHITE, ETC_DEFAULT
}
 enum More...
 
enum  Stream_type { STRM_void, STRM_file, STRM_tixel, STRM_string }
 

*** *** *** *** CLASS STREAM *** *** *** ***


More...
 

Functions

StiffMatrixType StiffMatrixType_i2e_SIFEL (int val)
 Conversion from "SIFEL int" to "enum" identificator of "stiffness matrix type". More...
 
int StiffMatrixType_e2i_SIFEL (StiffMatrixType val)
 Conversion from "enum" to "SIFEL int" identificator of "stiffness matrix type". More...
 
LinearSolverType LinearSolverType_i2e_SIFEL (int val)
 Conversion from "SIFEL int" to "enum" identificator of "linear solver type". More...
 
int LinearSolverType_e2i_SIFEL (LinearSolverType val)
 Conversion from "enum" to "SIFEL int" identificator of "linear solver type". More...
 
int EntityType_type2dim_jktkT3d (long val)
 Conversion from "entity type by t3d and jktk" to "dimension". More...
 
int EntityType_dim2type_jktkT3d (int val)
 Conversion from "dimension" to "entity type by t3d and jktk". More...
 
PAGroup PAGroup_t2g (PAType val)
 
PAType PAType_s2e_OOFEM (const char *str)
 
PAType PAType_i2e_SIFEL (int val)
 
int PAType_e2i_SIFEL (PAType val)
 
CrossSectType CrossSectType_i2e_SIFEL (int val, PAGroup pg)
 
int CrossSectType_e2i_SIFEL (CrossSectType val, PAGroup pg)
 
MaterialType MaterialType_s2e_OOFEM (const char *val)
 
const char * MaterialType_e2s_OOFEM (MaterialType val)
 
MaterialType MaterialType_i2e_SIFEL (int val, PAGroup pg)
 
int MaterialType_e2i_SIFEL (MaterialType val, PAGroup pg)
 
BCType BCType_s2e_OOFEM (const char *val)
 
const char * BCType_e2s_OOFEM (BCType val)
 
MMprocessing MMprocessingStoE (const char *val)
 
femFileFormat femFileFormatStoE (const char *fff)
 
const char * femFileFormatEtoS (femFileFormat fff)
 
DOFsPerNode DOFsPerNode_s2e (const char *val)
 
DOFsPerNode OOFEMdomain2DOFsPerNode (const char *od)
 
const char * DOFsPerNode2OOFEMdomain (DOFsPerNode od)
 
int DOFsPerNode2nDOFs (DOFsPerNode od)
 
bool DOFsPerNode2rotDOFsPresence (DOFsPerNode od)
 
int * DOFsPerNode2dofBCmask (DOFsPerNode od)
 
const char * DOFtype_i2s_ANSYS (DOFtype dt)
 
const char * DOFtype_i2s_force_ANSYS (DOFtype dt)
 
CellGeometry CellGeometry_i2e_HN (int val)
 
CellGeometry CellGeometry_i2e_JKTK (int val)
 
int CellGeometry_e2i_JKTK (CellGeometry cg)
 
CellGeometry CellGeometry_i2e_VTK (int val)
 
int CellGeometry_e2i_VTK (CellGeometry cg)
 
FEApproximation FEApproximation_s2e (const char *val)
 
SStype SStype_s2e (const char *val)
 
SStype SStype_i2e_SIFEL (int val)
 bar=1,plbeam=2,spacebeam=5,,plate=15,axisymm=20,shell=25,spacestress=30 More...
 
int SStype_e2i_SIFEL (SStype val)
 
FiniteElementType FET_s2e (const char *str)
 string to FET More...
 
FiniteElementType FETSet_si2e (const char *str, int val, Solver sol, PAGroup pg)
 string/int to FET More...
 
void FETSet_e2set (FiniteElementType fet, FiniteElementTypeSet *set)
 FET to FETset. More...
 
void FETSet_si2set (const char *str, int val, Solver sol, PAGroup pg, FiniteElementTypeSet *set)
 
FiniteElementType FETSet_set2e (const FiniteElementTypeSet *set, Solver sol, PAGroup pg)
 FETset to FET. More...
 
const char * FETSet_e2s_OOFEM (FiniteElementType feto)
 
int FETSet_e2i_SIFEL (FiniteElementType fet)
 
const char * FETSet_e2s_ANSYS (FiniteElementType fet)
 
const char * FETSet_set2s_OOFEM (const FiniteElementTypeSet *set, PAGroup pg)
 
int FETSet_set2i_SIFEL (const FiniteElementTypeSet *set, PAGroup pg)
 
IntPointSet IPS_inputfile_value_i2e_OOFEM (int val, FiniteElementTypeSet *fets)
 val je cislo ze vstupaku oofemu, keyword NIP More...
 
int IPS_inputfile_value_e2i_OOFEM (IntPointSet val)
 val je cislo ze vstupaku oofemu More...
 
IntPointSet IntPointSet_s2e (const char *val)
 
int IntPointSet_give_number_ips (IntPointSet ips)
 give number of int. points More...
 
double IPS_give_ip_coord_native (int i, IntPointSet ips, PoinT &coords)
 
IntPointSet IntPointSet_fets2ips (const FiniteElementTypeSet *set)
 
IntPointSet IntPointSet_fet2e_comp (FiniteElementType fet)
 FET to IPS for displacement computation (integration of stiffness matrix) More...
 
IntPointSet IntPointSet_fet2e_rslts (IntPointSet IPset, FiniteElementType fet)
 FET to IPS for results. More...
 
int ECN_convert_nodes_beam (bool i2e, int id, femFileFormat fff)
 
int ECN_convert_edges_beam (bool i2e, int id, femFileFormat fff)
 
int ECN_convert_nodes_triangle (bool i2e, int id, femFileFormat fff)
 
int ECN_convert_edges_triangle (bool i2e, int id, femFileFormat fff)
 
int ECN_convert_faces_triangle (bool i2e, int id, femFileFormat fff)
 
int ECN_convert_nodes_quadrangle (bool i2e, int id, femFileFormat fff)
 
int ECN_convert_edges_quadrangle (bool i2e, int id, femFileFormat fff)
 
int ECN_convert_nodes_brick (bool i2e, int id, femFileFormat fff)
 
int ECN_convert_edges_brick (bool i2e, int id, femFileFormat fff)
 
int ECN_convert_faces_brick (bool i2e, int id, femFileFormat fff)
 
int ECN_convert_i2e (int id, int compdim, int ord, CellGeometry cg, femFileFormat fff)
 INTERNAL to EXTERNAL conversion. More...
 
int ECN_convert_e2i (int id, int compdim, int ord, CellGeometry cg, femFileFormat fff)
 External to Internal conversion. More...
 
int ECN_convert_ips_triangle (bool i2e, int id, femFileFormat fff, IntPointSet ips)
 
int ECN_convert_ips_quadrangle (bool i2e, int id, femFileFormat fff, IntPointSet ips)
 
int ECN_convert_ips_brick (bool i2e, int id, femFileFormat fff, IntPointSet ips)
 
ComponentGeometryallocComponentGeometry (classID cid, Cell *owner, ComponentGeometry *src=NULL)
 
void OOFEM_output_scan_elem_head (const char *str, long o, long i, bool oid)
 
void OOFEM_output_scan_GP (const char *&str, int i, bool old=false)
 
void OOFEM_output_scan_GP (FILE *stream, int i, bool old=false)
 
double SigmaEq (VectoR &s, VectoR &t)
 
template<class T >
void TF_GPA_delete_damned (T &list)
 DELETE components marked by flag "delete". More...
 
template<class T >
void TF_GPA_add_another (GPA< T > &list, T *comp, const Geometry *mg)
 adds component to the end of list of Components More...
 
template<class T >
void TF_GPA_wdg_another (GPA< T > &list, T *comp, const Geometry *mg, long nid)
 
FILE * scan_DATA_head (FILE *stream, const char *str, const char *expnumtype, int *noc, const char *descript)
 
void scan_DATA_field (Stream *stream, const char *str, int nexc, long m, Lmtrx *dataL, Dmtrx *dataD, Lvctr *sprs, const char *name)
 
Elementallocate_element (bool mdl, CellGeometry eg, long gid, long oid, Geometry *geom, int np=0, bool attribs_alloc=true, long dom=0, long lid=-1)
 
void scan_expect_num (FILE *stream, long expctd)
 cte SRDC's I-DEAS UNV soubory More...
 
long give_nstepsOut (FILE *stream, femFileFormat ff, PAType pt, const Problem *Pd)
 
template<class T >
void TF_GPA_cleanup_duplicity (const StdoutDriver *sodriver, T &list, const char *name, char t, bool shake)
 clean up duplicity components More...
 
template<class T >
void TF_GPA_print_list (FILE *stream, const char *name, const char *name2, T &list, long id)
 
void print_VTK_START (Stream *stream, const Mesh *mg, const char *name, VTKdataset ds)
 
void print_VTK_FINISH (Stream *stream)
 
void print_VTK_head (FILE *stream, VTKdataset ds)
 
void print_VTK_init_point_data (Stream *stream, long n)
 
void print_VTK_init_cell_data (Stream *stream, long n)
 
void print_VTK_data_body (Stream *stream, long n, const char *name, const GPA< Array1d > *data, char type, bool r2z=false)
 
void print_dat_file (const char *file, long n, const Dvctr *data1, const Dvctr *data2, bool zeroline)
 print data for xmgrace More...
 
void FEM_solve_OOFEM (Problem *pd)
 
void mesh_generate_T3d (const Problem *pd, const char *solver, const char *options_string)
 
const PointDOFsBCPMgive_uniq_dofbc (int dim, const GPA< const Element > *superelems, const char *name, long id)
 
const char * BN_enum2char (BlockName bn)
 
BlockName BN_char2enum (const char *bn)
 
void read_line (FILE *stream, char *&dest, const char *name)
 reading of line from file More...
 
void filename_decomposition (char *&path, char *&base, char *&suff, const char *name)
 
void addSRCpriorDESTalloc (char *&dest, const char *src)
 
template<class T >
void TF_GPA_reid (GPA< T > &list)
 reset ids ascending More...
 
template<class T >
void TF_GPA_reidoid (GPA< T > &list)
 reset ids ascending More...
 
template<class T >
void TF_GPA_shake_down_reid (GPA< T > &list)
 clear out NULL components More...
 
template<class T >
void TF_GPA_shake_down_reidoid (GPA< T > &list)
 clear out NULL components More...
 
double give_copy_r2z (double a, double zero)
 
double * give_copy_r2z (double *a, long n, double zero)
 
void pprint_symtensor (char *stream, int precision, const long *a)
 
void pprint_symtensor_zeroL (char *stream, int precision)
 
void pprint_symtensor (FILE *stream, int precision, const long *a)
 
void pprint_symtensor_zeroL (FILE *stream, int precision)
 
void pprint_tensor (FILE *stream, int precision, const double *a)
 
void pprint_symtensor (char *stream, int precision, const double *a)
 
void pprint_symtensor (FILE *stream, int precision, const double *a)
 
void pprint_tensor_zero (char *stream, int precision)
 
void pprint_tensor_zero (FILE *stream, int precision)
 
void errorr (const char *file, int line, const char *format,...)
 

*** *** *** *** ERROR FCE *** *** *** ***


More...
 
void warningg (const char *file, int line, const char *format,...)
 
void openFileTest (const FILE *stream, const char *name)
 

*** *** *** *** FILE FCE *** *** *** ***


More...
 
FILE * openFileN (const char *File, int Line, const char *mode, const char *key, const char *name)
 
FILE * openFilePN (const char *File, int Line, const char *mode, const char *key, const char *path, const char *name)
 
FILE * openFilePNS (const char *File, int Line, const char *mode, const char *key, const char *path, const char *name, const char *suff)
 
FILE * openFilePNSS (const char *File, int Line, const char *mode, const char *key, const char *path, const char *name, const char *suff, const char *suff2)
 
const char * trmt_clr_int2clr (ETCLR clr)
 
void change_console_colour (FILE *stream, ETCLR clr)
 
template<class ArgType >
void allocate (ArgType *&p, long a)
 

*** *** *** *** ALLOCATE TEMPLATES *** *** *** ***


More...
 
template<class ArgType >
void allocate (ArgType **&p, long a, long b)
 
template<class ArgType >
void allocate (ArgType ***&p, long a, long b, long c)
 
template<class ArgType >
void deallocateCheck (ArgType *p, bool check=true)
 

*** *** *** *** DEALLOCATE TEMPLATES *** *** *** ***


More...
 
template<class ArgType >
void deallocateCheckUno (ArgType *p, bool check=true)
 
template<class ArgType >
void deallocateCheck (ArgType **p, long a, bool check=true)
 
template<class ArgType >
void deallocateCheckUno (ArgType **p, long a, bool check=true)
 
template<class ArgType >
void deallocateCheck (ArgType ***p, long a, long b, bool check=true)
 
template<class ArgType >
void deallocateCheckUno (ArgType ***p, long a, long b, bool check=true)
 
template<class ArgType >
void deallocateCheck (ArgType ***p, long a, long *b, bool check=true)
 
template<class ArgType >
void fill_all_by (ArgType *p, long a, ArgType value)
 

*** *** *** *** FILL TEMPLATES *** *** *** ***


More...
 
template<class ArgType >
void fill_all_by (ArgType **p, long a, long b, ArgType value)
 
template<class ArgType >
void fill_all_by (ArgType ***p, long a, long b, long c, ArgType value)
 
template<class ArgType >
void fill_row_by (ArgType **p, long i, long m, ArgType value)
 
template<class ArgType >
void fill_col_by (ArgType **p, long n, long j, ArgType value)
 
template<class ArgType >
void allocate_another_val (long n, ArgType *&old_field)
 

*** *** *** *** REALLOCATE TEMPLATES *** *** *** ***


More...
 
template<class ArgType >
void allocate_another_uno_ptr (long n, ArgType **&old_field, long add=1)
 
template<class ArgType >
void setadd_another_uno_ptr (long &n, ArgType **&field, ArgType *p)
 
template<class ArgType >
void shake_down_ptr_array (long &n, ArgType *array)
 

*** *** *** *** VARIOUS TEMPLATES *** *** *** ***


More...
 
template<class ArgType >
long arrays_arenot_identical (long n, ArgType *a1, ArgType *a2)
 
template<class ArgType >
long is_member_of_array (ArgType val, long n, const ArgType *array)
 check out "val" is member of "array" More...
 
template<class ArgType >
bool members_are_unique (long n, const ArgType *array)
 check out all members of array "a" are uniq More...
 
template<class ArgType >
bool same_array_elements_asym (long nx, const ArgType *x, long ny, const ArgType *y, bool same_dim=false)
 Function finds out whether every element of the array 'x' is in the array 'y'. More...
 
template<class ArgType >
bool same_array_elements_sym (long nx, const ArgType *x, long ny, const ArgType *y, bool same_dim=false)
 Function finds out whether every element of the array 'x' is in the array 'y', and symmetrically every element of the array 'y' is in the array 'x'. More...
 
template<class ArgType >
void add_array (long &n1, ArgType *&array1, long n2, const ArgType *array2)
 
template<class ArgType >
void add_array_unique (long &n1, ArgType *&array1, long n2, const ArgType *array2)
 
template<class ArgType >
void interchange2 (ArgType &a, ArgType &b)
 
long intersec_rectangle3d_line (double zero, double norm, const PoinT *A, const PoinT *B, const PoinT *C, const PoinT *D, const PoinT *U, const PoinT *V, double *ksi, double *eta, double *t, PoinT *I1, PoinT *I2)
 ZDROJE http://softsurfer.com/algorithm_archive.htm. More...
 
long nc_brick_3d (double zero, double x[], double y[], double z[], const PoinT *point, PoinT *answer)
 Function computes natural coordinates of 'point' on 'element', 'point' is entered in cartesian coordinates, 'element' is 3d brick=cube=hexahedron. More...
 
double area3D_Polygon (int n, const PoinT **V, const VectoR *N)
 

************************** WWW.SOFTSURFER.COM ALGORITHMS **************************


Copyright 2000, softSurfer (www.softsurfer.com) This code may be freely used and modified for any purpose providing that this copyright notice is included with it. More...

 
int intersect_RayTriangle (double zero, const PoinT *P0, const PoinT *P1, const PoinT *V0, const PoinT *V1, const PoinT *V2, PoinT *I)
 
void dx_bf_lin_hex_3d (double *n, double y, double z)
 function computes derivatives of tri-linear base functions on hexahedron with respect of natural coordinate x More...
 
void dy_bf_lin_hex_3d (double *n, double x, double z)
 function computes derivatives of tri-linear base functions on hexahedron with respect of natural coordinate y More...
 
void dz_bf_lin_hex_3d (double *n, double x, double y)
 function computes derivatives of tri-linear base functions on hexahedron with respect of natural coordinate z More...
 
void jac_3d (double &jac, Dvctr &x, Dvctr &y, Dvctr &z, double xi, double eta, double zeta)
 
int give_edge_points_commperpend_skewlines (const double *l1a, const double *l1b, const double *l2a, const double *l2b, double *p1, double *p2)
 

*** *** *** *** GEOMETRY FUNCTIONS *** *** *** ***


More...
 
long intersec_triangle_line (double zero, double norm, const PoinT *A, const PoinT *B, const PoinT *C, const PoinT *U, const PoinT *V, double *ksi, double *eta, double *t, PoinT *I1, PoinT *I2)
 
bool isWordChar (char C)
 

*** *** *** *** GENERAL FUNCTIONS *** *** *** ***


return true if character C is "normal" char –> C != ' ' '' '
' '\0' '' More...

 
bool isLineChar (char C)
 return true if character C is "normal" char or "space" char –> C != '
' '\0' '' More...
 
bool isSpaceChar (char C)
 return true if character C is "space" char –> C == ' ' '' More...
 
bool isDigitChar (char C)
 
long giveLineLength (const char *src)
 return length of line == sting compount of "line chars" More...
 
char * strdupl (const char *src)
 standard strdup - Memory for the new string is obtained with malloc(3), and can be freed with free(3). More...
 
char * strdupl (const char *src1, const char *src2)
 
char * strdupl (const char *src1, const char *src2, const char *src3)
 
char * pathstrdupl (const char *src)
 
long AP_find_option (int argc, char *argv[], const char *s)
 

*** *** *** *** ARGUMENTS PROCESSING *** *** *** ***


terminology: tar -cz -f archiv.tgz archiv/ /// fce name | arguments /// fce name | options | parameters /// fce name | opt | opt | opt argum. More...

 
void AP_fprint_arguments (FILE *stream, int argc, char *argv[])
 print arguments to stream More...
 
bool FP_skip_comment (FILE *stream)
 

*** *** *** *** FILE PROCESSING *** *** *** ***


general rules for file processing: More...

 
void FP_skip_line_commented (FILE *stream)
 move file descriptor to the start of the new noncommented line, without checking of EOF More...
 
void FP_skip_line_fast_skip_commented (FILE *stream, int n)
 move file descriptor to the start of the n-th new line, without checking of EOF More...
 
bool FP_skip_line (FILE *stream, int n)
 move file descriptor to the start of the n-th new line //[former read_line] More...
 
bool FP_skip_behind_line_starting_with (FILE *stream, const char *string, bool cs)
 move file descriptor to the start of the new line after the one starting with string More...
 
bool FP_skip_to_line_starting_with (FILE *stream, const char *string, bool cs)
 move file descriptor to the line starting with string, exactly behind the string More...
 
bool FP_skip_to_line_starting_with (FILE *stream, char C)
 replacement of old function "read_contiguous_star" move file descriptor to the line starting with character, directly to this char More...
 
bool FP_scan_array (FILE *stream, int n, int *dest)
 scan/copy array of numbers from src to dest, src pointer is shifted over the field More...
 
bool FP_scan_array (FILE *stream, int n, long *dest)
 
bool FP_scan_array (FILE *stream, int n, double *dest)
 
long FP_number_of_words (FILE *stream)
 count number of words (see isWordChar) in file More...
 
long FP_number_of_lines (FILE *stream, bool rwd)
 count number of lines in file More...
 
bool FP_skip_nonword (FILE *stream)
 

*** *** *** SKIPING *** *** ***


skiping == shift stream pointer at the first char which is not ... More...

 
bool FP_skip_space (FILE *stream)
 ... space More...
 
bool FP_skip_word (FILE *stream)
 ... word More...
 
long FP_scan_line_skip_emptyORcommented (FILE *stream, char *dest)
 

*** *** *** SCANNING *** *** ***


scanning == scan ... More...

 
long FP_scan_line (FILE *stream, char *dest)
 scan/copy line == string without '
' from stream More...
 
long FP_scan_line_alloc (FILE *stream, char *&dest)
 scan/copy line == string without '
' from stream; dest is NULL and allocated here More...
 
int FP_scan_word (FILE *src, char *dest)
 ... word; return value is length of the word More...
 
bool FP_skip_expected_string (FILE *src, const char *expctd, bool cs)
 ... word and compare with expected one More...
 
bool FP_scan_expected_word (FILE *src, const char *expctd, bool cs)
 ... word and compare with expected one More...
 
void FP_scan_expected_word_FL (const char *file, int line, FILE *src, const char *expctd, const char *msg, bool cs)
 ... word and compare with expected one, exit if false More...
 
bool FP_scan_expected_line (FILE *src, const char *expctd, bool cs)
 ... line and compare with expected one More...
 
void FP_scan_expected_line_FL (const char *file, int line, FILE *src, const char *expctd, const char *msg, bool cs)
 ... line and compare with expected one, exit if false More...
 
void errorr_expected (const char *file, int line, const char *msg, const char *expctd, const char *src)
 

*** *** *** *** STRING PROCESSING *** *** *** ***


src pointer is always shifted over the skipped/scanned/printed word/number/array word is string separated by ' ', '', '
' or '\0' More...

 
void errorr_expected (const char *file, int line, const char *msg, int expctd, const char *src)
 
void errorr_expected (const char *file, int line, const char *msg, long expctd, const char *src)
 
bool SP_cutcomment (char *src)
 cut of comment == end of line starting by '#' More...
 
bool SP_unskip_space (const char *&src)
 

*** *** *** SKIPING *** *** ***


(un)skiping == shift src pointer at the end(start) of ... More...

 
bool SP_skip_space (const char *&src)
 ... space == ' ' and '' characters More...
 
bool SP_skip_word (const char *&src, int n)
 ... word and space before More...
 
bool SP_skip_int (const char *&src)
 ... word compound of digits and space before More...
 
void SP_unscan_word (const char *&src, const char *w)
 

*** *** *** SCANNING *** *** ***


unscan word == shift pointer back over word More...

 
bool SP_scan_character (const char *&src, char &dest)
 scanning == scan ... to variable dest and shift src pointer at the end of ... More...
 
long SP_scan_word (const char *&src, char *dest)
 ... word; return value is length of the word More...
 
long SP_scan_line (const char *&src, char *dest)
 ... line; return value is length of the line More...
 
long SP_scan_line_alloc (const char *&src, char *&dest)
 ... line; return value is length of the line; dest is NULL and allocated here More...
 
bool SP_scan_expected_word (const char *&src, const char *expctd, bool cs)
 ... word and compare with expected one More...
 
void SP_scan_expected_word_FL (const char *file, int line, const char *&src, const char *expctd, const char *msg, bool cs)
 ... word and compare with expected one/two/three, exit if false More...
 
void SP_scan_expected_word_FL (const char *file, int line, const char *&src, const char *expctd1, const char *expctd2, const char *msg, bool cs)
 
void SP_scan_expected_word_FL (const char *file, int line, const char *&src, const char *expctd1, const char *expctd2, const char *expctd3, const char *msg, bool cs)
 
bool SP_scan_number (const char *&src, int &dest)
 ... number of type int/long/double More...
 
bool SP_scan_number (const char *&src, long &dest)
 
bool SP_scan_number (const char *&src, double &dest)
 
bool SP_scan_array_L (const char *&src, int L, double *a)
 
bool SP_scan_Dvctr_exit (const char *&src, int n, Dvctr *v)
 
bool SP_print_space (const char *&src, FILE *stream)
 

*** *** *** PRINTING *** *** ***


printing == print ... More...

 
bool SP_print_word (const char *&src, FILE *stream)
 ... word More...
 
long find_double (long n, long *p)
 

*** *** *** *** OBSOLETE FUNCTIONS *** *** *** ***


More...
 
void sprint_param (char *s, char *argv[], int n)
 
void read_star_end (FILE *stream, int n)
 
void read_star (FILE *stream)
 
void copy_star_end (FILE *sour, FILE *dest, int n=1)
 read line of file until
, no save, dava bacha na EOF More...
 
void copy_star (FILE *sour, FILE *dest)
 
void copy_line (FILE *sour, FILE *dest, int n)
 
void copy_to_end_line (FILE *sour, FILE *dest)
 
void copy_file (FILE *sour, FILE *dest)
 
int extract_long (const char *s1, const char *s2, long &a)
 
int extract_double (const char *s1, const char *s2, double &a)
 v retezci s1 se najde key retezec s2 a za nim se precte double More...
 
void ad_line (FILE *stream, char *s)
 
template<class ArgType >
bool SP_scan_expected_number (const char *&src, ArgType expctd)
 ... number and compare with expected one More...
 
template<class ArgType >
void SP_scan_expected_number_FL (const char *file, int line, const char *&src, ArgType expctd, const char *msg)
 ... number and compare with expected one, exit if false More...
 
template<class ArgType >
bool SP_scan_array (const char *&src, int n, ArgType *a)
 ... array of numbers More...
 
template<class ArgType >
bool SP_scan_array (const char *&src, long n, ArgType *a)
 
template<class ArgType >
bool SP_scan_array_alloc (const char *&src, long &n, ArgType *&a)
 
template<class ArgType >
bool SP_scan_Xvctr (const char *&src, ArgType *dest)
 bool SP_scan_Dvctr (const char *&src, Dvctr *dest); More...
 
void extract_double_array (const char *s1, const char *s2, long n, double *a)
 
void give_line (FILE *stream, char *&s)
 
void shaker (long &n, long *a)
 zlikviduje vicenasobne cifry pro long in <0;..> More...
 
void sort_4 (long *x)
 Function sorts first four members of array with ascending order. More...
 
void sort_3 (long *x)
 Function sorts first three members of array with ascending order. More...
 
void sort_2 (long *x)
 Function sorts first two members of array with ascending order. More...
 
void solve_3 (const double *m, const double *r, double *l)
 Function solves the system of linear equations. More...
 
void solve_3 (const double **m, const double *r, double *l)
 Function solves the system of linear equations. More...
 
long solv_2nle (double zero, const double *a, const double *b, const double *c, const double *d, double *x, double *y)
 function solves system of two non-linear equations: a[0]*x*y + b[0]*x + c[0]*y + d[0] = 0 a[1]*x*y + b[1]*x + c[1]*y + d[1] = 0 answer: -1 = infinite number of results 0,1,2 = number of results More...
 
long solv_2le (double zero, const double *a, const double *b, const double *c, double &x, double &y)
 function solves system of two linear equations: a[0]*x + b[0]*y + c[0] = 0 a[1]*x + b[1]*y + c[1] = 0 answer: -1 = infinite number of results 0,1 = number of results More...
 
long solv_1le (double zero, double a, double b, double &x)
 function solves linear equation: a*x + b = 0 answer: -1 = infinite number of results 0,1 = number of results More...
 
void nilling (double zero, double &a)
 
double nillret (double zero, double a)
 
bool isZero (double zero, double a)
 
bool isZero (double abszero, double relzero, double a)
 
long solv_polynom_2 (double zero, double a, double b, double c, double &r1, double &r2)
 function searchs roots of polynom of 2nd order = quadratic equation a*x^2 + b*x + c = 0 answer: -1 = infinite number of results 0,1,2 = no,one,two results More...
 
long div_dd (double d1, double d2, const char *s1, const char *s2, const long line)
 
long div_dd (long &answer, double d1, double d2)
 
long div_dd (int &answer, double d1, double d2)
 
int decomp_int (int answer[], int n, int l, int rad)
 
long decomp_int (int answer[], int n, long l, long rad)
 
long long decomp_int (int answer[], int n, long long l, long long rad)
 
bool isNonZero (double x, double tolerance)
 
bool ST_scan_number (Stream *src, int &dest)
 

*** *** *** *** TINYXML FCE *** *** *** ***


More...
 
bool ST_scan_number (Stream *src, long &dest)
 
bool ST_scan_number (Stream *src, double &dest)
 
bool ST_scan_array (Stream *src, int n, int *dest)
 
bool ST_scan_array (Stream *src, int n, long *dest)
 
bool ST_scan_array (Stream *src, int n, double *dest)
 
long GP_scan_line (Stream *stream, char *dest)
 ... line; return value is length of the line More...
 
long GP_scan_line_alloc (Stream *stream, char *&dest)
 ... line; return value is length of the line; dest is NULL and allocated here More...
 
long GP_scan_line_alloc_skip_commented (Stream *stream, char *&dest)
 
long GP_scan_word (Stream *stream, char *dest)
 ... word; return value is length of the word More...
 
const XMLElementXP_give_unique_expected_elem (const XMLNode *xelem, const char *name, bool uniq)
 
void XP_check_expected_attribute (const XMLNode *xelem, const char *name, const char *value)
 
const char * XP_giveDAtext (const XMLNode *xelem, int n, bool last, const char *format, const char *type, const char *name, int *noc)
 
XMLDocumentopenTXdcPN (const char *path, const char *name)
 

*** *** *** *** TINYXML FCE *** *** *** ***


More...
 
XMLDocumentopenTXdcPNSS (const char *path, const char *name, const char *suff, const char *suff2)
 

Variables

static const int TRIANGLE_IPN_OOFEM_3_I2E [3] = { 2, 3, 1 }
 
static const int TRIANGLE_IPN_OOFEM_3_E2I [3] = { 3, 1, 2 }
 
static const int TRIANGLE_IPN_OOFEM_4_I2E [4] = { 2, 3, 1, 4 }
 
static const int TRIANGLE_IPN_OOFEM_4_E2I [4] = { 3, 1, 2, 4 }
 
static const int BRICK_NN_SIFEL [8] = { 3, 2, 1, 4, 7, 6, 5, 8 }
 
static const int BRICK_EN_OOFEM [12] = { 1, 2, 3, 4, 9, 10, 11, 12, 5, 6, 7, 8 }
 
static const int BRICK_EN_SIFEL_I2E [12] = { 2, 1, 4, 3, 10, 9, 12, 11, 7, 6, 5, 8 }
 
static const int BRICK_EN_SIFEL_E2I [12] = { 2, 1, 4, 3, 11, 10, 9, 12, 6, 5, 8, 7 }
 
static const int BRICK_FN_SIFEL_I2E [6] = { 5, 6, 3, 2, 1, 4 }
 
static const int BRICK_FN_SIFEL_E2I [6] = { 5, 4, 3, 6, 1, 2 }
 

Enumeration Type Documentation

Adaptivity paramaters.

Enumerator
ADOA_Void 
ADPA_ZZ 
ADPA_SPR 

Definition at line 281 of file taux.h.

Enumerator
DvctrClass 
LvctrClass 
DscalClass 

Definition at line 269 of file arrays.h.

Enumerator
ATlong 
ATdouble 

Definition at line 270 of file arrays.h.

Enumerator
ASG_non 
ASG_prop 
ASG_id 
ASG_coord 
ASG_faceprop 

Definition at line 399 of file attribute.h.

Enumerator
BC_Void 
BC_OOFEM 
BC_SIFEL 
BC_PV 
BC_NL 
BC_CEL 
BC_CFL 
BC_CBL 
BC_DW 
cBCTypes 

Definition at line 566 of file alias.h.

Enumerator
BN_Void 
BN_COMM 
BN_OFN 
BN_ANAL 
BN_DOMN 
BN_OUTP 
BN_CS 
BN_MAT 
BN_BC 
BN_PV 
BN_NODES 
BN_ELEMS 
BN_NL 
BN_CEL 
BN_CFL 
BN_CBL 
BN_HN 
BN_RAN 
BN_LTF 
BN_EXTRCT 
BN_FIXED 

Definition at line 21 of file problem.h.

Enumerator
CG_Void 
CG_Line 
CG_PolyLine 
CG_Triangle 
CG_Quadrangle 
CG_Polygon 
CG_Tetrahedron 
CG_Hexahedron 
CG_Wedge 
CG_Pyramid 
cCG 

Definition at line 840 of file alias.h.

Type introduced to distinguish between classes.

Enumerator
classVoid 
classComponentGeometry 
classComponentGeometry1D 
classComponentGeometry1Dpoly 
classComponentGeometry2D 
classComponentGeometry2Dtriangle 
classComponentGeometry2Dquadrangle 
classComponentGeometry2Dpolygon 
classComponentGeometry3D 
classComponentGeometry3Dhexahedron 
classComponentGeometry3Dtetrahedron 
classVertex 
classNode 
classHangingNode 
classRigidArmNode 
classEdge 
classFace 
classPolyLine 
classLine 
classPolygonMdl 
classBeam 
classTriangle 
classQuadrangle 
classBrick 
classTetra 
classModel 
classMesh 
classAttribute 
classProblemAnalysis 
classCrossSection 
classMaterial 
classBoundaryCond 
classABC_NLoad 
classABC_CELoad 
classABC_CFLoad 
classABC_CBLoad 
classElemAttribs 
classGelemAttribs 
classFEelemAttribs 
classPointAttribs 
classRANAttribs 
classHNAttribs 

Definition at line 142 of file alias.h.

Enumerator
CST_Void 
CST_OOFEM 
CST_SIFEL 
CST_SimpleCS 
CST_LayeredCS 
CST_FiberedCS 
CST_Truss 
CST_2d 
CST_3d 
CST_Beam 
CST_Rectangle 
CST_Rectangle_tube 
CST_Circle 
CST_Circle_tube 
CST_Circle_cable 
CST_1d_rolled 
cCrossSectTypes 

Definition at line 435 of file alias.h.

Enumerator
DPN_Void 
DPN_Dxy_R___ 
DPN_Dxy_R__z 
DPN_D__zRxy_ 
DPN_DxyzR___ 
DPN_DxyzRxyz 
DPN_TR_1 
DPN_TR_2 

Definition at line 700 of file alias.h.

DOF type == physical meaning of dof; see help.txt.

Enumerator
DOF_Void 
DOF_Dx 
DOF_Dy 
DOF_Dz 
DOF_Rx 
DOF_Ry 
DOF_Rz 
DOF_Tm 

Definition at line 698 of file alias.h.

Enumerator
EAL_Void 
EAL_direct 
EAL_property 
EAL_geometry 
EAL_subdom 
EAL_domain 

Definition at line 702 of file attribute.h.

enum

Enumerator
ETC_VOID 
ETC_B_BLACK 
ETC_D_BLACK 
ETC_B_RED 
ETC_D_RED 
ETC_B_GREEN 
ETC_D_GREEN 
ETC_B_YELLOW 
ETC_D_YELLOW 
ETC_B_BLUE 
ETC_D_BLUE 
ETC_B_VIOLET 
ETC_D_VIOLET 
ETC_B_CYAN 
ETC_D_CYAN 
ETC_B_WHITE 
ETC_D_WHITE 
ETC_DEFAULT 

Definition at line 89 of file gelib.h.

finite element approximation

Enumerator
FEA_Void 
FEA_default 
FEA_linear 
FEA_bilinear 
FEA_133133 

Definition at line 937 of file alias.h.

Enumerator
FFF_Void 
FFF_VTK 

MIDAS i/o vtk ff.

FFF_VTP 

MIDAS i/o vtp ff.

FFF_VTU 

MIDAS i/o vtu ff.

FFF_UNV 

MIDAS i/o unv ff.

FFF_JKTK 

jktk i/o

FFF_T3d 

t3d i/o native ff

FFF_ANSYS 

ansys i/o native ff

FFF_OOFEM 

oofem i/o native ff

FFF_SIFEL 

sifel i/o native ff

FFF_MIDAS 

MIDAS input native ff - pro specialni potreby.

FFF_POLYLINE 

MIDAS input native ff - for mesh of polylines.

FFF_VTX 

MIDAS i/o vt* ff.

FFF_MELNIK 

special one time format for bridge in Melnik

FFF_VLNA 

special one time format for sculpture GDF142

Definition at line 632 of file alias.h.

Enumerator
FET_Void 
FET_OOFEM_Truss2d 
FET_OOFEM_Truss3d 
FET_OOFEM_LiBeam3d 
FET_OOFEM_LiBeam3dNL 
FET_OOFEM_Beam2d 
FET_OOFEM_Beam3d 
FET_OOFEM_TrPlaneStrain 
FET_OOFEM_Quad1PlaneStrain 
FET_OOFEM_TrPlaneStress2d 
FET_OOFEM_PlaneStress2d 
FET_OOFEM_TrPlaneStress2dRot 
FET_OOFEM_Tr_Shell01 
FET_OOFEM_RerShell 
FET_OOFEM_LSpace 
FET_OOFEM_QTrSpace 
FET_SIFEL_bar3d 
FET_SIFEL_beam3d 
FET_SIFEL_planeelementlt 
FET_SIFEL_planeelementlq 
FET_SIFEL_linearhex 
FET_SIFEL_trlint 
FET_SIFEL_quadlint 
FET_ANSYS_start 
FET_ANSYS_BEAM188 
FET_ANSYS_SHELL181 
FET_ANSYS_end 

Definition at line 995 of file alias.h.

Enumerator
IPS_Void 
IPS_1D_1ip 
IPS_1D_exact 
IPS_2D_3v_1ip 
IPS_2D_3v_3ip 
IPS_2D_3v_4ip 
IPS_2D_3v_shell 
IPS_2D_4v_4ip 
IPS_3D_8v_8ip 

Definition at line 1248 of file alias.h.

Enumerator
LCSd_Void 
LCSd_xy 
LCSd_xz 

Definition at line 217 of file taux.h.

Enumerator
LCSt_Void 
LCSt_NodeID 
LCSt_NodeProp 
LCSt_NodeCoords 
LCSt_Vector 

Definition at line 218 of file taux.h.

Linear solver type.

Enumerator
LST_Void 
LST_ldl 
LST_gauss 

Definition at line 293 of file alias.h.

Enumerator
MAT_Void 
MAT_OOFEM 
MAT_SIFEL 
MAT_IsoLE 
MAT_IsoTrans 
MAT_RIGID 
MAT_j2mat 
cMaterialTypes 

Definition at line 505 of file alias.h.

type of mesh generator

Enumerator
MGT_Void 
MGT_T3d 

Definition at line 191 of file alias.h.

Enumerator
MMP_Void 
MMP_primary 
MMP_secondary 
MMP_RFbyHN 

Definition at line 616 of file alias.h.

Enumerator
OM_Void 
OM_Convert 
OM_Design2design 
OM_Design2solver 
OM_Solver2design 
OM_Test 

Definition at line 19 of file problem.h.

The group of problem analysis.

Enumerator
PAG_Void 
PAG_mechanics 
PAG_transport 

Definition at line 367 of file alias.h.

Enumerator
PAT_Void 
PAT_OOFEM 
PAT_SIFEL 
PAT_static_linear_adapt 
PAT_static_linear 
PAT_static_nonlinear 
PAT_dynamic_PNlDEI 
PAT_stability_linear 
PAT_stationary 
PAT_nonstationary 
cPAT 

Definition at line 369 of file alias.h.

ProbDesc Boolean Option.

Enumerator
PDBO_allElemsProp1 
PDBO_BondEndRFran 
PDBO_uncfrd 
PDBO_MultipNode 
PDBO_MultipElem 
PDBO_preserveGeom 
PDBO_RIGIDmatToRAN 
PDBO_divideQuads 
PDBO_hingedBeamToTruss 
PDBO_tmpFileWrite2hdd 
PDBO_cutRF 
PDBO_OUT_print_property 
PDBO_OUT_print_parent_property 
PDBO_OUT_print_model_parent 
PDBO_OUT_print_CSusage 
PDBO_OUT_Test 
PDBO_OUT_MeshQual 
PDBO_OUT_MeshStats 
PDBO_OUT_origelemid 
PDBO_OUT_CabTenOnly 
PDBO_OUT_charVTK 
PDBO_OUT_solverINctrl 
PDBO_OUT_args 
PDBO_P_mesh_quads 
PDBO_P_rershell 
PDBO_P_dw 
PDBO_P_refder 
PDBO_ansys 
PDBO_stability 
PDBO_Vlna 
PDBO_melnik 
cPDBO 

Definition at line 24 of file problem.h.

Result type at element.

  • Array dimension depends on RTE, [NIP ; ncomps_of_stress] for RTE_stress or [NIP ; dim*nmedia] for RTE_gradient or ...
    • NIP has to be equal to this->give_NIP(sol)

RSLTSST_2dstrain RSLTSST_2dstress RTE_strain - [Ex Ey Ez Eyz Exz Exy ] - Ex je strain - vsechny slozky prodlouzeni/zkraceni [-] RTE_stress - [Sx Sy Sz Syz Sxz Sxy ] - Sx je stress - vsechny slozky napeti [Pa]

RTE = Result Types at Element Results are stored in MIDAS format:

SStype RTE vector comment

SST_truss only in local cs of the truss element RTE_global_strain [ex] - ex je strain - jen jedna hodnota relativniho prodlouzeni/zkraceni [-] RTE_global_stress [sx] - sx je stress - jen jedna hodnota napeti tah/tlak [Pa] SST_beam RTE_global_strain [-] - beam - abs. hodnoty na zac a na konc.; libeam relativni prevedu na 0 na zacatku a abs na konci, ale mam v tom gulas, zatim nevim presne co od toho chci RTE_global_stress [N Vy Vz Mx My Mz N Vy Vz Mx My Mz] - koncove sily na zacatku a konci prutu, oba maji stejne znamenko = konec prutu odriznut od konce [N,Nm] SST_2dstress RTE_global_strain [Ex Ey Exy ] - Ex je strain - relativni prodlouzeni/zkraceni [-] RTE_global_stress [Sx Sy Sxy ] - Sx je stress - napeti v ose x, y a smyk xy [Pa] SST_3dshell the generalized strain and generalized integral stress vector RTE_global_strain [ex ey ez gyz gxz gxy kx ky kz kyz kxz kxy] - 3 membrane normal and 3 shear deformations and 6 curvatures RTE_global_stress [nx ny nz vyz vxz vxy mx my mz myz mxz mxy] - 3 membrane normal and 3 shear forces and 6 moments RTE_localOO_strain [ex ey 0 gyz gxz gxy kx ky 0 0 0 kxy] - local = 4 null components RTE_localOO_stress [nx ny 0 vyz vxz vxy mx my 0 0 0 mxy] - OOFEM local coordinates - x = P2-P1, y= direction P3, z = y x x

Enumerator
RTE_global_strain 
RTE_global_stress 
RTE_localOO_strain 
RTE_localOO_stress 
RTE_layered_strain 
RTE_layered_stress 
RTE_plaststrain 
RTE_gradient 
RTE_fluxes 
RTE_ada_error_pct_l 
RTE_ada_error_pct_g 
RTE_ada_h_act 
RTE_ada_h_new 
RTE_ada_normal 
RTE_ada_eia 
cRTE 
RTE_Void 

Definition at line 240 of file alias.h.

Result type at node.

Enumerator
RTN_displacement 

displacement, N=ndofs

RTN_reaction 

reaction, N=ndofs

RTN_transpunknowns 

unknows in transport, N=ndofs

RTN_ada_refder 

adaptivity, refined derivatives

RTN_ada_h_act 

adaptivity, element characteristic size, actual

RTN_ada_h_new 

adaptivity, element characteristic size, new

cRTN 

count of ...

Definition at line 204 of file alias.h.

Result variable type.

Enumerator
RVT_Void 
RVTstrn 
RVTstrs 
RVTstrn_displ 
RVTstrn_rotat 
RVTstrs_displ 
RVTstrs_rotat 
RVTstrn_displ_local_main 
RVTstrn_rotat_local_main 
RVTstrs_displ_local_main 
RVTstrs_rotat_local_main 
RVTstrs_grad 

Definition at line 194 of file alias.h.

Enumerator
SODE_Void 
SODE_start_blue_arrow 
SODE_row 
SODE_end 
SODE_end_green_ok 
SODE_green_ok 

Definition at line 349 of file taux.h.

Solver.

Enumerator
SOL_Void 
SOL_OOFEM 
SOL_SIFEL 
SOL_ANSYS 

Definition at line 188 of file alias.h.

typ spr patche, závisí na typu/geometrii elementů

Enumerator
SPRPT_Void 
SPRPT_2d 

Definition at line 338 of file alias.h.

type of stress/strain state of element; especially results depends on this variable => described at Mesh :: print_results

Enumerator
SST_Void 
SST_truss 
SST_beam 
SST_plstress 
SST_plstrain 
SST_plate 
SST_3dshell 
SST_3d 
SST_transp2d 
cSSTypes 

Definition at line 954 of file alias.h.

Stiffness matrix type.

Enumerator
SMT_Void 
SMT_initial 
SMT_tangent 

Definition at line 269 of file alias.h.


*** *** *** *** CLASS STREAM *** *** *** ***


Enumerator
STRM_void 
STRM_file 
STRM_tixel 
STRM_string 

Definition at line 43 of file tixy2.h.

VTK data set.

Enumerator
VTKDS_Void 
VTKDS_polydata 
VTKDS_unstruct 

Definition at line 201 of file alias.h.

VTK type of cell topology for POLYDATA.

Enumerator
VTKPD_Void 
VTKPD_VERTICE 
VTKPD_LINE 
VTKPD_POLYGON 
VTKPD_TRIANGLE_STRIP 

Definition at line 931 of file alias.h.

Enumerator
VTKR_void 
VTKR_points 
VTKR_cells 
VTKR_lines 
VTKR_polygs 
VTKR_pred 
VTKR_pd 
VTKR_cd 
VTKR_scals 

Definition at line 559 of file geometry.cpp.

Function Documentation

void midaspace::ad_line ( FILE *  stream,
char *  s 
)

Definition at line 728 of file librw.cpp.

template<class ArgType >
void midaspace::add_array ( long &  n1,
ArgType *&  array1,
long  n2,
const ArgType *  array2 
)

Definition at line 364 of file gelib.h.

template<class ArgType >
void midaspace::add_array_unique ( long &  n1,
ArgType *&  array1,
long  n2,
const ArgType *  array2 
)

Definition at line 380 of file gelib.h.

References is_member_of_array().

void midaspace::addSRCpriorDESTalloc ( char *&  dest,
const char *  src 
)

Definition at line 47 of file taux.cpp.

References strdupl().

Referenced by midaspace::FiLe::addGlobPath().

template<class ArgType >
void midaspace::allocate ( ArgType *&  p,
long  a 
)


*** *** *** *** ALLOCATE TEMPLATES *** *** *** ***


Definition at line 183 of file gelib.h.

Referenced by allocate(), midaspace::DuplicatePoints::assign_cellpoints(), and midaspace::DuplicatePoints::find_duplicitys().

template<class ArgType >
void midaspace::allocate ( ArgType **&  p,
long  a,
long  b 
)

Definition at line 184 of file gelib.h.

References allocate().

template<class ArgType >
void midaspace::allocate ( ArgType ***&  p,
long  a,
long  b,
long  c 
)

Definition at line 185 of file gelib.h.

References allocate().

template<class ArgType >
void midaspace::allocate_another_uno_ptr ( long  n,
ArgType **&  old_field,
long  add = 1 
)

Definition at line 262 of file gelib.h.

Referenced by setadd_another_uno_ptr().

template<class ArgType >
void midaspace::allocate_another_val ( long  n,
ArgType *&  old_field 
)


*** *** *** *** REALLOCATE TEMPLATES *** *** *** ***


Definition at line 251 of file gelib.h.

References _errorr.

Referenced by midaspace::DuplicatePoints::add_point_to_cell().

Element* midaspace::allocate_element ( bool  mdl,
CellGeometry  eg,
long  gid,
long  oid,
Geometry *  geom,
int  np = 0,
bool  attribs_alloc = true,
long  dom = 0,
long  lid = -1 
)
ComponentGeometry* midaspace::allocComponentGeometry ( classID  cid,
Cell *  owner,
ComponentGeometry *  src = NULL 
)
long midaspace::AP_find_option ( int  argc,
char *  argv[],
const char *  s 
)


*** *** *** *** ARGUMENTS PROCESSING *** *** *** ***


terminology: tar -cz -f archiv.tgz archiv/ /// fce name | arguments /// fce name | options | parameters /// fce name | opt | opt | opt argum.

pass through arguments looking for option "s" [former find_param]

| parameters /// argv[0] argv[1] ... ... argv[argc-1] pass through arguments looking for option "s" return position of the option, 0 if not found

Definition at line 97 of file librw.cpp.

References _STRCASECMP.

Referenced by main(), and parameters().

void midaspace::AP_fprint_arguments ( FILE *  stream,
int  argc,
char *  argv[] 
)

print arguments to stream

print arguments to stream [former print_command_line]

Definition at line 106 of file librw.cpp.

double midaspace::area3D_Polygon ( int  n,
const PoinT **  V,
const VectoR *  N 
)


************************** WWW.SOFTSURFER.COM ALGORITHMS **************************


Copyright 2000, softSurfer (www.softsurfer.com) This code may be freely used and modified for any purpose providing that this copyright notice is included with it.

SoftSurfer makes no warranty for this code, and cannot be held liable for any real or imagined damage resulting from its use. Users of this code must verify correctness for their application.

Definition at line 443 of file geometrylib.cpp.

References midaspace::Elem3D::x, midaspace::Elem3D::y, and midaspace::Elem3D::z.

Referenced by midaspace::ComponentGeometry2D::initialize().

template<class ArgType >
long midaspace::arrays_arenot_identical ( long  n,
ArgType *  a1,
ArgType *  a2 
)
const char* midaspace::BCType_e2s_OOFEM ( BCType  val)
inline

Definition at line 587 of file alias.h.

References _errorr2, and BC_CFL.

BCType midaspace::BCType_s2e_OOFEM ( const char *  val)
inline

Definition at line 577 of file alias.h.

References BC_CEL, BC_CFL, BC_DW, BC_NL, BC_Void, and STRCMP.

Referenced by midaspace::BoundaryCond::initialize_from().

BlockName midaspace::BN_char2enum ( const char *  bn)
inline
const char* midaspace::BN_enum2char ( BlockName  bn)
inline
int midaspace::CellGeometry_e2i_JKTK ( CellGeometry  cg)
inline
int midaspace::CellGeometry_e2i_VTK ( CellGeometry  cg)
inline
CellGeometry midaspace::CellGeometry_i2e_HN ( int  val)
inline
CellGeometry midaspace::CellGeometry_i2e_JKTK ( int  val)
inline
CellGeometry midaspace::CellGeometry_i2e_VTK ( int  val)
inline
void midaspace::change_console_colour ( FILE *  stream,
ETCLR  clr 
)
inline

Definition at line 129 of file gelib.h.

References CHANGE_CONSOLE_COLOUR, and trmt_clr_int2clr().

Referenced by midaspace::StdoutDriver::print_info_message_core().

void midaspace::copy_file ( FILE *  sour,
FILE *  dest 
)

Definition at line 702 of file librw.cpp.

void midaspace::copy_line ( FILE *  sour,
FILE *  dest,
int  n 
)

Definition at line 689 of file librw.cpp.

Referenced by copy_star_end().

void midaspace::copy_star ( FILE *  sour,
FILE *  dest 
)

Definition at line 683 of file librw.cpp.

Referenced by copy_star_end().

void midaspace::copy_star_end ( FILE *  sour,
FILE *  dest,
int  n 
)

read line of file until
, no save, dava bacha na EOF

Definition at line 679 of file librw.cpp.

References copy_line(), and copy_star().

void midaspace::copy_to_end_line ( FILE *  sour,
FILE *  dest 
)

Definition at line 695 of file librw.cpp.

int midaspace::CrossSectType_e2i_SIFEL ( CrossSectType  val,
PAGroup  pg 
)
inline
CrossSectType midaspace::CrossSectType_i2e_SIFEL ( int  val,
PAGroup  pg 
)
inline
template<class ArgType >
void midaspace::deallocateCheck ( ArgType *  p,
bool  check = true 
)
template<class ArgType >
void midaspace::deallocateCheck ( ArgType **  p,
long  a,
bool  check = true 
)

Definition at line 204 of file gelib.h.

References _warningg, and deallocateCheck().

template<class ArgType >
void midaspace::deallocateCheck ( ArgType ***  p,
long  a,
long  b,
bool  check = true 
)

Definition at line 216 of file gelib.h.

References _warningg, and deallocateCheck().

template<class ArgType >
void midaspace::deallocateCheck ( ArgType ***  p,
long  a,
long *  b,
bool  check = true 
)

Definition at line 226 of file gelib.h.

References _warningg, and deallocateCheck().

template<class ArgType >
void midaspace::deallocateCheckUno ( ArgType *  p,
bool  check = true 
)

Definition at line 197 of file gelib.h.

References _warningg.

Referenced by deallocateCheckUno(), midaspace::FElement::~FElement(), and midaspace::Node::~Node().

template<class ArgType >
void midaspace::deallocateCheckUno ( ArgType **  p,
long  a,
bool  check = true 
)

Definition at line 209 of file gelib.h.

References _warningg, and deallocateCheckUno().

template<class ArgType >
void midaspace::deallocateCheckUno ( ArgType ***  p,
long  a,
long  b,
bool  check = true 
)

Definition at line 221 of file gelib.h.

References _warningg, and deallocateCheckUno().

int midaspace::decomp_int ( int  answer[],
int  n,
int  l,
int  rad 
)

Definition at line 384 of file mathlib.cpp.

long midaspace::decomp_int ( int  answer[],
int  n,
long  l,
long  rad 
)

Definition at line 389 of file mathlib.cpp.

long long midaspace::decomp_int ( int  answer[],
int  n,
long long  l,
long long  rad 
)

Definition at line 394 of file mathlib.cpp.

long midaspace::div_dd ( double  d1,
double  d2,
const char *  s1,
const char *  s2,
const long  line 
)

Definition at line 360 of file mathlib.cpp.

Referenced by div_dd().

long midaspace::div_dd ( long &  answer,
double  d1,
double  d2 
)

Definition at line 367 of file mathlib.cpp.

long midaspace::div_dd ( int &  answer,
double  d1,
double  d2 
)

Definition at line 374 of file mathlib.cpp.

References div_dd().

int* midaspace::DOFsPerNode2dofBCmask ( DOFsPerNode  od)
inline
int midaspace::DOFsPerNode2nDOFs ( DOFsPerNode  od)
inline
const char* midaspace::DOFsPerNode2OOFEMdomain ( DOFsPerNode  od)
inline
bool midaspace::DOFsPerNode2rotDOFsPresence ( DOFsPerNode  od)
inline
DOFsPerNode midaspace::DOFsPerNode_s2e ( const char *  val)
inline
const char* midaspace::DOFtype_i2s_ANSYS ( DOFtype  dt)
inline

Definition at line 807 of file alias.h.

References _errorr, DOF_Dx, DOF_Dy, DOF_Dz, DOF_Rx, DOF_Ry, and DOF_Rz.

Referenced by midaspace::PointAttribs::print_supported_BC_to_line().

const char* midaspace::DOFtype_i2s_force_ANSYS ( DOFtype  dt)
inline

Definition at line 820 of file alias.h.

References _errorr, DOF_Dx, DOF_Dy, DOF_Dz, DOF_Rx, DOF_Ry, and DOF_Rz.

Referenced by midaspace::PointAttribs::print_bc().

void midaspace::dx_bf_lin_hex_3d ( double *  n,
double  y,
double  z 
)

function computes derivatives of tri-linear base functions on hexahedron with respect of natural coordinate x

Parameters
n- array of derivatives of base functions
y,z- natural coodinates

Definition at line 567 of file geometrylib.cpp.

Referenced by jac_3d().

void midaspace::dy_bf_lin_hex_3d ( double *  n,
double  x,
double  z 
)

function computes derivatives of tri-linear base functions on hexahedron with respect of natural coordinate y

Parameters
n- array of derivatives of base functions
x,z- natural coodinates

Definition at line 587 of file geometrylib.cpp.

Referenced by jac_3d().

void midaspace::dz_bf_lin_hex_3d ( double *  n,
double  x,
double  y 
)

function computes derivatives of tri-linear base functions on hexahedron with respect of natural coordinate z

Parameters
n- array of derivatives of base functions
x,y- natural coodinates

Definition at line 607 of file geometrylib.cpp.

Referenced by jac_3d().

int midaspace::ECN_convert_e2i ( int  id,
int  compdim,
int  ord,
CellGeometry  cg,
femFileFormat  fff 
)
inline
int midaspace::ECN_convert_edges_beam ( bool  i2e,
int  id,
femFileFormat  fff 
)
inline

Definition at line 1588 of file alias.h.

Referenced by ECN_convert_i2e().

int midaspace::ECN_convert_edges_brick ( bool  i2e,
int  id,
femFileFormat  fff 
)
inline
int midaspace::ECN_convert_edges_quadrangle ( bool  i2e,
int  id,
femFileFormat  fff 
)
inline

Definition at line 1714 of file alias.h.

References _errorr, FFF_OOFEM, and FFF_T3d.

Referenced by ECN_convert_e2i(), and ECN_convert_i2e().

int midaspace::ECN_convert_edges_triangle ( bool  i2e,
int  id,
femFileFormat  fff 
)
inline

Definition at line 1624 of file alias.h.

References _errorr, FFF_OOFEM, and FFF_T3d.

Referenced by ECN_convert_e2i(), and ECN_convert_i2e().

int midaspace::ECN_convert_faces_brick ( bool  i2e,
int  id,
femFileFormat  fff 
)
inline

Definition at line 1841 of file alias.h.

References _errorr, BRICK_FN_SIFEL_E2I, BRICK_FN_SIFEL_I2E, FFF_JKTK, FFF_OOFEM, FFF_SIFEL, and FFF_T3d.

Referenced by ECN_convert_e2i(), and ECN_convert_i2e().

int midaspace::ECN_convert_faces_triangle ( bool  i2e,
int  id,
femFileFormat  fff 
)
inline

Definition at line 1634 of file alias.h.

Referenced by ECN_convert_i2e().

int midaspace::ECN_convert_i2e ( int  id,
int  compdim,
int  ord,
CellGeometry  cg,
femFileFormat  fff 
)
inline
int midaspace::ECN_convert_ips_brick ( bool  i2e,
int  id,
femFileFormat  fff,
IntPointSet  ips 
)
inline

Definition at line 1869 of file alias.h.

References _errorr, errol, FFF_OOFEM, and IPS_3D_8v_8ip.

Referenced by midaspace::Brick::read_output_OOFEM().

int midaspace::ECN_convert_ips_quadrangle ( bool  i2e,
int  id,
femFileFormat  fff,
IntPointSet  ips 
)
inline

Definition at line 1733 of file alias.h.

References _errorr, errol, FFF_OOFEM, and IPS_2D_4v_4ip.

Referenced by midaspace::Quadrangle::read_output_OOFEM().

int midaspace::ECN_convert_ips_triangle ( bool  i2e,
int  id,
femFileFormat  fff,
IntPointSet  ips 
)
inline
int midaspace::ECN_convert_nodes_beam ( bool  i2e,
int  id,
femFileFormat  fff 
)
inline
  • MIDAS has internal ECN
  • ECN from different file formats (OOFEM, SIFEL, T3D, VTK, etc.) has to be converted to the internal one

Definition at line 1587 of file alias.h.

Referenced by ECN_convert_e2i(), and ECN_convert_i2e().

int midaspace::ECN_convert_nodes_brick ( bool  i2e,
int  id,
femFileFormat  fff 
)
inline

Definition at line 1779 of file alias.h.

References _errorr, BRICK_NN_SIFEL, FFF_JKTK, FFF_OOFEM, FFF_SIFEL, FFF_T3d, and FFF_VTX.

Referenced by ECN_convert_e2i(), and ECN_convert_i2e().

int midaspace::ECN_convert_nodes_quadrangle ( bool  i2e,
int  id,
femFileFormat  fff 
)
inline

Definition at line 1693 of file alias.h.

References _errorr, FFF_JKTK, FFF_OOFEM, FFF_SIFEL, FFF_T3d, and FFF_VTX.

Referenced by ECN_convert_e2i(), and ECN_convert_i2e().

int midaspace::ECN_convert_nodes_triangle ( bool  i2e,
int  id,
femFileFormat  fff 
)
inline

Definition at line 1603 of file alias.h.

References _errorr, FFF_ANSYS, FFF_OOFEM, FFF_SIFEL, FFF_T3d, and FFF_VTX.

Referenced by ECN_convert_e2i(), and ECN_convert_i2e().

int midaspace::EntityType_dim2type_jktkT3d ( int  val)
inline

Conversion from "dimension" to "entity type by t3d and jktk".

Enum vertex=1, curve=2, surface=3, region=4, patch=5, shell=6.

Definition at line 332 of file alias.h.

Referenced by midaspace::Node::print_row().

int midaspace::EntityType_type2dim_jktkT3d ( long  val)
inline

Conversion from "entity type by t3d and jktk" to "dimension".

Enum vertex=1, curve=2, surface=3, region=4, patch=5, shell=6.

Definition at line 317 of file alias.h.

References _errorr2.

Referenced by midaspace::Node::add_domain(), midaspace::Node::read_input(), and midaspace::Node::set_master_component().

void midaspace::errorr ( const char *  file,
int  line,
const char *  format,
  ... 
)


*** *** *** *** ERROR FCE *** *** *** ***


Definition at line 10 of file gelib.cpp.

References CHANGE_CONSOLE_COLOUR, MAX_MSG_LENGTH, TC_D_RED, and TC_DEFAULT.

Referenced by errorr_expected(), openFileN(), and SP_scan_expected_word_FL().

void midaspace::errorr_expected ( const char *  file,
int  line,
const char *  msg,
const char *  expctd,
const char *  src 
)


*** *** *** *** STRING PROCESSING *** *** *** ***


src pointer is always shifted over the skipped/scanned/printed word/number/array word is string separated by ' ', '', '
' or '\0'

Definition at line 433 of file librw.cpp.

References errorr().

Referenced by FP_scan_expected_line_FL(), FP_scan_expected_word_FL(), SP_scan_expected_number_FL(), and SP_scan_expected_word_FL().

void midaspace::errorr_expected ( const char *  file,
int  line,
const char *  msg,
int  expctd,
const char *  src 
)

Definition at line 434 of file librw.cpp.

References errorr().

void midaspace::errorr_expected ( const char *  file,
int  line,
const char *  msg,
long  expctd,
const char *  src 
)

Definition at line 435 of file librw.cpp.

References errorr().

int midaspace::extract_double ( const char *  s1,
const char *  s2,
double &  a 
)

v retezci s1 se najde key retezec s2 a za nim se precte double

Definition at line 718 of file librw.cpp.

void midaspace::extract_double_array ( const char *  s1,
const char *  s2,
long  n,
double *  a 
)
int midaspace::extract_long ( const char *  s1,
const char *  s2,
long &  a 
)

Definition at line 708 of file librw.cpp.

FEApproximation midaspace::FEApproximation_s2e ( const char *  val)
inline

Definition at line 944 of file alias.h.

References _errorr, FEA_133133, FEA_default, FEA_linear, FEA_Void, and STRCMP.

Referenced by midaspace::ElemAttribs::initialize_from().

void midaspace::FEM_solve_OOFEM ( Problem *  pd)

redirection stdout to file, you can use "/dev/null" or NUL (win) to redirect to NULL nasledujicim radkum nerozumim, ale fungujou i pod woknama kde prirazeni stdout = ... nefunguje

stdout

stderr

OOFEM main

redirect back to screen stdout

stderr

Definition at line 18 of file module_oofem.cpp.

References _errorr, midaspace::FiLe::give_name(), midaspace::FiLe::give_name_or_null(), midaspace::Problem::give_OUT_moFILE(), midaspace::Problem::give_P_solverbinary(), oofem_main(), midaspace::StdoutDriver::print_info_message(), midaspace::StdoutDriver::print_info_time_green_ok(), SODE_end_green_ok, SODE_start_blue_arrow, midaspace::Problem::sodriver(), and strdupl().

Referenced by midaspace::Problem::main_OM_design2solver2design().

const char* midaspace::femFileFormatEtoS ( femFileFormat  fff)
inline

Definition at line 673 of file alias.h.

References _errorr, FFF_ANSYS, FFF_JKTK, FFF_MELNIK, FFF_OOFEM, FFF_POLYLINE, FFF_SIFEL, FFF_T3d, FFF_UNV, FFF_VTK, FFF_VTP, and FFF_VTU.

Referenced by ffstrcat().

femFileFormat midaspace::femFileFormatStoE ( const char *  fff)
inline
FiniteElementType midaspace::FET_s2e ( const char *  str)
inline

string to FET

Definition at line 1053 of file alias.h.

References _errorr, FET_OOFEM_RerShell, FET_Void, and STRCMP.

Referenced by midaspace::ElemAttribs::initialize_from().

int midaspace::FETSet_e2i_SIFEL ( FiniteElementType  fet)
inline
const char* midaspace::FETSet_e2s_ANSYS ( FiniteElementType  fet)
inline

Definition at line 1221 of file alias.h.

References _errorr2, FET_ANSYS_BEAM188, and FET_ANSYS_SHELL181.

Referenced by midaspace::Problem::print_input_ANSYS().

const char* midaspace::FETSet_e2s_OOFEM ( FiniteElementType  feto)
inline
void midaspace::FETSet_e2set ( FiniteElementType  fet,
FiniteElementTypeSet *  set 
)
inline
FiniteElementType midaspace::FETSet_set2e ( const FiniteElementTypeSet *  set,
Solver  sol,
PAGroup  pg 
)
inline
int midaspace::FETSet_set2i_SIFEL ( const FiniteElementTypeSet *  set,
PAGroup  pg 
)
inline

Definition at line 1237 of file alias.h.

References FETSet_e2i_SIFEL(), FETSet_set2e(), and SOL_SIFEL.

Referenced by midaspace::FElement::print_row().

const char* midaspace::FETSet_set2s_OOFEM ( const FiniteElementTypeSet *  set,
PAGroup  pg 
)
inline

Definition at line 1232 of file alias.h.

References FETSet_e2s_OOFEM(), FETSet_set2e(), and SOL_OOFEM.

Referenced by midaspace::FElement::print_row().

FiniteElementType midaspace::FETSet_si2e ( const char *  str,
int  val,
Solver  sol,
PAGroup  pg 
)
inline
void midaspace::FETSet_si2set ( const char *  str,
int  val,
Solver  sol,
PAGroup  pg,
FiniteElementTypeSet *  set 
)
inline

Definition at line 1139 of file alias.h.

References FETSet_e2set(), and FETSet_si2e().

Referenced by midaspace::Mesh::read_mesh_OOFEM(), and midaspace::Mesh::read_mesh_SIFEL().

void midaspace::filename_decomposition ( char *&  path,
char *&  base,
char *&  suff,
const char *  name 
)

Definition at line 16 of file taux.cpp.

References DIRSEPARATOR, and errol.

Referenced by midaspace::FiLe::decompose().

template<class ArgType >
void midaspace::fill_all_by ( ArgType *  p,
long  a,
ArgType  value 
)
template<class ArgType >
void midaspace::fill_all_by ( ArgType **  p,
long  a,
long  b,
ArgType  value 
)

Definition at line 239 of file gelib.h.

References fill_all_by().

template<class ArgType >
void midaspace::fill_all_by ( ArgType ***  p,
long  a,
long  b,
long  c,
ArgType  value 
)

Definition at line 240 of file gelib.h.

References fill_all_by().

template<class ArgType >
void midaspace::fill_col_by ( ArgType **  p,
long  n,
long  j,
ArgType  value 
)

Definition at line 244 of file gelib.h.

template<class ArgType >
void midaspace::fill_row_by ( ArgType **  p,
long  i,
long  m,
ArgType  value 
)

Definition at line 243 of file gelib.h.

References fill_all_by().

long midaspace::find_double ( long  n,
long *  p 
)


*** *** *** *** OBSOLETE FUNCTIONS *** *** *** ***


Definition at line 649 of file librw.cpp.

long midaspace::FP_number_of_lines ( FILE *  stream,
bool  rwd 
)

count number of lines in file

Definition at line 240 of file librw.cpp.

Referenced by midaspace::Mesh::read_mesh_ANSYS(), midaspace::Problem::read_mesh_OOFEM(), and midaspace::Mesh::read_mesh_UNV().

long midaspace::FP_number_of_words ( FILE *  stream)

count number of words (see isWordChar) in file

Definition at line 220 of file librw.cpp.

References isWordChar().

Referenced by parameters().

bool midaspace::FP_scan_array ( FILE *  stream,
int  n,
int *  dest 
)

scan/copy array of numbers from src to dest, src pointer is shifted over the field

Definition at line 214 of file librw.cpp.

Referenced by midaspace::Beam::read_output_OOFEM(), midaspace::Triangle::read_output_OOFEM(), midaspace::BoundaryCond::scan_components(), and ST_scan_array().

bool midaspace::FP_scan_array ( FILE *  stream,
int  n,
long *  dest 
)

Definition at line 215 of file librw.cpp.

bool midaspace::FP_scan_array ( FILE *  stream,
int  n,
double *  dest 
)

Definition at line 216 of file librw.cpp.

bool midaspace::FP_scan_expected_line ( FILE *  src,
const char *  expctd,
bool  cs 
)

... line and compare with expected one

Definition at line 404 of file librw.cpp.

References FP_skip_expected_string(), and FP_skip_space().

Referenced by FP_scan_expected_line_FL().

void midaspace::FP_scan_expected_line_FL ( const char *  file,
int  line,
FILE *  src,
const char *  expctd,
const char *  msg,
bool  cs 
)

... line and compare with expected one, exit if false

Definition at line 419 of file librw.cpp.

References errorr_expected(), and FP_scan_expected_line().

bool midaspace::FP_scan_expected_word ( FILE *  src,
const char *  expctd,
bool  cs 
)
void midaspace::FP_scan_expected_word_FL ( const char *  file,
int  line,
FILE *  src,
const char *  expctd,
const char *  msg,
bool  cs 
)

... word and compare with expected one, exit if false

Definition at line 398 of file librw.cpp.

References errorr_expected(), and FP_scan_expected_word().

long midaspace::FP_scan_line ( FILE *  stream,
char *  dest 
)
long midaspace::FP_scan_line_alloc ( FILE *  stream,
char *&  dest 
)

scan/copy line == string without '
' from stream; dest is NULL and allocated here

Definition at line 340 of file librw.cpp.

References _errorr, and FP_scan_line().

Referenced by GP_scan_line_alloc(), and read_line().

long midaspace::FP_scan_line_skip_emptyORcommented ( FILE *  stream,
char *  dest 
)


*** *** *** SCANNING *** *** ***


scanning == scan ...

scan/copy line == string without '
' from stream, skip lines commented by '#' at the first position

to variable dest and shift src pointer at the end of ... scan/copy line == string without '
' from stream, skip lines commented by '#' at the first position and empty lines

Definition at line 309 of file librw.cpp.

References FP_scan_line(), FP_skip_line(), and FP_skip_space().

Referenced by midaspace::Mesh::read_mesh_JKTK(), midaspace::Mesh::read_mesh_OOFEM(), midaspace::Problem::read_mesh_OOFEM(), midaspace::Mesh::read_mesh_SIFEL(), midaspace::Problem::read_mesh_SIFEL(), and midaspace::Mesh::read_mesh_T3d().

int midaspace::FP_scan_word ( FILE *  src,
char *  dest 
)

... word; return value is length of the word

Definition at line 356 of file librw.cpp.

References FP_skip_nonword(), and isWordChar().

Referenced by GP_scan_word(), parameters(), midaspace::Problem::read_geometry_VTK_core(), and midaspace::Model::read_model_MELNIK().

bool midaspace::FP_skip_behind_line_starting_with ( FILE *  stream,
const char *  string,
bool  cs 
)

move file descriptor to the start of the new line after the one starting with string

Definition at line 181 of file librw.cpp.

References FP_skip_expected_string(), and FP_skip_line().

Referenced by midaspace::Mesh::read_output_OOFEM().

bool midaspace::FP_skip_comment ( FILE *  stream)


*** *** *** *** FILE PROCESSING *** *** *** ***


general rules for file processing:

move file descriptor to the start of the new noncommented word(digit) == skip nonword chars and comment

  • EOF (end of file) is reached - char EOF is pushed back, information about reached EOF is returned move file descriptor to the start of the new noncommented word(digit) == skip nonword chars and comment

Definition at line 130 of file librw.cpp.

References FP_skip_line(), and isWordChar().

Referenced by midaspace::ProblemAnalysis::initialize_from(), midaspace::Mesh::read_mesh_SIFEL(), and midaspace::Problem::read_mesh_SIFEL().

bool midaspace::FP_skip_expected_string ( FILE *  src,
const char *  expctd,
bool  cs 
)
bool midaspace::FP_skip_line ( FILE *  stream,
int  n 
)
void midaspace::FP_skip_line_commented ( FILE *  stream)

move file descriptor to the start of the new noncommented line, without checking of EOF

Definition at line 145 of file librw.cpp.

References FP_skip_line().

Referenced by GP_scan_line_alloc_skip_commented(), parameters(), midaspace::Problem::read_mesh_OOFEM(), and midaspace::Problem::read_mesh_SIFEL().

void midaspace::FP_skip_line_fast_skip_commented ( FILE *  stream,
int  n 
)

move file descriptor to the start of the n-th new line, without checking of EOF

Definition at line 155 of file librw.cpp.

Referenced by midaspace::Problem::read_mesh_OOFEM().

bool midaspace::FP_skip_nonword ( FILE *  stream)


*** *** *** SKIPING *** *** ***


skiping == shift stream pointer at the first char which is not ...

... nonword == ' ', '
', '' and '' characters

... nonword

Definition at line 264 of file librw.cpp.

References isWordChar().

Referenced by FP_scan_expected_word(), FP_scan_word(), and parameters().

bool midaspace::FP_skip_space ( FILE *  stream)

... space

... space == ' ' and '' characters

Definition at line 277 of file librw.cpp.

References isSpaceChar().

Referenced by FP_scan_expected_line(), FP_scan_line_skip_emptyORcommented(), and midaspace::Model::read_model_MELNIK().

bool midaspace::FP_skip_to_line_starting_with ( FILE *  stream,
const char *  string,
bool  cs 
)

move file descriptor to the line starting with string, exactly behind the string

Definition at line 190 of file librw.cpp.

References FP_skip_expected_string(), and FP_skip_line().

Referenced by give_nstepsOut(), midaspace::Mesh::read_output_OOFEM(), and midaspace::Mesh::read_output_SIFEL().

bool midaspace::FP_skip_to_line_starting_with ( FILE *  stream,
char  C 
)

replacement of old function "read_contiguous_star" move file descriptor to the line starting with character, directly to this char

move file descriptor to the line starting with character, directly to this char

Definition at line 200 of file librw.cpp.

bool midaspace::FP_skip_word ( FILE *  stream)

... word

Definition at line 290 of file librw.cpp.

References isWordChar().

Referenced by FP_scan_expected_word().

double midaspace::give_copy_r2z ( double  a,
double  zero 
)
double* midaspace::give_copy_r2z ( double *  a,
long  n,
double  zero 
)

Definition at line 17 of file arrays.cpp.

References give_copy_r2z().

int midaspace::give_edge_points_commperpend_skewlines ( const double *  l1a,
const double *  l1b,
const double *  l2a,
const double *  l2b,
double *  p1,
double *  p2 
)


*** *** *** *** GEOMETRY FUNCTIONS *** *** *** ***


void midaspace::give_line ( FILE *  stream,
char *&  s 
)
long midaspace::give_nstepsOut ( FILE *  stream,
femFileFormat  ff,
PAType  pt,
const Problem *  Pd 
)
const PointDOFsBCPM* midaspace::give_uniq_dofbc ( int  dim,
const GPA< const Element > *  superelems,
const char *  name,
long  id 
)
long midaspace::giveLineLength ( const char *  src)

return length of line == sting compount of "line chars"

Definition at line 43 of file librw.cpp.

References isLineChar().

Referenced by midaspace::Attribute::scan_linerec(), and SP_scan_line_alloc().

long midaspace::GP_scan_line ( Stream *  stream,
char *  dest 
)

... line; return value is length of the line


*** *** *** *** STREAM PROCESSING *** *** *** ***


...

line; return value is length of the line

Definition at line 76 of file tixy2.cpp.

References midaspace::Stream::file(), FP_scan_line(), tinyxml2::XMLElement::GetText(), midaspace::Stream::isFile(), SP_scan_line(), and midaspace::Stream::tixel().

Referenced by midaspace::Problem::read_block(), midaspace::Problem::read_block_output(), and midaspace::Problem::read_characteristics_core().

long midaspace::GP_scan_line_alloc ( Stream *  stream,
char *&  dest 
)
long midaspace::GP_scan_line_alloc_skip_commented ( Stream *  stream,
char *&  dest 
)
long midaspace::GP_scan_word ( Stream *  stream,
char *  dest 
)

... word; return value is length of the word

Definition at line 104 of file tixy2.cpp.

References midaspace::Stream::file(), FP_scan_word(), tinyxml2::XMLElement::GetText(), midaspace::Stream::isFile(), SP_scan_word(), and midaspace::Stream::tixel().

template<class ArgType >
void midaspace::interchange2 ( ArgType &  a,
ArgType &  b 
)

Definition at line 400 of file gelib.h.

long midaspace::intersec_rectangle3d_line ( double  zero,
double  norm,
const PoinT *  A,
const PoinT *  B,
const PoinT *  C,
const PoinT *  D,
const PoinT *  U,
const PoinT *  V,
double *  ksi,
double *  eta,
double *  t,
PoinT *  I1,
PoinT *  I2 
)

ZDROJE http://softsurfer.com/algorithm_archive.htm.

Function computes edge points of common perpendicular of two line segments l1 and l2. The line segment l1 goes from point l1a to l1b. l2 (l2a l2b)

Return 0 - both edge points of common perpendicular is lying inside of the line segments l1 and l2 Return 1 - edge point of common perpendicular is lying outside of the line segment l1 Return 2 - edge point of common perpendicular is lying outside of the line segment l2 Return 3 - both edge points of common perpendicular is lying outside of the line segments l1 and l2 Function computes natural and cartesian coordinates of points of intersection of line and warped rectangle answer: -1 = infinite number of points 0,1,2 = number of points V \

Parameters
zero- accuracy of solving D–-–.---—C
norm- norm is on order equal to diagonal of rectangle / \ . /
A,B,C,D- arrays of cartesian coordinates of rectangle vertexes, dimension is 3 eta /........... /
U,V- arrays of cartesian coordinates of vertexes of line, dimension is 3 / . + /
xi,eta- arrays of natural coordinates of "points", dimension is 2 / . + /
t- array of position of intersection points between U(t=-1) and V(t=1) / . +/
I1,I2- arrays of cartesian coordinates of "points", dimension is 3 / . /\ A----------—B \ created 4.4.2003, Ladislav Svoboda, termi.nosp@m.t@cm.nosp@m.l.fsv.nosp@m..cvu.nosp@m.t.cz ksi U

Definition at line 70 of file geometrylib.cpp.

References _errorr, midaspace::Elem3D::add(), midaspace::VectoR::beP2P(), midaspace::PoinT::bePointAtAbscissa(), errol, intersect_RayTriangle(), solv_2nle(), midaspace::Elem3D::x, midaspace::Elem3D::y, and midaspace::Elem3D::z.

Referenced by midaspace::Cell::cross_abscissa_face().

long midaspace::intersec_triangle_line ( double  zero,
double  norm,
const PoinT *  A,
const PoinT *  B,
const PoinT *  C,
const PoinT *  U,
const PoinT *  V,
double *  ksi,
double *  eta,
double *  t,
PoinT *  I1,
PoinT *  I2 
)
int midaspace::intersect_RayTriangle ( double  zero,
const PoinT *  P0,
const PoinT *  P1,
const PoinT *  V0,
const PoinT *  V1,
const PoinT *  V2,
PoinT *  I 
)
IntPointSet midaspace::IntPointSet_fet2e_comp ( FiniteElementType  fet)
inline
IntPointSet midaspace::IntPointSet_fet2e_rslts ( IntPointSet  IPset,
FiniteElementType  fet 
)
inline
IntPointSet midaspace::IntPointSet_fets2ips ( const FiniteElementTypeSet *  set)
inline
int midaspace::IntPointSet_give_number_ips ( IntPointSet  ips)
inline
IntPointSet midaspace::IntPointSet_s2e ( const char *  val)
inline
double midaspace::IPS_give_ip_coord_native ( int  i,
IntPointSet  ips,
PoinT &  coords 
)
inline
int midaspace::IPS_inputfile_value_e2i_OOFEM ( IntPointSet  val)
inline

val je cislo ze vstupaku oofemu

, FiniteElementType fet)

Definition at line 1291 of file alias.h.

References _errorr, _errorr2, FET_Void, IPS_2D_3v_1ip, IPS_2D_3v_3ip, IPS_2D_3v_4ip, and IPS_2D_4v_4ip.

Referenced by midaspace::FElemAttribs::print_row().

IntPointSet midaspace::IPS_inputfile_value_i2e_OOFEM ( int  val,
FiniteElementTypeSet *  fets 
)
inline

val je cislo ze vstupaku oofemu, keyword NIP

Definition at line 1260 of file alias.h.

References midaspace::FiniteElementTypeSet::cg, CG_Quadrangle, CG_Triangle, errol, IPS_2D_3v_1ip, IPS_2D_3v_3ip, IPS_2D_3v_4ip, IPS_2D_4v_4ip, and IPS_Void.

Referenced by midaspace::ElemAttribs::initialize_from().

template<class ArgType >
long midaspace::is_member_of_array ( ArgType  val,
long  n,
const ArgType *  array 
)
bool midaspace::isDigitChar ( char  C)

Definition at line 37 of file librw.cpp.

Referenced by SP_skip_int().

bool midaspace::isLineChar ( char  C)

return true if character C is "normal" char or "space" char –> C != '
' '\0' ''

Definition at line 26 of file librw.cpp.

Referenced by FP_scan_line(), giveLineLength(), and SP_scan_line().

bool midaspace::isNonZero ( double  x,
double  tolerance 
)

Definition at line 401 of file mathlib.cpp.

Referenced by midaspace::HNAttribs::checkConsistency().

bool midaspace::isSpaceChar ( char  C)

return true if character C is "space" char –> C == ' ' ''

Definition at line 32 of file librw.cpp.

Referenced by FP_skip_space(), and SP_print_space().

bool midaspace::isWordChar ( char  C)


*** *** *** *** GENERAL FUNCTIONS *** *** *** ***


return true if character C is "normal" char –> C != ' ' '' '
' '\0' ''

non-word chars == ' ' '' '
' '\0' '' word chars == !non-word chars

return true if character C is "normal" char –> C != ' ' '' '
' '\0' ''

Definition at line 20 of file librw.cpp.

Referenced by FP_number_of_words(), FP_scan_word(), FP_skip_comment(), FP_skip_nonword(), FP_skip_word(), SP_print_word(), SP_scan_word(), and SP_skip_word().

bool midaspace::isZero ( double  zero,
double  a 
)
bool midaspace::isZero ( double  abszero,
double  relzero,
double  a 
)

Definition at line 314 of file mathlib.cpp.

References isZero().

void midaspace::jac_3d ( double &  jac,
Dvctr &  x,
Dvctr &  y,
Dvctr &  z,
double  xi,
double  eta,
double  zeta 
)
int midaspace::LinearSolverType_e2i_SIFEL ( LinearSolverType  val)
inline

Conversion from "enum" to "SIFEL int" identificator of "linear solver type".

Definition at line 305 of file alias.h.

References _errorr2, LST_gauss, and LST_ldl.

Referenced by midaspace::ProblemAnalysis::print_block_SIFEL().

LinearSolverType midaspace::LinearSolverType_i2e_SIFEL ( int  val)
inline

Conversion from "SIFEL int" to "enum" identificator of "linear solver type".

Definition at line 295 of file alias.h.

References LST_gauss, LST_ldl, and LST_Void.

Referenced by midaspace::ProblemAnalysis::initialize_from().

int midaspace::MaterialType_e2i_SIFEL ( MaterialType  val,
PAGroup  pg 
)
inline
const char* midaspace::MaterialType_e2s_OOFEM ( MaterialType  val)
inline

Definition at line 517 of file alias.h.

References _errorr2, MAT_IsoLE, and MAT_j2mat.

MaterialType midaspace::MaterialType_i2e_SIFEL ( int  val,
PAGroup  pg 
)
inline
MaterialType midaspace::MaterialType_s2e_OOFEM ( const char *  val)
inline

Definition at line 511 of file alias.h.

References MAT_IsoLE, MAT_j2mat, MAT_Void, and STRCMP.

Referenced by midaspace::Material::initialize_from().

template<class ArgType >
bool midaspace::members_are_unique ( long  n,
const ArgType *  array 
)

check out all members of array "a" are uniq

Definition at line 319 of file gelib.h.

Referenced by midaspace::DuplicatePoints::find_duplicitys(), and midaspace::GPA< midaspace::Point >::is_unique().

void midaspace::mesh_generate_T3d ( const Problem *  pd,
const char *  solver,
const char *  options_string 
)

redirection stdout to file, you can use "/dev/null" or NUL (win) to redirect to NULL nasledujicim radkum nerozumim, ale fungujou i pod woknama kde prirazeni stdout = ... nefunguje

stdout

stderr

T3d main

redirect back to screen stdout

stderr

Definition at line 19 of file module_t3d.cpp.

References _errorr, midaspace::FiLe::give_name(), midaspace::Problem::give_OUT_moFILE(), and strdupl().

Referenced by midaspace::Model::generate_mesh_primary().

MMprocessing midaspace::MMprocessingStoE ( const char *  val)
inline

Definition at line 622 of file alias.h.

References _errorr2, MMP_primary, MMP_RFbyHN, MMP_secondary, MMP_Void, and STRCMP.

Referenced by midaspace::FiLe::FiLe().

long midaspace::nc_brick_3d ( double  zero,
double  x[],
double  y[],
double  z[],
const PoinT *  point,
PoinT *  answer 
)

Function computes natural coordinates of 'point' on 'element', 'point' is entered in cartesian coordinates, 'element' is 3d brick=cube=hexahedron.

Parameters
zero- tolerance of natural coordinates on boundarys,(approximately 1.0e-5)
elem- pointer on 'element'
point- array of coordinates of 'point',dimension is 3
answer- array of dimension 3

created xx.x.xxxx, Dan Rypl, dr@cm.nosp@m.l.fs.nosp@m.v.cvu.nosp@m.t.cz

Definition at line 148 of file geometrylib.cpp.

References solve_3(), midaspace::Elem3D::x, midaspace::Elem3D::y, midaspace::Elem3D::z, and midaspace::Elem3D::zero().

Referenced by midaspace::Element::is_point_on().

void midaspace::nilling ( double  zero,
double &  a 
)

Definition at line 297 of file mathlib.cpp.

double midaspace::nillret ( double  zero,
double  a 
)

Definition at line 302 of file mathlib.cpp.

Referenced by solv_1le(), solv_2le(), solv_2nle(), and solv_polynom_2().

void midaspace::OOFEM_output_scan_elem_head ( const char *  str,
long  o,
long  i,
bool  oid 
)
void midaspace::OOFEM_output_scan_GP ( const char *&  str,
int  i,
bool  old = false 
)
void midaspace::OOFEM_output_scan_GP ( FILE *  stream,
int  i,
bool  old = false 
)

Definition at line 2108 of file cell.cpp.

References CASE, and FP_scan_expected_word_exit.

DOFsPerNode midaspace::OOFEMdomain2DOFsPerNode ( const char *  od)
inline
FILE * midaspace::openFileN ( const char *  File,
int  Line,
const char *  mode,
const char *  key,
const char *  name 
)

Definition at line 67 of file gelib.cpp.

References errorr().

Referenced by openFilePN(), openFilePNS(), and openFilePNSS().

FILE * midaspace::openFilePN ( const char *  File,
int  Line,
const char *  mode,
const char *  key,
const char *  path,
const char *  name 
)

Definition at line 77 of file gelib.cpp.

References openFileN().

FILE * midaspace::openFilePNS ( const char *  File,
int  Line,
const char *  mode,
const char *  key,
const char *  path,
const char *  name,
const char *  suff 
)

Definition at line 86 of file gelib.cpp.

References openFileN().

FILE * midaspace::openFilePNSS ( const char *  File,
int  Line,
const char *  mode,
const char *  key,
const char *  path,
const char *  name,
const char *  suff,
const char *  suff2 
)

Definition at line 95 of file gelib.cpp.

References openFileN().

void midaspace::openFileTest ( const FILE *  stream,
const char *  name 
)


*** *** *** *** FILE FCE *** *** *** ***


Definition at line 61 of file gelib.cpp.

References _errorr2.

XMLDocument* midaspace::openTXdcPN ( const char *  path,
const char *  name 
)


*** *** *** *** TINYXML FCE *** *** *** ***


XMLDocument* midaspace::openTXdcPNSS ( const char *  path,
const char *  name,
const char *  suff,
const char *  suff2 
)
PAGroup midaspace::PAGroup_t2g ( PAType  val)
inline
char * midaspace::pathstrdupl ( const char *  src)

Definition at line 73 of file librw.cpp.

References DIRSEPARATOR.

Referenced by parameters().

int midaspace::PAType_e2i_SIFEL ( PAType  val)
inline

Definition at line 421 of file alias.h.

References _errorr2, PAT_static_linear, and PAT_stationary.

Referenced by midaspace::ProblemAnalysis::print_block_SIFEL().

PAType midaspace::PAType_i2e_SIFEL ( int  val)
inline
PAType midaspace::PAType_s2e_OOFEM ( const char *  str)
inline
void midaspace::pprint_symtensor ( char *  stream,
int  precision,
const long *  a 
)
void midaspace::pprint_symtensor ( FILE *  stream,
int  precision,
const long *  a 
)

Definition at line 211 of file arrays.cpp.

void midaspace::pprint_symtensor ( char *  stream,
int  precision,
const double *  a 
)

Definition at line 570 of file arrays.cpp.

void midaspace::pprint_symtensor ( FILE *  stream,
int  precision,
const double *  a 
)

Definition at line 576 of file arrays.cpp.

void midaspace::pprint_symtensor_zeroL ( char *  stream,
int  precision 
)

Definition at line 205 of file arrays.cpp.

Referenced by midaspace::Lvctr::print_symtensor().

void midaspace::pprint_symtensor_zeroL ( FILE *  stream,
int  precision 
)

Definition at line 217 of file arrays.cpp.

void midaspace::pprint_tensor ( FILE *  stream,
int  precision,
const double *  a 
)

Definition at line 564 of file arrays.cpp.

Referenced by midaspace::Dmtrx::print_tensor().

void midaspace::pprint_tensor_zero ( char *  stream,
int  precision 
)
void midaspace::pprint_tensor_zero ( FILE *  stream,
int  precision 
)

Definition at line 589 of file arrays.cpp.

void midaspace::print_dat_file ( const char *  file,
long  n,
const Dvctr *  data1,
const Dvctr *  data2,
bool  zeroline 
)

print data for xmgrace

Definition at line 3495 of file geometry.cpp.

References _openFilePN, errol, and midaspace::Xvctr::give_size().

Referenced by midaspace::Mesh::print_results().

void midaspace::print_VTK_data_body ( Stream *  stream,
long  n,
const char *  name,
const GPA< Array1d > *  data,
char  type,
bool  r2z = false 
)
void midaspace::print_VTK_FINISH ( Stream *  stream)
void midaspace::print_VTK_head ( FILE *  stream,
VTKdataset  ds 
)

Definition at line 3133 of file geometry.cpp.

References _errorr, VTKDS_polydata, and VTKDS_unstruct.

Referenced by midaspace::Mesh::print_VTK_body().

void midaspace::print_VTK_init_cell_data ( Stream *  stream,
long  n 
)
void midaspace::print_VTK_init_point_data ( Stream *  stream,
long  n 
)
void midaspace::print_VTK_START ( Stream *  stream,
const Mesh *  mg,
const char *  name,
VTKdataset  ds 
)
void midaspace::read_line ( FILE *  stream,
char *&  dest,
const char *  name 
)

reading of line from file

Definition at line 1335 of file problem.cpp.

References _errorr2, and FP_scan_line_alloc().

Referenced by midaspace::Problem::read_mesh_OOFEM(), and midaspace::Problem::read_mesh_SIFEL().

void midaspace::read_star ( FILE *  stream)

Definition at line 672 of file librw.cpp.

Referenced by read_star_end().

void midaspace::read_star_end ( FILE *  stream,
int  n 
)

Definition at line 668 of file librw.cpp.

References FP_skip_line(), and read_star().

template<class ArgType >
bool midaspace::same_array_elements_asym ( long  nx,
const ArgType *  x,
long  ny,
const ArgType *  y,
bool  same_dim = false 
)

Function finds out whether every element of the array 'x' is in the array 'y'.

nx,ny - dimensions of arrays x, y

Definition at line 333 of file gelib.h.

Referenced by midaspace::PolyLine::divide(), midaspace::GPA< midaspace::Point >::has_same_members_as(), and same_array_elements_sym().

template<class ArgType >
bool midaspace::same_array_elements_sym ( long  nx,
const ArgType *  x,
long  ny,
const ArgType *  y,
bool  same_dim = false 
)

Function finds out whether every element of the array 'x' is in the array 'y', and symmetrically every element of the array 'y' is in the array 'x'.

!!! This in not perfect identical, because x(1,2,2) == y(1,1,2) !!! nx,ny - dimensions of arrays x, y

Definition at line 353 of file gelib.h.

References same_array_elements_asym().

void midaspace::scan_DATA_field ( Stream *  stream,
const char *  str,
int  nexc,
long  m,
Lmtrx *  dataL,
Dmtrx *  dataD,
Lvctr *  sprs,
const char *  name 
)
FILE* midaspace::scan_DATA_head ( FILE *  stream,
const char *  str,
const char *  expnumtype,
int *  noc,
const char *  descript 
)

Definition at line 460 of file geometry.cpp.

References _errorr3, CASE, SP_scan_expected_word_exit, and SP_scan_number().

Referenced by scan_DATA_field().

void midaspace::scan_expect_num ( FILE *  stream,
long  expctd 
)

cte SRDC's I-DEAS UNV soubory

Definition at line 1933 of file geometry.cpp.

References _errorr3.

Referenced by midaspace::Mesh::read_mesh_UNV().

template<class ArgType >
void midaspace::setadd_another_uno_ptr ( long &  n,
ArgType **&  field,
ArgType *  p 
)

Definition at line 272 of file gelib.h.

References allocate_another_uno_ptr().

template<class ArgType >
void midaspace::shake_down_ptr_array ( long &  n,
ArgType *  array 
)


*** *** *** *** VARIOUS TEMPLATES *** *** *** ***


Definition at line 283 of file gelib.h.

void midaspace::shaker ( long &  n,
long *  a 
)

zlikviduje vicenasobne cifry pro long in <0;..>

Definition at line 19 of file mathlib.cpp.

Referenced by midaspace::HNAttribs::find_hndomain().

double midaspace::SigmaEq ( VectoR &  s,
VectoR &  t 
)
long midaspace::solv_1le ( double  zero,
double  a,
double  b,
double &  x 
)

function solves linear equation: a*x + b = 0 answer: -1 = infinite number of results 0,1 = number of results

Parameters
zero- accuracy of solving
a,b- coeficients of equation
x- result

created 4.4.2003, Ladislav Svoboda, termi.nosp@m.t@cm.nosp@m.l.fsv.nosp@m..cvu.nosp@m.t.cz

Definition at line 284 of file mathlib.cpp.

References nillret().

Referenced by solv_2nle().

long midaspace::solv_2le ( double  zero,
const double *  a,
const double *  b,
const double *  c,
double &  x,
double &  y 
)

function solves system of two linear equations: a[0]*x + b[0]*y + c[0] = 0 a[1]*x + b[1]*y + c[1] = 0 answer: -1 = infinite number of results 0,1 = number of results

Parameters
zero- accuracy of solving
a,b,c- arrays of coeficients of equations, dimension is 2
x,y- results

created 4.4.2003, Ladislav Svoboda, termi.nosp@m.t@cm.nosp@m.l.fsv.nosp@m..cvu.nosp@m.t.cz

Definition at line 236 of file mathlib.cpp.

References nillret().

Referenced by solv_2nle().

long midaspace::solv_2nle ( double  zero,
const double *  a,
const double *  b,
const double *  c,
const double *  d,
double *  x,
double *  y 
)

function solves system of two non-linear equations: a[0]*x*y + b[0]*x + c[0]*y + d[0] = 0 a[1]*x*y + b[1]*x + c[1]*y + d[1] = 0 answer: -1 = infinite number of results 0,1,2 = number of results

Parameters
zero- accuracy of solving
a,b,c,d- arrays of coeficients of equations, dimension is 2
x,y- arrays results, dimension is 2

created 4.4.2003, Ladislav Svoboda, termi.nosp@m.t@cm.nosp@m.l.fsv.nosp@m..cvu.nosp@m.t.cz

toto je prej chyba, ale nevim proc, ale muzu to prozkoumat casem, zatim vracim -2 a vejs to pak overim, stejne se tahle fce pouziva jen v jedne fci

Definition at line 169 of file mathlib.cpp.

References nillret(), solv_1le(), solv_2le(), and solv_polynom_2().

Referenced by intersec_rectangle3d_line().

long midaspace::solv_polynom_2 ( double  zero,
double  a,
double  b,
double  c,
double &  r1,
double &  r2 
)

function searchs roots of polynom of 2nd order = quadratic equation a*x^2 + b*x + c = 0 answer: -1 = infinite number of results 0,1,2 = no,one,two results

Parameters
zero- accuracy of solving
a,b,c- coeficients of quadratic equation
r1,r2- roots of quadratic equation

created 11.1.2003, Ladislav Svoboda, termi.nosp@m.t@cm.nosp@m.l.fsv.nosp@m..cvu.nosp@m.t.cz

Definition at line 331 of file mathlib.cpp.

References nillret().

Referenced by solv_2nle().

void midaspace::solve_3 ( const double *  m,
const double *  r,
double *  l 
)

Function solves the system of linear equations.

Parameters
m- matrix of system contained in array
r- right hand side of system
l- left hand side of system - answer

created 28.3.2003, Ladislav Svoboda, termi.nosp@m.t@cm.nosp@m.l.fsv.nosp@m..cvu.nosp@m.t.cz

Definition at line 103 of file mathlib.cpp.

Referenced by nc_brick_3d().

void midaspace::solve_3 ( const double **  m,
const double *  r,
double *  l 
)

Function solves the system of linear equations.

Parameters
m- matrix of system
r- right hand side of system
l- left hand side of system - answer

created 28.3.2003, Ladislav Svoboda, termi.nosp@m.t@cm.nosp@m.l.fsv.nosp@m..cvu.nosp@m.t.cz

Definition at line 134 of file mathlib.cpp.

void midaspace::sort_2 ( long *  x)

Function sorts first two members of array with ascending order.

Parameters
x- sorted array

created 27.3.2003, Ladislav Svoboda, termi.nosp@m.t@cm.nosp@m.l.fsv.nosp@m..cvu.nosp@m.t.cz

Definition at line 86 of file mathlib.cpp.

void midaspace::sort_3 ( long *  x)

Function sorts first three members of array with ascending order.

Parameters
x- sorted array

created 27.3.2003, Ladislav Svoboda, termi.nosp@m.t@cm.nosp@m.l.fsv.nosp@m..cvu.nosp@m.t.cz

Definition at line 67 of file mathlib.cpp.

Referenced by sort_4().

void midaspace::sort_4 ( long *  x)

Function sorts first four members of array with ascending order.

Parameters
x- sorted array

created 27.3.2003, Ladislav Svoboda, termi.nosp@m.t@cm.nosp@m.l.fsv.nosp@m..cvu.nosp@m.t.cz

Definition at line 44 of file mathlib.cpp.

References sort_3().

bool midaspace::SP_cutcomment ( char *  src)

cut of comment == end of line starting by '#'

Definition at line 438 of file librw.cpp.

Referenced by midaspace::Problem::read_block(), and midaspace::Attribute::scan_linerec().

bool midaspace::SP_print_space ( const char *&  src,
FILE *  stream 
)


*** *** *** PRINTING *** *** ***


printing == print ...

printing == print ... to stream and shift src pointer at the end of ...

to stream and shift src pointer at the end of ... ... space == ' ' and '' characters

... space == ' ' and '' characters

Definition at line 625 of file librw.cpp.

References isSpaceChar().

Referenced by midaspace::Attribute::print_linerec().

bool midaspace::SP_print_word ( const char *&  src,
FILE *  stream 
)

... word

Definition at line 635 of file librw.cpp.

References isWordChar(), and SP_skip_space().

Referenced by midaspace::Attribute::print_linerec().

template<class ArgType >
bool midaspace::SP_scan_array ( const char *&  src,
int  n,
ArgType *  a 
)
template<class ArgType >
bool midaspace::SP_scan_array ( const char *&  src,
long  n,
ArgType *  a 
)

Definition at line 234 of file librw.h.

References SP_scan_number().

template<class ArgType >
bool midaspace::SP_scan_array_alloc ( const char *&  src,
long &  n,
ArgType *&  a 
)
bool midaspace::SP_scan_array_L ( const char *&  src,
int  L,
double *  a 
)

Definition at line 601 of file librw.cpp.

References _warningg2, SP_scan_array(), and SP_scan_expected_number().

bool midaspace::SP_scan_character ( const char *&  src,
char &  dest 
)

scanning == scan ... to variable dest and shift src pointer at the end of ...

... one char

Definition at line 517 of file librw.cpp.

References SP_skip_space().

bool midaspace::SP_scan_Dvctr_exit ( const char *&  src,
int  n,
Dvctr *  v 
)
template<class ArgType >
bool midaspace::SP_scan_expected_number ( const char *&  src,
ArgType  expctd 
)

... number and compare with expected one

Definition at line 214 of file librw.h.

References SP_scan_number().

Referenced by SP_scan_array_L(), SP_scan_Dvctr_exit(), and SP_scan_expected_number_FL().

template<class ArgType >
void midaspace::SP_scan_expected_number_FL ( const char *  file,
int  line,
const char *&  src,
ArgType  expctd,
const char *  msg 
)

... number and compare with expected one, exit if false

Definition at line 224 of file librw.h.

References errorr_expected(), and SP_scan_expected_number().

bool midaspace::SP_scan_expected_word ( const char *&  src,
const char *  expctd,
bool  cs 
)
void midaspace::SP_scan_expected_word_FL ( const char *  file,
int  line,
const char *&  src,
const char *  expctd,
const char *  msg,
bool  cs 
)

... word and compare with expected one/two/three, exit if false

Definition at line 590 of file librw.cpp.

References errorr_expected(), and SP_scan_expected_word().

void midaspace::SP_scan_expected_word_FL ( const char *  file,
int  line,
const char *&  src,
const char *  expctd1,
const char *  expctd2,
const char *  msg,
bool  cs 
)

Definition at line 591 of file librw.cpp.

References errorr(), and SP_scan_expected_word().

void midaspace::SP_scan_expected_word_FL ( const char *  file,
int  line,
const char *&  src,
const char *  expctd1,
const char *  expctd2,
const char *  expctd3,
const char *  msg,
bool  cs 
)

Definition at line 592 of file librw.cpp.

References errorr(), and SP_scan_expected_word().

long midaspace::SP_scan_line ( const char *&  src,
char *  dest 
)

... line; return value is length of the line

Definition at line 544 of file librw.cpp.

References CHECK_DEST, and isLineChar().

Referenced by GP_scan_line(), and midaspace::Attribute::scan_linerec().

long midaspace::SP_scan_line_alloc ( const char *&  src,
char *&  dest 
)

... line; return value is length of the line; dest is NULL and allocated here

Definition at line 559 of file librw.cpp.

References _errorr, giveLineLength(), and SP_skip_space().

Referenced by GP_scan_line_alloc(), midaspace::Attribute::initialize_from(), and midaspace::Problem::read_block_output().

bool midaspace::SP_scan_number ( const char *&  src,
int &  dest 
)

... number of type int/long/double

Definition at line 595 of file librw.cpp.

References SP_skip_int().

Referenced by midaspace::Node::add_domain(), midaspace::ProblemAnalysis::initialize_from(), midaspace::CrossSection::initialize_from(), midaspace::LCS_beam::initialize_from(), midaspace::Material::initialize_from(), midaspace::AdaptivityParameters::initialize_from(), midaspace::BoundaryCond::initialize_from(), midaspace::AssignFix::initialize_from(), midaspace::ElemAttribs::initialize_from(), midaspace::PointAttribs::initialize_from(), midaspace::RANAttribs::initialize_from(), midaspace::HNAttribs::initialize_from(), midaspace::Problem::read_block(), midaspace::Node::read_input(), midaspace::FElement::read_input(), midaspace::Triangle::read_input(), midaspace::Quadrangle::read_input(), midaspace::Mesh::read_mesh_JKTK(), midaspace::Problem::read_mesh_OOFEM(), midaspace::Mesh::read_mesh_SIFEL(), midaspace::Problem::read_mesh_SIFEL(), midaspace::Mesh::read_mesh_T3d(), midaspace::FElement::read_nodes(), midaspace::Node::read_output_OOFEM(), midaspace::Node::read_output_SIFEL(), midaspace::Beam::read_output_SIFEL(), midaspace::Triangle::read_output_SIFEL(), midaspace::Brick::read_output_SIFEL(), midaspace::Geometry::read_VTK(), midaspace::PointDOFsAttributes::scan_att_ndofs_new(), midaspace::PointDOFsAttributes::scan_att_new_sparse(), scan_DATA_head(), midaspace::PointDOFsAttributes::scan_mask_ndofs_new(), midaspace::PointDOFsAttributes::scan_ndofs_new(), SP_scan_array(), SP_scan_array_alloc(), SP_scan_expected_number(), SP_scan_Xvctr(), and ST_scan_number().

bool midaspace::SP_scan_number ( const char *&  src,
long &  dest 
)

Definition at line 596 of file librw.cpp.

References SP_skip_int().

bool midaspace::SP_scan_number ( const char *&  src,
double &  dest 
)

Definition at line 597 of file librw.cpp.

References SP_skip_word().

long midaspace::SP_scan_word ( const char *&  src,
char *  dest 
)
template<class ArgType >
bool midaspace::SP_scan_Xvctr ( const char *&  src,
ArgType *  dest 
)

bool SP_scan_Dvctr (const char *&src, Dvctr *dest);

Definition at line 252 of file librw.h.

References SP_scan_array(), and SP_scan_number().

Referenced by midaspace::ElemAttribs::initialize_from().

bool midaspace::SP_skip_int ( const char *&  src)

... word compound of digits and space before

Definition at line 486 of file librw.cpp.

References isDigitChar(), and SP_skip_space().

Referenced by SP_scan_number().

bool midaspace::SP_skip_space ( const char *&  src)

... space == ' ' and '' characters

skiping == shift src pointer at the end of ...

... space == ' ' and '' characters

Definition at line 465 of file librw.cpp.

Referenced by midaspace::PointAttribs::initialize_from(), midaspace::Attribute::scan_linerec(), SP_print_word(), SP_scan_character(), SP_scan_expected_word(), SP_scan_line_alloc(), SP_scan_word(), SP_skip_int(), and SP_skip_word().

bool midaspace::SP_skip_word ( const char *&  src,
int  n 
)
void midaspace::SP_unscan_word ( const char *&  src,
const char *  w 
)


*** *** *** SCANNING *** *** ***


unscan word == shift pointer back over word

unscan word == shift pointer back over word

Definition at line 504 of file librw.cpp.

References _errorr, and SP_unskip_space().

Referenced by midaspace::PointAttribs::initialize_from(), midaspace::RANAttribs::initialize_from(), and midaspace::HNAttribs::initialize_from().

bool midaspace::SP_unskip_space ( const char *&  src)


*** *** *** SKIPING *** *** ***


(un)skiping == shift src pointer at the end(start) of ...

... space == ' ' and '' characters

Definition at line 458 of file librw.cpp.

Referenced by SP_unscan_word().

void midaspace::sprint_param ( char *  s,
char *  argv[],
int  n 
)

Definition at line 661 of file librw.cpp.

Referenced by parameters().

int midaspace::SStype_e2i_SIFEL ( SStype  val)
inline

Definition at line 980 of file alias.h.

References _errorr, SST_plstrain, SST_plstress, and SST_Void.

SStype midaspace::SStype_i2e_SIFEL ( int  val)
inline

bar=1,plbeam=2,spacebeam=5,,plate=15,axisymm=20,shell=25,spacestress=30

Definition at line 971 of file alias.h.

References SST_plstrain, SST_plstress, and SST_Void.

Referenced by midaspace::Triangle::read_input(), and midaspace::Quadrangle::read_input().

SStype midaspace::SStype_s2e ( const char *  val)
inline

Definition at line 962 of file alias.h.

References _errorr, SST_plstrain, SST_Void, and STRCMP.

Referenced by midaspace::ElemAttribs::initialize_from().

bool midaspace::ST_scan_array ( Stream *  src,
int  n,
int *  dest 
)
bool midaspace::ST_scan_array ( Stream *  src,
int  n,
long *  dest 
)
bool midaspace::ST_scan_array ( Stream *  src,
int  n,
double *  dest 
)
bool midaspace::ST_scan_number ( Stream *  src,
int &  dest 
)


*** *** *** *** TINYXML FCE *** *** *** ***



*** *** *** *** STREAM PROCESSING *** *** *** ***


Definition at line 36 of file tixy2.cpp.

References errol, midaspace::Stream::file(), midaspace::Stream::isFile(), midaspace::Stream::isString(), midaspace::Stream::pstring(), and SP_scan_number().

Referenced by scan_DATA_field().

bool midaspace::ST_scan_number ( Stream *  src,
long &  dest 
)
bool midaspace::ST_scan_number ( Stream *  src,
double &  dest 
)
int midaspace::StiffMatrixType_e2i_SIFEL ( StiffMatrixType  val)
inline

Conversion from "enum" to "SIFEL int" identificator of "stiffness matrix type".

Definition at line 280 of file alias.h.

References _errorr2, SMT_initial, and SMT_tangent.

Referenced by midaspace::ProblemAnalysis::print_block_SIFEL().

StiffMatrixType midaspace::StiffMatrixType_i2e_SIFEL ( int  val)
inline

Conversion from "SIFEL int" to "enum" identificator of "stiffness matrix type".

Definition at line 271 of file alias.h.

References SMT_initial, SMT_tangent, and SMT_Void.

Referenced by midaspace::ProblemAnalysis::initialize_from().

char * midaspace::strdupl ( const char *  src)

standard strdup - Memory for the new string is obtained with malloc(3), and can be freed with free(3).

my strdupl - new delete

Definition at line 53 of file librw.cpp.

Referenced by midaspace::FiLe::addGlobPath(), addSRCpriorDESTalloc(), midaspace::FiLe::compose(), FEM_solve_OOFEM(), midaspace::FiLe::FiLe(), mesh_generate_T3d(), and midaspace::FiLe::set_empty_name_from_base().

char * midaspace::strdupl ( const char *  src1,
const char *  src2 
)

Definition at line 60 of file librw.cpp.

char * midaspace::strdupl ( const char *  src1,
const char *  src2,
const char *  src3 
)

Definition at line 66 of file librw.cpp.

template<class T >
void midaspace::TF_GPA_add_another ( GPA< T > &  list,
T *  comp,
const Geometry *  mg 
)
template<class T >
void midaspace::TF_GPA_cleanup_duplicity ( const StdoutDriver *  sodriver,
T &  list,
const char *  name,
char  t,
bool  shake 
)
template<class T >
void midaspace::TF_GPA_delete_damned ( T &  list)

DELETE components marked by flag "delete".

Definition at line 137 of file geometry.cpp.

References TF_GPA_shake_down_reidoid().

Referenced by midaspace::Mesh::delete_subdomains_except(), and midaspace::Geometry::kill_damned_elems().

template<class T >
void midaspace::TF_GPA_print_list ( FILE *  stream,
const char *  name,
const char *  name2,
T &  list,
long  id 
)

Definition at line 2972 of file geometry.cpp.

Referenced by midaspace::Mesh::print_control().

template<class T >
void midaspace::TF_GPA_reid ( GPA< T > &  list)
template<class T >
void midaspace::TF_GPA_reidoid ( GPA< T > &  list)

reset ids ascending

Definition at line 25 of file taux.h.

Referenced by TF_GPA_shake_down_reidoid(), and TF_GPA_wdg_another().

template<class T >
void midaspace::TF_GPA_shake_down_reid ( GPA< T > &  list)

clear out NULL components

Definition at line 27 of file taux.h.

References midaspace::GPA< T >::shake_down(), and TF_GPA_reid().

Referenced by midaspace::Problem::rm_MAT_RIGID().

template<class T >
void midaspace::TF_GPA_shake_down_reidoid ( GPA< T > &  list)

clear out NULL components

Definition at line 29 of file taux.h.

References midaspace::GPA< T >::shake_down(), and TF_GPA_reidoid().

Referenced by midaspace::Mesh::RIGIDmatToRAN(), TF_GPA_cleanup_duplicity(), and TF_GPA_delete_damned().

template<class T >
void midaspace::TF_GPA_wdg_another ( GPA< T > &  list,
T *  comp,
const Geometry *  mg,
long  nid 
)

Definition at line 151 of file geometry.cpp.

References TF_GPA_reidoid(), and midaspace::GPA< T >::wedge().

Referenced by midaspace::Geometry::wdg_another_Elem().

const char* midaspace::trmt_clr_int2clr ( ETCLR  clr)
inline
void midaspace::warningg ( const char *  file,
int  line,
const char *  format,
  ... 
)

Definition at line 26 of file gelib.cpp.

References CHANGE_CONSOLE_COLOUR, MAX_MSG_LENGTH, TC_D_VIOLET, and TC_DEFAULT.

void midaspace::XP_check_expected_attribute ( const XMLNode xelem,
const char *  name,
const char *  value 
)
const XMLElement * midaspace::XP_give_unique_expected_elem ( const XMLNode xelem,
const char *  name,
bool  uniq 
)
const char * midaspace::XP_giveDAtext ( const XMLNode xelem,
int  n,
bool  last,
const char *  format,
const char *  type,
const char *  name,
int *  noc 
)

Variable Documentation

const int midaspace::BRICK_EN_OOFEM[12] = { 1, 2, 3, 4, 9, 10, 11, 12, 5, 6, 7, 8 }
static

Definition at line 1807 of file alias.h.

Referenced by ECN_convert_edges_brick().

const int midaspace::BRICK_EN_SIFEL_E2I[12] = { 2, 1, 4, 3, 11, 10, 9, 12, 6, 5, 8, 7 }
static

Definition at line 1810 of file alias.h.

Referenced by ECN_convert_edges_brick().

const int midaspace::BRICK_EN_SIFEL_I2E[12] = { 2, 1, 4, 3, 10, 9, 12, 11, 7, 6, 5, 8 }
static

Definition at line 1809 of file alias.h.

Referenced by ECN_convert_edges_brick().

const int midaspace::BRICK_FN_SIFEL_E2I[6] = { 5, 4, 3, 6, 1, 2 }
static

Definition at line 1839 of file alias.h.

Referenced by ECN_convert_faces_brick().

const int midaspace::BRICK_FN_SIFEL_I2E[6] = { 5, 6, 3, 2, 1, 4 }
static

Definition at line 1838 of file alias.h.

Referenced by ECN_convert_faces_brick().

const int midaspace::BRICK_NN_SIFEL[8] = { 3, 2, 1, 4, 7, 6, 5, 8 }
static

Definition at line 1777 of file alias.h.

Referenced by ECN_convert_nodes_brick().

const int midaspace::TRIANGLE_IPN_OOFEM_3_E2I[3] = { 3, 1, 2 }
static

Definition at line 1646 of file alias.h.

Referenced by ECN_convert_ips_triangle().

const int midaspace::TRIANGLE_IPN_OOFEM_3_I2E[3] = { 2, 3, 1 }
static

Definition at line 1645 of file alias.h.

Referenced by ECN_convert_ips_triangle().

const int midaspace::TRIANGLE_IPN_OOFEM_4_E2I[4] = { 3, 1, 2, 4 }
static

Definition at line 1649 of file alias.h.

Referenced by ECN_convert_ips_triangle().

const int midaspace::TRIANGLE_IPN_OOFEM_4_I2E[4] = { 2, 3, 1, 4 }
static

Definition at line 1648 of file alias.h.

Referenced by ECN_convert_ips_triangle().