#include <cell.h>
 
  
 | Public Member Functions | |
| FElement (classID mecg, long gid, long oid, const Geometry *mg, long ord, long nn, long ne, long nf, bool aa, long dom, long lid) | |
| CONSTRUCTOR.  More... | |
| FElement (classID mecg, const FElement *src) | |
| CONSTRUCTOR COPY.  More... | |
| virtual | ~FElement () | 
| DESTRUCTOR.  More... | |
| void | attributes_allocation (const GelemAttribs *masterat) | 
| virtual void | initialize (void) | 
| initiate/sets data  More... | |
| virtual void | checkConsistency (void) const | 
| Checks data consistency.  More... | |
| const Mesh * | Msh (void) const | 
| virtual void | set_model_prop (long val, const Model *model, bool flag=false) | 
| virtual SPRpatchType | give_spr_patch_type (void) const | 
| return type of element for OOFEM solver  More... | |
| int | give_nDOFs (void) const | 
| give number of DOFs  More... | |
| IntPointSet | give_IPset_comp (Solver sol) const | 
| basic set = for displacement computation  More... | |
| IntPointSet | give_IPset_rslts (Solver sol) const | 
| basic set = for results  More... | |
| int | give_rslt_NIP (Solver sol) const | 
| IntPointSet | give_IPset2 (void) const | 
| higher set = for displacement^2 computation, or mass matrix or sigma error ...  More... | |
| void | set_lid (long val) | 
| int | give_ord (void) const | 
| long | give_nnoed (int i) const | 
| long | give_domain (void) const | 
| long | give_lid (void) const | 
| const Gelement * | give_mdl_masterel (void) const | 
| void | set_node (long i, long nid) | 
| ATRIBUTES.  More... | |
| void | set_node (long i, const Node *nod) | 
| const Node * | give_node (long i) const | 
| long | give_parent_id (void) const | 
| long | give_parent_prop (void) const | 
| void | set_regid (long val) | 
| long | give_regid (void) const | 
| void | allocate_results (void) | 
| RESULTS.  More... | |
| void | add_result (Array *rslt, long step, ResultTypesAtElem rt) | 
| void | set_result (long s, double *rslt, long step, ResultTypesAtElem rt) | 
| void | set_result (double rslt, long step, ResultTypesAtElem rt) | 
| void | set_result (const VectoR *rslt, long step, ResultTypesAtElem rt) | 
| const Dscal * | give_results_ds (long step, ResultTypesAtElem rt) const | 
| const Dvctr * | give_results_dv (long step, ResultTypesAtElem rt) const | 
| const Dmtrx * | give_results_dm (long step, ResultTypesAtElem rt) const | 
| const Array * | give_results (long step, ResultTypesAtElem rt) const | 
| virtual void | compute_maxSigmaEq (void) | 
| void | setup_maxSigmaEq (void) | 
| double | give_CSusage_elast (void) | 
| double | give_CSusage_elast_rel (void) | 
| int | give_CSusage_elast_bool (void) | 
| virtual double | give_ssstate (Dvctr *data, SStype SST, RVType rvtype, char type, long step, const Node *node=NULL)=0 | 
| give stress-strain state  More... | |
| void | check_rslts (long step, ResultTypesAtElem rt) const | 
| double | fillupbyzero (Dvctr *data, SStype SST) const | 
| long | give_result_ncomp (long time_step, ResultTypesAtElem rte) const | 
| void | initialize_CSL (int c, long *fID, long *tCSL) | 
| initializes Constant Surface Load  More... | |
| virtual void | read_input (const char *&str, femFileFormat fff) | 
| virtual void | read_output_OOFEM (FILE *stream, long step) | 
| virtual void | read_output_SIFEL (FILE *stream, long step, ResultTypesAtElem rt) | 
| virtual void | print_row (FILE *stream, femFileFormat fff, bool endline=true, long did=0) const | 
| print element row output for OOFEM  More... | |
| void | read_nodes (const char *&str, femFileFormat fff) | 
| print element row output for VTK  More... | |
| bool | is_cmfr (void) | 
| virtual void | give_ip_coords_global (IntPointSet ips, int i, PoinT &coords) const | 
|  Public Member Functions inherited from midaspace::Element | |
| Element (classID mecg, long gid, long oid, long prop, const Geometry *mg, long nn, long ne, long nf) | |
| CONSTRUCTOR.  More... | |
| Element (classID mecg, const Element *src) | |
| CONSTRUCTOR COPY.  More... | |
| virtual | ~Element () | 
| DESTRUCTOR.  More... | |
| VTKPDtopology | give_VTKPDtopology (void) const | 
| const Facedge * | give_same_dimension_facedge (void) const | 
| Returns edge/face/volume of same dimension as receiver (Beam returns edge, etc.)  More... | |
| virtual DOFsPerNode | give_DOFsPerNode_default (void) const =0 | 
| Returns edge/face/volume of same dimension as receiver (Beam returns edge, etc.)  More... | |
| virtual SStype | give_SSType_default (void) const =0 | 
| give default type of stress state  More... | |
| void | set_mprop (long val) | 
| *** SET ***  More... | |
| void | set_prop_node_inher (bool everynode) | 
| inherit property from element to nodes, only if node has one superelem  More... | |
| void | set_fullhinge_at (const Point *p) | 
| ElemAttribs * | give_elemAttribs (void) | 
| const ElemAttribs * | give_elemAttribs (void) const | 
| bool | has_fullhinge_at (int point) const | 
| void | connectivity_assembling (bool re=false) | 
| Function assembles connectivity between element and its nodes, edges and faces (which are allocated if needed)  More... | |
| void | connectivity_removing (void) | 
| Function removes connectivity between element and its components == nodes, edges and faces.  More... | |
| virtual long | give_edge_nodes (const Point **&edgnodes) const | 
| void | set_load (int i, int indx=-1) | 
| bool | is_point_on (const PoinT *point, const GeometryComponent *&comp, PoinT *nc) const | 
| Function finds out mutual position of point with coords and 'element'.  More... | |
| void | switch_node_pointer_in_all_components (Point *slave, Point *master, bool duplcheck) | 
| switch node pointer from oldnode/slave to newnode/master on this and all components (edges, faces)  More... | |
| virtual void | switch_node_pointer (Point *slave, Point *master, bool duplcheck) | 
| switch node pointer form slave to master  More... | |
| virtual double | give_quality (void) const | 
| compute quality of element  More... | |
| virtual double | give_volume (void) const | 
| compute volume of element  More... | |
| bool | isBeam (void) const | 
| bool | isTruss (void) const | 
| void | print_row_VTK (FILE *stream) const | 
| print element row output for VTK  More... | |
| virtual void | print_row_VTX (char *str) const | 
|  Public Member Functions inherited from midaspace::Cell | |
| CellGeometry | give_cellGeom (void) const | 
| int | give_dimension (void) const | 
| return type of element geometry, is identical with class derived from FElement  More... | |
| const PoinT * | give_centercoords (void) const | 
| double | give_circum (void) const | 
| double | give_lav (void) const | 
| double | give_GeomWeight1deg (void) const | 
| bool | is_point_in_sphere (const PoinT *point) const | 
| double | give_characteristic_size (void) const | 
| ComponentGeometry * | give_cg (void) | 
| Cell (classID mecg, long gid, long oid, long prop, const Geometry *mg, long nn, long ne, long nf) | |
| CONSTRUCTOR.  More... | |
| Cell (classID mecg, const Cell *src) | |
| CONSTRUCTOR COPY.  More... | |
| virtual | ~Cell () | 
| DESTRUCTOR.  More... | |
| void | check_connectivity_loc (void) const | 
| void | set_point (long i, const Point *val) | 
| ATRIBUTES.  More... | |
| void | set_point (long i, long pid) | 
| void | set_edge (long i, const Edge *val) | 
| void | set_face (long i, const Face *val) | 
| long | give_nno (void) const | 
| long | give_ned (void) const | 
| long | give_nfa (void) const | 
| const Point * | give_point (long i) const | 
| const Edge * | give_edge (long i) const | 
| const Face * | give_face (long i) const | 
| const GPA< const Point > * | give_points (void) const | 
| const GPA< const Edge > * | give_edges (void) const | 
| const GPA< const Face > * | give_faces (void) const | 
| long | give_point_indx (const Point *p) const | 
| virtual long | give_face_nodes_edges (const Point **&facnodes, const Edge **&facedges) const | 
| virtual void | switch_myself_at_connectivity (Cell *master) | 
| switch receiver to master in connectivity system  More... | |
| bool | switch_edge_pointer (Edge *slave, Edge *master) | 
| switch pointer to component edge - slave is replaced be master  More... | |
| bool | switch_face_pointer (Face *slave, Face *master) | 
| switch pointer to component face - slave is replaced be master  More... | |
| void | setup_duplicity_master (Cell *val) | 
| bool | invisible_duplicated (char flag='a') | 
| make invisible if duplicated  More... | |
| bool | has_same_geom_with (Cell *slave) const | 
| ASSORTED check same geometry.  More... | |
| bool | check_collapse (void) | 
| check any two nodes are same = element is collapsed  More... | |
| bool | cross_abscissa_node (const PoinT *a1, const PoinT *a2, long cunn, const Point **unnod, const Point *&nod, double &ksi, PoinT *cp) const | 
| Function finds out whether some element node lays on abscissa.  More... | |
| int | cross_abscissa_face (const PoinT *a1, const PoinT *a2, long cunf, const Face **unfac, const Cell *&comp, PoinT *nc, PoinT *cp) | 
| Function finds out whether abscissa intersects any face.  More... | |
|  Public Member Functions inherited from midaspace::GeometryComponent | |
| GeometryComponent (const Geometry *owner, long gid, long oid, long prop) | |
| CONSTRUCTOR.  More... | |
| GeometryComponent (const GeometryComponent *src) | |
| CONSTRUCTOR COPY.  More... | |
| virtual | ~GeometryComponent () | 
| DESTRUCTOR.  More... | |
| virtual void | finitialize (void) | 
| finalize preprocessing  More... | |
| void | reset_mprop (long val) | 
| bool | checkset_mprop (long val) | 
| void | set_origID (long val) | 
| void | set_delete_flag (bool val) | 
| long | give_mproperty () const | 
| *** GET ***  More... | |
| const Lvctr * | give_mproperty_ptr (void) const | 
| long | give_mpropertyORzero (void) const | 
| long | give_mproperty_cnt (void) const | 
| bool | has_mproperty (long prop) const | 
| long | give_origID () const | 
| bool | give_delete_flag () const | 
| Attributes * | give_attributes (void) | 
| const Attributes * | give_attributes (void) const | 
| bool | Parallel (void) const | 
| *** FEMesh ***  More... | |
| long | NumDomains (void) const | 
| void | check_connectivity (void) const | 
| void | mg_connectivity_assembling (void) | 
|  Public Member Functions inherited from midaspace::GeometrySubject | |
| GeometrySubject (long gid) | |
| CONSTRUCTOR.  More... | |
| GeometrySubject (long gid, const Problem *owner) | |
| CONSTRUCTOR.  More... | |
| GeometrySubject (long gid, const Geometry *owner) | |
| CONSTRUCTOR.  More... | |
| virtual | ~GeometrySubject () | 
| DESTRUCTOR.  More... | |
| void | set_Geom (const Geometry *owner) | 
| void | reset_Geom (const Geometry *owner) | 
| const Geometry * | give_Geom (void) const | 
|  Public Member Functions inherited from midaspace::ProblemSubject | |
| ProblemSubject (long gid) | |
| CONSTRUCTOR.  More... | |
| ProblemSubject (long gid, const Problem *owner) | |
| CONSTRUCTOR.  More... | |
| virtual | ~ProblemSubject () | 
| DESTRUCTOR.  More... | |
| virtual classID | give_classid () const | 
| Returns classID - class identification.  More... | |
| void | set_ID (long val) | 
| long | give_ID () const | 
| void | set_Pd (const Problem *owner) | 
| const Problem * | give_Pd (void) const | 
| Protected Member Functions | |
| virtual void | integrate_duplicated_cell (const Element *slave) | 
| DUPLICITY.  More... | |
|  Protected Member Functions inherited from midaspace::Element | |
| ElemAttribs * | elemAttribs () | 
| Gives attribute attributes, data type changed to ElemAttribs*.  More... | |
| const ElemAttribs * | elemAttribs () const | 
|  Protected Member Functions inherited from midaspace::Cell | |
| virtual void | integrate_duplicated_cell (const Cell *slave) | 
| Protected Attributes | |
| long | domain | 
| long | lid | 
| const Gelement * | mdl_masterel | 
| double * | maxSigmaEq | 
|  Protected Attributes inherited from midaspace::Cell | |
| ComponentGeometry * | cg | 
|  Protected Attributes inherited from midaspace::GeometryComponent | |
| Lvctr | mproperty | 
| long | origid | 
| bool | fordelete | 
| Attributes * | attributes | 
| ATTRIBUTES.  More... | |
|  Protected Attributes inherited from midaspace::GeometrySubject | |
| const Geometry * | Geom | 
| Pointer to owner == parent geometry.  More... | |
|  Protected Attributes inherited from midaspace::ProblemSubject | |
| long | ID | 
| (global) identification number == position in list of members; zero-based numbering.  More... | |
| const Problem * | Pd | 
| Pointer to owner = parent problem.  More... | |
| Private Attributes | |
| Array *** | results | 
| 2d array of pointers to Array (Xvctr or Xmtrx)  More... | |
| long | regid | 
| Additional Inherited Members | |
|  Public Attributes inherited from midaspace::Cell | |
| GPA< const Point > | points | 
| GPA< const Edge > | edges | 
| GPA< const Face > | faces | 
| bool | connectivity_assembled | 
| Cell * | duplmaster | 
| midaspace::FElement::FElement | ( | classID | mecg, | 
| long | gid, | ||
| long | oid, | ||
| const Geometry * | mg, | ||
| long | ord, | ||
| long | nn, | ||
| long | ne, | ||
| long | nf, | ||
| bool | aa, | ||
| long | dom, | ||
| long | lid | ||
| ) | 
CONSTRUCTOR.
Definition at line 1544 of file cell.cpp.
References attributes_allocation(), domain, lid, maxSigmaEq, mdl_masterel, regid, and results.
CONSTRUCTOR COPY.
Definition at line 1560 of file cell.cpp.
References midaspace::GeometryComponent::attributes, domain, errol, midaspace::ProblemSubject::ID, lid, maxSigmaEq, and results.
| 
 | virtual | 
