xc
Public Member Functions | Friends | List of all members

DummyNodes are a type of node created and used by Subdomains for their exterior nodes. More...

#include <DummyNode.h>

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

Public Member Functions

 DummyNode (Node &theRealNode)
 
NodegetNode (void) const
 Return a pointer to the associated node.
 
void setDOF_GroupPtr (DOF_Group *theDOF_Grp)
 Each DummyNode, when involved with a StaticCondensationAnalysis analysis, will be associated with a DOF_Group object. More...
 
DOF_GroupgetDOF_GroupPtr (void)
 Method which returns a pointer to the DOF_Group object that was set using {setDOF_GroupPtr}. More...
 
int getNumberDOF (void) const
 Invokes getNumberDOF() on its associated node object. More...
 
const MatrixgetMass (void) const
 Returns the result of invoking getMass() on its associated node object. More...
 
int setMass (const Matrix &)
 Returns the result of invoking setMass() on its associated node object. More...
 
const VectorgetCrds (void) const
 Returns the result of invoking getCrds() on its associated node object. More...
 
const VectorgetDisp (void) const
 Returns the result of invoking getDisp() on its associated Node object. More...
 
const VectorgetVel (void) const
 Returns the result of invoking getVel() on its associated node object. More...
 
const VectorgetAccel (void) const
 Returns the result of invoking getAccel() on its associated Node object. More...
 
const VectorgetTrialDisp (void) const
 Returns the result of invoking getTrialDisp() on its associated node object. More...
 
const VectorgetTrialVel (void) const
 Returns the result of invoking getTrialVel() on its associated Node object. More...
 
const VectorgetTrialAccel (void) const
 Returns the result of invoking getTrialAccel() on its associated node object. More...
 
int setTrialDisp (const Vector &)
 Does nothing.
 
int setTrialVel (const Vector &)
 Does nothing.
 
int setTrialAccel (const Vector &)
 Does nothing.
 
int setIncrTrialDisp (const Vector &)
 Does nothing.
 
int setIncrTrialVel (const Vector &)
 Does nothing.
 
int setIncrTrialAccel (const Vector &)
 Does nothing.
 
void addUnbalancedLoad (const Vector &)
 Returns the result of invoking addUnbalancedLoad() on its associated node object. More...
 
const VectorgetUnbalancedLoad (void) const
 Returns the result of invoking getUnbalancedLoad() on its associated node object. More...
 
void zeroUnbalancedLoad (void)
 Calls zeroUnbalancedLoad() on its associated node.
 
int commitState ()
 Does nothing.
 
void Print (std::ostream &s) const
 Print stuff.
 
int addElementPtr (Element *)
 Does nothing.
 
void setColor (int newColor)
 Does nothing.
 
int getColor (void) const
 Does nothing.
 
int sendSelf (Communicator &)
 Send the object through the communicator argument. More...
 
int recvSelf (const Communicator &)
 Receives object through the communicator argument. More...
 
- Public Member Functions inherited from XC::Node
 Node (int classTag)
 Default constructor. More...
 
 Node (int tag, int classTag)
 Constructor. More...
 
 Node (int tag, int ndof, double Crd1)
 Constructor. More...
 
 Node (int tag, int ndof, double Crd1, double Crd2)
 Constructor for 2d nodes. More...
 
 Node (int tag, int ndof, double Crd1, double Crd2, double Crd3)
 constructor for 3d nodes More...
 
 Node (int tag, int ndof, const Vector &crds)
 Constructor. More...
 
 Node (const Node &theCopy, bool copyMass=true)
 used for domain decomposition & external nodes copy everything but the mass we should really set the mass to 0.0
 
NodegetCopy (void) const
 Virtual constructor.
 
virtual ~Node (void)
 destructor
 
const IDgetDOFs (void) const
 Gets the equation numbers corresponding to the node DOFS.
 
size_t getNumberOfConnectedConstraints (void) const
 Return the nunber of connected constraints.
 
std::set< const Constraint * > getConnectedConstraints (void) const
 Return a set of const pointers the constraints connected to the node.
 
std::set< Constraint * > getConnectedConstraints (void)
 Return a set of pointers the constraints connected to the node.
 
boost::python::list getConnectedConstraintsPy (void)
 Return a Python list of pointers to the constraints connected to the node.
 
boost::python::list getConnectedConstraintTags (void) const
 Return a Python list with the tags of the constraints connected to the node.
 
