XC Open source finite element analysis program
Public Member Functions | List of all members
XC::ActorSubdomain Class Reference
Inheritance diagram for XC::ActorSubdomain:
XC::Subdomain XC::Actor XC::Element XC::Domain XC::MeshComponent XC::ObjWithRecorders XC::DistributedBase XC::ContinuaReprComponent XC::DomainComponent XC::TaggedObject XC::MovableObject XC::DistributedBase

Public Member Functions

 ActorSubdomain (Channel &, FEM_ObjectBroker &, DataOutputHandler::map_output_handlers *, EntCmd *)
 
virtual int run (void)
 
virtual const VectorgetLastExternalSysResponse (void)
 
virtual int update (void)
 Updates the state of the mesh.
 
virtual int updateTimeDt (void)
 
virtual int barrierCheck (int res)
 barrier check:
 
- Public Member Functions inherited from XC::Subdomain
 Subdomain (int tag, DataOutputHandler::map_output_handlers *oh, EntCmd *owr)
 
virtual int buildSubdomain (int numSubdomains, PartitionedModelBuilder &theBuilder)
 
virtual void clearAll (void)
 Removes all components from domain (nodes, elements, loads & constraints). 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 XC::DomainComponent from theElements to an XC::Element is o.k.
 
virtual bool addNode (Node *)
 Method to add a Node to the model.
 
virtual bool removeNode (int tag)
 Elimina the node identified by the tag being passed as parameter.
 
virtual NodeItergetNodes (void)
 Returns an iterator a los nodos del domain.
 
virtual const NodegetNode (int tag) const
 Returns a pointer to the nodo cuyo tag being passed as parameter.
 
virtual NodegetNode (int tag)
 Returns a pointer to the nodo cuyo tag being passed as parameter.
 
virtual NodePtrsWithIDsgetNodePtrs (void)
 
virtual const NodePtrsWithIDsgetNodePtrs (void) const
 
virtual bool hasNode (int tag)
 
virtual bool hasElement (int tag)
 
virtual int getNumNodes (void) const
 Returns the número de nodos.
 
virtual int commit (void)
 Commits domain state and triggers "record" method for all defined recorders.
 
virtual int revertToLastCommit (void)
 Returns the domain to its last commited state.
 
virtual int revertToStart (void)
 Returns the domain to its initial state and triggers the "restart" method for all the recorders.
 
virtual int update (double newTime, double dT)
 Actualiza el estado del domain.
 
virtual void Print (std::ostream &s, int flag=0)
 Imprime el domain.
 
virtual NodeItergetInternalNodeIter (void)
 
virtual NodeItergetExternalNodeIter (void) const
 
virtual bool addExternalNode (Node *)
 
virtual void wipeAnalysis (void)
 
virtual void setDomainDecompAnalysis (DomainDecompositionAnalysis &theAnalysis)
 
virtual int setAnalysisAlgorithm (EquiSolnAlgo &theAlgorithm)
 
virtual int setAnalysisIntegrator (IncrementalIntegrator &theIntegrator)
 
virtual int setAnalysisLinearSOE (LinearSOE &theSOE)
 
virtual int setAnalysisConvergenceTest (ConvergenceTest &theTest)
 
virtual int invokeChangeOnAnalysis (void)
 
virtual int getNumExternalNodes (void) const
 
virtual const IDgetExternalNodes (void) const
 
virtual int getNumDOF (void) const
 
virtual int commitState (void)
 Consuma el estado of the element.
 
virtual const MatrixgetTangentStiff (void)
 
virtual const MatrixgetInitialStiff (void)
 
virtual const MatrixgetDamp (void)
 
virtual const MatrixgetMass (void)
 
virtual void zeroLoad (void)
 Anula el load vector aplicadas of the element.
 
virtual int addLoad (ElementalLoad *theLoad, double loadFactor)
 
virtual int addInertiaLoadToUnbalance (const Vector &accel)
 
virtual const VectorgetResistingForce (void) const
 
