LifeV
NavierStokesSolverBlocks Class Reference

#include <NavierStokesSolverBlocks.hpp>

+ Collaboration diagram for NavierStokesSolverBlocks:

Private Member Functions

void buildGraphs ()
 Build the graphs. More...
 
void updateBCHandler (bcPtr_Type &bc)
 Update the bc handler. More...
 
void setSolversOptions (const Teuchos::ParameterList &solversOptions)
 Set options preconditioner. More...
 
void applyBoundaryConditionsResidual (vector_Type &r_u, const Real &time=0.0)
 Apply Bc to the residual vector. More...
 

Private Attributes

commPtr_Type M_comm
 
dataFile_Type M_dataFile
 
std::string M_uOrder
 
std::string M_pOrder
 
std::shared_ptr< FESpace< mesh_Type, map_Type > > M_velocityFESpace
 
std::shared_ptr< FESpace< mesh_Type, map_Type > > M_pressureFESpace
 
std::shared_ptr< FESpace< mesh_Type, map_Type > > M_velocityFESpaceScalar
 
std::shared_ptr< ETFESpace_velocityM_fespaceUETA
 
std::shared_ptr< ETFESpace_pressureM_fespacePETA
 
std::shared_ptr< ETFESpace_pressureM_fespaceUETA_scalar
 
bool M_stiffStrain
 
graphPtr_Type M_Mu_graph
 
graphPtr_Type M_Btranspose_graph
 
graphPtr_Type M_B_graph
 
graphPtr_Type M_C_graph
 
graphPtr_Type M_A_graph
 
graphPtr_Type M_F_graph
 
graphPtr_Type M_Jacobian_graph
 
graphPtr_Type M_Mp_graph
 
graphPtr_Type M_Fp_graph
 
matrixPtr_Type M_Mu
 
matrixPtr_Type M_Btranspose
 
matrixPtr_Type M_B
 
matrixPtr_Type M_C
 
matrixPtr_Type M_A
 
matrixPtr_Type M_F
 
matrixPtr_Type M_Jacobian
 
matrixPtr_Type M_Mp
 
matrixPtr_Type M_Fp
 
matrixPtr_Type M_block00
 
matrixPtr_Type M_block01
 
matrixPtr_Type M_block10
 
matrixPtr_Type M_block11
 
matrixPtr_Type M_block00_noBC
 
matrixPtr_Type M_block01_noBC
 
matrixPtr_Type M_block10_noBC
 
matrixPtr_Type M_block11_noBC
 
vectorPtr_Type M_rhs_noBC
 
vectorPtr_Type M_forces
 
std::shared_ptr< LifeV::Operators::NavierStokesOperatorM_operLoads
 
vectorPtr_Type M_uExtrapolated
 
vectorPtr_Type M_rhs
 
vectorPtr_Type M_rhs_pressure
 
vectorPtr_Type M_velocity
 
vectorPtr_Type M_pressure
 
vectorPtr_Type M_velocityRhs
 
vectorPtr_Type M_velocityExtrapolated
 
std::shared_ptr< map_TypeM_monolithicMap
 
vectorPtr_Type M_solution
 
vectorPtr_Type M_residual_u
 
vectorPtr_Type M_residual_p
 
vectorPtr_Type M_velocity_old_newton
 
vectorPtr_Type M_pressure_old_newton
 
vectorPtr_Type M_pressure_extrapolated
 
Displayer M_displayer
 Displayer to print in parallel (only PID 0 will print) More...
 
Real M_alpha
 Reals. More...
 
Real M_timeStep
 
Real M_time
 
bool M_useGraph
 Booleans. More...
 
bool M_graphIsBuilt
 
bool M_graphPCDisBuilt
 
std::shared_ptr< LifeV::Operators::NavierStokesOperatorM_oper
 
std::shared_ptr< LifeV::Operators::NavierStokesPreconditionerOperatorM_prec
 
std::shared_ptr< Operators::InvertibleOperatorM_invOper
 
parameterListPtr_Type M_pListLinSolver
 
bool M_fullyImplicit
 
bcPtr_Type M_bcPCD
 
bool M_steady
 
Real M_relativeTolerance
 
Real M_absoluteTolerance
 
Real M_etaMax
 
Int M_nonLinearLineSearch
 
UInt M_maxiterNonlinear
 
std::ofstream M_out_res
 
bcPtr_Type M_bc
 
bcPtr_Type M_bc_sol
 
bcPtr_Type M_bc_res_essential
 
bcPtr_Type M_bc_res_natural
 
Real M_density
 
Real M_viscosity
 
std::shared_ptr< StabilizationM_stabilization
 
bool M_useStabilization
 
std::string M_stabilizationType
 
bool M_nonconforming
 
bool M_imposeWeakBC
 
UInt M_flagWeakBC
 
Real M_meshSizeWeakBC
 
bool M_computeAerodynamicLoads
 
std::string M_methodAerodynamicLoads
 
UInt M_flagBody
 
bool M_penalizeReverseFlow
 
UInt M_flagPenalizeReverseFlow
 
bool M_solve_blocks
 
std::shared_ptr< PostProcessingBoundary< mesh_Type > > M_postProcessing
 Postprocessing class. More...
 
bool M_useFastAssembly
 
std::shared_ptr< FastAssemblerNSM_fastAssembler
 
Real M_orderBDF
 
UInt M_orderVel
 
matrixPtr_Type M_block00_weakBC
 
matrixPtr_Type M_block01_weakBC
 
typedef RegionMesh< LinearTetramesh_Type
 
typedef std::shared_ptr< mesh_TypemeshPtr_Type
 
typedef MapEpetra map_Type
 
typedef std::shared_ptr< map_TypemapPtr_Type
 
typedef MatrixEpetra< Realmatrix_Type
 
typedef std::shared_ptr< matrix_TypematrixPtr_Type
 
typedef VectorEpetra vector_Type
 
typedef std::shared_ptr< vector_TypevectorPtr_Type
 
typedef GetPot dataFile_Type
 
typedef std::shared_ptr< dataFile_TypedataFilePtr_Type
 
typedef Epetra_Comm comm_Type
 
typedef std::shared_ptr< comm_TypecommPtr_Type
 
typedef Epetra_FECrsGraph graph_Type
 
typedef std::shared_ptr< Epetra_FECrsGraph > graphPtr_Type
 
typedef ETFESpace< mesh_Type, map_Type, 3, 3 > ETFESpace_velocity
 
typedef ETFESpace< mesh_Type, map_Type, 3, 1 > ETFESpace_pressure
 