void connect (ContinuaReprComponent *el) const
 Inserts a component (element, constraint,...) to the connected component list.
 
void disconnect (ContinuaReprComponent *el) const
 Removes a component (element, constraint,...) from the connected component list.
 
size_t getNumberOfConnectedElements (void) const
 Return the number of elements that are connected with this node.
 
ElementConstPtrSet getConnectedElements (void) const
 Return a list of pointers to the elements that are connected with this node.
 
ElementPtrSet getConnectedElements (void)
 Return a list of pointers to the elements that are connected with this node.
 
boost::python::list getConnectedElementsPy (void)
 Return a python list of pointers to the elements that are connected with this node. More...
 
boost::python::list getConnectedElementTags (void) const
 Return a python list containing the tags of the elements that are connected with this node. More...
 
const MeshEdgenext (const std::deque< MeshEdge > &, const std::set< const MeshEdge *> &) const
 Returns an edge that has its origin in this node (and is not in visited).
 
const bool isDead (void) const
 True if node is inactive.
 
const bool isAlive (void) const
 True if node is active. More...
 
const bool isFrozen (void) const
 returns true if the node is frozen.
 
const bool isFree (void) const
 returns true if the node has no constraints.
 
const bool isFixedOnlyByFreezeConstraints (void) const
 Return true if the node is fixed only by its freeze constraints (all the other constraints, if any, are dead)
 
void kill (void)
 Deactivates the component.
 
void alive (void)
 Activates the component.
 
void freeze_if_dead (NodeLocker *locker)
 Imposes zero displacement (zero value for all node DOFs).
 
void melt_if_alive (void)
 Deletes the constraint over the node DOFs previously created by the freeze method. More...
 
SFreedom_Constraintfix (const SFreedom_Constraint &)
 Introduce en the node una constraint como la being passed as parameter. More...
 
void fix (const std::vector< int > &, const std::vector< double > &)
 Sets prescribed displacements on the DOFs being passed as parameter.
 
void fix (const ID &, const Vector &)
 Sets prescribed displacements on the DOFs being passed as parameter.
 
virtual size_t getDim (void) const
 Return the dimension of the node vector position (1,2 or 3).
 
virtual VectorgetCrds (void)
 Return a reference to the vector of nodal coordinates. More...
 
Vector getCrds3d (void) const
 Returns the node coordinates in a 3D space.
 
Pos2d getPosition2d (const Vector &) const
 Return the 2D position obtained as: initPos+ factor * v.
 
Pos3d getPosition3d (const Vector &) const
 Return the 3D position obtained as: initPos+ factor * v.
 
Pos2d getInitialPosition2d (void) const
 Return the initial position of the node in 2D.
 
Pos3d getInitialPosition3d (void) const
 Return the initial position of the node in 3D.
 
Pos2d getCurrentPosition2d (const double &factor=1.0) const
 Return the current position of the node scaled by factor: return initPos+ factor * nodDisplacement. More...
 
Pos3d getCurrentPosition3d (const double &factor=1.0) const
 Return the current position of the node scaled by factor: return initPos+ factor * nodDisplacement. More...
 
bool In (const GeomObj3d &, const double &factor=1.0, const double &tol=0.0) const
 Returns true if the current position of the node scaled by factor: return initPos+ factor * nodDisplacement lies insiof the geometric object. More...
 
bool In (const GeomObj2d &, const double &factor=1.0, const double &tol=0.0) const
 Returns true if the current position of the node scaled by factor: return initPos+ factor * nodDisplacement lies insiof the geometric object. More...
 
bool Out (const GeomObj3d &, const double &factor=1.0, const double &tol=0.0) const
 Returns true if the current position of the node scaled by factor: return initPos+ factor * nodDisplacement lies outsiof the geometric object. More...
 
bool Out (const GeomObj2d &, const double &factor=1.0, const double &tol=0.0) const
 Returns true if the current position of the node scaled by factor: return initPos+ factor * nodDisplacement lies outsiof the geometric object. More...
 
void setPos (const Pos3d &)
 Sets the node position.
 
void Move (const Vector3d &desplaz)
 Moves the node (intended only for its use from XC::Set).
 
void Transform (const TrfGeom &trf)
 Applies to the node position the transformation being passed as parameter.
 
double getDist2 (const Pos2d &p, bool initialGeometry=true) const
 Returns the square of the distance from the node to the point being passed as parameter. More...
 
