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

Local representation of a remote subdomain. More...

#include <ShadowSubdomain.h>

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

Public Member Functions

 ShadowSubdomain (int tag, MachineBroker &theMachineBroker, FEM_ObjectBroker &theObjectBroker, DataOutputHandler::map_output_handlers *oh, CommandEntity *owr)
 
 ShadowSubdomain (int tag, Channel &, FEM_ObjectBroker &, DataOutputHandler::map_output_handlers *, CommandEntity *)
 
virtual int buildSubdomain (int numSubdomains, PartitionedModelBuilder &theBuilder)
 
virtual int getRemoteData (void)
 
virtual bool addElement (Element *)
 Adds to the domain the element being passed as parameter.
 
virtual bool addNode (Node *)
 Method to add a node to the subdomain. More...
 
virtual bool addExternalNode (Node *)
 A Method to add the node pointed to by the argument. More...
 
virtual bool addSFreedom_Constraint (SFreedom_Constraint *)
 Adds a single freedom constraint to the domain. More...
 
virtual bool addMFreedom_Constraint (MFreedom_Constraint *)
 Adds to the domain a multi-freedom constraint. More...
 
virtual bool addLoadPattern (LoadPattern *)
 Appends the load pattern to the domain. More...
 
virtual bool addNodalLoad (NodalLoad *, int loadPattern)
 Appends a nodal load to the pattern being passed as parameter. More...
 
virtual bool addElementalLoad (ElementalLoad *, int loadPattern)
 Adds a load over element to the pattern. More...
 
virtual bool addSFreedom_Constraint (SFreedom_Constraint *, int loadPattern)
 Adds to the domain a single freedom constraint.
 
virtual bool hasNode (int tag)
 
virtual bool hasElement (int tag)
 
virtual void clearAll (void)
 Removes all components from domain (nodes, elements, loads & constraints). More...
 
virtual bool removeElement (int tag)
 Remove the element identified by the argument.
 
virtual bool removeNode (int tag)
 Remove a node from the subdomain. More...
 
virtual bool removeSFreedom_Constraint (int tag)
 Removes from domain the single freedom constraint identified by the argument. More...
 
virtual bool removeMFreedom_Constraint (int tag)
 Removes from domain the multi-freedom constraint identified by the argument. More...
 
virtual bool removeLoadPattern (int tag)
 Remove from domain el load pattern identified by the argument. More...
 
virtual bool removeNodalLoad (int tag, int loadPattern)
 Removes the nodal load from container.
 
virtual bool removeElementalLoad (int tag, int loadPattern)
 Removes the elemental load from container.
 
virtual bool removeSFreedom_Constraint (int tag, int loadPattern)
 Removes from domain the single freedom constraint being passed as parameter. More...
 
virtual ElementItergetElements ()
 Returns an iterator to the element container.
 
virtual NodeItergetNodes ()
 Return an iter to all nodes that have been added to the subdomain.
 
virtual NodeItergetInternalNodeIter (void)
 Return an iterator to the internal nodes of the subdomain, nodes that are added using the addNode() command. More...
 
virtual NodeItergetExternalNodeIter (void)
 
virtual ElementgetElementPtr (int tag)
 
virtual NodegetNodePtr (int tag)
 
virtual int getNumElements (void) const
 Return the number of elements.
 
virtual int getNumNodes (void) const
 Returns the number of external and internal Nodes.
 
virtual int getNumSPs (void) const
 
virtual int getNumMPs (void) const
 
virtual int getNumLoadPatterns (void) const
 
virtual GraphgetElementGraph (void)
 Builds (if necessary) the domain elements graph and returns a reference to it. More...
 
virtual GraphgetNodeGraph (void)
 Builds (if necessary) the domain node graph and returns a reference to it. More...
 
virtual void setCommitTag (int newTag)
 Set the committed tag to newTag.
 
virtual void setCurrentTime (double newTime)
 Set the current time to newTime.
 
virtual void setCommittedTime (double newTime)
 Set the committed time to newTime.
 
virtual void applyLoad (double pseudoTime)
 Apply the loads for the given time pseudoTime. More...
 
virtual void setLoadConstant (void)
 Set all the loads as constant. More...
 
virtual int update (void)
 Updates the state of the domain. More...
 
virtual int update (double newTime, double dT)
 Updates domain state.
 
virtual int commit (void)
 invokes the base Domain classes commit() method. More...
 
virtual int revertToLastCommit (void)
 Return the domain to its last committed state. More...
 
virtual int revertToStart (void)
 Return the domain to its initial state and triggers the "restart" method for all the recorders. More...
 
virtual int barrierCheckIN (void)
 
virtual int barrierCheckOUT (int)
 
virtual int setRayleighDampingFactors (const RayleighDampingFactors &rF)
 Set Rayleigh damping factors.
 
virtual int addRecorder (Recorder &theRecorder)
 Adds a recorder to the model. More...
 
virtual int removeRecorders (void)
 Remove the recorders.
 
virtual void wipeAnalysis (void)
 
virtual void setDomainDecompAnalysis (DomainDecompositionAnalysis &theAnalysis)
 Sets the corresponding DomainDecompositionAnalysis object to be {theAnalysis}. More...
 
virtual int setAnalysisAlgorithm (EquiSolnAlgo &theAlgorithm)
 
virtual int setAnalysisIntegrator (IncrementalIntegrator &theIntegrator)
 
virtual int setAnalysisLinearSOE (LinearSOE &theSOE)
 
virtual int setAnalysisConvergenceTest (ConvergenceTest &theTest)
 
virtual void clearAnalysis (void)
 
virtual void domainChange (void)
 Sets a flag indicating that the integer returned in the next call to hasDomainChanged() must be incremented by \(1\). More...
 
virtual int getNumExternalNodes (void) const
 Returns the number of external nodes that have been successfully added to the subdomain as external nodes and have yet to be removed from the subdomain. More...
 
virtual const IDgetExternalNodes (void) const
 Returns an ID containing the tags of all nodes added to the subdomain as external nodes and have yet to be removed from the subdomain. More...
 
virtual int getNumDOF (void) const
 Returns the num of external dof associated with the subdomain. More...
 
virtual const MatrixgetTang (void)
 Return the Matrix obtained from invoking getTangent() on the DomainDecompositionAnalysis object. More...
 
virtual const VectorgetResistingForce (void) const
 Return the Vector obtained from invoking getCondensedRHS() on the DomainDecompositionAnalysis object. More...
 
virtual int computeTang (void)
 The method first starts a Timer object running. More...
 
virtual int computeResidual (void)
 The method first starts a Timer object running. More...
 
const VectorgetLastExternalSysResponse (void)
 Return the Vector obtained by calling getLastSysResponse() on the associated FE_Element. More...
 
virtual int computeNodalResponse (void)
 Set the nodal responses for the nodes in the subdomain. More...
 
virtual int newStep (double deltaT)
 
virtual int sendSelf (Communicator &)
 Send itself.
 
virtual int recvSelf (const Communicator &)
 Receive itself.
 
virtual double getCost (void)
 Return the current value of realCost. More...
 
virtual void Print (std::ostream &s, int flag=0) const
 Print stuff.
 