DESTRUCTOR.
Definition at line 1571 of file cell.cpp.
References midaspace::cRTE, midaspace::deallocateCheckUno(), maxSigmaEq, Msh(), and results.
| void midaspace::FElement::add_result | ( | Array * | rslt, | 
| long | step, | ||
| ResultTypesAtElem | rt | ||
| ) | 
Definition at line 1708 of file cell.cpp.
References allocate_results(), errol, and results.
Referenced by midaspace::Beam::read_output_OOFEM(), midaspace::Triangle::read_output_OOFEM(), midaspace::Quadrangle::read_output_OOFEM(), midaspace::Brick::read_output_OOFEM(), midaspace::Beam::read_output_SIFEL(), midaspace::Triangle::read_output_SIFEL(), and midaspace::Brick::read_output_SIFEL().
| void midaspace::FElement::allocate_results | ( | void | ) | 
RESULTS.
Definition at line 1694 of file cell.cpp.
References midaspace::cRTE, midaspace::Mesh::give_rslts_nsteps(), Msh(), and results.
Referenced by add_result(), and set_result().
| void midaspace::FElement::attributes_allocation | ( | const GelemAttribs * | masterat | ) | 
Definition at line 1578 of file cell.cpp.
References midaspace::GeometryComponent::attributes, midaspace::EAL_direct, and errol.
Referenced by FElement(), and read_input().
| 
 | inline | 