typedef std::shared_ptr< BCHandlerbcPtr_Type
 
typedef Teuchos::ParameterList parameterList_Type
 
typedef std::shared_ptr< parameterList_TypeparameterListPtr_Type
 
typedef std::shared_ptr< Epetra_OperatorinvOpPtr_Type
 
typedef LifeV::Preconditioner basePrec_Type
 
typedef std::shared_ptr< basePrec_TypebasePrecPtr_Type
 
typedef LifeV::PreconditionerIfpack prec_Type
 
typedef std::shared_ptr< prec_TypeprecPtr_Type
 
typedef Teuchos::RCP< Teuchos::ParameterList > parameterListRCP_Type
 

Constructor and Destructor

 NavierStokesSolverBlocks (const dataFile_Type dataFile, const commPtr_Type &communicator)
 
 ~NavierStokesSolverBlocks ()
 

Methods

void setup (const meshPtr_Type &mesh, const int &id_domain=36)
 Setup for the solver. More...
 
void buildSystem ()
 Assemble constant terms. More...
 
void updateSystem (const vectorPtr_Type &u_star, const vectorPtr_Type &rhs_velocity)
 Update the convective term and the right hand side. More...
 
void iterate (bcPtr_Type &bc, const Real &time)
 Solve the current timestep, provided the BC. More...
 
void iterate (bcPtr_Type &bc, const Real &time, const vectorPtr_Type &velocities)
 Solve the current timestep, provided the BC and a vector of velocities (used only for for aorta example) More...
 
void iterate_steady ()
 Solve the steady Navier-Stokes equations. More...
 
void iterate_nonlinear (const Real &time)
 Solve the Navier-Stokes equations at a certain time. More...
 
void evalResidual (vector_Type &residual, const vector_Type &solution, const UInt iter_newton)
 Evaluate the residual of the NS problem. More...
 
void solveJac (vector_Type &increment, const vector_Type &residual, const Real linearRelTol)
 Evaluate the residual of the NS problem. More...
 
void updateJacobian (const vector_Type &u_k)
 Update the Jacobian matrix, only the term associated with the linearization of the convective term. More...
 
void applyBoundaryConditions (bcPtr_Type &bc, const Real &time)
 Apply the BCs semi-implicit case. More...
 
void applyBoundaryConditions (bcPtr_Type &bc, const Real &time, const vectorPtr_Type &velocities)
 Apply the BCs semi-implicit case (example aorta) More...
 
void applyBoundaryConditionsJacobian (bcPtr_Type &bc)
 Apply the BCs on the Jacobian matrix. More...
 
void applyBoundaryConditionsSolution (const Real &time)
 Apply the BCs to the solution. More...
 
void updateConvectiveTerm (const vectorPtr_Type &velocity)
 Update the convective term. More...
 
VectorSmall< 2 > computeForces (BCHandler &bcHandlerDrag, BCHandler &bcHandlerLift)
 Compute Aerodynamic Forces. More...
 
void solveTimeStep ()
 Solve a time step. More...
 
void computeForcesNonLinear (vectorPtr_Type &force, const vectorPtr_Type &solution)
 Compute Aerodynamic Forces - nonlinear case. More...
 
void evaluateResidual (const vectorPtr_Type &convective_velocity, const vectorPtr_Type &velocity_km1, const vectorPtr_Type &pressure_km1, const vectorPtr_Type &rhs_velocity, vectorPtr_Type &residual)
 Evaluates the fluid residual in FSI simulations. More...
 
void evaluateResidual (const vectorPtr_Type &convective_velocity, const vectorPtr_Type &velocity_km1, const vectorPtr_Type &pressure_km1, const vectorPtr_Type &rhs_velocity, vectorPtr_Type &residualVelocity, vectorPtr_Type &residualPressure)
 Evaluates the fluid residual in FSI simulations. More...
 
void updateStabilization (const vector_Type &convective_velocity_previous_newton_step, const vector_Type &velocity_previous_newton_step, const vector_Type &pressure_previous_newton_step, const vector_Type &velocity_rhs)
 Update stabilization terms. More...
 
void integrateForces (const vectorPtr_Type &velocity, const vectorPtr_Type &pressure)
 Computation of forces. More...
 
void preprocessBoundary (const Real &nx, const Real &ny, const Real &nz, BCHandler &bc, Real &Q_hat, const vectorPtr_Type &Phi_h, const UInt flag, vectorPtr_Type &Phi_h_flag, vectorPtr_Type &V_hat_x, vectorPtr_Type &V_hat_y, vectorPtr_Type &V_hat_z)
 Additional method used for pre-processing on non-circular boundaries (used only in example aorta) More...
 
void solveLaplacian (const UInt &flag, bcPtr_Type &bc_laplacian, vectorPtr_Type &laplacianSolution)
 Additional method used for pre-processing on non-circular boundaries (used only in example aorta) More...
 
void setupPostProc ()
 Additional setup for postprocessing on boundaries. More...
 
Real flux (const markerID_Type &flag, const vector_Type &velocity)
 Compute flux through a boundary face of the domain. More...
 
Real area (const markerID_Type &flag)
 Compute area of a boundary face of the domain. More...
 
Real pres (const markerID_Type &flag, const vector_Type &pressure)
 Compute mean pressure at a boundary face of the domain. More...
 
Vector geometricCenter (const markerID_Type &flag)
 Compute center of a boundary face of the domain. More...
 
Vector normal (const markerID_Type &flag)
 Compute normal of a boundary face of the domain. More...
 

Set methods

void setAlpha (const Real &alpha)
 Set coefficient associated to the time discretization scheme. More...
 
void setRhsVelocity (const vectorPtr_Type &vel_rhs)
 Set the rhs vector, velocity component. More...
 
void setExtrapolatedPressure (const vectorPtr_Type &pressure_extrapolated)
 Set the extrapolated pressure vector (used by semi-implicit VMS-LES stabilization) More...
 
void setExportFineScaleVelocity (ExporterHDF5< mesh_Type > &exporter, const int &numElementsTotal)
 Set if one needs to export the fine scale component (when using LES models) More...
 
void setParameters ()
 Set parameters of the solver. More...
 
void setTimeStep (const Real &dt)
 Set time step. More...
 
void setBoundaryConditions (const bcPtr_Type &bc)
 Set time step. More...
 

Get methods

const std::shared_ptr< FESpace< mesh_Type, map_Type > > & uFESpace () const
 Get the velocity FE space. More...
 