virtual double getNodeDisp (int nodeTag, int dof, int &errorFlag)
 Return the value of the dof component of displacement for the node with the tag being passed as parameter. More...
 
virtual int setMass (const Matrix &mass, int nodeTag)
 Set the mass matrix for the node identified by the argument.
 
- Public Member Functions inherited from XC::Shadow
 Shadow (Channel &theChannel, FEM_ObjectBroker &)
 Constructor. More...
 
 Shadow (Channel &theChannel, FEM_ObjectBroker &, ChannelAddress &theAddress)
 Constructor. More...
 
 Shadow (int actorType, FEM_ObjectBroker &, MachineBroker &, int compDemand)
 Constructor. More...
 
virtual int sendObject (MovableObject &theObject)
 Send object. More...
 
virtual int recvObject (MovableObject &theObject)
 Receive object. More...
 
virtual int sendMessage (const Message &theMessage)
 Receive message. More...
 
virtual int recvMessage (Message &theMessage)
 Send message. More...
 
virtual int sendMatrix (const Matrix &theMatrix)
 Send matrix. More...
 
virtual int recvMatrix (Matrix &theMatrix)
 Receive matrix. More...
 
virtual int sendVector (const Vector &theVector)
 Send vector. More...
 
virtual int recvVector (Vector &theVector)
 Receive vector. More...
 
virtual int sendID (const ID &theID)
 Send integer vector. More...
 
virtual int recvID (ID &theID)
 Receive integer vector. More...
 
ChannelAddressgetActorAddressPtr (void) const
 Return a pointer to the channel in the actors address space.
 
- Public Member Functions inherited from XC::ShadowActorBase
 ShadowActorBase (Channel &theChannel, FEM_ObjectBroker &)
 Constructor. More...
 
 ShadowActorBase (int actorType, FEM_ObjectBroker &myBroker, MachineBroker &theMachineBroker, int compDemand)
 Constructor. More...
 
void setCommitTag (int commitTag)
 Set the value for #commitTag.
 
int getCommitTag (void) const
 Return the #commitTag member.
 
ChannelgetChannelPtr (void) const
 Returns a pointer to the object channel theChannel.
 
virtual int barrierCheck (int result)
 barrier check.
 
- Public Member Functions inherited from XC::ObjectWithObjBroker
 ObjectWithObjBroker (FEM_ObjectBroker *)
 Object broker to use. More...
 
 ObjectWithObjBroker (FEM_ObjectBroker &)
 Constructor. Sets the broker.
 
FEM_ObjectBrokergetObjectBrokerPtr (void) const
 Returns a pointer to the broker #theBroker.
 
- Public Member Functions inherited from XC::Subdomain
 Subdomain (int tag, DataOutputHandler::map_output_handlers *oh, CommandEntity *owr)
 Constructor. More...
 
virtual ~Subdomain (void)
 Destructor.
 
virtual const NodegetNode (int tag) const
 Return a pointer to the node identified by the argument. More...
 
virtual NodegetNode (int tag)
 Return a pointer to the node identified by the argument. More...
 
virtual NodePtrsWithIDsgetNodePtrs (void)
 
virtual const NodePtrsWithIDsgetNodePtrs (void) const
 
virtual NodeItergetExternalNodeIter (void) const
 Return an itertor to the external nodes of the subdomain, nodes that have been added using the {addExternalNode(Node *)} method. More...
 
virtual int invokeChangeOnAnalysis (void)
 
virtual int commitState (void)
 Invokes commit() on itself.
 
virtual const MatrixgetTangentStiff (void)
 
virtual const MatrixgetInitialStiff (void)
 For this class does nothing but print an error message. More...
 
virtual const MatrixgetDamp (void)
 For this class does nothing but print an error message. More...
 
virtual const MatrixgetMass (void)
 For this class does nothing but print an error message. More...
 
virtual void zeroLoad (void)
 Zeroes the loads over the element. More...
 
virtual int addLoad (ElementalLoad *theLoad, double loadFactor)
 
virtual int addInertiaLoadToUnbalance (const Vector &accel)
 
virtual const VectorgetResistingForceIncInertia (void) const
 Returns the resisting force vector including inertia forces. More...
 
virtual bool isSubdomain (void)
 Return true. More...
 
void setFE_ElementPtr (FE_Element *theFE_Ele)
 Set the corresponding {FE_Element} to be that poited to by {theFEelePtr}. More...
 
virtual bool doesIndependentAnalysis (void)
 
- 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...
 
virtual BoolArray3d getNodePattern (void) const
 Return a grid of booleans, one for each of the element nodes. More...
 
std::vector< int > getIdxNodes (void) const
 Return the indexes of the nodes (used when creating VTK meshes). More...
 
virtual size_t getDimension (void) const
 Returns the element dimension (0, 1, 3 or 3).
 
virtual double getLength (bool initialGeometry=true) const
 Return the element length.
 
virtual double getArea (bool initialGeometry=true) const
 Return the element area.
 
virtual double getVolume (bool initialGeometry=true) const
 Return the element volume.
 
virtual void setIdNodes (const std::vector< int > &inodes)
 Set the nodes.
 
virtual void setIdNodes (const ID &inodes)
 Set the nodes.
 
virtual void setIdNode (const int &i, const int &inode)
 Set the i-th node.
 
int find (const Node *) const
 Returns the index of the node whose pointer is being passed as parameter. More...
 
void replaceNode (Node *, Node *)
 Replace the old node by the new one. More...
 
void setDomain (Domain *theDomain)
 Sets the domain for the element.
 
virtual const MatrixgetTangentStiff (void) const =0
 Return the tangent stiffness matrix. More...
 
virtual const MatrixgetInitialStiff (void) const =0
 
virtual const MatrixgetDamp (void) const
 Returns the damping matrix. More...
 
virtual const MatrixgetMass (void) const
 Returns the mass matrix. More...
 
virtual Matrix getMass (const Node *) const
 Returns the mass matrix corresponding to the node argument.
 
Matrix getTotalMass (void) const
 Returns the sum of the mass matrices corresponding to the nodes.
 
double getTotalMassComponent (const int &) const
 Return the mass matrix component for the DOF argument.
 
Matrix getNodeMatrixComponents (const Node *, const Matrix &) const
 Returns the components of the matrix relative to the node. More...
 
virtual void createInertiaLoad (const Vector &)
 Creates the inertia load that corresponds to the acceleration argument. More...
 
virtual int setRayleighDampingFactors (const RayleighDampingFactors &rF) const
 Set Rayleigh damping factors.
 
const VectorgetNodeResistingComponents (const size_t &, const Vector &) const
 Returns the generalized force of the element over the iNod-th node. More...
 
const VectorgetNodeResistingForce (const size_t &iNod) const
 Returns the generalized force of the element over the iNod-th node. More...
 
const VectorgetNodeResistingForceIncInertia (const size_t &iNod) const
 Returns the generalized force (including inertia forces) of the element over the node identified by the argument. More...
 
const VectorgetNodeResistingForce (const Node *) const
 Returns the generalized force (including inertia forces) of the element over the node identified by the argument. More...
 
const VectorgetNodeResistingForceIncInertia (const Node *) const
 Returns the generalized force (including inertia forces) of the element over the node identified by the argument. More...
 
