#include <geometry.h>
GENERAL INFO | |
const Model * | Master |
bool | Parallel |
long | NumDomains |
long * | NumNodes |
long * | NumElems |
long | cSubDomains |
long * | cNodesInSD |
Solver | rslts_solver |
RESULTS == structural analysis output data. More... | |
long | rslts_nsteps |
Lvctr * | rslts_step |
Dvctr * | rslts_loadlevel |
double | critical_coeff |
bool | RTN [cRTN] |
bool | RTE [cRTE] |
long | nRegions |
ADAPTIVITY == adaptivity in MIDAS. More... | |
void | set_Master_model (const Model *M) |
const Model * | give_Master_model (void) const |
long | NumNodes_plus (long i) |
void | set_RTN (ResultTypesAtNode rt, bool val) |
void | set_RTE (ResultTypesAtElem rt, bool val) |
bool | give_Parallel (void) const |
long | give_NumDomains (void) const |
long | give_NnAtDom (int did) const |
long | give_NeAtDom (int did) const |
long | give_cSubDomains (void) const |
const long * | give_cNodesInSD (void) const |
Solver | give_rslts_solver (void) const |
long | give_rslts_nsteps (void) const |
long | give_nRegions (void) const |
const Node * | give_Node_with_prop (long prp, bool unique) const |
void | add_another_Element (FElement *elem, long dom) |
adds elem to the end of array Elements More... | |
MESH DATA | |
long | give_Nn (void) const |
const Node * | give_Node (long i) const |
const FElement * | give_FElem (long i) const |
Node * | Nodes (long i) const |
FElement * | FElems (long i) const |
MESH STATS | |
GPA< Lvctr > | Lata |
dd More... | |
GPA< Dvctr > | Data |
GPA< const Dvctr > | pLata |
GPA< const Dvctr > | pData |
GENERAL METHODS | |
Mesh (long gid, const Problem *p, long numdom, MMprocessing mmp) | |
CONSTRUCTOR. More... | |
virtual | ~Mesh (void) |
DESTRUCTOR. More... | |
virtual classID | give_classid () const |
Returns classID - class identification. More... | |
virtual void | initialize (void) |
initiate/sets data More... | |
virtual void | checkConsistency (void) const |
Checks data consistency. More... | |
Point * | allocate_point (long gid, const PoinT *coo, char attribs_alloc='n') |
void | read_mesh_ANSYS (char *path, const char *filename) |
zatim to cte jen primitivni batch file pro ANSYS kterej obsahuje jen coordinaty of nodes a trojuhelnikove elementy More... | |
void | read_mesh_T3d (char *path, const char *filename) |
kompletni T3d mesh file More... | |
void | read_mesh_JKTK (char *path, const char *filename) |
JKTK file format. More... | |
void | read_mesh_OOFEM (FILE *stream, long nn, long ne) |
read native input file to OOFEM More... | |
void | read_mesh_SIFEL (FILE *stream) |
read native input file to SIFEL More... | |
void | read_mesh_UNV (char *path, const char *filename) |
void | read_mesh_VLNA (char *path, const char *filename) |
void | read_mesh_equal_to_model (void) |
make mesh equal to model - no remeshing process More... | |
void | read_structural_analysis_output (void) |
read output file from structural analysis package More... | |
void | read_output_OOFEM (void) |
read native output file of OOFEM More... | |
void | read_output_SIFEL (void) |
read native output file of SIFEL More... | |
void | find_slaves (void) |
cte VLNA soubory, zatim omezene More... | |
void | cleanup_duplicities (void) |
clean up duplicities (nodes,lines) More... | |
void | check_duplicity_nodes (void) |
set up duplicity nodes More... | |
void | mesh_quality (void) const |
compute mesh quality More... | |
void | RIGIDmatToRAN (void) |
rigid material to RAN More... | |
void | find_subdomains (void) |
subdomain More... | |
void | delete_subdomains_except (long leave) |
delete all subdomains except "leave" More... | |
void | sort_polydata (Xvctr *data) const |
sort polydata data More... | |
void | print_VTK_nodes (Stream *stream) const |
void | print_VTK_elems (Stream *stream, VTKdataset ds) const |
void | print_VTK_body (Stream *stream, VTKdataset ds) const |
void | print_VTK_PD_scal (bool xml, const char *suff, const char *name, const Xvctr **data) |
VTK file with one point data scalar. More... | |
void | print_VTK_CD_scal (bool xml, const char *suff, const char *name, const Xvctr **data) const |
VTK file with one cell data scalar. More... | |
void | print_VTK (femFileFormat format, const char *suff) |
VTK file with no data. More... | |
void | print_JKTK (femFileFormat format, const char *suff) |
print geometry to JKTK format file More... | |
void | print_block_nodes (FILE *stream, femFileFormat fff, int did) |
PRINTING OF FILES. More... | |
void | print_block_supported_dofs (FILE *stream, femFileFormat fff, int did) |
print input file for solver - block with supported nodes More... | |
void | print_block_elems (FILE *stream, femFileFormat fff, int did) |
print input file for solver - block with elements More... | |
void | print_block_nodal_load (FILE *stream, femFileFormat fff, int did) |
print input file for solver - block with nodal load More... | |
void | print_block_gravity_load_ANSYS (FILE *stream) const |
print input file for solver - block with gravity load More... | |
void | resize_Lata (long newsize) |
print VTK file divided to severel functions More... | |
void | resize_Lata_members (long newsize) |
void | resize_Data (long newsize) |
void | resize_Data_members (long newsize) |
void | print_control (FILE *conout) const |
Function prints contol data. More... | |
void | print_data_ready_vtk (void) |
void | print_results (void) |
TADY BUDOU VSECHNY INFORMACE O VYSLEDCICH ZE SOLVERU. More... | |
void | print_cabletensileonly (bool mft=true) |
void | print_characteristics_to_VTK (bool mft=true) |
void | adaptivity (void) |
ADAPTIVITY. More... | |
double | volume_core (void) const |
print volume to extra file More... | |
Additional Inherited Members | |
![]() | |
MMprocessing | give_gp (void) const |
bool | give_nodeprop (void) const |
bool | give_elemprop (void) const |
long | give_Npts (void) const |
long | give_Neds (void) const |
long | give_Nfas (void) const |
long | give_Nels (void) const |
const Point * | give_Pjnt (long i) const |
const Edge * | give_Edge (long i) const |
const Face * | give_Face (long i) const |
const Element * | give_Elem (long i) const |
const GPA< Point > * | give_Pjnts (void) const |
const GPA< Edge > * | give_Edges (void) const |
const GPA< Face > * | give_Faces (void) const |
const GPA< Element > * | give_Elems (void) const |
const Point * | give_Pjnt_with_prop (long prp, bool unique) const |
void | add_another_Pjnt (Point *comp) |
void | add_another_Edge (Edge *comp) |
void | add_another_Face (Face *comp) |
void | add_another_Elem (Element *comp) |
void | wdg_another_Elem (Element *comp, long nid) |
void | replace_Pjnt_by (Point *Pold, Point *Pnew) |
invisible and delete old, set ID and assign new, of new More... | |
void | kill_damned_elems (void) |
KILL ELEMENTS marked by flag "delete" ; KILL = invisible + delete. More... | |
void | letoff_aa (void) |
let off atributes arrays More... | |
void | connectivity_allocation (void) |
Function allocates arrays necessary for connectivity assembling. More... | |
void | connectivity_assembling (void) |
Function computes connectivity of mesh. More... | |
void | VTKCT_assembling (long indx=-1) |
sum counts of VTK cell types More... | |
void | aver_elem_circ_assembling (long indx=-1) |
void | anyBeamElem_assembling (long indx=-1) |
void | boubox_assembling (long indx=-1) |
void | geom_stats_assembling (const GeometryComponent *comp) |
bool | connectivity_is_assembled (void) const |
bool | VTKCT_is_assembled (void) const |
void | give_vtk_polydata_counts (long &cl, long &cp) const |
get/compute count of VTK polydata elements More... | |
bool | only_vtk_polydata (void) const |
all elements is polydata compatible More... | |
bool | only_1d_elements (void) const |
only 1d elements More... | |
double | give_aver_elem_circ (void) const |
long | give_anyBeamElem (void) const |
const PoinT * | give_boubox_diff (void) const |
VTKdataset | giveVTKDS (void) |
other More... | |
VTKPDtopology | give_VTKPDtopology_of_elem (long i) const |
void | print_info (void) const |
void | print_geom_info (void) const |
print info about geometry of mesh More... | |
Geometry (long gid, const Problem *p, MMprocessing proc) | |
CONSTRUCTOR. More... | |
virtual | ~Geometry (void) |
DESTRUCTOR. More... | |
virtual void | finitialize (void) |
finalize prepropcessing More... | |
void | read_addata_VTK (const char *filename, bool sparse) |
void | read_VTK (char DATASET, Stream *stream, bool addata=false, bool sparse=false) |
CORE read of VTK file. More... | |
bool | isModel (void) const |
bool | isMesh (void) const |
void | assign_NodeLoad_by_point_ID (const BoundaryCond *bc, long id) |
BC assign assign nodal load to the point by/via ... More... | |
void | assign_NodeLoad_by_point_prop (const BoundaryCond *bc, long prop) |
void | assign_NodeLoad_by_point_coords (const BoundaryCond *bc, const PoinT *coords) |
void | assign_BodyLoad_by_elem_ID (const BoundaryCond *bc, long id) |
assign body load to the element by/via ... More... | |
void | assign_BodyLoad_by_elem_prop (const BoundaryCond *bc, long prop) |
void | assign_EdgeLoad_by_elem_ID (const BoundaryCond *bc, long id, int indx=-1) |
assign edge load to the edge by/via ... More... | |
void | assign_EdgeLoad_by_elem_prop (const BoundaryCond *bc, long prop) |
void | assign_FaceLoad_by_elem_ID (const BoundaryCond *bc, long id, int indx=-1) |
assign face load to the face by/via ... More... | |
void | assign_FaceLoad_by_elem_prop (const BoundaryCond *bc, long prop) |
void | assign_FaceLoad_by_face_prop (const BoundaryCond *bc, long prop) |
void | join_geom (Geometry *geom) |
bool | give_3Delement_with_point_inside (const PoinT *coords, const GeometryComponent *&comp, PoinT *nc) const |
Function finds location of point indide of which 3d element is. More... | |
DOFsPerNode | give_DOFsPerNode (void) |
![]() | |
ProblemSubject (long gid) | |
CONSTRUCTOR. More... | |
ProblemSubject (long gid, const Problem *owner) | |
CONSTRUCTOR. More... | |
virtual | ~ProblemSubject () |
DESTRUCTOR. More... | |
void | set_ID (long val) |
long | give_ID () const |
void | set_Pd (const Problem *owner) |
const Problem * | give_Pd (void) const |
![]() | |
MMprocessing | gp |
bool | nodeprop |
bool | elemprop |
long | origPjntsNum |
long | origElemsNum |
GPA< Point > | Pjnts |
GPA< Edge > | Edges |
GPA< Face > | Faces |
GPA< Element > | Elems |
bool | connectivity_assembled |
when any function changes geometry there are two types of "set" functions a) stat is not activated => assemble for all element b) stat is activated => add one element More... | |
long | VTKCTcl |
ELEMENT STATS // VTK cells types - count elements of type: More... | |
long | VTKCTct |
long | VTKCTch |
double | aver_elem_circ |
long | anyBeamElem |
bool | boubox_assembled |
PoinT | boubox_min |
PoinT | boubox_max |
PoinT | boubox_diff |
![]() | |
long | ID |
(global) identification number == position in list of members; zero-based numbering. More... | |
const Problem * | Pd |
Pointer to owner = parent problem. More... | |
Definition at line 272 of file geometry.h.
midaspace::Mesh::Mesh | ( | long | gid, |
const Problem * | p, | ||
long | numdom, | ||
MMprocessing | mmp | ||
) |
CONSTRUCTOR.
Definition at line 1311 of file geometry.cpp.
References _errorr, critical_coeff, midaspace::cRTE, midaspace::cRTN, cSubDomains, Master, nRegions, NumDomains, NumElems, NumNodes, Parallel, rslts_loadlevel, rslts_nsteps, rslts_solver, rslts_step, RTE, RTN, and midaspace::SOL_Void.
|
virtual |
DESTRUCTOR.
Definition at line 1340 of file geometry.cpp.
References Data, midaspace::deallocateCheck(), Lata, NumElems, NumNodes, Parallel, rslts_loadlevel, and rslts_step.
void midaspace::Mesh::adaptivity | ( | void | ) |
ADAPTIVITY.
Definition at line 3950 of file geometry.cpp.
References _errorr, _errorr2, _openFilePNS, midaspace::GPA< T >::add(), midaspace::Node::add_resultE(), midaspace::CG_Hexahedron, midaspace::CG_Line, midaspace::CG_Quadrangle, midaspace::CG_Tetrahedron, midaspace::CG_Triangle, midaspace::Geometry::Elems, errol, FElems(), midaspace::Problem::give_adpa(), midaspace::FiLe::give_base(), midaspace::ProblemSubject::give_ID(), midaspace::Problem::give_OUT_moFILE(), midaspace::FiLe::give_path(), midaspace::AdaptivityParameters::give_required_error(), midaspace::Point::give_superelems(), Nodes(), nRegions, midaspace::ProblemSubject::Pd, midaspace::Geometry::Pjnts, midaspace::StdoutDriver::print_info_message(), midaspace::RTE_ada_eia, midaspace::RTE_ada_error_pct_g, midaspace::RTE_ada_error_pct_l, midaspace::RTE_ada_h_act, midaspace::RTE_ada_h_new, midaspace::RTE_ada_normal, midaspace::RTE_global_stress, midaspace::RTN_ada_h_act, midaspace::RTN_ada_h_new, midaspace::RTN_ada_refder, midaspace::AdaptivityParameters::set_error(), midaspace::FElement::set_result(), midaspace::Node::set_resultE(), midaspace::Node::set_resultN(), set_RTE(), set_RTN(), midaspace::SODE_end, midaspace::SODE_start_blue_arrow, and midaspace::Problem::sodriver().
void midaspace::Mesh::add_another_Element | ( | FElement * | elem, |
long | dom | ||
) |
adds elem to the end of array Elements
Definition at line 1398 of file geometry.cpp.
References midaspace::Geometry::add_another_Elem(), midaspace::Geometry::Elems, NumElems, Parallel, and midaspace::FElement::set_lid().
Referenced by midaspace::PolyLine::findout_segment_domain(), and initialize().
|
virtual |
Implements midaspace::Geometry.
Definition at line 505 of file geometry.cpp.
Referenced by read_mesh_ANSYS(), read_mesh_T3d(), and read_mesh_UNV().
void midaspace::Mesh::check_duplicity_nodes | ( | void | ) |
set up duplicity nodes
Definition at line 2414 of file geometry.cpp.
References _errorr, midaspace::DuplicatePoints::assign_cellpoints(), midaspace::classNode, midaspace::deallocateCheck(), midaspace::Geometry::Elems, midaspace::DuplicatePoints::find_duplicitys(), give_classid(), Nodes(), midaspace::ProblemSubject::Pd, midaspace::Geometry::Pjnts, midaspace::StdoutDriver::print_info_message(), midaspace::DuplicatePoints::set_point(), midaspace::SODE_end, midaspace::SODE_start_blue_arrow, midaspace::Problem::sodriver(), and ZERO_NC.
Referenced by cleanup_duplicities().
|
virtual |
Checks data consistency.
Reimplemented from midaspace::Geometry.
Definition at line 1392 of file geometry.cpp.
References midaspace::Geometry::checkConsistency().
void midaspace::Mesh::cleanup_duplicities | ( | void | ) |
clean up duplicities (nodes,lines)
Definition at line 2390 of file geometry.cpp.
References check_duplicity_nodes(), midaspace::Geometry::connectivity_assembling(), midaspace::Geometry::Edges, midaspace::Geometry::Elems, midaspace::Geometry::Faces, midaspace::Problem::give_PDBO(), midaspace::ProblemSubject::Pd, midaspace::PDBO_MultipElem, midaspace::PDBO_MultipNode, midaspace::Geometry::Pjnts, midaspace::Problem::sodriver(), and midaspace::TF_GPA_cleanup_duplicity().
void midaspace::Mesh::delete_subdomains_except | ( | long | leave | ) |
delete all subdomains except "leave"
delete all subdomains except "leave" zatim to neni dokonaly, mazou se jen nodes, edges, faces, elems z Mesh
Definition at line 2523 of file geometry.cpp.
References midaspace::Geometry::Edges, midaspace::Geometry::Elems, midaspace::Geometry::Faces, midaspace::Point::give_numsuperedge(), midaspace::Point::give_numsuperelem(), midaspace::Point::give_numsuperface(), midaspace::Point::give_superedge(), midaspace::Point::give_superelem(), midaspace::Point::give_superface(), Nodes(), midaspace::Geometry::Pjnts, midaspace::GeometryComponent::set_delete_flag(), and midaspace::TF_GPA_delete_damned().
|
inlineprivate |
Definition at line 348 of file geometry.h.
References midaspace::Geometry::Elems.
Referenced by adaptivity(), give_FElem(), print_block_elems(), print_block_gravity_load_ANSYS(), print_results(), print_VTK(), print_VTK_elems(), read_mesh_JKTK(), read_mesh_OOFEM(), read_mesh_SIFEL(), read_mesh_T3d(), read_output_OOFEM(), read_output_SIFEL(), and RIGIDmatToRAN().
void midaspace::Mesh::find_slaves | ( | void | ) |
cte VLNA soubory, zatim omezene
Definition at line 2342 of file geometry.cpp.
References midaspace::classEdge, midaspace::classNode, midaspace::Geometry::Elems, errol, midaspace::ProblemSubject::give_classid(), and midaspace::Geometry::Pjnts.
void midaspace::Mesh::find_subdomains | ( | void | ) |
subdomain
Definition at line 2471 of file geometry.cpp.
References cNodesInSD, midaspace::Geometry::connectivity_assembling(), cSubDomains, midaspace::Node::find_parent_subdom(), Nodes(), midaspace::ProblemSubject::Pd, midaspace::Geometry::Pjnts, midaspace::StdoutDriver::print_info_message(), midaspace::SODE_end, midaspace::SODE_start_blue_arrow, and midaspace::Problem::sodriver().
|
inlinevirtual |
Returns classID - class identification.
Reimplemented from midaspace::ProblemSubject.
Definition at line 391 of file geometry.h.
References midaspace::classMesh.
Referenced by check_duplicity_nodes(), print_JKTK(), read_mesh_T3d(), and RIGIDmatToRAN().
|
inline |
Definition at line 324 of file geometry.h.
References cNodesInSD.
|
inline |
Definition at line 323 of file geometry.h.
References cSubDomains.
|
inline |
Definition at line 354 of file geometry.h.
References FElems().
|
inline |
Definition at line 284 of file geometry.h.
References Master.
|
inline |
Definition at line 321 of file geometry.h.
References midaspace::Geometry::Elems, NumElems, and Parallel.
|
inline |
Definition at line 352 of file geometry.h.
References midaspace::Geometry::Pjnts.
|
inline |
Definition at line 320 of file geometry.h.
References NumNodes, Parallel, and midaspace::Geometry::Pjnts.
|
inline |
Definition at line 353 of file geometry.h.
References midaspace::Geometry::Pjnts.
Referenced by midaspace::RANAttribs::initialize(), midaspace::HNAttribs::initialize(), print_control(), and print_results().
|
inline |
Definition at line 334 of file geometry.h.
References midaspace::Geometry::give_Pjnt_with_prop().
|
inline |
Definition at line 330 of file geometry.h.
References nRegions.
Referenced by midaspace::Node::allocate_resultsE(), and midaspace::Node::~Node().
|
inline |
Definition at line 319 of file geometry.h.
References NumDomains.
Referenced by midaspace::PolyLine::findout_segment_domain(), and midaspace::LCS_beam::initialize().
|
inline |
Definition at line 318 of file geometry.h.
References Parallel.
Referenced by midaspace::PolyLine::findout_segment_domain(), midaspace::PolyLine::generate_mesh_RFbyHN(), and midaspace::LCS_beam::initialize().
|
inline |
Definition at line 328 of file geometry.h.
References rslts_nsteps.
Referenced by midaspace::FElement::allocate_results(), midaspace::Node::allocate_resultsE(), midaspace::Node::allocate_resultsN(), midaspace::Node::give_displcmnt_in_all_steps(), and print_results().
|
inline |
Definition at line 326 of file geometry.h.
References rslts_solver.
|
virtual |
initiate/sets data
Reimplemented from midaspace::Geometry.
Definition at line 1355 of file geometry.cpp.
References add_another_Element(), midaspace::Element::connectivity_assembling(), midaspace::Element::connectivity_removing(), midaspace::Geometry::Elems, midaspace::Cell::give_face(), midaspace::Facedge::give_facedgeAttribs(), midaspace::Problem::give_PDBO(), midaspace::Geometry::initialize(), midaspace::Quadrangle::is_first_diag_short(), midaspace::ProblemSubject::Pd, and midaspace::PDBO_divideQuads.
Referenced by midaspace::Model::transform_to_mesh().
void midaspace::Mesh::mesh_quality | ( | void | ) | const |
compute mesh quality
Definition at line 1406 of file geometry.cpp.
References _errorr, _errorr2, midaspace::Geometry::Elems, midaspace::ETC_D_GREEN, midaspace::ETC_D_RED, midaspace::Problem::give_PDBO(), midaspace::ProblemSubject::Pd, midaspace::PDBO_OUT_MeshQual, midaspace::StdoutDriver::print_info_message(), midaspace::StdoutDriver::print_info_message_colour(), midaspace::SODE_end, midaspace::SODE_start_blue_arrow, and midaspace::Problem::sodriver().
Referenced by midaspace::Geometry::print_info().
|
inlineprivate |
Definition at line 347 of file geometry.h.
References midaspace::Geometry::Pjnts.
Referenced by adaptivity(), check_duplicity_nodes(), delete_subdomains_except(), find_subdomains(), print_block_nodal_load(), print_block_nodes(), print_block_supported_dofs(), print_characteristics_to_VTK(), print_results(), read_mesh_equal_to_model(), read_mesh_JKTK(), read_mesh_OOFEM(), read_mesh_SIFEL(), read_mesh_T3d(), read_output_OOFEM(), and read_output_SIFEL().
|
inline |
Definition at line 313 of file geometry.h.
References NumNodes.
void midaspace::Mesh::print_block_elems | ( | FILE * | stream, |
femFileFormat | fff, | ||
int | did | ||
) |
print input file for solver - block with elements
Definition at line 2911 of file geometry.cpp.
References midaspace::Geometry::Elems, FElems(), midaspace::FElement::give_domain(), and midaspace::FElement::print_row().
Referenced by print_JKTK().
void midaspace::Mesh::print_block_gravity_load_ANSYS | ( | FILE * | stream | ) | const |
print input file for solver - block with gravity load
Definition at line 2936 of file geometry.cpp.
References _errorr2, midaspace::BC_DW, midaspace::BC_NL, midaspace::BC_PV, midaspace::Geometry::Elems, FElems(), midaspace::Problem::give_BCs(), midaspace::Element::give_elemAttribs(), midaspace::ProblemSubject::give_ID(), midaspace::Attributes::give_loads(), and midaspace::ProblemSubject::Pd.
void midaspace::Mesh::print_block_nodal_load | ( | FILE * | stream, |
femFileFormat | fff, | ||
int | did | ||
) |
print input file for solver - block with nodal load
Definition at line 2919 of file geometry.cpp.
References midaspace::FFF_ANSYS, midaspace::FFF_SIFEL, midaspace::Point::give_pointAttribs(), midaspace::Attributes::is_loaded(), Nodes(), midaspace::Geometry::Pjnts, and midaspace::PointAttribs::print_bc().
void midaspace::Mesh::print_block_nodes | ( | FILE * | stream, |
femFileFormat | fff, | ||
int | did | ||
) |
PRINTING OF FILES.
print input file for solver - block with nodes
Definition at line 2884 of file geometry.cpp.
References midaspace::Node::give_lid_id(), Nodes(), midaspace::Geometry::Pjnts, and midaspace::Node::print_row().
Referenced by print_JKTK().
void midaspace::Mesh::print_block_supported_dofs | ( | FILE * | stream, |
femFileFormat | fff, | ||
int | did | ||
) |
print input file for solver - block with supported nodes
Definition at line 2892 of file geometry.cpp.
References midaspace::FFF_ANSYS, midaspace::FFF_SIFEL, midaspace::Node::give_lid_id(), midaspace::Point::give_pointAttribs(), midaspace::PointAttribs::is_supported(), Nodes(), midaspace::Geometry::Pjnts, and midaspace::PointAttribs::print_supported_BC_to_line().
void midaspace::Mesh::print_cabletensileonly | ( | bool | mft = true | ) |
void midaspace::Mesh::print_characteristics_to_VTK | ( | bool | mft = true | ) |
Definition at line 3891 of file geometry.cpp.
References midaspace::PointAttribs::assemble_full_constrained(), midaspace::Geometry::Elems, midaspace::Point::give_pointAttribs(), midaspace::Geometry::giveVTKDS(), midaspace::PointAttribs::is_supported(), Lata, Nodes(), midaspace::Geometry::Pjnts, print_VTK_body(), midaspace::print_VTK_data_body(), midaspace::print_VTK_FINISH(), midaspace::print_VTK_init_cell_data(), midaspace::print_VTK_init_point_data(), midaspace::print_VTK_START(), midaspace::Stream::relink_up(), resize_Lata(), resize_Lata_members(), and midaspace::STRM_tixel.
void midaspace::Mesh::print_control | ( | FILE * | conout | ) | const |
Function prints contol data.
Definition at line 2980 of file geometry.cpp.
References midaspace::Geometry::Edges, midaspace::Geometry::Elems, midaspace::Geometry::Faces, give_Node(), midaspace::Point::give_superedges(), midaspace::Point::give_superelems(), midaspace::Geometry::Pjnts, and midaspace::TF_GPA_print_list().
void midaspace::Mesh::print_data_ready_vtk | ( | void | ) |
void midaspace::Mesh::print_JKTK | ( | femFileFormat | format, |
const char * | suff | ||
) |
print geometry to JKTK format file
Definition at line 3451 of file geometry.cpp.
References _openFilePNS, midaspace::classHangingNode, midaspace::Geometry::Elems, midaspace::FFF_JKTK, give_classid(), midaspace::ProblemSubject::give_ID(), midaspace::ProblemSubject::give_Pd(), midaspace::ProblemSubject::Pd, midaspace::Geometry::Pjnts, print_block_elems(), print_block_nodes(), midaspace::StdoutDriver::print_info_message(), midaspace::StdoutDriver::print_info_message_core(), midaspace::SODE_green_ok, midaspace::SODE_start_blue_arrow, and midaspace::Problem::sodriver().
void midaspace::Mesh::print_results | ( | void | ) |
TADY BUDOU VSECHNY INFORMACE O VYSLEDCICH ZE SOLVERU.
Definition at line 3524 of file geometry.cpp.
References _errorr, critical_coeff, midaspace::cSSTypes, Data, midaspace::Geometry::Elems, errol, FElems(), midaspace::FFF_VTK, midaspace::FFF_VTP, midaspace::FFF_VTU, midaspace::Problem::give_adpa(), midaspace::Problem::give_analloctype(), midaspace::FElement::give_CSusage_elast(), midaspace::FElement::give_CSusage_elast_bool(), midaspace::FElement::give_CSusage_elast_rel(), midaspace::Node::give_displcmnt_in_all_steps(), midaspace::Element::give_elemAttribs(), midaspace::AdaptivityParameters::give_error(), midaspace::FiLe::give_ff(), midaspace::ProblemSubject::give_ID(), give_Node(), midaspace::Problem::give_OUT_moFILE(), midaspace::Problem::give_OUT_printStep(), midaspace::FElement::give_parent_id(), midaspace::FElement::give_parent_prop(), midaspace::Problem::give_PDBO(), midaspace::FElement::give_regid(), midaspace::FElement::give_results(), midaspace::FElement::give_results_ds(), midaspace::Node::give_resultsE_dv(), midaspace::Node::give_resultsN_ds(), give_rslts_nsteps(), midaspace::FElement::give_ssstate(), midaspace::ElemAttribs::give_sst(), midaspace::Geometry::giveVTKDS(), tinyxml2::XMLNode::InsertEndChild(), Lata, tinyxml2::XMLDocument::NewElement(), tinyxml2::XMLDocument::NewText(), Nodes(), nRegions, midaspace::Geometry::origElemsNum, midaspace::Geometry::origPjntsNum, midaspace::PAT_stability_linear, midaspace::ProblemSubject::Pd, pData, midaspace::PDBO_OUT_print_CSusage, midaspace::PDBO_OUT_print_model_parent, midaspace::PDBO_OUT_print_property, midaspace::PDBO_P_refder, midaspace::PDBO_preserveGeom, midaspace::Geometry::Pjnts, midaspace::print_dat_file(), midaspace::StdoutDriver::print_info_message(), midaspace::StdoutDriver::print_info_message_core(), print_VTK_body(), midaspace::print_VTK_data_body(), midaspace::print_VTK_FINISH(), midaspace::print_VTK_init_cell_data(), midaspace::print_VTK_init_point_data(), midaspace::print_VTK_START(), midaspace::Stream::relink_downL(), midaspace::Stream::relink_up(), resize_Data(), resize_Data_members(), resize_Lata(), resize_Lata_members(), rslts_loadlevel, rslts_nsteps, RTE, midaspace::RTE_ada_error_pct_g, midaspace::RTE_ada_error_pct_l, midaspace::RTE_ada_h_act, midaspace::RTE_ada_h_new, midaspace::RTE_ada_normal, midaspace::RTE_global_strain, midaspace::RTE_global_stress, midaspace::RTE_plaststrain, RTN, midaspace::RTN_ada_h_act, midaspace::RTN_ada_h_new, midaspace::RTN_displacement, midaspace::RTN_reaction, midaspace::RTN_transpunknowns, midaspace::RVTstrn, midaspace::RVTstrn_displ, midaspace::RVTstrn_rotat, midaspace::RVTstrs, midaspace::RVTstrs_displ, midaspace::RVTstrs_rotat, midaspace::Node::setup_full_alloc_DOFvals_at(), midaspace::SODE_green_ok, midaspace::SODE_start_blue_arrow, midaspace::Problem::sodriver(), midaspace::SST_3d, midaspace::SST_3dshell, midaspace::SST_beam, midaspace::SST_plstrain, midaspace::SST_plstress, midaspace::SST_truss, midaspace::STRM_file, midaspace::STRM_tixel, midaspace::Stream::tix_doc(), midaspace::Stream::tixel(), volume_core(), midaspace::VTKDS_polydata, midaspace::VTKDS_unstruct, and midaspace::VTKDS_Void.
void midaspace::Mesh::print_VTK | ( | femFileFormat | format, |
const char * | suff | ||
) |
VTK file with no data.
VTK file with one cell data scalar.
VTK file with no data
Definition at line 3407 of file geometry.cpp.
References _errorr, midaspace::Geometry::Elems, FElems(), midaspace::FFF_VTK, midaspace::FFF_VTP, midaspace::FFF_VTU, midaspace::GeometryComponent::give_mpropertyORzero(), midaspace::FElement::give_parent_prop(), midaspace::Problem::give_PDBO(), midaspace::Geometry::giveVTKDS(), Lata, midaspace::ProblemSubject::Pd, midaspace::PDBO_OUT_print_parent_property, midaspace::PDBO_OUT_print_property, print_VTK_body(), midaspace::print_VTK_data_body(), midaspace::print_VTK_FINISH(), midaspace::print_VTK_init_cell_data(), midaspace::print_VTK_START(), resize_Lata(), resize_Lata_members(), midaspace::STRM_file, midaspace::STRM_tixel, midaspace::VTKDS_polydata, midaspace::VTKDS_unstruct, and midaspace::VTKDS_Void.
void midaspace::Mesh::print_VTK_body | ( | Stream * | stream, |
VTKdataset | ds | ||
) | const |
Definition at line 3267 of file geometry.cpp.
References midaspace::Stream::file(), midaspace::Stream::isFile(), print_VTK_elems(), midaspace::print_VTK_head(), and print_VTK_nodes().
Referenced by print_characteristics_to_VTK(), print_results(), and print_VTK().
void midaspace::Mesh::print_VTK_CD_scal | ( | bool | xml, |
const char * | suff, | ||
const char * | name, | ||
const Xvctr ** | data | ||
) | const |
VTK file with one cell data scalar.
void midaspace::Mesh::print_VTK_elems | ( | Stream * | stream, |
VTKdataset | ds | ||
) | const |
Definition at line 3172 of file geometry.cpp.
References _errorr, midaspace::CellGeometry_e2i_VTK(), midaspace::Geometry::Elems, FElems(), midaspace::Stream::file(), midaspace::Geometry::give_vtk_polydata_counts(), tinyxml2::XMLNode::InsertEndChild(), midaspace::Stream::isFile(), midaspace::FElement::Msh(), tinyxml2::XMLDocument::NewElement(), tinyxml2::XMLDocument::NewText(), tinyxml2::XMLElement::SetAttribute(), tinyxml2::XMLElement::ShallowClone(), midaspace::Stream::tix_doc(), midaspace::Stream::tixel(), midaspace::VTKDS_polydata, midaspace::VTKDS_unstruct, midaspace::VTKPD_LINE, and midaspace::VTKPD_POLYGON.
Referenced by print_VTK_body().
void midaspace::Mesh::print_VTK_nodes | ( | Stream * | stream | ) | const |
Definition at line 3145 of file geometry.cpp.
References midaspace::Stream::file(), tinyxml2::XMLNode::InsertEndChild(), midaspace::Stream::isFile(), tinyxml2::XMLNode::LastChild(), tinyxml2::XMLDocument::NewElement(), tinyxml2::XMLDocument::NewText(), midaspace::Geometry::Pjnts, tinyxml2::XMLElement::SetAttribute(), midaspace::Stream::tix_doc(), midaspace::Stream::tixel(), and tinyxml2::XMLElement::ToElement().
Referenced by print_VTK_body().
void midaspace::Mesh::print_VTK_PD_scal | ( | bool | xml, |
const char * | suff, | ||
const char * | name, | ||
const Xvctr ** | data | ||
) |
VTK file with one point data scalar.
void midaspace::Mesh::read_mesh_ANSYS | ( | char * | path, |
const char * | filename | ||
) |
zatim to cte jen primitivni batch file pro ANSYS kterej obsahuje jen coordinaty of nodes a trojuhelnikove elementy
Definition at line 1520 of file geometry.cpp.
References _errorr3, _openFilePN, allocate_point(), midaspace::Geometry::Elems, midaspace::FP_number_of_lines(), midaspace::FP_skip_line(), midaspace::Cell::give_nno(), midaspace::Geometry::Pjnts, midaspace::Elem3D::scan_x(), midaspace::Elem3D::scan_y(), midaspace::Elem3D::scan_z(), and midaspace::FElement::set_node().
void midaspace::Mesh::read_mesh_equal_to_model | ( | void | ) |
make mesh equal to model - no remeshing process
Definition at line 1763 of file geometry.cpp.
References midaspace::classLine, midaspace::classPolyLine, midaspace::Geometry::elemprop, midaspace::Geometry::Elems, errol, midaspace::ProblemSubject::give_classid(), midaspace::Geometry::give_Elem(), midaspace::Element::give_elemAttribs(), midaspace::Geometry::give_elemprop(), midaspace::ProblemSubject::give_ID(), midaspace::Geometry::give_Nels(), midaspace::Cell::give_nno(), midaspace::Geometry::give_nodeprop(), midaspace::Geometry::give_Npts(), midaspace::Geometry::give_Pjnt(), midaspace::Cell::give_point(), Master, midaspace::Geometry::nodeprop, Nodes(), midaspace::Geometry::Pjnts, midaspace::Node::set_master_component(), midaspace::FElement::set_model_prop(), and midaspace::FElement::set_node().
Referenced by midaspace::Model::transform_to_mesh().
void midaspace::Mesh::read_mesh_JKTK | ( | char * | path, |
const char * | filename | ||
) |
JKTK file format.
Definition at line 1586 of file geometry.cpp.
References _openFilePN, midaspace::allocate_element(), midaspace::CellGeometry_i2e_JKTK(), midaspace::Geometry::connectivity_allocation(), midaspace::Geometry::Elems, errol, FElems(), midaspace::FFF_JKTK, midaspace::FP_scan_line_skip_emptyORcommented(), Nodes(), midaspace::Geometry::Pjnts, midaspace::Node::read_input(), midaspace::FElement::read_input(), SP_scan_expected_number_exit, and midaspace::SP_scan_number().
void midaspace::Mesh::read_mesh_OOFEM | ( | FILE * | stream, |
long | nn, | ||
long | ne | ||
) |
read native input file to OOFEM
Definition at line 1822 of file geometry.cpp.
References _errorr2, midaspace::allocate_element(), midaspace::FiniteElementTypeSet::cg, midaspace::Geometry::Elems, FElems(), midaspace::FETSet_si2set(), midaspace::FFF_OOFEM, midaspace::FP_scan_line_skip_emptyORcommented(), midaspace::Problem::give_analgroup(), midaspace::Element::give_elemAttribs(), Nodes(), midaspace::ProblemSubject::Pd, midaspace::Geometry::Pjnts, midaspace::Node::read_input(), midaspace::FElement::read_input(), midaspace::ElemAttribs::set_FETS(), midaspace::SOL_OOFEM, SP_scan_expected_number_exit, midaspace::SP_scan_word(), and STRCMP.
Referenced by midaspace::Problem::read_mesh_OOFEM().
void midaspace::Mesh::read_mesh_SIFEL | ( | FILE * | stream | ) |
read native input file to SIFEL
Definition at line 1873 of file geometry.cpp.
References _errorr, midaspace::allocate_element(), midaspace::FiniteElementTypeSet::cg, midaspace::Geometry::Elems, FElems(), midaspace::FETSet_si2set(), midaspace::FFF_SIFEL, midaspace::FP_scan_line(), midaspace::FP_scan_line_skip_emptyORcommented(), midaspace::FP_skip_comment(), midaspace::Problem::give_analgroup(), midaspace::Element::give_elemAttribs(), midaspace::Point::give_pointAttribs(), Nodes(), midaspace::ProblemSubject::Pd, midaspace::Geometry::Pjnts, midaspace::Node::read_input(), midaspace::FElement::read_input(), midaspace::PointAttribs::set_dofbc(), midaspace::ElemAttribs::set_FETS(), midaspace::SOL_SIFEL, SP_scan_expected_number_exit, midaspace::SP_scan_number(), and midaspace::SP_skip_word().
Referenced by midaspace::Problem::read_mesh_SIFEL().
void midaspace::Mesh::read_mesh_T3d | ( | char * | path, |
const char * | filename | ||
) |
kompletni T3d mesh file
Definition at line 1638 of file geometry.cpp.
References _errorr, _openFilePNS, midaspace::Node::add_domain(), midaspace::allocate_element(), allocate_point(), midaspace::Node::assign_attributes(), midaspace::CG_Hexahedron, midaspace::CG_Line, midaspace::CG_Pyramid, midaspace::CG_Quadrangle, midaspace::CG_Tetrahedron, midaspace::CG_Triangle, midaspace::CG_Wedge, midaspace::classHNAttribs, midaspace::classRANAttribs, midaspace::Geometry::connectivity_allocation(), midaspace::Geometry::Elems, errol, FElems(), midaspace::FFF_T3d, midaspace::FP_scan_line_skip_emptyORcommented(), give_classid(), midaspace::FiLe::give_name(), midaspace::Problem::give_OUT_moFILE(), midaspace::Node::initialize_domli(), Nodes(), NumDomains, NumElems, NumNodes, Parallel, midaspace::ProblemSubject::Pd, midaspace::Geometry::Pjnts, midaspace::Node::read_input(), midaspace::FElement::read_input(), midaspace::Node::release_attributes(), and midaspace::SP_scan_number().
Referenced by midaspace::Model::transform_to_mesh().
void midaspace::Mesh::read_mesh_UNV | ( | char * | path, |
const char * | filename | ||
) |
Definition at line 1941 of file geometry.cpp.
References _errorr, _errorr3, _openFilePN, allocate_point(), midaspace::Geometry::Elems, errol, midaspace::FP_number_of_lines(), midaspace::Cell::give_nno(), midaspace::Geometry::Pjnts, midaspace::scan_expect_num(), midaspace::Elem3D::scan_xyz(), and midaspace::FElement::set_node().
void midaspace::Mesh::read_mesh_VLNA | ( | char * | path, |
const char * | filename | ||
) |
void midaspace::Mesh::read_output_OOFEM | ( | void | ) |
read native output file of OOFEM
Definition at line 2120 of file geometry.cpp.
References _errorr, _openFilePN, _openFilePNS, critical_coeff, midaspace::Geometry::Elems, errol, FElems(), midaspace::FFF_OOFEM, FP_scan_expected_word_exit, midaspace::FP_skip_behind_line_starting_with(), midaspace::FP_skip_expected_string(), midaspace::FP_skip_line(), midaspace::FP_skip_to_line_starting_with(), midaspace::Problem::give_analloctype(), midaspace::Problem::give_analtype(), midaspace::Problem::give_IN_file_results(), midaspace::FiLe::give_name(), midaspace::FiLe::give_name_or_null(), midaspace::Problem::give_nsteps(), midaspace::give_nstepsOut(), midaspace::Problem::give_OUT_moFILE(), midaspace::Problem::give_OUT_Path(), midaspace::Problem::give_output_file(), midaspace::Problem::give_primary_geometry(), Nodes(), midaspace::Geometry::only_1d_elements(), midaspace::PAT_stability_linear, midaspace::PAT_static_linear, midaspace::PAT_static_nonlinear, midaspace::ProblemSubject::Pd, midaspace::Geometry::Pjnts, midaspace::Node::read_output_OOFEM(), midaspace::FElement::read_output_OOFEM(), rslts_loadlevel, rslts_nsteps, rslts_solver, rslts_step, RTE, midaspace::RTE_global_strain, midaspace::RTE_global_stress, RTN, midaspace::RTN_displacement, midaspace::RTN_reaction, midaspace::SOL_OOFEM, and midaspace::SOL_Void.
Referenced by read_structural_analysis_output().
void midaspace::Mesh::read_output_SIFEL | ( | void | ) |
read native output file of SIFEL
Definition at line 2211 of file geometry.cpp.
References _errorr, _errorr2, _openFilePN, midaspace::Geometry::Elems, errol, FElems(), midaspace::FFF_SIFEL, midaspace::FP_scan_expected_word(), midaspace::FP_scan_line(), midaspace::FP_skip_line(), midaspace::FP_skip_to_line_starting_with(), midaspace::Problem::give_analtype(), midaspace::Problem::give_IN_file_results(), midaspace::FiLe::give_name_or_null(), midaspace::give_nstepsOut(), midaspace::Problem::give_OUT_Path(), midaspace::Problem::give_output_file(), Nodes(), midaspace::PAT_nonstationary, midaspace::ProblemSubject::Pd, midaspace::Geometry::Pjnts, midaspace::Node::read_output_SIFEL(), midaspace::FElement::read_output_SIFEL(), rslts_loadlevel, rslts_nsteps, rslts_solver, rslts_step, RTE, midaspace::RTE_fluxes, midaspace::RTE_global_strain, midaspace::RTE_global_stress, midaspace::RTE_gradient, RTN, midaspace::RTN_displacement, midaspace::RTN_reaction, midaspace::RTN_transpunknowns, midaspace::SOL_SIFEL, and midaspace::SOL_Void.
Referenced by read_structural_analysis_output().
void midaspace::Mesh::read_structural_analysis_output | ( | void | ) |
read output file from structural analysis package
Definition at line 2018 of file geometry.cpp.
References _errorr2, errol, midaspace::FFF_OOFEM, midaspace::FFF_SIFEL, midaspace::FiLe::give_ff(), midaspace::Problem::give_IN_file_results(), midaspace::Problem::give_IN_file_results_addataVTK(), midaspace::FiLe::give_name(), midaspace::ProblemSubject::Pd, midaspace::StdoutDriver::print_info_message(), midaspace::StdoutDriver::print_info_message_core(), midaspace::Geometry::read_addata_VTK(), read_output_OOFEM(), read_output_SIFEL(), midaspace::SODE_green_ok, midaspace::SODE_start_blue_arrow, and midaspace::Problem::sodriver().
void midaspace::Mesh::resize_Data | ( | long | newsize | ) |
void midaspace::Mesh::resize_Data_members | ( | long | newsize | ) |
void midaspace::Mesh::resize_Lata | ( | long | newsize | ) |
print VTK file divided to severel functions
Definition at line 3043 of file geometry.cpp.
References Lata.
Referenced by print_characteristics_to_VTK(), print_results(), and print_VTK().
void midaspace::Mesh::resize_Lata_members | ( | long | newsize | ) |
Definition at line 3055 of file geometry.cpp.
References Lata.
Referenced by print_characteristics_to_VTK(), print_results(), and print_VTK().
void midaspace::Mesh::RIGIDmatToRAN | ( | void | ) |
rigid material to RAN
Definition at line 1464 of file geometry.cpp.
References _errorr, midaspace::classBeam, midaspace::classNode, midaspace::Geometry::connectivity_assembling(), midaspace::Geometry::Elems, FElems(), midaspace::Node::give_classid(), give_classid(), midaspace::ProblemSubject::give_ID(), midaspace::Cell::give_lav(), midaspace::FElement::give_mdl_masterel(), midaspace::PointAttribs::give_nDOFs(), midaspace::Point::give_pointAttribs(), midaspace::Geometry::isModel(), midaspace::MAT_RIGID, midaspace::ProblemSubject::Pd, midaspace::StdoutDriver::print_info_message(), midaspace::Geometry::replace_Pjnt_by(), midaspace::SODE_end, midaspace::SODE_start_blue_arrow, midaspace::Problem::sodriver(), and midaspace::TF_GPA_shake_down_reidoid().
|
inline |
Definition at line 283 of file geometry.h.
References Master.
Referenced by midaspace::Model::transform_to_mesh().
|
inline |
|
inline |
void midaspace::Mesh::sort_polydata | ( | Xvctr * | data | ) | const |
sort polydata data
Definition at line 2695 of file geometry.cpp.
References _errorr, midaspace::Xvctr::cpat(), midaspace::Geometry::Elems, midaspace::Geometry::give_vtk_polydata_counts(), midaspace::Geometry::give_VTKPDtopology_of_elem(), midaspace::VTKPD_LINE, and midaspace::VTKPD_POLYGON.
double midaspace::Mesh::volume_core | ( | void | ) | const |
print volume to extra file
Definition at line 4141 of file geometry.cpp.
References midaspace::Geometry::Elems, errol, midaspace::Problem::give_fulldata(), and midaspace::ProblemSubject::Pd.
Referenced by print_results().
|
protected |
Definition at line 293 of file geometry.h.
Referenced by find_subdomains(), and give_cNodesInSD().
|
protected |
Definition at line 302 of file geometry.h.
Referenced by Mesh(), print_results(), and read_output_OOFEM().
|
protected |
Definition at line 292 of file geometry.h.
Referenced by find_subdomains(), give_cSubDomains(), and Mesh().
Definition at line 374 of file geometry.h.
Referenced by print_results(), resize_Data(), resize_Data_members(), and ~Mesh().
dd
ee
Definition at line 373 of file geometry.h.
Referenced by print_characteristics_to_VTK(), print_results(), print_VTK(), resize_Lata(), resize_Lata_members(), and ~Mesh().
|
private |
Definition at line 279 of file geometry.h.
Referenced by give_Master_model(), Mesh(), read_mesh_equal_to_model(), and set_Master_model().
|
protected |
ADAPTIVITY == adaptivity in MIDAS.
Definition at line 308 of file geometry.h.
Referenced by adaptivity(), give_nRegions(), Mesh(), and print_results().
|
protected |
Definition at line 289 of file geometry.h.
Referenced by give_NumDomains(), Mesh(), and read_mesh_T3d().
|
protected |
Definition at line 290 of file geometry.h.
Referenced by add_another_Element(), give_NeAtDom(), Mesh(), read_mesh_T3d(), and ~Mesh().
|
protected |
Definition at line 290 of file geometry.h.
Referenced by give_NnAtDom(), Mesh(), NumNodes_plus(), read_mesh_T3d(), and ~Mesh().
|
protected |
Definition at line 288 of file geometry.h.
Referenced by add_another_Element(), give_NeAtDom(), give_NnAtDom(), give_Parallel(), Mesh(), read_mesh_T3d(), and ~Mesh().
Definition at line 376 of file geometry.h.
Referenced by print_results().
Definition at line 375 of file geometry.h.
|
protected |
Definition at line 301 of file geometry.h.
Referenced by Mesh(), print_results(), read_output_OOFEM(), read_output_SIFEL(), and ~Mesh().
|
protected |
Definition at line 299 of file geometry.h.
Referenced by give_rslts_nsteps(), Mesh(), print_results(), read_output_OOFEM(), and read_output_SIFEL().
|
protected |
RESULTS == structural analysis output data.
Definition at line 298 of file geometry.h.
Referenced by give_rslts_solver(), Mesh(), read_output_OOFEM(), and read_output_SIFEL().
|
protected |
Definition at line 300 of file geometry.h.
Referenced by Mesh(), read_output_OOFEM(), read_output_SIFEL(), and ~Mesh().
|
protected |
Definition at line 305 of file geometry.h.
Referenced by Mesh(), print_results(), read_output_OOFEM(), read_output_SIFEL(), and set_RTE().
|
protected |
Definition at line 304 of file geometry.h.
Referenced by Mesh(), print_results(), read_output_OOFEM(), read_output_SIFEL(), and set_RTN().