const std::shared_ptr< FESpace< mesh_Type, map_Type > > & pFESpace () const
 Get the velocity FE space. More...
 
const std::shared_ptr< FESpace< mesh_Type, map_Type > > & uFESpace_scalar () const
 Get the velocity FE space. More...
 
void updateVelocity (vectorPtr_Type &velocity)
 Get the velocity vector. More...
 
void updatePressure (vectorPtr_Type &pressure)
 Get the pressure vector. More...
 
matrixPtr_Type const & getF () const
 Get the F block. More...
 
matrixPtr_Type const & getJacobian () const
 Get the jacobian block. More...
 
matrixPtr_Type const & getBtranspose () const
 Get the Btranspose block. More...
 
matrixPtr_Type const & getB () const
 Get the B block. More...
 
vectorPtr_Type const & getRhs () const
 Get the rhs. More...
 
vectorPtr_Type const & getRhsPressure () const
 Get the rhs vector (pressure part) More...
 
matrixPtr_Type const & Mu () const
 
Real density () const
 
Real viscosity () const
 
matrixPtr_Type const & block00 () const
 Get the (0,0) block. More...
 
matrixPtr_Type const & block01 () const
 Get the (0,1) block. More...
 
matrixPtr_Type const & block10 () const
 Get the (1,0) block. More...
 
matrixPtr_Type const & block11 () const
 Get the (1,1) More...
 
bool useStabilization () const
 Get if using a stabilization. More...
 
void assembleInterfaceMass (matrixPtr_Type &mass_interface, const mapPtr_Type &interface_map, markerID_Type interfaceFlag, const vectorPtr_Type &numerationInterface, const UInt &offset)
 
Displayer const & getDisplayer () const
 Get the displayer. More...
 
matrixPtr_Type block00_noBC () const
 Get the (0,0) block without BCs. More...
 
matrixPtr_Type block01_noBC () const
 Get the (0,1) block without BCs. More...
 
vectorPtr_Type rhs_noBC () const
 Get the rhs without bcs applied. More...
 
vectorPtr_Type getForces () const
 Get the forces. More...
 

Detailed Description

Definition at line 108 of file NavierStokesSolverBlocks.hpp.

Member Typedef Documentation

◆ mesh_Type

Definition at line 116 of file NavierStokesSolverBlocks.hpp.

◆ meshPtr_Type

typedef std::shared_ptr<mesh_Type> meshPtr_Type

Definition at line 117 of file NavierStokesSolverBlocks.hpp.

◆ map_Type

Definition at line 119 of file NavierStokesSolverBlocks.hpp.

◆ mapPtr_Type

typedef std::shared_ptr<map_Type> mapPtr_Type

Definition at line 120 of file NavierStokesSolverBlocks.hpp.

◆ matrix_Type

Definition at line 122 of file NavierStokesSolverBlocks.hpp.

◆ matrixPtr_Type

typedef std::shared_ptr<matrix_Type> matrixPtr_Type

Definition at line 123 of file NavierStokesSolverBlocks.hpp.

◆ vector_Type

Definition at line 125 of file NavierStokesSolverBlocks.hpp.

◆ vectorPtr_Type

typedef std::shared_ptr<vector_Type> vectorPtr_Type

Definition at line 126 of file NavierStokesSolverBlocks.hpp.

◆ dataFile_Type

Definition at line 128 of file NavierStokesSolverBlocks.hpp.

◆ dataFilePtr_Type

typedef std::shared_ptr<dataFile_Type> dataFilePtr_Type

Definition at line 129 of file NavierStokesSolverBlocks.hpp.

◆ comm_Type

typedef Epetra_Comm comm_Type

Definition at line 131 of file NavierStokesSolverBlocks.hpp.

◆ commPtr_Type

typedef std::shared_ptr< comm_Type > commPtr_Type

Definition at line 132 of file NavierStokesSolverBlocks.hpp.

◆ graph_Type

typedef Epetra_FECrsGraph graph_Type

Definition at line 134 of file NavierStokesSolverBlocks.hpp.

◆ graphPtr_Type

typedef std::shared_ptr<Epetra_FECrsGraph> graphPtr_Type

Definition at line 135 of file NavierStokesSolverBlocks.hpp.

◆ ETFESpace_velocity

Definition at line 137 of file NavierStokesSolverBlocks.hpp.

◆ ETFESpace_pressure

Definition at line 138 of file NavierStokesSolverBlocks.hpp.

◆ bcPtr_Type

typedef std::shared_ptr<BCHandler> bcPtr_Type

Definition at line 140 of file NavierStokesSolverBlocks.hpp.

◆ parameterList_Type

typedef Teuchos::ParameterList parameterList_Type

Definition at line 142 of file NavierStokesSolverBlocks.hpp.

◆ parameterListPtr_Type

typedef std::shared_ptr<parameterList_Type> parameterListPtr_Type

Definition at line 143 of file NavierStokesSolverBlocks.hpp.

◆ invOpPtr_Type

typedef std::shared_ptr<Epetra_Operator> invOpPtr_Type

Definition at line 145 of file NavierStokesSolverBlocks.hpp.

◆ basePrec_Type

◆ basePrecPtr_Type

typedef std::shared_ptr<basePrec_Type> basePrecPtr_Type

Definition at line 148 of file NavierStokesSolverBlocks.hpp.

◆ prec_Type

◆ precPtr_Type

typedef std::shared_ptr<prec_Type> precPtr_Type

Definition at line 150 of file NavierStokesSolverBlocks.hpp.

◆ parameterListRCP_Type

typedef Teuchos::RCP< Teuchos::ParameterList > parameterListRCP_Type

Definition at line 151 of file NavierStokesSolverBlocks.hpp.

Constructor & Destructor Documentation

◆ NavierStokesSolverBlocks()

NavierStokesSolverBlocks ( const dataFile_Type  dataFile,
const commPtr_Type communicator 
)

Definition at line 35 of file NavierStokesSolverBlocks.cpp.

◆ ~NavierStokesSolverBlocks()

Definition at line 64 of file NavierStokesSolverBlocks.cpp.

Member Function Documentation

◆ setup()

void setup ( const meshPtr_Type mesh,
const int &  id_domain = 36 
)

Setup for the solver.

Parameters
meshmesh used
id_domainused just in case of multiple fluids

Definition at line 77 of file NavierStokesSolverBlocks.cpp.

◆ buildSystem()

void buildSystem ( )

Assemble constant terms.

Definition at line 356 of file NavierStokesSolverBlocks.cpp.