virtual const VectorgetResistingForceIncInertia (void) const
 Returns the action of the element over its attached nodes. Computes damping matrix.
 
virtual bool isSubdomain (void)
 
virtual int setRayleighDampingFactors (const RayleighDampingFactors &rF)
 Asigna valores a los coeficientes de amortiguamiento de Rayleigh.
 
virtual int computeTang (void)
 
virtual int computeResidual (void)
 
virtual const MatrixgetTang (void)
 
void setFE_ElementPtr (FE_Element *theFE_Ele)
 
virtual int computeNodalResponse (void)
 
virtual int newStep (double deltaT)
 
virtual bool doesIndependentAnalysis (void)
 
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.
 
virtual double getCost (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.
 
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.
 
std::vector< int > getIdxNodes (void) const
 
virtual size_t getDimension (void) const
 Returns the element dimension (0, 1, 3 or 3).
 
virtual void setIdNodos (const std::vector< int > &inodos)
 Asigna los nodos.
 
virtual void setIdNodos (const ID &inodos)
 Asigna los nodos.
 
void setDomain (Domain *theDomain)
 Sets the domain for the element.
 
virtual const MatrixgetTangentStiff (void) const =0
 
virtual const MatrixgetInitialStiff (void) const =0
 
virtual const MatrixgetDamp (void) const
 Returns the matriz de amortiguamiento.
 
virtual const MatrixgetMass (void) const
 Returns the mass matrix.
 
virtual int setRayleighDampingFactors (const RayleighDampingFactors &rF) const
 Asigna valores a los coeficientes de amortiguamiento de Rayleigh.
 
const VectorgetNodeResistingComponents (const size_t &, const Vector &) const
 Returns the generalized force of the element over the iNod-th node.
 
const VectorgetNodeResistingForce (const size_t &iNod) const
 Returns the generalized force of the element over the iNod-th node.
 
const VectorgetNodeResistingForceIncInertia (const size_t &iNod) const
 Returns the fuerza generalizada (incluyendo fuerzas de inercia) of the element sobre el nodo which index is being passed as parameter.
 
const VectorgetNodeResistingForce (const Node *) const
 Returns the fuerza generalizada of the element sobre el nodo pointed by the parameter.
 
const VectorgetNodeResistingForceIncInertia (const Node *) const
 Returns the fuerza generalizada (incluyendo fuerzas de inercia) of the element over the node pointed by the parameter.
 
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.
 
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.
 
virtual ResponsesetResponse (const std::vector< std::string > &argv, Information &eleInformation)
 
virtual int getResponse (int responseID, Information &eleInformation)
 
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)
 
int setMaterialParameter (Material *, const std::vector< std::string > &, const size_t &, Parameter &)
 
virtual int updateParameter (int parameterID, Information &info)
 