double getDist (const Pos2d &p, bool initialGeometry=true) const
 Returns the distance from the node to the point being passed as parameter. More...
 
double getDist2 (const Pos3d &p, bool initialGeometry=true) const
 Returns the square of the distance from the node to the point being passed as parameter. More...
 
double getDist (const Pos3d &p, bool initialGeometry=true) const
 Returns the distance from the node to the point being passed as parameter. More...
 
Vector getDispXYZ (void) const
 Returns the XYZ components of node displacement.
 
Vector getRotXYZ (void) const
 Returns the XYZ components of node rotation.
 
Vector getVelXYZ (void) const
 Returns the XYZ components of the translational velocity of the node.
 
Vector getOmegaXYZ (void) const
 Returns the XYZ components of the angular velocity of the node.
 
Vector getAccelXYZ (void) const
 Returns the XYZ components of the translational acceleration of the node.
 
Vector getAlphaXYZ (void) const
 Returns the XYZ components of the angular acceleration of the node.
 
virtual const VectorgetIncrDisp (void) const
 Returns the displacement increment.
 
virtual const VectorgetIncrDeltaDisp (void) const
 Return the incremental displacement. More...
 
virtual int setTrialDispComponent (double value, int dof)
 
virtual int incrTrialDisp (const Vector &)
 Increments the current trial displacement. More...
 
virtual int incrTrialVel (const Vector &)
 Increments the current trial velocity. More...
 
virtual int incrTrialAccel (const Vector &)
 Increments the current trial acceleration. More...
 
const NodalLoadnewLoad (const Vector &)
 Create a new load on the node and put it in the current load pattern.
 
void createInertiaLoad (const Vector &)
 Creates the inertia load that corresponds to the acceleration argument. More...
 
virtual int addUnbalancedLoad (const Vector &load, double fact=1.0)
 Adds vector to the node unbalanced load. More...
 
virtual int addInertiaLoadToUnbalance (const Vector &accel, double fact=1.0)
 Adds inertial loads to the node unbalanced load vector. More...
 
virtual const VectorgetUnbalancedLoadIncInertia (void) const
 Return unbalanced load vector including inertial forces. More...
 
virtual int revertToLastCommit ()
 Returns to the last committed state. More...
 
virtual int revertToStart ()
 Returns to the initial state. More...
 
double getMassComponent (const int &) const
 Return the mass matrix component for the DOF argument.
 
virtual int setNumColR (int numCol)
 Creates a Matrix to store the R matrix. More...
 
virtual int setR (int row, int col, double Value)
 Sets the (row,col) entry of R to be equal to Value. More...
 
virtual const VectorgetRV (const Vector &V)
 This is a method provided for Element objects, the Node object returns the product of the matrix R and the vector V. More...
 
virtual int setRayleighDampingFactor (double alphaM)
 Sets the Rayleigh dumping factor.
 
virtual const MatrixgetDamp (void) const
 Return the damping matrix of the node.
 
void addTributary (const double &) const
 Adds to tributary the lentgth, area o volume being passed as parameter. More...
 
void resetTributary (void) const
 Zeroes tributary (length, area or volume).
 
const double & getTributary (void) const
 Return tributary value (length, area or volume).
 
virtual int setNumEigenvectors (int numVectorsToStore)
 Set the dimensions of the matrix that constrains the eigenvectors. More...
 
virtual int setEigenvector (int, const Vector &)
 Set el eigenvector eigenvector al modo mode.
 
int getNumModes (void) const
 
virtual Vector getEigenvector (int) const
 Returns the eigenvector that corresponds to i-th mode.
 
Vector getNormalizedEigenvector (int) const
 Returns the eigenvector that corresponds to i-th mode normalized so the maximum values of the components is 1 (infinite norm). More...
 
virtual const MatrixgetEigenvectors (void) const
 Returns the eigenvectors that correspond to the node.
 
Matrix getNormalizedEigenvectors (void) const
 Returns a matrix with the eigenvectors as columns.
 
Pos2d getEigenPosition2d (const double &, int) const
 Return the "modal" position of the node scaled by factor: return initPos+ factor * getNormalizedEigenvector(mode). More...
 
Pos3d getEigenPosition3d (const double &, int) const
 Return the "modal" position of the node scaled by factor: return initPos+ factor * getNormalizedEigenvector(mode). More...
 
Vector3d getEigenvectorDisp3dComponents (int) const
 Return the eigenvector displacement components in a 3D vector.
 
Vector3d getEigenvectorRot3dComponents (int) const
 Return the eigenvector rotation components in a 3D vector.
 
void clearEigenvectors (void)
 Remove the stored eigenvectors.
 
double getAngularFrequency (int) const
 Return the angular frequency corresponding to the i-th mode.
 
Vector getAngularFrequencies (void) const
 Returns the angular frequencies from the modal analysis.
 
virtual double getModalParticipationFactor (int mode) const
 Returns the modal participation factor corresponding to i-th mode. More...
 
Vector getModalParticipationFactors (void) const
 Returns the modal participation factors.
 
virtual double getModalParticipationFactor (int mode, const std::set< int > &dofs) const
 Returns the modal participation factor corresponding to i-th mode. More...
 
Vector getModalParticipationFactors (const std::set< int > &dofs) const
 Returns the modal participation factors. More...
 
Vector getModalParticipationFactorsForDOFs (const boost::python::list &) const
 Returns the modal participation factors. More...
 
Vector getDistributionFactor (int mode) const
 Returns the distribution factor corresponding to the i-th mode.
 
Vector getDistributionFactor (int mode, const std::set< int > &dofs) const
 Returns the distribution factor corresponding to the mode being passed as parameter. More...
 
Matrix getDistributionFactors (void) const
 Returns the matrix with the computed distribution factors placed by columns. More...
 
double getEffectiveModalMass (int mode) const
 Return the effective modal mass that corresponds to i mode. More...
 
Vector getEffectiveModalMasses (void) const
 Returns the effective modal masses.
 
Vector getEquivalentStaticLoad (int mode, const double &) const
 Return the equivalent static load for the mode being passed as parameter and the acceleration corresponding to that mode. More...
 
Vector getMaxModalDisplacement (int mode, const double &) const
 Returns the maximal modal displacement for the node being passed as parameter and the acceleration corresponding to that mode. More...
 
Vector getMaxModalVelocity (int mode, const double &) const
 Return the maximal modal velocity for the mode being passed as parameter and the acceleration corresponding to that mode. More...
 
Vector getMaxModalAcceleration (int mode, const double &) const
 Return the maximal modal acceleration for the mode being passed as parameter and the acceleration corresponding to that mode. More...
 
Vector getMaxModalDisplacementForDOFs (int mode, const double &, const std::set< int > &dofs) const
 Returns the maximal modal displacement on the DOFs and mode being passed as parameter and the acceleration corresponding to that mode. More...
 
Vector getMaxModalVelocityForDOFs (int mode, const double &, const std::set< int > &dofs) const
 Returns the maximum modal velocity on the DOFs and mode being passed as parameter and the acceleration corresponding to that mode. More...
 
Vector getMaxModalAccelerationForDOFs (int mode, const double &, const std::set< int > &dofs) const
 Return the maximal modal acceleration on the DOFs and mode being passed as parameter and the acceleration corresponding to that mode. More...
 
Vector getMaxModalDisplacementForDOFs (int mode, const double &, const boost::python::list &dofs) const
 Returns the maximal modal displacement on the DOFs and mode being passed as parameter and the acceleration corresponding to that mode. More...
 
Vector getMaxModalVelocityForDOFs (int mode, const double &, const boost::python::list &dofs) const
 Returns the maximum modal velocity on the DOFs and mode being passed as parameter and the acceleration corresponding to that mode. More...
 
Vector getMaxModalAccelerationForDOFs (int mode, const double &, const boost::python::list &dofs) const
 Return the maximal modal acceleration on the DOFs and mode being passed as parameter and the acceleration corresponding to that mode. 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.
 
std::set< SetBase * > get_sets (void) const
 Returns the sets that include this node.
 
void add_to_sets (std::set< SetBase *> &)
 Adds the node to the sets being passed as parameters.
 
void copySetsFrom (const Node &)
 Add this element to all the sets containing the given one.
 
virtual void Print (std::ostream &s, int flag=0) const
 Prints node data. More...
 
Vector3d get3dForceComponents (const Vector &) const
 Return the "force/displacement" components in a 3d vector.
 
Vector3d get3dMomentComponents (const Vector &) const
 Return the "moment/rotation" components in a 3d vector.
 
virtual const VectorgetReaction (void) const
 Return the node reaction.
 