Vector getEquivalentStaticLoad (int mode, const double &) const
 Returns the equivalent static load for the mode being passed as parameter and the acceleration that corresponding that mode. More...
 
Matrix getEquivalentStaticNodalLoads (int mode, const double &) const
 Returns the equivalent static load on each node for the mode being passed as parameter and the corresponding acceleration to the mode. More...
 
virtual ResponsesetResponse (const std::vector< std::string > &argv, Information &eleInformation)
 setResponse() is a method invoked to determine if the element will respond to a request for a certain of information. More...
 
virtual int getResponse (int responseID, Information &eleInformation)
 Obtain information from an analysis. More...
 
ResponsesetMaterialResponse (Material *, const std::vector< std::string > &, const size_t &, Information &)
 
virtual int addInertiaLoadSensitivityToUnbalance (const Vector &accel, bool tag)
 
virtual int setParameter (const std::vector< std::string > &argv, Parameter &param)
 Sets the value param to the parameter argv.
 
int setMaterialParameter (Material *, const std::vector< std::string > &, const size_t &, Parameter &)
 Set the value of a parameter of the material. More...
 
virtual int updateParameter (int parameterID, Information &info)
 Updates the parameter identified by parameterID with info.
 
virtual int activateParameter (int parameterID)
 Activates the parameter identified by parameterID.
 
virtual const VectorgetResistingForceSensitivity (int gradNumber)
 
virtual const MatrixgetInitialStiffSensitivity (int gradNumber)
 
virtual const MatrixgetDampSensitivity (int gradNumber)
 
virtual const MatrixgetMassSensitivity (int gradNumber)
 
virtual int commitSensitivity (int gradNumber, int numGrads)
 
virtual int addResistingForceToNodalReaction (bool inclInertia)
 Adds nodal reactions.
 
double MaxCooNod (int i) const
 Returns the maximum value of the i coordinate of the element nodes.
 
double MinCooNod (int i) const
 Returns the minimum value of the i coordinate of the element nodes.
 
const MatrixgetCooNodes (void) const
 Returns the coordinates of the nodes.
 
virtual Matrix getLocalAxes (bool initialGeometry=true) const
 Returns a matrix with the axes of the element as matrix rows [[x1,y1,z1],[x2,y2,z2],...·].
 
virtual Vector getBaseVector (size_t i, bool initialGeometry=true) const
 Returns a base vector in the direction of the local i-th axis from the i-th row of the matrix returned by getLocalAxes. More...
 
virtual Vector3d getBaseVector3d (size_t i, bool initialGeometry=true) const
 Returns a base vector in the direction of the local i-th axis from the i-th row of the matrix returned by getLocalAxes. More...
 
virtual Vector3d getIVector3d (bool initialGeometry=true) const
 Returns a vector in the direction of the local x axis from the first row of the matrix returned by getLocalAxes. More...
 
virtual Vector3d getJVector3d (bool initialGeometry=true) const
 Returns a vector in the direction of the local y axis from the second row of the matrix returned by getLocalAxes. More...
 
virtual Vector3d getKVector3d (bool initialGeometry=true) const
 Returns a vector in the direction of the local z axis from the third row of the matrix returned by getLocalAxes. More...
 
virtual Rect3d3dCooSys getCooSys (bool) const
 Returns the element coordinate system from the matrix returned by getLocalAxes. More...
 
Pos3d getPosNode (const size_t &i, bool initialGeometry=true) const
 Returns the position of the i-th node. More...
 
std::deque< Pos3dgetPosNodes (bool initialGeometry=true) const
 Returns the coordinates of the nodes.
 
virtual Pos3d getCenterOfMassPosition (bool initialGeometry=true) const
 Returns the coordinates of the center of gravity of the element.
 
Vector getCenterOfMassCoordinates (bool initialGeometry=true) const
 Returns the coordinates of the center of mass of the element.
 
Pos3dArray3d getPoints (const size_t &ni, const size_t &nj, const size_t &nk, bool initialGeometry=true)
 Returns a grid of points distributed along the line.
 
bool In (const GeomObj3d &, const double &factor=1.0, const double &tol=0.0) const
 
bool Out (const GeomObj3d &, const double &factor=1.0, const double &tol=0.0) const
 
bool In (const GeomObj2d &, const double &factor=1.0, const double &tol=0.0) const
 
bool Out (const GeomObj2d &, const double &factor=1.0, const double &tol=0.0) const
 
virtual double getDist2 (const Pos2d &p, bool initialGeometry=true) const
 Returns the squared distance from the element to the point being passed as parameter. More...
 
virtual double getDist (const Pos2d &p, bool initialGeometry=true) const
 Returns the the distance from the element to the point being passed as parameter. More...
 
virtual double getDist2 (const Pos3d &p, bool initialGeometry=true) const
 Returns the squared distance from the element to the point being passed as parameter. More...
 
virtual double getDist (const Pos3d &p, bool initialGeometry=true) const
 Returns the the distance from the element to the point being passed as parameter. More...
 
virtual Pos2d getProjection (const Pos2d &p, bool initialGeometry=true) const
 Return the projection of the argument on the element. More...
 
virtual Pos3d getProjection (const Pos3d &p, bool initialGeometry=true) const
 Return the projection of the argument on the element. More...
 
void resetTributaries (void) const
 Resets tributary areas of connected nodes.
 
void dumpTributaries (const std::vector< double > &) const
 Adds to the tributary magnitude of each node the vector being passed as parameter. More...
 
virtual void computeTributaryLengths (bool initialGeometry=true) const
 Computes the tributary lengths that corresponds to each node of the element.
 
virtual double getTributaryLength (const Node *) const
 Returns the tributary length corresponding to the node being passed as parameter. More...
 
virtual double getTributaryLengthByTag (const int &) const
 Returns the tributary length corresponding to the node which tag se pasa as parameter. More...
 
virtual void computeTributaryAreas (bool initialGeometry=true) const
 Compute tributary areas for each element node.
 
virtual double getTributaryArea (const Node *) const
 Returns the tributary area corresponding to the node.
 
virtual double getTributaryAreaByTag (const int &) const
 Returns the tributary area corresponding to the node.
 
virtual void computeTributaryVolumes (bool initialGeometry=true) const
 Computes the tributary volumes that corresponds to each node of the element.
 
virtual double getTributaryVolume (const Node *) const
 Returns the tributary volume corresponding to the node being passed as parameter. More...
 
virtual double getTributaryVolumeByTag (const int &) const
 Returns the tributary volume corresponding to the node which tag se pasa as parameter. More...
 
virtual ParticlePos3d getNaturalCoordinates (const Pos3d &, bool initialGeometry=true) const
 
virtual Vector getInterpolationFactors (const ParticlePos3d &) const
 Returns interpolation factors for a material point.
 
virtual Vector getInterpolationFactors (const Pos3d &) const
 Returns interpolation factors for a material point.
 
virtual int getVtkCellType (void) const
 Interfaz con VTK.
 
virtual const GaussModelgetGaussModel (void) const
 Returns the Gauss integration model of the element.
 
virtual NodesEdge getNodesEdge (const size_t &) const
 Returns the nodes of the element edge.
 
virtual int getEdgeNodes (const Node *, const Node *) const
 Returns the edge of the element that ends in the nodes being passed as parameters. More...
 
int getEdgeNodes (const int &, const int &) const
 Returns the edge of the element that ends in the nodes with the tags being passed as parameters. More...
 
virtual ID getEdgesNode (const Node *) const
 Returns the edges of the element that ends in the node being passed as parameter. More...
 
std::set< int > getEdgesNodes (const NodePtrSet &) const
 Returns the element edges that have both ends in the node set being passed as parameter. More...
 
ID getEdgesNodeByTag (const int &) const
 Returns the edges of the element that have an en in the node with the tag being passed as parameter. More...
 
virtual ID getLocalIndexNodesEdge (const size_t &i) const
 Returns the local indexes of the element nodes that lie over the i-th edge. More...
 
virtual std::set< std::string > getMaterialNames (void) const
 Return the names of the material(s) of the element.
 
boost::python::list getMaterialNamesPy (void) const
 Return the names of the material(s) of the element in a Python list.
 
virtual boost::python::list getValuesAtNodes (const std::string &, bool silent=false) const
 Return a python list with the values of the argument property at element nodes. More...
 
std::set< SetBase * > get_sets (void) const
 Returns the sets to which the element belongs.
 
void add_to_sets (std::set< SetBase *> &)
 Adds the element to the sets being passed as parameters.
 
- Public Member Functions inherited from XC::MeshComponent
 MeshComponent (int classTag)
 Constructor.
 
 MeshComponent (int tag, int classTag)
 Constructor.
 
- Public Member Functions inherited from XC::ContinuaReprComponent
 ContinuaReprComponent (int classTag)
 
 ContinuaReprComponent (int tag, int classTag)
 
virtual const bool isDead (void) const
 Return true if the component is not active.
 
virtual const bool isAlive (void) const
 Return true if the component is active.
 
virtual void kill (void)
 Deactivates the component.
 
virtual void alive (void)
 Activates the component.
 
- Public Member Functions inherited from XC::DomainComponent
 ~DomainComponent (void)
 Destructor.
 
size_t getIdx (void) const
 Returns the index of the object (to be used in VTK arrays).
 
virtual DomaingetDomain (void) const
 Returns a pointer to the enclosing domain. More...
 
const PreprocessorgetPreprocessor (void) const
 Returns (if possible) a pointer to the preprocessor.
 
PreprocessorgetPreprocessor (void)
 Return (if possible) a pointer to the preprocessor.
 
const LoadPatterngetCurrentLoadPattern (void) const
 Return the current load pattern.
 
LoadPatterngetCurrentLoadPattern (void)
 Return the current load pattern.
 
void set_index (const size_t &i)
 Set the index for the object (see numera in Set). More...
 
boost::python::dict getPyDict (void) const
 Return a Python dictionary with the object members values.
 
void setPyDict (const boost::python::dict &)
 Set the values of the object members from a Python dictionary.
 
- Public Member Functions inherited from XC::TaggedObject
 TaggedObject (int tag, CommandEntity *owr=nullptr)
 Constructor. More...
 
void assignTag (int newTag)
 Set tag (to be called from Python interface).
 
int getTag (void) const
 Returns the tag associated with the object.
 
boost::python::dict getPyDict (void) const
 Return a Python dictionary with the object members values.
 
void setPyDict (const boost::python::dict &)
 Set the values of the object members from a Python dictionary.
 
- Public Member Functions inherited from CommandEntity
 CommandEntity (CommandEntity *owr=nullptr)
 Default constructor.
 
CommandEntityOwner (void)
 Return a pointer to the object owner.
 
const CommandEntityOwner (void) const
 Return un puntero al objeto propietario de ESTE.
 
const StandardOutputWrappergetStandardOutputWrapper (void) const
 Return the regular output stream wrapper.
 
StandardOutputWrappergetStandardOutputWrapper (void)
 Return the regular output stream wrapper.
 
const std::string & getLogFileName (void) const
 Returns log file name.
 
void setLogFileName (const std::string &)
 Sets log file name.
 
const std::string & getErrFileName (void) const
 Returns err file name.
 
void setErrFileName (const std::string &)
 Sets error file name.
 
const std::string & getOutputFileName (void) const
 Returns regular output file name.
 
void setOutputFileName (const std::string &)
 Sets regular output file name.
 
boost::python::object evalPy (boost::python::object dict, const std::string &)
 Return the Python object that results from evaluating the argument.
 
boost::python::object execPy (boost::python::object dict, const std::string &)
 Return the Python objects that results from executing the code in the string argument.
 
boost::python::object execFilePy (boost::python::object dict, const std::string &)
 Return the Python object that results from executing the code in the file.
 
- Public Member Functions inherited from EntityWithProperties
 EntityWithProperties (EntityWithProperties *owr=nullptr)
 Default constructor.
 
virtual bool operator== (const EntityWithProperties &) const
 Comparison operator.
 
void clearPyProps (void)
 Clear python properties map.
 
bool hasPyProp (const std::string &)
 Returns true if property exists.
 
boost::python::object getPyProp (const std::string &str)
 Return the Python object with the name being passed as parameter.
 
void setPyProp (std::string str, boost::python::object val)
 Sets/appends a value tho the Python object's dictionary.
 
void copyPropsFrom (const EntityWithProperties &)
 Copy the properties from the argument.
 
boost::python::list getPropNames (void) const
 Return the names of the object properties weightings.
 
const PythonDict & getPropertiesDict (void) const
 Return a std::map container with the properties of the object.
 
- Public Member Functions inherited from EntityWithOwner
 EntityWithOwner (EntityWithOwner *owr=nullptr)
 Default constructor.
 
 EntityWithOwner (const EntityWithOwner &)
 Copy constructor.
 
EntityWithOwneroperator= (const EntityWithOwner &)
 Assignment operator.
 
virtual bool operator== (const EntityWithOwner &) const
 Comparison operator.
 
virtual ~EntityWithOwner (void)
 Virtual destructor.
 
virtual std::string getClassName (void) const
 Returns demangled class name.
 
void set_owner (EntityWithOwner *owr)
 Assigns the owner of the object.
 
EntityWithOwnerOwner (void)
 
const EntityWithOwnerOwner (void) const
 
- Public Member Functions inherited from XC::MovableObject
 MovableObject (int classTag, int dbTag)
 Constructor. More...
 
 MovableObject (int classTag)
 Constructor. More...
 
 MovableObject (const MovableObject &)
 Copy constructor. Doesn't copy the dbTag.
 
MovableObjectoperator= (const MovableObject &)
 Assignment operator. Doesn't copy the dbTag.
 
int getClassTag (void) const
 Return the class identifier.
 
int getDbTag (void) const
 Return the object identifier in the database.
 
int getDbTag (Communicator &)
 Return the object identifier in the database.
 
void setDbTag (int dbTag)
 Sets the object identifier in the database.
 
void setDbTag (Communicator &)
 Sets the object identifier in the database if not already set. More...
 
virtual int 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.
 
- Public Member Functions inherited from XC::Domain
 Domain (CommandEntity *owr, DataOutputHandler::map_output_handlers *oh)
 Constructor. More...
 
 Domain (CommandEntity *owr, int numNods, int numElements, int numSPs, int numMPs, int numLPatterns, int numNLockers, DataOutputHandler::map_output_handlers *oh)
 Constructor. More...
 
