xc
|
3D beam element with PrismaticBarCrossSection type material. More...
#include <DispBeamColumn3d.h>
Public Member Functions | |
DispBeamColumn3d (int tag=0) | |
DispBeamColumn3d (int tag, int numSec, const Material *theSection, const CrdTransf *trf) | |
DispBeamColumn3d (int tag, int nd1, int nd2, int numSections, const std::vector< PrismaticBarCrossSection *> &s, CrdTransf3d &coordTransf, double rho=0.0) | |
Element * | getCopy (void) const |
Virtual constructor. | |
int | getNumDOF (void) const |
return the number of DOF associated with the element. More... | |
void | setDomain (Domain *theDomain) |
Sets the domain for the element. | |
int | commitState (void) |
Commit the current element state. More... | |
int | revertToLastCommit (void) |
Revert to the last commited state. More... | |
int | revertToStart (void) |
Reverts the element to its initial state. More... | |
int | update (void) |
Updates the element state. More... | |
const Matrix & | getTangentStiff (void) const |
Return the tangent stiffness matrix. More... | |
const Matrix & | getInitialStiff (void) const |
const Matrix & | getMass (void) const |
Returns the mass matrix. More... | |
void | zeroLoad (void) |
Zeroes loads on element. | |
int | addLoad (ElementalLoad *theLoad, double loadFactor) |
int | addInertiaLoadToUnbalance (const Vector &accel) |
const Vector & | getResistingForce (void) const |
Returns the resisting force vector for the element. More... | |
const Vector & | getResistingForceIncInertia (void) const |
Returns the resisting force vector including inertia forces. More... | |
int | sendSelf (CommParameters &) |
Send the object. More... | |
int | recvSelf (const CommParameters &) |
Receive the object. More... | |
void | Print (std::ostream &s, int flag=0) |
Print stuff. | |
Response * | setResponse (const std::vector< std::string > &argv, Information &eleInfo) |
setResponse() is a method invoked to determine if the element will respond to a request for a certain of information. More... | |
int | getResponse (int responseID, Information &eleInfo) |
Obtain information from an analysis. More... | |
![]() | |
BeamColumnWithSectionFDTrf3d (int tag, int classTag, int numSec) | |
BeamColumnWithSectionFDTrf3d (int tag, int classTag, int numSec, const Material *mat, const CrdTransf *trf) | |
BeamColumnWithSectionFDTrf3d (int tag, int classTag, int numSec, int nodeI, int nodeJ, CrdTransf3d &coordTransf) | |
BeamColumnWithSectionFDTrf3d (const BeamColumnWithSectionFDTrf3d &) | |
Copy constructor. | |
~BeamColumnWithSectionFDTrf3d (void) | |
Destructor. | |
void | initialize_trf (void) |
virtual CrdTransf * | getCoordTransf (void) |
Returns (if possible) a pointer to the coordinate transformation. | |
virtual const CrdTransf * | getCoordTransf (void) const |
Returns (if possible) a pointer to the coordinate transformation. | |
Vector | getVDirStrongAxisLocalCoord (const size_t &i) const |
Returns i-th cross section strong axis direction vector expressed in local coordinates. | |
Vector | getVDirWeakAxisLocalCoord (const size_t &i) const |
Returns i-th cross section weak axis direction vector expressed in local coordinates. | |
double | getStrongAxisAngle (const size_t &i) const |
Returns the angle between i-th cross section strong axis and the local XZ plane. More... | |
double | getWeakAxisAngle (const size_t &i) const |
Returns the angle between i-th cross section weak axis and the local XZ plane. More... | |
const Vector & | getVDirStrongAxisGlobalCoord (const size_t &i, bool initialGeometry) const |
Returns i-th cross section strong axis direction vector expressed in global coordinates. | |
const Vector & | getVDirWeakAxisGlobalCoord (const size_t &i, bool initialGeometry) const |
Returns i-th cross section weak axis direction vector expressed in global coordinates. | |
![]() | |
BeamColumnWithSectionFD (int tag, int classTag, const size_t &numSecc=1) | |
BeamColumnWithSectionFD (int tag, int classTag, const size_t &numSecc, const Material *m) | |
BeamColumnWithSectionFD (int tag, int classTag, const size_t &numSecc, const PrismaticBarCrossSection *sccModel) | |
BeamColumnWithSectionFD (int tag, int classTag, const size_t &numSecc, const PrismaticBarCrossSection *sccModel, int Nd1, int Nd2) | |
const PrismaticBarCrossSection * | getSectionPtr (const size_t &i) const |
Returns a pointer to the i-th section of the element. | |
void | setTrialSectionDeformations (const std::vector< Vector > &vs) |
virtual void | setSection (const PrismaticBarCrossSection *sccModel) |
bool | setSections (const std::vector< PrismaticBarCrossSection *> §ionPtrs) |
size_t | getNumSections (void) const |
PrismaticBarCrossSectionsVector & | getSections (void) |
Response * | setSectionResponse (PrismaticBarCrossSection *, const std::vector< std::string > &, const size_t &, Information &) |
int | setSectionParameter (PrismaticBarCrossSection *, const std::vector< std::string > &, const size_t &, Parameter &) |
![]() | |
Element1D (int tag, int classTag) | |
Constructor. | |
Element1D (int tag, int classTag, int Nd1, int Nd2) | |
Constructor. | |
Matrix | getLocalAxes (bool) const |
Returs a matrix with the axes of the element as matrix rows [[x1,y1,z1],[x2,y2,z2],...·]. | |
virtual CrdTransf * | checkCoordTransf (void) |
Returns (and checks that it exists) a const pointer to the coordinate transformation. | |
virtual const CrdTransf * | checkCoordTransf (void) const |
Returns (and checks that it exists) a const pointer to the coordinate transformation. | |
virtual const Matrix & | getCooPoints (const size_t &ndiv) const |
Return points distributed between the nodes as a matrix with the coordinates as rows. | |
virtual const Vector & | getCooPoint (const double &xrel) const |
Return the point that correspond to the relative coordinate 0<=xrel<=1. | |
Segment3d | getLineSegment (bool initialGeometry=true) const |
Return the segment defined by the element. | |
double | getDist2 (const Pos2d &p, bool initialGeometry=true) const |
Return the squared distance from the element to the point que is being passed as parameter. More... | |
double | getDist (const Pos2d &p, bool initialGeometry=true) const |
Return the the distance from the element to the point being passed as parameter. More... | |
double | getDist2 (const Pos3d &p, bool initialGeometry=true) const |
Return the squared distance from the element to the point que is being passed as parameter. More... | |
double | getDist (const Pos3d &p, bool initialGeometry=true) const |
Return the the distance from the element to the point being passed as parameter. More... | |
size_t | getDimension (void) const |
Return the element dimension (0, 1, 2 or 3). | |
int | getVtkCellType (void) const |
Interfaz con VTK. | |
virtual void | computeTributaryLengths (bool initialGeometry=true) const |
Calcula the tributary lengths that corresponds to each node of the element. | |
double | getTributaryLength (const Node *) const |
Return the tributary length corresponding to the node being passed as parameter. More... | |
void | vector2dUniformLoadGlobal (const Vector &) |
void | vector2dUniformLoadLocal (const Vector &) |
void | vector2dPointByRelDistLoadGlobal (const double &, const Vector &) |
void | vector2dPointByRelDistLoadLocal (const double &, const Vector &) |
void | vector2dPointLoadGlobal (const Vector &, const Vector &) |
void | vector2dPointLoadLocal (const Vector &, const Vector &) |
void | vector3dUniformLoadGlobal (const Vector &) |
void | vector3dUniformLoadLocal (const Vector &) |
void | vector3dPointByRelDistLoadGlobal (const double &, const Vector &) |
void | vector3dPointByRelDistLoadLocal (const double &, const Vector &) |
void | vector3dPointLoadGlobal (const Vector &, const Vector &) |
void | vector3dPointLoadLocal (const Vector &, const Vector &) |
void | strainLoad (const DeformationPlane &p1, const DeformationPlane &p2) |
![]() | |
ElementBase (int tag, int classTag) | |
Default constructor. | |
ElementBase (const ElementBase &) | |
Copy constructor. | |
ElementBase & | operator= (const ElementBase &) |
Assignment operator. | |
int | getNumExternalNodes (void) const |
Return the number of external nodes. | |
NodePtrsWithIDs & | getNodePtrs (void) |
Returns a pointer to the node vector. | |
const NodePtrsWithIDs & | getNodePtrs (void) const |
Returns a pointer to the node vector. | |
Pos3d | getCenterOfMassPosition (bool initialGeometry=true) const |
Return position of the element centroid. | |
![]() | |
Element (int tag, int classTag) | |
Constructor that takes the element's unique tag and the number of external nodes for the element. More... | |
virtual int | getNumEdges (void) const |
Returns number of edges (it must be overloaded for elements that have nodes inside edges. More... | |
std::vector< int > | getIdxNodes (void) const |
virtual void | setIdNodes (const std::vector< int > &inodes) |
Set the nodes. | |
virtual void | setIdNodes (const ID &inodes) |
Set the nodes. | |
virtual bool | isSubdomain (void) |
Returns true if the element is a subdomain. | |
virtual const Matrix & | getDamp (void) const |
Returns the damping matrix. More... | |
virtual int | setRayleighDampingFactors (const RayleighDampingFactors &rF) const |
Set Rayleigh damping factors. | |
const Vector & | getNodeResistingComponents (const size_t &, const Vector &) const |
Returns the generalized force of the element over the iNod-th node. More... | |
const Vector & | getNodeResistingForce (const size_t &iNod) const |
Returns the generalized force of the element over the iNod-th node. More... | |
const Vector & | getNodeResistingForceIncInertia (const size_t &iNod) const |
Returns the generalized force (including inertia forces) of the element over the node identified by the argument. More... | |
const Vector & | getNodeResistingForce (const Node *) const |
Returns the generalized force (including inertia forces) of the element over the node identified by the argument. More... | |
const Vector & | getNodeResistingForceIncInertia (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... | |
Response * | setMaterialResponse (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 ¶m) |
Sets the value param to the parameter argv . | |
int | setMaterialParameter (Material *, const std::vector< std::string > &, const size_t &, Parameter &) |
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 Vector & | getResistingForceSensitivity (int gradNumber) |
virtual const Matrix & | getInitialStiffSensitivity (int gradNumber) |
virtual const Matrix & | getDampSensitivity (int gradNumber) |
virtual const Matrix & | getMassSensitivity (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 Matrix & | getCooNodes (void) const |
Returns the coordinates of the nodes. | |
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::list< Pos3d > | getPosNodes (bool initialGeometry=true) const |
Returns the coordinates of the nodes. | |
Vector | getCenterOfMassCoordinates (bool initialGeometry=true) const |
Returns the coordinates del centro de gravedad 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 |
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 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 Vector | getInterpolationFactors (const ParticlePos3d &) const |
Returns interpolattion factors for a material point. | |
virtual Vector | getInterpolationFactors (const Pos3d &) const |
Returns interpolattion factors for a material point. | |
virtual const GaussModel & | getGaussModel (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. | |
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. | |
![]() | |
MeshComponent (int classTag) | |
Constructor. | |
MeshComponent (int tag, int classTag) | |
Constructor. | |
![]() | |
ContinuaReprComponent (int classTag) | |
ContinuaReprComponent (int tag, int classTag) | |
virtual const bool | isDead (void) const |
virtual const bool | isAlive (void) const |
virtual void | kill (void) |
virtual void | alive (void) |
![]() | |
~DomainComponent (void) | |
Destructor. | |
size_t | getIdx (void) const |
Returns the index of the object (to be used in VTK arrays). | |
virtual Domain * | getDomain (void) const |
Returns a pointer to the enclosing domain. More... | |
const Preprocessor * | getPreprocessor (void) const |
Returns (if possible) a pointer to the preprocessor. | |
Preprocessor * | getPreprocessor (void) |
Return (if possible) a pointer to the preprocessor. | |
void | set_index (const size_t &i) |
Set the index for the object (see numera in Set). More... | |
![]() | |
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. | |
![]() | |
MovableObject (int classTag, int dbTag) | |
Constructor. More... | |
MovableObject (int classTag) | |
Constructor. More... | |
MovableObject (const MovableObject &) | |
Copy constructor. Doesn't copy the dbTag. | |
MovableObject & | operator= (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 (CommParameters &) |
Return the object identifier in the database. | |
void | setDbTag (int dbTag) |
Sets the object identifier in the database. | |
void | setDbTag (CommParameters &) |
Sets the object identifier in the database if not already set. 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 . | |
![]() | |
DistributedBase (void) | |
Constructor. | |
virtual DbTagData & | getDbTagData (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. | |
Protected Member Functions | |
int | sendData (CommParameters &cp) |
Send members through the channel being passed as parameter. | |
int | recvData (const CommParameters &cp) |
Receives members through the channel being passed as parameter. | |
![]() | |
int | sendData (CommParameters &cp) |
Send members through the channel being passed as parameter. | |
int | recvData (const CommParameters &cp) |
Receives members through the channel being passed as parameter. | |
void | set_transf (const CrdTransf *trf) |
![]() | |
int | sendData (CommParameters &cp) |
Send members through the channel being passed as parameter. | |
int | recvData (const CommParameters &cp) |
Receives members through the channel being passed as parameter. | |
![]() | |
ElemPtrArray3d | put_on_mesh (const NodePtrArray3d &, meshing_dir dm) const |
Places the element on the mesh. | |
ElemPtrArray3d | cose (const SetEstruct &f1, const SetEstruct &f2) const |
int | sendCoordTransf (int posFlag, const int &, const int &, CommParameters &) |
Envía la coordinate transformation through the channel being passed as parameter. | |
CrdTransf * | recvCoordTransf (int posFlag, const int &, const int &, const CommParameters &) |
Recibe la coordinate transformation through the channel being passed as parameter. | |
CrdTransf2d * | recvCoordTransf2d (int posFlag, const int &, const int &, const CommParameters &) |
Recibe una coordinate transformation 2d through the channel being passed as parameter. | |
CrdTransf3d * | recvCoordTransf3d (int posFlag, const int &, const int &, const CommParameters &) |
Recibe una coordinate transformation 3d through the channel being passed as parameter. | |
![]() | |
TIPOMAT * | cast_material (const Material *ptr_mat) |
Casts the material pointer to a suitable type. | |
int | sendData (CommParameters &cp) |
Send members through the channel being passed as parameter. | |
int | recvData (const CommParameters &cp) |
Receives members through the channel being passed as parameter. | |
![]() | |
const Vector & | getRayleighDampingForces (void) const |
Returns element Rayleigh damping forces. | |
int | sendData (CommParameters &cp) |
Sends object members through the channel being passed as parameter. | |
int | recvData (const CommParameters &cp) |
Receives object members through the channel being passed as parameter. | |
![]() | |
void | setup_matrices (std::deque< Matrix > &, const int &) const |
Initializes the matrix container. | |
int | sendIdsEtiquetas (int posDbTag, CommParameters &) |
Send labelsthrough the channel being passed as parameter. | |
int | recvIdsEtiquetas (int posDbTag, const CommParameters &) |
Receive labels through the channel being passed as parameter. | |
int | sendData (CommParameters &) |
Send members through the channel being passed as parameter. | |
int | recvData (const CommParameters &) |
Receives members through the channel being passed as parameter. | |
![]() | |
int | sendData (CommParameters &) |
Send members through the channel being passed as parameter. | |
int | recvData (const CommParameters &) |
Receives members through the channel being passed as parameter. | |
![]() | |
DomainComponent (int tag, int classTag) | |
Constructor. More... | |
int | sendData (CommParameters &) |
Send object members through the channel being passed as parameter. | |
int | recvData (const CommParameters &) |
Receive object members through the channel being passed as parameter. | |
![]() | |
void | setTag (int newTag) |
Set tag. More... | |
Additional Inherited Members | |
![]() | |
typedef std::vector< const Node * > | NodesEdge |
Nodes on an element edge. More... | |
![]() | |
static const int | numNodes (void) |
Returns the element number of nodes. | |
![]() | |
static void | setDeadSRF (const double &d) |
Assigns Stress Reduction Factor for element deactivation. | |
static DefaultTag & | getDefaultTag (void) |
Returns next element's tag value by default. | |
![]() | |
static double | dead_srf = 1e-6 |
Stress reduction factor for foozen elements. | |
![]() | |
CrdTransf3d * | theCoordTransf |
![]() | |
PrismaticBarCrossSectionsVector | theSections |
pointers to the PrismaticBarCrossSection objects | |
SectionMatrices | section_matrices |
![]() | |
std::vector< double > | tributaryLengths |
![]() | |
NodePtrsWithIDs | theNodes |
pointers to node. | |
![]() | |
Vector | load |
vector for applying loads | |
RayleighDampingFactors | rayFactors |
Rayleigh damping factors. | |
Matrix | Kc |
pointer to hold last committed matrix if needed for rayleigh damping | |
![]() | |
int | index |
Index for VTK arrays. | |
LabelContainer | labels |
Label container. | |
3D beam element with PrismaticBarCrossSection type material.
|
virtual |
Commit the current element state.
The element is to commit its current state. To return 0 if sucessfull, a negative number if not.
Reimplemented from XC::BeamColumnWithSectionFD.
|
virtual |
Returns the mass matrix.
Returns the mass matrix. The element is to compute its mass matrix based on the original location of the nodes and the current trial response quantities at the nodes.
\[ //! M_e= {\frac{\partial I_i}{\partial \ddot U} \vert}_{U_{trial}} //! \]
Reimplemented from XC::Element.
|
virtual |
return the number of DOF associated with the element.
To return the number of dof associated with the element. This should equal the sum of the dofs at each of the external nodes. To ensure this, each subclass can overwrite the DomainComponent classes {setDomain()} method.
Implements XC::Element.
|
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}) \]
Implements XC::Element.
|
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 from XC::Element.
|
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 successfull {setResponse()} method invocation. To return \(0\) if successfull, a negative number if not. The base class implementation will always return \(-1\).
Reimplemented from XC::Element.
|
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}} \]
Implements XC::Element.
|
virtual |
Receive the object.
Each object has to receive the data needed to be able to recreate itself in the new process after it has been sent through cp
. If the object is an aggregation containing other objects, new objects of the correct type can be constructed using #theBroker. To return 0 if successful or a -1 if not.
Implements XC::MovableObject.
|
virtual |
Revert to the last commited state.
The element is to set it's current state to the last committed state. To return 0 if sucessfull, a negative number if not.
Reimplemented from XC::BeamColumnWithSectionFD.
|
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 sucessfull, a negative number if not.
Reimplemented from XC::BeamColumnWithSectionFD.
|
virtual |
Send the object.
Each object has to send the data needed to be able to reproduce that object in a remote process. The object uses the methods provided by cp
object to send the data to another channel at the remote actor, the address of the channel is set before this method is called. An object of similar type at the remote actor is invoked with a receiveSelf() to receive the data. Returns 0 if successful (successful in that the data got to the channel), or a - if no data was sent.
Implements XC::MovableObject.
|
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 from XC::Element.
|
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 from XC::Element.