void setReaction (const Vector &)
 Set the node reaction.
 
Vector3d getReactionForce3d (void) const
 Return the reaction force in a 3D vector.
 
Vector3d getReactionMoment3d (void) const
 Return the reaction moment in a 3D vector.
 
const VectorgetResistingForce (const ElementConstPtrSet &, const bool &) const
 Return the action of the elements from the set over this node.
 
SlidingVectorsSystem3d getResistingSlidingVectorsSystem3d (const ElementConstPtrSet &, const bool &) const
 Returns the sliding vector system that represents the action of the elements of the set over the node. More...
 
virtual int addReactionForce (const Vector &, double factor)
 Increments the node reaction.
 
virtual int resetReactionForce (bool inclInertia)
 Calculate the reactions in this node (used in Domain::calculateNodalReactions). More...
 
bool checkReactionForce (const double &) const
 Checks that reactions on the node correspond to constrained degrees of freedom. More...
 
Matrix getTangentStiff (const ElementConstPtrSet &) const
 Return the tangent stiffness contribution of the elements argument. More...
 
Matrix getInitialStiff (const ElementConstPtrSet &) const
 Return the initial stiffness contribution of the elements argument. More...
 
int addInertiaLoadSensitivityToUnbalance (const Vector &accel, double fact=1.0, bool tag=false)
 ??
 
Matrix getMassSensitivity (void) const
 
virtual const MatrixgetDampSensitivity (void) const
 
int getCrdsSensitivity (void) const
 
int saveSensitivity (Vector *v, Vector *vdot, Vector *vdotdot, int gradNum, int numGrads)
 
double getDispSensitivity (int dof, int gradNum) const
 Return displacement sensitivity.
 
double getVelSensitivity (int dof, int gradNum) const
 Return velocity sensitivity.
 
double getAccSensitivity (int dof, int gradNum) const
 Return acceleration sensitivity.
 
int setParameter (const std::vector< std::string > &argv, Parameter &param)
 Sets the value param to the parameter argv.
 
int updateParameter (int parameterID, Information &info)
 Updates the parameter identified by parameterID with info.
 
int activateParameter (int parameterID)
 Activates the parameter identified by parameterID.
 
- 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)
 
- 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 void setDomain (Domain *theDomain)
 Sets the pointer to the domain. More...
 
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...
 
- 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.
 
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.
 
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 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.
 
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.
 

Friends

std::ostream & operator<< (std::ostream &, const DummyNode &)
 

Additional Inherited Members

- Public Types inherited from XC::Node
typedef std::set< Element * > ElementPtrSet
 Container of element pointers.
 
typedef std::set< const Element * > ElementConstPtrSet
 Container of const element pointers.
 
- Public Types inherited from EntityWithProperties
typedef std::map< std::string, boost::python::object > PythonDict
 
- Static Public Member Functions inherited from XC::Node
static DefaultTaggetDefaultTag (void)
 Returns a default value for node identifier.
 
- 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.
 
- Protected Member Functions inherited from XC::Node
DbTagDatagetDbTagData (void) const
 Returns a vector to store the dbTags de los miembros of the clase. More...
 
int sendData (Communicator &)
 Sends object members through the communicator argument.
 
int recvData (const Communicator &)
 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...
 
bool isEqual (const TaggedObject &) const
 Return true if both objects are equal.
 
- Protected Member Functions inherited from CommandEntity
template<class T >
void string_to (T &, const std::string &) const
 
- Protected Member Functions inherited from EntityWithProperties
bool isEqual (const EntityWithProperties &) const
 Return true if both objects are equal.
 
- Protected Member Functions inherited from EntityWithOwner
virtual bool isEqual (const EntityWithOwner &) const
 Return true if both objects are equal.
 
- Static Protected Member Functions inherited from CommandEntity
static CommandEntityentcmd_cast (boost::any &data)
 
- Protected Attributes inherited from XC::MeshComponent
int index
 Index for VTK arrays.
 
LabelContainer labels
 Label container.
 
- Static Protected Attributes inherited from EntityWithOwner
static int verbosity = 1
 Object that owns THIS ONE. More...
 

Detailed Description

DummyNodes are a type of node created and used by Subdomains for their exterior nodes.

They reference a real node and most methods invoked on them are in turn invoked by the dummy node on the real node. The calls asking the real node to change its current state are ignored. The calls involving DOF_Group are handled by the dummy node.