virtual int activateParameter (int 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 valor máximo de la coordenada i of the nodes of the element.
 
double MinCooNod (int i) const
 Returns the minimum value de la coordenada i of the nodes of the element.
 
const MatrixgetCooNodos (void) const
 Returns the coordinates of the nodes.
 
virtual Matrix getLocalAxes (bool initialGeometry=true) const
 Returs a matrix with the axes of the element as matrix rows [[x1,y1,z1],[x2,y2,z2],...·].
 
Pos3d getPosNodo (const size_t &i, bool initialGeometry=true) const
 Returns the position of the i-th node. More...
 
std::list< Pos3d > getPosNodos (bool initialGeometry=true) const
 Returns the coordinates of the nodes.
 
virtual Pos3d getPosCdg (bool initialGeometry=true) const
 Returns the coordinates del centro de gravedad of the element.
 
Vector getCooCdg (bool initialGeometry=true) const
 Returns the coordinates del centro de gravedad of the element.
 
TritrizPos3d getPuntos (const size_t &ni, const size_t &nj, const size_t &nk, bool initialGeometry=true)
 Returns a grid of points distributed along the line.
 
virtual double getDist2 (const Pos2d &p, bool initialGeometry=true) const
 Returns the squared distance from the element to the point being passed as parameter.
 
virtual double getDist (const Pos2d &p, bool initialGeometry=true) const
 Returns the the distance from the element to the point being passed as parameter.
 
virtual double getDist2 (const Pos3d &p, bool initialGeometry=true) const
 Returns the squared distance from the element to the point being passed as parameter.
 
virtual double getDist (const Pos3d &p, bool initialGeometry=true) const
 Returns the the distance from the element to the point being passed as parameter.
 
void resetTributarias (void) const
 Resets tributary areas of connected nodes.
 
void vuelcaTributarias (const std::vector< double > &) const
 Adds to the tributary magnitude of each node the vector being passed as parameter.
 
virtual void calculaLongsTributarias (bool initialGeometry=true) const
 Computes the tributary lengths that corresponds to each node of the element.
 
virtual double getLongTributaria (const Node *) const
 Returns the tributary length corresponding to the node being passed as parameter.
 
virtual double getLongTributariaByTag (const int &) const
 Returns the tributary length corresponding to the node cuyo tag se pasa as parameter.
 
virtual void calculaAreasTributarias (bool initialGeometry=true) const
 Calcula las áreas tributarias that corresponds to cada nodo of the element.
 
virtual double getAreaTributaria (const Node *) const
 Returns the área tributaria corresponding to the node being passed as parameter.
 
virtual double getAreaTributariaByTag (const int &) const
 Returns the área tributaria corresponding to the node cuyo tag se pasa as parameter.
 
virtual void calculaVolsTributarios (bool initialGeometry=true) const
 Calcula los volúmenes tributarios that corresponds to cada nodo of the element.
 
virtual double getVolTributario (const Node *) const
 Returns the tributary volume corresponding to the node being passed as parameter.
 
virtual double getVolTributarioByTag (const int &) const
 Returns the tributary volume corresponding to the node cuyo tag se pasa as parameter.
 
virtual Vector getInterpolationFactors (const ParticlePos3d &) const
 Returns interpolattion factors for a material point.
 
virtual Vector getInterpolationFactors (const Pos3d &) const
 Returns interpolattion factors for a material point.
 
virtual int getVtkCellType (void) const
 Interfaz con VTK.
 
virtual int getMEDCellType (void) const
 Interfaz con el formato MED de Salome.
 
virtual const GaussModelgetGaussModel (void) const
 Returns the Gauss integration model of the element.
 
MEDGaussModel getMEDGaussModel (void) const
 Returns the Gauss integration model of the element for MED library.
 
virtual NodesEdge getNodesEdge (const size_t &) const
 Returns the nodos del borde (o arista) of the element which index is being passed as parameter.
 
virtual int getEdgeNodes (const Node *, const Node *) const
 Returns the borde (o arista) of the element que tiene por extremos los nodos being passed as parameters.
 
int getEdgeNodes (const int &, const int &) const
 Returns the borde of the element que tiene por extremos los nodos being passed as parameters.
 
virtual ID getEdgesNode (const Node *) const
 Returns the bordes of the element que tienen por extremo el nodo being passed as parameter.
 
std::set< int > getEdgesNodes (const NodePtrSet &) const
 Returns the bordes of the element que tienen ambos extremos en el node set being passed as parameter.
 
ID getEdgesNodeByTag (const int &) const
 Returns the bordes of the element que tienen por extremo el nodo cuyo tag is being passed as parameter.
 
virtual ID getLocalIndexNodesEdge (const size_t &i) const
 Returns the local indexes of the element nodes that lie over the i-th edge.
 
std::set< SetBase * > get_sets (void) const
 Returns the sets to which the element belongs.
 
void add_to_sets (std::set< SetBase * > &)
 Adds the element to the sets being passed as parameters.
 
- Public Member Functions inherited from XC::MeshComponent
 MeshComponent (int classTag)
 Constructor.
 
 MeshComponent (int tag, int classTag)
 Constructor.
 
- Public Member Functions inherited from XC::ContinuaReprComponent
 ContinuaReprComponent (int classTag)
 
 ContinuaReprComponent (int tag, int classTag)
 
virtual const bool isDead (void) const
 
virtual const bool isAlive (void) const
 
virtual void kill (void)
 
virtual void alive (void)
 
- Public Member Functions inherited from XC::DomainComponent
 ~DomainComponent (void)
 Destructor.
 
size_t getIdx (void) const
 Returns the index of the object (to be used in VTK arrays).
 
virtual DomaingetDomain (void) const
 Returns a pointer to the domain.
 
const PreprocessorGetPreprocessor (void) const
 Returns (if possible) a pointer to the preprocessor.
 
PreprocessorGetPreprocessor (void)
 Returns (if possible) a pointer to the preprocessor.
 
void set_indice (const size_t &i)
 Set the index for the object (see numera in Set). This index is used on VTK arrays.
 
- Public Member Functions inherited from XC::TaggedObject
 TaggedObject (int tag, EntCmd *owr=nullptr)
 Constructor.
 
void assignTag (int newTag)
 Establece el valor del tag.
 
int getTag (void) const
 
- Public Member Functions inherited from XC::MovableObject
 MovableObject (int classTag, int dbTag)
 Constructor.
 
 MovableObject (int classTag)
 Constructor.
 
 MovableObject (const MovableObject &otro)
 Copy constructor.
 
MovableObjectoperator= (const MovableObject &otro)
 Operacdor asignación.
 
int getClassTag (void) const
 Returns the tag de la clase.
 
int getDbTag (void) const
 Returns the tag para la database.
 
int getDbTag (CommParameters &)
 Returns the tag para la database.
 
void setDbTag (int dbTag)
 Asigna el tag para la database.
 
void setDbTag (CommParameters &)
 Asigna, sólo si es preciso, el tag para la database.
 
virtual int setVariable (const std::string &variable, Information &)
 Returns the identificador de la variable cuyo nombre being passed as parameter.
 
virtual int getVariable (const std::string &variable, Information &)
 
- Public Member Functions inherited from XC::DistributedBase
 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.
 
- Public Member Functions inherited from XC::Domain
 Domain (EntCmd *owr, DataOutputHandler::map_output_handlers *oh)
 Constructor.
 
 Domain (EntCmd *owr, int numNods, int numElements, int numSPs, int numMPs, int numLPatterns, int numNLockers, DataOutputHandler::map_output_handlers *oh)
 Constructor.
 
virtual ~Domain (void)
 Destructor. More...
 
virtual bool addElement (Element *)
 Adds to the domain the element being passed as parameter.
 
virtual bool addSFreedom_Constraint (SFreedom_Constraint *)
 Adds to the domain una constraint monopunto.
 
virtual bool addMFreedom_Constraint (MFreedom_Constraint *)
 Adds to the domain una constraint multipunto.
 
virtual bool addMRMFreedom_Constraint (MRMFreedom_Constraint *)
 Adds to the domain una constraint multi retained node.
 
virtual bool addLoadPattern (LoadPattern *)
 Adds al modelo la hipótesis simple being passed as parameter.
 
virtual bool addNodeLocker (NodeLocker *)
 Adds al modelo.
 
virtual bool addLoadCombination (LoadCombination *)
 Adds to the domain the load combination being passed as parameter.
 
void setNodeReactionException (const int &)
 Asigna la excepción para comprobación de reacciones (ver Domain::checkNodalReactions).
 
void checkNodalReactions (const double &)
 
virtual bool addSFreedom_Constraint (SFreedom_Constraint *, int loadPatternTag)
 Adds to the domain una constraint monopunto.
 
virtual bool addNodalLoad (NodalLoad *, int loadPatternTag)
 Appends a nodal load to the pattern being passed as parameter.
 
virtual bool addElementalLoad (ElementalLoad *, int loadPatternTag)
 Adds to the caso being passed as parameter una load over elements.
 
virtual bool removeElement (int tag)
 Clears the element identified by the tag being passed as parameter.
 
virtual bool removeSFreedom_Constraint (int theNode, int theDOF, int loadPatternTag)
 
virtual bool removeSFreedom_Constraint (int tag)
 Elimina del domain la constraint monopunto cuyo tag being passed as parameter.
 
virtual bool removeMFreedom_Constraint (int tag)
 Elimina del domain la constraint multipunto cuyo tag being passed as parameter.
 
virtual bool removeMRMFreedom_Constraint (int tag)
 Elimina del domain la constraint multi retained node cuyo tag being passed as parameter.
 
virtual bool removeLoadPattern (int loadTag)
 Elimina del domain el load pattern cuyo tag being passed as parameter.
 
virtual bool removeNodeLocker (int nlTag)
 Elimina del domain el.
 
bool removeLoadPattern (LoadPattern *lp)
 Elimina del domain el load pattern being passed as parameter.
 
bool removeNodeLocker (NodeLocker *lp)
 Elimina del domain el load pattern being passed as parameter.
 
void removeLoadCombination (LoadCombination *comb)
 Removes from the domain the load combination being passed as parameter.
 
void removeLPs (void)
 Elimina del domain todos los load patterns.
 
void removeNLs (void)
 Elimina del domain todos los bloqueos de nodos.
 
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 ElementItergetElements (void)
 Returns an iterator to the element container.
 
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.
 
const std::string & getNombreCombActual (void) const
 Returns 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.
 
virtual ElementgetElement (int tag)
 Returns a pointer to the element identified by the tag being passed as parameter.
 
virtual const ElementgetElement (int tag) const
 Returns a const pointer to the element identified by the tag being passed as parameter.
 
bool existNode (int tag)
 Returns true if the mesh has a node with the tag being passed as parameter.
 
const PseudoTimeTrackergetTimeTracker (void) const
 
int getCurrentGeoTag (void) const
 
virtual int getCommitTag (void) const
 
virtual int getNumElements (void) const
 Returns the number of elements.
 
virtual const VectorgetPhysicalBounds (void)
 Returns the BND of the model.
 
virtual GraphgetElementGraph (void)
 Builds (if necessary) the domain elements graph and returns a reference to it.
 
virtual GraphgetNodeGraph (void)
 Builds (if necessary) the domain nodes graph and returns a reference to it.
 
virtual void setCommitTag (int newTag)
 
virtual void setCurrentTime (double newTime)
 
virtual void setCommittedTime (double newTime)
 
virtual void setTime (double newTime)
 
virtual void applyLoad (double pseudoTime)
 
virtual void setLoadConstant (void)
 Set all the loads as constant.
 
virtual int initialize (void)
 Inicializa.
 
void resetLoadCase (void)
 Prepares the domain to solve for a new load pattern.
 
int getNumModes (void) const
 Returns the number of computed eigenvalues.
 
virtual int setEigenvalues (const Vector &)
 Sets eigenvalues.
 
virtual const double & getEigenvalue (int) const
 Returns the eigenvalue of the i-th mode.
 
double getAngularFrequency (int) const
 Return the angular frequency of the i-th mode.
 
double getPeriodo (int) const
 Returns the period of the i-th mode.
 
double getFrecuencia (int) const
 Return the frequency of the i-th mode.
 
virtual const VectorgetEigenvalues (void) const
 Returns 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
 Returns the modal participation factor of the i-th mode.
 
virtual const VectorgetModalParticipationFactors (void) const
 Returns the modal participation factors.
 
const double getEffectiveModalMass (int mode) const
 Return the effective modal mass of the i-th mode.
 
Vector getEffectiveModalMasses (void) const
 Returns the effective modal masses for each mode.
 
double getTotalMass (void) const
 Return the total effective modal mass.
 
virtual void domainChange (void)
 Establece que the model ha cambiado.
 
virtual int hasDomainChanged (void)
 Returns true if the modelo ha cambiado.
 
virtual void setDomainChangeStamp (int newStamp)
 
virtual int addRegion (MeshRegion &theRegion)
 Adds a region.
 
virtual MeshRegiongetRegion (int region)
 Returns a pointer to the la región cuyo tag being passed as parameter.
 
const PreprocessorGetPreprocessor (void) const
 Returns (if possible) a pointer to the preprocessor.
 
PreprocessorGetPreprocessor (void)
 Returns (if possible) a pointer to the preprocessor.
 
virtual double getNodeDisp (int nodeTag, int dof, int &errorFlag)
 Returns the value of dof component of displacement for the node with the tag being passed as parameter. More...
 
virtual int setMass (const Matrix &mass, int nodeTag)
 Asigna la matriz de masas al nudo cuyo tag being passed as parameter.
 
virtual int calculateNodalReactions (bool inclInertia, const double &)
 Calculate nodal reaction forces and moments.
 
virtual int addRecorder (Recorder &theRecorder)
 Adds a recorder to the model.
 
- Public Member Functions inherited from XC::ObjWithRecorders
 ObjWithRecorders (EntCmd *owr, DataOutputHandler::map_output_handlers *oh=nullptr)
 
virtual ~ObjWithRecorders (void)
 Destructor.
 
RecordernewRecorder (const std::string &, DataOutputHandler *oh=nullptr)
 Lee un objeto Recorder desde archivo.
 
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)
 Ejecuta los recorders sobre el tag being passed as parameter.
 