+ Here is the caller graph for this function:

◆ updateSystem()

void updateSystem ( const vectorPtr_Type u_star,
const vectorPtr_Type rhs_velocity 
)

Update the convective term and the right hand side.

Parameters
u_starextrapolate velocity
rhs_velocityright hand side, velocity block

Definition at line 495 of file NavierStokesSolverBlocks.cpp.

+ Here is the caller graph for this function:

◆ iterate() [1/2]

void iterate ( bcPtr_Type bc,
const Real time 
)

Solve the current timestep, provided the BC.

Parameters
bcboundary conditions
timecurrent time

Definition at line 726 of file NavierStokesSolverBlocks.cpp.

◆ iterate() [2/2]

void iterate ( bcPtr_Type bc,
const Real time,
const vectorPtr_Type velocities 
)

Solve the current timestep, provided the BC and a vector of velocities (used only for for aorta example)

Parameters
bcboundary conditions
timecurrent time
velocitiesvector of velocity (used for imposing velocity on noncircular inflows)

Definition at line 713 of file NavierStokesSolverBlocks.cpp.

◆ iterate_steady()

void iterate_steady ( )

Solve the steady Navier-Stokes equations.

Definition at line 899 of file NavierStokesSolverBlocks.cpp.

+ Here is the caller graph for this function:

◆ iterate_nonlinear()

void iterate_nonlinear ( const Real time)

Solve the Navier-Stokes equations at a certain time.

Parameters
timecurrent time

Definition at line 873 of file NavierStokesSolverBlocks.cpp.

+ Here is the caller graph for this function:

◆ evalResidual()

void evalResidual ( vector_Type residual,
const vector_Type solution,
const UInt  iter_newton 
)

Evaluate the residual of the NS problem.

Parameters
residualresidual vector
solutionsolution vector
iter_newtoncurrent newton iteration

Definition at line 1168 of file NavierStokesSolverBlocks.cpp.

◆ solveJac()

void solveJac ( vector_Type increment,
const vector_Type residual,
const Real  linearRelTol 
)

Evaluate the residual of the NS problem.

Parameters
incrementincrement vector
residualresidual vector
linearRelToltolerance of the linar solver

Definition at line 1508 of file NavierStokesSolverBlocks.cpp.

◆ updateJacobian()

void updateJacobian ( const vector_Type u_k)

Update the Jacobian matrix, only the term associated with the linearization of the convective term.

Parameters
u_kvelocity previous newton step

Definition at line 1396 of file NavierStokesSolverBlocks.cpp.

◆ applyBoundaryConditions() [1/2]

void applyBoundaryConditions ( bcPtr_Type bc,
const Real time 
)

Apply the BCs semi-implicit case.

Parameters
bcboundary conditions of the problem
timecurrent time

Definition at line 667 of file NavierStokesSolverBlocks.cpp.

◆ applyBoundaryConditions() [2/2]

void applyBoundaryConditions ( bcPtr_Type bc,
const Real time,
const vectorPtr_Type velocities 
)

Apply the BCs semi-implicit case (example aorta)

Parameters
bcboundary conditions of the problem
timecurrent time
velocitiesvector of velocities to be imposed

Definition at line 702 of file NavierStokesSolverBlocks.cpp.

◆ applyBoundaryConditionsJacobian()

void applyBoundaryConditionsJacobian ( bcPtr_Type bc)

Apply the BCs on the Jacobian matrix.

Parameters
bcboundary conditions of the problem

Definition at line 1584 of file NavierStokesSolverBlocks.cpp.

◆ applyBoundaryConditionsSolution()

void applyBoundaryConditionsSolution ( const Real time)

Apply the BCs to the solution.

Parameters
timecurrent time

Definition at line 915 of file NavierStokesSolverBlocks.cpp.

◆ updateConvectiveTerm()

void updateConvectiveTerm ( const vectorPtr_Type velocity)

Update the convective term.

Parameters
velocityvelocity vector

Definition at line 1357 of file NavierStokesSolverBlocks.cpp.

◆ computeForces()

VectorSmall< 2 > computeForces ( BCHandler bcHandlerDrag,
BCHandler bcHandlerLift 
)

Compute Aerodynamic Forces.

Parameters
bcHandlerDragbc to be used for drag computation
bcHandlerLiftbc to be used for lift computation

Definition at line 845 of file NavierStokesSolverBlocks.cpp.

◆ solveTimeStep()

void solveTimeStep ( )

Solve a time step.

Definition at line 740 of file NavierStokesSolverBlocks.cpp.

◆ computeForcesNonLinear()

void computeForcesNonLinear ( vectorPtr_Type force,
const vectorPtr_Type solution 
)

Compute Aerodynamic Forces - nonlinear case.

Parameters
forcevector containing the forces
solutionvector with the solution

Definition at line 1100 of file NavierStokesSolverBlocks.cpp.

◆ evaluateResidual() [1/2]

void evaluateResidual ( const vectorPtr_Type convective_velocity,
const vectorPtr_Type velocity_km1,
const vectorPtr_Type pressure_km1,
const vectorPtr_Type rhs_velocity,
vectorPtr_Type residual 
)

Evaluates the fluid residual in FSI simulations.

Parameters
convective_velocitydifference between fluid velocity and mesh velocity at previous Newton iteration
velocity_km1fluid velocity at previous Newton iteration
pressure_km1fluid pressure at previous Newton iteration
pressure_km1terms of bdf associated to the rhs
residualresidual that will be assembled

Definition at line 999 of file NavierStokesSolverBlocks.cpp.

◆ evaluateResidual() [2/2]

void evaluateResidual ( const vectorPtr_Type convective_velocity,
const vectorPtr_Type velocity_km1,
const vectorPtr_Type pressure_km1,
const vectorPtr_Type rhs_velocity,
vectorPtr_Type residualVelocity,
vectorPtr_Type residualPressure 
)

Evaluates the fluid residual in FSI simulations.

Parameters
convective_velocitydifference between fluid velocity and mesh velocity at previous Newton iteration
velocity_km1fluid velocity at previous Newton iteration
pressure_km1fluid pressure at previous Newton iteration
pressure_km1terms of bdf associated to the rhs
residualVelocityresidual associated to the fluid momentum equation
residualPressureresidual associated to the fluid continuity equation

Definition at line 926 of file NavierStokesSolverBlocks.cpp.

◆ updateStabilization()

void updateStabilization ( const vector_Type convective_velocity_previous_newton_step,
const vector_Type velocity_previous_newton_step,
const vector_Type pressure_previous_newton_step,
const vector_Type velocity_rhs 
)