Definition at line 709 of file cell.h.
References _errorr3, and results.
Referenced by midaspace::Beam::compute_maxSigmaEq(), midaspace::Triangle::compute_maxSigmaEq(), midaspace::Beam::give_ssstate(), midaspace::Triangle::give_ssstate(), midaspace::Quadrangle::give_ssstate(), and midaspace::Brick::give_ssstate().
| 
 | virtual | 
Checks data consistency.
Reimplemented from midaspace::Cell.
Reimplemented in midaspace::Brick, midaspace::Tetra, midaspace::Quadrangle, midaspace::Triangle, and midaspace::Beam.
Definition at line 1594 of file cell.cpp.
References _errorr, midaspace::Cell::checkConsistency(), midaspace::Element::elemAttribs(), and give_ord().
Referenced by midaspace::Beam::checkConsistency(), midaspace::Triangle::checkConsistency(), midaspace::Quadrangle::checkConsistency(), midaspace::Tetra::checkConsistency(), and midaspace::Brick::checkConsistency().
| 
 | inlinevirtual | 
Reimplemented in midaspace::Triangle, and midaspace::Beam.
Definition at line 697 of file cell.h.
References _errorr2, and midaspace::ProblemSubject::ID.
Referenced by setup_maxSigmaEq().
Definition at line 1785 of file cell.cpp.
References _errorr2, midaspace::Problem::give_global_nDOFs(), midaspace::ProblemSubject::Pd, midaspace::Dvctr::resize_ignore_vals(), midaspace::SST_3d, midaspace::SST_3dshell, midaspace::SST_beam, midaspace::SST_plstrain, midaspace::SST_plstress, midaspace::SST_transp2d, midaspace::SST_truss, and midaspace::Dvctr::zero().
Referenced by midaspace::Beam::give_ssstate(), midaspace::Triangle::give_ssstate(), midaspace::Quadrangle::give_ssstate(), and midaspace::Brick::give_ssstate().
| double midaspace::FElement::give_CSusage_elast | ( | void | ) | 
Definition at line 1737 of file cell.cpp.
References midaspace::Element::elemAttribs(), midaspace::ElemAttribs::give_cs(), midaspace::CrossSection::give_nlayers(), maxSigmaEq, and setup_maxSigmaEq().
Referenced by midaspace::Mesh::print_results().
| int midaspace::FElement::give_CSusage_elast_bool | ( | void | ) | 
Definition at line 1778 of file cell.cpp.
References give_CSusage_elast_rel().
Referenced by midaspace::Mesh::print_results().
| double midaspace::FElement::give_CSusage_elast_rel | ( | void | ) | 
Definition at line 1757 of file cell.cpp.
References midaspace::Element::elemAttribs(), midaspace::ElemAttribs::give_cs(), midaspace::CrossSection::give_mat(), midaspace::ElemAttribs::give_mat(), midaspace::CrossSection::give_nlayers(), midaspace::Material::give_Ry(), maxSigmaEq, and setup_maxSigmaEq().
Referenced by give_CSusage_elast_bool(), and midaspace::Mesh::print_results().
| 
 | inline | 