void restart (void)
 Rearranca los recorders.
 
virtual int removeRecorders (void)
 Elimina los recorders.
 
void setLinks (Domain *dom)
 Asigna el domain a los recorders.
 
void SetOutputHandlers (DataOutputHandler::map_output_handlers *oh)
 Asigna el almacén de gestores de salida.
 
- Public Member Functions inherited from XC::Actor
 Actor (Channel &theChannel, FEM_ObjectBroker &theBroker, int numActorMethods=0)
 Constructor to init the list.
 
 Actor (const Actor &)
 Copy constructor.
 
Actoroperator= (const Actor &)
 Assignment operator.
 
virtual ~Actor (void)
 Destructor.
 
virtual int addMethod (int tag, int(*fp)())
 Method to add a function to the list of avaiable actor methods. The function will be identified as tag, it is a function with no args that returns an int.
 
virtual int getMethod ()
 Method to return the integer tag of the next method the actor has been asked to invoke.
 
virtual int processMethod (int tag)
 Method to process the function whose id is tag.
 
virtual int sendObject (MovableObject &theObject, ChannelAddress *theAddress=0)
 Sends object theObject through the channel being passed as parameter.
 
virtual int recvObject (MovableObject &theObject, ChannelAddress *theAddress=0)
 Receives object theObject through the channel being passed as parameter.
 
