LifeV
|
Fluid-Structure Interface operator class. More...
#include <FSIOperator.hpp>
Constructors, Destructor | |
FSIOperator () | |
virtual | ~FSIOperator () |
Virtual Public Methods | |
virtual void | setDataFile (const dataFile_Type &data) |
initializes the GetPot data file More... | |
virtual void | setupFEspace () |
sets the space discretization parameters More... | |
virtual void | partitionMeshes () |
partitions the meshes for the fluid and the structure More... | |
void | partitionMeshes (meshFilter_Type &fluidMeshFilter, meshFilter_Type &solidMeshFilter) |
reads the meshes already partitioned for the fluid and the structure More... | |
virtual void | setupDOF () |
sets up the correspondences between the fluid and structure degrees of freedom across the interface. More... | |
virtual void | setupDOF (meshFilter_Type &) |
reads from HDF5 file the correspondences between the fluid and structure degrees of freedom across the interface. More... | |
virtual void | setupFluidSolid () |
setup of the fluid and solid solver classes More... | |
virtual void | setupFluidSolid (UInt const fluxes) |
setup of the fluid and solid solver classes More... | |
virtual void | setupSystem () |
Setup method. More... | |
virtual void | buildSystem () |
Builds the local matrices. More... | |
virtual void | updateSystem () |
Updates the FSI system. More... | |
void | couplingVariableExtrap () |
Extrapolates an approximation of the solution. More... | |
virtual void | solveJac (vector_Type &muk, const vector_Type &res, const Real linearRelTol)=0 |
solves the Jacobian system More... | |
virtual void | evalResidual (vector_Type &res, const vector_Type &disp, const UInt iter)=0 |
Evaluates the nonlinear residual of the FSI system. More... | |
virtual void | updateSolution (const vector_Type &solution) |
Update the solution after NonLinearRichardson is called. More... | |
virtual void | setVectorInStencils (const vectorPtr_Type &, const vectorPtr_Type &, const vectorPtr_Type &, const UInt) |
Set vectors for restart. More... | |
virtual void | setFluidVectorInStencil (const vectorPtr_Type &, const vectorPtr_Type &, const UInt) |
virtual void | setSolidVectorInStencil (const vectorPtr_Type &, const UInt) |
virtual void | setALEVectorInStencil (const vectorPtr_Type &, const UInt, const bool) |
virtual void | finalizeRestart () |
virtual void | initialize (fluid_Type::function_Type const &u0, fluid_Type::function_Type const &p0, solid_Type::function const &d0, solid_Type::function const &w0, fluid_Type::function_Type const &df0) |
Initializes all the quantities using functions. More... | |
MONOLITHIC Solver Methods - Implemented There | |
virtual void | iterateMesh (const vector_Type &) |
virtual void | setupBDF (const vector_Type &) |
virtual void | updateRHS () |
virtual void | applyBoundaryConditions () |
Public Methods | |
void | initializeTimeAdvance (const std::vector< vectorPtr_Type > &initialFluidVel, const std::vector< vectorPtr_Type > &initialSolidDisp, const std::vector< vectorPtr_Type > &initialFluiDisp) |
Initializes the TimeAdvance scheme which should handle the fluid time discretization, solid and move mesh. More... | |
virtual void | initializeMonolithicOperator (std::vector< vectorPtr_Type >, std::vector< vectorPtr_Type >, std::vector< vectorPtr_Type >) |
void | initializeFluid (const vector_Type &velAndPressure, const vector_Type &displacement) |
initializes the fluid solver with vectors More... | |
void | initializeSolid (vectorPtr_Type displacement, vectorPtr_Type) |
initializes the solid solver with vectors More... | |
void | moveMesh (const vector_Type &disp) |
moves the mesh using the solution of the harmonic extension equation More... | |
void | createInterfaceMaps (std::map< ID, ID > const &locDofMap) |
Creates the Epetra maps for the interface. More... | |
void | transferFluidOnInterface (const vector_Type &_vec1, vector_Type &_vec2) |
Method to import an VectorEpetra defined on the fluid map (i.e. with the fluid numeration of the dofs) to the interface. More... | |
void | transferSolidOnFluid (const vector_Type &_vec1, vector_Type &_vec2) |
void | transferSolidOnInterface (const vector_Type &_vec1, vector_Type &_vec2) |
Method to import an VectorEpetra defined on the solid map (i.e. with the solid numeration of the dofs) to the interface. More... | |
void | transferInterfaceOnSolid (const vector_Type &_vec1, vector_Type &_vec2) |
Method to import an VectorEpetra defined on the solid map (i.e. with the solid numeration of the dofs) to the interface. More... | |
void | bcManageVectorRHS (const fluidBchandlerPtr_Type &bch, vector_Type &rhs) |
Update the RHS on the base of the fluid BC. More... | |
void | bcManageVectorRHS (const fluidBchandlerPtr_Type &bcHandlerFluid, const solidBchandlerPtr_Type &bcHandlerSolid, vector_Type &rhs) |
Update the RHS on the base of the fluid and solid BC. More... | |
void | setAlphaf () |
Method to set the Robin vector coefficient of the Robin–Neumann coupling scheme (as a constant vector vector) More... | |
void | setAlphafCoef () |
Method to compute the scalar coefficient of the Robin–Neumann coupling scheme. More... | |
void | setStructureToFluidParameters () |
Method calling setAlphaf and setAlphafCoef. More... | |
void | resetRHS () |
Reset the right hand side to zero. More... | |
Display Methods | |
bool | isLeader () const |
Displayer const & | displayer () |
Getter for the Displayer attribute. More... | |
Get Functions | |
void | extrapolation (vector_Type &extrapolation) const |
Get the extrapolation of the solution. More... | |
UInt | imposedFluxes () |
Returns the number of imposed fluxes. More... | |
const vector_Type & | lambdaFluid () const |
const vector_Type & | lambdaSolid () const |
const vector_Type & | lambdaSolidOld () const |
const vector_Type & | lambdaDotSolid () const |
const vector_Type & | sigmaFluid () const |
const vector_Type & | sigmaSolid () const |
const vector_Type & | lambdaFluidRepeated () const |
const vector_Type & | lambdaSolidRepeated () const |
const vector_Type & | lambdaDotSolidRepeated () const |
const vector_Type & | sigmaFluidRepeated () const |
const vector_Type & | sigmaSolidRepeated () const |
const vector_Type & | minusSigmaFluid () const |
const vector_Type & | minusSigmaFluidRepeated () const |
vector_Type & | Alphaf () const |
coefficient for the Robin–Neumann coupling scheme More... | |
commPtr_Type | worldComm () const |
bool | isFluid () const |
bool | isSolid () const |
bool | isLinearFluid () const |
bool | isLinearSolid () const |
int | getFluidLeaderId () const |
int | getSolidLeaderId () const |
const fluid_Type & | fluid () const |
Getter for the fluid solver. More... | |
const solid_Type & | solid () const |
Getter for the solid solver. More... | |
const meshMotion_Type & | meshMotion () const |
Getter for the harmonic extension solver. More... | |
fluid_Type & | fluid () |
Getter-Setter for the fluid solver. More... | |
solid_Type & | solid () |
Getter-Setter for the solid solver. More... | |
meshMotion_Type & | meshMotion () |
Getter-Setter for the mesh motion solver. More... | |
const data_Type & | data () const |
getter for the FSI data container More... | |
const data_Type::dataFluidPtr_Type & | dataFluid () const |
getter for the fluid data container More... | |
const data_Type::dataSolidPtr_Type & | dataSolid () const |
getter for the solid data container More... | |
mesh_Type & | fluidMesh () const |
getter for the unpartitioned fluid mesh More... | |
mesh_Type & | solidMesh () const |
getter for the unpartitioned solid mesh More... | |
mesh_Type & | fluidLocalMesh () |
getter for the partitioned fluid mesh More... | |
mesh_Type & | solidLocalMesh () |
getter for the partitioned solid mesh More... | |
const FESpace< mesh_Type, MapEpetra > & | uFESpace () const |
getter for the fluid velocity FESpace More... | |
std::shared_ptr< FESpace< mesh_Type, MapEpetra > > | uFESpacePtr () const |
const FESpace< mesh_Type, MapEpetra > & | pFESpace () const |
getter for the fluid pressure FESpace More... | |
std::shared_ptr< FESpace< mesh_Type, MapEpetra > > | pFESpacePtr () const |
const FESpace< mesh_Type, MapEpetra > & | dFESpace () const |
getter for the solid displacement FESpace More... | |
std::shared_ptr< FESpace< mesh_Type, MapEpetra > > | dFESpacePtr () const |
const ETFESpace< mesh_Type, MapEpetra, 3, 3 > & | dFESpaceET () const |
getter for the solid displacement FESpace More... | |
std::shared_ptr< ETFESpace< mesh_Type, MapEpetra, 3, 3 > > | dFESpaceETPtr () const |
const FESpace< mesh_Type, MapEpetra > & | mmFESpace () const |
getter for the harmonic extension solution FESpace More... | |
std::shared_ptr< FESpace< mesh_Type, MapEpetra > > | mmFESpacePtr () const |
const vector_Type & | meshDisp () const |
getter for the harmonic extension solution More... | |
const vector_Type & | dispFluidMeshOld () const |
getter for the harmonic extension solution of the previous time step More... | |
virtual vector_Type & | veloFluidMesh () |
getter for the mesh velocity More... | |
vector_Type & | derVeloFluidMesh () |
getter for the mesh velocity increment (used for Newton FSI) More... | |
const dofInterface3DPtr_Type & | dofFluidToStructure () const |
const dofInterface3DPtr_Type & | dofStructureToSolid () const |
const dofInterface3DPtr_Type & | dofStructureToHarmonicExtension () const |
const dofInterface3DPtr_Type & | dofHarmonicExtensionToFluid () const |
std::shared_ptr< MapEpetra > & | fluidInterfaceMap () |
std::shared_ptr< MapEpetra > & | solidInterfaceMap () |
virtual std::shared_ptr< MapEpetra > & | couplingVariableMap () |
Getter for the map of the variable used for the coupling. More... | |
BCFunctionRobin & | bcfRobinOuterWall () |
Method to implement Robin boundary conditions on the external wall for the structure. More... | |
bcVectorInterfacePtr_Type | bcvStructureDisptoFluid () const |
bcVectorInterfacePtr_Type | bcvStructureToFluid () const |
bcVectorInterfacePtr_Type | bcvSolidLoadToStructure () const |
bcVectorInterfacePtr_Type | bcvFluidInterfaceDisp () const |
bcVectorInterfacePtr_Type | bcvHarmonicExtensionVelToFluid () const |
bcVectorInterfacePtr_Type | bcvDerHarmonicExtensionVelToFluid () const |
bcVectorInterfacePtr_Type | bcvStructureDispToHarmonicExtension () const |
bcVectorInterfacePtr_Type | bcvStructureDispToSolid () const |
bcVectorInterfacePtr_Type | bcvDerStructureDispToSolid () const |
bcVectorInterfacePtr_Type | bcvFluidLoadToStructure () const |
bcVectorInterfacePtr_Type | bcvDerFluidLoadToStructure () const |
bcVectorInterfacePtr_Type | bcvDerFluidLoadToFluid () const |
const fluidBchandlerPtr_Type & | BCh_fluid () const |
Getter for the BCHandler of the fluid problem. More... | |
const fluidBchandlerPtr_Type & | BCh_harmonicExtension () const |
Getter for the BCHandler of the harmonic extension problem. More... | |
const fluidBchandlerPtr_Type & | BCh_du () const |
Getter for the BCHandler of the linearized fluid problem (to be used in Newton for the partitioned FSI) More... | |
const fluidBchandlerPtr_Type & | BCh_du_inv () const |
Getter for the BCHandler of the linearized inverse of the fluid Steklov Poincare' operator (not used) More... | |
const solidBchandlerPtr_Type & | BCh_solid () const |
Getter for the BCHandler of the solid problem. More... | |
const solidBchandlerPtr_Type & | BCh_dz () const |
Getter for the BCHandler of the linearized solid problem. More... | |
const solidBchandlerPtr_Type & | BCh_dz_inv () const |
Getter for the BCHandler of the linearized inverse of the solid Steklov Poincare' operator (not used) More... | |
const vectorPtr_Type & | getRHS () const |
Getter for the right hand side. More... | |
const std::shared_ptr< TimeAdvance< vector_Type > > | ALETimeAdvance () const |
const std::shared_ptr< TimeAdvance< vector_Type > > | fluidTimeAdvance () const |
const std::shared_ptr< TimeAdvance< vector_Type > > | solidTimeAdvance () const |
const std::string | ALETimeAdvanceMethod () const |
const std::string | fluidTimeAdvanceMethod () const |
const std::string | solidTimeAdvanceMethod () const |
virtual const vector_Type & | solution () const |
gets the solution vector by reference More... | |
virtual void | getSolidDisp (vector_Type &soliddisp) |
gets the solid displacement by copy More... | |
virtual void | getSolidVel (vector_Type &solidvel) |
gets the solid velocity by copy More... | |
virtual void | exportSolidDisplacement (vector_Type &solidDisplacement) |
Export the solid displacement by copying it to an external vector. More... | |
virtual void | exportSolidVelocity (vector_Type &solidVelocity) |
Export the solid velocity by copying it to an external vector. More... | |
virtual void | exportSolidAcceleration (vector_Type &solidAcc) |
Export the solid acceleration by copying it to an external vector. More... | |
virtual void | exportFluidVelocity (vector_Type &fluidVelocity) |
Export the fluid velocity by copying it to an external vector. More... | |
virtual void | exportFluidPressure (vector_Type &fluidPressure) |
Export the fluid pressure by copying it to an external vector. More... | |
virtual void | exportFluidVelocityAndPressure (vector_Type &fluidVelocityAndPressure) |
Export the fluid velocity and pressure by copying it to an external vector. More... | |
virtual void | exportFluidDisplacement (vector_Type &fluidDisplacement) |
Export the fluid displacement by copying it to an external vector. More... | |
Set Functions | |
void | setComm (const commPtr_Type &comm, const commPtr_Type &worldComm) |
Setter for the local and world communicators. More... | |
void | setData (const dataPtr_Type &data) |
Setter for the FSI data. More... | |
void | setFluid (const fluidPtr_Type &fluid, const meshMotionPtr_Type &meshmotion) |
Setter for the fluid and geometry problems. More... | |
void | setSolid (const solidPtr_Type &solid) |
Setter for the solid problem. More... | |
void | setFluid (const bool &isFluid) |
Setter for the "fluid" flag. More... | |
void | setSolid (const bool &isSolid) |
Setter for the "solid" flag. More... | |
void | setLinearFluid (const bool &linFluid) |
Setter for the "linear fluid" flag. More... | |
void | setLinearSolid (const bool &linSolid) |
Setter for the "linear solid" flag. More... | |
void | setFluidLeader (const int &fluidLeader) |
void | setSolidLeader (const int &solidLeader) |
virtual void | setFluidBC (const fluidBchandlerPtr_Type &bc_fluid) |
Setter for the fluid BCHandler. More... | |
void | setLinFluidBC (const fluidBchandlerPtr_Type &bc_dfluid) |
Setter for the BCHandler of the linearized fluid problem (to be used in segregated Newton FSI) More... | |
void | setInvLinFluidBC (const fluidBchandlerPtr_Type &bc_dfluid_inv) |
Setter for the BCHandler of the inverse linearized fluid steklov Poincare' operator (to be used in SP FSI formulation) More... | |
void | setHarmonicExtensionBC (const fluidBchandlerPtr_Type &bc_he) |
Setter for the BCHandler of the gerometry problem (to be used in segregated Newton FSI) More... | |
virtual void | setSolidBC (const solidBchandlerPtr_Type &bc_solid) |
Setter for the fluid BCHandler. More... | |
void | setLinSolidBC (const solidBchandlerPtr_Type &bc_dsolid) |
Setter for the BCHandler of the linearized solid problem (to be used in segregated Newton FSI) More... | |
void | setInvLinSolidBC (const solidBchandlerPtr_Type &bc_dsolid_inv) |
Setter for the BCHandler of the inverse linearized solid steklov Poincare' operator (to be used in SP FSI formulation) More... | |
void | setLambdaFluid (const vector_Type &lambda) |
Setter for the interface displacement (partitioned according to the fluid) More... | |
void | setLambdaSolid (const vector_Type &lambda) |
Setter for the interface displacement (partitioned according to the solid) More... | |
void | setLambdaSolidOld (const vector_Type &lambda) |
Setter for the solid interface displacement at the previous time step. More... | |
void | setLambdaDotSolid (const vector_Type &lambda) |
Setter for the solid interface velocity at the previous time step. More... | |
void | setSigmaFluid (const vector_Type &sigma) |
Setter for the fluid interface stress. More... | |
void | setSigmaSolid (const vector_Type &sigma) |
Setter for the solid interface stress. More... | |
void | setMinusSigmaFluid (const vector_Type &sigma) |
void | setAlphafbcf (const bcFunction_Type &alphafbcf) |
Setter for the Robin coefficient of the Robin–Neumann coupling scheme (as a BCFunction) More... | |
void | setStructureDispToHarmonicExtension (const vector_Type &disp, UInt type=0) |
void | setStructureToFluid (const vector_Type &vel, UInt type=0) |
void | setStructureDispToFluid (const vector_Type &vel, UInt type=0) |
void | setStructureDispToSolid (const vector_Type &disp, UInt type=0) |
void | setDerStructureDispToSolid (const vector_Type &ddisp, UInt type=0) |
void | setSolidLoadToStructure (const vector_Type &load, UInt type=0) |
void | setHarmonicExtensionVelToFluid (const vector_Type &vel, UInt type=0) |
void | setDerHarmonicExtensionVelToFluid (const vector_Type &dvel, UInt type=0) |
void | setFluidLoadToStructure (const vector_Type &load, UInt type=0) |
void | setDerFluidLoadToStructure (const vector_Type &dload, UInt type=0) |
void | setDerFluidLoadToFluid (const vector_Type &dload, UInt type=0) |
void | setRobinOuterWall (const function_Type &dload, const function_Type &E) |
void | setSolutionDerivative (const vector_Type &solutionDerivative) |
Setter for the time derivative of the interface displacement. More... | |
void | setupTimeAdvance (const dataFile_Type &dataFile) |
Setup of the TimeAdvance classes given the input data file. More... | |
Protected Methods | |
virtual void | variablesInit (const std::string &dOrder) |
initailize the variables More... | |
void | transferMeshMotionOnFluid (const vector_Type &_vec1, vector_Type &_vec2) |
Interpolates the mesh motion dofs on the fluid. More... | |
void | interpolateVelocity (const vector_Type &_vec1, vector_Type &_vec2) |
Interpolates mesh motion into velocity. More... | |
void | interpolateInterfaceDofs (const FESpace< mesh_Type, MapEpetra > &_fespace1, const vector_Type &_vec1, const FESpace< mesh_Type, MapEpetra > &_fespace2, vector_Type &_vec2, dofInterface3DPtr_Type &_dofInterface) |
Interpolates to vectors on the interface. More... | |
Private Methods | |
FSIOperator (const FSIOperator &) | |
Private Copy Constructor. More... | |
Fluid-Structure Interface operator class.
This is the base class for the FSI solvers in LifeV. It contains the methods to evaluate the residual and compute the Jacobian matrix, which make it suited for the generalized Newton algorithm implemented in NonlinearRichardson.hpp. The fluid and structure classes are members of this class and different formulations (e.g. Monolithic [4] , segregated Newton [6] , Dirichlet–Neumann [5] , Robin Neumann [1] ) are implemented in the derived classes.
Definition at line 111 of file FSIOperator.hpp.
typedef RegionMesh<LinearTetra> mesh_Type |
Definition at line 120 of file FSIOperator.hpp.
typedef ExporterHDF5Mesh3D<mesh_Type> meshFilter_Type |
Definition at line 122 of file FSIOperator.hpp.
Definition at line 125 of file FSIOperator.hpp.
typedef StructuralOperator<mesh_Type> solid_Type |
Definition at line 126 of file FSIOperator.hpp.
Definition at line 127 of file FSIOperator.hpp.
Definition at line 128 of file FSIOperator.hpp.
typedef StructuralOperator<mesh_Type> solidLin_Type |
Definition at line 129 of file FSIOperator.hpp.
typedef std::shared_ptr<fluid_Type> fluidPtr_Type |
Definition at line 130 of file FSIOperator.hpp.
typedef std::shared_ptr<solid_Type> solidPtr_Type |
Definition at line 131 of file FSIOperator.hpp.
typedef std::shared_ptr<meshMotion_Type> meshMotionPtr_Type |
Definition at line 132 of file FSIOperator.hpp.
typedef std::shared_ptr<fluidLin_Type> fluidLinPtr_Type |
Definition at line 133 of file FSIOperator.hpp.
typedef std::shared_ptr<solidLin_Type> solidLinPtr_Type |
Definition at line 134 of file FSIOperator.hpp.
typedef fluid_Type::vector_Type vector_Type |
Definition at line 135 of file FSIOperator.hpp.
typedef std::shared_ptr<vector_Type> vectorPtr_Type |
Definition at line 136 of file FSIOperator.hpp.
typedef vector_Type solution_Type |
Definition at line 137 of file FSIOperator.hpp.
typedef std::shared_ptr<solution_Type> solutionPtr_Type |
Definition at line 138 of file FSIOperator.hpp.
Definition at line 139 of file FSIOperator.hpp.
Definition at line 140 of file FSIOperator.hpp.
typedef std::function< Real ( const Real&, const Real&, const Real&, const Real&, const ID& ) > function_Type |
Definition at line 142 of file FSIOperator.hpp.
typedef Real( * bcFunction_Type) (const Real &, const Real &, const Real &, const Real &, const ID &) |
Definition at line 143 of file FSIOperator.hpp.
typedef std::shared_ptr<DOFInterface3Dto3D> dofInterface3DPtr_Type |
Definition at line 145 of file FSIOperator.hpp.
typedef std::shared_ptr<DOFInterface3Dto2D> dofInterface2DPtr_Type |
Definition at line 146 of file FSIOperator.hpp.
typedef std::shared_ptr<BCVectorInterface> bcVectorInterfacePtr_Type |
Definition at line 147 of file FSIOperator.hpp.
Definition at line 148 of file FSIOperator.hpp.
Definition at line 149 of file FSIOperator.hpp.
typedef BCHandler solidBchandler_Type |
Definition at line 150 of file FSIOperator.hpp.
typedef std::shared_ptr<solidBchandler_Type> solidBchandlerPtr_Type |
Definition at line 151 of file FSIOperator.hpp.
Definition at line 152 of file FSIOperator.hpp.
typedef std::shared_ptr<data_Type> dataPtr_Type |
Definition at line 153 of file FSIOperator.hpp.
typedef std::map<ID, ID>::const_iterator iterator_Type |
Definition at line 154 of file FSIOperator.hpp.
typedef FactorySingleton<Factory<FSIOperator, std::string> > FSIFactory_Type |
Definition at line 155 of file FSIOperator.hpp.
typedef Displayer::commPtr_Type commPtr_Type |
Definition at line 156 of file FSIOperator.hpp.
typedef GetPot dataFile_Type |
Definition at line 157 of file FSIOperator.hpp.
typedef std::shared_ptr<dataFile_Type> dataFilePtr_Type |
Definition at line 158 of file FSIOperator.hpp.
FSIOperator | ( | ) |
Definition at line 53 of file FSIOperator.cpp.
|
virtual |
Definition at line 151 of file FSIOperator.cpp.
|
inlineprivate |
Private Copy Constructor.
Definition at line 1308 of file FSIOperator.hpp.
|
virtual |
initializes the GetPot data file
Reimplemented in FSIFixedPoint, and FSIExactJacobian.
Definition at line 160 of file FSIOperator.cpp.
|
virtual |
sets the space discretization parameters
The FE discretization is set accordingly to what specified in the FSIdata member (order of accuracy for the fluid pressure, velocity and for the structure).
Reimplemented in FSIMonolithic, FSIFixedPoint, and FSIExactJacobian.
Definition at line 181 of file FSIOperator.cpp.
|
virtual |
partitions the meshes for the fluid and the structure
This method is not called when the mesh partition is done offline
Definition at line 392 of file FSIOperator.cpp.
void partitionMeshes | ( | meshFilter_Type & | fluidMeshFilter, |
meshFilter_Type & | solidMeshFilter | ||
) |
reads the meshes already partitioned for the fluid and the structure
The offline partitioning can avoid the call to partitionMesh and the memory overhead of saving the entire unpartitioned mesh. The offline partitioned mesh must be saved in HDF5 format. { This method still does not work for the partitioned algorithms }
Definition at line 408 of file FSIOperator.cpp.
|
virtual |
sets up the correspondences between the fluid and structure degrees of freedom across the interface.
This method introduces a non scalable loop, in DOFInterface3Dto3D. It is preferable to avoid it for massively parallel computetions, using the offline partitioner. However it is much lighter that the correspondent method for partitioned algorithms.
Reimplemented in FSIMonolithic, and FSIMonolithicGE.
Definition at line 417 of file FSIOperator.cpp.
|
inlinevirtual |
reads from HDF5 file the correspondences between the fluid and structure degrees of freedom across the interface.
still not implemented for all the FSI formulations
Reimplemented in FSIMonolithic.
Definition at line 214 of file FSIOperator.hpp.
|
virtual |
setup of the fluid and solid solver classes
This method computes the number of fluxes assigned at the boundaries and calls setupFluidSolid(UInt fluxes)
Reimplemented in FSIMonolithic, FSIFixedPoint, and FSIExactJacobian.
Definition at line 489 of file FSIOperator.cpp.
|
virtual |
setup of the fluid and solid solver classes
Fluid, solid and harmonic extension solvers are instantiated
Reimplemented in FSIMonolithic, FSIMonolithicGI, and FSIMonolithicGE.
Definition at line 495 of file FSIOperator.cpp.
|
virtual |
Setup method.
the setup is called for the fluid, structure and harmonic extension solvers
Reimplemented in FSIMonolithic, and FSIMonolithicGE.
Definition at line 516 of file FSIOperator.cpp.
|
virtual |
Builds the local matrices.
The matrix for the harmonic extension, and the constant part of the matrices for the fluid and solid solvers are built.
Reimplemented in FSIMonolithic, and FSIMonolithicGI.
Definition at line 538 of file FSIOperator.cpp.
|
virtual |
Updates the FSI system.
The system is updated for the next time iteration
Reimplemented in FSIMonolithic, and FSIMonolithicGE.
Definition at line 559 of file FSIOperator.cpp.
void couplingVariableExtrap | ( | ) |
Extrapolates an approximation of the solution.
Extrapolates the solution for the next time step. This method should be handled by a more general time-advance class.
Definition at line 590 of file FSIOperator.cpp.
|
pure virtual |
solves the Jacobian system
The implementation of this method distinguish the various FSI formulations which derive from this class. For this reason it must be pure virtual, snd implemented in the child classes.
muk | unknown solution at the k-th nonlinear iteration |
res | residual vector (the right hand side of the Jacobian system) |
linearRelTol | tolerance for the nonlinear solver |
Implemented in FSIMonolithic, FSIFixedPoint, and FSIExactJacobian.
|
pure virtual |
Evaluates the nonlinear residual of the FSI system.
The implementation of this method also depends on the child classes, though it does not characterize them.
res | residual vector to be computed |
disp | current unknown solution |
iter | nonlinear iteration counter. The part of th rhs related to the time discretization is computed only for iter=0 |
Implemented in FSIMonolithic, FSIMonolithicGE, FSIFixedPoint, FSIMonolithicGI, and FSIExactJacobian.
|
virtual |
Update the solution after NonLinearRichardson is called.
Eventually it can update also some post-processing quantity.
Reimplemented in FSIMonolithic, FSIMonolithicGE, and FSIMonolithicGI.
Definition at line 616 of file FSIOperator.cpp.
|
inlinevirtual |
Set vectors for restart.
Set vectors for restart
Reimplemented in FSIMonolithic.
Definition at line 286 of file FSIOperator.hpp.
|
inlinevirtual |
Reimplemented in FSIMonolithic.
Definition at line 292 of file FSIOperator.hpp.
|
inlinevirtual |
Reimplemented in FSIMonolithic.
Definition at line 294 of file FSIOperator.hpp.
|
inlinevirtual |
Reimplemented in FSIMonolithic, FSIMonolithicGI, and FSIMonolithicGE.
Definition at line 296 of file FSIOperator.hpp.
|
inlinevirtual |
Reimplemented in FSIMonolithic.
Definition at line 298 of file FSIOperator.hpp.
|
virtual |
Initializes all the quantities using functions.
calls the initialize methods for the subproblems. The mesh velocity is used to compute the convective term in the fluid equations
u0 | initial fluid velocity |
p0 | initial fluid pressure |
d0 | initial solid displacement |
w0 | initial mesh velocity |
Definition at line 657 of file FSIOperator.cpp.
|
inlinevirtual |
Reimplemented in FSIMonolithicGE.
Definition at line 320 of file FSIOperator.hpp.
|
inlinevirtual |
Definition at line 324 of file FSIOperator.hpp.
|
inlinevirtual |
Reimplemented in FSIMonolithic.
Definition at line 325 of file FSIOperator.hpp.
|
inlinevirtual |
Reimplemented in FSIMonolithicGE, and FSIMonolithicGI.
Definition at line 326 of file FSIOperator.hpp.
|
inlinestatic |
Definition at line 332 of file FSIOperator.hpp.
|
inlinestatic |
Definition at line 337 of file FSIOperator.hpp.
|
inlinestatic |
Definition at line 341 of file FSIOperator.hpp.
|
inlinestatic |
Definition at line 346 of file FSIOperator.hpp.
|
inlinestatic |
Definition at line 350 of file FSIOperator.hpp.
|
inlinestatic |
Definition at line 355 of file FSIOperator.hpp.
void initializeTimeAdvance | ( | const std::vector< vectorPtr_Type > & | initialFluidVel, |
const std::vector< vectorPtr_Type > & | initialSolidDisp, | ||
const std::vector< vectorPtr_Type > & | initialFluiDisp | ||
) |
Initializes the TimeAdvance scheme which should handle the fluid time discretization, solid and move mesh.
Initialization of the time advancing classes for fluid, structure and geometry problem.
Definition at line 764 of file FSIOperator.cpp.
|
inlinevirtual |
Reimplemented in FSIMonolithic.
Definition at line 388 of file FSIOperator.hpp.
void initializeFluid | ( | const vector_Type & | velAndPressure, |
const vector_Type & | displacement | ||
) |
initializes the fluid solver with vectors
velAndPressure | initial vector containing the velocity and pressure |
displacement | initial vector containing the mesh displacement |
Definition at line 797 of file FSIOperator.cpp.
void initializeSolid | ( | vectorPtr_Type | displacement, |
vectorPtr_Type | |||
) |
initializes the solid solver with vectors
displacement | initial vector containing the structure displacement |
velocity | initial vector containing the velocity, used for the initialization of the TimeAdvanceNewmark scheme |
Definition at line 805 of file FSIOperator.cpp.
void moveMesh | ( | const vector_Type & | disp | ) |
moves the mesh using the solution of the harmonic extension equation
disp | displacement of the mesh, must be the difference between the current solution of the HE problem and the one at the previous time step. |
Definition at line 812 of file FSIOperator.cpp.
Creates the Epetra maps for the interface.
Given a std::map holding the numeration of the interface according to the fluid (first) and the solid (second), builds the MapEpetras for the interface dofs (e.g. M_fluidInterfaceMap). Note that when both the fluid and solid meshes are partitioned (e.g. in the monolithic solver) the local dofs are those of the FLUID partition of the interface, even when the numeration refers to the solid.
Definition at line 821 of file FSIOperator.cpp.
void transferFluidOnInterface | ( | const vector_Type & | _vec1, |
vector_Type & | _vec2 | ||
) |
Method to import an VectorEpetra defined on the fluid map (i.e. with the fluid numeration of the dofs) to the interface.
Note that the output vector will have the solid numeration on the interface! By default in fact the vectors on the FSI interface in LifeV are numerated according to the solid.
Definition at line 896 of file FSIOperator.cpp.
void transferSolidOnFluid | ( | const vector_Type & | _vec1, |
vector_Type & | _vec2 | ||
) |
Definition at line 938 of file FSIOperator.cpp.
void transferSolidOnInterface | ( | const vector_Type & | _vec1, |
vector_Type & | _vec2 | ||
) |
Method to import an VectorEpetra defined on the solid map (i.e. with the solid numeration of the dofs) to the interface.
The output vector has the solid numeration of the dofs and is partitioned according to the solid partition. This method is not used in the monolithic solvers.
Definition at line 977 of file FSIOperator.cpp.
void transferInterfaceOnSolid | ( | const vector_Type & | _vec1, |
vector_Type & | _vec2 | ||
) |
Method to import an VectorEpetra defined on the solid map (i.e. with the solid numeration of the dofs) to the interface.
the output vector have the numeration of the solid, as in transferSolidOnInterface, but is partitioned according to the fluid! This method is not used in the monolithic solvers.
Definition at line 1018 of file FSIOperator.cpp.
void bcManageVectorRHS | ( | const fluidBchandlerPtr_Type & | bch, |
vector_Type & | rhs | ||
) |
Update the RHS on the base of the fluid BC.
This method is used by the Multiscale to update the RHS vector for the nonlinear subiterations.
bcHandlerFluid | fluid BC handler |
rhs | RHS of the FSI problem |
Definition at line 1058 of file FSIOperator.cpp.
void bcManageVectorRHS | ( | const fluidBchandlerPtr_Type & | bcHandlerFluid, |
const solidBchandlerPtr_Type & | bcHandlerSolid, | ||
vector_Type & | rhs | ||
) |
Update the RHS on the base of the fluid and solid BC.
This method is used by the Multiscale to update the RHS vector for the nonlinear subiterations.
bcHandlerFluid | fluid BC handler |
bcHandlerSolid | solid BC handler |
rhs | RHS of the FSI problem |
Definition at line 1069 of file FSIOperator.cpp.
|
inline |
Method to set the Robin vector coefficient of the Robin–Neumann coupling scheme (as a constant vector vector)
Definition at line 462 of file FSIOperator.hpp.
void setAlphafCoef | ( | ) |
Method to compute the scalar coefficient of the Robin–Neumann coupling scheme.
Definition at line 1086 of file FSIOperator.cpp.
void setStructureToFluidParameters | ( | ) |
Method calling setAlphaf and setAlphafCoef.
Definition at line 1096 of file FSIOperator.cpp.
|
inline |
Reset the right hand side to zero.
This method is used in the multiscale framework during subiterations
Definition at line 475 of file FSIOperator.hpp.
bool isLeader | ( | ) | const |
Definition at line 1118 of file FSIOperator.cpp.
Displayer const & displayer | ( | ) |
Getter for the Displayer attribute.
Definition at line 1141 of file FSIOperator.cpp.
|
inline |
Get the extrapolation of the solution.
extrapolation | vector to be filled with the extrapolated solution |
Definition at line 505 of file FSIOperator.hpp.
UInt imposedFluxes | ( | void | ) |
Returns the number of imposed fluxes.
Definition at line 634 of file FSIOperator.cpp.
|
inline |
Definition at line 519 of file FSIOperator.hpp.
|
inline |
Definition at line 523 of file FSIOperator.hpp.
|
inline |
Definition at line 527 of file FSIOperator.hpp.
|
inline |
Definition at line 531 of file FSIOperator.hpp.
|
inline |
Definition at line 535 of file FSIOperator.hpp.
|
inline |
Definition at line 539 of file FSIOperator.hpp.
|
inline |
Definition at line 544 of file FSIOperator.hpp.
|
inline |
Definition at line 548 of file FSIOperator.hpp.
|
inline |
Definition at line 552 of file FSIOperator.hpp.
|
inline |
Definition at line 556 of file FSIOperator.hpp.
|
inline |
Definition at line 560 of file FSIOperator.hpp.
|
inline |
Definition at line 567 of file FSIOperator.hpp.
|
inline |
Definition at line 572 of file FSIOperator.hpp.
|
inline |
coefficient for the Robin–Neumann coupling scheme
Definition at line 578 of file FSIOperator.hpp.
|
inline |
Definition at line 583 of file FSIOperator.hpp.
|
inline |
Definition at line 588 of file FSIOperator.hpp.
|
inline |
Definition at line 592 of file FSIOperator.hpp.
|
inline |
Definition at line 597 of file FSIOperator.hpp.
|
inline |
Definition at line 601 of file FSIOperator.hpp.
|
inline |
Definition at line 606 of file FSIOperator.hpp.
|
inline |
Definition at line 610 of file FSIOperator.hpp.
|
inline |
Getter for the fluid solver.
Definition at line 616 of file FSIOperator.hpp.
|
inline |
Getter for the solid solver.
Definition at line 621 of file FSIOperator.hpp.
|
inline |
Getter for the harmonic extension solver.
Definition at line 626 of file FSIOperator.hpp.
|
inline |
Getter-Setter for the fluid solver.
Definition at line 633 of file FSIOperator.hpp.
|
inline |
Getter-Setter for the solid solver.
Definition at line 639 of file FSIOperator.hpp.
|
inline |
Getter-Setter for the mesh motion solver.
Definition at line 645 of file FSIOperator.hpp.
|
inline |
getter for the FSI data container
Definition at line 653 of file FSIOperator.hpp.
|
inline |
getter for the fluid data container
Definition at line 658 of file FSIOperator.hpp.
|
inline |
getter for the solid data container
Definition at line 663 of file FSIOperator.hpp.
|
inline |
getter for the unpartitioned fluid mesh
Definition at line 669 of file FSIOperator.hpp.
|
inline |
getter for the unpartitioned solid mesh
Definition at line 674 of file FSIOperator.hpp.
|
inline |
getter for the partitioned fluid mesh
Definition at line 683 of file FSIOperator.hpp.
|
inline |
getter for the partitioned solid mesh
Definition at line 688 of file FSIOperator.hpp.
getter for the fluid velocity FESpace
Definition at line 694 of file FSIOperator.hpp.
Definition at line 698 of file FSIOperator.hpp.
getter for the fluid pressure FESpace
Definition at line 703 of file FSIOperator.hpp.
Definition at line 707 of file FSIOperator.hpp.
getter for the solid displacement FESpace
Definition at line 712 of file FSIOperator.hpp.
Definition at line 716 of file FSIOperator.hpp.
getter for the solid displacement FESpace
Definition at line 721 of file FSIOperator.hpp.
Definition at line 725 of file FSIOperator.hpp.
getter for the harmonic extension solution FESpace
Definition at line 730 of file FSIOperator.hpp.
Definition at line 734 of file FSIOperator.hpp.
|
inline |
getter for the harmonic extension solution
Definition at line 739 of file FSIOperator.hpp.
|
inline |
getter for the harmonic extension solution of the previous time step
Definition at line 744 of file FSIOperator.hpp.
|
inlinevirtual |
getter for the mesh velocity
Definition at line 749 of file FSIOperator.hpp.
|
inline |
getter for the mesh velocity increment (used for Newton FSI)
Definition at line 755 of file FSIOperator.hpp.
|
inline |
Definition at line 760 of file FSIOperator.hpp.
|
inline |
Definition at line 764 of file FSIOperator.hpp.
|
inline |
Definition at line 768 of file FSIOperator.hpp.
|
inline |
Definition at line 772 of file FSIOperator.hpp.
|
inline |
Definition at line 777 of file FSIOperator.hpp.
|
inline |
Definition at line 781 of file FSIOperator.hpp.
|
inlinevirtual |
Getter for the map of the variable used for the coupling.
Reimplemented in FSIMonolithic.
Definition at line 787 of file FSIOperator.hpp.
|
inline |
Method to implement Robin boundary conditions on the external wall for the structure.
Definition at line 793 of file FSIOperator.hpp.
|
inline |
Definition at line 798 of file FSIOperator.hpp.
|
inline |
Definition at line 802 of file FSIOperator.hpp.
|
inline |
Definition at line 806 of file FSIOperator.hpp.
|
inline |
Definition at line 810 of file FSIOperator.hpp.
|
inline |
Definition at line 814 of file FSIOperator.hpp.
|
inline |
Definition at line 818 of file FSIOperator.hpp.
|
inline |
Definition at line 822 of file FSIOperator.hpp.
|
inline |
Definition at line 826 of file FSIOperator.hpp.
|
inline |
Definition at line 830 of file FSIOperator.hpp.
|
inline |
Definition at line 834 of file FSIOperator.hpp.
|
inline |
Definition at line 838 of file FSIOperator.hpp.
|
inline |
Definition at line 842 of file FSIOperator.hpp.
|
inline |
Getter for the BCHandler of the fluid problem.
Definition at line 850 of file FSIOperator.hpp.
|
inline |
Getter for the BCHandler of the harmonic extension problem.
Definition at line 855 of file FSIOperator.hpp.
|
inline |
Getter for the BCHandler of the linearized fluid problem (to be used in Newton for the partitioned FSI)
Definition at line 860 of file FSIOperator.hpp.
|
inline |
Getter for the BCHandler of the linearized inverse of the fluid Steklov Poincare' operator (not used)
Definition at line 866 of file FSIOperator.hpp.
|
inline |
Getter for the BCHandler of the solid problem.
Definition at line 871 of file FSIOperator.hpp.
|
inline |
Getter for the BCHandler of the linearized solid problem.
Definition at line 876 of file FSIOperator.hpp.
|
inline |
Getter for the BCHandler of the linearized inverse of the solid Steklov Poincare' operator (not used)
Definition at line 882 of file FSIOperator.hpp.
|
inline |
Getter for the right hand side.
Definition at line 888 of file FSIOperator.hpp.
|
inline |
Definition at line 893 of file FSIOperator.hpp.
|
inline |
Definition at line 897 of file FSIOperator.hpp.
|
inline |
Definition at line 901 of file FSIOperator.hpp.
|
inline |
Definition at line 906 of file FSIOperator.hpp.
|
inline |
Definition at line 910 of file FSIOperator.hpp.
|
inline |
Definition at line 914 of file FSIOperator.hpp.
|
inlinevirtual |
gets the solution vector by reference
Reimplemented in FSIMonolithic.
Definition at line 920 of file FSIOperator.hpp.
|
inlinevirtual |
gets the solid displacement by copy
Definition at line 926 of file FSIOperator.hpp.
|
inlinevirtual |
gets the solid velocity by copy
Definition at line 932 of file FSIOperator.hpp.
|
inlinevirtual |
Export the solid displacement by copying it to an external vector.
solidDisplacement | vector to be filled with the solid displacement |
Reimplemented in FSIMonolithic.
Definition at line 941 of file FSIOperator.hpp.
|
inlinevirtual |
Export the solid velocity by copying it to an external vector.
solidVelocity | vector to be filled with the solid velocity |
Reimplemented in FSIMonolithic.
Definition at line 950 of file FSIOperator.hpp.
|
inlinevirtual |
Export the solid acceleration by copying it to an external vector.
solidAcc | vector to be filled with the solid acceleration |
Reimplemented in FSIMonolithic.
Definition at line 959 of file FSIOperator.hpp.
|
inlinevirtual |
Export the fluid velocity by copying it to an external vector.
fluidVelocity | vector to be filled with the fluid velocity |
Reimplemented in FSIMonolithic.
Definition at line 968 of file FSIOperator.hpp.
|
inlinevirtual |
Export the fluid pressure by copying it to an external vector.
fluidPressure | vector to be filled with the fluid pressure |
Reimplemented in FSIMonolithic.
Definition at line 977 of file FSIOperator.hpp.
|
inlinevirtual |
Export the fluid velocity and pressure by copying it to an external vector.
fluidVelocityAndPressure | vector to be filled with the fluid velocity and pressure |
Reimplemented in FSIMonolithic.
Definition at line 986 of file FSIOperator.hpp.
|
inlinevirtual |
Export the fluid displacement by copying it to an external vector.
fluidDisplacement | vector to be filled with the fluid displacement |
Definition at line 995 of file FSIOperator.hpp.
void setComm | ( | const commPtr_Type & | comm, |
const commPtr_Type & | worldComm | ||
) |
Setter for the local and world communicators.
The communicator can be different depending on which type of subdomain we are considering
Definition at line 1199 of file FSIOperator.cpp.
|
inline |
Setter for the FSI data.
Definition at line 1014 of file FSIOperator.hpp.
void setFluid | ( | const fluidPtr_Type & | fluid, |
const meshMotionPtr_Type & | meshmotion | ||
) |
Setter for the fluid and geometry problems.
Definition at line 1208 of file FSIOperator.cpp.
void setSolid | ( | const solidPtr_Type & | solid | ) |
Setter for the solid problem.
Definition at line 1218 of file FSIOperator.cpp.
|
inline |
Setter for the "fluid" flag.
Definition at line 1025 of file FSIOperator.hpp.
|
inline |
Setter for the "solid" flag.
Definition at line 1030 of file FSIOperator.hpp.
|
inline |
Setter for the "linear fluid" flag.
Definition at line 1036 of file FSIOperator.hpp.
|
inline |
Setter for the "linear solid" flag.
Definition at line 1041 of file FSIOperator.hpp.
|
inline |
Definition at line 1046 of file FSIOperator.hpp.
|
inline |
Definition at line 1050 of file FSIOperator.hpp.
|
virtual |
Setter for the fluid BCHandler.
Reimplemented in FSIMonolithic.
Definition at line 1227 of file FSIOperator.cpp.
|
inline |
Setter for the BCHandler of the linearized fluid problem (to be used in segregated Newton FSI)
Definition at line 1063 of file FSIOperator.hpp.
|
inline |
Setter for the BCHandler of the inverse linearized fluid steklov Poincare' operator (to be used in SP FSI formulation)
Definition at line 1071 of file FSIOperator.hpp.
void setHarmonicExtensionBC | ( | const fluidBchandlerPtr_Type & | bc_he | ) |
Setter for the BCHandler of the gerometry problem (to be used in segregated Newton FSI)
Definition at line 1238 of file FSIOperator.cpp.
|
virtual |
Setter for the fluid BCHandler.
Definition at line 1250 of file FSIOperator.cpp.
|
inline |
Setter for the BCHandler of the linearized solid problem (to be used in segregated Newton FSI)
Definition at line 1084 of file FSIOperator.hpp.
|
inline |
Setter for the BCHandler of the inverse linearized solid steklov Poincare' operator (to be used in SP FSI formulation)
Definition at line 1092 of file FSIOperator.hpp.
void setLambdaFluid | ( | const vector_Type & | lambda | ) |
Setter for the interface displacement (partitioned according to the fluid)
Definition at line 1261 of file FSIOperator.cpp.
void setLambdaSolid | ( | const vector_Type & | lambda | ) |
Setter for the interface displacement (partitioned according to the solid)
Definition at line 1278 of file FSIOperator.cpp.
void setLambdaSolidOld | ( | const vector_Type & | lambda | ) |
Setter for the solid interface displacement at the previous time step.
Definition at line 1295 of file FSIOperator.cpp.
void setLambdaDotSolid | ( | const vector_Type & | lambda | ) |
Setter for the solid interface velocity at the previous time step.
Definition at line 1310 of file FSIOperator.cpp.
void setSigmaFluid | ( | const vector_Type & | sigma | ) |
Setter for the fluid interface stress.
Definition at line 1343 of file FSIOperator.cpp.
void setSigmaSolid | ( | const vector_Type & | sigma | ) |
Setter for the solid interface stress.
Definition at line 1327 of file FSIOperator.cpp.
void setMinusSigmaFluid | ( | const vector_Type & | sigma | ) |
Definition at line 1361 of file FSIOperator.cpp.
void setAlphafbcf | ( | const bcFunction_Type & | alphafbcf | ) |
Setter for the Robin coefficient of the Robin–Neumann coupling scheme (as a BCFunction)
Definition at line 1380 of file FSIOperator.cpp.
void setStructureDispToHarmonicExtension | ( | const vector_Type & | disp, |
UInt | type = 0 |
||
) |
Definition at line 1390 of file FSIOperator.cpp.
void setStructureToFluid | ( | const vector_Type & | vel, |
UInt | type = 0 |
||
) |
Definition at line 1401 of file FSIOperator.cpp.
void setStructureDispToFluid | ( | const vector_Type & | vel, |
UInt | type = 0 |
||
) |
Definition at line 1412 of file FSIOperator.cpp.
void setStructureDispToSolid | ( | const vector_Type & | disp, |
UInt | type = 0 |
||
) |
Definition at line 1423 of file FSIOperator.cpp.
void setDerStructureDispToSolid | ( | const vector_Type & | ddisp, |
UInt | type = 0 |
||
) |
Definition at line 1434 of file FSIOperator.cpp.
void setSolidLoadToStructure | ( | const vector_Type & | load, |
UInt | type = 0 |
||
) |
Definition at line 1445 of file FSIOperator.cpp.
void setHarmonicExtensionVelToFluid | ( | const vector_Type & | vel, |
UInt | type = 0 |
||
) |
Definition at line 1456 of file FSIOperator.cpp.
void setDerHarmonicExtensionVelToFluid | ( | const vector_Type & | dvel, |
UInt | type = 0 |
||
) |
Definition at line 1467 of file FSIOperator.cpp.
void setFluidLoadToStructure | ( | const vector_Type & | load, |
UInt | type = 0 |
||
) |
Definition at line 1479 of file FSIOperator.cpp.
void setDerFluidLoadToStructure | ( | const vector_Type & | dload, |
UInt | type = 0 |
||
) |
Definition at line 1490 of file FSIOperator.cpp.
void setDerFluidLoadToFluid | ( | const vector_Type & | dload, |
UInt | type = 0 |
||
) |
Definition at line 1501 of file FSIOperator.cpp.
void setRobinOuterWall | ( | const function_Type & | dload, |
const function_Type & | E | ||
) |
Definition at line 1509 of file FSIOperator.cpp.
|
inline |
Setter for the time derivative of the interface displacement.
Definition at line 1142 of file FSIOperator.hpp.
void setupTimeAdvance | ( | const dataFile_Type & | dataFile | ) |
Setup of the TimeAdvance classes given the input data file.
Definition at line 676 of file FSIOperator.cpp.
|
protectedvirtual |
initailize the variables
instantiates the pointers which are used in the segregated FSI solvers. Reimplemented in the Monolithic class.
dorder | unused parameter |
Reimplemented in FSIMonolithic.
Definition at line 1523 of file FSIOperator.cpp.
|
protected |
Interpolates the mesh motion dofs on the fluid.
The order of the spatial approximation depends on this method: when the mesh motion approximation is first order in space the overall approximation is of the first order even if the fluid is solved with hicher order FEs. Calls the interpolateVelocity method
Definition at line 1560 of file FSIOperator.cpp.
|
protected |
Interpolates mesh motion into velocity.
Interpolates a vector with the map of the harmonic extension into one with the map of the fluid velocity
Definition at line 1586 of file FSIOperator.cpp.
|
protected |
Interpolates to vectors on the interface.
The two vectors can have different numeration, for different discretizations this method is not tested.
Definition at line 1781 of file FSIOperator.cpp.
Definition at line 1196 of file FSIOperator.hpp.
Definition at line 1197 of file FSIOperator.hpp.
Definition at line 1198 of file FSIOperator.hpp.
Definition at line 1199 of file FSIOperator.hpp.
Definition at line 1200 of file FSIOperator.hpp.
|
protected |
Definition at line 1202 of file FSIOperator.hpp.
|
protected |
Definition at line 1203 of file FSIOperator.hpp.
|
protected |
Definition at line 1205 of file FSIOperator.hpp.
|
protected |
Definition at line 1206 of file FSIOperator.hpp.
|
protected |
Definition at line 1208 of file FSIOperator.hpp.
|
protected |
Definition at line 1209 of file FSIOperator.hpp.
|
protected |
Definition at line 1210 of file FSIOperator.hpp.
|
protected |
Definition at line 1213 of file FSIOperator.hpp.
|
protected |
Definition at line 1214 of file FSIOperator.hpp.
|
protected |
Definition at line 1216 of file FSIOperator.hpp.
|
protected |
Definition at line 1217 of file FSIOperator.hpp.
|
protected |
Definition at line 1219 of file FSIOperator.hpp.
|
protected |
Definition at line 1220 of file FSIOperator.hpp.
|
protected |
Definition at line 1222 of file FSIOperator.hpp.
|
protected |
Definition at line 1223 of file FSIOperator.hpp.
|
protected |
Definition at line 1224 of file FSIOperator.hpp.
|
protected |
Definition at line 1226 of file FSIOperator.hpp.
|
protected |
Definition at line 1227 of file FSIOperator.hpp.
|
protected |
Definition at line 1228 of file FSIOperator.hpp.
|
protected |
Definition at line 1230 of file FSIOperator.hpp.
|
protected |
Definition at line 1231 of file FSIOperator.hpp.
|
protected |
Definition at line 1232 of file FSIOperator.hpp.
|
protected |
Definition at line 1233 of file FSIOperator.hpp.
|
protected |
Definition at line 1236 of file FSIOperator.hpp.
|
protected |
Definition at line 1238 of file FSIOperator.hpp.
|
protected |
Definition at line 1239 of file FSIOperator.hpp.
|
protected |
Definition at line 1241 of file FSIOperator.hpp.
|
protected |
Definition at line 1243 of file FSIOperator.hpp.
|
protected |
Definition at line 1244 of file FSIOperator.hpp.
|
protected |
Definition at line 1247 of file FSIOperator.hpp.
|
protected |
Definition at line 1249 of file FSIOperator.hpp.
|
protected |
Definition at line 1251 of file FSIOperator.hpp.
|
protected |
Definition at line 1253 of file FSIOperator.hpp.
|
protected |
Definition at line 1254 of file FSIOperator.hpp.
|
protected |
Definition at line 1255 of file FSIOperator.hpp.
|
protected |
Definition at line 1256 of file FSIOperator.hpp.
|
protected |
Definition at line 1260 of file FSIOperator.hpp.
|
protected |
Definition at line 1261 of file FSIOperator.hpp.
|
protected |
Definition at line 1262 of file FSIOperator.hpp.
|
protected |
Definition at line 1263 of file FSIOperator.hpp.
|
protected |
Definition at line 1265 of file FSIOperator.hpp.
|
protected |
Definition at line 1266 of file FSIOperator.hpp.
|
protected |
Definition at line 1267 of file FSIOperator.hpp.
|
protected |
Definition at line 1268 of file FSIOperator.hpp.
|
protected |
Definition at line 1269 of file FSIOperator.hpp.
|
protected |
Definition at line 1270 of file FSIOperator.hpp.
|
protected |
Definition at line 1271 of file FSIOperator.hpp.
|
protected |
Definition at line 1272 of file FSIOperator.hpp.
|
protected |
Definition at line 1276 of file FSIOperator.hpp.
|
protected |
Definition at line 1277 of file FSIOperator.hpp.
|
protected |
Definition at line 1278 of file FSIOperator.hpp.
|
protected |
Definition at line 1279 of file FSIOperator.hpp.
|
protected |
Definition at line 1280 of file FSIOperator.hpp.
|
protected |
Definition at line 1285 of file FSIOperator.hpp.
|
protected |
Definition at line 1286 of file FSIOperator.hpp.
|
protected |
Definition at line 1287 of file FSIOperator.hpp.
|
protected |
Definition at line 1288 of file FSIOperator.hpp.
|
protected |
Definition at line 1291 of file FSIOperator.hpp.
|
protected |
Definition at line 1292 of file FSIOperator.hpp.
|
protected |
Definition at line 1294 of file FSIOperator.hpp.
|
protected |
Definition at line 1296 of file FSIOperator.hpp.
|
protected |
Definition at line 1298 of file FSIOperator.hpp.
|
protected |
Definition at line 1299 of file FSIOperator.hpp.
|
protected |
Definition at line 1301 of file FSIOperator.hpp.
|
private |
Definition at line 1314 of file FSIOperator.hpp.
|
private |
Definition at line 1315 of file FSIOperator.hpp.
|
private |
Definition at line 1317 of file FSIOperator.hpp.
|
private |
Definition at line 1318 of file FSIOperator.hpp.
|
private |
Definition at line 1319 of file FSIOperator.hpp.
|
private |
Definition at line 1321 of file FSIOperator.hpp.
|
private |
Definition at line 1322 of file FSIOperator.hpp.
|
private |
Definition at line 1324 of file FSIOperator.hpp.
|
private |
Definition at line 1325 of file FSIOperator.hpp.
|
private |
Definition at line 1328 of file FSIOperator.hpp.
|
private |
Definition at line 1330 of file FSIOperator.hpp.
|
private |
Definition at line 1332 of file FSIOperator.hpp.
|
private |
Definition at line 1333 of file FSIOperator.hpp.
|
private |
Definition at line 1334 of file FSIOperator.hpp.
|
private |
Definition at line 1337 of file FSIOperator.hpp.
|
private |
Definition at line 1339 of file FSIOperator.hpp.
|
private |
Definition at line 1340 of file FSIOperator.hpp.
|
private |
Definition at line 1342 of file FSIOperator.hpp.
|
private |
Definition at line 1343 of file FSIOperator.hpp.
|
private |
Definition at line 1345 of file FSIOperator.hpp.
|
private |
Definition at line 1346 of file FSIOperator.hpp.
|
private |
Definition at line 1348 of file FSIOperator.hpp.