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

Base clas for 3D force beam column elements with PrismaticBarCrossSection type material. More...

#include <NLForceBeamColumn3dBase.h>

Inheritance diagram for XC::NLForceBeamColumn3dBase:
XC::BeamColumnWithSectionFDTrf3d XC::BeamColumnWithSectionFD XC::Element1D XC::ElementBase< 2 > XC::Element XC::MeshComponent XC::ContinuaReprComponent XC::DomainComponent XC::TaggedObject XC::MovableObject XC::DistributedBase XC::ForceBeamColumn3d XC::NLBeamColumn3d

Public Member Functions

 NLForceBeamColumn3dBase (int tag, int classTag, int numSec=0)
 
 NLForceBeamColumn3dBase (int tag, int classTag, int numSec, const Material *theSection, const CrdTransf *coordTransf)
 
 NLForceBeamColumn3dBase (const NLForceBeamColumn3dBase &)
 Copy constructor.
 
void setSection (const PrismaticBarCrossSection *sccModel)
 
int getNumDOF (void) const
 return the number of DOF associated with the element. More...
 
double getRho (void) const
 
void setRho (const double &r)
 
const MatrixgetTangentStiff (void) const
 Return the tangent stiffness matrix. More...
 
const VectorgetResistingForce (void) const
 Returns the resisting force vector for the element. More...
 
double getAN1 (void)
 Axial force which acts over the element at its back end. More...
 
double getAN2 (void)
 Axial force which acts over the element at its front end. More...
 
double getN1 (void)
 Axial force at the front end. More...
 
double getN2 (void)
 Axial force at the back end. More...
 
double getN (void)
 Mean axial force. More...
 
double getAMz1 (void)
 Moment about z axis drived over the bar at its back end. More...
 
double getAMz2 (void)
 Moment about z axis drived over the bar at its front end. More...
 
double getMz1 (void)
 Moment about z axis at its back end. More...
 
double getMz2 (void)
 Moment about z axis at its front end. More...
 
double getVy (void)
 y shear.
 
double getAVy1 (void)
 y shear drived over the bar at its back end. More...
 
double getAVy2 (void)
 y shear drived over the bar at its front end. More...
 
double getVy1 (void)
 y shear at its back end. More...
 
double getVy2 (void)
 y shear at its front end. More...
 
double getVz (void)
 z shear. More...
 
double getAVz1 (void)
 z shear drived over the bar at its back end. More...
 
double getAVz2 (void)
 z shear drived over the bar at its front end. More...
 
double getVz1 (void)
 z shear at its back end. More...
 
double getVz2 (void)
 z shear at its front end. More...
 
double getMy1 (void)
 Moment about y axis at the back end. More...
 
double getMy2 (void)
 Moment about y axis at the front end. More...
 
double getT (void)
 Element's torque. More...
 
double getT1 (void)
 Torsor at the back end. More...
 
double getT2 (void)
 Torsor at the front end. More...
 
- Public Member Functions inherited from XC::BeamColumnWithSectionFDTrf3d
 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 CrdTransfgetCoordTransf (void)
 Returns (if possible) a pointer to the coordinate transformation.
 