Definition at line 642 of file cell.h.
References domain.
Referenced by midaspace::Mesh::print_block_elems(), and midaspace::Triangle::Triangle().
| 
 | inlinevirtual | 
Reimplemented in midaspace::Quadrangle, and midaspace::Triangle.
Definition at line 741 of file cell.h.
References _errorr.
| IntPointSet midaspace::FElement::give_IPset2 | ( | void | ) | const | 
higher set = for displacement^2 computation, or mass matrix or sigma error ...
| IntPointSet midaspace::FElement::give_IPset_comp | ( | Solver | sol | ) | const | 
basic set = for displacement computation
basic set = for displacement computation (integration of stiffness matrix)
Definition at line 1635 of file cell.cpp.
References midaspace::Element::elemAttribs(), midaspace::FETSet_set2e(), midaspace::Problem::give_analgroup(), midaspace::ElemAttribs::give_IPset(), midaspace::IntPointSet_fet2e_comp(), midaspace::IPS_Void, and midaspace::ProblemSubject::Pd.
Referenced by give_IPset_rslts().
| IntPointSet midaspace::FElement::give_IPset_rslts | ( | Solver | sol | ) | const | 
basic set = for results
Definition at line 1647 of file cell.cpp.
References midaspace::Element::elemAttribs(), midaspace::FETSet_set2e(), midaspace::Problem::give_analgroup(), give_IPset_comp(), midaspace::IntPointSet_fet2e_rslts(), and midaspace::ProblemSubject::Pd.
Referenced by give_rslt_NIP(), midaspace::Beam::read_output_OOFEM(), midaspace::Triangle::read_output_OOFEM(), midaspace::Quadrangle::read_output_OOFEM(), midaspace::Brick::read_output_OOFEM(), midaspace::Beam::read_output_SIFEL(), and midaspace::Triangle::read_output_SIFEL().
| 
 | inline | 