Member Function Documentation

◆ addUnbalancedLoad()

void XC::DummyNode::addUnbalancedLoad ( const Vector load)

Returns the result of invoking addUnbalancedLoad() on its associated node object.

◆ getAccel()

const XC::Vector & XC::DummyNode::getAccel ( void  ) const
virtual

Returns the result of invoking getAccel() on its associated Node object.

Reimplemented from XC::Node.

◆ getCrds()

const XC::Vector & XC::DummyNode::getCrds ( void  ) const
virtual

Returns the result of invoking getCrds() on its associated node object.

Reimplemented from XC::Node.

◆ getDisp()

const XC::Vector & XC::DummyNode::getDisp ( void  ) const
virtual

Returns the result of invoking getDisp() on its associated Node object.

Reimplemented from XC::Node.

◆ getDOF_GroupPtr()

XC::DOF_Group * XC::DummyNode::getDOF_GroupPtr ( void  )
virtual

Method which returns a pointer to the DOF_Group object that was set using {setDOF_GroupPtr}.

If no pointer has been set a \(0\) is returned.

Reimplemented from XC::Node.

◆ getMass()

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

Returns the result of invoking getMass() on its associated node object.

Reimplemented from XC::Node.

◆ getNumberDOF()

int XC::DummyNode::getNumberDOF ( void  ) const
virtual

Invokes getNumberDOF() on its associated node object.

Reimplemented from XC::Node.

◆ getTrialAccel()

const XC::Vector & XC::DummyNode::getTrialAccel ( void  ) const
virtual

Returns the result of invoking getTrialAccel() on its associated node object.

Reimplemented from XC::Node.

◆ getTrialDisp()

const XC::Vector & XC::DummyNode::getTrialDisp ( void  ) const
virtual

Returns the result of invoking getTrialDisp() on its associated node object.

Reimplemented from XC::Node.

◆ getTrialVel()

const XC::Vector & XC::DummyNode::getTrialVel ( void  ) const
virtual

Returns the result of invoking getTrialVel() on its associated Node object.

Reimplemented from XC::Node.

◆ getUnbalancedLoad()

const XC::Vector & XC::DummyNode::getUnbalancedLoad ( void  ) const
virtual

Returns the result of invoking getUnbalancedLoad() on its associated node object.

Reimplemented from XC::Node.

◆ getVel()

const XC::Vector & XC::DummyNode::getVel ( void  ) const
virtual

Returns the result of invoking getVel() on its associated node object.

Reimplemented from XC::Node.

◆ recvSelf()

int XC::DummyNode::recvSelf ( const Communicator comm)
virtual

Receives object through the communicator argument.

Invoked on a remote machine to read its data that was sent by a node object in another actor when sendSelf() was invoked. As in {sendSelf()}, the Node object creates an ID object. It asks the Channel object to fill this object with data. Based on the data it creates Matrix and Vector objects to store the Nodes data and asks the cp object to fill these with data. The data placed here by the cp object correspond to the data put there by the sending Node object.

Reimplemented from XC::Node.

◆ sendSelf()

int XC::DummyNode::sendSelf ( Communicator comm)
virtual

Send the object through the communicator argument.

Causes the Node object to send the data needed to init itself on a remote machine to the Communicator object cp. The data sent includes the tag, number of dof, coordinates, committed response quantities, unbalanced load, mass and participation matrix. To do this the Node creates an ID object into which it stores its tag, the ndof and a flag indicating whether any additional information, i.e. mass, response quantities also need to be sent. In addition four database tags are also included in this ID object. The database tags, if not already obtained, are requested from the cp object (these are needed as each object can only store a single object of a particular size using it's own database tags – additional tags are needed when multiple objects of the same size are needed. The objects that have been created are then sent.

Reimplemented from XC::Node.

◆ setDOF_GroupPtr()

void XC::DummyNode::setDOF_GroupPtr ( DOF_Group theDOF_Grp)
virtual

Each DummyNode, when involved with a StaticCondensationAnalysis analysis, will be associated with a DOF_Group object.

It is the DOF_Group that contains the ID of equation numbers. When invoked this method sets that link for the DummyNode object.

Reimplemented from XC::Node.

◆ setMass()

int XC::DummyNode::setMass ( const Matrix m)
virtual

Returns the result of invoking setMass() on its associated node object.

Reimplemented from XC::Node.


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