Update stabilization terms.

Parameters
convective_velocity_previous_newton_stepdifference between fluid velocity and mesh velocity at previous Newton iteration
velocity_previous_newton_stepfluid velocity at previous Newton iteration
pressure_previous_newton_stepfluid pressure at previous Newton iteration
velocity_rhsblock of the velocity of the rhs

Definition at line 1428 of file NavierStokesSolverBlocks.cpp.

◆ integrateForces()

void integrateForces ( const vectorPtr_Type velocity,
const vectorPtr_Type pressure 
)

Computation of forces.

Parameters
velocityvelocity vector
pressurepressure vector

◆ preprocessBoundary()

void preprocessBoundary ( const Real nx,
const Real ny,
const Real nz,
BCHandler bc,
Real Q_hat,
const vectorPtr_Type Phi_h,
const UInt  flag,
vectorPtr_Type Phi_h_flag,
vectorPtr_Type V_hat_x,
vectorPtr_Type V_hat_y,
vectorPtr_Type V_hat_z 
)

Additional method used for pre-processing on non-circular boundaries (used only in example aorta)

Parameters
nxx component normal vector to an outflow face
nyy component normal vector to an outflow face
nzz component normal vector to an outflow face
bcboundary conditions
Q_hatreference flowrate to be imposed
Phi_hsolution laplacian
flagflag outflow
Phi_h_flagsolution laplacian on the outflow flag
V_hat_xreference velocity, x component
V_hat_yreference velocity, y component
V_hat_zreference velocity, z component

Definition at line 1591 of file NavierStokesSolverBlocks.cpp.

◆ solveLaplacian()

void solveLaplacian ( const UInt flag,
bcPtr_Type bc_laplacian,
vectorPtr_Type laplacianSolution 
)

Additional method used for pre-processing on non-circular boundaries (used only in example aorta)

Parameters
flagflag of the outflow face
bc_laplacianboundary conditions laplacian
laplacianSolutionsolution laplacian

Definition at line 1640 of file NavierStokesSolverBlocks.cpp.

◆ setupPostProc()

void setupPostProc ( )

Additional setup for postprocessing on boundaries.

Definition at line 1712 of file NavierStokesSolverBlocks.cpp.

+ Here is the caller graph for this function:

◆ flux()

Real flux ( const markerID_Type flag,
const vector_Type velocity 
)

Compute flux through a boundary face of the domain.

Parameters
flagflag of the face
velocityvelocity vector

Definition at line 1724 of file NavierStokesSolverBlocks.cpp.

◆ area()

Real area ( const markerID_Type flag)

Compute area of a boundary face of the domain.

Parameters
flagflag of the outflow face

Definition at line 1731 of file NavierStokesSolverBlocks.cpp.

◆ pres()

Real pres ( const markerID_Type flag,
const vector_Type pressure 
)

Compute mean pressure at a boundary face of the domain.

Parameters
flagflag of the outflow face
pressurepressure vector

Definition at line 1749 of file NavierStokesSolverBlocks.cpp.

◆ geometricCenter()

Vector geometricCenter ( const markerID_Type flag)

Compute center of a boundary face of the domain.

Parameters
flagflag of the face

Definition at line 1737 of file NavierStokesSolverBlocks.cpp.

◆ normal()

Vector normal ( const markerID_Type flag)

Compute normal of a boundary face of the domain.

Parameters
flagflag of the face

Definition at line 1743 of file NavierStokesSolverBlocks.cpp.

◆ setAlpha()

void setAlpha ( const Real alpha)
inline

Set coefficient associated to the time discretization scheme.

Parameters
alphacoefficient BDF scheme in front of u^{n+1}

Definition at line 400 of file NavierStokesSolverBlocks.hpp.

+ Here is the caller graph for this function:

◆ setRhsVelocity()

void setRhsVelocity ( const vectorPtr_Type vel_rhs)
inline

Set the rhs vector, velocity component.

Parameters
vel_rhsrhs vector, velocity component

Definition at line 413 of file NavierStokesSolverBlocks.hpp.

+ Here is the caller graph for this function:

◆ setExtrapolatedPressure()

void setExtrapolatedPressure ( const vectorPtr_Type pressure_extrapolated)
inline

Set the extrapolated pressure vector (used by semi-implicit VMS-LES stabilization)

Parameters
pressure_extrapolatedpressure extrapolated vector

Definition at line 422 of file NavierStokesSolverBlocks.hpp.

+ Here is the caller graph for this function:

◆ setExportFineScaleVelocity()

void setExportFineScaleVelocity ( ExporterHDF5< mesh_Type > &  exporter,
const int &  numElementsTotal 
)

Set if one needs to export the fine scale component (when using LES models)

Parameters
exporterexporter
numElementsTotalnumber of total elements (tetrahedral elements)

Definition at line 206 of file NavierStokesSolverBlocks.cpp.

◆ setParameters()

void setParameters ( )

Set parameters of the solver.

Definition at line 68 of file NavierStokesSolverBlocks.cpp.

+ Here is the caller graph for this function:

◆ setTimeStep()

void setTimeStep ( const Real dt)
inline

Set time step.

Parameters
dttime step size

Definition at line 438 of file NavierStokesSolverBlocks.hpp.

+ Here is the caller graph for this function:

◆ setBoundaryConditions()

void setBoundaryConditions ( const bcPtr_Type bc)

Set time step.

Parameters
bcboundary conditions of the problem

Definition at line 1756 of file NavierStokesSolverBlocks.cpp.

◆ uFESpace()

const std::shared_ptr<FESpace<mesh_Type, map_Type> >& uFESpace ( ) const
inline

Get the velocity FE space.

Definition at line 455 of file NavierStokesSolverBlocks.hpp.

◆ pFESpace()

const std::shared_ptr<FESpace<mesh_Type, map_Type> >& pFESpace ( ) const
inline

Get the velocity FE space.

Definition at line 461 of file NavierStokesSolverBlocks.hpp.

◆ uFESpace_scalar()

const std::shared_ptr<FESpace<mesh_Type, map_Type> >& uFESpace_scalar ( ) const
inline

Get the velocity FE space.

Definition at line 467 of file NavierStokesSolverBlocks.hpp.

◆ updateVelocity()

void updateVelocity ( vectorPtr_Type velocity)
inline

Get the velocity vector.

Definition at line 473 of file NavierStokesSolverBlocks.hpp.

+ Here is the caller graph for this function:

◆ updatePressure()

void updatePressure ( vectorPtr_Type pressure)
inline

Get the pressure vector.

Definition at line 479 of file NavierStokesSolverBlocks.hpp.

+ Here is the caller graph for this function:

◆ getF()

matrixPtr_Type const& getF ( ) const
inline

Get the F block.

Definition at line 485 of file NavierStokesSolverBlocks.hpp.

◆ getJacobian()

matrixPtr_Type const& getJacobian ( ) const
inline

Get the jacobian block.

Definition at line 491 of file NavierStokesSolverBlocks.hpp.

◆ getBtranspose()

matrixPtr_Type const& getBtranspose ( ) const
inline

Get the Btranspose block.

Definition at line 497 of file NavierStokesSolverBlocks.hpp.

◆ getB()

matrixPtr_Type const& getB ( ) const
inline

Get the B block.

Definition at line 503 of file NavierStokesSolverBlocks.hpp.

◆ getRhs()

vectorPtr_Type const& getRhs ( ) const
inline

Get the rhs.

Definition at line 509 of file NavierStokesSolverBlocks.hpp.

◆ getRhsPressure()

vectorPtr_Type const& getRhsPressure ( ) const
inline

Get the rhs vector (pressure part)

Definition at line 515 of file NavierStokesSolverBlocks.hpp.

◆ Mu()

matrixPtr_Type const& Mu ( ) const
inline

Definition at line 520 of file NavierStokesSolverBlocks.hpp.

◆ density()

Real density ( ) const
inline

Definition at line 525 of file NavierStokesSolverBlocks.hpp.

◆ viscosity()

Real viscosity ( ) const
inline

Definition at line 530 of file NavierStokesSolverBlocks.hpp.

◆ block00()

matrixPtr_Type const& block00 ( ) const
inline

Get the (0,0) block.

Definition at line 536 of file NavierStokesSolverBlocks.hpp.

◆ block01()

matrixPtr_Type const& block01 ( ) const
inline

Get the (0,1) block.

Definition at line 542 of file NavierStokesSolverBlocks.hpp.

◆ block10()

matrixPtr_Type const& block10 ( ) const
inline

Get the (1,0) block.

Definition at line 548 of file NavierStokesSolverBlocks.hpp.

◆ block11()

matrixPtr_Type const& block11 ( ) const
inline

Get the (1,1)

Definition at line 554 of file NavierStokesSolverBlocks.hpp.

◆ useStabilization()

bool useStabilization ( ) const
inline

Get if using a stabilization.

Definition at line 560 of file NavierStokesSolverBlocks.hpp.

◆ assembleInterfaceMass()

void assembleInterfaceMass ( matrixPtr_Type mass_interface,
const mapPtr_Type interface_map,
markerID_Type  interfaceFlag,
const vectorPtr_Type numerationInterface,
const UInt offset 
)

Definition at line 1072 of file NavierStokesSolverBlocks.cpp.

◆ getDisplayer()

Displayer const& getDisplayer ( ) const
inline

Get the displayer.

Definition at line 569 of file NavierStokesSolverBlocks.hpp.

◆ block00_noBC()

matrixPtr_Type block00_noBC ( ) const
inline

Get the (0,0) block without BCs.

Definition at line 572 of file NavierStokesSolverBlocks.hpp.

◆ block01_noBC()

matrixPtr_Type block01_noBC ( ) const
inline

Get the (0,1) block without BCs.

Definition at line 578 of file NavierStokesSolverBlocks.hpp.

◆ rhs_noBC()

vectorPtr_Type rhs_noBC ( ) const
inline

Get the rhs without bcs applied.

Definition at line 584 of file NavierStokesSolverBlocks.hpp.

◆ getForces()

vectorPtr_Type getForces ( ) const
inline

Get the forces.

Definition at line 590 of file NavierStokesSolverBlocks.hpp.

◆ buildGraphs()

void buildGraphs ( )
private

Build the graphs.

Definition at line 218 of file NavierStokesSolverBlocks.cpp.

◆ updateBCHandler()

void updateBCHandler ( bcPtr_Type bc)
private

Update the bc handler.

Definition at line 921 of file NavierStokesSolverBlocks.cpp.

◆ setSolversOptions()

void setSolversOptions ( const Teuchos::ParameterList &  solversOptions)
private

Set options preconditioner.

Definition at line 211 of file NavierStokesSolverBlocks.cpp.

◆ applyBoundaryConditionsResidual()

void applyBoundaryConditionsResidual ( vector_Type r_u,
const Real time = 0.0 
)
private

Apply Bc to the residual vector.

Extract each component of the input vector

Apply BC on each component

Definition at line 1321 of file NavierStokesSolverBlocks.cpp.

Field Documentation

◆ M_comm

commPtr_Type M_comm
private

Definition at line 612 of file NavierStokesSolverBlocks.hpp.

◆ M_dataFile

dataFile_Type M_dataFile
private

Definition at line 615 of file NavierStokesSolverBlocks.hpp.

◆ M_uOrder

std::string M_uOrder
private

Definition at line 618 of file NavierStokesSolverBlocks.hpp.

◆ M_pOrder

std::string M_pOrder
private

Definition at line 619 of file NavierStokesSolverBlocks.hpp.

◆ M_velocityFESpace

std::shared_ptr<FESpace<mesh_Type, map_Type> > M_velocityFESpace
private

Definition at line 622 of file NavierStokesSolverBlocks.hpp.

◆ M_pressureFESpace

std::shared_ptr<FESpace<mesh_Type, map_Type> > M_pressureFESpace
private

Definition at line 623 of file NavierStokesSolverBlocks.hpp.

◆ M_velocityFESpaceScalar

std::shared_ptr<FESpace<mesh_Type, map_Type> > M_velocityFESpaceScalar
private

Definition at line 624 of file NavierStokesSolverBlocks.hpp.

◆ M_fespaceUETA

std::shared_ptr<ETFESpace_velocity > M_fespaceUETA
private

Definition at line 627 of file NavierStokesSolverBlocks.hpp.

◆ M_fespacePETA

std::shared_ptr<ETFESpace_pressure > M_fespacePETA
private

Definition at line 628 of file NavierStokesSolverBlocks.hpp.

◆ M_fespaceUETA_scalar

std::shared_ptr<ETFESpace_pressure > M_fespaceUETA_scalar
private

Definition at line 629 of file NavierStokesSolverBlocks.hpp.

◆ M_stiffStrain

bool M_stiffStrain
private

Definition at line 632 of file NavierStokesSolverBlocks.hpp.