virtual ~Domain (void)
 Destructor. More...
 
virtual bool addMRMFreedom_Constraint (MRMFreedom_Constraint *)
 Adds to the domain a multi-freedom multi-retained node constraint.
 
virtual bool isLoadPatternActive (const LoadPattern *) const
 Return true if the load pattern is already added to the domain. More...
 
virtual bool addNodeLocker (NodeLocker *)
 Appends the node locker object to the domain.
 
virtual bool addLoadCombination (LoadCombination *)
 Adds to the domain the load combination being passed as parameter.
 
virtual bool addParameter (Parameter *)
 
void setNodeReactionException (const int &)
 Sets the exception for node reactions checking (see Domain::checkNodalReactions).
 
bool checkNodalReactions (const double &)
 Check that al free nodes have zero reaction.
 
virtual bool removeSFreedom_Constraint (int theNode, int theDOF, int loadPatternTag)
 Remove the single freedom constraint from the load pattern identified by the argument. More...
 
virtual bool removeMRMFreedom_Constraint (int tag)
 Removes from domain the multi-freedom multi-retained node constraint identified by the argument. More...
 
virtual bool removeNodeLocker (int nlTag)
 Remove from domain el.
 
bool removeLoadPattern (LoadPattern *lp)
 Remove from domain the load pattern being passed as parameter.
 
bool removeAllLoadPatterns (void)
 Remove from all load patterns from domain.
 
bool removeNodeLocker (NodeLocker *lp)
 Remove from domain the load pattern being passed as parameter.
 
void removeLoadCombination (LoadCombination *comb)
 Removes from the domain the load combination being passed as parameter. More...
 
void removeAllLoadCombinations (void)
 Remove all the load combinations currently in activeCombinations.
 
void removeAllLoadsAndCombinations (void)
 Remove all the load patterns and load combinations currently in this domain. More...
 
void removeLPs (void)
 Remove all the load patterns from this domain.
 
void removeNLs (void)
 Remove all node lockers from domain.
 
virtual void clearDOF_GroupPtr (void)
 Clears the pointers to DOF groups.
 
virtual MeshgetMesh (void)
 Returns a reference to the domain mesh.
 
virtual const MeshgetMesh (void) const
 Returns a reference to the domain mesh.
 
virtual ConstrContainergetConstraints (void)
 Returns domain constraints.
 
virtual const ConstrContainergetConstraints (void) const
 Returns domain constraints.
 
std::string getCurrentCombinationName (void) const
 Return the name of the current load combination.
 
std::string getCurrentLoadCaseDescription (void) const
 Return the name of the current load case.
 
bool existElement (int tag)
 Returns true if the element identified by the tag being passed as parameter already exists in the domain. More...
 
virtual ElementgetElement (int tag)
 Return a pointer to the element identified by the argument. More...
 
virtual const ElementgetElement (int tag) const
 Returns a const pointer to the element identified by the argument. More...
 
bool existNode (int tag)
 Return true if the mesh has a node with this tag. More...
 
virtual ParametergetParameter (int tag)
 Return a pointer to the parameter identified by the argument. More...
 
virtual const ParametergetParameter (int tag) const
 Return a pointer to the parameter identified by the argument. More...
 
const PseudoTimeTrackergetTimeTracker (void) const
 Return a constant reference to the internal time tracker.
 
double getCommittedTime (void) const
 Return the committed value of the pseudo-time.
 
double getCurrentTime (void) const
 Return the current value fo the pseudo-time.
 
int getCurrentGeoTag (void) const
 
virtual int getCommitTag (void) const
 
virtual const VectorgetPhysicalBounds (void)
 
virtual void setTime (double newTime)
 
virtual int initialize (void)
 Initialize mesh.
 
void resetLoadCase (void)
 Prepares the domain to solve for a new load pattern.
 
int getNumModes (void) const
 Return the number of computed eigenvalues.
 
virtual int setEigenvalues (const Vector &)
 Sets eigenvalues.
 
virtual const double & getEigenvalue (int) const
 Return the eigenvalue of the i-th mode.
 
double getAngularFrequency (int) const
 Return the angular frequency of the i-th mode.
 
double getPeriod (int) const
 Return the period of the i-th mode.
 
double getFrequency (int) const
 Return the frequency of the i-th mode.
 
virtual const VectorgetEigenvalues (void) const
 Return the eigenvalues vector.
 
boost::python::list getEigenvaluesPy (void) const
 Returns a Python list with the computed eigenvalues for each mode.
 
Vector getAngularFrequencies (void) const
 Returns a vector with the computed angular frequencies (for each mode).
 
Vector getPeriods (void) const
 Returns a vector with the computed periods (for each mode).
 
Vector getFrequencies (void) const
 Returns a vector with the computed frequencies (for each mode).
 
virtual int setModalParticipationFactors (const Vector &)
 Sets the values of the modal participation factors.
 
virtual const double & getModalParticipationFactor (int mode) const
 Return the modal participation factor of the i-th mode.
 
virtual const VectorgetModalParticipationFactors (void) const
 Return the modal participation factors.
 
const double getEffectiveModalMass (int mode) const
 Return the effective modal mass of the i-th mode.
 
Vector getEffectiveModalMasses (void) const
 Return the effective modal masses for each mode.
 
double getTotalEffectiveModalMass (void) const
 Return the total effective modal mass.
 
Matrix getTotalMass (void) const
 Return the total mass matrix.
 
double getTotalMassComponent (const int &) const
 Return the total mass matrix component for the DOF argument.
 
virtual int hasDomainChanged (void)
 Returns true if the model has changed. More...
 
virtual void setDomainChangeStamp (int newStamp)
 Set the domain stamp to be newStamp. More...
 
virtual int addRegion (MeshRegion &theRegion)
 Adds a region.
 
virtual MeshRegiongetRegion (int region)
 Returns a pointer to the region identified by the argument.
 
const PreprocessorgetPreprocessor (void) const
 Returns (if possible) a pointer to the preprocessor.
 
PreprocessorgetPreprocessor (void)
 Returns (if possible) a pointer to the preprocessor.
 
virtual int calculateNodalReactions (bool inclInertia, const double &)
 Calculate nodal reaction forces and moments.
 
- Public Member Functions inherited from XC::ObjWithRecorders
 ObjWithRecorders (CommandEntity *owr, DataOutputHandler::map_output_handlers *oh=nullptr)
 
- Public Member Functions inherited from XC::RecorderContainer
 RecorderContainer (DataOutputHandler::map_output_handlers *oh=nullptr)
 
virtual ~RecorderContainer (void)
 Destructor.
 
RecordernewRecorder (const std::string &, DataOutputHandler *oh=nullptr)
 Read a Recorder object from file.
 
recorder_iterator recorder_begin (void)
 
const_recorder_iterator recorder_begin (void) const
 
recorder_iterator recorder_end (void)
 
const_recorder_iterator recorder_end (void) const
 
virtual int record (int track, double timeStamp=0.0)
 To invoke {record(cTag, timeStamp)} on any Recorder objects which have been added. More...
 