virtual const CrdTransfgetCoordTransf (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 VectorgetVDirStrongAxisGlobalCoord (const size_t &i, bool initialGeometry) const
 Returns i-th cross section strong axis direction vector expressed in global coordinates.
 
const VectorgetVDirWeakAxisGlobalCoord (const size_t &i, bool initialGeometry) const
 Returns i-th cross section weak axis direction vector expressed in global coordinates.
 
- Public Member Functions inherited from XC::BeamColumnWithSectionFD
 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 PrismaticBarCrossSectiongetSectionPtr (const size_t &i) const
 Returns a pointer to the i-th section of the element.
 
void setTrialSectionDeformations (const std::vector< Vector > &vs)
 
bool setSections (const std::vector< PrismaticBarCrossSection *> &sectionPtrs)
 
size_t getNumSections (void) const
 
PrismaticBarCrossSectionsVectorgetSections (void)
 
ResponsesetSectionResponse (PrismaticBarCrossSection *, const std::vector< std::string > &, const size_t &, Information &)
 
int setSectionParameter (PrismaticBarCrossSection *, const std::vector< std::string > &, const size_t &, Parameter &)
 
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...
 
void zeroLoad (void)
 Zeroes loads on element.
 
- Public Member Functions inherited from XC::Element1D
 Element1D (int tag, int classTag)
 Constructor.
 
 Element1D (int tag, int classTag, int Nd1, int Nd2)
 Constructor.
 
void setDomain (Domain *theDomain)
 Sets the domain for the element.
 
Matrix getLocalAxes (bool) const
 Returs a matrix with the axes of the element as matrix rows [[x1,y1,z1],[x2,y2,z2],...·].
 
virtual CrdTransfcheckCoordTransf (void)
 Returns (and checks that it exists) a const pointer to the coordinate transformation.
 
virtual const CrdTransfcheckCoordTransf (void) const
 Returns (and checks that it exists) a const pointer to the coordinate transformation.
 
virtual const MatrixgetCooPoints (const size_t &ndiv) const
 Return points distributed between the nodes as a matrix with the coordinates as rows.
 
virtual const VectorgetCooPoint (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)
 
- Public Member Functions inherited from XC::ElementBase< 2 >
 ElementBase (int tag, int classTag)
 Default constructor.
 
 ElementBase (const ElementBase &)
 Copy constructor.
 
ElementBaseoperator= (const ElementBase &)
 Assignment operator.
 
int getNumExternalNodes (void) const
 Return the number of external nodes.
 
NodePtrsWithIDsgetNodePtrs (void)
 Returns a pointer to the node vector.
 
const NodePtrsWithIDsgetNodePtrs (void) const
 Returns a pointer to the node vector.
 
Pos3d getCenterOfMassPosition (bool initialGeometry=true) const
 Return position of the element centroid.
 
- Public Member Functions inherited from XC::Element
 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 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 int update (void)
 Updates the element state. More...
 
virtual bool isSubdomain (void)
 Returns true if the element is a subdomain.
 
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 int addLoad (ElementalLoad *theLoad, double loadFactor)=0
 
virtual int addInertiaLoadToUnbalance (const Vector &accel)=0
 
virtual int setRayleighDampingFactors (const RayleighDampingFactors &rF) const
 Set Rayleigh damping factors.
 
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 &)
 
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 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 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.
 
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
 
virtual const bool isAlive (void) const
 
virtual void kill (void)
 
virtual void alive (void)
 
- 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.
 
void set_index (const size_t &i)
 Set the index for the object (see numera in Set). More...
 
- 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)
 Print stuff.
 
- 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 (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 sendSelf (CommParameters &cp)=0
 Send the object. More...
 
virtual int recvSelf (const CommParameters &cp)=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 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.
 

Protected Member Functions

void resizeMatrices (const size_t &nSections)
 alocate section flexibility matrices and section deformation vectors
 
void initializeSectionHistoryVariables (void)
 
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.
 
- Protected Member Functions inherited from XC::BeamColumnWithSectionFDTrf3d
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)
 
- Protected Member Functions inherited from XC::BeamColumnWithSectionFD
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.
 
- Protected Member Functions inherited from XC::Element1D
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.
 
CrdTransfrecvCoordTransf (int posFlag, const int &, const int &, const CommParameters &)
 Recibe la coordinate transformation through the channel being passed as parameter.
 
CrdTransf2drecvCoordTransf2d (int posFlag, const int &, const int &, const CommParameters &)
 Recibe una coordinate transformation 2d through the channel being passed as parameter.
 
CrdTransf3drecvCoordTransf3d (int posFlag, const int &, const int &, const CommParameters &)
 Recibe una coordinate transformation 3d through the channel being passed as parameter.
 
- Protected Member Functions inherited from XC::ElementBase< 2 >
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.
 
