LifeV
|
#include <NavierStokesSolverBlocks.hpp>
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... | |
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... | |
Definition at line 108 of file NavierStokesSolverBlocks.hpp.
typedef RegionMesh<LinearTetra> mesh_Type |
Definition at line 116 of file NavierStokesSolverBlocks.hpp.
typedef std::shared_ptr<mesh_Type> meshPtr_Type |
Definition at line 117 of file NavierStokesSolverBlocks.hpp.
Definition at line 119 of file NavierStokesSolverBlocks.hpp.
typedef std::shared_ptr<map_Type> mapPtr_Type |
Definition at line 120 of file NavierStokesSolverBlocks.hpp.
typedef MatrixEpetra<Real> matrix_Type |
Definition at line 122 of file NavierStokesSolverBlocks.hpp.
typedef std::shared_ptr<matrix_Type> matrixPtr_Type |
Definition at line 123 of file NavierStokesSolverBlocks.hpp.
typedef VectorEpetra vector_Type |
Definition at line 125 of file NavierStokesSolverBlocks.hpp.
typedef std::shared_ptr<vector_Type> vectorPtr_Type |
Definition at line 126 of file NavierStokesSolverBlocks.hpp.
typedef GetPot dataFile_Type |
Definition at line 128 of file NavierStokesSolverBlocks.hpp.
typedef std::shared_ptr<dataFile_Type> dataFilePtr_Type |
Definition at line 129 of file NavierStokesSolverBlocks.hpp.
typedef Epetra_Comm comm_Type |
Definition at line 131 of file NavierStokesSolverBlocks.hpp.
typedef std::shared_ptr< comm_Type > commPtr_Type |
Definition at line 132 of file NavierStokesSolverBlocks.hpp.
typedef Epetra_FECrsGraph graph_Type |
Definition at line 134 of file NavierStokesSolverBlocks.hpp.
typedef std::shared_ptr<Epetra_FECrsGraph> graphPtr_Type |
Definition at line 135 of file NavierStokesSolverBlocks.hpp.
typedef ETFESpace<mesh_Type, map_Type, 3, 3 > ETFESpace_velocity |
Definition at line 137 of file NavierStokesSolverBlocks.hpp.
typedef ETFESpace<mesh_Type, map_Type, 3, 1 > ETFESpace_pressure |
Definition at line 138 of file NavierStokesSolverBlocks.hpp.
typedef std::shared_ptr<BCHandler> bcPtr_Type |
Definition at line 140 of file NavierStokesSolverBlocks.hpp.
typedef Teuchos::ParameterList parameterList_Type |
Definition at line 142 of file NavierStokesSolverBlocks.hpp.
typedef std::shared_ptr<parameterList_Type> parameterListPtr_Type |
Definition at line 143 of file NavierStokesSolverBlocks.hpp.
typedef std::shared_ptr<Epetra_Operator> invOpPtr_Type |
Definition at line 145 of file NavierStokesSolverBlocks.hpp.
typedef LifeV::Preconditioner basePrec_Type |
Definition at line 147 of file NavierStokesSolverBlocks.hpp.
typedef std::shared_ptr<basePrec_Type> basePrecPtr_Type |
Definition at line 148 of file NavierStokesSolverBlocks.hpp.
typedef LifeV::PreconditionerIfpack prec_Type |
Definition at line 149 of file NavierStokesSolverBlocks.hpp.
typedef std::shared_ptr<prec_Type> precPtr_Type |
Definition at line 150 of file NavierStokesSolverBlocks.hpp.
typedef Teuchos::RCP< Teuchos::ParameterList > parameterListRCP_Type |
Definition at line 151 of file NavierStokesSolverBlocks.hpp.
NavierStokesSolverBlocks | ( | const dataFile_Type | dataFile, |
const commPtr_Type & | communicator | ||
) |
Definition at line 35 of file NavierStokesSolverBlocks.cpp.
Definition at line 64 of file NavierStokesSolverBlocks.cpp.
void setup | ( | const meshPtr_Type & | mesh, |
const int & | id_domain = 36 |
||
) |
Setup for the solver.
mesh | mesh used |
id_domain | used just in case of multiple fluids |
Definition at line 77 of file NavierStokesSolverBlocks.cpp.
void buildSystem | ( | ) |
Assemble constant terms.
Definition at line 356 of file NavierStokesSolverBlocks.cpp.
void updateSystem | ( | const vectorPtr_Type & | u_star, |
const vectorPtr_Type & | rhs_velocity | ||
) |
Update the convective term and the right hand side.
u_star | extrapolate velocity |
rhs_velocity | right hand side, velocity block |
Definition at line 495 of file NavierStokesSolverBlocks.cpp.
void iterate | ( | bcPtr_Type & | bc, |
const Real & | time | ||
) |
Solve the current timestep, provided the BC.
bc | boundary conditions |
time | current time |
Definition at line 726 of file NavierStokesSolverBlocks.cpp.
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)
bc | boundary conditions |
time | current time |
velocities | vector of velocity (used for imposing velocity on noncircular inflows) |
Definition at line 713 of file NavierStokesSolverBlocks.cpp.
void iterate_steady | ( | ) |
Solve the steady Navier-Stokes equations.
Definition at line 899 of file NavierStokesSolverBlocks.cpp.
void iterate_nonlinear | ( | const Real & | time | ) |
Solve the Navier-Stokes equations at a certain time.
time | current time |
Definition at line 873 of file NavierStokesSolverBlocks.cpp.
void evalResidual | ( | vector_Type & | residual, |
const vector_Type & | solution, | ||
const UInt | iter_newton | ||
) |
Evaluate the residual of the NS problem.
residual | residual vector |
solution | solution vector |
iter_newton | current newton iteration |
Definition at line 1168 of file NavierStokesSolverBlocks.cpp.
void solveJac | ( | vector_Type & | increment, |
const vector_Type & | residual, | ||
const Real | linearRelTol | ||
) |
Evaluate the residual of the NS problem.
increment | increment vector |
residual | residual vector |
linearRelTol | tolerance of the linar solver |
Definition at line 1508 of file NavierStokesSolverBlocks.cpp.
void updateJacobian | ( | const vector_Type & | u_k | ) |
Update the Jacobian matrix, only the term associated with the linearization of the convective term.
u_k | velocity previous newton step |
Definition at line 1396 of file NavierStokesSolverBlocks.cpp.
void applyBoundaryConditions | ( | bcPtr_Type & | bc, |
const Real & | time | ||
) |
Apply the BCs semi-implicit case.
bc | boundary conditions of the problem |
time | current time |
Definition at line 667 of file NavierStokesSolverBlocks.cpp.
void applyBoundaryConditions | ( | bcPtr_Type & | bc, |
const Real & | time, | ||
const vectorPtr_Type & | velocities | ||
) |
Apply the BCs semi-implicit case (example aorta)
bc | boundary conditions of the problem |
time | current time |
velocities | vector of velocities to be imposed |
Definition at line 702 of file NavierStokesSolverBlocks.cpp.
void applyBoundaryConditionsJacobian | ( | bcPtr_Type & | bc | ) |
Apply the BCs on the Jacobian matrix.
bc | boundary conditions of the problem |
Definition at line 1584 of file NavierStokesSolverBlocks.cpp.
void applyBoundaryConditionsSolution | ( | const Real & | time | ) |
Apply the BCs to the solution.
time | current time |
Definition at line 915 of file NavierStokesSolverBlocks.cpp.
void updateConvectiveTerm | ( | const vectorPtr_Type & | velocity | ) |
Update the convective term.
velocity | velocity vector |
Definition at line 1357 of file NavierStokesSolverBlocks.cpp.
VectorSmall< 2 > computeForces | ( | BCHandler & | bcHandlerDrag, |
BCHandler & | bcHandlerLift | ||
) |
Compute Aerodynamic Forces.
bcHandlerDrag | bc to be used for drag computation |
bcHandlerLift | bc to be used for lift computation |
Definition at line 845 of file NavierStokesSolverBlocks.cpp.
void solveTimeStep | ( | ) |
Solve a time step.
Definition at line 740 of file NavierStokesSolverBlocks.cpp.
void computeForcesNonLinear | ( | vectorPtr_Type & | force, |
const vectorPtr_Type & | solution | ||
) |
Compute Aerodynamic Forces - nonlinear case.
force | vector containing the forces |
solution | vector with the solution |
Definition at line 1100 of file NavierStokesSolverBlocks.cpp.
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.
convective_velocity | difference between fluid velocity and mesh velocity at previous Newton iteration |
velocity_km1 | fluid velocity at previous Newton iteration |
pressure_km1 | fluid pressure at previous Newton iteration |
pressure_km1 | terms of bdf associated to the rhs |
residual | residual that will be assembled |
Definition at line 999 of file NavierStokesSolverBlocks.cpp.
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.
convective_velocity | difference between fluid velocity and mesh velocity at previous Newton iteration |
velocity_km1 | fluid velocity at previous Newton iteration |
pressure_km1 | fluid pressure at previous Newton iteration |
pressure_km1 | terms of bdf associated to the rhs |
residualVelocity | residual associated to the fluid momentum equation |
residualPressure | residual associated to the fluid continuity equation |
Definition at line 926 of file NavierStokesSolverBlocks.cpp.
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.
convective_velocity_previous_newton_step | difference between fluid velocity and mesh velocity at previous Newton iteration |
velocity_previous_newton_step | fluid velocity at previous Newton iteration |
pressure_previous_newton_step | fluid pressure at previous Newton iteration |
velocity_rhs | block of the velocity of the rhs |
Definition at line 1428 of file NavierStokesSolverBlocks.cpp.
void integrateForces | ( | const vectorPtr_Type & | velocity, |
const vectorPtr_Type & | pressure | ||
) |
Computation of forces.
velocity | velocity vector |
pressure | pressure vector |
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)
nx | x component normal vector to an outflow face |
ny | y component normal vector to an outflow face |
nz | z component normal vector to an outflow face |
bc | boundary conditions |
Q_hat | reference flowrate to be imposed |
Phi_h | solution laplacian |
flag | flag outflow |
Phi_h_flag | solution laplacian on the outflow flag |
V_hat_x | reference velocity, x component |
V_hat_y | reference velocity, y component |
V_hat_z | reference velocity, z component |
Definition at line 1591 of file NavierStokesSolverBlocks.cpp.
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)
flag | flag of the outflow face |
bc_laplacian | boundary conditions laplacian |
laplacianSolution | solution laplacian |
Definition at line 1640 of file NavierStokesSolverBlocks.cpp.
void setupPostProc | ( | ) |
Additional setup for postprocessing on boundaries.
Definition at line 1712 of file NavierStokesSolverBlocks.cpp.
Real flux | ( | const markerID_Type & | flag, |
const vector_Type & | velocity | ||
) |
Compute flux through a boundary face of the domain.
flag | flag of the face |
velocity | velocity vector |
Definition at line 1724 of file NavierStokesSolverBlocks.cpp.
Real area | ( | const markerID_Type & | flag | ) |
Compute area of a boundary face of the domain.
flag | flag of the outflow face |
Definition at line 1731 of file NavierStokesSolverBlocks.cpp.
Real pres | ( | const markerID_Type & | flag, |
const vector_Type & | pressure | ||
) |
Compute mean pressure at a boundary face of the domain.
flag | flag of the outflow face |
pressure | pressure vector |
Definition at line 1749 of file NavierStokesSolverBlocks.cpp.
Vector geometricCenter | ( | const markerID_Type & | flag | ) |
Compute center of a boundary face of the domain.
flag | flag of the face |
Definition at line 1737 of file NavierStokesSolverBlocks.cpp.
Vector normal | ( | const markerID_Type & | flag | ) |
Compute normal of a boundary face of the domain.
flag | flag of the face |
Definition at line 1743 of file NavierStokesSolverBlocks.cpp.
|
inline |
Set coefficient associated to the time discretization scheme.
alpha | coefficient BDF scheme in front of u^{n+1} |
Definition at line 400 of file NavierStokesSolverBlocks.hpp.
|
inline |
Set the rhs vector, velocity component.
vel_rhs | rhs vector, velocity component |
Definition at line 413 of file NavierStokesSolverBlocks.hpp.
|
inline |
Set the extrapolated pressure vector (used by semi-implicit VMS-LES stabilization)
pressure_extrapolated | pressure extrapolated vector |
Definition at line 422 of file NavierStokesSolverBlocks.hpp.
void setExportFineScaleVelocity | ( | ExporterHDF5< mesh_Type > & | exporter, |
const int & | numElementsTotal | ||
) |
Set if one needs to export the fine scale component (when using LES models)
exporter | exporter |
numElementsTotal | number of total elements (tetrahedral elements) |
Definition at line 206 of file NavierStokesSolverBlocks.cpp.
void setParameters | ( | ) |
Set parameters of the solver.
Definition at line 68 of file NavierStokesSolverBlocks.cpp.
|
inline |
Set time step.
dt | time step size |
Definition at line 438 of file NavierStokesSolverBlocks.hpp.
void setBoundaryConditions | ( | const bcPtr_Type & | bc | ) |
Set time step.
bc | boundary conditions of the problem |
Definition at line 1756 of file NavierStokesSolverBlocks.cpp.
Get the velocity FE space.
Definition at line 455 of file NavierStokesSolverBlocks.hpp.
Get the velocity FE space.
Definition at line 461 of file NavierStokesSolverBlocks.hpp.
Get the velocity FE space.
Definition at line 467 of file NavierStokesSolverBlocks.hpp.
|
inline |
Get the velocity vector.
Definition at line 473 of file NavierStokesSolverBlocks.hpp.
|
inline |
Get the pressure vector.
Definition at line 479 of file NavierStokesSolverBlocks.hpp.
|
inline |
Get the F block.
Definition at line 485 of file NavierStokesSolverBlocks.hpp.
|
inline |
Get the jacobian block.
Definition at line 491 of file NavierStokesSolverBlocks.hpp.
|
inline |
Get the Btranspose block.
Definition at line 497 of file NavierStokesSolverBlocks.hpp.
|
inline |
Get the B block.
Definition at line 503 of file NavierStokesSolverBlocks.hpp.
|
inline |
Get the rhs.
Definition at line 509 of file NavierStokesSolverBlocks.hpp.
|
inline |
Get the rhs vector (pressure part)
Definition at line 515 of file NavierStokesSolverBlocks.hpp.
|
inline |
Definition at line 520 of file NavierStokesSolverBlocks.hpp.
|
inline |
Definition at line 525 of file NavierStokesSolverBlocks.hpp.
|
inline |
Definition at line 530 of file NavierStokesSolverBlocks.hpp.
|
inline |
Get the (0,0) block.
Definition at line 536 of file NavierStokesSolverBlocks.hpp.
|
inline |
Get the (0,1) block.
Definition at line 542 of file NavierStokesSolverBlocks.hpp.
|
inline |
Get the (1,0) block.
Definition at line 548 of file NavierStokesSolverBlocks.hpp.
|
inline |
Get the (1,1)
Definition at line 554 of file NavierStokesSolverBlocks.hpp.
|
inline |
Get if using a stabilization.
Definition at line 560 of file NavierStokesSolverBlocks.hpp.
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.
|
inline |
Get the displayer.
Definition at line 569 of file NavierStokesSolverBlocks.hpp.
|
inline |
Get the (0,0) block without BCs.
Definition at line 572 of file NavierStokesSolverBlocks.hpp.
|
inline |
Get the (0,1) block without BCs.
Definition at line 578 of file NavierStokesSolverBlocks.hpp.
|
inline |
Get the rhs without bcs applied.
Definition at line 584 of file NavierStokesSolverBlocks.hpp.
|
inline |
Get the forces.
Definition at line 590 of file NavierStokesSolverBlocks.hpp.
|
private |
Build the graphs.
Definition at line 218 of file NavierStokesSolverBlocks.cpp.
|
private |
Update the bc handler.
Definition at line 921 of file NavierStokesSolverBlocks.cpp.
|
private |
Set options preconditioner.
Definition at line 211 of file NavierStokesSolverBlocks.cpp.
|
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.
|
private |
Definition at line 612 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 615 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 618 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 619 of file NavierStokesSolverBlocks.hpp.
Definition at line 622 of file NavierStokesSolverBlocks.hpp.
Definition at line 623 of file NavierStokesSolverBlocks.hpp.
Definition at line 624 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 627 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 628 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 629 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 632 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 635 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 636 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 637 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 638 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 639 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 640 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 641 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 643 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 644 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 647 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 648 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 649 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 650 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 651 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 652 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 653 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 655 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 656 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 659 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 660 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 661 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 662 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 666 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 667 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 668 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 669 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 670 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 671 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 672 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 675 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 676 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 677 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 678 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 679 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 680 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 681 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 683 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 684 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 686 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 687 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 689 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 690 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 692 of file NavierStokesSolverBlocks.hpp.
|
private |
Displayer to print in parallel (only PID 0 will print)
Definition at line 695 of file NavierStokesSolverBlocks.hpp.
|
private |
Reals.
Definition at line 698 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 699 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 700 of file NavierStokesSolverBlocks.hpp.
|
private |
Booleans.
Definition at line 703 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 704 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 705 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 708 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 711 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 714 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 717 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 720 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 723 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 726 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 728 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 728 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 728 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 729 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 730 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 731 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 734 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 735 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 736 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 737 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 739 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 740 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 742 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 744 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 746 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 748 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 751 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 752 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 753 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 756 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 757 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 758 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 760 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 761 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 763 of file NavierStokesSolverBlocks.hpp.
|
private |
Postprocessing class.
Definition at line 766 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 768 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 769 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 770 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 771 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 773 of file NavierStokesSolverBlocks.hpp.
|
private |
Definition at line 774 of file NavierStokesSolverBlocks.hpp.