virtual int sendMessage (const Message &theMessage, ChannelAddress *theAddress=0)
 Envía el mensaje through the channel being passed as parameter.
 
virtual int recvMessage (Message &theMessage, ChannelAddress *theAddress=0)
 Recibe el mensaje through the channel being passed as parameter.
 
virtual int sendMatrix (const Matrix &theMatrix, ChannelAddress *theAddress=0)
 Envía la matriz through the channel being passed as parameter.
 
virtual int recvMatrix (Matrix &theMatrix, ChannelAddress *theAddress=0)
 Recibe la matriz through the channel being passed as parameter.
 
virtual int sendVector (const Vector &theVector, ChannelAddress *theAddress=0)
 Envía el vector through the channel being passed as parameter.
 
virtual int recvVector (Vector &theVector, ChannelAddress *theAddress=0)
 Recibe el vector through the channel being passed as parameter.
 
virtual int sendID (const ID &theID, ChannelAddress *theAddress=0)
 Envía el vector de enteros through the channel being passed as parameter.
 
virtual int recvID (ID &theID, ChannelAddress *theAddress=0)
 Recibe el vector de enteros through the channel being passed as parameter.
 
ChannelgetChannelPtr (void) const
 Returns a pointer to the canal.
 
FEM_ObjectBrokergetObjectBrokerPtr (void) const
 Returns a pointer to the broker.
 
