XC Open source finite element analysis program
|
SubstructuringAnalysis is a subclass of Analysis, it is used when performing a domain decomposition analysis. It provides methods which can be invoked by a subdomain to perform the numerical computations required. More...
#include <SubstructuringAnalysis.h>
Public Member Functions | |
virtual int | analyze (void) |
Performs the analysis. | |
Public Member Functions inherited from XC::DomainDecompositionAnalysis | |
virtual void | clearAll (void) |
Clears all object members (constraint handler, analysis model,...). | |
virtual int | initialize (void) |
virtual int | domainChanged (void) |
Performs los cambios que implica un cambio en el domain del problema. | |
virtual bool | doesIndependentAnalysis (void) |
virtual int | analyze (double dT) |
Performs the analysis. | |
virtual int | getNumExternalEqn (void) |
Returns the number of external equations. | |
virtual int | getNumInternalEqn (void) |
Returns the number of internal equations. | |
virtual int | newStep (double dT) |
virtual int | computeInternalResponse (void) |
virtual int | formTangent (void) |
Forma la tangent stiffness matrix. | |
virtual int | formResidual (void) |
Forma el vector residuo. | |
virtual int | formTangVectProduct (Vector &force) |
?? | |
virtual const Matrix & | getTangent (void) |
Return the tangent stiffness matrix. | |
virtual const Vector & | getResidual (void) |
Returns the vector residuo. | |
virtual const Vector & | getTangVectProduct (void) |
virtual const DomainSolver * | getDomainSolver (void) const |
Returns a pointer to the DomainSolver. | |
virtual DomainSolver * | getDomainSolver (void) |
Returns a pointer to the DomainSolver. | |
virtual const Subdomain * | getSubdomain (void) const |
Returns a pointer to the subdomain. | |
virtual Subdomain * | getSubdomain (void) |
Returns a pointer to the subdomain. | |
virtual int | sendSelf (CommParameters &) |
virtual int | recvSelf (const CommParameters &) |
virtual int | setAlgorithm (EquiSolnAlgo &theAlgorithm) |
Sets the solution algorithm to use in the analysis. | |
virtual int | setIntegrator (IncrementalIntegrator &theIntegrator) |
Sets the integrator to use in the analysis. | |
virtual int | setLinearSOE (LinearSOE &theSOE) |
Sets the system of equations to use in the analysis. | |
virtual int | setConvergenceTest (ConvergenceTest &theTest) |
Sets the convergence test to use in the analysis. | |
Public Member Functions inherited from XC::Analysis | |
SoluMethod * | getSoluMethodPtr (void) |
Domain * | getDomainPtr (void) |
Returns a pointer to the domain. | |
const Domain * | getDomainPtr (void) const |
Returns a pointer to the domain. | |
ConstraintHandler * | getConstraintHandlerPtr (void) |
Returns a pointer to the gestor de coacciones. | |
DOF_Numberer * | getDOF_NumbererPtr (void) const |
Returns a pointer to the DOF numberer. | |
AnalysisModel * | getAnalysisModelPtr (void) const |
Returns a pointer to the analysis model. | |
LinearSOE * | getLinearSOEPtr (void) const |
Returns a pointer to the linear system of equations. | |
EigenSOE * | getEigenSOEPtr (void) const |
Returns a pointer to the system of equations de eigenvalues. | |
Integrator * | getIntegratorPtr (void) |
Returns, if possible, a pointer al integrator otherwise it returns nullptr. | |
const Integrator * | getIntegratorPtr (void) const |
Returns, if possible, a pointer al integrator otherwise it returns nullptr. | |
IncrementalIntegrator * | getIncrementalIntegratorPtr (void) |
Returns, if possible, a pointer al integrator incremental otherwise it returns nullptr. | |
EigenIntegrator * | getEigenIntegratorPtr (void) |
Returns, if possible, a pointer al EigenIntegrator otherwise it returns nullptr. | |
LinearBucklingIntegrator * | getLinearBucklingIntegratorPtr (void) |
Returns, if possible, a pointer al LinearBucklingIntegrator otherwise it returns nullptr. | |
TransientIntegrator * | getTransientIntegratorPtr (void) |
Returns, if possible, a pointer al EigenIntegrator otherwise it returns nullptr. | |
StaticIntegrator * | getStaticIntegratorPtr (void) |
Returns, if possible, a pointer al StaticIntegrator otherwise it returns nullptr. | |
SolutionAlgorithm * | getSolutionAlgorithmPtr (void) |
EigenAlgorithm * | getEigenSolutionAlgorithmPtr (void) |
Return a pointer to the eigenproblem solution algorithm (if it's not defined it returns nullptr). | |
EquiSolnAlgo * | getEquiSolutionAlgorithmPtr (void) |
Return a pointer to the linear SOE solution algorithm (if it's not defined it returns nullptr). | |
DomainDecompAlgo * | getDomainDecompSolutionAlgorithmPtr (void) |
Return a pointer to the domain decomposition solution algorithm (if it's not defined it returns nullptr). | |
virtual ConvergenceTest * | getConvergenceTestPtr (void) |
Returns a pointer to the convergence test (only for suitable analysis). | |
virtual const ConvergenceTest * | getConvergenceTestPtr (void) const |
Returns a pointer to the convergence test (only for suitable analysis). | |
virtual int | setNumberer (DOF_Numberer &theNumberer) |
Sets the renumerador to use in the analysis. | |
virtual int | setEigenSOE (EigenSOE &theSOE) |
Sets the sistema de eigenvalues to use in the analysis. | |
virtual int | setIntegrator (Integrator &theNewIntegrator) |
Sets the integrator to use in the analysis. | |
virtual int | setAlgorithm (SolutionAlgorithm &theNewAlgorithm) |
Set the solution algorithm to be used in the analysis. | |
void | brokeConstraintHandler (const CommParameters &, const ID &) |
void | brokeNumberer (const CommParameters &, const ID &) |
void | brokeAnalysisModel (const CommParameters &, const ID &) |
void | brokeDDLinearSOE (const CommParameters &, const ID &) |
void | brokeLinearSOE (const CommParameters &, const ID &) |
void | brokeIncrementalIntegrator (const CommParameters &, const ID &) |
void | brokeStaticIntegrator (const CommParameters &, const ID &) |
void | brokeTransientIntegrator (const CommParameters &, const ID &) |
void | brokeDomainDecompAlgo (const CommParameters &, const ID &) |
void | brokeEquiSolnAlgo (const CommParameters &, const ID &) |
int | getAnalysisResult (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. | |
MovableObject & | operator= (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 | setParameter (const std::vector< std::string > &argv, Parameter ¶m) |
virtual int | updateParameter (int parameterID, Information &info) |
virtual int | activateParameter (int parameterID) |
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. | |
virtual DbTagData & | getDbTagData (void) const |
Returns a vector to store class dbTags. | |
const int & | getDbTagDataPos (const int &i) const |
Returns the data at the i-th position. | |
void | setDbTagDataPos (const int &i, const int &v) |
Sets the data at the i-th position. | |
void | inicComm (const int &dataSize) const |
Initializes communication. | |
Friends | |
class | ProcSolu |
Additional Inherited Members | |
Protected Member Functions inherited from XC::DomainDecompositionAnalysis | |
Subdomain * | getSubdomainPtr (void) const |
Returns a pointer to the subdomain. | |
void | set_all_links (void) |
Sets los pointers tol DomainDecompSolutionAlgorithm y al subdomain. | |
DomainDecompositionAnalysis (Subdomain &theDomain, SoluMethod *s=nullptr) | |
Constructor. | |
DomainDecompositionAnalysis (Subdomain &theDomain, DomainSolver &theSolver, SoluMethod *s=nullptr) | |
Constructor. | |
DomainDecompositionAnalysis (int classTag, Subdomain &theDomain, SoluMethod *s=nullptr) | |
Constructor. | |
DomainDecompositionAnalysis (int classTag, Subdomain &theDomain, DomainSolver &theSolver, SoluMethod *s) | |
Constructor. | |
Protected Member Functions inherited from XC::Analysis | |
int | newStepDomain (AnalysisModel *theModel, const double &dT=0.0) |
ProcSolu * | getProcSolu (void) |
const ProcSolu * | getProcSolu (void) const |
Analysis (SoluMethod *metodo) | |
Constructor. | |
Protected Attributes inherited from XC::DomainDecompositionAnalysis | |
int | domainStamp |
Protected Attributes inherited from XC::Analysis | |
int | analysis_result |
Equal to zero if success. | |
SoluMethod * | metodo_solu |
Solution method. | |
SubstructuringAnalysis is a subclass of Analysis, it is used when performing a domain decomposition analysis. It provides methods which can be invoked by a subdomain to perform the numerical computations required.