| 
 | inline | 
Definition at line 645 of file cell.h.
References mdl_masterel.
Referenced by midaspace::FElemAttribs::initialize(), midaspace::Mesh::RIGIDmatToRAN(), and midaspace::Triangle::Triangle().
| 
 | inline | 
give number of DOFs
Definition at line 625 of file cell.h.
References midaspace::DOFsPerNode2nDOFs(), midaspace::Element::elemAttribs(), and midaspace::Cell::give_nno().
| 
 | inline | 
Definition at line 640 of file cell.h.
References midaspace::Element::elemAttribs(), errol, and give_ord().
Referenced by midaspace::Problem::read_mesh_SIFEL().
| 
 | inline | 
Definition at line 652 of file cell.h.
References midaspace::Cell::points.
Referenced by midaspace::FElemAttribs::initialize().
| 
 | inline | 
Definition at line 639 of file cell.h.
References midaspace::Element::elemAttribs(), and midaspace::ElemAttribs::give_ord().
Referenced by checkConsistency(), midaspace::Beam::give_edge_nodes(), midaspace::Triangle::give_edge_nodes(), midaspace::Quadrangle::give_edge_nodes(), midaspace::Tetra::give_edge_nodes(), midaspace::Brick::give_edge_nodes(), midaspace::Triangle::give_face_nodes_edges(), midaspace::Quadrangle::give_face_nodes_edges(), midaspace::Tetra::give_face_nodes_edges(), midaspace::Brick::give_face_nodes_edges(), give_nnoed(), midaspace::Triangle::give_quality(), midaspace::PolyLine::init_point_on(), print_row(), read_input(), midaspace::Problem::read_mesh_SIFEL(), and read_nodes().
| 
 | inline | 
