Class for creating a bidirectional 2D two-node link element using Yamamoto HDRB formulation.
More...
|
| HDRBYamamoto2DLink (const std::vector< unsigned int > nodes, double de, double di, double hr, unsigned int dim) |
| Creates a HDRBYamamoto2DLink in a finite element Mesh. More...
|
|
| ~HDRBYamamoto2DLink () |
| Destroys this HDRBYamamoto2DLink object. More...
|
|
void | CommitState () |
| Save the material states in the element. More...
|
|
void | ReverseState () |
| Reverse the material/section states to previous converged state in this element. More...
|
|
void | InitialState () |
| Brings the material/section state to its initial state in this element. More...
|
|
void | UpdateState () |
| Update the material states in the element. More...
|
|
void | SetDomain (std::map< unsigned int, std::shared_ptr< Node > > &nodes) |
| Sets the finite element dependance among objects. More...
|
|
void | SetDamping (const std::shared_ptr< Damping > &damping) |
| Sets the damping model. More...
|
|
std::vector< unsigned int > | GetTotalDegreeOfFreedom () const |
| Gets the list of total-degree of freedom of this Element. More...
|
|
Eigen::MatrixXd | GetStrain () const |
| Gets the material/section (generalised) strain. More...
|
|
Eigen::MatrixXd | GetStress () const |
| Gets the material/section (generalised) stress. More...
|
|
Eigen::MatrixXd | GetStrainRate () const |
| Gets the material/section (generalised) strain-rate. More...
|
|
Eigen::MatrixXd | GetStrainAt (double x3, double x2) const |
| Gets the material strain in section at coordinate (x3,x2). More...
|
|
Eigen::MatrixXd | GetStressAt (double x3, double x2) const |
| Gets the material stress in section at coordinate (x3,x2). More...
|
|
Eigen::VectorXd | GetVTKResponse (std::string response) const |
| Gets the element internal response in VTK format for Paraview display. More...
|
|
double | ComputeEnergy () |
| Computes the element energy for a given deformation. More...
|
|
Eigen::MatrixXd | ComputeMassMatrix () |
| Compute the lumped/consistent mass matrix of the element. More...
|
|
Eigen::MatrixXd | ComputeStiffnessMatrix () |
| Compute the stiffness matrix of the element using gauss-integration. More...
|
|
Eigen::MatrixXd | ComputeDampingMatrix () |
| Compute the damping matrix of the element using gauss-integration. More...
|
|
Eigen::MatrixXd | ComputePMLMatrix () |
| Compute the PML history matrix using gauss-integration. More...
|
|
Eigen::VectorXd | ComputeInternalForces () |
| Compute the internal (elastic) forces acting on the element. More...
|
|
Eigen::VectorXd | ComputeInternalDynamicForces () |
| Compute the elastic, inertial, and viscous forces acting on the element. More...
|
|
Eigen::VectorXd | ComputeSurfaceForces (const std::shared_ptr< Load > &surface, unsigned int face) |
| Compute the surface forces acting on the element. More...
|
|
Eigen::VectorXd | ComputeBodyForces (const std::shared_ptr< Load > &body, unsigned int k=0) |
| Compute the body forces acting on the element. More...
|
|
Eigen::VectorXd | ComputeDomainReductionForces (const std::shared_ptr< Load > &drm, unsigned int k) |
| Compute the domain reduction forces acting on the element. More...
|
|
| 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...
|
|
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...
|
|
|
double | n |
| Yamamoto's model parameter. More...
|
|
double | alpha |
| Yamamoto's model parameter. More...
|
|
double | Ar |
| Rubber bearing area. More...
|
|
double | Hr |
| Rubber bearing height. More...
|
|
double | Krb |
| Rubber Bearing linear stiffness. More...
|
|
double | cr |
| coefficient of shear stress More...
|
|
double | cs |
| coefficient of shear stress More...
|
|
unsigned int | Dimension |
| HDRB link dimension in 3D. More...
|
|
unsigned int | nMax |
| Newton-Raphson maximum number of iterations. More...
|
|
Eigen::VectorXd | Pn |
| Displacement Trajectory Vector. More...
|
|
Eigen::VectorXd | Qn |
| Non-linear Displacement Trajectory Vector. More...
|
|
Eigen::VectorXd | Fn |
| Non-linear Restoring Force Vector. More...
|
|
Eigen::VectorXd | Fc |
| Non-linear Commited Restoring Force Vector. More...
|
|
Eigen::VectorXd | Paux |
| Trial Displacement Trajectory Vector. More...
|
|
Eigen::VectorXd | Qaux |
| Non-linear Displacement Trajectory Vector. More...
|
|
std::vector< std::shared_ptr< Node > > | theNodes |
| The Element's Nodes. More...
|
|
Class for creating a bidirectional 2D two-node link element using Yamamoto HDRB formulation.
- See also
- Element.hpp Mesh.hpp