Class for creating an uniaxial 3D two-node link element using Bouc-Wen formulation. More...
#include <UnxBoucWen3DLink.hpp>
Public Member Functions | |
UnxBoucWen3DLink (const std::vector< unsigned int > nodes, std::vector< double > parameters, std::vector< double > variables, const unsigned int dim, const unsigned int dir, double tol=1E-06, unsigned int nmax=50) | |
Creates a UnxBoucWen3DLink in a finite element Mesh. More... | |
~UnxBoucWen3DLink () | |
Destroys this UnxBoucWen3DLink 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... | |
Private Member Functions | |
double | sign (double x) const |
Sign function. More... | |
Eigen::VectorXd | ComputeRelativeDeformation () const |
Update strain in the element: More... | |
Eigen::MatrixXd | ComputeLocalAxes () const |
Compute local axes. More... | |
Eigen::MatrixXd | ComputeRotationMatrix () const |
Compute rotation matrix. More... | |
Private Attributes | |
double | Ko |
Initial stiffness of hysteretic component. More... | |
double | Fy |
Yield force. More... | |
double | alpha |
Yielding exponent (sharpness of hysteresis loop corners) More... | |
double | eta |
Yielding exponent (sharpness of hysteresis loop corners) More... | |
double | beta |
First hysteretic shape parameter. More... | |
double | gamma |
second hysteretic shape parameter More... | |
double | Tol |
Newton-Raphson Tolerance. More... | |
double | z |
Trial Hysteretic evolution parameters. More... | |
double | zn |
Hysteretic evolution parameters. More... | |
double | U |
Trial displacements in local coordinates. More... | |
double | Un |
Displacements in local coordinates. More... | |
double | qbw |
Non-linear Bouc-Wen internal force. More... | |
double | qbc |
Non-linear commited Bouc-Wen internal force. More... | |
double | kbw |
Consistent Bouc-Wen stiffness. More... | |
double | kbc |
Consistent commited Bouc-Wen stiffness. More... | |
unsigned int | nMax |
Newton-Raphson maximum number of iterations. More... | |
unsigned int | Dimension |
The element dimension in global coordinates. More... | |
unsigned int | Direction |
The element direction in global coordinates. More... | |
std::vector< std::shared_ptr< Node > > | theNodes |
The Element's Nodes. More... | |
Class for creating an uniaxial 3D two-node link element using Bouc-Wen formulation.
UnxBoucWen3DLink::UnxBoucWen3DLink | ( | const std::vector< unsigned int > | nodes, |
std::vector< double > | parameters, | ||
std::vector< double > | variables, | ||
const unsigned int | dim, | ||
const unsigned int | dir, | ||
double | tol = 1E-06 , |
||
unsigned int | nmax = 50 |
||
) |
Creates a UnxBoucWen3DLink in a finite element Mesh.
nodes | The Node connectivity array of this Element. |
parameters | Vector that contains the Bouc-Wen model parameters. |
variables | Vector that contains auxiliary model parameters. |
dim | The model dimension. |
dir | The local direction where this Element is acting. |
tol | Tolerance to stop Newton-Raphson iterations. |
nmax | Maximum number of iteration for Newton-Raphson. |
UnxBoucWen3DLink::~UnxBoucWen3DLink | ( | ) |
Destroys this UnxBoucWen3DLink object.
|
virtual |
|
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. |
Implements Element.
|
virtual |
Compute the damping matrix of the element using gauss-integration.
Implements Element.
|
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. |
Implements Element.
|
virtual |
Computes the element energy for a given deformation.
Implements Element.
|
virtual |
|
virtual |
Compute the internal (elastic) forces acting on the element.
Implements Element.
|
private |
Compute local axes.
|
virtual |
Compute the lumped/consistent mass matrix of the element.
Implements Element.
|
virtual |
|
private |
Update strain in the element:
|
private |
Compute rotation matrix.
|
virtual |
Compute the stiffness matrix of the element using gauss-integration.
Implements Element.
|
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. |
Implements Element.
|
virtual |
Gets the material/section (generalised) strain.
Implements Element.
|
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. |
Implements Element.
|
virtual |
Gets the material/section (generalised) strain-rate.
Implements Element.
|
virtual |
Gets the material/section (generalised) stress.
Implements Element.
|
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. |
Implements Element.
|
virtual |
|
virtual |
|
virtual |
Brings the material/section state to its initial state in this element.
Implements Element.
|
virtual |
|
virtual |
|
virtual |
|
private |
Sign function.
|
virtual |
|
private |
Yielding exponent (sharpness of hysteresis loop corners)
|
private |
First hysteretic shape parameter.
|
private |
The element dimension in global coordinates.
|
private |
The element direction in global coordinates.
|
private |
Yielding exponent (sharpness of hysteresis loop corners)
|
private |
Yield force.
|
private |
second hysteretic shape parameter
|
private |
Consistent commited Bouc-Wen stiffness.
|
private |
Consistent Bouc-Wen stiffness.
|
private |
Initial stiffness of hysteretic component.
|
private |
Newton-Raphson maximum number of iterations.
|
private |
Non-linear commited Bouc-Wen internal force.
|
private |
Non-linear Bouc-Wen internal force.
|
private |
Newton-Raphson Tolerance.
|
private |
Trial displacements in local coordinates.
|
private |
Displacements in local coordinates.
|
private |
Trial Hysteretic evolution parameters.
|
private |
Hysteretic evolution parameters.