◆ M_Mu_graph

graphPtr_Type M_Mu_graph
private

Definition at line 635 of file NavierStokesSolverBlocks.hpp.

◆ M_Btranspose_graph

graphPtr_Type M_Btranspose_graph
private

Definition at line 636 of file NavierStokesSolverBlocks.hpp.

◆ M_B_graph

graphPtr_Type M_B_graph
private

Definition at line 637 of file NavierStokesSolverBlocks.hpp.

◆ M_C_graph

graphPtr_Type M_C_graph
private

Definition at line 638 of file NavierStokesSolverBlocks.hpp.

◆ M_A_graph

graphPtr_Type M_A_graph
private

Definition at line 639 of file NavierStokesSolverBlocks.hpp.

◆ M_F_graph

graphPtr_Type M_F_graph
private

Definition at line 640 of file NavierStokesSolverBlocks.hpp.

◆ M_Jacobian_graph

graphPtr_Type M_Jacobian_graph
private

Definition at line 641 of file NavierStokesSolverBlocks.hpp.

◆ M_Mp_graph

graphPtr_Type M_Mp_graph
private

Definition at line 643 of file NavierStokesSolverBlocks.hpp.

◆ M_Fp_graph

graphPtr_Type M_Fp_graph
private

Definition at line 644 of file NavierStokesSolverBlocks.hpp.

◆ M_Mu

matrixPtr_Type M_Mu
private

Definition at line 647 of file NavierStokesSolverBlocks.hpp.

◆ M_Btranspose

matrixPtr_Type M_Btranspose
private

Definition at line 648 of file NavierStokesSolverBlocks.hpp.

◆ M_B

matrixPtr_Type M_B
private

Definition at line 649 of file NavierStokesSolverBlocks.hpp.

◆ M_C

matrixPtr_Type M_C
private

Definition at line 650 of file NavierStokesSolverBlocks.hpp.

◆ M_A

matrixPtr_Type M_A
private

Definition at line 651 of file NavierStokesSolverBlocks.hpp.

◆ M_F

matrixPtr_Type M_F
private

Definition at line 652 of file NavierStokesSolverBlocks.hpp.

◆ M_Jacobian

matrixPtr_Type M_Jacobian
private

Definition at line 653 of file NavierStokesSolverBlocks.hpp.

◆ M_Mp

matrixPtr_Type M_Mp
private

Definition at line 655 of file NavierStokesSolverBlocks.hpp.

◆ M_Fp

matrixPtr_Type M_Fp
private

Definition at line 656 of file NavierStokesSolverBlocks.hpp.

◆ M_block00

matrixPtr_Type M_block00
private

Definition at line 659 of file NavierStokesSolverBlocks.hpp.

◆ M_block01

matrixPtr_Type M_block01
private

Definition at line 660 of file NavierStokesSolverBlocks.hpp.

◆ M_block10

matrixPtr_Type M_block10
private

Definition at line 661 of file NavierStokesSolverBlocks.hpp.

◆ M_block11

matrixPtr_Type M_block11
private

Definition at line 662 of file NavierStokesSolverBlocks.hpp.

◆ M_block00_noBC

matrixPtr_Type M_block00_noBC
private

Definition at line 666 of file NavierStokesSolverBlocks.hpp.

◆ M_block01_noBC

matrixPtr_Type M_block01_noBC
private

Definition at line 667 of file NavierStokesSolverBlocks.hpp.

◆ M_block10_noBC

matrixPtr_Type M_block10_noBC
private

Definition at line 668 of file NavierStokesSolverBlocks.hpp.

◆ M_block11_noBC

matrixPtr_Type M_block11_noBC
private

Definition at line 669 of file NavierStokesSolverBlocks.hpp.

◆ M_rhs_noBC

vectorPtr_Type M_rhs_noBC
private

Definition at line 670 of file NavierStokesSolverBlocks.hpp.

◆ M_forces

vectorPtr_Type M_forces
private

Definition at line 671 of file NavierStokesSolverBlocks.hpp.

◆ M_operLoads

std::shared_ptr<LifeV::Operators::NavierStokesOperator> M_operLoads
private

Definition at line 672 of file NavierStokesSolverBlocks.hpp.

◆ M_uExtrapolated

vectorPtr_Type M_uExtrapolated
private

Definition at line 675 of file NavierStokesSolverBlocks.hpp.

◆ M_rhs

vectorPtr_Type M_rhs
private

Definition at line 676 of file NavierStokesSolverBlocks.hpp.

◆ M_rhs_pressure

vectorPtr_Type M_rhs_pressure
private

Definition at line 677 of file NavierStokesSolverBlocks.hpp.

◆ M_velocity

vectorPtr_Type M_velocity
private

Definition at line 678 of file NavierStokesSolverBlocks.hpp.

◆ M_pressure

vectorPtr_Type M_pressure
private

Definition at line 679 of file NavierStokesSolverBlocks.hpp.

◆ M_velocityRhs

vectorPtr_Type M_velocityRhs
private

Definition at line 680 of file NavierStokesSolverBlocks.hpp.

◆ M_velocityExtrapolated

vectorPtr_Type M_velocityExtrapolated
private

Definition at line 681 of file NavierStokesSolverBlocks.hpp.

◆ M_monolithicMap

std::shared_ptr<map_Type> M_monolithicMap
private

Definition at line 683 of file NavierStokesSolverBlocks.hpp.

◆ M_solution

vectorPtr_Type M_solution
private

Definition at line 684 of file NavierStokesSolverBlocks.hpp.

◆ M_residual_u

vectorPtr_Type M_residual_u
private

Definition at line 686 of file NavierStokesSolverBlocks.hpp.

◆ M_residual_p

vectorPtr_Type M_residual_p
private

Definition at line 687 of file NavierStokesSolverBlocks.hpp.

◆ M_velocity_old_newton

vectorPtr_Type M_velocity_old_newton
private

Definition at line 689 of file NavierStokesSolverBlocks.hpp.

◆ M_pressure_old_newton

vectorPtr_Type M_pressure_old_newton
private

Definition at line 690 of file NavierStokesSolverBlocks.hpp.

◆ M_pressure_extrapolated

vectorPtr_Type M_pressure_extrapolated
private

Definition at line 692 of file NavierStokesSolverBlocks.hpp.

◆ M_displayer

Displayer M_displayer
private

Displayer to print in parallel (only PID 0 will print)

Definition at line 695 of file NavierStokesSolverBlocks.hpp.

◆ M_alpha