- Protected Member Functions inherited from XC::Element
const VectorgetRayleighDampingForces (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.
 
- Protected Member Functions inherited from XC::MeshComponent
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.
 
- Protected Member Functions inherited from XC::ContinuaReprComponent
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.
 
- Protected Member Functions inherited from XC::DomainComponent
 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.
 
- Protected Member Functions inherited from XC::TaggedObject
void setTag (int newTag)
 Set tag. More...
 

Protected Attributes

double rho
 mass density per unit length
 
int maxIters
 maximum number of local iterations
 
double tol
 tolerance for relative energy norm for local iterations
 
int initialFlag
 indicates if the element has been initialized
 
bool isTorsion
 
Matrix kv
 stiffness matrix in the basic system
 
EsfBeamColumn3d Se
 element resisting forces in the basic system
 
Matrix kvcommit
 commited stiffness matrix in the basic system
 
EsfBeamColumn3d Secommit
 commited element end forces in the basic system
 
std::vector< Matrixfs
 array of section flexibility matrices
 
std::vector< Vectorvs
 array of section deformation vectors
 
std::vector< VectorSsr
 array of section resisting force vectors
 
std::vector< Vectorvscommit
 array of commited section deformation vectors
 
Matrix sp
 Applied section forces due to element loads, 5 x nSections.
 
FVectorBeamColumn3d p0
 Reactions in the basic system due to element loads.
 
Matrix Ki
 
- Protected Attributes inherited from XC::BeamColumnWithSectionFDTrf3d
CrdTransf3dtheCoordTransf
 
- Protected Attributes inherited from XC::BeamColumnWithSectionFD
PrismaticBarCrossSectionsVector theSections
 pointers to the PrismaticBarCrossSection objects
 
SectionMatrices section_matrices
 
- Protected Attributes inherited from XC::Element1D
std::vector< double > tributaryLengths
 
- Protected Attributes inherited from XC::ElementBase< 2 >
NodePtrsWithIDs theNodes
 pointers to node.
 
- Protected Attributes inherited from XC::Element
Vector load
 vector for applying 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.
 

Static Protected Attributes

static const size_t NDM = 3
 dimension of the problem (3d)
 
static const int NND = 6
 number of nodal dof's
 
static const size_t NEGD = 12
 number of element global dof's
 
static const size_t NEBD = 6
 number of element dof's in the basic system
 
static const double DefaultLoverGJ = 1.0e-10
 
static Matrix theMatrix
 
static Vector theVector
 
static double workArea []
 

Additional Inherited Members

- Public Types inherited from XC::Element
typedef std::vector< const Node * > NodesEdge
 Nodes on an element edge. More...
 
- Static Public Member Functions inherited from XC::ElementBase< 2 >
static const int numNodes (void)
 Returns the element number of nodes.
 
- Static Public Member Functions inherited from XC::Element
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 Attributes inherited from XC::Element
static double dead_srf = 1e-6
 Stress reduction factor for foozen elements.
 

Detailed Description

Base clas for 3D force beam column elements with PrismaticBarCrossSection type material.

Member Function Documentation

§ getAMz1()

double XC::NLForceBeamColumn3dBase::getAMz1 ( void  )
inline

Moment about z axis drived over the bar at its back end.

¡Warning! call "calc_resisting_force" before calling this method.

§ getAMz2()

double XC::NLForceBeamColumn3dBase::getAMz2 ( void  )
inline

Moment about z axis drived over the bar at its front end.

¡Warning! call "calc_resisting_force" before calling this method.

§ getAN1()

double XC::NLForceBeamColumn3dBase::getAN1 ( void  )
inline

Axial force which acts over the element at its back end.

¡Warning! call "calc_resisting_force" before calling this method.

§ getAN2()

double XC::NLForceBeamColumn3dBase::getAN2 ( void  )
inline

Axial force which acts over the element at its front end.

¡Warning! call "calc_resisting_force" before calling this method.

§ getAVy1()

double XC::NLForceBeamColumn3dBase::getAVy1 ( void  )
inline

y shear drived over the bar at its back end.

¡Warning! call "calc_resisting_force" before calling this method.

§ getAVy2()

double XC::NLForceBeamColumn3dBase::getAVy2 ( void  )
inline

y shear drived over the bar at its front end.

¡Warning! call "calc_resisting_force" before calling this method.

§ getAVz1()

double XC::NLForceBeamColumn3dBase::getAVz1 ( void  )
inline

z shear drived over the bar at its back end.

¡Warning! call "calc_resisting_force" before calling this method.

§ getAVz2()

double XC::NLForceBeamColumn3dBase::getAVz2 ( void  )
inline

z shear drived over the bar at its front end.

¡Warning! call "calc_resisting_force" before calling this method.

§ getMy1()

double XC::NLForceBeamColumn3dBase::getMy1 ( void  )
inline

Moment about y axis at the back end.

¡Warning! call "calc_resisting_force" before calling this method.

§ getMy2()

double XC::NLForceBeamColumn3dBase::getMy2 ( void  )
inline

Moment about y axis at the front end.

¡Warning! call "calc_resisting_force" before calling this method.

§ getMz1()

double XC::NLForceBeamColumn3dBase::getMz1 ( void  )
inline

Moment about z axis at its back end.

¡Warning! call "calc_resisting_force" before calling this method.

§ getMz2()

double XC::NLForceBeamColumn3dBase::getMz2 ( void  )
inline

Moment about z axis at its front end.

¡Warning! call "calc_resisting_force" before calling this method.

§ getN()

double XC::NLForceBeamColumn3dBase::getN ( void  )
inline

Mean axial force.

¡Warning! call "calc_resisting_force" before calling this method.

§ getN1()

double XC::NLForceBeamColumn3dBase::getN1 ( void  )
inline

Axial force at the front end.

¡Warning! call "calc_resisting_force" before calling this method.

§ getN2()

double XC::NLForceBeamColumn3dBase::getN2 ( void  )
inline

Axial force at the back end.

¡Warning! call "calc_resisting_force" before calling this method.

§ getNumDOF()

int XC::NLForceBeamColumn3dBase::getNumDOF ( void  ) const
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.

§ getResistingForce()

const XC::Vector & XC::NLForceBeamColumn3dBase::getResistingForce ( void  ) const
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.

§ getT()

double XC::NLForceBeamColumn3dBase::getT ( void  )
inline

Element's torque.

¡Warning! call "calc_resisting_force" before calling this method.

§ getT1()

double XC::NLForceBeamColumn3dBase::getT1 ( void  )
inline

Torsor at the back end.

¡Warning! call "calc_resisting_force" before calling this method.

§ getT2()

double XC::NLForceBeamColumn3dBase::getT2 ( void  )
inline

Torsor at the front end.

¡Warning! call "calc_resisting_force" before calling this method.

§ getTangentStiff()

const XC::Matrix & XC::NLForceBeamColumn3dBase::getTangentStiff ( void  ) const
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.

§ getVy1()

double XC::NLForceBeamColumn3dBase::getVy1 ( void  )
inline

y shear at its back end.

¡Warning! call "calc_resisting_force" before calling this method.

§ getVy2()

double XC::NLForceBeamColumn3dBase::getVy2 ( void  )
inline

y shear at its front end.

¡Warning! call "calc_resisting_force" before calling this method.

§ getVz()

double XC::NLForceBeamColumn3dBase::getVz ( void  )
inline

z shear.

¡Warning! call "calc_resisting_force" before calling this method.

§ getVz1()

double XC::NLForceBeamColumn3dBase::getVz1 ( void  )
inline

z shear at its back end.

¡Warning! call "calc_resisting_force" before calling this method.

§ getVz2()

double XC::NLForceBeamColumn3dBase::getVz2 ( void  )
inline

z shear at its front end.

¡Warning! call "calc_resisting_force" before calling this method.


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