Virtual class for creating an element in a mesh. More...
#include <Element.hpp>
Public Member Functions | |
Element (std::string name, const std::vector< unsigned int > nodes, unsigned int ndofs, unsigned int VTKcell, unsigned int SVLcell) | |
Creates an Element in a finite element Mesh. More... | |
virtual | ~Element ()=0 |
Destroys this Element object. More... | |
virtual void | CommitState ()=0 |
Save the material/section states in the element. More... | |
virtual void | UpdateState ()=0 |
Update the material/section states in the element. More... | |
virtual void | ReverseState ()=0 |
Reverse the material/section states to previous converged state in this element. More... | |
virtual void | InitialState ()=0 |
Brings the material/section state to its initial state in this element. More... | |
virtual void | SetDomain (std::map< unsigned int, std::shared_ptr< Node > > &nodes)=0 |
Sets the finite element dependance among objects. More... | |
virtual void | SetDamping (const std::shared_ptr< Damping > &damping)=0 |
Sets the damping model. More... | |
virtual std::vector< unsigned int > | GetTotalDegreeOfFreedom () const =0 |
Gets the list of total-degree of freedom of this Element. More... | |
virtual Eigen::MatrixXd | GetStrain () const =0 |
Gets the material/section (generalised) strain. More... | |
virtual Eigen::MatrixXd | GetStress () const =0 |
Gets the material/section (generalised) stress. More... | |
virtual Eigen::MatrixXd | GetStrainRate () const =0 |
Gets the material/section (generalised) strain-rate. More... | |
virtual Eigen::MatrixXd | GetStrainAt (double x3=0.0, double x2=0.0) const =0 |
Gets the material strain in section at coordinate (x3,x2). More... | |
virtual Eigen::MatrixXd | GetStressAt (double x3=0.0, double x2=0.0) const =0 |
Gets the material stress in section at coordinate (x3,x2). More... | |
virtual Eigen::VectorXd | GetVTKResponse (std::string response) const =0 |
Gets the element internal response in VTK format for Paraview display. More... | |
virtual double | ComputeEnergy ()=0 |
Computes the element energy for a given deformation. More... | |
virtual Eigen::MatrixXd | ComputeMassMatrix ()=0 |
Compute the lumped/consistent mass matrix of the element or close form solutions. More... | |
virtual Eigen::MatrixXd | ComputeStiffnessMatrix ()=0 |
Compute the stiffness matrix of the element using gauss-integration or close form solutions. More... | |
virtual Eigen::MatrixXd | ComputeDampingMatrix ()=0 |
Compute the damping matrix of the element using gauss-integration or close form solutions. More... | |
virtual Eigen::MatrixXd | ComputePMLMatrix ()=0 |
Compute the PML history matrix for Perfectly-Matched Layer (PML). More... | |
virtual Eigen::VectorXd | ComputeInternalForces ()=0 |
Compute the internal forces acting on the element. More... | |
virtual Eigen::VectorXd | ComputeInternalDynamicForces ()=0 |
Compute the elastic, inertial, and viscous forces acting on the element. More... | |
virtual Eigen::VectorXd | ComputeSurfaceForces (const std::shared_ptr< Load > &surface, unsigned int k)=0 |
Compute the surface forces acting on the element. More... | |
virtual Eigen::VectorXd | ComputeBodyForces (const std::shared_ptr< Load > &body, unsigned int k=0)=0 |
Compute the body forces acting on the element. More... | |
virtual Eigen::VectorXd | ComputeDomainReductionForces (const std::shared_ptr< Load > &drm, unsigned int k)=0 |
Compute the domain reduction forces acting on the element. More... | |
std::string | GetName () const |
Gets the Element Name. More... | |
unsigned int | GetVTKCellType () const |
Gets the Element VTK cell type. More... | |
unsigned int | GetVTKGroupType () const |
Gets the Element VTK group type. More... | |
unsigned int | GetNumberOfNodes () const |
Returns the number of nodes in element. More... | |
unsigned int | GetNumberOfDegreeOfFreedom () const |
Returns total number of degree of freedom in the element. More... | |
const std::vector< unsigned int > & | GetNodes () const |
Returns the Node Connectivity Indexes. More... | |
bool | HasFixedNode (const std::vector< std::shared_ptr< Node > > &nodes) const |
Returns if the element has fixed nodes. More... | |
Private Attributes | |
std::string | Name |
The element name. More... | |
unsigned int | VTKCell |
The VTK element number. More... | |
unsigned int | SVLCell |
The SeismoVLAB element type. More... | |
unsigned int | NumberOfNodes |
The number of nodes in element. More... | |
unsigned int | NumberOfDegreeOfFreedom |
The number of nodes in element. More... | |
std::vector< unsigned int > | Nodes |
The node connectivity indexes. More... | |
Virtual class for creating an element in a mesh.
Element::Element | ( | std::string | name, |
const std::vector< unsigned int > | nodes, | ||
unsigned int | ndofs, | ||
unsigned int | VTKcell, | ||
unsigned int | SVLcell | ||
) |
Creates an Element in a finite element Mesh.
name | The name of this Element object. |
nodes | The Node connectivity array. |
ndofs | The number of degree-of-freedom of the Element object. |
VTKcell | The VTK cell number for Paraview display. |
SVLcell | The SeismoVLAB element type for Paraview display. |
|
pure virtual |
Destroys this Element object.
|
pure virtual |
Save the material/section states in the element.
Implemented in TIEQlin2DQuad4, EQlin2DQuad4, lin3DShell4, UnxBoucWen2DLink, UnxBoucWen3DLink, lin3DFrame2, PML3DHexa8, PML2DQuad4, PML2DQuad8, lin2DTria3, lin2DTria6, lin2DQuad4, HDRBYamamoto2DLink, HDRBYamamoto3DLink, lin3DTruss3, lin2DFrame2, kin2DQuad4, lin2DQuad8, lin2DTruss3, kin2DFrame2, lin3DTetra10, lin3DTetra4, kin3DHexa8, lin3DHexa20, lin3DHexa8, kin2DTruss2, kin3DTruss2, lin2DTruss2, lin3DTruss2, ZeroLength1D, null2DFrame2, and null3DFrame2.
|
pure virtual |
Compute the body forces acting on the element.
body | Pointer to the Load object that contains this information. |
k | The time step at which the body load is evaluated. |
Implemented in TIEQlin2DQuad4, EQlin2DQuad4, lin3DShell4, UnxBoucWen2DLink, UnxBoucWen3DLink, lin3DFrame2, PML3DHexa8, PML2DQuad4, PML2DQuad8, lin2DTria3, lin2DTria6, lin2DQuad4, HDRBYamamoto2DLink, HDRBYamamoto3DLink, lin3DTruss3, lin2DFrame2, kin2DQuad4, lin2DQuad8, lin2DTruss3, kin2DFrame2, lin3DTetra10, lin3DTetra4, kin3DHexa8, lin3DHexa20, lin3DHexa8, kin2DTruss2, kin3DTruss2, lin2DTruss2, lin3DTruss2, ZeroLength1D, null2DFrame2, and null3DFrame2.
|
pure virtual |
Compute the damping matrix of the element using gauss-integration or close form solutions.
Implemented in TIEQlin2DQuad4, EQlin2DQuad4, lin3DShell4, UnxBoucWen2DLink, UnxBoucWen3DLink, lin3DFrame2, PML3DHexa8, PML2DQuad4, PML2DQuad8, lin2DTria3, lin2DTria6, lin2DQuad4, HDRBYamamoto2DLink, HDRBYamamoto3DLink, lin3DTruss3, lin2DFrame2, kin2DQuad4, lin2DQuad8, lin2DTruss3, kin2DFrame2, lin3DTetra10, lin3DTetra4, kin3DHexa8, lin3DHexa20, lin3DHexa8, kin2DTruss2, kin3DTruss2, lin2DTruss2, lin3DTruss2, ZeroLength1D, null2DFrame2, and null3DFrame2.
|
pure virtual |
Compute the domain reduction forces acting on the element.
drm | Pointer to the DRM Load object that contains this information. |
k | The time step at which the body load is evaluated. |
Implemented in TIEQlin2DQuad4, EQlin2DQuad4, lin3DShell4, UnxBoucWen2DLink, UnxBoucWen3DLink, lin3DFrame2, PML3DHexa8, PML2DQuad4, PML2DQuad8, lin2DTria3, lin2DTria6, lin2DQuad4, HDRBYamamoto2DLink, HDRBYamamoto3DLink, lin3DTruss3, lin2DFrame2, kin2DQuad4, lin2DQuad8, lin2DTruss3, kin2DFrame2, lin3DTetra10, lin3DTetra4, kin3DHexa8, lin3DHexa20, lin3DHexa8, kin2DTruss2, kin3DTruss2, lin2DTruss2, lin3DTruss2, ZeroLength1D, null2DFrame2, and null3DFrame2.
|
pure virtual |
Computes the element energy for a given deformation.
Implemented in TIEQlin2DQuad4, EQlin2DQuad4, lin3DShell4, UnxBoucWen2DLink, UnxBoucWen3DLink, lin3DFrame2, PML3DHexa8, PML2DQuad4, PML2DQuad8, lin2DTria3, lin2DTria6, lin2DQuad4, HDRBYamamoto2DLink, HDRBYamamoto3DLink, lin3DTruss3, lin2DFrame2, kin2DQuad4, lin2DQuad8, lin2DTruss3, kin2DFrame2, lin3DTetra10, lin3DTetra4, kin3DHexa8, lin3DHexa20, lin3DHexa8, kin2DTruss2, kin3DTruss2, lin2DTruss2, lin3DTruss2, ZeroLength1D, null2DFrame2, and null3DFrame2.
|
pure virtual |
Compute the elastic, inertial, and viscous forces acting on the element.
Implemented in TIEQlin2DQuad4, EQlin2DQuad4, lin3DShell4, UnxBoucWen2DLink, UnxBoucWen3DLink, lin3DFrame2, PML3DHexa8, PML2DQuad4, PML2DQuad8, lin2DTria3, lin2DTria6, lin2DQuad4, HDRBYamamoto2DLink, HDRBYamamoto3DLink, lin3DTruss3, lin2DFrame2, kin2DQuad4, lin2DQuad8, lin2DTruss3, kin2DFrame2, lin3DTetra10, lin3DTetra4, kin3DHexa8, lin3DHexa20, lin3DHexa8, kin2DTruss2, kin3DTruss2, lin2DTruss2, lin3DTruss2, ZeroLength1D, null2DFrame2, and null3DFrame2.
|
pure virtual |
Compute the internal forces acting on the element.
Implemented in TIEQlin2DQuad4, EQlin2DQuad4, lin3DShell4, UnxBoucWen2DLink, UnxBoucWen3DLink, lin3DFrame2, PML3DHexa8, PML2DQuad4, PML2DQuad8, lin2DTria3, lin2DTria6, lin2DQuad4, HDRBYamamoto2DLink, HDRBYamamoto3DLink, lin3DTruss3, lin2DFrame2, kin2DQuad4, lin2DQuad8, lin2DTruss3, kin2DFrame2, lin3DTetra10, lin3DTetra4, kin3DHexa8, lin3DHexa20, lin3DHexa8, kin2DTruss2, kin3DTruss2, lin2DTruss2, lin3DTruss2, ZeroLength1D, null2DFrame2, and null3DFrame2.
|
pure virtual |
Compute the lumped/consistent mass matrix of the element or close form solutions.
Implemented in TIEQlin2DQuad4, EQlin2DQuad4, lin3DShell4, UnxBoucWen2DLink, UnxBoucWen3DLink, lin3DFrame2, PML3DHexa8, PML2DQuad4, PML2DQuad8, lin2DTria3, lin2DTria6, lin2DQuad4, HDRBYamamoto2DLink, HDRBYamamoto3DLink, lin3DTruss3, lin2DFrame2, kin2DQuad4, lin2DQuad8, lin2DTruss3, kin2DFrame2, lin3DTetra10, lin3DTetra4, kin3DHexa8, lin3DHexa20, lin3DHexa8, kin2DTruss2, kin3DTruss2, lin2DTruss2, lin3DTruss2, ZeroLength1D, null2DFrame2, and null3DFrame2.
|
pure virtual |
Compute the PML history matrix for Perfectly-Matched Layer (PML).
Implemented in TIEQlin2DQuad4, EQlin2DQuad4, lin3DShell4, UnxBoucWen2DLink, UnxBoucWen3DLink, lin3DFrame2, PML3DHexa8, PML2DQuad4, PML2DQuad8, lin2DTria3, lin2DTria6, lin2DQuad4, HDRBYamamoto2DLink, HDRBYamamoto3DLink, lin3DTruss3, lin2DFrame2, kin2DQuad4, lin2DQuad8, lin2DTruss3, kin2DFrame2, lin3DTetra10, lin3DTetra4, kin3DHexa8, lin3DHexa20, lin3DHexa8, kin2DTruss2, kin3DTruss2, lin2DTruss2, lin3DTruss2, ZeroLength1D, null2DFrame2, and null3DFrame2.
|
pure virtual |
Compute the stiffness matrix of the element using gauss-integration or close form solutions.
Implemented in TIEQlin2DQuad4, EQlin2DQuad4, lin3DShell4, UnxBoucWen2DLink, UnxBoucWen3DLink, lin3DFrame2, PML3DHexa8, PML2DQuad4, PML2DQuad8, lin2DTria3, lin2DTria6, lin2DQuad4, HDRBYamamoto2DLink, HDRBYamamoto3DLink, lin3DTruss3, lin2DFrame2, kin2DQuad4, lin2DQuad8, lin2DTruss3, kin2DFrame2, lin3DTetra10, lin3DTetra4, kin3DHexa8, lin3DHexa20, lin3DHexa8, kin2DTruss2, kin3DTruss2, lin2DTruss2, lin3DTruss2, ZeroLength1D, null2DFrame2, and null3DFrame2.
|
pure virtual |
Compute the surface forces acting on the element.
surface | Pointer to the Load object that contains this information. |
k | The time step at which the surface load is evaluated. |
Implemented in TIEQlin2DQuad4, EQlin2DQuad4, lin3DShell4, UnxBoucWen2DLink, UnxBoucWen3DLink, lin3DFrame2, PML3DHexa8, PML2DQuad4, PML2DQuad8, lin2DTria3, lin2DTria6, lin2DQuad4, HDRBYamamoto2DLink, HDRBYamamoto3DLink, lin3DTruss3, lin2DFrame2, kin2DQuad4, lin2DQuad8, lin2DTruss3, kin2DFrame2, lin3DTetra10, lin3DTetra4, kin3DHexa8, lin3DHexa20, lin3DHexa8, kin2DTruss2, kin3DTruss2, lin2DTruss2, lin3DTruss2, ZeroLength1D, null2DFrame2, and null3DFrame2.
std::string Element::GetName | ( | ) | const |
const std::vector<unsigned int>& Element::GetNodes | ( | ) | const |
Returns the Node Connectivity Indexes.
unsigned int Element::GetNumberOfDegreeOfFreedom | ( | ) | const |
Returns total number of degree of freedom in the element.
unsigned int Element::GetNumberOfNodes | ( | ) | const |
Returns the number of nodes in element.
|
pure virtual |
Gets the material/section (generalised) strain.
Implemented in TIEQlin2DQuad4, EQlin2DQuad4, lin3DShell4, UnxBoucWen2DLink, UnxBoucWen3DLink, lin3DFrame2, PML3DHexa8, PML2DQuad4, PML2DQuad8, lin2DTria3, lin2DTria6, lin2DQuad4, HDRBYamamoto2DLink, HDRBYamamoto3DLink, lin3DTruss3, lin2DFrame2, kin2DQuad4, lin2DQuad8, lin2DTruss3, kin2DFrame2, lin3DTetra10, lin3DTetra4, kin3DHexa8, lin3DHexa20, lin3DHexa8, kin2DTruss2, kin3DTruss2, lin2DTruss2, lin3DTruss2, ZeroLength1D, null2DFrame2, and null3DFrame2.
|
pure virtual |
Gets the material strain in section at coordinate (x3,x2).
x3 | Local coordinate along the x3-axis. |
x2 | Local coordinate along the x2-axis. |
Implemented in TIEQlin2DQuad4, EQlin2DQuad4, lin3DShell4, UnxBoucWen2DLink, UnxBoucWen3DLink, lin3DFrame2, PML3DHexa8, PML2DQuad4, PML2DQuad8, lin2DTria3, lin2DTria6, lin2DQuad4, HDRBYamamoto2DLink, HDRBYamamoto3DLink, lin3DTruss3, lin2DFrame2, kin2DQuad4, lin2DQuad8, lin2DTruss3, kin2DFrame2, lin3DTetra10, lin3DTetra4, kin3DHexa8, lin3DHexa20, lin3DHexa8, kin2DTruss2, kin3DTruss2, lin2DTruss2, lin3DTruss2, ZeroLength1D, null2DFrame2, and null3DFrame2.
|
pure virtual |
Gets the material/section (generalised) strain-rate.
Implemented in TIEQlin2DQuad4, EQlin2DQuad4, lin3DShell4, UnxBoucWen2DLink, UnxBoucWen3DLink, lin3DFrame2, PML3DHexa8, PML2DQuad4, PML2DQuad8, lin2DTria3, lin2DTria6, lin2DQuad4, HDRBYamamoto2DLink, HDRBYamamoto3DLink, lin3DTruss3, lin2DFrame2, kin2DQuad4, lin2DQuad8, lin2DTruss3, kin2DFrame2, lin3DTetra10, lin3DTetra4, kin3DHexa8, lin3DHexa20, lin3DHexa8, kin2DTruss2, kin3DTruss2, lin2DTruss2, lin3DTruss2, ZeroLength1D, null2DFrame2, and null3DFrame2.
|
pure virtual |
Gets the material/section (generalised) stress.
Implemented in TIEQlin2DQuad4, EQlin2DQuad4, lin3DShell4, UnxBoucWen2DLink, UnxBoucWen3DLink, lin3DFrame2, PML3DHexa8, PML2DQuad4, PML2DQuad8, lin2DTria3, lin2DTria6, lin2DQuad4, HDRBYamamoto2DLink, HDRBYamamoto3DLink, lin3DTruss3, lin2DFrame2, kin2DQuad4, lin2DQuad8, lin2DTruss3, kin2DFrame2, lin3DTetra10, lin3DTetra4, kin3DHexa8, lin3DHexa20, lin3DHexa8, kin2DTruss2, kin3DTruss2, lin2DTruss2, lin3DTruss2, ZeroLength1D, null2DFrame2, and null3DFrame2.
|
pure virtual |
Gets the material stress in section at coordinate (x3,x2).
x3 | Local coordinate along the x3-axis. |
x2 | Local coordinate along the x2-axis. |
Implemented in TIEQlin2DQuad4, EQlin2DQuad4, lin3DShell4, UnxBoucWen2DLink, UnxBoucWen3DLink, lin3DFrame2, PML3DHexa8, PML2DQuad4, PML2DQuad8, lin2DTria3, lin2DTria6, lin2DQuad4, HDRBYamamoto2DLink, HDRBYamamoto3DLink, lin3DTruss3, lin2DFrame2, kin2DQuad4, lin2DQuad8, lin2DTruss3, kin2DFrame2, lin3DTetra10, lin3DTetra4, kin3DHexa8, lin3DHexa20, lin3DHexa8, kin2DTruss2, kin3DTruss2, lin2DTruss2, lin3DTruss2, ZeroLength1D, null2DFrame2, and null3DFrame2.
|
pure virtual |
Gets the list of total-degree of freedom of this Element.
Implemented in TIEQlin2DQuad4, EQlin2DQuad4, lin3DShell4, UnxBoucWen2DLink, UnxBoucWen3DLink, lin3DFrame2, PML3DHexa8, PML2DQuad4, PML2DQuad8, lin2DTria3, lin2DTria6, lin2DQuad4, HDRBYamamoto2DLink, HDRBYamamoto3DLink, lin3DTruss3, lin2DFrame2, kin2DQuad4, lin2DQuad8, lin2DTruss3, kin2DFrame2, lin3DTetra10, lin3DTetra4, kin3DHexa8, lin3DHexa20, lin3DHexa8, kin2DTruss2, kin3DTruss2, lin2DTruss2, lin3DTruss2, ZeroLength1D, null2DFrame2, and null3DFrame2.
unsigned int Element::GetVTKCellType | ( | ) | const |
Gets the Element VTK cell type.
unsigned int Element::GetVTKGroupType | ( | ) | const |
Gets the Element VTK group type.
|
pure virtual |
Gets the element internal response in VTK format for Paraview display.
response | The response to be display in Paraview. |
Implemented in TIEQlin2DQuad4, EQlin2DQuad4, lin3DShell4, UnxBoucWen2DLink, UnxBoucWen3DLink, lin3DFrame2, PML3DHexa8, PML2DQuad4, PML2DQuad8, lin2DTria3, lin2DTria6, lin2DQuad4, HDRBYamamoto2DLink, HDRBYamamoto3DLink, lin3DTruss3, lin2DFrame2, kin2DQuad4, lin2DQuad8, lin2DTruss3, kin2DFrame2, lin3DTetra10, lin3DTetra4, kin3DHexa8, lin3DHexa20, lin3DHexa8, kin2DTruss2, kin3DTruss2, lin2DTruss2, lin3DTruss2, ZeroLength1D, null2DFrame2, and null3DFrame2.
bool Element::HasFixedNode | ( | const std::vector< std::shared_ptr< Node > > & | nodes | ) | const |
Returns if the element has fixed nodes.
|
pure virtual |
Brings the material/section state to its initial state in this element.
Implemented in TIEQlin2DQuad4, EQlin2DQuad4, lin3DShell4, UnxBoucWen2DLink, UnxBoucWen3DLink, lin3DFrame2, PML3DHexa8, PML2DQuad4, PML2DQuad8, lin2DTria3, lin2DTria6, lin2DQuad4, HDRBYamamoto2DLink, HDRBYamamoto3DLink, lin3DTruss3, lin2DFrame2, kin2DQuad4, lin2DQuad8, lin2DTruss3, kin2DFrame2, lin3DTetra10, lin3DTetra4, kin3DHexa8, lin3DHexa20, lin3DHexa8, kin2DTruss2, kin3DTruss2, lin2DTruss2, lin3DTruss2, ZeroLength1D, null2DFrame2, and null3DFrame2.
|
pure virtual |
Reverse the material/section states to previous converged state in this element.
Implemented in TIEQlin2DQuad4, EQlin2DQuad4, lin3DShell4, UnxBoucWen2DLink, UnxBoucWen3DLink, lin3DFrame2, PML3DHexa8, PML2DQuad4, PML2DQuad8, lin2DTria3, lin2DTria6, lin2DQuad4, HDRBYamamoto2DLink, HDRBYamamoto3DLink, lin3DTruss3, lin2DFrame2, kin2DQuad4, lin2DQuad8, lin2DTruss3, kin2DFrame2, lin3DTetra10, lin3DTetra4, kin3DHexa8, lin3DHexa20, lin3DHexa8, kin2DTruss2, kin3DTruss2, lin2DTruss2, lin3DTruss2, ZeroLength1D, null2DFrame2, and null3DFrame2.
|
pure virtual |
Sets the damping model.
damping | Pointer to the damping model. |
Implemented in TIEQlin2DQuad4, EQlin2DQuad4, lin3DShell4, UnxBoucWen2DLink, UnxBoucWen3DLink, lin3DFrame2, PML3DHexa8, PML2DQuad4, PML2DQuad8, lin2DTria3, lin2DTria6, lin2DQuad4, HDRBYamamoto2DLink, HDRBYamamoto3DLink, lin3DTruss3, lin2DFrame2, kin2DQuad4, lin2DQuad8, lin2DTruss3, kin2DFrame2, lin3DTetra10, lin3DTetra4, kin3DHexa8, lin3DHexa20, lin3DHexa8, kin2DTruss2, kin3DTruss2, lin2DTruss2, lin3DTruss2, ZeroLength1D, null2DFrame2, and null3DFrame2.
|
pure virtual |
Sets the finite element dependance among objects.
Implemented in TIEQlin2DQuad4, EQlin2DQuad4, lin3DShell4, UnxBoucWen2DLink, UnxBoucWen3DLink, lin3DFrame2, PML3DHexa8, PML2DQuad4, PML2DQuad8, lin2DTria3, lin2DTria6, lin2DQuad4, HDRBYamamoto2DLink, HDRBYamamoto3DLink, lin3DTruss3, lin2DFrame2, kin2DQuad4, lin2DQuad8, lin2DTruss3, kin2DFrame2, lin3DTetra10, lin3DTetra4, kin3DHexa8, lin3DHexa20, lin3DHexa8, kin2DTruss2, kin3DTruss2, lin2DTruss2, lin3DTruss2, ZeroLength1D, null2DFrame2, and null3DFrame2.
|
pure virtual |
Update the material/section states in the element.
Implemented in TIEQlin2DQuad4, EQlin2DQuad4, lin3DShell4, UnxBoucWen2DLink, UnxBoucWen3DLink, lin3DFrame2, PML3DHexa8, PML2DQuad4, PML2DQuad8, lin2DTria3, lin2DTria6, lin2DQuad4, HDRBYamamoto2DLink, HDRBYamamoto3DLink, lin3DTruss3, lin2DFrame2, kin2DQuad4, lin2DQuad8, lin2DTruss3, kin2DFrame2, lin3DTetra10, lin3DTetra4, kin3DHexa8, lin3DHexa20, lin3DHexa8, kin2DTruss2, kin3DTruss2, lin2DTruss2, lin3DTruss2, ZeroLength1D, null2DFrame2, and null3DFrame2.
|
private |
The element name.
|
private |
The node connectivity indexes.
|
private |
The number of nodes in element.
|
private |
The number of nodes in element.
|
private |
The SeismoVLAB element type.
|
private |
The VTK element number.