ChannelAddressgetShadowsAddressPtr (void) const
 
void setCommitTag (int commitTag)
 

Additional Inherited Members

- Public Types inherited from XC::Element
typedef std::vector< const Node * > NodesEdge
 
- Public Types inherited from XC::ObjWithRecorders
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 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.
 
- Protected Member Functions inherited from XC::Subdomain
virtual int buildMap (void) const
 
FE_ElementgetFE_ElementPtr (void)
 
DomainDecompositionAnalysisgetDDAnalysis (void)
 
- Protected Member Functions inherited from XC::Element
virtual TritrizPtrElem put_on_mesh (const TritrizPtrNod &, meshing_dir) const
 Places the element on the mesh.
 
virtual TritrizPtrElem cose (const SetEstruct &f1, const SetEstruct &f2) const
 
const VectorgetRayleighDampingForces (void) const
 Returns element Rayleigh damping forces.
 
int sendData (CommParameters &cp)
 Sends object members through the channel being passed as parameter.
 
int recvData (const CommParameters &cp)
 Receives object members through the channel being passed as parameter.
 
- Protected Member Functions inherited from XC::MeshComponent
void setup_matrices (std::deque< Matrix > &, const int &) const
 Initializes the matrix container.
 
int sendIdsEtiquetas (int posDbTag, CommParameters &)
 Send labelsthrough the channel being passed as parameter.
 