void restart (void)
 To invoke {restart()} on any Recorder objects which have been added. More...
 
void setLinks (Domain *dom)
 Asigna el domain a los recorders.
 
void SetOutputHandlers (DataOutputHandler::map_output_handlers *oh)
 Set the outputhandlers container.
 

Protected Member Functions

virtual int buildMap (void) const
 
virtual int buildEleGraph (Graph &theEleGraph)
 Builds the element graph. More...
 
virtual int buildNodeGraph (Graph &theNodeGraph)
 Builds the node graph. More...
 
- Protected Member Functions inherited from XC::Subdomain
FE_ElementgetFE_ElementPtr (void)
 Return a pointer to the last FE_Element set using {setFE_ElementPtr}. More...
 
DomainDecompositionAnalysisgetDDAnalysis (void)
 
- Protected Member Functions inherited from XC::Element
virtual ElemPtrArray3d put_on_mesh (const NodePtrArray3d &, meshing_dir) const
 Places the element on the mesh.
 
virtual ElemPtrArray3d sew (const SetEstruct &f1, const SetEstruct &f2) const
 
const VectorgetRayleighDampingForces (void) const
 Returns element Rayleigh damping forces.
 
const Materialget_material_ptr (const std::string &) const
 Return a pointer to the material that corresponds to the name. More...
 
int sendData (Communicator &comm)
 Sends object members through the communicator argument.
 
int recvData (const Communicator &comm)
 Receives object members through the communicator argument.
 
- Protected Member Functions inherited from XC::MeshComponent
void setup_matrices (std::deque< Matrix > &, const int &) const
 Initializes the matrix container.
 
int sendIdsLabels (int posDbTag, Communicator &)
 Send labelsthrough the communicator argument.
 
int recvIdsLabels (int posDbTag, const Communicator &)
 Receive labels through the communicator argument.
 
int sendData (Communicator &)
 Send members through the communicator argument.
 
int recvData (const Communicator &)
 Receives members through the communicator argument.
 
- Protected Member Functions inherited from XC::ContinuaReprComponent
int sendData (Communicator &)
 Send members through the communicator argument.
 
int recvData (const Communicator &)
 Receives members through the communicator argument.
 
- Protected Member Functions inherited from XC::DomainComponent
 DomainComponent (int tag, int classTag)
 Constructor. More...
 
int sendData (Communicator &)
 Send object members through the communicator argument.
 
int recvData (const Communicator &)
 Receive object members through the communicator argument.
 
- Protected Member Functions inherited from XC::TaggedObject
void setTag (int newTag)
 Set tag. More...
 
- Protected Member Functions inherited from CommandEntity
template<class T >
void string_to (T &, const std::string &) const
 
- Protected Member Functions inherited from XC::Domain
virtual Domainget_domain_ptr (void)
 
void free_mem (void)
 
DbTagDatagetDbTagData (void) const
 Returns a vector to store the dbTags de los miembros of the clase. More...
 
int sendData (Communicator &comm)
 Send data through the communicator argument.
 
int recvData (const Communicator &comm)
 Receive data through the communicator argument.
 
- Protected Member Functions inherited from XC::RecorderContainer
int sendData (Communicator &comm)
 
int recvData (const Communicator &comm)
 
size_t getNumRecorders (void) const
 Returns the number of recorders already defined.
 

Additional Inherited Members

- Public Types inherited from XC::Element
typedef std::vector< const Node * > NodesEdge
 Nodes on an element edge. More...
 
- Public Types inherited from EntityWithProperties
typedef std::map< std::string, boost::python::object > PythonDict
 
- Public Types inherited from XC::RecorderContainer
typedef std::list< Recorder * > lista_recorders
 
typedef lista_recorders::iterator recorder_iterator
 
typedef lista_recorders::const_iterator const_recorder_iterator
 
- 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 Member Functions inherited from CommandEntity
static void resetStandardOutput (void)
 Reset the standard output streams to its defaults buffers.
 
- Static Public Member Functions inherited from EntityWithOwner
static int getVerbosityLevel (void)
 Get the value of the verbosity level.
 
static void setVerbosityLevel (const int &)
 Set the value of the verbosity level.
 
- Static Public Member Functions inherited from XC::Domain
static void setDeadSRF (const double &)
 Assigns Stress Reduction Factor for element deactivation.
 
- Static Public Attributes inherited from XC::Element
static double dead_srf = 1e-6
 Stress reduction factor for foozen elements.
 
- Static Protected Member Functions inherited from CommandEntity
static CommandEntityentcmd_cast (boost::any &data)
 
- Protected Attributes inherited from XC::ShadowActorBase
ChanneltheChannel
 Communication channel to use.
 
- Protected Attributes inherited from XC::ObjectWithObjBroker
FEM_ObjectBrokertheBroker
 
- Protected Attributes inherited from XC::Subdomain
bool mapBuilt
 
ID map
 
Vector mappedVect
 
Matrix mappedMatrix
 
TaggedObjectStorage * internalNodes
 
TaggedObjectStorage * externalNodes
 
- Protected Attributes inherited from XC::Element
Vector load
 vector for applied nodal loads.
 
RayleighDampingFactors rayFactors
 Rayleigh damping factors.
 
Matrix Kc
 pointer to hold last committed matrix if needed for rayleigh damping
 
- Protected Attributes inherited from XC::MeshComponent
int index
 Index for VTK arrays.
 
LabelContainer labels
 Label container.
 
- Static Protected Attributes inherited from EntityWithOwner
static int verbosity = 1
 Object that owns THIS ONE. More...
 

Detailed Description

Local representation of a remote subdomain.

Member Function Documentation

◆ addElementalLoad()

bool XC::ShadowSubdomain::addElementalLoad ( ElementalLoad load,
int  loadPatternTag 
)
virtual

Adds a load over element to the pattern.

To add the elemental load theld to the LoadPattern in the domain whose tag is given by loadPatternTag. If {_DEBUG} is defines, checks to see that corresponding element exists in the domain. A pointer to the LoadPattern is obtained from the LoadPattern container and the load is added to LoadPattern by invoking {addElementalLoad(theLd)} on the LoadPattern object. The domain is responsible for invoking {setDomain(this)} on the load. The call returns true if the load was added, otherwise a warning is raised and and {false} is returned.

Parameters
loadload over element.
loadPatternTagload pattern identifier.

Reimplemented from XC::Domain.

◆ addExternalNode()

bool XC::ShadowSubdomain::addExternalNode ( Node thePtr)
virtual

A Method to add the node pointed to by the argument.

