xc
|
Domain (mesh and boundary conditions) of the finite element model. More...
#include <Domain.h>
Public Member Functions | |
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 | addElement (Element *) |
Adds to the domain the element being passed as parameter. | |
virtual bool | addNode (Node *) |
Adds to the domain the node being passed as parameter. | |
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 | addMRMFreedom_Constraint (MRMFreedom_Constraint *) |
Adds to the domain a multi-freedom multi-retained node constraint. | |
virtual bool | addLoadPattern (LoadPattern *) |
Appends the load pattern 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. | |
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 | addSFreedom_Constraint (SFreedom_Constraint *, int loadPatternTag) |
Adds to the domain a single freedom constraint. | |
virtual bool | addNodalLoad (NodalLoad *, int loadPatternTag) |
Appends a nodal load to the pattern being passed as parameter. More... | |
virtual bool | addElementalLoad (ElementalLoad *, int loadPatternTag) |
Adds a load over element to the pattern. More... | |
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 the node identified by the argument. | |
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 | 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 | removeMRMFreedom_Constraint (int tag) |
Removes from domain the multi-freedom multi-retained node constraint identified by the argument. More... | |
virtual bool | removeLoadPattern (int loadTag) |
Remove from domain el load pattern identified by the argument. More... | |
virtual bool | removeNodeLocker (int nlTag) |
Remove from domain el. | |
bool | removeLoadPattern (LoadPattern *lp) |
Remove from domain el load pattern being passed as parameter. | |
bool | removeNodeLocker (NodeLocker *lp) |
Remove from domain el load pattern being passed as parameter. | |
void | removeLoadCombination (LoadCombination *comb) |
Removes from the domain the load combination being passed as parameter. More... | |
void | removeLPs (void) |
Remove from domain todos los load patterns. | |
void | removeNLs (void) |
Remove all node lockers from domain. | |
virtual bool | removeNodalLoad (int tag, int loadPattern) |
Removes from domain the nodal load being passed as parameter. More... | |
virtual bool | removeElementalLoad (int tag, int loadPattern) |
Removes from domain the elemental load being passed as parameter. More... | |
virtual bool | removeSFreedom_Constraint (int tag, int loadPattern) |
Removes from domain the single freedom constraint being passed as parameter. More... | |
virtual void | clearDOF_GroupPtr (void) |
Clears the pointers to DOF groups. | |
virtual ElementIter & | getElements (void) |
Returns an iterator to the element container. | |
virtual NodeIter & | getNodes (void) |
Returns an iterator to the node container. | |
virtual Mesh & | getMesh (void) |
Returns a reference to the domain mesh. | |
virtual const Mesh & | getMesh (void) const |
Returns a reference to the domain mesh. | |
virtual ConstrContainer & | getConstraints (void) |
Returns domain constraints. | |
virtual const ConstrContainer & | getConstraints (void) const |
Returns domain constraints. | |
const std::string & | getCurrentCombinationName (void) const |
Return the name of the current load combination. | |
bool | existElement (int tag) |
Returns true if the element identified by the tag being passed as parameter already exists en el domain. More... | |
virtual Element * | getElement (int tag) |
Return a pointer to the element identified by the argument. More... | |
virtual const Element * | getElement (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 Node * | getNode (int tag) |
Return a pointer to the node identified by the argument. More... | |
virtual const Node * | getNode (int tag) const |
Return a pointer to the node identified by the argument. More... | |
const PseudoTimeTracker & | getTimeTracker (void) const |
int | getCurrentGeoTag (void) const |
virtual int | getCommitTag (void) const |
virtual int | getNumElements (void) const |
Return the number of elements. | |
virtual int | getNumNodes (void) const |
Return the number of nodes. | |
virtual const Vector & | getPhysicalBounds (void) |
virtual Graph & | getElementGraph (void) |
Builds (if necessary) the domain elements graph and returns a reference to it. More... | |
virtual Graph & | getNodeGraph (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 | setTime (double 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 | initialize (void) |
Inicializa. | |
virtual int | setRayleighDampingFactors (const RayleighDampingFactors &rF) |
Set Rayleigh damping factors. | |
virtual int | commit (void) |
Commits domain state and triggers "record" method for all defined recorders. More... | |
virtual int | revertToLastCommit (void) |
Return the domain to its last commited 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 | update (void) |
Updates the state of the domain. More... | |
virtual int | update (double newTime, double dT) |
Actualiza el estado del domain. | |
virtual int | newStep (double dT) |
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 | getPeriodo (int) const |
Return the period of the i-th mode. | |
double | getFrecuencia (int) const |
Return the frequency of the i-th mode. | |
virtual const Vector & | getEigenvalues (void) const |
Return the eigenvalues vector. | |
Vector | getAngularFrequencies (void) const |
Returns a vector with the computed angular frequencies (for each mode). | |
Vector | getPeriodos (void) const |
Returns a vector with the computed periods (for each mode). | |
Vector | getFrecuencias (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 Vector & | getModalParticipationFactors (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 | getTotalMass (void) const |
Return the total effective modal mass. | |
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 | 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 MeshRegion * | getRegion (int region) |
Returns a pointer to the region identified by the argument. | |
virtual void | Print (std::ostream &s, int flag=0) |
Print stuff. More... | |
virtual int | sendSelf (CommParameters &) |
Sends object through the channel being passed as parameter. | |
virtual int | recvSelf (const CommParameters &) |
Receives object through the channel being passed as parameter. | |
const Preprocessor * | getPreprocessor (void) const |
Returns (if possible) a pointer to the preprocessor. | |
Preprocessor * | getPreprocessor (void) |
Returns (if possible) a pointer to the preprocessor. | |
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. | |
virtual int | calculateNodalReactions (bool inclInertia, const double &) |
Calculate nodal reaction forces and moments. | |
virtual int | addRecorder (Recorder &theRecorder) |
Adds a recorder to the model. More... | |
![]() | |
ObjWithRecorders (CommandEntity *owr, DataOutputHandler::map_output_handlers *oh=nullptr) | |
virtual | ~ObjWithRecorders (void) |
Destructor. | |
Recorder * | newRecorder (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... | |
virtual int | removeRecorders (void) |
Remove the recorders. | |
void | setLinks (Domain *dom) |
Asigna el domain a los recorders. | |
void | SetOutputHandlers (DataOutputHandler::map_output_handlers *oh) |
Set the outputhandlers container. | |
![]() | |
DistributedBase (void) | |
Constructor. | |
const int & | getDbTagDataPos (const int &i) const |
Returns the data at the i-th position. | |
void | setDbTagDataPos (const int &i, const int &v) |
Sets the data at the i-th position. | |
void | inicComm (const int &dataSize) const |
Initializes communication. | |
Static Public Member Functions | |
static void | setDeadSRF (const double &) |
Assigns Stress Reduction Factor for element deactivation. | |
Protected Member Functions | |
virtual int | buildEleGraph (Graph &theEleGraph) |
Builds the element graph. More... | |
virtual int | buildNodeGraph (Graph &theNodeGraph) |
Builds the node graph. More... | |
virtual Domain * | get_domain_ptr (void) |
void | free_mem (void) |
DbTagData & | getDbTagData (void) const |
Returns a vector to store the dbTags de los miembros of the clase. More... | |
int | sendData (CommParameters &cp) |
Send data through the channel being passed as parameter. | |
int | recvData (const CommParameters &cp) |
Receive data through the channel being passed as parameter. | |
![]() | |
int | sendData (CommParameters &cp) |
int | recvData (const CommParameters &cp) |
size_t | getNumRecorders (void) const |
Returns the number of recorders already defined. | |
Friends | |
std::ostream & | operator<< (std::ostream &, Domain &) |
int | sendDomain (Domain &, int posDbTag, DbTagData &, CommParameters &cp) |
int | receiveDomain (Domain &, int posDbTag, DbTagData &, const CommParameters &cp) |
Additional Inherited Members | |
![]() | |
typedef std::list< Recorder * > | lista_recorders |
typedef lista_recorders::iterator | recorder_iterator |
typedef lista_recorders::const_iterator | const_recorder_iterator |
Domain (mesh and boundary conditions) of the finite element model.
Is a container class for storing and providing access to the components of a domain, i.e. nodes, elements, boundary conditions, and load patterns.
A Domain is a container class which contains the all elements, nodes, load cases, single point constraints and multiple point constraints that the model builder uses to create the model of the structure. It provides operations for the following:
XC::Domain::Domain | ( | CommandEntity * | owr, |
DataOutputHandler::map_output_handlers * | oh | ||
) |
Constructor.
Constructs an empty domain. The storage for the DomainComponents uses ArrayOfTaggedObjects objects for each type of object to be stored.
owr | object that contains this one. |
XC::Domain::Domain | ( | CommandEntity * | owr, |
int | numNodes, | ||
int | numElements, | ||
int | numSPs, | ||
int | numMPs, | ||
int | numLoadPatterns, | ||
int | numNodeLockers, | ||
DataOutputHandler::map_output_handlers * | oh | ||
) |
Constructor.
Constructs an empty Domain. The initial sizes specified for these objects are no more needed (so ignored)
owr | object that contains this one. |
numNodes | number of nodes. |
numElements | number of elements. |
numSPs | number of single freedom constraints. |
numMPs | number of multi-freedom constraintes. |
numLoadPatterns | number of load patterns. |
numNodeLockers | number of node lockers. |
|
virtual |
Destructor.
destructor, this calls delete on all components of the model, i.e. calls delete on all that is added to the model. WARNING: if 3rd constructor, TaggedObjectStorage objects passed must have been created with new and nowhere else must the destructor be called.
|
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.
load | load over element. |
pattern | load pattern identifier. |
Reimplemented in XC::ShadowSubdomain, and XC::PartitionedDomain.
|
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.
Reimplemented in XC::ShadowSubdomain, and XC::PartitionedDomain.
|
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 in XC::ShadowSubdomain, and XC::PartitionedDomain.
|
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.
load | load over node. |
pattern | load pattern identifier. |
Reimplemented in XC::ShadowSubdomain, and XC::PartitionedDomain.
|
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::ObjWithRecorders.
Reimplemented in XC::ShadowSubdomain, and XC::PartitionedDomain.
|
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 in XC::ShadowSubdomain, and XC::PartitionedDomain.
|
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 in XC::ShadowSubdomain, and XC::PartitionedDomain.
|
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 in XC::ShadowSubdomain, and XC::PartitionedDomain.
|
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 in XC::ShadowSubdomain.
|
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 in XC::ShadowSubdomain, XC::Subdomain, and XC::PartitionedDomain.
|
virtual |
Commits domain state and triggers "record" method for all defined recorders.
To commit the state of the domain , that is to accept the current state as being ion the solution path. The domain invokes {commit()} on all nodes in the domain and then {commit()} on all elements of the domain. These are calls for the nodes and elements to set there committed state as given by their current state. The domain will then set its committed time variable to be equal to the current time and lastly increments its commit tag by \(1\).
Reimplemented in XC::ShadowSubdomain, XC::Subdomain, and XC::PartitionedDomain.
|
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 in XC::ShadowSubdomain.
bool XC::Domain::existElement | ( | int | tag | ) |
Returns true if the element identified by the tag being passed as parameter already exists en el domain.
bool XC::Domain::existNode | ( | int | tag | ) |
Return true if the mesh has a node with this tag.
tag | node identifier. |
|
protectedvirtual |
Returns a vector to store the dbTags de los miembros of the clase.
Reimplemented from XC::DistributedBase.
|
virtual |
Return a pointer to the element identified by the argument.
tag | element identifier. |
Reimplemented in XC::PartitionedDomain.
|
virtual |
Returns a const pointer to the element identified by the argument.
tag | element identifier. |
|
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 in XC::ShadowSubdomain.
|
virtual |
Return a pointer to the node identified by the argument.
tag | node identifier. |
Reimplemented in XC::Subdomain.
|
virtual |
Return a pointer to the node identified by the argument.
tag | node identifier. |
Reimplemented in XC::Subdomain.
|
virtual |
Return the value of the dof component of displacement for the node with the tag being passed as parameter.
nodeTag | node identifier. |
dof | component of the displacement. |
errorFlag | error indicator. |
Reimplemented in XC::ShadowSubdomain, and XC::PartitionedDomain.
|
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 in XC::ShadowSubdomain.
|
virtual |
This information is built up as nodes are added to the domain, initially all are set to \(0\) in the constructor.
|
virtual |
Returns true if the model has changed.
To return an integer stamp indicating the state of the domain. Initially \(0\), this integer is incremented by \(1\) if {domainChange()} has been invoked since the last invocation of the method. If the domain has changed it marks the element and node graph flags as not having been built.
|
virtual |
Print stuff.
To print the state of the domain. The domain invokes {Print(s,flag)} on all it's container objects.
Reimplemented in XC::ShadowSubdomain, XC::Subdomain, and XC::PartitionedDomain.
|
virtual |
Removes from domain the elemental load being passed as parameter.
elemLoadTag | Identifier of the load over elements to remove. |
loadPattern | Load pattern identifier. |
Reimplemented in XC::ShadowSubdomain.
void XC::Domain::removeLoadCombination | ( | LoadCombination * | comb | ) |
Removes from the domain the load combination being passed as parameter.
|
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.
tag | identifier of the load pattern. |
Reimplemented in XC::ShadowSubdomain, and XC::PartitionedDomain.
|
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.
tag | identifier of the constraint. |
Reimplemented in XC::ShadowSubdomain, and XC::PartitionedDomain.
|
virtual |
Removes from domain the multi-freedom multi-retained node constraint identified by the argument.
tag | identifier of the constraint. |
|
virtual |
Removes from domain the nodal load being passed as parameter.
nodalLoadTag | Nodal load identifier. |
loadPattern | Load pattern identifier. |
Reimplemented in XC::ShadowSubdomain.
|
virtual |
Remove the single freedom constraint from the load pattern identified by the argument.
To remove the SFreedom_Constraint whose tag is given by tag
from the domain. The domain achieves this by invoking {removeComponent(tag)} on the container for the single 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. Note this will only remove SFreedom_Constraints which have been added to the domain and not directly to LoadPatterns.
theNode | node identifier. |
theDOF | degree of freedom identifier. |
loadPatternTag | load pattern identifier (if -1 then remove from domain). |
|
virtual |
Removes from domain the single freedom constraint identified by the argument.
tag | identifier of the single freedom constraint. |
Reimplemented in XC::ShadowSubdomain, and XC::PartitionedDomain.
|
virtual |
Removes from domain the single freedom constraint being passed as parameter.
singleFreedomTag | Single freedom identifier. |
loadPattern | Load pattern identifier. |
Reimplemented in XC::ShadowSubdomain.
|
virtual |
Return the domain to its last commited 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 in XC::ShadowSubdomain, XC::Subdomain, and XC::PartitionedDomain.
|
virtual |
Return the domain to its initial state and triggers the "restart" method for all the recorders.
Reimplemented in XC::ShadowSubdomain, XC::Subdomain, and XC::PartitionedDomain.
|
virtual |
Set the domain stamp to be newStamp
.
Domain stamp is the integer returned by hasDomainChanged().
|
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 in XC::ShadowSubdomain, and XC::PartitionedDomain.
|
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 in XC::ShadowSubdomain, XC::Subdomain, XC::PartitionedDomain, and XC::ActorSubdomain.