Definition at line 656 of file cell.h.
References _errorr, midaspace::GeometryComponent::give_mproperty(), and mdl_masterel.
Referenced by midaspace::Mesh::print_results().
| 
 | inline | 
Definition at line 657 of file cell.h.
References _errorr, midaspace::GeometryComponent::give_mpropertyORzero(), and mdl_masterel.
Referenced by midaspace::Mesh::print_results(), and midaspace::Mesh::print_VTK().
| 
 | inline | 
Definition at line 682 of file cell.h.
References regid.
Referenced by midaspace::Mesh::print_results().
| long midaspace::FElement::give_result_ncomp | ( | long | time_step, | 
| ResultTypesAtElem | rte | ||
| ) | const | 
Definition at line 1803 of file cell.cpp.
References errol, midaspace::Xmtrx::give_ccols(), and results.
| 
 | inline | 
Definition at line 692 of file cell.h.
References results.
Referenced by midaspace::Mesh::print_results(), midaspace::Triangle::read_output_OOFEM(), and midaspace::Quadrangle::read_output_OOFEM().
| const Dmtrx * midaspace::FElement::give_results_dm | ( | long | step, | 
| ResultTypesAtElem | rt | ||
| ) | const | 
Definition at line 1716 of file cell.cpp.
References errol, and results.
Referenced by midaspace::Beam::compute_maxSigmaEq(), midaspace::Triangle::compute_maxSigmaEq(), midaspace::Beam::give_ssstate(), midaspace::Triangle::give_ssstate(), midaspace::Quadrangle::give_ssstate(), midaspace::Brick::give_ssstate(), midaspace::Triangle::read_output_OOFEM(), and midaspace::Quadrangle::read_output_OOFEM().
| const Dscal * midaspace::FElement::give_results_ds | ( | long | step, | 
| ResultTypesAtElem | rt | ||
| ) | const | 
Definition at line 1714 of file cell.cpp.
References errol, and results.
Referenced by midaspace::Mesh::print_results().
| const Dvctr * midaspace::FElement::give_results_dv | ( | long | step, | 
| ResultTypesAtElem | rt | ||
| ) | const | 
| 
 | inline | 
Definition at line 631 of file cell.h.
References give_IPset_rslts(), and midaspace::IntPointSet_give_number_ips().
Referenced by midaspace::Triangle::give_ssstate(), midaspace::Quadrangle::give_ssstate(), midaspace::Brick::give_ssstate(), and midaspace::Brick::read_output_SIFEL().
| 
 | inlinevirtual | 
return type of element for OOFEM solver
Reimplemented in midaspace::Quadrangle, and midaspace::Triangle.
Definition at line 623 of file cell.h.
References errol, and midaspace::SPRPT_Void.
| 
 | pure virtual | 
give stress-strain state
Implemented in midaspace::Brick, midaspace::Tetra, midaspace::Quadrangle, midaspace::Triangle, and midaspace::Beam.
Referenced by midaspace::Mesh::print_results().
| 
 | virtual | 
