LifeV
|
This class contains an Oseen equation solver. More...
#include <OseenSolver.hpp>
Public Member Functions | |
preconditionerPtr_Type & | preconditioner () |
Return a shared pointer to the preconditioner (of type derived from EpetraPreconditioner) More... | |
Public Types | |
typedef MeshType | mesh_Type |
typedef SolverType | linearSolver_Type |
typedef std::shared_ptr< linearSolver_Type > | linearSolverPtr_Type |
typedef OseenData | data_Type |
typedef std::shared_ptr< data_Type > | dataPtr_Type |
typedef std::function< Real(const Real &t, const Real &x, const Real &y, const Real &z, const ID &i) > | function_Type |
typedef std::function< Real(const Real &t, const Real &x, const Real &y, const Real &z, const ID &i) > | source_Type |
typedef BCHandler | bcHandler_Type |
typedef std::shared_ptr< bcHandler_Type > | bcHandlerPtr_Type |
typedef linearSolver_Type::matrix_type | matrix_Type |
typedef std::shared_ptr< matrix_Type > | matrixPtr_Type |
typedef linearSolver_Type::vector_type | vector_Type |
typedef std::shared_ptr< vector_Type > | vectorPtr_Type |
typedef vector_Type | solution_Type |
typedef std::shared_ptr< solution_Type > | solutionPtr_Type |
typedef linearSolver_Type::prec_raw_type | preconditioner_Type |
typedef linearSolver_Type::prec_type | preconditionerPtr_Type |
Constructors & Destructor | |
OseenSolver () | |
Empty constructor. More... | |
OseenSolver (std::shared_ptr< data_Type > dataType, FESpace< mesh_Type, MapEpetra > &velocityFESpace, FESpace< mesh_Type, MapEpetra > &pressureFESpace, std::shared_ptr< Epetra_Comm > &communicator, const Int lagrangeMultiplier=0) | |
Constructor. More... | |
OseenSolver (std::shared_ptr< data_Type > dataType, FESpace< mesh_Type, MapEpetra > &velocityFESpace, FESpace< mesh_Type, MapEpetra > &pressureFESpace, std::shared_ptr< Epetra_Comm > &communicator, const MapEpetra monolithicMap, const UInt offset=0) | |
Constructor. More... | |
OseenSolver (std::shared_ptr< data_Type > dataType, FESpace< mesh_Type, MapEpetra > &velocityFESpace, FESpace< mesh_Type, MapEpetra > &pressureFESpace, const std::vector< Int > &lagrangeMultipliers, std::shared_ptr< Epetra_Comm > &communicator) | |
Constructor. More... | |
virtual | ~OseenSolver () |
virtual destructor More... | |
Methods | |
virtual void | setUp (const GetPot &dataFile) |
Set up data from GetPot. More... | |
void | initialize (const function_Type &velocityFunction, const function_Type &pressureFunction) |
Initialize with velocityFunction and pressureFunction. More... | |
void | initialize (const vector_Type &velocityInitialGuess, const vector_Type &pressureInitialGuess) |
Initialize with velocityInitialGuess and pressureInitialGuess. More... | |
void | initialize (const vector_Type &velocityAndPressure) |
Initialize with velocityAndPressure. More... | |
virtual void | buildSystem () |
Build linear system. More... | |
virtual void | updateSystem (const Real alpha, const vector_Type &betaVector, const vector_Type &sourceVector) |
Update system. More... | |
virtual void | updateSystem (const Real alpha, const vector_Type &betaVector, const vector_Type &sourceVector, matrixPtr_Type matrix, const vector_Type &un) |
Update system. More... | |
void | updateStabilization (matrix_Type &matrixFull) |
Update stabilization term. More... | |
virtual void | updateRightHandSide (const vector_Type &rightHandSide) |
Update the right hand side. More... | |
void | updateSourceTerm (const source_Type &source) |
Update the source term. More... | |
virtual void | iterate (bcHandler_Type &bcHandler) |
Update convective term, boundary condition and solve the linearized ns system. More... | |
void | reduceSolution (Vector &velocity, Vector &pressure) |
Reduce the local solution in global vectors. More... | |
void | reduceResidual (Vector &residual) |
Reduce the residual. More... | |
void | setBlockPreconditioner (matrixPtr_Type blockPreconditioner) |
Set a block preconditioner. More... | |
void | getFluidMatrix (matrix_Type &matrixFull) |
Update and return the coefficient matrix. More... | |
void | setupPostProc () |
Set up post processing. More... | |
Real | area (const markerID_Type &flag) |
Compute area on a boundary face with given flag. More... | |
Vector | normal (const markerID_Type &flag) |
Compute the outgoing normal of a boundary face with given flag. More... | |
Vector | geometricCenter (const markerID_Type &flag) |
Compute the geometric center of a boundary face with given flag. More... | |
Real | flux (const markerID_Type &flag, const vector_Type &solution) |
Compute flux on a boundary face with given flag and a given solution. More... | |
Real | flux (const markerID_Type &flag) |
Compute flux on a boundary face with given flag. More... | |
Real | kineticNormalStress (const markerID_Type &flag, const vector_Type &solution) |
Compute the kinetic normal stress (i.e., the normal stress due to the kinetic energy) on a boundary face with a given flag and a given solution. More... | |
Real | kineticNormalStress (const markerID_Type &flag) |
Compute the kinetic normal stress (i.e., the normal stress due to the kinetic energy) on a boundary face with a given flag. More... | |
Real | pressure (const markerID_Type &flag, const vector_Type &solution) |
Compute average pressure on a boundary face with given flag and a given solution. More... | |
Real | pressure (const markerID_Type &flag) |
Compute average pressure on a boundary face with given flag. More... | |
Real | meanNormalStress (const markerID_Type &flag, bcHandler_Type &bcHandler, const vector_Type &solution) |
Compute the mean normal stress on a boundary face with a given flag and a given solution. More... | |
Real | meanNormalStress (const markerID_Type &flag, bcHandler_Type &bcHandler) |
Compute the mean normal stress on a boundary face with a given flag. More... | |
Real | meanTotalNormalStress (const markerID_Type &flag, bcHandler_Type &bcHandler, const vector_Type &solution) |
Compute the mean total normal stress on a boundary face with a given flag and a given solution. More... | |
Real | meanTotalNormalStress (const markerID_Type &flag, bcHandler_Type &bcHandler) |
Compute the mean total normal stress on a boundary face with a given flag. More... | |
Real | lagrangeMultiplier (const markerID_Type &flag, bcHandler_Type &bcHandler) |
Get the Lagrange multiplier related to a flux imposed on a given part of the boundary. More... | |
Real | lagrangeMultiplier (const markerID_Type &flag, bcHandler_Type &bcHandler, const vector_Type &solution) |
Get the Lagrange multiplier related to a flux imposed on a given part of the boundary. More... | |
void | resetPreconditioner (bool reset=true) |
Reset the preconditioner. More... | |
void | resetStabilization () |
Reset stabilization matrix at the same time as the preconditioner. More... | |
void | updateUn () |
Update. More... | |
void | updateUn (const vector_Type &solution) |
Update for the monolithic. More... | |
void | showMe (std::ostream &output=std::cout) const |
Display general information about the content of the class. More... | |
Set Methods | |
void | setRecomputeMatrix (const bool &recomputeMatrix) |
Set. More... | |
void | setSourceTerm (source_Type source) |
set the source term functor More... | |
void | setTolMaxIteration (const Real &tolerance, const Int &maxIteration=-1) |
Set the tolerance and the maximum number of iterations of the linear solver. More... | |
Get Methods | |
const dataPtr_Type & | data () const |
Return the data container of the fluid. More... | |
const Real & | density () const |
Return the density of the fluid. More... | |
const Real & | viscosity () const |
Return the viscosity of the fluid. More... | |
const vectorPtr_Type & | solution () const |
Return the local solution vector. More... | |
const vector_Type & | residual () const |
Return the local residual vector. More... | |
FESpace< mesh_Type, MapEpetra > & | velocityFESpace () |
Return velocity FE space. More... | |
const FESpace< mesh_Type, MapEpetra > & | velocityFESpace () const |
FESpace< mesh_Type, MapEpetra > & | pressureFESpace () |
Return pressure FE space. More... | |
const FESpace< mesh_Type, MapEpetra > & | pressureFESpace () const |
const source_Type & | sourceTerm () const |
Get the source term. More... | |
PostProcessingBoundary< mesh_Type > & | postProcessing () |
Returns the post processing structure. More... | |
const PostProcessingBoundary< mesh_Type > & | postProcessing () const |
const MapEpetra & | getMap () const |
Return MapEpetra. More... | |
const std::shared_ptr< Epetra_Comm > & | comm () const |
Return Epetra communicator. More... | |
const Displayer & | getDisplayer () const |
Return displayer. More... | |
const bool & | recomputeMatrix () const |
Return. More... | |
matrix_Type & | matrixNoBC () |
Return matrix without boundary conditions. More... | |
const matrix_Type & | matrixNoBC () const |
matrix_Type & | matrixMass () |
Return mass matrix. More... | |
const matrix_Type & | matrixMass () const |
const matrixPtr_Type | matrixMassPtr () const |
void | postProcessingSetArea () |
Set up post processing structures. More... | |
void | postProcessingSetNormal () |
Set up post processing. More... | |
void | postProcessingSetPhi () |
Set up post processing. More... | |
bool | getIsDiagonalBlockPreconditioner () |
Return a bool value if using diagonal block preconditioner. More... | |
const bool & | getIsDiagonalBlockPreconditioner () const |
Constructor | |
OseenSolver (const OseenSolver &oseen) | |
Empty copy constructor. More... | |
Private Methods | |
Real | removeMean (vector_Type &x) |
Removes mean of component of vector x. More... | |
void | applyBoundaryConditions (matrix_Type &matrix, vector_Type &rightHandSide, bcHandler_Type &bcHandler) |
Apply boundary conditions. More... | |
void | echo (std::string message) |
Echo message. More... | |
const UInt & | dimVelocity () const |
Return the dim of velocity FE space. More... | |
const UInt & | dimPressure () const |
Return the dim of pressure FE space. More... | |
This class contains an Oseen equation solver.
Definition at line 88 of file OseenSolver.hpp.
Definition at line 96 of file OseenSolver.hpp.
typedef SolverType linearSolver_Type |
Definition at line 97 of file OseenSolver.hpp.
typedef std::shared_ptr<linearSolver_Type> linearSolverPtr_Type |
Definition at line 98 of file OseenSolver.hpp.
Definition at line 99 of file OseenSolver.hpp.
typedef std::shared_ptr< data_Type > dataPtr_Type |
Definition at line 100 of file OseenSolver.hpp.
typedef std::function< Real ( const Real& t, const Real& x, const Real& y, const Real& z, const ID& i ) > function_Type |
Definition at line 103 of file OseenSolver.hpp.
typedef std::function< Real ( const Real& t, const Real& x, const Real& y, const Real& z, const ID& i ) > source_Type |
Definition at line 106 of file OseenSolver.hpp.
typedef BCHandler bcHandler_Type |
Definition at line 108 of file OseenSolver.hpp.
typedef std::shared_ptr<bcHandler_Type> bcHandlerPtr_Type |
Definition at line 109 of file OseenSolver.hpp.
Definition at line 114 of file OseenSolver.hpp.
typedef std::shared_ptr<matrix_Type> matrixPtr_Type |
Definition at line 116 of file OseenSolver.hpp.
Definition at line 117 of file OseenSolver.hpp.
typedef std::shared_ptr<vector_Type> vectorPtr_Type |
Definition at line 118 of file OseenSolver.hpp.
typedef vector_Type solution_Type |
Definition at line 120 of file OseenSolver.hpp.
typedef std::shared_ptr<solution_Type> solutionPtr_Type |
Definition at line 121 of file OseenSolver.hpp.
typedef linearSolver_Type::prec_raw_type preconditioner_Type |
Definition at line 123 of file OseenSolver.hpp.
typedef linearSolver_Type::prec_type preconditionerPtr_Type |
Definition at line 124 of file OseenSolver.hpp.
OseenSolver | ( | ) |
Empty constructor.
OseenSolver | ( | std::shared_ptr< data_Type > | dataType, |
FESpace< mesh_Type, MapEpetra > & | velocityFESpace, | ||
FESpace< mesh_Type, MapEpetra > & | pressureFESpace, | ||
std::shared_ptr< Epetra_Comm > & | communicator, | ||
const Int | lagrangeMultiplier = 0 |
||
) |
Constructor.
dataType | OseenData class |
velocityFESpace | Velocity FE space |
pressureFESpace | Pressure FE space |
communicator | MPI communicator |
lagrangeMultiplier | Lagrange multiplier |
Definition at line 899 of file OseenSolver.hpp.
OseenSolver | ( | std::shared_ptr< data_Type > | dataType, |
FESpace< mesh_Type, MapEpetra > & | velocityFESpace, | ||
FESpace< mesh_Type, MapEpetra > & | pressureFESpace, | ||
std::shared_ptr< Epetra_Comm > & | communicator, | ||
const MapEpetra | monolithicMap, | ||
const UInt | offset = 0 |
||
) |
Constructor.
dataType | OseenData class |
velocityFESpace | Velocity FE space |
pressureFESpace | Pressure FE space |
communicator | MPI communicator |
monolithicMap | MapEpetra class |
offset |
Definition at line 964 of file OseenSolver.hpp.
OseenSolver | ( | std::shared_ptr< data_Type > | dataType, |
FESpace< mesh_Type, MapEpetra > & | velocityFESpace, | ||
FESpace< mesh_Type, MapEpetra > & | pressureFESpace, | ||
const std::vector< Int > & | lagrangeMultipliers, | ||
std::shared_ptr< Epetra_Comm > & | communicator | ||
) |
Constructor.
dataType | OseenData class |
velocityFESpace | Velocity FE space |
pressureFESpace | Pressure FE space |
lagrangeMultipliers | (lagrange multipliers for the flux problem with rufaec flag) |
communicator | MPI communicator |
Definition at line 1021 of file OseenSolver.hpp.
|
virtual |
virtual destructor
Definition at line 1077 of file OseenSolver.hpp.
|
protected |
Empty copy constructor.
|
virtual |
Set up data from GetPot.
dataFile | GetPot object |
Reimplemented in OseenSolverShapeDerivative< MeshType, SolverType >.
Definition at line 1089 of file OseenSolver.hpp.
void initialize | ( | const function_Type & | velocityFunction, |
const function_Type & | pressureFunction | ||
) |
Initialize with velocityFunction and pressureFunction.
velocityFunction | |
pressureFunction |
Definition at line 1127 of file OseenSolver.hpp.
void initialize | ( | const vector_Type & | velocityInitialGuess, |
const vector_Type & | pressureInitialGuess | ||
) |
Initialize with velocityInitialGuess and pressureInitialGuess.
velocityInitialGuess | |
pressureInitialGuess |
Definition at line 1146 of file OseenSolver.hpp.
void initialize | ( | const vector_Type & | velocityAndPressure | ) |
Initialize with velocityAndPressure.
velocityAndPressure |
Definition at line 1159 of file OseenSolver.hpp.
|
virtual |
Build linear system.
Definition at line 1172 of file OseenSolver.hpp.
|
virtual |
Update system.
alpha | |
betaVector | |
sourceVector |
Definition at line 1386 of file OseenSolver.hpp.
|
virtual |
Update system.
alpha | |
betaVector | |
sourceVector | |
matrix | |
un |
managing the convective term
managing the convective term : semi-implicit approximation of the convective term
Definition at line 1410 of file OseenSolver.hpp.
void updateStabilization | ( | matrix_Type & | matrixFull | ) |
|
inlinevirtual |
Update the right hand side.
rightHandSide | right hand side |
Definition at line 250 of file OseenSolver.hpp.
void updateSourceTerm | ( | const source_Type & | source | ) |
|
virtual |
Update convective term, boundary condition and solve the linearized ns system.
bcHandler | BC handler |
Definition at line 1663 of file OseenSolver.hpp.
Reduce the local solution in global vectors.
velocity | |
pressure |
Definition at line 1722 of file OseenSolver.hpp.
void reduceResidual | ( | Vector & | residual | ) |
void setBlockPreconditioner | ( | matrixPtr_Type | blockPreconditioner | ) |
void getFluidMatrix | ( | matrix_Type & | matrixFull | ) |
Update and return the coefficient matrix.
matrixFull | The coefficient matrix |
Definition at line 1767 of file OseenSolver.hpp.
void setupPostProc | ( | ) |
Set up post processing.
Definition at line 2051 of file OseenSolver.hpp.
Real area | ( | const markerID_Type & | flag | ) |
Compute area on a boundary face with given flag.
flag |
Definition at line 1834 of file OseenSolver.hpp.
Vector normal | ( | const markerID_Type & | flag | ) |
Compute the outgoing normal of a boundary face with given flag.
flag |
Definition at line 1841 of file OseenSolver.hpp.
Vector geometricCenter | ( | const markerID_Type & | flag | ) |
Compute the geometric center of a boundary face with given flag.
flag |
Definition at line 1848 of file OseenSolver.hpp.
Real flux | ( | const markerID_Type & | flag, |
const vector_Type & | solution | ||
) |
Compute flux on a boundary face with given flag and a given solution.
flag | |
solution |
Definition at line 1803 of file OseenSolver.hpp.
Real flux | ( | const markerID_Type & | flag | ) |
Compute flux on a boundary face with given flag.
flag |
Definition at line 1796 of file OseenSolver.hpp.
Real kineticNormalStress | ( | const markerID_Type & | flag, |
const vector_Type & | solution | ||
) |
Compute the kinetic normal stress (i.e., the normal stress due to the kinetic energy) on a boundary face with a given flag and a given solution.
This method computes the following quantity:
flag | boundary flag |
solution | problem solution |
Definition at line 1822 of file OseenSolver.hpp.
Real kineticNormalStress | ( | const markerID_Type & | flag | ) |
Compute the kinetic normal stress (i.e., the normal stress due to the kinetic energy) on a boundary face with a given flag.
This method computes the following quantity:
flag | boundary flag |
Definition at line 1815 of file OseenSolver.hpp.
Real pressure | ( | const markerID_Type & | flag, |
const vector_Type & | solution | ||
) |
Compute average pressure on a boundary face with given flag and a given solution.
flag | |
solution |
Definition at line 1862 of file OseenSolver.hpp.
Real pressure | ( | const markerID_Type & | flag | ) |
Compute average pressure on a boundary face with given flag.
flag |
Definition at line 1855 of file OseenSolver.hpp.
Real meanNormalStress | ( | const markerID_Type & | flag, |
bcHandler_Type & | bcHandler, | ||
const vector_Type & | solution | ||
) |
Compute the mean normal stress on a boundary face with a given flag and a given solution.
The mean normal stress is defined as the average of the normal component of the traction vector.
flag | Flag of the boundary face |
bcHandler | BChandler containing the boundary conditions of the problem. |
solution | Vector containing the solution of the problem (and also the Lagrange multipliers at the end). |
Definition at line 1883 of file OseenSolver.hpp.
Real meanNormalStress | ( | const markerID_Type & | flag, |
bcHandler_Type & | bcHandler | ||
) |
Compute the mean normal stress on a boundary face with a given flag.
The mean normal stress is defined as the average of the normal component of the traction vector.
TODO The current version returns the exact mean normal stress if a flow rate boundary condition is imposed on the chosen boundary face. On the contrary, if other boundary conditions are applied, the mean normal stress is approximated with the mean pressure, which is a reasonable approximation for several applications.
flag | Flag of the boundary face |
bcHandler | BChandler containing the boundary conditions of the problem. |
Definition at line 1876 of file OseenSolver.hpp.
Real meanTotalNormalStress | ( | const markerID_Type & | flag, |
bcHandler_Type & | bcHandler, | ||
const vector_Type & | solution | ||
) |
Compute the mean total normal stress on a boundary face with a given flag and a given solution.
The mean total normal stress is defined as the average of the normal component of the traction vector minus the kinetic contribution.
TODO The current version returns the exact mean normal stress if a flow rate boundary condition is imposed on the chosen boundary face. On the contrary, if other boundary conditions are applied, the mean normal stress is approximated with the mean pressure, which is a reasonable approximation for several applications.
flag | Flag of the boundary face |
bcHandler | BChandler containing the boundary conditions of the problem. |
solution | Vector containing the solution of the problem (and also the Lagrange multipliers at the end). |
Definition at line 1909 of file OseenSolver.hpp.
Real meanTotalNormalStress | ( | const markerID_Type & | flag, |
bcHandler_Type & | bcHandler | ||
) |
Compute the mean total normal stress on a boundary face with a given flag.
The mean total normal stress is defined as the average of the normal component of the traction vector minus the kinetic contribution.
flag | Flag of the boundary face |
bcHandler | BChandler containing the boundary conditions of the problem. |
Definition at line 1902 of file OseenSolver.hpp.
Real lagrangeMultiplier | ( | const markerID_Type & | flag, |
bcHandler_Type & | bcHandler | ||
) |
Get the Lagrange multiplier related to a flux imposed on a given part of the boundary.
flag | Flag of the boundary face associated with the flux and the Lagrange multiplier we want. |
bcHandler | BChandler containing the boundary conditions of the problem. |
Definition at line 1916 of file OseenSolver.hpp.
Real lagrangeMultiplier | ( | const markerID_Type & | flag, |
bcHandler_Type & | bcHandler, | ||
const vector_Type & | solution | ||
) |
Get the Lagrange multiplier related to a flux imposed on a given part of the boundary.
flag | Flag of the boundary face associated with the flux and the Lagrange multiplier we want. |
bcHandler | BChandler containing the boundary conditions of the problem. |
solution | Vector containing the solution of the problem (and also the Lagrange multipliers at the end). |
Definition at line 1923 of file OseenSolver.hpp.
|
inline |
Reset the preconditioner.
reset | Reset preconditioner. |
Definition at line 486 of file OseenSolver.hpp.
|
inline |
Reset stabilization matrix at the same time as the preconditioner.
Definition at line 495 of file OseenSolver.hpp.
|
inline |
Update.
Definition at line 501 of file OseenSolver.hpp.
|
inline |
Update for the monolithic.
Definition at line 507 of file OseenSolver.hpp.
void showMe | ( | std::ostream & | output = std::cout | ) | const |
Display general information about the content of the class.
output | specify the output format (std::cout by default) |
|
inline |
|
inline |
Set the tolerance and the maximum number of iterations of the linear solver.
tolerance | Tolerance |
maxIteration | maximum number of iterations |
Definition at line 2063 of file OseenSolver.hpp.
|
inline |
Return the data container of the fluid.
Definition at line 557 of file OseenSolver.hpp.
|
inline |
Return the density of the fluid.
Definition at line 566 of file OseenSolver.hpp.
|
inline |
Return the viscosity of the fluid.
Definition at line 575 of file OseenSolver.hpp.
|
inline |
Return the local solution vector.
Definition at line 584 of file OseenSolver.hpp.
|
inline |
Return the local residual vector.
Definition at line 593 of file OseenSolver.hpp.
Definition at line 607 of file OseenSolver.hpp.
Definition at line 621 of file OseenSolver.hpp.
|
inline |
|
inline |
Returns the post processing structure.
Definition at line 639 of file OseenSolver.hpp.
|
inline |
Definition at line 644 of file OseenSolver.hpp.
|
inline |
|
inline |
Return Epetra communicator.
Definition at line 662 of file OseenSolver.hpp.
|
inline |
|
inline |
|
inline |
Return matrix without boundary conditions.
Definition at line 689 of file OseenSolver.hpp.
|
inline |
Definition at line 694 of file OseenSolver.hpp.
|
inline |
|
inline |
Definition at line 708 of file OseenSolver.hpp.
|
inline |
Definition at line 713 of file OseenSolver.hpp.
void postProcessingSetArea | ( | ) |
Set up post processing structures.
Definition at line 1775 of file OseenSolver.hpp.
void postProcessingSetNormal | ( | ) |
Set up post processing.
Definition at line 1782 of file OseenSolver.hpp.
void postProcessingSetPhi | ( | ) |
Set up post processing.
Definition at line 1789 of file OseenSolver.hpp.
|
inline |
Return a bool value if using diagonal block preconditioner.
Definition at line 732 of file OseenSolver.hpp.
|
inline |
Definition at line 737 of file OseenSolver.hpp.
|
inline |
Return a shared pointer to the preconditioner (of type derived from EpetraPreconditioner)
Definition at line 745 of file OseenSolver.hpp.
|
protected |
Removes mean of component of vector x.
x |
Definition at line 1947 of file OseenSolver.hpp.
|
protected |
Apply boundary conditions.
matrix | |
rightHandSide | |
bcHandler |
Definition at line 2005 of file OseenSolver.hpp.
|
protected |
Echo message.
message |
|
inlineprotected |
Return the dim of velocity FE space.
Definition at line 787 of file OseenSolver.hpp.
|
inlineprotected |
Return the dim of pressure FE space.
Definition at line 793 of file OseenSolver.hpp.
|
protected |
data for Navier-Stokes solvers
Definition at line 803 of file OseenSolver.hpp.
Definition at line 806 of file OseenSolver.hpp.
Definition at line 807 of file OseenSolver.hpp.
|
protected |
MPI communicator.
Definition at line 810 of file OseenSolver.hpp.
|
protected |
Definition at line 812 of file OseenSolver.hpp.
|
protected |
mass matrix
Definition at line 815 of file OseenSolver.hpp.
|
protected |
mass matrix
Definition at line 818 of file OseenSolver.hpp.
|
protected |
Stokes matrix: nu*stiff.
Definition at line 821 of file OseenSolver.hpp.
|
protected |
matrix to be solved
matrix without boundary conditions
Definition at line 827 of file OseenSolver.hpp.
|
protected |
stabilization matrix
Definition at line 830 of file OseenSolver.hpp.
|
protected |
source term for Navier-Stokes equations
Definition at line 833 of file OseenSolver.hpp.
|
protected |
Right hand side for the velocity component.
Definition at line 836 of file OseenSolver.hpp.
|
protected |
Global solution.
Definition at line 839 of file OseenSolver.hpp.
|
protected |
residual
Definition at line 842 of file OseenSolver.hpp.
|
protected |
Definition at line 844 of file OseenSolver.hpp.
|
protected |
Definition at line 846 of file OseenSolver.hpp.
|
protected |
Postprocessing class.
Definition at line 849 of file OseenSolver.hpp.
|
protected |
Definition at line 852 of file OseenSolver.hpp.
|
protected |
Definition at line 853 of file OseenSolver.hpp.
|
protected |
Definition at line 854 of file OseenSolver.hpp.
|
protected |
Definition at line 855 of file OseenSolver.hpp.
|
protected |
Definition at line 857 of file OseenSolver.hpp.
|
protected |
Definition at line 858 of file OseenSolver.hpp.
|
protected |
Definition at line 859 of file OseenSolver.hpp.
|
protected |
Definition at line 860 of file OseenSolver.hpp.
|
protected |
Definition at line 862 of file OseenSolver.hpp.
|
protected |
Definition at line 864 of file OseenSolver.hpp.
|
protected |
Definition at line 866 of file OseenSolver.hpp.
|
protected |
Definition at line 869 of file OseenSolver.hpp.
|
protected |
Definition at line 871 of file OseenSolver.hpp.
|
protected |
Definition at line 873 of file OseenSolver.hpp.
|
protected |
Definition at line 875 of file OseenSolver.hpp.
|
protected |
Elementary matrices and vectors.
Definition at line 878 of file OseenSolver.hpp.
|
protected |
Definition at line 879 of file OseenSolver.hpp.
|
protected |
Definition at line 880 of file OseenSolver.hpp.
|
protected |
Definition at line 881 of file OseenSolver.hpp.
|
protected |
Definition at line 882 of file OseenSolver.hpp.
|
protected |
Definition at line 883 of file OseenSolver.hpp.
|
protected |
Definition at line 884 of file OseenSolver.hpp.
|
protected |
Definition at line 885 of file OseenSolver.hpp.
|
protected |
Definition at line 886 of file OseenSolver.hpp.
|
protected |
Definition at line 887 of file OseenSolver.hpp.