int recvIdsEtiquetas (int posDbTag, const CommParameters &)
 Receive labels through the channel being passed as parameter.
 
int sendData (CommParameters &)
 Send members through the channel being passed as parameter.
 
int recvData (const CommParameters &)
 Receives members through the channel being passed as parameter.
 
- Protected Member Functions inherited from XC::ContinuaReprComponent
int sendData (CommParameters &)
 Send members through the channel being passed as parameter.
 
int recvData (const CommParameters &)
 Receives members through the channel being passed as parameter.
 
- Protected Member Functions inherited from XC::DomainComponent
 DomainComponent (int tag, int classTag)
 Constructor.
 
int sendData (CommParameters &)
 Send object members through the channel being passed as parameter.
 
int recvData (const CommParameters &)
 Receives object members through the channel being passed as parameter.
 
- Protected Member Functions inherited from XC::TaggedObject
void setTag (int newTag)
 Establece el valor del tag.
 
- Protected Member Functions inherited from XC::Domain
virtual int buildEleGraph (Graph &theEleGraph)
 Builds the element graph.
 
virtual int buildNodeGraph (Graph &theNodeGraph)
 Builds the node graph.
 
virtual Domainget_domain_ptr (void)
 
void libera (void)
 
DbTagDatagetDbTagData (void) const
 Returns a vector para almacenar los dbTags de los miembros de la clase.
 
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.
 
- Protected Member Functions inherited from XC::ObjWithRecorders
int sendData (CommParameters &cp)
 
int recvData (const CommParameters &cp)
 
size_t getNumRecorders (void) const
 Returns the number of recorders already defined.
 
- Protected Attributes inherited from XC::Subdomain
bool mapBuilt
 
IDmap
 
VectormappedVect
 
MatrixmappedMatrix
 
TaggedObjectStorageinternalNodes
 
TaggedObjectStorageexternalNodes
 
- Protected Attributes inherited from XC::Element
Vector load
 vector for applying loads
 
RayleighDampingFactors rayFactors
 Rayleigh damping factors.
 
Matrix Kc
 pointer to hold last committed matrix if needed for rayleigh damping
 
- Protected Attributes inherited from XC::MeshComponent
int index
 Index for VTK arrays.
 
LabelContainer labels
 Label container.
 
- Protected Attributes inherited from XC::Actor
FEM_ObjectBrokertheBroker
 
ChanneltheChannel
 

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