Real M_alpha
private

Reals.

Definition at line 698 of file NavierStokesSolverBlocks.hpp.

◆ M_timeStep

Real M_timeStep
private

Definition at line 699 of file NavierStokesSolverBlocks.hpp.

◆ M_time

Real M_time
private

Definition at line 700 of file NavierStokesSolverBlocks.hpp.

◆ M_useGraph

bool M_useGraph
private

Booleans.

Definition at line 703 of file NavierStokesSolverBlocks.hpp.

◆ M_graphIsBuilt

bool M_graphIsBuilt
private

Definition at line 704 of file NavierStokesSolverBlocks.hpp.

◆ M_graphPCDisBuilt

bool M_graphPCDisBuilt
private

Definition at line 705 of file NavierStokesSolverBlocks.hpp.

◆ M_oper

std::shared_ptr<LifeV::Operators::NavierStokesOperator> M_oper
private

Definition at line 708 of file NavierStokesSolverBlocks.hpp.

◆ M_prec

Definition at line 711 of file NavierStokesSolverBlocks.hpp.

◆ M_invOper

std::shared_ptr<Operators::InvertibleOperator> M_invOper
private

Definition at line 714 of file NavierStokesSolverBlocks.hpp.

◆ M_pListLinSolver

parameterListPtr_Type M_pListLinSolver
private

Definition at line 717 of file NavierStokesSolverBlocks.hpp.

◆ M_fullyImplicit

bool M_fullyImplicit
private

Definition at line 720 of file NavierStokesSolverBlocks.hpp.

◆ M_bcPCD

bcPtr_Type M_bcPCD
private

Definition at line 723 of file NavierStokesSolverBlocks.hpp.

◆ M_steady

bool M_steady
private

Definition at line 726 of file NavierStokesSolverBlocks.hpp.

◆ M_relativeTolerance

Real M_relativeTolerance
private

Definition at line 728 of file NavierStokesSolverBlocks.hpp.

◆ M_absoluteTolerance

Real M_absoluteTolerance
private

Definition at line 728 of file NavierStokesSolverBlocks.hpp.

◆ M_etaMax

Real M_etaMax
private

Definition at line 728 of file NavierStokesSolverBlocks.hpp.

◆ M_nonLinearLineSearch

Int M_nonLinearLineSearch
private

Definition at line 729 of file NavierStokesSolverBlocks.hpp.

◆ M_maxiterNonlinear

UInt M_maxiterNonlinear
private

Definition at line 730 of file NavierStokesSolverBlocks.hpp.

◆ M_out_res

std::ofstream M_out_res
private

Definition at line 731 of file NavierStokesSolverBlocks.hpp.

◆ M_bc

bcPtr_Type M_bc
private

Definition at line 734 of file NavierStokesSolverBlocks.hpp.

◆ M_bc_sol

bcPtr_Type M_bc_sol
private

Definition at line 735 of file NavierStokesSolverBlocks.hpp.

◆ M_bc_res_essential

bcPtr_Type M_bc_res_essential
private

Definition at line 736 of file NavierStokesSolverBlocks.hpp.

◆ M_bc_res_natural

bcPtr_Type M_bc_res_natural
private

Definition at line 737 of file NavierStokesSolverBlocks.hpp.

◆ M_density

Real M_density
private

Definition at line 739 of file NavierStokesSolverBlocks.hpp.

◆ M_viscosity

Real M_viscosity
private

Definition at line 740 of file NavierStokesSolverBlocks.hpp.

◆ M_stabilization

std::shared_ptr<Stabilization> M_stabilization
private

Definition at line 742 of file NavierStokesSolverBlocks.hpp.

◆ M_useStabilization

bool M_useStabilization
private

Definition at line 744 of file NavierStokesSolverBlocks.hpp.

◆ M_stabilizationType

std::string M_stabilizationType
private

Definition at line 746 of file NavierStokesSolverBlocks.hpp.

◆ M_nonconforming

bool M_nonconforming
private

Definition at line 748 of file NavierStokesSolverBlocks.hpp.

◆ M_imposeWeakBC

bool M_imposeWeakBC
private

Definition at line 751 of file NavierStokesSolverBlocks.hpp.

◆ M_flagWeakBC

UInt M_flagWeakBC
private

Definition at line 752 of file NavierStokesSolverBlocks.hpp.

◆ M_meshSizeWeakBC

Real M_meshSizeWeakBC
private

Definition at line 753 of file NavierStokesSolverBlocks.hpp.

◆ M_computeAerodynamicLoads

bool M_computeAerodynamicLoads
private

Definition at line 756 of file NavierStokesSolverBlocks.hpp.

◆ M_methodAerodynamicLoads

std::string M_methodAerodynamicLoads
private

Definition at line 757 of file NavierStokesSolverBlocks.hpp.

◆ M_flagBody

UInt M_flagBody
private

Definition at line 758 of file NavierStokesSolverBlocks.hpp.

◆ M_penalizeReverseFlow

bool M_penalizeReverseFlow
private

Definition at line 760 of file NavierStokesSolverBlocks.hpp.

◆ M_flagPenalizeReverseFlow

UInt M_flagPenalizeReverseFlow
private

Definition at line 761 of file NavierStokesSolverBlocks.hpp.

◆ M_solve_blocks

bool M_solve_blocks
private

Definition at line 763 of file NavierStokesSolverBlocks.hpp.

◆ M_postProcessing

std::shared_ptr<PostProcessingBoundary<mesh_Type> > M_postProcessing
private

Postprocessing class.

Definition at line 766 of file NavierStokesSolverBlocks.hpp.

◆ M_useFastAssembly

bool M_useFastAssembly
private

Definition at line 768 of file NavierStokesSolverBlocks.hpp.

◆ M_fastAssembler

std::shared_ptr<FastAssemblerNS> M_fastAssembler
private

Definition at line 769 of file NavierStokesSolverBlocks.hpp.

◆ M_orderBDF

Real M_orderBDF
private

Definition at line 770 of file NavierStokesSolverBlocks.hpp.

◆ M_orderVel

UInt M_orderVel
private

Definition at line 771 of file NavierStokesSolverBlocks.hpp.

◆ M_block00_weakBC

matrixPtr_Type M_block00_weakBC
private

Definition at line 773 of file NavierStokesSolverBlocks.hpp.

◆ M_block01_weakBC

matrixPtr_Type M_block01_weakBC
private

Definition at line 774 of file NavierStokesSolverBlocks.hpp.


The documentation for this class was generated from the following files: