LifeV
|
#include <StructuralOperator.hpp>
Protected Member Functions | |
void | applyBoundaryConditions (matrix_Type &matrix, vector_Type &rhs, bcHandler_Type &BCh, UInt offset=0) |
Apply boundary condition. More... | |
UInt | dim () const |
void | setupMapMarkersVolumes (void) |
construct the map between the markers and the volumes More... | |
Constructor & Destructor | |
StructuralOperator () | |
virtual | ~StructuralOperator () |
Methods | |
void | setup (std::shared_ptr< data_Type > data, const FESpacePtr_Type &dFESpace, const ETFESpacePtr_Type &dETFESpace, bcHandler_Type &BCh, std::shared_ptr< Epetra_Comm > &comm) |
Setup the created object of the class Venantkirchhof. More... | |
void | setup (std::shared_ptr< data_Type > data, const FESpacePtr_Type &dFESpace, const ETFESpacePtr_Type &dETFESpace, std::shared_ptr< Epetra_Comm > &comm) |
void | setup (std::shared_ptr< data_Type > data, const FESpacePtr_Type &dFESpace, const ETFESpacePtr_Type &dETFESpace, std::shared_ptr< Epetra_Comm > &comm, const std::shared_ptr< const MapEpetra > &monolithicMap, UInt offset=0) |
void | updateSystem (void) |
Updates the system at the end of each time step. More... | |
void | updateSystem (matrixPtr_Type &mat_stiff) |
Updates the system at the end of each time step when the matrix is passed from outside. More... | |
void | updateRightHandSideWithBodyForce (const Real currentTime, const vector_Type &rhsTimeAdvance) |
Updates the system at the end of each time step given a source term. More... | |
void | setRightHandSide (const vector_Type &rightHandSide) |
Updates the rhs at the start of each time step. More... | |
void | computeRHSNoBC (void) |
Comuptes the right hand side in the updateSystem methods. More... | |
void | buildSystem (const Real coefficient) |
Compute the mass matrix and it calls the method to build the linear part of the stiffness matrix of the material class. More... | |
void | computeMassMatrix (const Real factor=1.) |
Compute the mass matrix and the linear part of the stiffness matrix. More... | |
void | iterate (const bcHandler_Type &bch) |
Solve the non-linear system. More... | |
void | iterateLin (bcHandler_Type &bch) |
Solve the linearized problem. Used in FSI segregated in ExactJacobian. More... | |
void | showMe (std::ostream &c=std::cout) const |
Output. More... | |
void | updateJacobian (const vector_Type &solution, matrixPtr_Type &jacobian) |
Update the Jacobian Matrix at each iteration of the nonLinearRichardson method. More... | |
void | updateJacobian (const vector_Type &solution) |
Update the Jacobian Matrix at each iteration of the nonLinearRichardson method. More... | |
void | solveJac (vector_Type &step, const vector_Type &residual, Real &linear_rel_tol) |
Solves the tangent problem for newton iterations. More... | |
void | solveJacobian (vector_Type &step, const vector_Type &residual, Real &linear_rel_tol, bcHandler_Type &BCd) |
Solves the tangent problem with custom BC. More... | |
void | evalResidual (vector_Type &residual, const vector_Type &solution, Int iter) |
Evaluates residual for newton interations. More... | |
void | evalResidualDisplacement (const vector_Type &solution) |
Evaluates residual of the displacement for FSI problems. More... | |
void | evalResidualDisplacementLin (const vector_Type &solution) |
Evaluates residual of the displacement in the Linearized problem of ExactJcobian. FSI problems. More... | |
void | initialize (const function &d0) |
Sets the initial displacement, velocity, acceleration. More... | |
void | initialize (vectorPtr_Type d0) |
Sets the initial displacement, velocity, acceleration. More... | |
void | reduceSolution (Vector &displacement, Vector &velocity) |
Computes the velocity and acceleration vector at the n-th time step. More... | |
void | computeMatrix (matrixPtr_Type &stiff, const vector_Type &sol, Real const &factor, const UInt iter) |
Multiply the mass matrix and the linear stiffness matrix by the rescaleFactor. More... | |
void | jacobianDistribution (vectorPtr_Type displacement, vector_Type &jacobianDistribution) |
compute the value of the determinant of F in all the volumes of the mesh More... | |
void | colorMesh (vector_Type &meshColors) |
compute the value of the determinant of F in all the volumes of the mesh More... | |
void | computeCauchyStressTensor (const vectorPtr_Type disp, const QuadratureRule &evalQuad, vectorPtr_Type sigma_1, vectorPtr_Type sigma_2, vectorPtr_Type sigma_3) |
Compute the three columns of the Cauchy stress tensor. More... | |
void | computePrincipalTensions (vectorPtr_Type sigma_1, vectorPtr_Type sigma_2, vectorPtr_Type sigma_3, vectorPtr_Type vectorEigenvalue) |
Compute the nodal principal tensions given the cauchy stress tensor. More... | |
Set Methods | |
void | setBC (const bcHandler_Type &BCd) |
Setters Set the BCHandler object. More... | |
void | setSourceTerm (source_Type const &) |
Set the source object. More... | |
void | setSourceTerm (const volumeForcePtr_Type s) |
Set the source object. More... | |
void | setHavingSourceTerm (const bool havingSource) |
Set the source object. More... | |
void | setRecur (UInt recur) |
Set the recur parameter. More... | |
void | setDataFromGetPot (const GetPot &dataFile) |
Set the data fields with the Getpot data file for preconditioners and solver. More... | |
void | setTimeAdvance (const timeAdvancePtr_Type &timeAdvancePtr) |
void | constructPatchAreaVector (vector_Type &patchArea, const vector_Type &solution) |
constructPatchAreaVector: This method build the patch area vector used in the reconstruction process More... | |
void | reconstructElementaryVector (VectorElemental &elVecSigma, vector_Type &patchArea, UInt nVol) |
reconstructElementaryVector: This method applies a reconstruction procedure on the elvec that is passed More... | |
Get Methods | |
MapEpetra const & | map () const |
Getters Get the Epetramap. More... | |
Displayer const & | displayer () const |
Get the Displayer object. More... | |
std::shared_ptr< const Displayer > const & | displayerPtr () const |
matrixPtr_Type const | massMatrix () const |
Get the matrix containing the mass mtrix and the linear part of the stiffness matrix. More... | |
FESpace_Type & | dispFESpace () |
Get the FESpace object. More... | |
ETFESpace_Type & | dispETFESpace () |
Get the ETFESpace object. More... | |
bcHandler_Type const & | bcHandler () const |
Get the bCHandler object. More... | |
vector_Type & | residual () |
Get the residual. More... | |
const bool | havingSourceTerm () const |
Get the source term. More... | |
vector_Type & | displacement () |
Get the displacement. More... | |
vectorPtr_Type | displacementPtr () |
vectorPtr_Type & | rhsWithoutBC () |
Get the right hand sde without BC. More... | |
solver_Type & | linearSolver () |
vector_Type & | rhsCopy () |
Get the right hand. The member rhsCopy is used for Debug purposes! More... | |
vector_Type & | residualCopy () |
vector_Type & | bodyForce () |
std::shared_ptr< Epetra_Comm > const & | comunicator () const |
Get the comunicator object. More... | |
Real | rescaleFactor () |
Get the rescaleFactor. More... | |
const UInt & | offset () const |
const materialPtr_Type & | material () const |
void | solidMatrix (matrixPtr_Type &) |
Do nothing in the linear case: the matrix remains constant. More... | |
Real | thickness () const |
Get the thickness. More... | |
Real | young (UInt material=1) const |
Get the Young modulus. More... | |
Real | poisson (UInt material=1) const |
Get the Poisson coefficient. More... | |
Real | rho () const |
Get the density. More... | |
const std::shared_ptr< data_Type > & | data () const |
Get the data container. More... | |
void | apply (const vector_Type &sol, vector_Type &res) const |
mapMarkerVolumesPtr_Type | mapMarkersVolumes () const |
Get the density. More... | |
mapMarkerIndexesPtr_Type | mapMarkersIndexes () const |
Get the density. More... | |
const timeAdvancePtr_Type & | timeAdvancePtr () const |
Definition at line 167 of file StructuralOperator.hpp.
Definition at line 173 of file StructuralOperator.hpp.
typedef std::function<Real ( Real const&, Real const&, Real const&, Real const&, ID const& ) > source_Type |
Definition at line 174 of file StructuralOperator.hpp.
typedef StructuralConstitutiveLaw<Mesh> material_Type |
Definition at line 176 of file StructuralOperator.hpp.
typedef std::shared_ptr<material_Type> materialPtr_Type |
Definition at line 177 of file StructuralOperator.hpp.
typedef BCHandler bcHandlerRaw_Type |
Definition at line 179 of file StructuralOperator.hpp.
typedef std::shared_ptr<bcHandlerRaw_Type> bcHandler_Type |
Definition at line 180 of file StructuralOperator.hpp.
typedef LinearSolver solver_Type |
Definition at line 182 of file StructuralOperator.hpp.
typedef solver_Type::matrix_Type matrix_Type |
Definition at line 184 of file StructuralOperator.hpp.
typedef std::shared_ptr<matrix_Type> matrixPtr_Type |
Definition at line 185 of file StructuralOperator.hpp.
typedef solver_Type::vector_Type vector_Type |
Definition at line 186 of file StructuralOperator.hpp.
typedef std::shared_ptr<vector_Type> vectorPtr_Type |
Definition at line 187 of file StructuralOperator.hpp.
typedef vector_Type solution_Type |
Definition at line 188 of file StructuralOperator.hpp.
typedef std::shared_ptr<solution_Type> solutionPtr_Type |
Definition at line 189 of file StructuralOperator.hpp.
Definition at line 191 of file StructuralOperator.hpp.
typedef RegionMesh<LinearTetra > mesh_Type |
Definition at line 193 of file StructuralOperator.hpp.
typedef std::vector< mesh_Type::element_Type* > vectorVolumes_Type |
Definition at line 194 of file StructuralOperator.hpp.
typedef std::vector< UInt > vectorIndexes_Type |
Definition at line 195 of file StructuralOperator.hpp.
typedef std::map< UInt, vectorVolumes_Type> mapMarkerVolumes_Type |
Definition at line 197 of file StructuralOperator.hpp.
typedef std::map< UInt, vectorIndexes_Type> mapMarkerIndexes_Type |
Definition at line 198 of file StructuralOperator.hpp.
typedef std::shared_ptr<mapMarkerVolumes_Type> mapMarkerVolumesPtr_Type |
Definition at line 199 of file StructuralOperator.hpp.
typedef std::shared_ptr<mapMarkerIndexes_Type> mapMarkerIndexesPtr_Type |
Definition at line 200 of file StructuralOperator.hpp.
typedef mapMarkerVolumes_Type::const_iterator mapIterator_Type |
Definition at line 201 of file StructuralOperator.hpp.
Definition at line 203 of file StructuralOperator.hpp.
typedef std::function<bool (const UInt, const UInt) > comparisonPolicy_Type |
Definition at line 205 of file StructuralOperator.hpp.
Definition at line 207 of file StructuralOperator.hpp.
typedef std::unique_ptr<markerSelector_Type> markerSelectorPtr_Type |
Definition at line 208 of file StructuralOperator.hpp.
typedef ETFESpace< RegionMesh<LinearTetra>, MapEpetra, 3, 3 > ETFESpace_Type |
Definition at line 210 of file StructuralOperator.hpp.
typedef std::shared_ptr<ETFESpace_Type> ETFESpacePtr_Type |
Definition at line 211 of file StructuralOperator.hpp.
typedef FESpace< RegionMesh<LinearTetra>, MapEpetra > FESpace_Type |
Definition at line 213 of file StructuralOperator.hpp.
typedef std::shared_ptr<FESpace_Type> FESpacePtr_Type |
Definition at line 214 of file StructuralOperator.hpp.
typedef LifeV::Preconditioner basePrec_Type |
Definition at line 217 of file StructuralOperator.hpp.
typedef std::shared_ptr<basePrec_Type> basePrecPtr_Type |
Definition at line 218 of file StructuralOperator.hpp.
Definition at line 219 of file StructuralOperator.hpp.
typedef std::shared_ptr<precIfpack_Type> precIfpackPtr_Type |
Definition at line 220 of file StructuralOperator.hpp.
typedef LifeV::PreconditionerML precML_Type |
Definition at line 221 of file StructuralOperator.hpp.
typedef std::shared_ptr<precML_Type> precMLPtr_Type |
Definition at line 222 of file StructuralOperator.hpp.
typedef TimeAdvance< vector_Type > timeAdvance_Type |
Definition at line 225 of file StructuralOperator.hpp.
typedef std::shared_ptr< timeAdvance_Type > timeAdvancePtr_Type |
Definition at line 226 of file StructuralOperator.hpp.
typedef Epetra_SerialDenseMatrix matrixSerialDense_Type |
Definition at line 228 of file StructuralOperator.hpp.
typedef std::shared_ptr<matrixSerialDense_Type> matrixSerialDensePtr_Type |
Definition at line 229 of file StructuralOperator.hpp.
typedef std::vector<LifeV::Real> vectorInvariants_Type |
Definition at line 230 of file StructuralOperator.hpp.
typedef std::shared_ptr<vectorInvariants_Type> vectorInvariantsPtr_Type |
Definition at line 232 of file StructuralOperator.hpp.
typedef std::function<VectorSmall<3> Real const&, const Real&, const Real&, const Real& ) > volumeForce_Type |
Definition at line 236 of file StructuralOperator.hpp.
typedef std::shared_ptr<volumeForce_Type> volumeForcePtr_Type |
Definition at line 237 of file StructuralOperator.hpp.
Definition at line 238 of file StructuralOperator.hpp.
typedef std::shared_ptr<sourceFunctor_Type> sourceFunctorPtr_Type |
Definition at line 239 of file StructuralOperator.hpp.
Definition at line 866 of file StructuralOperator.hpp.
|
inlinevirtual |
Definition at line 248 of file StructuralOperator.hpp.
void setup | ( | std::shared_ptr< data_Type > | data, |
const FESpacePtr_Type & | dFESpace, | ||
const ETFESpacePtr_Type & | dETFESpace, | ||
bcHandler_Type & | BCh, | ||
std::shared_ptr< Epetra_Comm > & | comm | ||
) |
Setup the created object of the class Venantkirchhof.
data_file | GetPot data file |
refFE | reference FE for the displacement |
BCh | boundary conditions for the displacement |
comm | the Epetra Comunicator |
Definition at line 906 of file StructuralOperator.hpp.
void setup | ( | std::shared_ptr< data_Type > | data, |
const FESpacePtr_Type & | dFESpace, | ||
const ETFESpacePtr_Type & | dETFESpace, | ||
std::shared_ptr< Epetra_Comm > & | comm | ||
) |
data_file | GetPot data file |
refFE | reference FE for the displacement |
comm | the Epetra Comunicator |
Definition at line 918 of file StructuralOperator.hpp.
void setup | ( | std::shared_ptr< data_Type > | data, |
const FESpacePtr_Type & | dFESpace, | ||
const ETFESpacePtr_Type & | dETFESpace, | ||
std::shared_ptr< Epetra_Comm > & | comm, | ||
const std::shared_ptr< const MapEpetra > & | monolithicMap, | ||
UInt | offset = 0 |
||
) |
data_file | GetPot data file |
refFE | reference FE for the displacement |
comm | the comunicator parameter |
monolithicMap | the MapEpetra |
offset | the offset parameter |
Definition at line 938 of file StructuralOperator.hpp.
void updateSystem | ( | void | ) |
Updates the system at the end of each time step.
Definition at line 1027 of file StructuralOperator.hpp.
void updateSystem | ( | matrixPtr_Type & | mat_stiff | ) |
Updates the system at the end of each time step when the matrix is passed from outside.
stiff | stiffness matrix provided from outside |
Definition at line 1033 of file StructuralOperator.hpp.
void updateRightHandSideWithBodyForce | ( | const Real | currentTime, |
const vector_Type & | rhsTimeAdvance | ||
) |
Updates the system at the end of each time step given a source term.
rhsTimeAdvance | the portion of the rhs of the discrete equation which comes from TA. |
Definition at line 1059 of file StructuralOperator.hpp.
|
inline |
Updates the rhs at the start of each time step.
rhs | solid right hand side ! |
Definition at line 315 of file StructuralOperator.hpp.
void computeRHSNoBC | ( | void | ) |
Comuptes the right hand side in the updateSystem methods.
void buildSystem | ( | const Real | coefficient | ) |
Compute the mass matrix and it calls the method to build the linear part of the stiffness matrix of the material class.
Definition at line 1082 of file StructuralOperator.hpp.
void computeMassMatrix | ( | const Real | factor = 1. | ) |
Compute the mass matrix and the linear part of the stiffness matrix.
matrix | the matrix containing the mass matrix and the linear part of he stiffness matrix |
rescale | factor for FSI problems |
Number of displacement components
Definition at line 1098 of file StructuralOperator.hpp.
void iterate | ( | const bcHandler_Type & | bch | ) |
Solve the non-linear system.
bch | BCHander object containing the boundary conditions |
Definition at line 1156 of file StructuralOperator.hpp.
void iterateLin | ( | bcHandler_Type & | bch | ) |
Solve the linearized problem. Used in FSI segregated in ExactJacobian.
bch | BCHander object containing the boundary conditions |
Definition at line 1213 of file StructuralOperator.hpp.
void showMe | ( | std::ostream & | c = std::cout | ) | const |
void updateJacobian | ( | const vector_Type & | solution, |
matrixPtr_Type & | jacobian | ||
) |
Update the Jacobian Matrix at each iteration of the nonLinearRichardson method.
solution | the current solution at each iteration of the nonLinearRichardson method |
jacobian | the Jacobian matrix that must be updated |
Definition at line 1801 of file StructuralOperator.hpp.
void updateJacobian | ( | const vector_Type & | solution | ) |
Update the Jacobian Matrix at each iteration of the nonLinearRichardson method.
Note: this method is used in FSIExactJacobian
solution | the current solution at each iteration of the nonLinearRichardson method |
Definition at line 1831 of file StructuralOperator.hpp.
void solveJac | ( | vector_Type & | step, |
const vector_Type & | residual, | ||
Real & | linear_rel_tol | ||
) |
Solves the tangent problem for newton iterations.
step | the vector containing the solution of the sistem J*step=-Res |
res | the vector conteining the residual |
lin_res_tol | linear_rel_tol send for the relative tolerance to the linear solver is therefore eta. eta is determined by the modified Eisenstat-Walker formula |
Definition at line 1839 of file StructuralOperator.hpp.
void solveJacobian | ( | vector_Type & | step, |
const vector_Type & | residual, | ||
Real & | linear_rel_tol, | ||
bcHandler_Type & | BCd | ||
) |
Solves the tangent problem with custom BC.
step | the vector containing the solution of the sistem J*step=-Res |
res | the vector conteining the residual |
lin_res_tol | linear_rel_tol send for the relative tolerance to the linear solver is therefore eta. eta is determined by the modified Eisenstat-Walker formula |
BCd | BCHandler object containing the boundary condition |
Definition at line 1849 of file StructuralOperator.hpp.
void evalResidual | ( | vector_Type & | residual, |
const vector_Type & | solution, | ||
Int | iter | ||
) |
Evaluates residual for newton interations.
res | residal vector that is update every time the method is called |
sol | solution vector from which the residual is computed |
iter | iteration of the nonLinearRichardson method |
Definition at line 1620 of file StructuralOperator.hpp.
void evalResidualDisplacement | ( | const vector_Type & | solution | ) |
Evaluates residual of the displacement for FSI problems.
sol,the | current displacement of he sturcture |
Definition at line 1686 of file StructuralOperator.hpp.
void evalResidualDisplacementLin | ( | const vector_Type & | solution | ) |
Evaluates residual of the displacement in the Linearized problem of ExactJcobian. FSI problems.
sol,the | current displacement of he sturcture |
Definition at line 1710 of file StructuralOperator.hpp.
void initialize | ( | const function & | d0 | ) |
Sets the initial displacement, velocity, acceleration.
d0 | space function describing the initial displacement |
w0 | space function describing the initial velocity |
a0 | space function describing the initial acceleration |
Definition at line 1734 of file StructuralOperator.hpp.
void initialize | ( | vectorPtr_Type | d0 | ) |
Sets the initial displacement, velocity, acceleration.
d0 | space function describing the initial displacement |
w0 | empty vector |
a0 | empty vector |
Definition at line 1727 of file StructuralOperator.hpp.
Computes the velocity and acceleration vector at the n-th time step.
Reduce the complete solution to the solution on the pocessor with rank 0
disp | displacement solution |
vel | velocity solution |
Definition at line 1741 of file StructuralOperator.hpp.
void computeMatrix | ( | matrixPtr_Type & | stiff, |
const vector_Type & | sol, | ||
Real const & | factor, | ||
const UInt | iter | ||
) |
Multiply the mass matrix and the linear stiffness matrix by the rescaleFactor.
in the linear case the solid matrix is constant, thus it does not need to be recomputed.Update (in the case of nonlinear material) the solid matrix
stiff | stiffness matrix |
sol | the current solution |
factor | the rescaleFactor |
It is right to do globalAssemble() inside the M_material class
Definition at line 1238 of file StructuralOperator.hpp.
void jacobianDistribution | ( | vectorPtr_Type | displacement, |
vector_Type & | jacobianDistribution | ||
) |
compute the value of the determinant of F in all the volumes of the mesh
displacement | the solution at a certain time |
Definition at line 1265 of file StructuralOperator.hpp.
void colorMesh | ( | vector_Type & | meshColors | ) |
compute the value of the determinant of F in all the volumes of the mesh
displacement | the solution at a certain time |
Definition at line 1462 of file StructuralOperator.hpp.
void computeCauchyStressTensor | ( | const vectorPtr_Type | disp, |
const QuadratureRule & | evalQuad, | ||
vectorPtr_Type | sigma_1, | ||
vectorPtr_Type | sigma_2, | ||
vectorPtr_Type | sigma_3 | ||
) |
Compute the three columns of the Cauchy stress tensor.
displacement | at a certain time |
Definition at line 1502 of file StructuralOperator.hpp.
void computePrincipalTensions | ( | vectorPtr_Type | sigma_1, |
vectorPtr_Type | sigma_2, | ||
vectorPtr_Type | sigma_3, | ||
vectorPtr_Type | vectorEigenvalue | ||
) |
Compute the nodal principal tensions given the cauchy stress tensor.
The | three vectors of the three columns of the Cauchy stress tensor |
Definition at line 1518 of file StructuralOperator.hpp.
|
inline |
Setters Set the BCHandler object.
Definition at line 496 of file StructuralOperator.hpp.
|
inline |
Set the source object.
Definition at line 506 of file StructuralOperator.hpp.
|
inline |
Set the source object.
Definition at line 512 of file StructuralOperator.hpp.
|
inline |
Set the source object.
Definition at line 518 of file StructuralOperator.hpp.
|
inline |
Set the recur parameter.
Definition at line 530 of file StructuralOperator.hpp.
void setDataFromGetPot | ( | const GetPot & | dataFile | ) |
Set the data fields with the Getpot data file for preconditioners and solver.
Definition at line 1758 of file StructuralOperator.hpp.
|
inline |
Definition at line 538 of file StructuralOperator.hpp.
void constructPatchAreaVector | ( | vector_Type & | patchArea, |
const vector_Type & | solution | ||
) |
constructPatchAreaVector: This method build the patch area vector used in the reconstruction process
NONE |
Definition at line 1385 of file StructuralOperator.hpp.
void reconstructElementaryVector | ( | VectorElemental & | elVecSigma, |
vector_Type & | patchArea, | ||
UInt | nVol | ||
) |
reconstructElementaryVector: This method applies a reconstruction procedure on the elvec that is passed
elvecTens | VectorElemental over which the reconstruction is applied |
Definition at line 1437 of file StructuralOperator.hpp.
|
inline |
Getters Get the Epetramap.
Definition at line 564 of file StructuralOperator.hpp.
|
inline |
Get the Displayer object.
Definition at line 570 of file StructuralOperator.hpp.
|
inline |
Definition at line 575 of file StructuralOperator.hpp.
|
inline |
Get the matrix containing the mass mtrix and the linear part of the stiffness matrix.
Get the mass matrix
Definition at line 584 of file StructuralOperator.hpp.
|
inline |
Get the FESpace object.
Definition at line 590 of file StructuralOperator.hpp.
|
inline |
Get the ETFESpace object.
Definition at line 596 of file StructuralOperator.hpp.
|
inline |
Get the bCHandler object.
Definition at line 602 of file StructuralOperator.hpp.
|
inline |
Get the residual.
Definition at line 608 of file StructuralOperator.hpp.
|
inline |
Get the source term.
Definition at line 614 of file StructuralOperator.hpp.
|
inline |
Get the displacement.
Definition at line 621 of file StructuralOperator.hpp.
|
inline |
Definition at line 626 of file StructuralOperator.hpp.
|
inline |
Get the right hand sde without BC.
Definition at line 632 of file StructuralOperator.hpp.
|
inline |
Definition at line 637 of file StructuralOperator.hpp.
|
inline |
Get the right hand. The member rhsCopy is used for Debug purposes!
Definition at line 643 of file StructuralOperator.hpp.
|
inline |
Definition at line 647 of file StructuralOperator.hpp.
|
inline |
Definition at line 652 of file StructuralOperator.hpp.
|
inline |
Get the comunicator object.
Definition at line 658 of file StructuralOperator.hpp.
|
inline |
Get the rescaleFactor.
Definition at line 664 of file StructuralOperator.hpp.
|
inline |
Get the offset parameter. It is taken into account when the boundary conditions are applied and the matrices are assembled.
Definition at line 672 of file StructuralOperator.hpp.
|
inline |
Get the offset parameter. It is taken into account when the boundary conditions are applied and the matrices are assembled.
Definition at line 680 of file StructuralOperator.hpp.
|
inline |
Do nothing in the linear case: the matrix remains constant.
Otherwise substitute the matrix with an updated oneGet the Solid Matrix
Definition at line 689 of file StructuralOperator.hpp.
|
inline |
Get the thickness.
Definition at line 695 of file StructuralOperator.hpp.
Get the Young modulus.
Definition at line 701 of file StructuralOperator.hpp.
Get the Poisson coefficient.
Definition at line 707 of file StructuralOperator.hpp.
|
inline |
Get the density.
Definition at line 713 of file StructuralOperator.hpp.
|
inline |
Get the data container.
Definition at line 719 of file StructuralOperator.hpp.
void apply | ( | const vector_Type & | sol, |
vector_Type & | res | ||
) | const |
Definition at line 1895 of file StructuralOperator.hpp.
|
inline |
Get the density.
Definition at line 727 of file StructuralOperator.hpp.
|
inline |
Get the density.
Definition at line 733 of file StructuralOperator.hpp.
|
inline |
Definition at line 738 of file StructuralOperator.hpp.
|
protected |
Apply boundary condition.
matrix | the matrix of the system |
rhs | the right hand side of the system |
BCh | BCHandler object |
offset | the offset parameter |
Definition at line 1903 of file StructuralOperator.hpp.
|
inlineprotected |
Definition at line 760 of file StructuralOperator.hpp.
|
protected |
construct the map between the markers and the volumes
VOID |
Definition at line 974 of file StructuralOperator.hpp.
|
protected |
Protected Members.
Definition at line 776 of file StructuralOperator.hpp.
|
protected |
Definition at line 778 of file StructuralOperator.hpp.
|
protected |
Definition at line 780 of file StructuralOperator.hpp.
|
protected |
Definition at line 782 of file StructuralOperator.hpp.
|
protected |
Definition at line 784 of file StructuralOperator.hpp.
|
protected |
data for solving tangent problem with aztec + preconditioner
Definition at line 787 of file StructuralOperator.hpp.
|
protected |
Definition at line 788 of file StructuralOperator.hpp.
|
protected |
Elementary matrices and vectors.
Definition at line 791 of file StructuralOperator.hpp.
|
protected |
linearized velocity
Definition at line 794 of file StructuralOperator.hpp.
|
protected |
right hand side displacement
Definition at line 797 of file StructuralOperator.hpp.
|
protected |
Definition at line 799 of file StructuralOperator.hpp.
|
protected |
Definition at line 800 of file StructuralOperator.hpp.
|
protected |
right hand side
Definition at line 803 of file StructuralOperator.hpp.
|
protected |
Definition at line 805 of file StructuralOperator.hpp.
|
protected |
|
protected |
files for lists of iterations and residuals per timestep
Definition at line 813 of file StructuralOperator.hpp.
|
protected |
Definition at line 814 of file StructuralOperator.hpp.
|
protected |
BCHandler object.
Definition at line 817 of file StructuralOperator.hpp.
|
protected |
Map Epetra.
Definition at line 820 of file StructuralOperator.hpp.
|
protected |
Matrix M: mass.
Definition at line 823 of file StructuralOperator.hpp.
|
protected |
Matrix Temp: Temporary matrix to compute residuals or rhs.
Definition at line 826 of file StructuralOperator.hpp.
|
protected |
Jacobian Matrix: Matrix to store the jacobian of the newton method.
Definition at line 830 of file StructuralOperator.hpp.
|
protected |
level of recursion for Aztec (has a sens with FSI coupling)
Definition at line 834 of file StructuralOperator.hpp.
|
protected |
Definition at line 836 of file StructuralOperator.hpp.
|
protected |
Definition at line 837 of file StructuralOperator.hpp.
|
protected |
Definition at line 839 of file StructuralOperator.hpp.
|
protected |
Definition at line 840 of file StructuralOperator.hpp.
|
protected |
Material class.
Definition at line 845 of file StructuralOperator.hpp.
|
protected |
Map between markers and volumes on the mesh.
Definition at line 848 of file StructuralOperator.hpp.
|
protected |
Map between markers and volumes on the mesh.
Definition at line 851 of file StructuralOperator.hpp.
|
protected |
Elementary matrix for the tensor F.
Definition at line 854 of file StructuralOperator.hpp.
|
protected |
Definition at line 855 of file StructuralOperator.hpp.
|
protected |
Definition at line 858 of file StructuralOperator.hpp.