initiate/sets data
Reimplemented from midaspace::GeometryComponent.
Reimplemented in midaspace::Beam.
Definition at line 1588 of file cell.cpp.
References midaspace::GeometryComponent::initialize().
Referenced by midaspace::Beam::initialize().
| void midaspace::FElement::initialize_CSL | ( | int | c, | 
| long * | fID, | ||
| long * | tCSL | ||
| ) | 
initializes Constant Surface Load
| 
 | protectedvirtual | 
DUPLICITY.
Reimplemented from midaspace::Element.
Definition at line 1665 of file cell.cpp.
References _errorr, midaspace::Element::elemAttribs(), midaspace::ElemAttribs::give_FETS(), midaspace::Element::integrate_duplicated_cell(), and midaspace::FiniteElementTypeSet::is_equal_to().
| 
 | inline | 
Definition at line 615 of file cell.h.
References midaspace::GeometrySubject::Geom.
Referenced by allocate_results(), midaspace::Beam::give_ssstate(), midaspace::Triangle::give_ssstate(), midaspace::Quadrangle::give_ssstate(), midaspace::Mesh::print_VTK_elems(), set_node(), midaspace::Triangle::Triangle(), and ~FElement().
| 
 | virtual | 
print element row output for OOFEM
print row to solver input file
Implements midaspace::GeometryComponent.
Reimplemented in midaspace::Beam.
Definition at line 1935 of file cell.cpp.
References midaspace::CellGeometry_e2i_JKTK(), domain, midaspace::ECN_convert_e2i(), midaspace::Cell::edges, midaspace::Element::elemAttribs(), errol, midaspace::Cell::faces, midaspace::FET_ANSYS_start, midaspace::FETSet_set2e(), midaspace::FETSet_set2i_SIFEL(), midaspace::FETSet_set2s_OOFEM(), midaspace::FFF_ANSYS, midaspace::FFF_JKTK, midaspace::FFF_OOFEM, midaspace::FFF_SIFEL, midaspace::Problem::give_analgroup(), midaspace::Cell::give_cellGeom(), midaspace::ProblemSubject::give_ID(), midaspace::GeometryComponent::give_mpropertyORzero(), give_ord(), midaspace::Problem::give_PDBO(), midaspace::ProblemSubject::ID, lid, midaspace::GeometryComponent::origid, midaspace::GeometryComponent::Parallel(), midaspace::ProblemSubject::Pd, midaspace::PDBO_melnik, midaspace::PDBO_OUT_origelemid, midaspace::Cell::points, midaspace::Attributes::print_row(), midaspace::SOL_ANSYS, midaspace::SST_plstrain, and midaspace::SST_plstress.
Referenced by midaspace::Mesh::print_block_elems(), and midaspace::Beam::print_row().
| 
 | virtual | 
edge face properties
Reimplemented in midaspace::Brick, midaspace::Quadrangle, and midaspace::Triangle.
Definition at line 1816 of file cell.cpp.
References _errorr, _errorr2, attributes_allocation(), CASE, midaspace::CG_Hexahedron, midaspace::CG_Line, midaspace::CG_Quadrangle, midaspace::CG_Triangle, midaspace::Element::connectivity_assembling(), midaspace::ECN_convert_e2i(), midaspace::Cell::edges, midaspace::Element::elemAttribs(), errol, midaspace::Cell::faces, midaspace::FFF_JKTK, midaspace::FFF_OOFEM, midaspace::FFF_SIFEL, midaspace::FFF_T3d, midaspace::GeometrySubject::Geom, midaspace::Cell::give_cellGeom(), midaspace::Gelement::give_gelemAttribs(), midaspace::GeometryComponent::give_mproperty_cnt(), give_ord(), midaspace::ElemAttribs::initialize_from(), mdl_masterel, midaspace::Cell::points, read_nodes(), set_model_prop(), midaspace::Element::set_mprop(), SP_scan_expected_number_exit, SP_scan_expected_word_exit, midaspace::SP_scan_number(), and midaspace::SP_skip_word().
Referenced by midaspace::Triangle::read_input(), midaspace::Quadrangle::read_input(), midaspace::Brick::read_input(), midaspace::Mesh::read_mesh_JKTK(), midaspace::Mesh::read_mesh_OOFEM(), midaspace::Mesh::read_mesh_SIFEL(), and midaspace::Mesh::read_mesh_T3d().
| void midaspace::FElement::read_nodes | ( | const char *& | str, | 
| femFileFormat | fff | ||
| ) | 
print element row output for VTK
read nodes in in human numbering from a string
Definition at line 2027 of file cell.cpp.
References midaspace::ECN_convert_e2i(), midaspace::Element::elemAttribs(), midaspace::Cell::give_cellGeom(), give_ord(), midaspace::Cell::points, set_node(), and midaspace::SP_scan_number().
Referenced by read_input().
| 
 | inlinevirtual | 
Reimplemented in midaspace::Brick, midaspace::Quadrangle, midaspace::Triangle, and midaspace::Beam.
Definition at line 722 of file cell.h.
References _errorr.
Referenced by midaspace::Mesh::read_output_OOFEM().
| 
 | inlinevirtual | 
Reimplemented in midaspace::Brick, midaspace::Triangle, and midaspace::Beam.
Definition at line 723 of file cell.h.
References _errorr.
Referenced by midaspace::Mesh::read_output_SIFEL().
| 
 | inline | 
Definition at line 638 of file cell.h.
References lid.
Referenced by midaspace::Mesh::add_another_Element().
| 
 | virtual | 
Reimplemented from midaspace::GeometryComponent.
Definition at line 1620 of file cell.cpp.
References errol, midaspace::Cell::give_dimension(), midaspace::Geometry::give_Elem(), mdl_masterel, and midaspace::GeometryComponent::set_mprop().
Referenced by read_input(), and midaspace::Mesh::read_mesh_equal_to_model().
| 
 | inline | 
ATRIBUTES.
Definition at line 649 of file cell.h.
References Msh(), and midaspace::Cell::points.
Referenced by midaspace::PolyLine::findout_segment_domain(), midaspace::Mesh::read_mesh_ANSYS(), midaspace::Mesh::read_mesh_equal_to_model(), midaspace::Mesh::read_mesh_UNV(), and read_nodes().
| 
 | inline | 
Definition at line 650 of file cell.h.
References midaspace::Cell::points.
| 
 | inline | 
| void midaspace::FElement::set_result | ( | long | s, | 
| double * | rslt, | ||
| long | step, | ||
| ResultTypesAtElem | rt | ||
| ) | 
Definition at line 1709 of file cell.cpp.
References allocate_results(), errol, and results.
Referenced by midaspace::Mesh::adaptivity().
| void midaspace::FElement::set_result | ( | double | rslt, | 
| long | step, | ||
| ResultTypesAtElem | rt | ||
| ) | 
Definition at line 1710 of file cell.cpp.
References allocate_results(), errol, and results.
| void midaspace::FElement::set_result | ( | const VectoR * | rslt, | 
| long | step, | ||
| ResultTypesAtElem | rt | ||
| ) | 
Definition at line 1711 of file cell.cpp.
References allocate_results(), errol, and results.
| void midaspace::FElement::setup_maxSigmaEq | ( | void | ) | 
Definition at line 1719 of file cell.cpp.
References compute_maxSigmaEq(), midaspace::Element::elemAttribs(), midaspace::ElemAttribs::give_cs(), midaspace::CrossSection::give_nlayers(), and maxSigmaEq.
Referenced by give_CSusage_elast(), and give_CSusage_elast_rel().
| 
 | protected | 
Definition at line 592 of file cell.h.
Referenced by FElement(), give_domain(), and print_row().
| 
 | protected | 
Definition at line 593 of file cell.h.
Referenced by FElement(), give_lid(), print_row(), and set_lid().
| 
 | protected | 
Definition at line 673 of file cell.h.
Referenced by midaspace::Beam::compute_maxSigmaEq(), midaspace::Triangle::compute_maxSigmaEq(), FElement(), give_CSusage_elast(), give_CSusage_elast_rel(), setup_maxSigmaEq(), and ~FElement().
| 
 | protected | 
Definition at line 595 of file cell.h.
Referenced by FElement(), give_mdl_masterel(), give_parent_id(), give_parent_prop(), read_input(), set_model_prop(), and midaspace::Triangle::Triangle().
| 
 | private | 
Definition at line 671 of file cell.h.
Referenced by FElement(), give_regid(), and set_regid().
| 
 | private | 
2d array of pointers to Array (Xvctr or Xmtrx)
Definition at line 670 of file cell.h.
Referenced by add_result(), allocate_results(), check_rslts(), FElement(), give_result_ncomp(), give_results(), give_results_dm(), give_results_ds(), give_results_dv(), set_result(), and ~FElement().
 1.8.6.
1.8.6.