|
| vector_Type & | linearRightHandSideNoBC () |
| | Return. More...
|
| |
| const vector_Type & | linearRightHandSideNoBC () const |
| |
| const vector_Type & | linearSolution () const |
| | Get the solution of the Shape Derivative problem. More...
|
| |
| bool | stabilization () |
| | Return. More...
|
| |
| const bool & | stabilization () const |
| |
| Real | linearFlux (const markerID_Type &flag) |
| | Compute the derivative of the flow rate on a boundary face. More...
|
| |
| | LIFEV_DEPRECATED (Real getLinearFlux(const markerID_Type &flag)) |
| |
| Real | linearPressure (const markerID_Type &flag) |
| | Compute the derivative of the pressure on a boundary face. More...
|
| |
| | LIFEV_DEPRECATED (Real getLinearPressure(const markerID_Type &flag)) |
| |
| Real | linearLagrangeMultiplier (const markerID_Type &flag, bcHandler_Type &bcHandler) |
| | Compute the derivative of a Lagrange multiplier (which correspond to the value of the derivative of the mean normal stress on a boundary face) More...
|
| |
| | LIFEV_DEPRECATED (Real getLinearLagrangeMultiplier(const markerID_Type &flag, bcHandler_Type &bcHandler)) |
| |
| Real | linearKineticNormalStress (const markerID_Type &flag) |
| | Compute the derivative of the kinetic normal stress (i.e., the normal stress due to the kinetic energy) on a boundary face with given flag. More...
|
| |
| Real | linearKineticNormalStress (const markerID_Type &flag, const vector_Type &solution, const vector_Type &linearSolution) |
| | Compute the derivative of 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 | linearMeanNormalStress (const markerID_Type &flag, bcHandler_Type &bcHandler) |
| | Compute the derivative of the mean normal stress on a boundary face with a given flag. More...
|
| |
| Real | linearMeanNormalStress (const markerID_Type &flag, bcHandler_Type &bcHandler, const vector_Type &linearSolution) |
| | Compute the derivative of the mean normal stress on a boundary face with a given flag. More...
|
| |
| Real | linearMeanTotalNormalStress (const markerID_Type &flag, bcHandler_Type &bcHandler) |
| | Compute the derivative of the mean total normal stress on a boundary face with a given flag. More...
|
| |
| Real | linearMeanTotalNormalStress (const markerID_Type &flag, bcHandler_Type &bcHandler, const vector_Type &solution, const vector_Type &linearSolution) |
| | Compute the derivative of the mean total normal stress on a boundary face with a given flag. More...
|
| |
| | OseenSolverShapeDerivative (const OseenSolverShapeDerivative &oseenShapeDerivative) |
| | Empty copy constructor. More...
|
| |
|
| 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 |
| |
| preconditionerPtr_Type & | preconditioner () |
| | Return a shared pointer to the preconditioner (of type derived from EpetraPreconditioner) More...
|
| |
| | 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...
|
| |
| 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...
|
| |
| 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...
|
| |
| 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 |
| |
| | OseenSolver (const OseenSolver &oseen) |
| | Empty copy constructor. More...
|
| |
| 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...
|
| |
| dataPtr_Type | M_oseenData |
| | data for Navier-Stokes solvers More...
|
| |
| FESpace< mesh_Type, MapEpetra > & | M_velocityFESpace |
| |
| FESpace< mesh_Type, MapEpetra > & | M_pressureFESpace |
| |
| Displayer | M_Displayer |
| | MPI communicator. More...
|
| |
| MapEpetra | M_localMap |
| |
| matrixPtr_Type | M_velocityMatrixMass |
| | mass matrix More...
|
| |
| matrixPtr_Type | M_pressureMatrixMass |
| | mass matrix More...
|
| |
| matrixPtr_Type | M_matrixStokes |
| | Stokes matrix: nu*stiff. More...
|
| |
| matrixPtr_Type | M_matrixNoBC |
| | matrix to be solved More...
|
| |
| matrixPtr_Type | M_matrixStabilization |
| | stabilization matrix More...
|
| |
| source_Type | M_source |
| | source term for Navier-Stokes equations More...
|
| |
| vectorPtr_Type | M_rightHandSideNoBC |
| | Right hand side for the velocity component. More...
|
| |
| vectorPtr_Type | M_solution |
| | Global solution. More...
|
| |
| vectorPtr_Type | M_residual |
| | residual More...
|
| |
| linearSolverPtr_Type | M_linearSolver |
| |
| bool | M_steady |
| |
| std::shared_ptr< PostProcessingBoundary< mesh_Type > > | M_postProcessing |
| | Postprocessing class. More...
|
| |
| bool | M_stabilization |
| | Stabilization. More...
|
| |
| bool | M_reuseStabilization |
| |
| bool | M_resetStabilization |
| |
| Int | M_iterReuseStabilization |
| |
| details::StabilizationIP< mesh_Type, DOF > | M_ipStabilization |
| |
| Real | M_gammaBeta |
| |
| Real | M_gammaDiv |
| |
| Real | M_gammaPress |
| |
| const function_Type * | M_betaFunction |
| |
| bool | M_divBetaUv |
| |
| bool | M_stiffStrain |
| |
| Real | M_diagonalize |
| |
| UInt | M_count |
| |
| bool | M_recomputeMatrix |
| |
| bool | M_isDiagonalBlockPreconditioner |
| |
| MatrixElemental | M_elementMatrixStiff |
| | Elementary matrices and vectors. More...
|
| |
| MatrixElemental | M_elementMatrixMass |
| |
| MatrixElemental | M_elementMatrixPreconditioner |
| |
| MatrixElemental | M_elementMatrixDivergence |
| |
| MatrixElemental | M_elementMatrixGradient |
| |
| VectorElemental | M_elementRightHandSide |
| |
| matrixPtr_Type | M_blockPreconditioner |
| |
| VectorElemental | M_wLoc |
| |
| VectorElemental | M_uLoc |
| |
| std::shared_ptr< vector_Type > | M_un |
| |