A Method to add the node pointed to by thePtr to the Subdomain. This node is an external node to the subdomain and is returned in calls to getExternalNodes() and {getNodes()}. A DummyNode is created and added to the external nodes storage object. Invokes setDomain(this)} on the DummyNode and {domainChanged() on itself.

Reimplemented from XC::Subdomain.

◆ addLoadPattern()

bool XC::ShadowSubdomain::addLoadPattern ( LoadPattern lp)
virtual

Appends the load pattern to the domain.

To add the LoadPattern thePattern to the domain. The load is added to domain by the domain invoking {addComponent(theLd)} on the container for the LoadPatterns. The domain is responsible for invoking {setDomain(this)} on the load. The call returns true if the load was added, otherwise a warning is raised and false is returned.

Parameters
lppointer to the load pattern to ask for.

Reimplemented from XC::Domain.

◆ addMFreedom_Constraint()

bool XC::ShadowSubdomain::addMFreedom_Constraint ( MFreedom_Constraint mpConstraint)
virtual

Adds to the domain a multi-freedom constraint.

To add the multiple point constraint pointed to by theMPptr, to the domain. In addition the domain always checks to ensure that no other MP_Constraint with a similar tag exists in the domain. If the checks are successful, the constraint is added to domain by the domain invoking {addComponent(theMPptr)} on the container for the MP_Constraints. The domain then invokes {setDomain(this)} on the constraint and domainChange() on itself. The call returns {true} if the constraint was added, otherwise a warning is raised and false is returned.

Reimplemented from XC::Domain.

◆ addNodalLoad()

bool XC::ShadowSubdomain::addNodalLoad ( NodalLoad load,
int  loadPatternTag 
)
virtual

Appends a nodal load to the pattern being passed as parameter.

To add the nodal load theld to the LoadPattern in the domain whose tag is given by loadPatternTag. If {_DEBUG} is defines, checks to see that corresponding node exists in the domain. A pointer to the LoadPattern is obtained from the LoadPattern container and the load is added to LoadPattern by invoking {addNodalLoad(theLd)} on the LoadPattern object. The domain is responsible for invoking {setDomain(this)} on the load. The call returns true if the load was added, a warning is raised and and {false} is returned.

Parameters
loadload over node.
loadPatternTagload pattern identifier.

Reimplemented from XC::Domain.

◆ addNode()

bool XC::ShadowSubdomain::addNode ( Node node)
virtual

Method to add a node to the subdomain.

A Method to add the node pointed to by node to the Subdomain. This node is an internal node to the domain and is returned in calls to getNodes()} and {getInternalNodes(). Invokes setDomain(this)} on the Node and {domainChanged() on itself.

Reimplemented from XC::Subdomain.

◆ addRecorder()

int XC::ShadowSubdomain::addRecorder ( Recorder theRecorder)
virtual

Adds a recorder to the model.

To add a recorder object theRecorder to the domain. {record(commitTag)} is invoked on each commit(). The pointers to the recorders are stored in an array which is resized on each invocation of this method.

Reimplemented from XC::Domain.

◆ addSFreedom_Constraint()

bool XC::ShadowSubdomain::addSFreedom_Constraint ( SFreedom_Constraint spConstraint)
virtual

Adds a single freedom constraint to the domain.

To add the single point constraint pointed to by spConstraint to the domain. In addition the container always checks to ensure that no other constraint with a similar tag exists in the domain. The domain then invokes setDomain(this) on the constraint and domainChange() on itself.

Reimplemented from XC::Domain.

◆ applyLoad()

void XC::ShadowSubdomain::applyLoad ( double  timeStep)
virtual

Apply the loads for the given time pseudoTime.

To apply the loads for the given time pseudoTime. The domain first clears the current load at all nodes and elements, done by invoking zeroUnbalancedLoad()} on each node and {zeroLoad() on each element. The domain then invokes {applyLoad(pseudoTime)} on all LoadPatterns which have been added to the domain. The domain will then invoke {applyConstraint(pseudoTime)} on all the constraints in the single and multi point constraint containers. Finally the domain sets its current time to be {pseudoTime}.

Reimplemented from XC::Domain.

◆ buildEleGraph()

int XC::ShadowSubdomain::buildEleGraph ( Graph theEleGraph)
protectedvirtual

Builds the element graph.

A method which will cause the domain to discard the current element graph and build a new one based on the element connectivity. Returns \(0\) if successful otherwise \(-1\) is returned along with an error message.

Reimplemented from XC::Domain.

◆ buildNodeGraph()

int XC::ShadowSubdomain::buildNodeGraph ( Graph theNodeGraph)
protectedvirtual

Builds the node graph.

A method which will cause the domain to discard the current node graph and build a new one based on the node connectivity. Returns \(0\) if successful otherwise \(-1\) is returned along with an error message.

Reimplemented from XC::Domain.

◆ clearAll()

void XC::ShadowSubdomain::clearAll ( void  )
virtual

Removes all components from domain (nodes, elements, loads & constraints).

To remove all the components from the model and invoke the destructor on these objects. First clearAll() is invoked on all the LoadPattern objects. Then the domain object invokes {clearAll()} on its container objects. In addition the destructor for each Recorder object that has been added to the domain is invoked. In addition the current time and load factor are set to \(0\), and the box bounding the domain is set to the box enclosing the origin.

GENERAL NOTE ON REMOVAL OF COMPONENTS: downward casts (while bad) are o.k. as only the type of components can be added to the storage objects, e.g. only elements can be added to theElements therefore casting a DomainComponent from theElements to an Element is o.k.

Reimplemented from XC::Subdomain.

◆ commit()

int XC::ShadowSubdomain::commit ( void  )
virtual

invokes the base Domain classes commit() method.

It then goes through all the Nodes in the Subdomain, invoking commitState() on the Nodes.

Reimplemented from XC::Subdomain.

◆ computeNodalResponse()

int XC::ShadowSubdomain::computeNodalResponse ( void  )
virtual

Set the nodal responses for the nodes in the subdomain.

To set the nodal responses for the nodes in the subdomain. Returns the result of invoking computeInternalResponse() on the DomainDecomposition analysis object associated with the subdomain.

Reimplemented from XC::Subdomain.

◆ computeResidual()

int XC::ShadowSubdomain::computeResidual ( void  )
virtual

The method first starts a Timer object running.

formResidual(), is then invoked on the DomainDecompositionAnalysis object. The Timer is then stopped and the real time is added to the realCost. Returns the result of invoking formResidual.

Reimplemented from XC::Subdomain.

◆ computeTang()

int XC::ShadowSubdomain::computeTang ( void  )
virtual

The method first starts a Timer object running.

formTang(), is then invoked on the DomainDecompositionAnalysis object. The Timer is then stopped and the real time is added to the realCost. Returns the result of invoking formTang.

Reimplemented from XC::Subdomain.

◆ domainChange()

void XC::ShadowSubdomain::domainChange ( void  )
virtual

Sets a flag indicating that the integer returned in the next call to hasDomainChanged() must be incremented by \(1\).

Sets a flag indicating that the integer returned in the next call to hasDomainChanged() must be incremented by \(1\). This method is invoked whenever a Node, Element or Constraint object is added to the domain.

Reimplemented from XC::Domain.

◆ getCost()

double XC::ShadowSubdomain::getCost ( void  )
virtual

Return the current value of realCost.

Returns the current value of realCost, resetting the value of realCost to be 0.0. The value of realCost is added to when computeTang() and computeREsidual are invoked on the Subdomain.

Reimplemented from XC::Subdomain.

◆ getElementGraph()

XC::Graph & XC::ShadowSubdomain::getElementGraph ( void  )
virtual

Builds (if necessary) the domain elements graph and returns a reference to it.

Return the current element graph (the connectivity of the elements in the mesh). If the eleChangeFlag has been set to true the method will invoke {buildEleGraph(theEleGraph)} on itself before returning the graph. The vertices in the element graph are to be labeled \(0\) through \(numEle-1\). The vertices references contain the elemental tags.

Reimplemented from XC::Domain.

◆ getExternalNodes()

const XC::ID & XC::ShadowSubdomain::getExternalNodes ( void  ) const
virtual

Returns an ID containing the tags of all nodes added to the subdomain as external nodes and have yet to be removed from the subdomain.

Reimplemented from XC::Subdomain.

◆ getInternalNodeIter()

XC::NodeIter & XC::ShadowSubdomain::getInternalNodeIter ( void  )
virtual

Return an iterator to the internal nodes of the subdomain, nodes that are added using the addNode() command.

Reimplemented from XC::Subdomain.

◆ getLastExternalSysResponse()

const XC::Vector & XC::ShadowSubdomain::getLastExternalSysResponse ( void  )
virtual

Return the Vector obtained by calling getLastSysResponse() on the associated FE_Element.

Reimplemented from XC::Subdomain.

◆ getNodeDisp()

double XC::ShadowSubdomain::getNodeDisp ( int  nodeTag,
int  dof,
int &  errorFlag 
)
virtual

Return the value of the dof component of displacement for the node with the tag being passed as parameter.

Parameters
nodeTagnode identifier.
dofcomponent of the displacement.
errorFlagerror indicator.

Reimplemented from XC::Domain.

◆ getNodeGraph()

XC::Graph & XC::ShadowSubdomain::getNodeGraph ( void  )
virtual

Builds (if necessary) the domain node graph and returns a reference to it.

Return the current node graph (the connectivity of the nodes in the mesh). If the nodeChangeFlag has been set to true the will invoke {buildNodeGraph(theNodeGraph)} on itself before returning the graph. The vertices in the node graph are to be labeled \(0\) through \(numNode-1\). The Vertices references contain the nodal tags.

Reimplemented from XC::Domain.

◆ getNumDOF()

int XC::ShadowSubdomain::getNumDOF ( void  ) const
virtual

Returns the num of external dof associated with the subdomain.

Returns the num of external dof associated with the subdomain, the number returned is the result of invoking getNumExternalEqn() on the DomainDecompAnalysis object associated with the Subdomain. If no Analysis yet associated with the Subdomain \(0\) is returned.

Reimplemented from XC::Subdomain.

◆ getNumExternalNodes()

int XC::ShadowSubdomain::getNumExternalNodes ( void  ) const
virtual

Returns the number of external nodes that have been successfully added to the subdomain as external nodes and have yet to be removed from the subdomain.

Reimplemented from XC::Subdomain.

◆ getResistingForce()

const XC::Vector & XC::ShadowSubdomain::getResistingForce ( void  ) const
virtual

Return the Vector obtained from invoking getCondensedRHS() on the DomainDecompositionAnalysis object.

Reimplemented from XC::Subdomain.

◆ getTang()

const XC::Matrix & XC::ShadowSubdomain::getTang ( void  )
virtual

Return the Matrix obtained from invoking getTangent() on the DomainDecompositionAnalysis object.

Reimplemented from XC::Subdomain.

◆ removeLoadPattern()

bool XC::ShadowSubdomain::removeLoadPattern ( int  tag)
virtual

Remove from domain el load pattern identified by the argument.

To remove the LoadPattern whose tag is given by tag from the domain. The domain achieves this by invoking {removeComponent(tag, numSPs)} on the container for the constraints. If the LoadPattern exists, the domain then iterates through the loads and constraints of the LoadPattern invoking {setDomain(nullptr)} on these objects. Returns \(0\) if the load was not in the domain, otherwise returns a pointer to the load that was removed. Invokes {setDomain(0)} on the load case before it is returned.

Parameters
tagidentifier of the load pattern.

Reimplemented from XC::Domain.

◆ removeMFreedom_Constraint()

bool XC::ShadowSubdomain::removeMFreedom_Constraint ( int  tag)
virtual

Removes from domain the multi-freedom constraint identified by the argument.

To remove the MP_Constraint whose tag is given by tag from the domain. The domain achieves this by invoking {removeComponent(tag)} on the container for the multi point constraints. Returns \(0\) if the constraint was not in the domain, otherwise the domain invokes {setDomain(nullptr)} on the constraint and domainChange() on itself before a pointer to the constraint is returned.

Parameters
tagidentifier of the constraint.

Reimplemented from XC::Domain.

◆ removeNode()

bool XC::ShadowSubdomain::removeNode ( int  tag)
virtual

Remove a node from the subdomain.

To remove a Node whose tag is given by tag from the Subdomain. Returns \(0\) if the Node is not in the Subdoamin, otherwise it removes the pointer to the node from the storage object, invokes domainChange() on itself, and returns the pointer to the Node. If the Node is external, the destructor is called on the DummyNode. Invokes domainChanged() on itself.

Reimplemented from XC::Subdomain.

◆ removeSFreedom_Constraint() [1/2]

bool XC::ShadowSubdomain::removeSFreedom_Constraint ( int  tag)
virtual

Removes from domain the single freedom constraint identified by the argument.

Parameters
tagidentifier of the single freedom constraint.

Reimplemented from XC::Domain.

◆ removeSFreedom_Constraint() [2/2]

bool XC::ShadowSubdomain::removeSFreedom_Constraint ( int  singleFreedomTag,
int  loadPattern 
)
virtual

Removes from domain the single freedom constraint being passed as parameter.

Parameters
singleFreedomTagSingle freedom identifier.
loadPatternLoad pattern identifier.

Reimplemented from XC::Domain.

◆ revertToLastCommit()

int XC::ShadowSubdomain::revertToLastCommit ( void  )
virtual

Return the domain to its last committed state.

To return the domain to the state it was in at the last commit. The domain invokes revertToLastCommit() on all nodes and elements in the domain. The domain sets its current loadFactor and time stamp to be equal to the last committed values. The domain decrements the current commitTag by \(1\). Finally it invokes applyLoad() on itself with the current time.

Reimplemented from XC::Subdomain.

◆ revertToStart()

int XC::ShadowSubdomain::revertToStart ( void  )
virtual

Return the domain to its initial state and triggers the "restart" method for all the recorders.

Reimplemented from XC::Subdomain.

◆ setDomainDecompAnalysis()

void XC::ShadowSubdomain::setDomainDecompAnalysis ( DomainDecompositionAnalysis theNewAnalysis)
virtual

Sets the corresponding DomainDecompositionAnalysis object to be {theAnalysis}.

Reimplemented from XC::Subdomain.

◆ setLoadConstant()

void XC::ShadowSubdomain::setLoadConstant ( void  )
virtual

Set all the loads as constant.

To set the loads in the LoadPatterns to be constant. The domain achieves this by invoking setLoadConstant() on all the LoadPatterns which have been added to the domain. Note that LoadPatterns added after this method has been invoked will not be constant until this method is invoked again.

Reimplemented from XC::Domain.

◆ update()

int XC::ShadowSubdomain::update ( void  )
virtual

Updates the state of the domain.

Called by the AnalysisModel to update the state of the domain. Iterates over all the elements of the Domain and invokes {update()}.

Reimplemented from XC::Subdomain.


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