xc
Public Types | Public Member Functions | Static Public Member Functions | Static Public Attributes | Protected Member Functions | Protected Attributes | Friends | List of all members

Base class for the finite elements. More...

#include <Element.h>

Inheritance diagram for XC::Element:
Inheritance graph
[legend]
Collaboration diagram for XC::Element:
Collaboration graph
[legend]

Public Types

typedef std::vector< const Node * > NodesEdge
 Nodes on an element edge. More...
 
- Public Types inherited from EntityWithProperties
typedef std::map< std::string, boost::python::object > PythonDict
 

Public Member Functions

 Element (int tag, int classTag)
 Constructor that takes the element's unique tag and the number of external nodes for the element. More...
 
virtual ElementgetCopy (void) const =0
 Virtual constructor.
 
virtual int getNumExternalNodes (void) const =0
 return the number of external nodes associated with the element.
 
virtual int getNumEdges (void) const
 Returns number of edges (it must be overloaded for elements that have nodes inside edges. More...
 
virtual BoolArray3d getNodePattern (void) const
 Return a grid of booleans, one for each of the element nodes. More...
 
virtual NodePtrsWithIDsgetNodePtrs (void)=0
 
virtual const NodePtrsWithIDsgetNodePtrs (void) const =0
 
std::vector< int > getIdxNodes (void) const
 Return the indexes of the nodes (used when creating VTK meshes). More...
 
virtual int getNumDOF (void) const =0
 return the number of DOF associated with the element. More...
 
virtual size_t getDimension (void) const
 Returns the element dimension (0, 1, 3 or 3).
 
virtual double getLength (bool initialGeometry=true) const
 Return the element length.
 
virtual double getArea (bool initialGeometry=true) const
 Return the element area.
 
virtual double getVolume (bool initialGeometry=true) const
 Return the element volume.
 
virtual void setIdNodes (const std::vector< int > &inodes)
 Set the nodes.
 
virtual void setIdNodes (const ID &inodes)
 Set the nodes.
 
virtual void setIdNode (const int &i, const int &inode)
 Set the i-th node.
 
int find (const Node *) const
 Returns the index of the node whose pointer is being passed as parameter. More...
 
void replaceNode (Node *, Node *)
 Replace the old node by the new one. More...
 
void setDomain (Domain *theDomain)
 Sets the domain for the element.
 
virtual int commitState (void)
 Commit the current element state. More...
 
virtual int revertToLastCommit (void)=0
 Revert to the last committed state. More...
 
virtual int revertToStart (void)
 Reverts the element to its initial state. More...
 
virtual int update (void)
 Updates the element state. More...
 
virtual bool isSubdomain (void)
 Returns true if the element is a subdomain.
 
virtual const MatrixgetTangentStiff (void) const =0
 Return the tangent stiffness matrix. More...
 
virtual const MatrixgetInitialStiff (void) const =0
 
virtual const MatrixgetDamp (void) const
 Returns the damping matrix. More...
 
virtual const MatrixgetMass (void) const
 Returns the mass matrix. More...
 
virtual Matrix getMass (const Node *) const
 Returns the mass matrix corresponding to the node argument.
 
Matrix getTotalMass (void) const
 Returns the sum of the mass matrices corresponding to the nodes.
 
double getTotalMassComponent (const int &) const
 Return the mass matrix component for the DOF argument.
 
Matrix getNodeMatrixComponents (const Node *, const Matrix &) const
 Returns the components of the matrix relative to the node. More...
 
virtual void zeroLoad (void)
 Zeroes the loads over the element. More...
 
virtual void createInertiaLoad (const Vector &)
 Creates the inertia load that corresponds to the acceleration argument. More...
 
virtual int addLoad (ElementalLoad *, double loadFactor)=0
 
virtual int addInertiaLoadToUnbalance (const Vector &accel)=0
 
virtual int setRayleighDampingFactors (const RayleighDampingFactors &rF) const
 Set Rayleigh damping factors.
 
virtual const VectorgetResistingForce (void) const =0
 Returns the resisting force vector for the element. More...
 
virtual const VectorgetResistingForceIncInertia (void) const
 Returns the resisting force vector including inertia forces. More...
 
const VectorgetNodeResistingComponents (const size_t &, const Vector &) const
 Returns the generalized force of the element over the iNod-th node. More...
 
const VectorgetNodeResistingForce (const size_t &iNod) const
 Returns the generalized force of the element over the iNod-th node. More...
 
const VectorgetNodeResistingForceIncInertia (const size_t &iNod) const
 Returns the generalized force (including inertia forces) of the element over the node identified by the argument. More...
 
const VectorgetNodeResistingForce (const Node *) const
 Returns the generalized force (including inertia forces) of the element over the node identified by the argument. More...
 
const VectorgetNodeResistingForceIncInertia (const Node *) const
 Returns the generalized force (including inertia forces) of the element over the node identified by the argument. More...
 
Vector getEquivalentStaticLoad (int mode, const double &) const
 Returns the equivalent static load for the mode being passed as parameter and the acceleration that corresponding that mode. More...
 
Matrix getEquivalentStaticNodalLoads (int mode, const double &) const
 Returns the equivalent static load on each node for the mode being passed as parameter and the corresponding acceleration to the mode. More...
 
virtual ResponsesetResponse (const std::vector< std::string > &argv, Information &eleInformation)
 setResponse() is a method invoked to determine if the element will respond to a request for a certain of information. More...
 
virtual int getResponse (int responseID, Information &eleInformation)
 Obtain information from an analysis. More...
 
ResponsesetMaterialResponse (Material *, const std::vector< std::string > &, const size_t &, Information &)
 
virtual int addInertiaLoadSensitivityToUnbalance (const Vector &accel, bool tag)
 
virtual int setParameter (const std::vector< std::string > &argv, Parameter &param)
 Sets the value param to the parameter argv.
 
int setMaterialParameter (Material *, const std::vector< std::string > &, const size_t &, Parameter &)
 Set the value of a parameter of the material. More...
 
virtual int updateParameter (int parameterID, Information &info)
 Updates the parameter identified by parameterID with info.
 
virtual int activateParameter (int parameterID)
 Activates the parameter identified by parameterID.
 
virtual const VectorgetResistingForceSensitivity (int gradNumber)
 
virtual const MatrixgetInitialStiffSensitivity (int gradNumber)
 
virtual const MatrixgetDampSensitivity (int gradNumber)
 
virtual const MatrixgetMassSensitivity (int gradNumber)
 
virtual int commitSensitivity (int gradNumber, int numGrads)
 
virtual int addResistingForceToNodalReaction (bool inclInertia)
 Adds nodal reactions.
 
double MaxCooNod (int i) const
 Returns the maximum value of the i coordinate of the element nodes.
 
double MinCooNod (int i) const
 Returns the minimum value of the i coordinate of the element nodes.
 
const MatrixgetCooNodes (void) const
 Returns the coordinates of the nodes.
 
virtual Matrix getLocalAxes (bool initialGeometry=true) const
 Returns a matrix with the axes of the element as matrix rows [[x1,y1,z1],[x2,y2,z2],...ยท].
 
virtual Vector getBaseVector (size_t i, bool initialGeometry=true) const
 Returns a base vector in the direction of the local i-th axis from the i-th row of the matrix returned by getLocalAxes. More...
 
virtual Vector3d getBaseVector3d (size_t i, bool initialGeometry=true) const
 Returns a base vector in the direction of the local i-th axis from the i-th row of the matrix returned by getLocalAxes. More...
 
virtual Vector3d getIVector3d (bool initialGeometry=true) const
 Returns a vector in the direction of the local x axis from the first row of the matrix returned by getLocalAxes. More...
 
virtual Vector3d getJVector3d (bool initialGeometry=true) const
 Returns a vector in the direction of the local y axis from the second row of the matrix returned by getLocalAxes. More...
 
virtual Vector3d getKVector3d (bool initialGeometry=true) const
 Returns a vector in the direction of the local z axis from the third row of the matrix returned by getLocalAxes. More...
 
virtual Rect3d3dCooSys getCooSys (bool) const
 Returns the element coordinate system from the matrix returned by getLocalAxes. More...
 
Pos3d getPosNode (const size_t &i, bool initialGeometry=true) const
 Returns the position of the i-th node. More...
 
std::deque< Pos3dgetPosNodes (bool initialGeometry=true) const
 Returns the coordinates of the nodes.
 
virtual Pos3d getCenterOfMassPosition (bool initialGeometry=true) const
 Returns the coordinates of the center of gravity of the element.
 
Vector getCenterOfMassCoordinates (bool initialGeometry=true) const
 Returns the coordinates of the center of mass of the element.
 
Pos3dArray3d getPoints (const size_t &ni, const size_t &nj, const size_t &nk, bool initialGeometry=true)
 Returns a grid of points distributed along the line.
 
bool In (const GeomObj3d &, const double &factor=1.0, const double &tol=0.0) const
 
bool Out (const GeomObj3d &, const double &factor=1.0, const double &tol=0.0) const
 
bool In (const GeomObj2d &, const double &factor=1.0, const double &tol=0.0) const
 
bool Out (const GeomObj2d &, const double &factor=1.0, const double &tol=0.0) const
 
virtual double getDist2 (const Pos2d &p, bool initialGeometry=true) const
 Returns the squared distance from the element to the point being passed as parameter. More...
 
virtual double getDist (const Pos2d &p, bool initialGeometry=true) const
 Returns the the distance from the element to the point being passed as parameter. More...
 
virtual double getDist2 (const Pos3d &p, bool initialGeometry=true) const
 Returns the squared distance from the element to the point being passed as parameter. More...
 
virtual double getDist (const Pos3d &p, bool initialGeometry=true) const
 Returns the the distance from the element to the point being passed as parameter. More...
 
virtual Pos2d getProjection (const Pos2d &p, bool initialGeometry=true) const
 Return the projection of the argument on the element. More...
 
virtual Pos3d getProjection (const Pos3d &p, bool initialGeometry=true) const
 Return the projection of the argument on the element. More...
 
void resetTributaries (void) const
 Resets tributary areas of connected nodes.
 
void dumpTributaries (const std::vector< double > &) const
 Adds to the tributary magnitude of each node the vector being passed as parameter. More...
 
virtual void computeTributaryLengths (bool initialGeometry=true) const
 Computes the tributary lengths that corresponds to each node of the element.
 
virtual double getTributaryLength (const Node *) const
 Returns the tributary length corresponding to the node being passed as parameter. More...
 
virtual double getTributaryLengthByTag (const int &) const
 Returns the tributary length corresponding to the node which tag se pasa as parameter. More...
 
virtual void computeTributaryAreas (bool initialGeometry=true) const
 Compute tributary areas for each element node.
 
virtual double getTributaryArea (const Node *) const
 Returns the tributary area corresponding to the node.
 
virtual double getTributaryAreaByTag (const int &) const
 Returns the tributary area corresponding to the node.
 
virtual void computeTributaryVolumes (bool initialGeometry=true) const
 Computes the tributary volumes that corresponds to each node of the element.
 
virtual double getTributaryVolume (const Node *) const
 Returns the tributary volume corresponding to the node being passed as parameter. More...
 
virtual double getTributaryVolumeByTag (const int &) const
 Returns the tributary volume corresponding to the node which tag se pasa as parameter. More...
 
virtual ParticlePos3d getNaturalCoordinates (const Pos3d &, bool initialGeometry=true) const
 
virtual Vector getInterpolationFactors (const ParticlePos3d &) const
 Returns interpolation factors for a material point.
 
virtual Vector getInterpolationFactors (const Pos3d &) const
 Returns interpolation factors for a material point.
 
virtual int getVtkCellType (void) const
 Interfaz con VTK.
 
virtual const GaussModelgetGaussModel (void) const
 Returns the Gauss integration model of the element.
 
virtual NodesEdge getNodesEdge (const size_t &) const
 Returns the nodes of the element edge.
 
virtual int getEdgeNodes (const Node *, const Node *) const
 Returns the edge of the element that ends in the nodes being passed as parameters. More...
 
int getEdgeNodes (const int &, const int &) const
 Returns the edge of the element that ends in the nodes with the tags being passed as parameters. More...
 
virtual ID getEdgesNode (const Node *) const
 Returns the edges of the element that ends in the node being passed as parameter. More...
 
std::set< int > getEdgesNodes (const NodePtrSet &) const
 Returns the element edges that have both ends in the node set being passed as parameter. More...
 
ID getEdgesNodeByTag (const int &) const
 Returns the edges of the element that have an en in the node with the tag being passed as parameter. More...
 
virtual ID getLocalIndexNodesEdge (const size_t &i) const
 Returns the local indexes of the element nodes that lie over the i-th edge. More...
 
virtual std::set< std::string > getMaterialNames (void) const
 Return the names of the material(s) of the element.
 
boost::python::list getMaterialNamesPy (void) const
 Return the names of the material(s) of the element in a Python list.
 
virtual boost::python::list getValuesAtNodes (const std::string &, bool silent=false) const
 Return a python list with the values of the argument property at element nodes. More...
 
std::set< SetBase * > get_sets (void) const
 Returns the sets to which the element belongs.
 
void add_to_sets (std::set< SetBase *> &)
 Adds the element to the sets being passed as parameters.
 
- Public Member Functions inherited from XC::MeshComponent
 MeshComponent (int classTag)
 Constructor.
 
 MeshComponent (int tag, int classTag)
 Constructor.
 
- Public Member Functions inherited from XC::ContinuaReprComponent
 ContinuaReprComponent (int classTag)
 
 ContinuaReprComponent (int tag, int classTag)
 
virtual const bool isDead (void) const
 Return true if the component is not active.
 
virtual const bool isAlive (void) const
 Return true if the component is active.
 
virtual void kill (void)
 Deactivates the component.
 
virtual void alive (void)
 Activates the component.
 
- Public Member Functions inherited from XC::DomainComponent
 ~DomainComponent (void)
 Destructor.
 
size_t getIdx (void) const
 Returns the index of the object (to be used in VTK arrays).
 
virtual DomaingetDomain (void) const
 Returns a pointer to the enclosing domain. More...
 
const PreprocessorgetPreprocessor (void) const
 Returns (if possible) a pointer to the preprocessor.
 
PreprocessorgetPreprocessor (void)
 Return (if possible) a pointer to the preprocessor.
 
const LoadPatterngetCurrentLoadPattern (void) const
 Return the current load pattern.
 
LoadPatterngetCurrentLoadPattern (void)
 Return the current load pattern.
 
void set_index (const size_t &i)
 Set the index for the object (see numera in Set). More...
 
boost::python::dict getPyDict (void) const
 Return a Python dictionary with the object members values.
 
void setPyDict (const boost::python::dict &)
 Set the values of the object members from a Python dictionary.
 
- Public Member Functions inherited from XC::TaggedObject
 TaggedObject (int tag, CommandEntity *owr=nullptr)
 Constructor. More...
 
void assignTag (int newTag)
 Set tag (to be called from Python interface).
 
int getTag (void) const
 Returns the tag associated with the object.
 
virtual void Print (std::ostream &, int flag=0) const
 Print stuff.
 
boost::python::dict getPyDict (void) const
 Return a Python dictionary with the object members values.
 
void setPyDict (const boost::python::dict &)
 Set the values of the object members from a Python dictionary.
 
- Public Member Functions inherited from CommandEntity
 CommandEntity (CommandEntity *owr=nullptr)
 Default constructor.
 
CommandEntityOwner (void)
 Return a pointer to the object owner.
 
const CommandEntityOwner (void) const
 Return un puntero al objeto propietario de ESTE.
 
const StandardOutputWrappergetStandardOutputWrapper (void) const
 Return the regular output stream wrapper.
 
StandardOutputWrappergetStandardOutputWrapper (void)
 Return the regular output stream wrapper.
 
const std::string & getLogFileName (void) const
 Returns log file name.
 
void setLogFileName (const std::string &)
 Sets log file name.
 
const std::string & getErrFileName (void) const
 Returns err file name.
 
void setErrFileName (const std::string &)
 Sets error file name.
 
const std::string & getOutputFileName (void) const
 Returns regular output file name.
 
void setOutputFileName (const std::string &)
 Sets regular output file name.
 
boost::python::object evalPy (boost::python::object dict, const std::string &)
 Return the Python object that results from evaluating the argument.
 
boost::python::object execPy (boost::python::object dict, const std::string &)
 Return the Python objects that results from executing the code in the string argument.
 
boost::python::object execFilePy (boost::python::object dict, const std::string &)
 Return the Python object that results from executing the code in the file.
 
- Public Member Functions inherited from EntityWithProperties
 EntityWithProperties (EntityWithProperties *owr=nullptr)
 Default constructor.
 
virtual bool operator== (const EntityWithProperties &) const
 Comparison operator.
 
void clearPyProps (void)
 Clear python properties map.
 
bool hasPyProp (const std::string &)
 Returns true if property exists.
 
boost::python::object getPyProp (const std::string &str)
 Return the Python object with the name being passed as parameter.
 
void setPyProp (std::string str, boost::python::object val)
 Sets/appends a value tho the Python object's dictionary.
 
void copyPropsFrom (const EntityWithProperties &)
 Copy the properties from the argument.
 
boost::python::list getPropNames (void) const
 Return the names of the object properties weightings.
 
const PythonDict & getPropertiesDict (void) const
 Return a std::map container with the properties of the object.
 
- Public Member Functions inherited from EntityWithOwner
 EntityWithOwner (EntityWithOwner *owr=nullptr)
 Default constructor.
 
 EntityWithOwner (const EntityWithOwner &)
 Copy constructor.
 
EntityWithOwneroperator= (const EntityWithOwner &)
 Assignment operator.
 
virtual bool operator== (const EntityWithOwner &) const
 Comparison operator.
 
virtual ~EntityWithOwner (void)
 Virtual destructor.
 
virtual std::string getClassName (void) const
 Returns demangled class name.
 
void set_owner (EntityWithOwner *owr)
 Assigns the owner of the object.
 
EntityWithOwnerOwner (void)
 
const EntityWithOwnerOwner (void) const
 
- Public Member Functions inherited from XC::MovableObject
 MovableObject (int classTag, int dbTag)
 Constructor. More...
 
 MovableObject (int classTag)
 Constructor. More...
 
 MovableObject (const MovableObject &)
 Copy constructor. Doesn't copy the dbTag.
 
MovableObjectoperator= (const MovableObject &)
 Assignment operator. Doesn't copy the dbTag.
 
int getClassTag (void) const
 Return the class identifier.
 
int getDbTag (void) const
 Return the object identifier in the database.
 
int getDbTag (Communicator &)
 Return the object identifier in the database.
 
void setDbTag (int dbTag)
 Sets the object identifier in the database.
 
void setDbTag (Communicator &)
 Sets the object identifier in the database if not already set. More...
 
virtual int sendSelf (Communicator &comm)=0
 Send the object. More...
 
virtual int recvSelf (const Communicator &comm)=0
 Receive the object. More...
 
virtual int setVariable (const std::string &variable, Information &)
 Set the value of the variable idenfified by var.
 
virtual int getVariable (const std::string &variable, Information &)
 Return the value of the variable idenfified by var.
 
- Public Member Functions inherited from XC::DistributedBase
 DistributedBase (void)
 Constructor.
 
virtual ~DistributedBase (void)
 Destructor.
 
virtual DbTagDatagetDbTagData (void) const
 Returns a vector to store class dbTags.
 
const int & getDbTagDataPos (const int &i) const
 Returns the data at the i-th position.
 
void setDbTagDataPos (const int &i, const int &v)
 Sets the data at the i-th position.
 
void inicComm (const int &dataSize) const
 Initializes communication.
 

Static Public Member Functions

static void setDeadSRF (const double &d)
 Assigns Stress Reduction Factor for element deactivation.
 
static DefaultTaggetDefaultTag (void)
 Returns next element's tag value by default.
 
- Static Public Member Functions inherited from CommandEntity
static void resetStandardOutput (void)
 Reset the standard output streams to its defaults buffers.
 
- Static Public Member Functions inherited from EntityWithOwner
static int getVerbosityLevel (void)
 Get the value of the verbosity level.
 
static void setVerbosityLevel (const int &)
 Set the value of the verbosity level.
 

Static Public Attributes

static double dead_srf = 1e-6
 Stress reduction factor for foozen elements.
 

Protected Member Functions

virtual ElemPtrArray3d put_on_mesh (const NodePtrArray3d &, meshing_dir) const
 Places the element on the mesh.
 
virtual ElemPtrArray3d sew (const SetEstruct &f1, const SetEstruct &f2) const
 
const VectorgetRayleighDampingForces (void) const
 Returns element Rayleigh damping forces.
 
const Materialget_material_ptr (const std::string &) const
 Return a pointer to the material that corresponds to the name. More...
 
int sendData (Communicator &comm)
 Sends object members through the communicator argument.
 
int recvData (const Communicator &comm)
 Receives object members through the communicator argument.
 
- Protected Member Functions inherited from XC::MeshComponent
void setup_matrices (std::deque< Matrix > &, const int &) const
 Initializes the matrix container.
 
int sendIdsLabels (int posDbTag, Communicator &)
 Send labelsthrough the communicator argument.
 
int recvIdsLabels (int posDbTag, const Communicator &)
 Receive labels through the communicator argument.
 
int sendData (Communicator &)
 Send members through the communicator argument.
 
int recvData (const Communicator &)
 Receives members through the communicator argument.
 
- Protected Member Functions inherited from XC::ContinuaReprComponent
int sendData (Communicator &)
 Send members through the communicator argument.
 
int recvData (const Communicator &)
 Receives members through the communicator argument.
 
- Protected Member Functions inherited from XC::DomainComponent
 DomainComponent (int tag, int classTag)
 Constructor. More...
 
int sendData (Communicator &)
 Send object members through the communicator argument.
 
int recvData (const Communicator &)
 Receive object members through the communicator argument.
 
- Protected Member Functions inherited from XC::TaggedObject
void setTag (int newTag)
 Set tag. More...
 
- Protected Member Functions inherited from CommandEntity
template<class T >
void string_to (T &, const std::string &) const
 

Protected Attributes

Vector load
 vector for applied nodal loads.
 
RayleighDampingFactors rayFactors
 Rayleigh damping factors.
 
Matrix Kc
 pointer to hold last committed matrix if needed for rayleigh damping
 
- Protected Attributes inherited from XC::MeshComponent
int index
 Index for VTK arrays.
 
LabelContainer labels
 Label container.
 

Friends

class EntMdlr
 
class Preprocessor
 

Additional Inherited Members

- Static Protected Member Functions inherited from CommandEntity
static CommandEntityentcmd_cast (boost::any &data)
 
- Static Protected Attributes inherited from EntityWithOwner
static int verbosity = 1
 Object that owns THIS ONE. More...
 

Detailed Description

Base class for the finite elements.

The element class provides the interface that all element writers must provide when introducing new element classes.

Member Typedef Documentation

◆ NodesEdge

typedef std::vector<const Node *> XC::Element::NodesEdge

Nodes on an element edge.

Constructor & Destructor Documentation

◆ Element()

Element::Element ( int  tag,
int  cTag 
)

Constructor that takes the element's unique tag and the number of external nodes for the element.

Parameters
tagelement identifier.
cTagelement class identifier.

Member Function Documentation

◆ commitState()

int Element::commitState ( void  )
virtual

Commit the current element state.

The element is to commit its current state. To return 0 if successful, a negative number if not.

Reimplemented in XC::TwentyNodeBrick, XC::ASDShellQ4, XC::Subdomain, XC::ZeroLengthContact3D, XC::EightNodeBrick, XC::ZeroLength, XC::ZeroLengthContact2D, XC::UpdatedLagrangianBeam2D, XC::Joint2D, XC::BeamColumnJoint3d, XC::BeamContact2D, XC::fElement, XC::ShellNLDKGQ, XC::ZeroLengthSection, XC::BeamColumnJoint2d, XC::BeamWithHinges2d, XC::BeamWithHinges3d, XC::Shell4NBase, XC::FlatSliderSimple2d, XC::Truss, XC::TwentySevenNodeBrick, XC::NLBeamColumn2d, XC::ElasticTimoshenkoBeam3d, XC::ElasticTimoshenkoBeam2d, XC::DispBeamColumn2dBase, XC::DispBeamColumn3d, XC::ElasticBeam2d, XC::ForceBeamColumn3d, XC::ElasticBeam3d, XC::beam2d02, XC::ForceBeamColumn2d, XC::TotalLagrangianFD8NodeBrick, XC::NLBeamColumn3d, XC::CorotTruss, XC::TrussSection, XC::Spring, XC::FlatSliderSimple3d, XC::ProtoBeam2d, XC::CorotTrussSection, XC::NewElement, XC::ProtoBeam3d, XC::SingleFPSimple2d, XC::InelasticYS2DGNL, XC::SingleFPSimple3d, XC::BeamColumnWithSectionFD, XC::SurfaceLoadBase< NNODES >, XC::SurfaceLoadBase< QSL_NUM_NODE >, XC::SurfaceLoadBase< SL_NUM_NODE >, XC::Inelastic2DYS02, XC::ElemWithMaterial< NNODOS, PhysProp >, XC::ElemWithMaterial< 8, NDMaterialPhysicalProperties >, XC::ElemWithMaterial< NNODES, SolidMech2D >, XC::ElemWithMaterial< 4, BeamColumnJointPhysicalProperties >, XC::ElemWithMaterial< 20, NDMaterialPhysicalProperties >, XC::ElemWithMaterial< NNODES, PhysProp >, XC::ElemWithMaterial< NNODES, NDMaterialPhysicalProperties >, XC::ElemWithMaterial< 7, Joint3DPhysicalProperties >, XC::ElemWithMaterial< NNODES, SectionFDPhysicalProperties >, XC::ElemWithMaterial< BC2D_NUM_NODE, Contact2D >, XC::ElemWithMaterial< 9, SolidMech2D >, XC::ElemWithMaterial< 5, Joint2DPhysicalProperties >, XC::ElemWithMaterial< 9, NDMaterialPhysicalProperties >, and XC::Inelastic2DYS03.

◆ createInertiaLoad()

void Element::createInertiaLoad ( const Vector )
virtual

Creates the inertia load that corresponds to the acceleration argument.

Reimplemented in XC::FourNodeQuad, XC::Shell4NBase, XC::ProtoBeam2d, XC::ProtoBeam3d, and XC::ProtoTruss.

◆ dumpTributaries()

void Element::dumpTributaries ( const std::vector< double > &  t) const

Adds to the tributary magnitude of each node the vector being passed as parameter.

◆ find()

int Element::find ( const Node nPtr) const

Returns the index of the node whose pointer is being passed as parameter.

◆ get_material_ptr()

const XC::Material * Element::get_material_ptr ( const std::string &  matName) const
protected

Return a pointer to the material that corresponds to the name.

Parameters
matNamename of the material.

◆ getBaseVector()

XC::Vector Element::getBaseVector ( size_t  i,
bool  initialGeometry = true 
) const
virtual

Returns a base vector in the direction of the local i-th axis from the i-th row of the matrix returned by getLocalAxes.

Parameters
iindex of the base vector.
initialGeometryif true use initial geometry (instead of the deformed one).

◆ getBaseVector3d()

Vector3d Element::getBaseVector3d ( size_t  i,
bool  initialGeometry = true 
) const
virtual

Returns a base vector in the direction of the local i-th axis from the i-th row of the matrix returned by getLocalAxes.

◆ getCooSys()

Rect3d3dCooSys Element::getCooSys ( bool  initialGeometry) const
virtual

Returns the element coordinate system from the matrix returned by getLocalAxes.

Reimplemented in XC::Element0D.

◆ getDamp()

const XC::Matrix & Element::getDamp ( void  ) const
virtual

Returns the damping matrix.

To return the damping matrix. The element is to compute its damping matrix based on the original location of the nodes and the current trial response quantities at the nodes.

\[ //! C_e= {\frac{\partial R_i}{\partial \dot U} \vert}_{U_{trial}} //! \]

Reimplemented in XC::ZeroLengthContact3D, XC::ZeroLength, XC::TwentyEightNodeBrickUP, XC::ZeroLengthContact2D, XC::BeamColumnJoint3d, XC::Joint2D, XC::BeamColumnJoint2d, XC::TwentyNodeBrick_u_p_U, XC::fElement, XC::Joint3D, XC::Twenty_Node_Brick, XC::Truss, XC::NineFourNodeQuadUP, XC::EightNodeBrick_u_p_U, XC::BrickUP, XC::Spring, and XC::FourNodeQuadUP.

◆ getDist() [1/2]

double Element::getDist ( const Pos2d p,
bool  initialGeometry = true 
) const
virtual

◆ getDist() [2/2]

double Element::getDist ( const Pos3d p,
bool  initialGeometry = true 
) const
virtual

◆ getDist2() [1/2]

double Element::getDist2 ( const Pos2d p,
bool  initialGeometry = true 
) const
virtual

◆ getDist2() [2/2]

double Element::getDist2 ( const Pos3d p,
bool  initialGeometry = true 
) const
virtual

◆ getEdgeNodes() [1/2]

int Element::getEdgeNodes ( const Node ,
const Node  
) const
virtual

◆ getEdgeNodes() [2/2]

int Element::getEdgeNodes ( const int &  iN1,
const int &  iN2 
) const

Returns the edge of the element that ends in the nodes with the tags being passed as parameters.

◆ getEdgesNode()

XC::ID Element::getEdgesNode ( const Node ) const
virtual

Returns the edges of the element that ends in the node being passed as parameter.

◆ getEdgesNodeByTag()

XC::ID Element::getEdgesNodeByTag ( const int &  iN) const

Returns the edges of the element that have an en in the node with the tag being passed as parameter.

◆ getEdgesNodes()

std::set< int > Element::getEdgesNodes ( const NodePtrSet &  nodes) const

Returns the element edges that have both ends in the node set being passed as parameter.

◆ getEquivalentStaticLoad()

XC::Vector Element::getEquivalentStaticLoad ( int  mode,
const double &  accel_mode 
) const

Returns the equivalent static load for the mode being passed as parameter and the acceleration that corresponding that mode.

◆ getEquivalentStaticNodalLoads()

XC::Matrix Element::getEquivalentStaticNodalLoads ( int  mode,
const double &  accel_mode 
) const

Returns the equivalent static load on each node for the mode being passed as parameter and the corresponding acceleration to the mode.

◆ getIdxNodes()

std::vector< int > Element::getIdxNodes ( void  ) const

Return the indexes of the nodes (used when creating VTK meshes).

◆ getIVector3d()

Vector3d Element::getIVector3d ( bool  initialGeometry = true) const
virtual

Returns a vector in the direction of the local x axis from the first row of the matrix returned by getLocalAxes.

◆ getJVector3d()

Vector3d Element::getJVector3d ( bool  initialGeometry = true) const
virtual

Returns a vector in the direction of the local y axis from the second row of the matrix returned by getLocalAxes.

◆ getKVector3d()

Vector3d Element::getKVector3d ( bool  initialGeometry = true) const
virtual

Returns a vector in the direction of the local z axis from the third row of the matrix returned by getLocalAxes.

◆ getLocalIndexNodesEdge()

XC::ID Element::getLocalIndexNodesEdge ( const size_t &  i) const
virtual

◆ getMass()

const XC::Matrix & Element::getMass ( void  ) const
virtual

◆ getNodeMatrixComponents()

XC::Matrix Element::getNodeMatrixComponents ( const Node ptrNod,
const Matrix m 
) const

Returns the components of the matrix relative to the node.

Parameters
ptrNodpointer to the node.
mmatrix to extract the components from.

◆ getNodePattern()

BoolArray3d Element::getNodePattern ( void  ) const
virtual

◆ getNodeResistingComponents()

const XC::Vector & Element::getNodeResistingComponents ( const size_t &  iNod,
const Vector rf 
) const

Returns the generalized force of the element over the iNod-th node.

◆ getNodeResistingForce() [1/2]

const XC::Vector & Element::getNodeResistingForce ( const size_t &  iNod) const

Returns the generalized force of the element over the iNod-th node.

◆ getNodeResistingForce() [2/2]

const XC::Vector & Element::getNodeResistingForce ( const Node ptrNod) const

Returns the generalized force (including inertia forces) of the element over the node identified by the argument.

◆ getNodeResistingForceIncInertia() [1/2]

const XC::Vector & Element::getNodeResistingForceIncInertia ( const size_t &  iNod) const

Returns the generalized force (including inertia forces) of the element over the node identified by the argument.

◆ getNodeResistingForceIncInertia() [2/2]

const XC::Vector & Element::getNodeResistingForceIncInertia ( const Node ptrNod) const

Returns the generalized force (including inertia forces) of the element over the node identified by the argument.

◆ getNumDOF()

virtual int XC::Element::getNumDOF ( void  ) const
pure virtual

◆ getNumEdges()

int Element::getNumEdges ( void  ) const
virtual

Returns number of edges (it must be overloaded for elements that have nodes inside edges.

◆ getPosNode()

Pos3d Element::getPosNode ( const size_t &  i,
bool  initialGeometry = true 
) const

Returns the position of the i-th node.

Parameters
iindex of the node in the element.
initialGeometryif true initial position of the node is returned.

◆ getProjection() [1/2]

Pos2d Element::getProjection ( const Pos2d p,
bool  initialGeometry = true 
) const
virtual

◆ getProjection() [2/2]

Pos3d Element::getProjection ( const Pos3d p,
bool  initialGeometry = true 
) const
virtual

◆ getResistingForce()

virtual const Vector& XC::Element::getResistingForce ( void  ) const
pure virtual

Returns the resisting force vector for the element.

This is equal to the applied load due to element loads minus the loads at the nodes due to internal stresses in the element due to the current trial displacement, i.e.

\[ R_e= P_{e} - {R_e}(U_{trial}) \]

Implemented in XC::TwentyNodeBrick, XC::ShadowSubdomain, XC::ASDShellQ4, XC::Subdomain, XC::EightNodeBrick, XC::ZeroLengthContact3D, XC::ZeroLength, XC::TwentyEightNodeBrickUP, XC::BeamColumnJoint3d, XC::UpdatedLagrangianBeam2D, XC::Joint2D, XC::ZeroLengthContact2D, XC::BeamColumnJoint2d, XC::TwentyNodeBrick_u_p_U, XC::fElement, XC::Joint3D, XC::BeamContact2D, XC::Twenty_Node_Brick, XC::ZeroLengthSection, XC::EnhancedQuad, XC::Truss, XC::NineFourNodeQuadUP, XC::BeamWithHinges2d, XC::BeamWithHinges3d, XC::Brick, XC::Shell4NBase, XC::TwentySevenNodeBrick, XC::NineNodeMixedQuad, XC::FlatSliderSimple2d, XC::ElasticTimoshenkoBeam3d, XC::EightNodeBrick_u_p_U, XC::ElasticTimoshenkoBeam2d, XC::BrickUP, XC::Tri31, XC::FourNodeQuad, XC::CorotTruss, XC::TotalLagrangianFD20NodeBrick, XC::DispBeamColumn3d, XC::ElasticBeam2d, XC::BbarBrick, XC::TrussSection, XC::ConstantPressureVolumeQuad, XC::TotalLagrangianFD8NodeBrick, XC::Spring, XC::FourNodeQuadUP, XC::ElasticBeam3d, XC::beam2d02, XC::BrickSurfaceLoad, XC::CorotTrussSection, XC::FlatSliderSimple3d, XC::ShellMITC9, XC::beam2d04, XC::NewElement, XC::beam2d03, XC::NLForceBeamColumn3dBase, XC::SingleFPSimple2d, XC::NLForceBeamColumn2dBase, XC::SingleFPSimple3d, XC::DispBeamColumn2d, XC::QuadSurfaceLoad, XC::InelasticYS2DGNL, and XC::beam3dBase.

◆ getResistingForceIncInertia()

const XC::Vector & Element::getResistingForceIncInertia ( void  ) const
virtual

Returns the resisting force vector including inertia forces.

Returns the action of the element over its attached nodes.

Returns the resisting force vector for the element with inertia forces included. This is equal to the applied load due to element loads (loads set using addLoad(), minus the loads at the nodes due to internal stresses in the element due to the current trial response quantities, i.e.

\[ R_e = P_e - I_e (\ddot U_{trial}) - R_e(\dot U_{trial}, U_{trial}) \]

Computes damping matrix.

Reimplemented in XC::TwentyNodeBrick, XC::ASDShellQ4, XC::Subdomain, XC::EightNodeBrick, XC::ZeroLengthContact3D, XC::ZeroLength, XC::TwentyEightNodeBrickUP, XC::BeamColumnJoint3d, XC::UpdatedLagrangianBeam2D, XC::Joint2D, XC::ZeroLengthContact2D, XC::BeamColumnJoint2d, XC::TwentyNodeBrick_u_p_U, XC::fElement, XC::Joint3D, XC::BeamContact2D, XC::Twenty_Node_Brick, XC::ZeroLengthSection, XC::EnhancedQuad, XC::Truss, XC::NineFourNodeQuadUP, XC::BeamWithHinges2d, XC::BeamWithHinges3d, XC::Brick, XC::Shell4NBase, XC::TwentySevenNodeBrick, XC::NineNodeMixedQuad, XC::FlatSliderSimple2d, XC::ElasticTimoshenkoBeam3d, XC::EightNodeBrick_u_p_U, XC::ElasticTimoshenkoBeam2d, XC::BrickUP, XC::Tri31, XC::NLBeamColumn2d, XC::FourNodeQuad, XC::CorotTruss, XC::TotalLagrangianFD20NodeBrick, XC::DispBeamColumn3d, XC::ElasticBeam2d, XC::BbarBrick, XC::DispBeamColumn2dBase, XC::TrussSection, XC::ConstantPressureVolumeQuad, XC::ForceBeamColumn3d, XC::TotalLagrangianFD8NodeBrick, XC::Spring, XC::ForceBeamColumn2d, XC::FourNodeQuadUP, XC::ElasticBeam3d, XC::beam2d02, XC::NLBeamColumn3d, XC::BrickSurfaceLoad, XC::CorotTrussSection, XC::FlatSliderSimple3d, XC::ShellMITC9, XC::beam2d04, XC::NewElement, XC::beam2d03, XC::SingleFPSimple2d, XC::SingleFPSimple3d, XC::QuadSurfaceLoad, and XC::beam3dBase.

◆ getResponse()

int Element::getResponse ( int  responseID,
Information eleInfo 
)
virtual

Obtain information from an analysis.

getResponse is a method invoked to obtain information from an analysis. The method is invoked with the integer argument returned and the Information object that was prepared in a successful {setResponse()} method invocation. To return \(0\) if successful, a negative number if not. The base class implementation will always return \(-1\).

Reimplemented in XC::ElasticBeam3d, XC::TwentyNodeBrick, XC::ASDShellQ4, XC::EightNodeBrick, XC::ElasticTimoshenkoBeam3d, XC::ZeroLengthContact3D, XC::ZeroLength, XC::TwentyEightNodeBrickUP, XC::BeamColumnJoint3d, XC::ZeroLengthContact2D, XC::BeamColumnJoint2d, XC::UpdatedLagrangianBeam2D, XC::Joint2D, XC::ZeroLengthSection, XC::TwentyNodeBrick_u_p_U, XC::ElasticTimoshenkoBeam2d, XC::BeamContact2D, XC::Twenty_Node_Brick, XC::ElasticBeam2d, XC::Joint3D, XC::Truss, XC::Brick, XC::NineFourNodeQuadUP, XC::TwentySevenNodeBrick, XC::BeamWithHinges2d, XC::BeamWithHinges3d, XC::FlatSliderSimple2d, XC::EightNodeBrick_u_p_U, XC::NLBeamColumn2d, XC::Shell4NBase, XC::Tri31, XC::BrickUP, XC::CorotTruss, XC::TotalLagrangianFD20NodeBrick, XC::DispBeamColumn3d, XC::TotalLagrangianFD8NodeBrick, XC::TrussSection, XC::BbarBrick, XC::ForceBeamColumn3d, XC::Spring, XC::ForceBeamColumn2d, XC::FourNodeQuadUP, XC::NLBeamColumn3d, XC::CorotTrussSection, XC::FlatSliderSimple3d, XC::NewElement, XC::SingleFPSimple2d, XC::SingleFPSimple3d, XC::DispBeamColumnNL2d, XC::DispBeamColumn2d, XC::InelasticYS2DGNL, XC::ElemWithMaterial< NNODOS, PhysProp >, XC::ElemWithMaterial< 8, NDMaterialPhysicalProperties >, XC::ElemWithMaterial< NNODES, SolidMech2D >, XC::ElemWithMaterial< 4, BeamColumnJointPhysicalProperties >, XC::ElemWithMaterial< 20, NDMaterialPhysicalProperties >, XC::ElemWithMaterial< NNODES, PhysProp >, XC::ElemWithMaterial< NNODES, NDMaterialPhysicalProperties >, XC::ElemWithMaterial< 7, Joint3DPhysicalProperties >, XC::ElemWithMaterial< NNODES, SectionFDPhysicalProperties >, XC::ElemWithMaterial< BC2D_NUM_NODE, Contact2D >, XC::ElemWithMaterial< 9, SolidMech2D >, XC::ElemWithMaterial< 5, Joint2DPhysicalProperties >, and XC::ElemWithMaterial< 9, NDMaterialPhysicalProperties >.

◆ getTangentStiff()

virtual const Matrix& XC::Element::getTangentStiff ( void  ) const
pure virtual

Return the tangent stiffness matrix.

To return the tangent stiffness matrix. The element is to compute its stiffness matrix based on the original location of the nodes and the current trial displacement at the nodes.

\[ K_e = {\frac{\partial f_{R_i}}{\partial U} \vert}_{U_{trial}} \]

Implemented in XC::TwentyNodeBrick, XC::ASDShellQ4, XC::EightNodeBrick, XC::ZeroLengthContact3D, XC::ZeroLength, XC::TwentyEightNodeBrickUP, XC::ZeroLengthContact2D, XC::BeamColumnJoint3d, XC::Joint2D, XC::UpdatedLagrangianBeam2D, XC::BeamColumnJoint2d, XC::BeamContact2D, XC::TwentyNodeBrick_u_p_U, XC::fElement, XC::ShellNLDKGQ, XC::Joint3D, XC::ZeroLengthSection, XC::Twenty_Node_Brick, XC::EnhancedQuad, XC::BeamWithHinges2d, XC::BeamWithHinges3d, XC::Truss, XC::NineFourNodeQuadUP, XC::TwentySevenNodeBrick, XC::FlatSliderSimple2d, XC::Brick, XC::NineNodeMixedQuad, XC::ElasticTimoshenkoBeam3d, XC::ElasticTimoshenkoBeam2d, XC::EightNodeBrick_u_p_U, XC::BrickUP, XC::TotalLagrangianFD20NodeBrick, XC::DispBeamColumn3d, XC::ElasticBeam2d, XC::CorotTruss, XC::FourNodeQuad, XC::BbarBrick, XC::ConstantPressureVolumeQuad, XC::Tri31, XC::TrussSection, XC::Spring, XC::FourNodeQuadUP, XC::ElasticBeam3d, XC::TotalLagrangianFD8NodeBrick, XC::BrickSurfaceLoad, XC::beam2d02, XC::Shell4NBase, XC::CorotTrussSection, XC::FlatSliderSimple3d, XC::beam2d04, XC::NewElement, XC::NLForceBeamColumn3dBase, XC::ShellMITC9, XC::beam2d03, XC::NLForceBeamColumn2dBase, XC::SingleFPSimple3d, XC::DispBeamColumn2d, XC::InelasticYS2DGNL, XC::QuadSurfaceLoad, and XC::beam3dBase.

◆ getTributaryLength()

double Element::getTributaryLength ( const Node ) const
virtual

Returns the tributary length corresponding to the node being passed as parameter.

Reimplemented in XC::Element1D.

◆ getTributaryLengthByTag()

double Element::getTributaryLengthByTag ( const int &  tag) const
virtual

Returns the tributary length corresponding to the node which tag se pasa as parameter.

◆ getTributaryVolume()

double Element::getTributaryVolume ( const Node ) const
virtual

Returns the tributary volume corresponding to the node being passed as parameter.

◆ getTributaryVolumeByTag()

double Element::getTributaryVolumeByTag ( const int &  tag) const
virtual

Returns the tributary volume corresponding to the node which tag se pasa as parameter.

◆ getValuesAtNodes()

boost::python::list Element::getValuesAtNodes ( const std::string &  code,
bool  silent = false 
) const
virtual

◆ replaceNode()

void Element::replaceNode ( Node oldNode,
Node newNode 
)

Replace the old node by the new one.

Parameters
oldNodepointer to the node to be replaced.
newNodenode to place in-lieu of the previous one.

◆ revertToLastCommit()

virtual int XC::Element::revertToLastCommit ( void  )
pure virtual

Revert to the last committed state.

The element is to set it's current state to the last committed state. To return 0 if successful, a negative number if not.

Implemented in XC::TwentyNodeBrick, XC::ASDShellQ4, XC::ShadowSubdomain, XC::ZeroLengthContact3D, XC::EightNodeBrick, XC::ZeroLength, XC::ZeroLengthContact2D, XC::UpdatedLagrangianBeam2D, XC::Joint2D, XC::Subdomain, XC::BeamColumnJoint3d, XC::BeamContact2D, XC::fElement, XC::ShellNLDKGQ, XC::BeamColumnJoint2d, XC::ZeroLengthSection, XC::BeamWithHinges2d, XC::BeamWithHinges3d, XC::Shell4NBase, XC::FlatSliderSimple2d, XC::Truss, XC::TwentySevenNodeBrick, XC::NLBeamColumn2d, XC::DispBeamColumn2dBase, XC::DispBeamColumn3d, XC::ElasticBeam2d, XC::ForceBeamColumn3d, XC::ElasticBeam3d, XC::beam2d02, XC::ForceBeamColumn2d, XC::TotalLagrangianFD8NodeBrick, XC::NLBeamColumn3d, XC::CorotTruss, XC::TrussSection, XC::Spring, XC::beam2d04, XC::FlatSliderSimple3d, XC::ProtoBeam2d, XC::CorotTrussSection, XC::NewElement, XC::beam2d03, XC::ProtoBeam3d, XC::SingleFPSimple2d, XC::SingleFPSimple3d, XC::BeamColumnWithSectionFD, XC::SurfaceLoadBase< NNODES >, XC::SurfaceLoadBase< QSL_NUM_NODE >, XC::SurfaceLoadBase< SL_NUM_NODE >, XC::ElemWithMaterial< NNODOS, PhysProp >, XC::beam3dBase, XC::ElemWithMaterial< 8, NDMaterialPhysicalProperties >, XC::ElemWithMaterial< NNODES, SolidMech2D >, XC::ElemWithMaterial< 4, BeamColumnJointPhysicalProperties >, XC::ElemWithMaterial< 20, NDMaterialPhysicalProperties >, XC::ElemWithMaterial< NNODES, PhysProp >, XC::ElemWithMaterial< NNODES, NDMaterialPhysicalProperties >, XC::ElemWithMaterial< 7, Joint3DPhysicalProperties >, XC::ElemWithMaterial< NNODES, SectionFDPhysicalProperties >, XC::ElemWithMaterial< BC2D_NUM_NODE, Contact2D >, XC::ElemWithMaterial< 9, SolidMech2D >, XC::ElemWithMaterial< 5, Joint2DPhysicalProperties >, and XC::ElemWithMaterial< 9, NDMaterialPhysicalProperties >.

◆ revertToStart()

int Element::revertToStart ( void  )
virtual

Reverts the element to its initial state.

The element is to set it's current state to the state it was at before the analysis started. To return 0 if successful, a negative number if not.

Reimplemented in XC::TwentyNodeBrick, XC::ASDShellQ4, XC::ShadowSubdomain, XC::ZeroLengthContact3D, XC::EightNodeBrick, XC::ZeroLength, XC::ZeroLengthContact2D, XC::Joint2D, XC::Subdomain, XC::BeamColumnJoint3d, XC::BeamContact2D, XC::fElement, XC::BeamColumnJoint2d, XC::ShellNLDKGQ, XC::ZeroLengthSection, XC::BeamWithHinges2d, XC::BeamWithHinges3d, XC::Shell4NBase, XC::FlatSliderSimple2d, XC::Truss, XC::TwentySevenNodeBrick, XC::NLBeamColumn2d, XC::DispBeamColumn2dBase, XC::DispBeamColumn3d, XC::ElasticBeam2d, XC::ForceBeamColumn3d, XC::ElasticBeam3d, XC::beam2d02, XC::ForceBeamColumn2d, XC::TotalLagrangianFD8NodeBrick, XC::NLBeamColumn3d, XC::CorotTruss, XC::TrussSection, XC::Spring, XC::FlatSliderSimple3d, XC::ProtoBeam2d, XC::CorotTrussSection, XC::NewElement, XC::ProtoBeam3d, XC::SingleFPSimple2d, XC::SingleFPSimple3d, XC::BeamColumnWithSectionFD, XC::SurfaceLoadBase< NNODES >, XC::SurfaceLoadBase< QSL_NUM_NODE >, XC::SurfaceLoadBase< SL_NUM_NODE >, XC::ElemWithMaterial< NNODOS, PhysProp >, XC::ElemWithMaterial< 8, NDMaterialPhysicalProperties >, XC::ElemWithMaterial< NNODES, SolidMech2D >, XC::ElemWithMaterial< 4, BeamColumnJointPhysicalProperties >, XC::ElemWithMaterial< 20, NDMaterialPhysicalProperties >, XC::ElemWithMaterial< NNODES, PhysProp >, XC::ElemWithMaterial< NNODES, NDMaterialPhysicalProperties >, XC::ElemWithMaterial< 7, Joint3DPhysicalProperties >, XC::ElemWithMaterial< NNODES, SectionFDPhysicalProperties >, XC::ElemWithMaterial< BC2D_NUM_NODE, Contact2D >, XC::ElemWithMaterial< 9, SolidMech2D >, XC::ElemWithMaterial< 5, Joint2DPhysicalProperties >, and XC::ElemWithMaterial< 9, NDMaterialPhysicalProperties >.

◆ setMaterialParameter()

int Element::setMaterialParameter ( Material theMaterial,
const std::vector< std::string > &  argv,
const size_t &  offset,
Parameter param 
)

Set the value of a parameter of the material.

Parameters
theMaterialmaterial to modify.
argvargument values.
offsetargument to discard for the material parameters.

◆ setResponse()

XC::Response * Element::setResponse ( const std::vector< std::string > &  argv,
Information eleInfo 
)
virtual

setResponse() is a method invoked to determine if the element will respond to a request for a certain of information.

The information requested of the element is passed in the array of char pointers argv of length {em argc}. If the element does not respond to the request a \(-1\) is returned. If it does respond, an integer value greater than or equal to \(0\) is returned. This is the responseID passed in the getResponse() method. In addition the Element object is responsible for setting the Information object eleInformation with the type of the return, i.e. {IntType, DoubleType, MatrixType, VectorType, IDType}, and for creating a Matrix, Vector or ID object for the Information object, if the information to be returned is of any of these types. The information object is responsible for invoking the destructor on these objects. The base class responds to no requests and will always return \(-1\).

Reimplemented in XC::ElasticBeam3d, XC::TwentyNodeBrick, XC::ASDShellQ4, XC::EightNodeBrick, XC::ZeroLengthContact3D, XC::ZeroLength, XC::TwentyEightNodeBrickUP, XC::BeamColumnJoint3d, XC::ZeroLengthContact2D, XC::BeamColumnJoint2d, XC::UpdatedLagrangianBeam2D, XC::Joint2D, XC::ZeroLengthSection, XC::TwentyNodeBrick_u_p_U, XC::Twenty_Node_Brick, XC::Joint3D, XC::Truss, XC::Brick, XC::NineFourNodeQuadUP, XC::TwentySevenNodeBrick, XC::BeamWithHinges2d, XC::BeamWithHinges3d, XC::FlatSliderSimple2d, XC::EightNodeBrick_u_p_U, XC::NLBeamColumn2d, XC::Shell4NBase, XC::Tri31, XC::BrickUP, XC::CorotTruss, XC::TotalLagrangianFD20NodeBrick, XC::DispBeamColumn3d, XC::TotalLagrangianFD8NodeBrick, XC::TrussSection, XC::BbarBrick, XC::ForceBeamColumn3d, XC::Spring, XC::ForceBeamColumn2d, XC::FourNodeQuadUP, XC::NLBeamColumn3d, XC::CorotTrussSection, XC::FlatSliderSimple3d, XC::NewElement, XC::SingleFPSimple2d, XC::SingleFPSimple3d, XC::DispBeamColumnNL2d, XC::DispBeamColumn2d, XC::InelasticYS2DGNL, XC::ElemWithMaterial< NNODOS, PhysProp >, XC::ElemWithMaterial< 8, NDMaterialPhysicalProperties >, XC::ElemWithMaterial< NNODES, SolidMech2D >, XC::ElemWithMaterial< 4, BeamColumnJointPhysicalProperties >, XC::ElemWithMaterial< 20, NDMaterialPhysicalProperties >, XC::ElemWithMaterial< NNODES, PhysProp >, XC::ElemWithMaterial< NNODES, NDMaterialPhysicalProperties >, XC::ElemWithMaterial< 7, Joint3DPhysicalProperties >, XC::ElemWithMaterial< NNODES, SectionFDPhysicalProperties >, XC::ElemWithMaterial< BC2D_NUM_NODE, Contact2D >, XC::ElemWithMaterial< 9, SolidMech2D >, XC::ElemWithMaterial< 5, Joint2DPhysicalProperties >, and XC::ElemWithMaterial< 9, NDMaterialPhysicalProperties >.

◆ update()

int Element::update ( void  )
virtual

Updates the element state.

This method is invoked after the response quantities have been updated in the Domain, but not necessarily committed, e.g. during a non-linear Newton-Raphson solution algorithm. To return \(0\) if successful, a negative number if not. This base class implementation returns 0.

Reimplemented in XC::TwentyNodeBrick, XC::ASDShellQ4, XC::ShadowSubdomain, XC::EightNodeBrick, XC::TwentyEightNodeBrickUP, XC::ZeroLength, XC::ZeroLengthContact2D, XC::Subdomain, XC::BeamColumnJoint3d, XC::Joint2D, XC::UpdatedLagrangianBeam2D, XC::BeamContact2D, XC::fElement, XC::TwentyNodeBrick_u_p_U, XC::BeamColumnJoint2d, XC::Joint3D, XC::Twenty_Node_Brick, XC::BeamWithHinges2d, XC::BeamWithHinges3d, XC::EnhancedQuad, XC::ZeroLengthSection, XC::NineFourNodeQuadUP, XC::FlatSliderSimple2d, XC::TwentySevenNodeBrick, XC::Brick, XC::Truss, XC::EightNodeBrick_u_p_U, XC::NLBeamColumn2d, XC::DispBeamColumn3d, XC::TotalLagrangianFD20NodeBrick, XC::FourNodeQuad, XC::ForceBeamColumn3d, XC::ConstantPressureVolumeQuad, XC::Tri31, XC::ElasticBeam2d, XC::ForceBeamColumn2d, XC::TotalLagrangianFD8NodeBrick, XC::FourNodeQuadUP, XC::NLBeamColumn3d, XC::CorotTruss, XC::TrussSection, XC::ElasticBeam3d, XC::Spring, XC::Shell4NBase, XC::FlatSliderSimple3d, XC::CorotTrussSection, XC::NewElement, XC::ProtoBeam2d, XC::ProtoBeam3d, XC::SingleFPSimple2d, XC::DispBeamColumnNL2d, XC::ActorSubdomain, XC::DispBeamColumn2d, XC::SingleFPSimple3d, XC::SurfaceLoadBase< NNODES >, XC::SurfaceLoadBase< QSL_NUM_NODE >, XC::SurfaceLoadBase< SL_NUM_NODE >, and XC::Inelastic2DYS02.

◆ zeroLoad()

void Element::zeroLoad ( void  )
virtual

The documentation for this class was generated from the following files: