https://mooseframework.inl.gov
Public Types | Public Member Functions | Static Public Member Functions | Public Attributes | Static Public Attributes | Protected Member Functions | Protected Attributes | List of all members
SIMPLESolve Class Reference

Implementation of Semi-Implicit Method for Pressure-Linked Equations (SIMPLE) with MOOSE-based applications. More...

#include <SIMPLESolve.h>

Inheritance diagram for SIMPLESolve:
[legend]

Public Types

typedef DataFileName DataFileParameterType
 

Public Member Functions

 SIMPLESolve (Executioner &ex)
 
virtual void checkIntegrity () override
 Check if the user defined time kernels, if yes error out. More...
 
virtual void linkRhieChowUserObject () override
 Fetch the Rhie Chow user object that is reponsible for determining face velocities and mass flux. More...
 
virtual void initialSetup () override
 
virtual bool solve () override
 Performs the momentum pressure coupling. More...
 
const std::vector< LinearSystem * > systemsToSolve () const
 Return pointers to the systems which are solved for within this object. More...
 
virtual void setInnerSolve (SolveObject &) override
 
void setupPressurePin ()
 Setup pressure pin if there is need for one. More...
 
virtual bool enabled () const
 
std::shared_ptr< MooseObjectgetSharedPtr ()
 
std::shared_ptr< const MooseObjectgetSharedPtr () const
 
bool isKokkosObject (IsKokkosObjectKey &&) const
 
MooseAppgetMooseApp () const
 
const std::string & type () const
 
const std::string & name () const
 
std::string typeAndName () const
 
MooseObjectParameterName uniqueParameterName (const std::string &parameter_name) const
 
MooseObjectName uniqueName () const
 
const InputParametersparameters () const
 
const hit::Node * getHitNode () const
 
bool hasBase () const
 
const std::string & getBase () const
 
const T & getParam (const std::string &name) const
 
std::vector< std::pair< T1, T2 > > getParam (const std::string &param1, const std::string &param2) const
 
const T * queryParam (const std::string &name) const
 
const T & getRenamedParam (const std::string &old_name, const std::string &new_name) const
 
getCheckedPointerParam (const std::string &name, const std::string &error_string="") const
 
bool isParamValid (const std::string &name) const
 
bool isParamSetByUser (const std::string &name) const
 
void connectControllableParams (const std::string &parameter, const std::string &object_type, const std::string &object_name, const std::string &object_parameter) const
 
void paramError (const std::string &param, Args... args) const
 
void paramWarning (const std::string &param, Args... args) const
 
void paramWarning (const std::string &param, Args... args) const
 
void paramInfo (const std::string &param, Args... args) const
 
std::string messagePrefix (const bool hit_prefix=true) const
 
std::string errorPrefix (const std::string &) const
 
void mooseError (Args &&... args) const
 
void mooseDocumentedError (const std::string &repo_name, const unsigned int issue_num, Args &&... args) const
 
void mooseErrorNonPrefixed (Args &&... args) const
 
void mooseWarning (Args &&... args) const
 
void mooseWarning (Args &&... args) const
 
void mooseWarningNonPrefixed (Args &&... args) const
 
void mooseWarningNonPrefixed (Args &&... args) const
 
void mooseDeprecated (Args &&... args) const
 
void mooseDeprecated (Args &&... args) const
 
void mooseInfo (Args &&... args) const
 
void callMooseError (std::string msg, const bool with_prefix, const hit::Node *node=nullptr) const
 
std::string getDataFileName (const std::string &param) const
 
std::string getDataFileNameByName (const std::string &relative_path) const
 
std::string getDataFilePath (const std::string &relative_path) const
 
PerfGraphperfGraph ()
 
bool isDefaultPostprocessorValue (const std::string &param_name, const unsigned int index=0) const
 
bool hasPostprocessor (const std::string &param_name, const unsigned int index=0) const
 
bool hasPostprocessorByName (const PostprocessorName &name) const
 
std::size_t coupledPostprocessors (const std::string &param_name) const
 
const PostprocessorName & getPostprocessorName (const std::string &param_name, const unsigned int index=0) const
 
const PostprocessorValuegetPostprocessorValue (const std::string &param_name, const unsigned int index=0) const
 
const PostprocessorValuegetPostprocessorValue (const std::string &param_name, const unsigned int index=0) const
 
const PostprocessorValuegetPostprocessorValueOld (const std::string &param_name, const unsigned int index=0) const
 
const PostprocessorValuegetPostprocessorValueOld (const std::string &param_name, const unsigned int index=0) const
 
const PostprocessorValuegetPostprocessorValueOlder (const std::string &param_name, const unsigned int index=0) const
 
const PostprocessorValuegetPostprocessorValueOlder (const std::string &param_name, const unsigned int index=0) const
 
virtual const PostprocessorValuegetPostprocessorValueByName (const PostprocessorName &name) const
 
virtual const PostprocessorValuegetPostprocessorValueByName (const PostprocessorName &name) const
 
const PostprocessorValuegetPostprocessorValueOldByName (const PostprocessorName &name) const
 
const PostprocessorValuegetPostprocessorValueOldByName (const PostprocessorName &name) const
 
const PostprocessorValuegetPostprocessorValueOlderByName (const PostprocessorName &name) const
 
const PostprocessorValuegetPostprocessorValueOlderByName (const PostprocessorName &name) const
 
const Parallel::Communicator & comm () const
 
processor_id_type n_processors () const
 
processor_id_type processor_id () const
 
UserObjectName getUserObjectName (const std::string &param_name) const
 
const T & getUserObject (const std::string &param_name, bool is_dependency=true) const
 
const T & getUserObjectByName (const UserObjectName &object_name, bool is_dependency=true) const
 
const UserObjectgetUserObjectBase (const std::string &param_name, bool is_dependency=true) const
 
const UserObjectgetUserObjectBaseByName (const UserObjectName &object_name, bool is_dependency=true) const
 
bool hasUserObject (const std::string &param_name) const
 
bool hasUserObject (const std::string &param_name) const
 
bool hasUserObject (const std::string &param_name) const
 
bool hasUserObject (const std::string &param_name) const
 
bool hasUserObjectByName (const UserObjectName &object_name) const
 
bool hasUserObjectByName (const UserObjectName &object_name) const
 
bool hasUserObjectByName (const UserObjectName &object_name) const
 
bool hasUserObjectByName (const UserObjectName &object_name) const
 

Static Public Member Functions

static InputParameters validParams ()
 
static void callMooseError (MooseApp *const app, const InputParameters &params, std::string msg, const bool with_prefix, const hit::Node *node)
 

Public Attributes

 usingCombinedWarningSolutionWarnings
 
const ConsoleStream _console
 

Static Public Attributes

static const std::string type_param
 
static const std::string name_param
 
static const std::string unique_name_param
 
static const std::string app_param
 
static const std::string moose_base_param
 
static const std::string kokkos_object_param
 

Protected Member Functions

virtual void checkTimeKernels (LinearSystem &system)
 Check if the system contains time kernels. More...
 
virtual std::vector< std::pair< unsigned int, Real > > solveMomentumPredictor () override
 Solve a momentum predictor step with a fixed pressure field. More...
 
virtual std::pair< unsigned int, RealsolvePressureCorrector () override
 Solve a pressure corrector step. More...
 
virtual std::pair< unsigned int, RealcorrectVelocity (const bool subtract_updated_pressure, const bool recompute_face_mass_flux, const SolverParams &solver_params)
 Computes new velocity field based on computed pressure gradients. More...
 
std::pair< unsigned int, RealsolveAdvectedSystem (const unsigned int system_num, LinearSystem &system, const Real relaxation_factor, libMesh::SolverConfiguration &solver_config, const Real abs_tol, const Real field_relaxation=1.0, const Real min_value_limiter=std::numeric_limits< Real >::min())
 Solve an equation which contains an advection term that depends on the solution of the segregated Navier-Stokes equations. More...
 
std::pair< unsigned int, RealsolveSolidEnergy ()
 Solve an equation which contains the solid energy conservation. More...
 
void checkDependentParameterError (const std::string &main_parameter, const std::vector< std::string > &dependent_parameters, const bool should_be_defined)
 
void flagInvalidSolutionInternal (const InvalidSolutionID invalid_solution_id) const
 
InvalidSolutionID registerInvalidSolutionInternal (const std::string &message, const bool warning) const
 
PerfID registerTimedSection (const std::string &section_name, const unsigned int level) const
 
PerfID registerTimedSection (const std::string &section_name, const unsigned int level, const std::string &live_message, const bool print_dots=true) const
 
std::string timedSectionName (const std::string &section_name) const
 
virtual void addPostprocessorDependencyHelper (const PostprocessorName &) const
 
virtual void addUserObjectDependencyHelper (const UserObject &) const
 

Protected Attributes

std::vector< unsigned int_momentum_system_numbers
 The number(s) of the system(s) corresponding to the momentum equation(s) More...
 
std::vector< LinearSystem * > _momentum_systems
 Pointer(s) to the system(s) corresponding to the momentum equation(s) More...
 
const unsigned int _pressure_sys_number
 The number of the system corresponding to the pressure equation. More...
 
LinearSystem_pressure_system
 Reference to the linear system corresponding to the pressure equation. More...
 
const unsigned int _energy_sys_number
 The number of the system corresponding to the energy equation. More...
 
LinearSystem_energy_system
 Pointer to the linear system corresponding to the fluid energy equation. More...
 
const unsigned int _solid_energy_sys_number
 The number of the system corresponding to the solid energy equation. More...
 
LinearSystem_solid_energy_system
 Pointer to the linear system corresponding to the solid energy equation. More...
 
std::vector< LinearSystem * > _passive_scalar_systems
 Pointer(s) to the system(s) corresponding to the passive scalar equation(s) More...
 
std::vector< LinearSystem * > _active_scalar_systems
 Pointer(s) to the system(s) corresponding to the active scalar equation(s) More...
 
std::vector< LinearSystem * > _turbulence_systems
 Pointer(s) to the system(s) corresponding to the turbulence equation(s) More...
 
RhieChowMassFlux_rc_uo
 Pointer to the segregated RhieChow interpolation object. More...
 
std::vector< LinearSystem * > _systems_to_solve
 Shortcut to every linear system that we solve for here. More...
 
const std::vector< SolverSystemName > & _active_scalar_system_names
 The names of the active scalar systems. More...
 
const bool _has_active_scalar_systems
 Boolean for easy check if a active scalar systems shall be solved or not. More...
 
std::vector< unsigned int_active_scalar_system_numbers
 
const std::vector< Real_active_scalar_equation_relaxation
 The user-defined relaxation parameter(s) for the active scalar equation(s) More...
 
Moose::PetscSupport::PetscOptions _active_scalar_petsc_options
 Options which hold the petsc settings for the active scalar equation(s) More...
 
SIMPLESolverConfiguration _active_scalar_linear_control
 Options for the linear solver of the active scalar equation(s) More...
 
const Real _active_scalar_l_abs_tol
 Absolute linear tolerance for the active scalar equation(s). More...
 
const std::vector< Real_active_scalar_absolute_tolerance
 The user-defined absolute tolerance for determining the convergence in active scalars. More...
 
NS::FV::CHTHandler _cht
 ********************** Conjugate heat transfer variables ************** // More...
 
const std::vector< SolverSystemName > & _momentum_system_names
 The names of the momentum systems. More...
 
SIMPLESolverConfiguration _momentum_linear_control
 Options for the linear solver of the momentum equation. More...
 
const Real _momentum_l_abs_tol
 Absolute linear tolerance for the momentum equation(s). More...
 
Moose::PetscSupport::PetscOptions _momentum_petsc_options
 Options which hold the petsc settings for the momentum equation. More...
 
const Real _momentum_equation_relaxation
 The user-defined relaxation parameter for the momentum equation. More...
 
const SolverSystemName & _pressure_system_name
 The name of the pressure system. More...
 
SIMPLESolverConfiguration _pressure_linear_control
 Options for the linear solver of the pressure equation. More...
 
const Real _pressure_l_abs_tol
 Absolute linear tolerance for the pressure equation. More...
 
Moose::PetscSupport::PetscOptions _pressure_petsc_options
 Options which hold the petsc settings for the pressure equation. More...
 
const Real _pressure_variable_relaxation
 The user-defined relaxation parameter for the pressure variable. More...
 
const bool _pin_pressure
 If the pressure needs to be pinned. More...
 
const Real _pressure_pin_value
 The value we want to enforce for pressure. More...
 
dof_id_type _pressure_pin_dof
 The dof ID where the pressure needs to be pinned. More...
 
const bool _has_energy_system
 Boolean for easy check if a fluid energy system shall be solved or not. More...
 
const Real _energy_equation_relaxation
 The user-defined relaxation parameter for the energy equation. More...
 
Moose::PetscSupport::PetscOptions _energy_petsc_options
 Options which hold the petsc settings for the fluid energy equation. More...
 
SIMPLESolverConfiguration _energy_linear_control
 Options for the linear solver of the energy equation. More...
 
const Real _energy_l_abs_tol
 Absolute linear tolerance for the energy equations. More...
 
const bool _has_solid_energy_system
 Boolean for easy check if a solid energy system shall be solved or not. More...
 
Moose::PetscSupport::PetscOptions _solid_energy_petsc_options
 Options which hold the petsc settings for the fluid energy equation. More...
 
SIMPLESolverConfiguration _solid_energy_linear_control
 Options for the linear solver of the energy equation. More...
 
const Real _solid_energy_l_abs_tol
 Absolute linear tolerance for the energy equations. More...
 
const std::vector< SolverSystemName > & _passive_scalar_system_names
 The names of the passive scalar systems. More...
 
const bool _has_passive_scalar_systems
 Boolean for easy check if a passive scalar systems shall be solved or not. More...
 
std::vector< unsigned int_passive_scalar_system_numbers
 
const std::vector< Real_passive_scalar_equation_relaxation
 The user-defined relaxation parameter(s) for the passive scalar equation(s) More...
 
Moose::PetscSupport::PetscOptions _passive_scalar_petsc_options
 Options which hold the petsc settings for the passive scalar equation(s) More...
 
SIMPLESolverConfiguration _passive_scalar_linear_control
 Options for the linear solver of the passive scalar equation(s) More...
 
const Real _passive_scalar_l_abs_tol
 Absolute linear tolerance for the passive scalar equation(s). More...
 
const std::vector< SolverSystemName > & _turbulence_system_names
 The names of the turbulence systems. More...
 
const bool _has_turbulence_systems
 Boolean for easy check if a turbulence scalar systems shall be solved or not. More...
 
std::vector< unsigned int_turbulence_system_numbers
 
const std::vector< Real_turbulence_equation_relaxation
 The user-defined relaxation parameter(s) for the turbulence equation(s) More...
 
std::vector< Real_turbulence_field_relaxation
 The user-defined relaxation parameter(s) for the turbulence field(s) More...
 
std::vector< Real_turbulence_field_min_limit
 The user-defined lower limit for turbulent quantities e.g. k, eps/omega, etc.. More...
 
Moose::PetscSupport::PetscOptions _turbulence_petsc_options
 Options which hold the petsc settings for the turbulence equation(s) More...
 
SIMPLESolverConfiguration _turbulence_linear_control
 Options for the linear solver of the turbulence equation(s) More...
 
const Real _turbulence_l_abs_tol
 Absolute linear tolerance for the turbulence equation(s). More...
 
const Real _momentum_absolute_tolerance
 The user-defined absolute tolerance for determining the convergence in momentum. More...
 
const Real _pressure_absolute_tolerance
 The user-defined absolute tolerance for determining the convergence in pressure. More...
 
const Real _energy_absolute_tolerance
 The user-defined absolute tolerance for determining the convergence in energy. More...
 
const Real _solid_energy_absolute_tolerance
 The user-defined absolute tolerance for determining the convergence in solid energy. More...
 
const std::vector< Real_passive_scalar_absolute_tolerance
 The user-defined absolute tolerance for determining the convergence in passive scalars. More...
 
const std::vector< Real_turbulence_absolute_tolerance
 The user-defined absolute tolerance for determining the convergence turbulence variables. More...
 
const unsigned int _num_iterations
 The maximum number of momentum-pressure iterations. More...
 
const bool _continue_on_max_its
 If solve should continue if maximum number of iterations is hit. More...
 
const bool _print_fields
 Debug parameter which allows printing the coupling and solution vectors/matrices. More...
 
Executioner_executioner
 
FEProblemBase_problem
 
DisplacedProblem_displaced_problem
 
MooseMesh_mesh
 
MooseMesh_displaced_mesh
 
SystemBase_solver_sys
 
AuxiliarySystem_aux
 
SolveObject_inner_solve
 
const bool & _enabled
 
MooseApp_app
 
Factory_factory
 
ActionFactory_action_factory
 
const std::string & _type
 
const std::string & _name
 
const InputParameters_pars
 
MooseApp_pg_moose_app
 
const std::string _prefix
 
const Parallel::Communicator & _communicator
 

Detailed Description

Implementation of Semi-Implicit Method for Pressure-Linked Equations (SIMPLE) with MOOSE-based applications.

It is a slightly restricted version of the PIMPLE algorithm: (i) no PISO iterations are allowed, (ii) no time kernels are allowed.

Definition at line 21 of file SIMPLESolve.h.

Constructor & Destructor Documentation

◆ SIMPLESolve()

SIMPLESolve::SIMPLESolve ( Executioner ex)

Definition at line 24 of file SIMPLESolve.C.

Member Function Documentation

◆ checkDependentParameterError()

void SIMPLESolveBase::checkDependentParameterError ( const std::string &  main_parameter,
const std::vector< std::string > &  dependent_parameters,
const bool  should_be_defined 
)
protectedinherited

Definition at line 600 of file SIMPLESolveBase.C.

Referenced by SIMPLESolveBase::SIMPLESolveBase(), and SIMPLESolveNonlinearAssembly::SIMPLESolveNonlinearAssembly().

603 {
604  for (const auto & param : dependent_parameters)
605  if (parameters().isParamSetByUser(param) == !should_be_defined)
606  paramError(param,
607  "This parameter should " + std::string(should_be_defined ? "" : "not") +
608  " be given by the user with the corresponding " + main_parameter +
609  " setting!");
610 }
void paramError(const std::string &param, Args... args) const
const InputParameters & parameters() const
bool isParamSetByUser(const std::string &name) const

◆ checkIntegrity()

void SIMPLESolve::checkIntegrity ( )
overridevirtual

Check if the user defined time kernels, if yes error out.

Reimplemented from SIMPLESolveBase.

Definition at line 37 of file SIMPLESolve.C.

Referenced by SIMPLE::init().

38 {
39  // check to make sure that we don't have any time kernels in this simulation (Steady State)
40  for (const auto system : _momentum_systems)
41  checkTimeKernels(*system);
42 
44 
47 
49  for (const auto system : _turbulence_systems)
50  checkTimeKernels(*system);
51 
53  for (const auto system : _passive_scalar_systems)
54  checkTimeKernels(*system);
55 
57  for (const auto system : _active_scalar_systems)
58  checkTimeKernels(*system);
59 }
const bool _has_energy_system
Boolean for easy check if a fluid energy system shall be solved or not.
std::vector< LinearSystem * > _passive_scalar_systems
Pointer(s) to the system(s) corresponding to the passive scalar equation(s)
const bool _has_turbulence_systems
Boolean for easy check if a turbulence scalar systems shall be solved or not.
const bool _has_active_scalar_systems
Boolean for easy check if a active scalar systems shall be solved or not.
std::vector< LinearSystem * > _active_scalar_systems
Pointer(s) to the system(s) corresponding to the active scalar equation(s)
LinearSystem & _pressure_system
Reference to the linear system corresponding to the pressure equation.
LinearSystem * _energy_system
Pointer to the linear system corresponding to the fluid energy equation.
virtual void checkTimeKernels(LinearSystem &system)
Check if the system contains time kernels.
Definition: SIMPLESolve.C:27
std::vector< LinearSystem * > _turbulence_systems
Pointer(s) to the system(s) corresponding to the turbulence equation(s)
const bool _has_passive_scalar_systems
Boolean for easy check if a passive scalar systems shall be solved or not.
std::vector< LinearSystem * > _momentum_systems
Pointer(s) to the system(s) corresponding to the momentum equation(s)

◆ checkTimeKernels()

void SIMPLESolve::checkTimeKernels ( LinearSystem system)
protectedvirtual

Check if the system contains time kernels.

Definition at line 27 of file SIMPLESolve.C.

Referenced by checkIntegrity().

28 {
29  // check to make sure that we don't have any time kernels in this simulation (Steady State)
30  if (system.containsTimeKernel())
31  mooseError("You have specified time kernels in your steady state simulation in system",
32  system.name(),
33  ", SIMPLE is a steady-state solver! Use the PIMPLE executioner instead.");
34 }
virtual bool containsTimeKernel() override
virtual const std::string & name() const
void mooseError(Args &&... args) const

◆ correctVelocity()

std::pair< unsigned int, Real > LinearAssemblySegregatedSolve::correctVelocity ( const bool  subtract_updated_pressure,
const bool  recompute_face_mass_flux,
const SolverParams solver_params 
)
protectedvirtualinherited

Computes new velocity field based on computed pressure gradients.

Parameters
subtract_updated_pressureIf we need to subtract the updated pressure gradient from the right hand side of the system
recompute_face_mass_fluxIf we want to recompute the face flux too
solver_paramsDummy solver parameter object for the linear solve

Reimplemented in PIMPLESolve.

Definition at line 432 of file LinearAssemblySegregatedSolve.C.

Referenced by PIMPLESolve::correctVelocity(), and LinearAssemblySegregatedSolve::solve().

435 {
436  // Compute the coupling fields between the momentum and pressure equations.
437  // The first argument makes sure the pressure gradient is staged at the first
438  // iteration
439  _rc_uo->computeHbyA(subtract_updated_pressure, _print_fields);
440 
441  // We set the preconditioner/controllable parameters for the pressure equations through
442  // petsc options. Linear tolerances will be overridden within the solver.
444 
445  // Solve the pressure corrector
446  const auto residuals = solvePressureCorrector();
447 
448  // Compute the face velocity which is used in the advection terms. In certain
449  // segregated solver algorithms (like PISO) this is only done on the last iteration.
450  if (recompute_face_mass_flux)
452 
453  auto & pressure_current_solution = *(_pressure_system.system().current_local_solution.get());
454  auto & pressure_old_solution = *(_pressure_system.solutionPreviousNewton());
455 
456  // Relax the pressure update for the next momentum predictor
458  pressure_current_solution, pressure_old_solution, _pressure_variable_relaxation);
459 
460  // Overwrite old solution
461  pressure_old_solution = pressure_current_solution;
462  _pressure_system.setSolution(pressure_current_solution);
463 
464  // We recompute the updated pressure gradient
466 
467  // Reconstruct the cell velocity as well to accelerate convergence
469 
470  return residuals;
471 }
void computeGradients()
const bool _print_fields
Debug parameter which allows printing the coupling and solution vectors/matrices. ...
void computeFaceMassFlux()
Update the values of the face velocities in the containers.
void setSolution(const NumericVector< Number > &soln)
RhieChowMassFlux * _rc_uo
Pointer to the segregated RhieChow interpolation object.
const Real _pressure_variable_relaxation
The user-defined relaxation parameter for the pressure variable.
void computeHbyA(const bool with_updated_pressure, const bool verbose)
Computes the inverse of the diagonal (1/A) of the system matrix plus the H/A components for the press...
LinearSystem & _pressure_system
Reference to the linear system corresponding to the pressure equation.
void computeCellVelocity()
Update the cell values of the velocity variables.
void petscSetOptions(const PetscOptions &po, const SolverParams &solver_params, FEProblemBase *const problem=nullptr)
virtual std::pair< unsigned int, Real > solvePressureCorrector() override
Solve a pressure corrector step.
std::unique_ptr< NumericVector< Number > > current_local_solution
virtual const NumericVector< Number > * solutionPreviousNewton() const
void relaxSolutionUpdate(NumericVector< Number > &vec_new, const NumericVector< Number > &vec_old, const Real relaxation_factor)
Relax the update on a solution field using the following approach: $u = u_{old}+ (u - u_{old})$...
Moose::PetscSupport::PetscOptions _pressure_petsc_options
Options which hold the petsc settings for the pressure equation.
virtual System & system() override

◆ initialSetup()

void LinearAssemblySegregatedSolve::initialSetup ( )
overridevirtualinherited

Reimplemented from SolveObject.

Definition at line 298 of file LinearAssemblySegregatedSolve.C.

Referenced by SIMPLE::init().

299 {
300  if (_cht.enabled())
301  {
304  }
305 }
void setupConjugateHeatTransferContainers()
Set up the boundary condition pairs, functor maps, and every other necessary structure for the conjug...
Definition: CHTHandler.C:226
void deduceCHTBoundaryCoupling()
Run error checks and make sure everything works.
Definition: CHTHandler.C:103
virtual bool enabled() const override final
Check if CHT treatment is needed.
Definition: CHTHandler.h:138
NS::FV::CHTHandler _cht
********************** Conjugate heat transfer variables ************** //

◆ linkRhieChowUserObject()

void LinearAssemblySegregatedSolve::linkRhieChowUserObject ( )
overridevirtualinherited

Fetch the Rhie Chow user object that is reponsible for determining face velocities and mass flux.

Implements SIMPLESolveBase.

Definition at line 185 of file LinearAssemblySegregatedSolve.C.

Referenced by SIMPLE::init(), and PIMPLE::init().

186 {
187  _rc_uo =
188  const_cast<RhieChowMassFlux *>(&getUserObject<RhieChowMassFlux>("rhie_chow_user_object"));
191 
192  // Initialize the face velocities in the RC object
193  if (!_app.isRecovering())
196 }
User object responsible for determining the face fluxes using the Rhie-Chow interpolation in a segreg...
RhieChowMassFlux * _rc_uo
Pointer to the segregated RhieChow interpolation object.
LinearSystem & _pressure_system
Reference to the linear system corresponding to the pressure equation.
std::vector< unsigned int > _momentum_system_numbers
The number(s) of the system(s) corresponding to the momentum equation(s)
void linkMomentumPressureSystems(const std::vector< LinearSystem *> &momentum_systems, const LinearSystem &pressure_system, const std::vector< unsigned int > &momentum_system_numbers)
Update the momentum system-related information.
MooseApp & _app
std::vector< LinearSystem * > _momentum_systems
Pointer(s) to the system(s) corresponding to the momentum equation(s)
bool isRecovering() const
void initCouplingField()
Initialize the coupling fields (HbyA and Ainv)
void initFaceMassFlux()
Initialize the container for face velocities.

◆ setInnerSolve()

virtual void SIMPLESolveBase::setInnerSolve ( SolveObject )
inlineoverridevirtualinherited

Reimplemented from SolveObject.

Definition at line 48 of file SIMPLESolveBase.h.

49  {
50  mooseError("Cannot set inner solve object for solves that inherit from SIMPLESolveBase");
51  }
void mooseError(Args &&... args) const

◆ setupPressurePin()

void SIMPLESolveBase::setupPressurePin ( )
inherited

Setup pressure pin if there is need for one.

Definition at line 591 of file SIMPLESolveBase.C.

Referenced by SIMPLE::init(), SIMPLENonlinearAssembly::init(), and PIMPLE::init().

592 {
593  if (_pin_pressure)
595  _problem.mesh(),
596  getParam<Point>("pressure_pin_point"));
597 }
FEProblemBase & _problem
virtual const MooseVariableFieldBase & getVariable(const THREAD_ID tid, const std::string &var_name, Moose::VarKindType expected_var_type=Moose::VarKindType::VAR_ANY, Moose::VarFieldType expected_var_field_type=Moose::VarFieldType::VAR_FIELD_ANY) const override
dof_id_type _pressure_pin_dof
The dof ID where the pressure needs to be pinned.
const bool _pin_pressure
If the pressure needs to be pinned.
dof_id_type findPointDoFID(const MooseVariableFieldBase &variable, const MooseMesh &mesh, const Point &point)
Find the ID of the degree of freedom which corresponds to the variable and a given point on the mesh...
virtual MooseMesh & mesh() override

◆ solve()

bool LinearAssemblySegregatedSolve::solve ( )
overridevirtualinherited

Performs the momentum pressure coupling.

Returns
True if solver is converged.

Implements SolveObject.

Definition at line 561 of file LinearAssemblySegregatedSolve.C.

562 {
563  // Do not solve if problem is set not to
564  if (!_problem.shouldSolve())
565  return true;
566 
567  // Dummy solver parameter file which is needed for switching petsc options
568  SolverParams solver_params;
569  solver_params._type = Moose::SolveType::ST_LINEAR;
570  solver_params._line_search = Moose::LineSearchType::LS_NONE;
571 
572  // Initialize the SIMPLE iteration counter
573  unsigned int simple_iteration_counter = 0;
574 
575  // Assign residuals to general residual vector
576  const unsigned int no_systems = _momentum_systems.size() + 1 + _has_energy_system +
578  _turbulence_systems.size();
579 
580  std::vector<std::pair<unsigned int, Real>> ns_residuals(no_systems, std::make_pair(0, 1.0));
581  std::vector<Real> ns_abs_tols(_momentum_systems.size(), _momentum_absolute_tolerance);
582  ns_abs_tols.push_back(_pressure_absolute_tolerance);
583 
584  // Push back energy tolerances
585  if (_has_energy_system)
586  ns_abs_tols.push_back(_energy_absolute_tolerance);
588  ns_abs_tols.push_back(_solid_energy_absolute_tolerance);
590  for (const auto scalar_tol : _active_scalar_absolute_tolerance)
591  ns_abs_tols.push_back(scalar_tol);
592 
593  // Push back turbulence tolerances
595  for (const auto turbulence_tol : _turbulence_absolute_tolerance)
596  ns_abs_tols.push_back(turbulence_tol);
597 
598  bool converged = false;
599  // Loop until converged or hit the maximum allowed iteration number
600  if (_cht.enabled())
602 
603  while (simple_iteration_counter < _num_iterations && !converged)
604  {
605  simple_iteration_counter++;
606 
607  // We set the preconditioner/controllable parameters through petsc options. Linear
608  // tolerances will be overridden within the solver. In case of a segregated momentum
609  // solver, we assume that every velocity component uses the same preconditioner
611 
612  // Initialize pressure gradients, after this we just reuse the last ones from each
613  // iteration
614  if (simple_iteration_counter == 1)
616 
617  _console << "Iteration " << simple_iteration_counter << " Initial residual norms:" << std::endl;
618 
619  // Solve the momentum predictor step
620  auto momentum_residual = solveMomentumPredictor();
621  for (const auto system_i : index_range(momentum_residual))
622  ns_residuals[system_i] = momentum_residual[system_i];
623 
624  // Now we correct the velocity, this function depends on the method, it differs for
625  // SIMPLE/PIMPLE, this returns the pressure errors
626  ns_residuals[momentum_residual.size()] = correctVelocity(true, true, solver_params);
627 
628  // If we have an energy equation, solve it here.We assume the material properties in the
629  // Navier-Stokes equations depend on temperature, therefore we can not solve for temperature
630  // outside of the velocity-pressure loop
631  if (_has_energy_system)
632  {
633  // If there is no CHT specified this will just do go once through this block
635  while (!_cht.converged())
636  {
637  if (_cht.enabled())
639 
640  // We set the preconditioner/controllable parameters through petsc options. Linear
641  // tolerances will be overridden within the solver.
643  ns_residuals[momentum_residual.size() + _has_energy_system] =
649 
651  {
652  // For now we only update gradients if cht is needed, might change in the future
653  if (_cht.enabled())
654  {
657  }
658 
659  // We set the preconditioner/controllable parameters through petsc options. Linear
660  // tolerances will be overridden within the solver.
662  ns_residuals[momentum_residual.size() + _has_solid_energy_system + _has_energy_system] =
664 
665  // For now we only update gradients if cht is needed, might change in the future
666  if (_cht.enabled())
668  }
669 
670  if (_cht.enabled())
671  {
674  }
675 
677  }
678  if (_cht.enabled())
680  }
681 
682  // If we have active scalar equations, solve them here in case they depend on temperature
683  // or they affect the fluid properties such that they must be solved concurrently with
684  // pressure and velocity
686  {
687  _problem.execute(EXEC_NONLINEAR);
688 
689  // We set the preconditioner/controllable parameters through petsc options. Linear
690  // tolerances will be overridden within the solver.
692  for (const auto i : index_range(_active_scalar_system_names))
693  ns_residuals[momentum_residual.size() + 1 + _has_energy_system + _has_solid_energy_system +
699  }
700 
701  // If we have turbulence equations, solve them here.
702  // The turbulent viscosity depends on the value of the turbulence surrogate variables
704  {
705  // We set the preconditioner/controllable parameters through petsc options. Linear
706  // tolerances will be overridden within the solver.
708  for (const auto i : index_range(_turbulence_system_names))
709  {
710  ns_residuals[momentum_residual.size() + 1 + _has_energy_system + _has_solid_energy_system +
711  _active_scalar_system_names.size() + i] =
719  }
720  }
721 
722  _problem.execute(EXEC_NONLINEAR);
723 
724  converged = NS::FV::converged(ns_residuals, ns_abs_tols);
725  }
726 
727  // If we have passive scalar equations, solve them here. We assume the material properties in
728  // the Navier-Stokes equations do not depend on passive scalars, as they are passive, therefore
729  // we solve outside of the velocity-pressure loop
731  {
732  // The reason why we need more than one iteration is due to the matrix relaxation
733  // which can be used to stabilize the equations
734  bool passive_scalar_converged = false;
735  unsigned int ps_iteration_counter = 0;
736 
737  _console << "Passive scalar iteration " << ps_iteration_counter
738  << " Initial residual norms:" << std::endl;
739 
740  while (ps_iteration_counter < _num_iterations && !passive_scalar_converged)
741  {
742  ps_iteration_counter++;
743  std::vector<std::pair<unsigned int, Real>> scalar_residuals(
744  _passive_scalar_system_names.size(), std::make_pair(0, 1.0));
745  std::vector<Real> scalar_abs_tols;
746  for (const auto scalar_tol : _passive_scalar_absolute_tolerance)
747  scalar_abs_tols.push_back(scalar_tol);
748 
749  // We set the preconditioner/controllable parameters through petsc options. Linear
750  // tolerances will be overridden within the solver.
752  for (const auto i : index_range(_passive_scalar_system_names))
753  scalar_residuals[i] = solveAdvectedSystem(_passive_scalar_system_numbers[i],
758 
759  passive_scalar_converged = NS::FV::converged(scalar_residuals, scalar_abs_tols);
760  }
761 
762  // Both flow and scalars must converge
763  converged = passive_scalar_converged && converged;
764  }
765 
767 
768  return converged;
769 }
bool shouldSolve() const
const std::vector< Real > _active_scalar_equation_relaxation
The user-defined relaxation parameter(s) for the active scalar equation(s)
FEProblemBase & _problem
SIMPLESolverConfiguration _turbulence_linear_control
Options for the linear solver of the turbulence equation(s)
const Real _energy_absolute_tolerance
The user-defined absolute tolerance for determining the convergence in energy.
void updateCHTBoundaryCouplingFields(const NS::CHTSide side)
Update the coupling fields for.
Definition: CHTHandler.C:327
const unsigned int _num_iterations
The maximum number of momentum-pressure iterations.
SIMPLESolverConfiguration _energy_linear_control
Options for the linear solver of the energy equation.
void computeGradients()
Moose::PetscSupport::PetscOptions _turbulence_petsc_options
Options which hold the petsc settings for the turbulence equation(s)
const bool _has_energy_system
Boolean for easy check if a fluid energy system shall be solved or not.
Moose::LineSearchType _line_search
SIMPLESolverConfiguration _active_scalar_linear_control
Options for the linear solver of the active scalar equation(s)
std::vector< Real > _turbulence_field_relaxation
The user-defined relaxation parameter(s) for the turbulence field(s)
const Real _passive_scalar_l_abs_tol
Absolute linear tolerance for the passive scalar equation(s).
std::pair< unsigned int, Real > solveSolidEnergy()
Solve an equation which contains the solid energy conservation.
std::vector< LinearSystem * > _passive_scalar_systems
Pointer(s) to the system(s) corresponding to the passive scalar equation(s)
void resetIntegratedFluxes()
Reset the heat fluxes to 0.
Definition: CHTHandler.C:408
Moose::PetscSupport::PetscOptions _solid_energy_petsc_options
Options which hold the petsc settings for the fluid energy equation.
const bool _has_turbulence_systems
Boolean for easy check if a turbulence scalar systems shall be solved or not.
std::vector< unsigned int > _turbulence_system_numbers
void printIntegratedFluxes() const
Print the integrated heat fluxes.
Definition: CHTHandler.C:396
LinearSystem * _solid_energy_system
Pointer to the linear system corresponding to the solid energy equation.
Definition: NS.h:197
std::pair< unsigned int, Real > solveAdvectedSystem(const unsigned int system_num, LinearSystem &system, const Real relaxation_factor, libMesh::SolverConfiguration &solver_config, const Real abs_tol, const Real field_relaxation=1.0, const Real min_value_limiter=std::numeric_limits< Real >::min())
Solve an equation which contains an advection term that depends on the solution of the segregated Nav...
const bool _has_active_scalar_systems
Boolean for easy check if a active scalar systems shall be solved or not.
const Real _active_scalar_l_abs_tol
Absolute linear tolerance for the active scalar equation(s).
void initializeCHTCouplingFields()
Initialize the coupling fields for the conjugate heat transfer routines.
Definition: CHTHandler.C:306
virtual std::pair< unsigned int, Real > correctVelocity(const bool subtract_updated_pressure, const bool recompute_face_mass_flux, const SolverParams &solver_params)
Computes new velocity field based on computed pressure gradients.
void resetCHTConvergence()
Reset the convergence data.
Definition: CHTHandler.h:144
bool converged(const std::vector< std::pair< unsigned int, Real >> &residuals, const std::vector< Real > &abs_tolerances)
Based on the residuals, determine if the iterative process converged or not.
const Real _pressure_absolute_tolerance
The user-defined absolute tolerance for determining the convergence in pressure.
const Real _momentum_absolute_tolerance
The user-defined absolute tolerance for determining the convergence in momentum.
const std::vector< SolverSystemName > & _passive_scalar_system_names
The names of the passive scalar systems.
std::vector< LinearSystem * > _active_scalar_systems
Pointer(s) to the system(s) corresponding to the active scalar equation(s)
SIMPLESolverConfiguration _passive_scalar_linear_control
Options for the linear solver of the passive scalar equation(s)
virtual void execute(const ExecFlagType &exec_type)
Moose::PetscSupport::PetscOptions _energy_petsc_options
Options which hold the petsc settings for the fluid energy equation.
LinearSystem & _pressure_system
Reference to the linear system corresponding to the pressure equation.
LinearSystem * _energy_system
Pointer to the linear system corresponding to the fluid energy equation.
const unsigned int _energy_sys_number
The number of the system corresponding to the energy equation.
void incrementCHTIterators()
Increment CHT iterators in the loop.
Definition: CHTHandler.h:150
Moose::PetscSupport::PetscOptions _passive_scalar_petsc_options
Options which hold the petsc settings for the passive scalar equation(s)
bool converged() const
Check if CHT iteration converged.
Definition: CHTHandler.C:415
Moose::PetscSupport::PetscOptions _momentum_petsc_options
Options which hold the petsc settings for the momentum equation.
const std::vector< Real > _passive_scalar_absolute_tolerance
The user-defined absolute tolerance for determining the convergence in passive scalars.
Moose::SolveType _type
const std::vector< SolverSystemName > & _turbulence_system_names
The names of the turbulence systems.
const Real _energy_l_abs_tol
Absolute linear tolerance for the energy equations.
void petscSetOptions(const PetscOptions &po, const SolverParams &solver_params, FEProblemBase *const problem=nullptr)
void sumIntegratedFluxes()
Sum the integrated fluxes over all processors.
Definition: CHTHandler.C:385
const std::vector< Real > _turbulence_equation_relaxation
The user-defined relaxation parameter(s) for the turbulence equation(s)
std::vector< LinearSystem * > _turbulence_systems
Pointer(s) to the system(s) corresponding to the turbulence equation(s)
const std::vector< Real > _passive_scalar_equation_relaxation
The user-defined relaxation parameter(s) for the passive scalar equation(s)
const std::vector< SolverSystemName > & _active_scalar_system_names
The names of the active scalar systems.
const Real _energy_equation_relaxation
The user-defined relaxation parameter for the energy equation.
virtual std::vector< std::pair< unsigned int, Real > > solveMomentumPredictor() override
Solve a momentum predictor step with a fixed pressure field.
const Real _turbulence_l_abs_tol
Absolute linear tolerance for the turbulence equation(s).
Moose::PetscSupport::PetscOptions _active_scalar_petsc_options
Options which hold the petsc settings for the active scalar equation(s)
const bool _has_passive_scalar_systems
Boolean for easy check if a passive scalar systems shall be solved or not.
const std::vector< Real > _active_scalar_absolute_tolerance
The user-defined absolute tolerance for determining the convergence in active scalars.
virtual bool enabled() const override final
Check if CHT treatment is needed.
Definition: CHTHandler.h:138
const ConsoleStream _console
const Real _solid_energy_absolute_tolerance
The user-defined absolute tolerance for determining the convergence in solid energy.
std::vector< unsigned int > _active_scalar_system_numbers
std::vector< LinearSystem * > _momentum_systems
Pointer(s) to the system(s) corresponding to the momentum equation(s)
const bool _continue_on_max_its
If solve should continue if maximum number of iterations is hit.
std::vector< Real > _turbulence_field_min_limit
The user-defined lower limit for turbulent quantities e.g. k, eps/omega, etc..
const std::vector< Real > _turbulence_absolute_tolerance
The user-defined absolute tolerance for determining the convergence turbulence variables.
auto index_range(const T &sizable)
std::vector< unsigned int > _passive_scalar_system_numbers
NS::FV::CHTHandler _cht
********************** Conjugate heat transfer variables ************** //
Definition: NS.h:196
const bool _has_solid_energy_system
Boolean for easy check if a solid energy system shall be solved or not.

◆ solveAdvectedSystem()

std::pair< unsigned int, Real > LinearAssemblySegregatedSolve::solveAdvectedSystem ( const unsigned int  system_num,
LinearSystem system,
const Real  relaxation_factor,
libMesh::SolverConfiguration solver_config,
const Real  abs_tol,
const Real  field_relaxation = 1.0,
const Real  min_value_limiter = std::numeric_limits<Real>::min() 
)
protectedinherited

Solve an equation which contains an advection term that depends on the solution of the segregated Navier-Stokes equations.

Parameters
system_numThe number of the system which is solved
systemReference to the system which is solved
relaxation_factorThe relaxation factor for matrix relaxation
solver_configThe solver configuration object for the linear solve
abs_tolThe scaled absolute tolerance for the linear solve
field_relaxation(optional) The relaxation factor for fields if relax_fields is true. Default value is 1.0.
min_value_limiter(optional) The minimum value for the solution field
Returns
The normalized residual norm of the equation.

Definition at line 474 of file LinearAssemblySegregatedSolve.C.

Referenced by LinearAssemblySegregatedSolve::solve().

481 {
482  _problem.setCurrentLinearSystem(system_num);
483 
484  // We will need some members from the implicit linear system
485  LinearImplicitSystem & li_system = libMesh::cast_ref<LinearImplicitSystem &>(system.system());
486 
487  // We will need the solution, the right hand side and the matrix
488  NumericVector<Number> & current_local_solution = *(li_system.current_local_solution);
489  NumericVector<Number> & solution = *(li_system.solution);
490  SparseMatrix<Number> & mmat = *(li_system.matrix);
491  NumericVector<Number> & rhs = *(li_system.rhs);
492 
493  // We need a vector that stores the (diagonal_relaxed-original_diagonal) vector
494  auto diff_diagonal = solution.zero_clone();
495 
496  // Fetch the linear solver from the system
497  PetscLinearSolver<Real> & linear_solver =
498  libMesh::cast_ref<PetscLinearSolver<Real> &>(*li_system.get_linear_solver());
499 
500  _problem.computeLinearSystemSys(li_system, mmat, rhs, true);
501 
502  // Go and relax the system matrix and the right hand side
503  NS::FV::relaxMatrix(mmat, relaxation_factor, *diff_diagonal);
504  NS::FV::relaxRightHandSide(rhs, solution, *diff_diagonal);
505 
506  if (_print_fields)
507  {
508  _console << system.name() << " system matrix" << std::endl;
509  mmat.print();
510  }
511 
512  // We compute the normalization factors based on the fluxes
513  Real norm_factor = NS::FV::computeNormalizationFactor(solution, mmat, rhs);
514 
515  // We need the non-preconditioned norm to be consistent with the norm factor
516  LibmeshPetscCall(KSPSetNormType(linear_solver.ksp(), KSP_NORM_UNPRECONDITIONED));
517 
518  // Setting the linear tolerances and maximum iteration counts
519  solver_config.real_valued_data["abs_tol"] = absolute_tol * norm_factor;
520  linear_solver.set_solver_configuration(solver_config);
521 
522  // Solve the system and update current local solution
523  auto its_res_pair = linear_solver.solve(mmat, mmat, solution, rhs);
524  li_system.update();
525 
526  if (_print_fields)
527  {
528  _console << " rhs when we solve " << system.name() << std::endl;
529  rhs.print();
530  _console << system.name() << " solution " << std::endl;
531  solution.print();
532  _console << " Norm factor " << norm_factor << std::endl;
533  }
534 
535  // Limiting scalar solution
536  if (min_value_limiter != std::numeric_limits<Real>::min())
537  NS::FV::limitSolutionUpdate(current_local_solution, min_value_limiter);
538 
539  // Relax the field update for the next momentum predictor
540  if (field_relaxation != 1.0)
541  {
542  auto & old_local_solution = *(system.solutionPreviousNewton());
543  NS::FV::relaxSolutionUpdate(current_local_solution, old_local_solution, field_relaxation);
544 
545  // Update old solution, only needed if relaxing the field
546  old_local_solution = current_local_solution;
547  }
548 
549  system.setSolution(current_local_solution);
550 
551  const auto residuals =
552  std::make_pair(its_res_pair.first, linear_solver.get_initial_residual() / norm_factor);
553 
554  _console << " Advected system: " << system.name() << " " << COLOR_GREEN << residuals.second
555  << COLOR_DEFAULT << " Linear its: " << residuals.first << std::endl;
556 
557  return residuals;
558 }
void relaxMatrix(SparseMatrix< Number > &matrix_in, const Real relaxation_parameter, NumericVector< Number > &diff_diagonal)
Relax the matrix to ensure diagonal dominance, we hold onto the difference in diagonals for later use...
FEProblemBase & _problem
const bool _print_fields
Debug parameter which allows printing the coupling and solution vectors/matrices. ...
Real computeNormalizationFactor(const NumericVector< Number > &solution, const SparseMatrix< Number > &mat, const NumericVector< Number > &rhs)
Compute a normalization factor which is applied to the linear residual to determine convergence...
virtual std::unique_ptr< NumericVector< T > > zero_clone() const=0
NumericVector< Number > * rhs
void setSolution(const NumericVector< Number > &soln)
virtual std::pair< unsigned int, Real > solve(SparseMatrix< T > &matrix_in, NumericVector< T > &solution_in, NumericVector< T > &rhs_in, const std::optional< double > tol=std::nullopt, const std::optional< unsigned int > m_its=std::nullopt) override
virtual LinearSolver< Number > * get_linear_solver() const override
void relaxRightHandSide(NumericVector< Number > &rhs_in, const NumericVector< Number > &solution_in, const NumericVector< Number > &diff_diagonal)
Relax the right hand side of an equation, this needs to be called once and the system matrix has been...
std::map< std::string, Real > real_valued_data
virtual void computeLinearSystemSys(libMesh::LinearImplicitSystem &sys, libMesh::SparseMatrix< libMesh::Number > &system_matrix, NumericVector< libMesh::Number > &rhs, const bool compute_gradients=true)
virtual const std::string & name() const
std::unique_ptr< NumericVector< Number > > solution
virtual void print(std::ostream &os=libMesh::out) const
void set_solver_configuration(SolverConfiguration &solver_configuration)
DIE A HORRIBLE DEATH HERE typedef LIBMESH_DEFAULT_SCALAR_TYPE Real
SparseMatrix< Number > * matrix
void setCurrentLinearSystem(unsigned int sys_num)
std::unique_ptr< NumericVector< Number > > current_local_solution
virtual const NumericVector< Number > * solutionPreviousNewton() const
const ConsoleStream _console
void limitSolutionUpdate(NumericVector< Number > &solution, const Real min_limit=std::numeric_limits< Real >::epsilon(), const Real max_limit=1e10)
Limit a solution to its minimum and maximum bounds: $u = min(max(u, min_limit), max_limit)$.
void relaxSolutionUpdate(NumericVector< Number > &vec_new, const NumericVector< Number > &vec_old, const Real relaxation_factor)
Relax the update on a solution field using the following approach: $u = u_{old}+ (u - u_{old})$...
void print(std::ostream &os=libMesh::out, const bool sparse=false) const
virtual System & system() override

◆ solveMomentumPredictor()

std::vector< std::pair< unsigned int, Real > > LinearAssemblySegregatedSolve::solveMomentumPredictor ( )
overrideprotectedvirtualinherited

Solve a momentum predictor step with a fixed pressure field.

Returns
A vector of (number of linear iterations, normalized residual norm) pairs for the momentum equations. The length of the vector equals the dimensionality of the domain.

Implements SIMPLESolveBase.

Definition at line 199 of file LinearAssemblySegregatedSolve.C.

Referenced by LinearAssemblySegregatedSolve::solve().

200 {
201  // Temporary storage for the (flux-normalized) residuals from
202  // different momentum components
203  std::vector<std::pair<unsigned int, Real>> its_normalized_residuals;
204 
205  LinearImplicitSystem & momentum_system_0 =
206  libMesh::cast_ref<LinearImplicitSystem &>(_momentum_systems[0]->system());
207 
208  PetscLinearSolver<Real> & momentum_solver =
209  libMesh::cast_ref<PetscLinearSolver<Real> &>(*momentum_system_0.get_linear_solver());
210 
211  // Solve the momentum equations.
212  // TO DO: These equations are VERY similar. If we can store the differences (things coming from
213  // BCs for example) separately, it is enough to construct one matrix.
214  for (const auto system_i : index_range(_momentum_systems))
215  {
217 
218  // We will need the right hand side and the solution of the next component
219  LinearImplicitSystem & momentum_system =
220  libMesh::cast_ref<LinearImplicitSystem &>(_momentum_systems[system_i]->system());
221 
222  NumericVector<Number> & solution = *(momentum_system.solution);
223  NumericVector<Number> & rhs = *(momentum_system.rhs);
224  SparseMatrix<Number> & mmat = *(momentum_system.matrix);
225 
226  auto diff_diagonal = solution.zero_clone();
227 
228  // We assemble the matrix and the right hand side
229  _problem.computeLinearSystemSys(momentum_system, mmat, rhs, /*compute_grads*/ true);
230 
231  // Still need to relax the right hand side with the same vector
232  NS::FV::relaxMatrix(mmat, _momentum_equation_relaxation, *diff_diagonal);
233  NS::FV::relaxRightHandSide(rhs, solution, *diff_diagonal);
234 
235  // The normalization factor depends on the right hand side so we need to recompute it for this
236  // component
237  Real norm_factor = NS::FV::computeNormalizationFactor(solution, mmat, rhs);
238 
239  // Very important, for deciding the convergence, we need the unpreconditioned
240  // norms in the linear solve
241  LibmeshPetscCall(KSPSetNormType(momentum_solver.ksp(), KSP_NORM_UNPRECONDITIONED));
242  // Solve this component. We don't update the ghosted solution yet, that will come at the end
243  // of the corrector step. Also setting the linear tolerances and maximum iteration counts.
245  momentum_solver.set_solver_configuration(_momentum_linear_control);
246 
247  // We solve the equation
248  auto its_resid_pair = momentum_solver.solve(mmat, mmat, solution, rhs);
249  momentum_system.update();
250 
251  // We will reuse the preconditioner for every momentum system
252  if (system_i == 0)
253  momentum_solver.reuse_preconditioner(true);
254 
255  // Save the normalized residual
256  its_normalized_residuals.push_back(
257  std::make_pair(its_resid_pair.first, momentum_solver.get_initial_residual() / norm_factor));
258 
259  if (_print_fields)
260  {
261  _console << " solution after solve " << std::endl;
262  solution.print();
263  _console << " matrix when we solve " << std::endl;
264  mmat.print();
265  _console << " rhs when we solve " << std::endl;
266  rhs.print();
267  _console << " velocity solution component " << system_i << std::endl;
268  solution.print();
269  _console << "Norm factor " << norm_factor << std::endl;
270  _console << Moose::stringify(momentum_solver.get_initial_residual()) << std::endl;
271  }
272 
273  // Printing residuals
274  _console << " Momentum equation:"
275  << (_momentum_systems.size() > 1
276  ? std::string(" Component ") + std::to_string(system_i + 1) + std::string(" ")
277  : std::string(" "))
278  << COLOR_GREEN << its_normalized_residuals[system_i].second << COLOR_DEFAULT
279  << " Linear its: " << its_normalized_residuals[system_i].first << std::endl;
280  }
281 
282  for (const auto system_i : index_range(_momentum_systems))
283  {
284  LinearImplicitSystem & momentum_system =
285  libMesh::cast_ref<LinearImplicitSystem &>(_momentum_systems[system_i]->system());
286  _momentum_systems[system_i]->setSolution(*(momentum_system.current_local_solution));
287  _momentum_systems[system_i]->copyPreviousNonlinearSolutions();
288  }
289 
290  // We reset this to ensure the preconditioner is recomputed new time we go to the momentum
291  // predictor
292  momentum_solver.reuse_preconditioner(false);
293 
294  return its_normalized_residuals;
295 }
void relaxMatrix(SparseMatrix< Number > &matrix_in, const Real relaxation_parameter, NumericVector< Number > &diff_diagonal)
Relax the matrix to ensure diagonal dominance, we hold onto the difference in diagonals for later use...
FEProblemBase & _problem
SIMPLESolverConfiguration _momentum_linear_control
Options for the linear solver of the momentum equation.
const bool _print_fields
Debug parameter which allows printing the coupling and solution vectors/matrices. ...
Real computeNormalizationFactor(const NumericVector< Number > &solution, const SparseMatrix< Number > &mat, const NumericVector< Number > &rhs)
Compute a normalization factor which is applied to the linear residual to determine convergence...
const Real _momentum_equation_relaxation
The user-defined relaxation parameter for the momentum equation.
NumericVector< Number > * rhs
const Real _momentum_l_abs_tol
Absolute linear tolerance for the momentum equation(s).
virtual LinearSolver< Number > * get_linear_solver() const override
void relaxRightHandSide(NumericVector< Number > &rhs_in, const NumericVector< Number > &solution_in, const NumericVector< Number > &diff_diagonal)
Relax the right hand side of an equation, this needs to be called once and the system matrix has been...
std::map< std::string, Real > real_valued_data
virtual void computeLinearSystemSys(libMesh::LinearImplicitSystem &sys, libMesh::SparseMatrix< libMesh::Number > &system_matrix, NumericVector< libMesh::Number > &rhs, const bool compute_gradients=true)
std::vector< unsigned int > _momentum_system_numbers
The number(s) of the system(s) corresponding to the momentum equation(s)
virtual std::unique_ptr< SparseMatrix< T > > zero_clone() const=0
std::unique_ptr< NumericVector< Number > > solution
virtual void print(std::ostream &os=libMesh::out) const
std::string stringify(const T &t)
DIE A HORRIBLE DEATH HERE typedef LIBMESH_DEFAULT_SCALAR_TYPE Real
SparseMatrix< Number > * matrix
void setCurrentLinearSystem(unsigned int sys_num)
std::unique_ptr< NumericVector< Number > > current_local_solution
const ConsoleStream _console
std::vector< LinearSystem * > _momentum_systems
Pointer(s) to the system(s) corresponding to the momentum equation(s)
auto index_range(const T &sizable)
void print(std::ostream &os=libMesh::out, const bool sparse=false) const

◆ solvePressureCorrector()

std::pair< unsigned int, Real > LinearAssemblySegregatedSolve::solvePressureCorrector ( )
overrideprotectedvirtualinherited

Solve a pressure corrector step.

Returns
The number of linear iterations and the normalized residual norm of the pressure equation.

Implements SIMPLESolveBase.

Definition at line 308 of file LinearAssemblySegregatedSolve.C.

Referenced by LinearAssemblySegregatedSolve::correctVelocity().

309 {
311 
312  // We will need some members from the linear system
313  LinearImplicitSystem & pressure_system =
314  libMesh::cast_ref<LinearImplicitSystem &>(_pressure_system.system());
315 
316  // We will need the solution, the right hand side and the matrix
317  NumericVector<Number> & current_local_solution = *(pressure_system.current_local_solution);
318  NumericVector<Number> & solution = *(pressure_system.solution);
319  SparseMatrix<Number> & mmat = *(pressure_system.matrix);
320  NumericVector<Number> & rhs = *(pressure_system.rhs);
321 
322  // Fetch the linear solver from the system
323  PetscLinearSolver<Real> & pressure_solver =
324  libMesh::cast_ref<PetscLinearSolver<Real> &>(*pressure_system.get_linear_solver());
325 
326  _problem.computeLinearSystemSys(pressure_system, mmat, rhs, false);
327 
328  if (_print_fields)
329  {
330  _console << "Pressure matrix" << std::endl;
331  mmat.print();
332  }
333 
334  // We compute the normalization factors based on the fluxes
335  Real norm_factor = NS::FV::computeNormalizationFactor(solution, mmat, rhs);
336 
337  // We need the non-preconditioned norm to be consistent with the norm factor
338  LibmeshPetscCall(KSPSetNormType(pressure_solver.ksp(), KSP_NORM_UNPRECONDITIONED));
339 
340  // Setting the linear tolerances and maximum iteration counts
343 
344  if (_pin_pressure)
346  pressure_system.update();
347 
348  auto its_res_pair = pressure_solver.solve(mmat, mmat, solution, rhs);
349  pressure_system.update();
350 
351  if (_print_fields)
352  {
353  _console << " rhs when we solve pressure " << std::endl;
354  rhs.print();
355  _console << " Pressure " << std::endl;
356  solution.print();
357  _console << "Norm factor " << norm_factor << std::endl;
358  }
359 
360  _pressure_system.setSolution(current_local_solution);
361 
362  const auto residuals =
363  std::make_pair(its_res_pair.first, pressure_solver.get_initial_residual() / norm_factor);
364 
365  _console << " Pressure equation: " << COLOR_GREEN << residuals.second << COLOR_DEFAULT
366  << " Linear its: " << residuals.first << std::endl;
367 
368  return residuals;
369 }
FEProblemBase & _problem
const bool _print_fields
Debug parameter which allows printing the coupling and solution vectors/matrices. ...
Real computeNormalizationFactor(const NumericVector< Number > &solution, const SparseMatrix< Number > &mat, const NumericVector< Number > &rhs)
Compute a normalization factor which is applied to the linear residual to determine convergence...
NumericVector< Number > * rhs
void setSolution(const NumericVector< Number > &soln)
virtual std::pair< unsigned int, Real > solve(SparseMatrix< T > &matrix_in, NumericVector< T > &solution_in, NumericVector< T > &rhs_in, const std::optional< double > tol=std::nullopt, const std::optional< unsigned int > m_its=std::nullopt) override
virtual LinearSolver< Number > * get_linear_solver() const override
std::map< std::string, Real > real_valued_data
virtual void computeLinearSystemSys(libMesh::LinearImplicitSystem &sys, libMesh::SparseMatrix< libMesh::Number > &system_matrix, NumericVector< libMesh::Number > &rhs, const bool compute_gradients=true)
LinearSystem & _pressure_system
Reference to the linear system corresponding to the pressure equation.
SIMPLESolverConfiguration _pressure_linear_control
Options for the linear solver of the pressure equation.
const Real _pressure_l_abs_tol
Absolute linear tolerance for the pressure equation.
std::unique_ptr< NumericVector< Number > > solution
dof_id_type _pressure_pin_dof
The dof ID where the pressure needs to be pinned.
virtual void print(std::ostream &os=libMesh::out) const
const bool _pin_pressure
If the pressure needs to be pinned.
void set_solver_configuration(SolverConfiguration &solver_configuration)
DIE A HORRIBLE DEATH HERE typedef LIBMESH_DEFAULT_SCALAR_TYPE Real
SparseMatrix< Number > * matrix
void setCurrentLinearSystem(unsigned int sys_num)
const Real _pressure_pin_value
The value we want to enforce for pressure.
std::unique_ptr< NumericVector< Number > > current_local_solution
const ConsoleStream _console
void constrainSystem(SparseMatrix< Number > &mx, NumericVector< Number > &rhs, const Real desired_value, const dof_id_type dof_id)
Implicitly constrain the system by adding a factor*(u-u_desired) to it at a desired dof value...
void print(std::ostream &os=libMesh::out, const bool sparse=false) const
virtual System & system() override
const unsigned int _pressure_sys_number
The number of the system corresponding to the pressure equation.

◆ solveSolidEnergy()

std::pair< unsigned int, Real > LinearAssemblySegregatedSolve::solveSolidEnergy ( )
protectedinherited

Solve an equation which contains the solid energy conservation.

Definition at line 372 of file LinearAssemblySegregatedSolve.C.

Referenced by LinearAssemblySegregatedSolve::solve().

373 {
375 
376  // We will need some members from the linear system
377  LinearImplicitSystem & system =
378  libMesh::cast_ref<LinearImplicitSystem &>(_solid_energy_system->system());
379 
380  // We will need the solution, the right hand side and the matrix
381  NumericVector<Number> & current_local_solution = *(system.current_local_solution);
382  NumericVector<Number> & solution = *(system.solution);
383  SparseMatrix<Number> & mmat = *(system.matrix);
384  NumericVector<Number> & rhs = *(system.rhs);
385 
386  // Fetch the linear solver from the system
387  PetscLinearSolver<Real> & solver =
388  libMesh::cast_ref<PetscLinearSolver<Real> &>(*system.get_linear_solver());
389 
390  _problem.computeLinearSystemSys(system, mmat, rhs, false);
391 
392  if (_print_fields)
393  {
394  _console << "Solid energy matrix" << std::endl;
395  mmat.print();
396  }
397 
398  // We compute the normalization factors based on the fluxes
399  Real norm_factor = NS::FV::computeNormalizationFactor(solution, mmat, rhs);
400 
401  // We need the non-preconditioned norm to be consistent with the norm factor
402  LibmeshPetscCall(KSPSetNormType(solver.ksp(), KSP_NORM_UNPRECONDITIONED));
403 
404  // Setting the linear tolerances and maximum iteration counts
407 
408  auto its_res_pair = solver.solve(mmat, mmat, solution, rhs);
409  system.update();
410 
411  if (_print_fields)
412  {
413  _console << " rhs when we solve solid energy " << std::endl;
414  rhs.print();
415  _console << " Solid energy " << std::endl;
416  solution.print();
417  _console << "Norm factor " << norm_factor << std::endl;
418  }
419 
420  _solid_energy_system->setSolution(current_local_solution);
421 
422  const auto residuals =
423  std::make_pair(its_res_pair.first, solver.get_initial_residual() / norm_factor);
424 
425  _console << " Solid energy equation: " << COLOR_GREEN << residuals.second << COLOR_DEFAULT
426  << " Linear its: " << residuals.first << std::endl;
427 
428  return residuals;
429 }
FEProblemBase & _problem
const bool _print_fields
Debug parameter which allows printing the coupling and solution vectors/matrices. ...
const Real _solid_energy_l_abs_tol
Absolute linear tolerance for the energy equations.
Real computeNormalizationFactor(const NumericVector< Number > &solution, const SparseMatrix< Number > &mat, const NumericVector< Number > &rhs)
Compute a normalization factor which is applied to the linear residual to determine convergence...
LinearSystem * _solid_energy_system
Pointer to the linear system corresponding to the solid energy equation.
NumericVector< Number > * rhs
void setSolution(const NumericVector< Number > &soln)
virtual std::pair< unsigned int, Real > solve(SparseMatrix< T > &matrix_in, NumericVector< T > &solution_in, NumericVector< T > &rhs_in, const std::optional< double > tol=std::nullopt, const std::optional< unsigned int > m_its=std::nullopt) override
virtual LinearSolver< Number > * get_linear_solver() const override
std::map< std::string, Real > real_valued_data
virtual void computeLinearSystemSys(libMesh::LinearImplicitSystem &sys, libMesh::SparseMatrix< libMesh::Number > &system_matrix, NumericVector< libMesh::Number > &rhs, const bool compute_gradients=true)
const unsigned int _solid_energy_sys_number
The number of the system corresponding to the solid energy equation.
std::unique_ptr< NumericVector< Number > > solution
virtual void print(std::ostream &os=libMesh::out) const
void set_solver_configuration(SolverConfiguration &solver_configuration)
DIE A HORRIBLE DEATH HERE typedef LIBMESH_DEFAULT_SCALAR_TYPE Real
SparseMatrix< Number > * matrix
void setCurrentLinearSystem(unsigned int sys_num)
std::unique_ptr< NumericVector< Number > > current_local_solution
const ConsoleStream _console
SIMPLESolverConfiguration _solid_energy_linear_control
Options for the linear solver of the energy equation.
void print(std::ostream &os=libMesh::out, const bool sparse=false) const
virtual System & system() override

◆ systemsToSolve()

const std::vector<LinearSystem *> LinearAssemblySegregatedSolve::systemsToSolve ( ) const
inlineinherited

Return pointers to the systems which are solved for within this object.

Definition at line 41 of file LinearAssemblySegregatedSolve.h.

Referenced by PIMPLE::getTimeIntegrators(), and PIMPLE::relativeSolutionDifferenceNorm().

41 { return _systems_to_solve; }
std::vector< LinearSystem * > _systems_to_solve
Shortcut to every linear system that we solve for here.

◆ validParams()

InputParameters SIMPLESolve::validParams ( )
static

Definition at line 18 of file SIMPLESolve.C.

Referenced by SIMPLE::validParams().

19 {
21  return params;
22 }

Member Data Documentation

◆ _active_scalar_absolute_tolerance

const std::vector<Real> LinearAssemblySegregatedSolve::_active_scalar_absolute_tolerance
protectedinherited

The user-defined absolute tolerance for determining the convergence in active scalars.

Definition at line 142 of file LinearAssemblySegregatedSolve.h.

Referenced by LinearAssemblySegregatedSolve::solve().

◆ _active_scalar_equation_relaxation

const std::vector<Real> LinearAssemblySegregatedSolve::_active_scalar_equation_relaxation
protectedinherited

The user-defined relaxation parameter(s) for the active scalar equation(s)

Definition at line 129 of file LinearAssemblySegregatedSolve.h.

Referenced by LinearAssemblySegregatedSolve::LinearAssemblySegregatedSolve(), and LinearAssemblySegregatedSolve::solve().

◆ _active_scalar_l_abs_tol

const Real LinearAssemblySegregatedSolve::_active_scalar_l_abs_tol
protectedinherited

Absolute linear tolerance for the active scalar equation(s).

We need to store this, because it needs to be scaled with a representative flux.

Definition at line 139 of file LinearAssemblySegregatedSolve.h.

Referenced by LinearAssemblySegregatedSolve::solve().

◆ _active_scalar_linear_control

SIMPLESolverConfiguration LinearAssemblySegregatedSolve::_active_scalar_linear_control
protectedinherited

Options for the linear solver of the active scalar equation(s)

Definition at line 135 of file LinearAssemblySegregatedSolve.h.

Referenced by LinearAssemblySegregatedSolve::LinearAssemblySegregatedSolve(), and LinearAssemblySegregatedSolve::solve().

◆ _active_scalar_petsc_options

Moose::PetscSupport::PetscOptions LinearAssemblySegregatedSolve::_active_scalar_petsc_options
protectedinherited

Options which hold the petsc settings for the active scalar equation(s)

Definition at line 132 of file LinearAssemblySegregatedSolve.h.

Referenced by LinearAssemblySegregatedSolve::LinearAssemblySegregatedSolve(), and LinearAssemblySegregatedSolve::solve().

◆ _active_scalar_system_names

const std::vector<SolverSystemName>& LinearAssemblySegregatedSolve::_active_scalar_system_names
protectedinherited

The names of the active scalar systems.

Definition at line 120 of file LinearAssemblySegregatedSolve.h.

Referenced by LinearAssemblySegregatedSolve::LinearAssemblySegregatedSolve(), and LinearAssemblySegregatedSolve::solve().

◆ _active_scalar_system_numbers

std::vector<unsigned int> LinearAssemblySegregatedSolve::_active_scalar_system_numbers
protectedinherited

◆ _active_scalar_systems

std::vector<LinearSystem *> LinearAssemblySegregatedSolve::_active_scalar_systems
protectedinherited

Pointer(s) to the system(s) corresponding to the active scalar equation(s)

Definition at line 106 of file LinearAssemblySegregatedSolve.h.

Referenced by checkIntegrity(), LinearAssemblySegregatedSolve::LinearAssemblySegregatedSolve(), and LinearAssemblySegregatedSolve::solve().

◆ _cht

NS::FV::CHTHandler LinearAssemblySegregatedSolve::_cht
protectedinherited

********************** Conjugate heat transfer variables ************** //

Definition at line 147 of file LinearAssemblySegregatedSolve.h.

Referenced by LinearAssemblySegregatedSolve::initialSetup(), LinearAssemblySegregatedSolve::LinearAssemblySegregatedSolve(), and LinearAssemblySegregatedSolve::solve().

◆ _continue_on_max_its

const bool SIMPLESolveBase::_continue_on_max_its
protectedinherited

If solve should continue if maximum number of iterations is hit.

Definition at line 235 of file SIMPLESolveBase.h.

Referenced by SIMPLESolveNonlinearAssembly::solve(), and LinearAssemblySegregatedSolve::solve().

◆ _energy_absolute_tolerance

const Real SIMPLESolveBase::_energy_absolute_tolerance
protectedinherited

The user-defined absolute tolerance for determining the convergence in energy.

Definition at line 220 of file SIMPLESolveBase.h.

Referenced by SIMPLESolveNonlinearAssembly::solve(), and LinearAssemblySegregatedSolve::solve().

◆ _energy_equation_relaxation

const Real SIMPLESolveBase::_energy_equation_relaxation
protectedinherited

The user-defined relaxation parameter for the energy equation.

Definition at line 130 of file SIMPLESolveBase.h.

Referenced by SIMPLESolveNonlinearAssembly::solve(), and LinearAssemblySegregatedSolve::solve().

◆ _energy_l_abs_tol

const Real SIMPLESolveBase::_energy_l_abs_tol
protectedinherited

Absolute linear tolerance for the energy equations.

We need to store this, because it needs to be scaled with a representative flux.

Definition at line 140 of file SIMPLESolveBase.h.

Referenced by SIMPLESolveNonlinearAssembly::solve(), and LinearAssemblySegregatedSolve::solve().

◆ _energy_linear_control

SIMPLESolverConfiguration SIMPLESolveBase::_energy_linear_control
protectedinherited

Options for the linear solver of the energy equation.

Definition at line 136 of file SIMPLESolveBase.h.

Referenced by SIMPLESolveBase::SIMPLESolveBase(), SIMPLESolveNonlinearAssembly::solve(), and LinearAssemblySegregatedSolve::solve().

◆ _energy_petsc_options

Moose::PetscSupport::PetscOptions SIMPLESolveBase::_energy_petsc_options
protectedinherited

Options which hold the petsc settings for the fluid energy equation.

Definition at line 133 of file SIMPLESolveBase.h.

Referenced by SIMPLESolveBase::SIMPLESolveBase(), SIMPLESolveNonlinearAssembly::solve(), and LinearAssemblySegregatedSolve::solve().

◆ _energy_sys_number

const unsigned int LinearAssemblySegregatedSolve::_energy_sys_number
protectedinherited

The number of the system corresponding to the energy equation.

Definition at line 91 of file LinearAssemblySegregatedSolve.h.

Referenced by LinearAssemblySegregatedSolve::solve().

◆ _energy_system

LinearSystem* LinearAssemblySegregatedSolve::_energy_system
protectedinherited

Pointer to the linear system corresponding to the fluid energy equation.

Definition at line 94 of file LinearAssemblySegregatedSolve.h.

Referenced by checkIntegrity(), LinearAssemblySegregatedSolve::LinearAssemblySegregatedSolve(), and LinearAssemblySegregatedSolve::solve().

◆ _has_active_scalar_systems

const bool LinearAssemblySegregatedSolve::_has_active_scalar_systems
protectedinherited

Boolean for easy check if a active scalar systems shall be solved or not.

Definition at line 123 of file LinearAssemblySegregatedSolve.h.

Referenced by checkIntegrity(), LinearAssemblySegregatedSolve::LinearAssemblySegregatedSolve(), and LinearAssemblySegregatedSolve::solve().

◆ _has_energy_system

const bool SIMPLESolveBase::_has_energy_system
protectedinherited

◆ _has_passive_scalar_systems

const bool SIMPLESolveBase::_has_passive_scalar_systems
protectedinherited

◆ _has_solid_energy_system

const bool SIMPLESolveBase::_has_solid_energy_system
protectedinherited

◆ _has_turbulence_systems

const bool SIMPLESolveBase::_has_turbulence_systems
protectedinherited

Boolean for easy check if a turbulence scalar systems shall be solved or not.

Definition at line 187 of file SIMPLESolveBase.h.

Referenced by checkIntegrity(), LinearAssemblySegregatedSolve::LinearAssemblySegregatedSolve(), SIMPLESolveBase::SIMPLESolveBase(), and LinearAssemblySegregatedSolve::solve().

◆ _momentum_absolute_tolerance

const Real SIMPLESolveBase::_momentum_absolute_tolerance
protectedinherited

The user-defined absolute tolerance for determining the convergence in momentum.

Definition at line 214 of file SIMPLESolveBase.h.

Referenced by SIMPLESolveNonlinearAssembly::solve(), and LinearAssemblySegregatedSolve::solve().

◆ _momentum_equation_relaxation

const Real SIMPLESolveBase::_momentum_equation_relaxation
protectedinherited

The user-defined relaxation parameter for the momentum equation.

Definition at line 95 of file SIMPLESolveBase.h.

Referenced by SIMPLESolveNonlinearAssembly::solveMomentumPredictor(), and LinearAssemblySegregatedSolve::solveMomentumPredictor().

◆ _momentum_l_abs_tol

const Real SIMPLESolveBase::_momentum_l_abs_tol
protectedinherited

Absolute linear tolerance for the momentum equation(s).

We need to store this, because it needs to be scaled with a representative flux.

Definition at line 89 of file SIMPLESolveBase.h.

Referenced by SIMPLESolveNonlinearAssembly::solveMomentumPredictor(), and LinearAssemblySegregatedSolve::solveMomentumPredictor().

◆ _momentum_linear_control

SIMPLESolverConfiguration SIMPLESolveBase::_momentum_linear_control
protectedinherited

Options for the linear solver of the momentum equation.

Definition at line 85 of file SIMPLESolveBase.h.

Referenced by SIMPLESolveBase::SIMPLESolveBase(), SIMPLESolveNonlinearAssembly::solveMomentumPredictor(), and LinearAssemblySegregatedSolve::solveMomentumPredictor().

◆ _momentum_petsc_options

Moose::PetscSupport::PetscOptions SIMPLESolveBase::_momentum_petsc_options
protectedinherited

Options which hold the petsc settings for the momentum equation.

Definition at line 92 of file SIMPLESolveBase.h.

Referenced by SIMPLESolveBase::SIMPLESolveBase(), SIMPLESolveNonlinearAssembly::solve(), and LinearAssemblySegregatedSolve::solve().

◆ _momentum_system_names

const std::vector<SolverSystemName>& SIMPLESolveBase::_momentum_system_names
protectedinherited

◆ _momentum_system_numbers

std::vector<unsigned int> LinearAssemblySegregatedSolve::_momentum_system_numbers
protectedinherited

◆ _momentum_systems

std::vector<LinearSystem *> LinearAssemblySegregatedSolve::_momentum_systems
protectedinherited

◆ _num_iterations

const unsigned int SIMPLESolveBase::_num_iterations
protectedinherited

The maximum number of momentum-pressure iterations.

Definition at line 232 of file SIMPLESolveBase.h.

Referenced by SIMPLESolveNonlinearAssembly::solve(), and LinearAssemblySegregatedSolve::solve().

◆ _passive_scalar_absolute_tolerance

const std::vector<Real> SIMPLESolveBase::_passive_scalar_absolute_tolerance
protectedinherited

The user-defined absolute tolerance for determining the convergence in passive scalars.

Definition at line 226 of file SIMPLESolveBase.h.

Referenced by SIMPLESolveBase::SIMPLESolveBase(), SIMPLESolveNonlinearAssembly::solve(), and LinearAssemblySegregatedSolve::solve().

◆ _passive_scalar_equation_relaxation

const std::vector<Real> SIMPLESolveBase::_passive_scalar_equation_relaxation
protectedinherited

The user-defined relaxation parameter(s) for the passive scalar equation(s)

Definition at line 169 of file SIMPLESolveBase.h.

Referenced by SIMPLESolveBase::SIMPLESolveBase(), SIMPLESolveNonlinearAssembly::solve(), and LinearAssemblySegregatedSolve::solve().

◆ _passive_scalar_l_abs_tol

const Real SIMPLESolveBase::_passive_scalar_l_abs_tol
protectedinherited

Absolute linear tolerance for the passive scalar equation(s).

We need to store this, because it needs to be scaled with a representative flux.

Definition at line 179 of file SIMPLESolveBase.h.

Referenced by SIMPLESolveNonlinearAssembly::solve(), and LinearAssemblySegregatedSolve::solve().

◆ _passive_scalar_linear_control

SIMPLESolverConfiguration SIMPLESolveBase::_passive_scalar_linear_control
protectedinherited

Options for the linear solver of the passive scalar equation(s)

Definition at line 175 of file SIMPLESolveBase.h.

Referenced by SIMPLESolveBase::SIMPLESolveBase(), SIMPLESolveNonlinearAssembly::solve(), and LinearAssemblySegregatedSolve::solve().

◆ _passive_scalar_petsc_options

Moose::PetscSupport::PetscOptions SIMPLESolveBase::_passive_scalar_petsc_options
protectedinherited

Options which hold the petsc settings for the passive scalar equation(s)

Definition at line 172 of file SIMPLESolveBase.h.

Referenced by SIMPLESolveBase::SIMPLESolveBase(), SIMPLESolveNonlinearAssembly::solve(), and LinearAssemblySegregatedSolve::solve().

◆ _passive_scalar_system_names

const std::vector<SolverSystemName>& SIMPLESolveBase::_passive_scalar_system_names
protectedinherited

◆ _passive_scalar_system_numbers

std::vector<unsigned int> SIMPLESolveBase::_passive_scalar_system_numbers
protectedinherited

◆ _passive_scalar_systems

std::vector<LinearSystem *> LinearAssemblySegregatedSolve::_passive_scalar_systems
protectedinherited

Pointer(s) to the system(s) corresponding to the passive scalar equation(s)

Definition at line 103 of file LinearAssemblySegregatedSolve.h.

Referenced by checkIntegrity(), LinearAssemblySegregatedSolve::LinearAssemblySegregatedSolve(), and LinearAssemblySegregatedSolve::solve().

◆ _pin_pressure

const bool SIMPLESolveBase::_pin_pressure
protectedinherited

◆ _pressure_absolute_tolerance

const Real SIMPLESolveBase::_pressure_absolute_tolerance
protectedinherited

The user-defined absolute tolerance for determining the convergence in pressure.

Definition at line 217 of file SIMPLESolveBase.h.

Referenced by SIMPLESolveNonlinearAssembly::solve(), and LinearAssemblySegregatedSolve::solve().

◆ _pressure_l_abs_tol

const Real SIMPLESolveBase::_pressure_l_abs_tol
protectedinherited

Absolute linear tolerance for the pressure equation.

We need to store this, because it needs to be scaled with a representative flux.

Definition at line 107 of file SIMPLESolveBase.h.

Referenced by SIMPLESolveNonlinearAssembly::solvePressureCorrector(), and LinearAssemblySegregatedSolve::solvePressureCorrector().

◆ _pressure_linear_control

SIMPLESolverConfiguration SIMPLESolveBase::_pressure_linear_control
protectedinherited

Options for the linear solver of the pressure equation.

Definition at line 103 of file SIMPLESolveBase.h.

Referenced by SIMPLESolveBase::SIMPLESolveBase(), SIMPLESolveNonlinearAssembly::solvePressureCorrector(), and LinearAssemblySegregatedSolve::solvePressureCorrector().

◆ _pressure_petsc_options

Moose::PetscSupport::PetscOptions SIMPLESolveBase::_pressure_petsc_options
protectedinherited

Options which hold the petsc settings for the pressure equation.

Definition at line 110 of file SIMPLESolveBase.h.

Referenced by LinearAssemblySegregatedSolve::correctVelocity(), SIMPLESolveBase::SIMPLESolveBase(), and SIMPLESolveNonlinearAssembly::solve().

◆ _pressure_pin_dof

dof_id_type SIMPLESolveBase::_pressure_pin_dof
protectedinherited

◆ _pressure_pin_value

const Real SIMPLESolveBase::_pressure_pin_value
protectedinherited

The value we want to enforce for pressure.

Definition at line 119 of file SIMPLESolveBase.h.

Referenced by SIMPLESolveNonlinearAssembly::solvePressureCorrector(), and LinearAssemblySegregatedSolve::solvePressureCorrector().

◆ _pressure_sys_number

const unsigned int LinearAssemblySegregatedSolve::_pressure_sys_number
protectedinherited

The number of the system corresponding to the pressure equation.

Definition at line 85 of file LinearAssemblySegregatedSolve.h.

Referenced by LinearAssemblySegregatedSolve::solvePressureCorrector().

◆ _pressure_system

LinearSystem& LinearAssemblySegregatedSolve::_pressure_system
protectedinherited

◆ _pressure_system_name

const SolverSystemName& SIMPLESolveBase::_pressure_system_name
protectedinherited

The name of the pressure system.

Definition at line 100 of file SIMPLESolveBase.h.

◆ _pressure_variable_relaxation

const Real SIMPLESolveBase::_pressure_variable_relaxation
protectedinherited

The user-defined relaxation parameter for the pressure variable.

Definition at line 113 of file SIMPLESolveBase.h.

Referenced by LinearAssemblySegregatedSolve::correctVelocity(), and SIMPLESolveNonlinearAssembly::solve().

◆ _print_fields

const bool SIMPLESolveBase::_print_fields
protectedinherited

◆ _rc_uo

RhieChowMassFlux* LinearAssemblySegregatedSolve::_rc_uo
protectedinherited

Pointer to the segregated RhieChow interpolation object.

Definition at line 112 of file LinearAssemblySegregatedSolve.h.

Referenced by LinearAssemblySegregatedSolve::correctVelocity(), and LinearAssemblySegregatedSolve::linkRhieChowUserObject().

◆ _solid_energy_absolute_tolerance

const Real SIMPLESolveBase::_solid_energy_absolute_tolerance
protectedinherited

The user-defined absolute tolerance for determining the convergence in solid energy.

Definition at line 223 of file SIMPLESolveBase.h.

Referenced by SIMPLESolveNonlinearAssembly::solve(), and LinearAssemblySegregatedSolve::solve().

◆ _solid_energy_l_abs_tol

const Real SIMPLESolveBase::_solid_energy_l_abs_tol
protectedinherited

Absolute linear tolerance for the energy equations.

We need to store this, because it needs to be scaled with a representative flux.

Definition at line 155 of file SIMPLESolveBase.h.

Referenced by LinearAssemblySegregatedSolve::solveSolidEnergy(), and SIMPLESolveNonlinearAssembly::solveSolidEnergySystem().

◆ _solid_energy_linear_control

SIMPLESolverConfiguration SIMPLESolveBase::_solid_energy_linear_control
protectedinherited

Options for the linear solver of the energy equation.

Definition at line 151 of file SIMPLESolveBase.h.

Referenced by SIMPLESolveBase::SIMPLESolveBase(), LinearAssemblySegregatedSolve::solveSolidEnergy(), and SIMPLESolveNonlinearAssembly::solveSolidEnergySystem().

◆ _solid_energy_petsc_options

Moose::PetscSupport::PetscOptions SIMPLESolveBase::_solid_energy_petsc_options
protectedinherited

Options which hold the petsc settings for the fluid energy equation.

Definition at line 148 of file SIMPLESolveBase.h.

Referenced by SIMPLESolveBase::SIMPLESolveBase(), and LinearAssemblySegregatedSolve::solve().

◆ _solid_energy_sys_number

const unsigned int LinearAssemblySegregatedSolve::_solid_energy_sys_number
protectedinherited

The number of the system corresponding to the solid energy equation.

Definition at line 97 of file LinearAssemblySegregatedSolve.h.

Referenced by LinearAssemblySegregatedSolve::solveSolidEnergy().

◆ _solid_energy_system

LinearSystem* LinearAssemblySegregatedSolve::_solid_energy_system
protectedinherited

Pointer to the linear system corresponding to the solid energy equation.

Definition at line 100 of file LinearAssemblySegregatedSolve.h.

Referenced by LinearAssemblySegregatedSolve::LinearAssemblySegregatedSolve(), LinearAssemblySegregatedSolve::solve(), and LinearAssemblySegregatedSolve::solveSolidEnergy().

◆ _systems_to_solve

std::vector<LinearSystem *> LinearAssemblySegregatedSolve::_systems_to_solve
protectedinherited

Shortcut to every linear system that we solve for here.

Definition at line 115 of file LinearAssemblySegregatedSolve.h.

Referenced by LinearAssemblySegregatedSolve::LinearAssemblySegregatedSolve(), and LinearAssemblySegregatedSolve::systemsToSolve().

◆ _turbulence_absolute_tolerance

const std::vector<Real> SIMPLESolveBase::_turbulence_absolute_tolerance
protectedinherited

The user-defined absolute tolerance for determining the convergence turbulence variables.

Definition at line 229 of file SIMPLESolveBase.h.

Referenced by SIMPLESolveBase::SIMPLESolveBase(), and LinearAssemblySegregatedSolve::solve().

◆ _turbulence_equation_relaxation

const std::vector<Real> SIMPLESolveBase::_turbulence_equation_relaxation
protectedinherited

The user-defined relaxation parameter(s) for the turbulence equation(s)

Definition at line 193 of file SIMPLESolveBase.h.

Referenced by SIMPLESolveBase::SIMPLESolveBase(), and LinearAssemblySegregatedSolve::solve().

◆ _turbulence_field_min_limit

std::vector<Real> SIMPLESolveBase::_turbulence_field_min_limit
protectedinherited

The user-defined lower limit for turbulent quantities e.g. k, eps/omega, etc..

Definition at line 199 of file SIMPLESolveBase.h.

Referenced by SIMPLESolveBase::SIMPLESolveBase(), and LinearAssemblySegregatedSolve::solve().

◆ _turbulence_field_relaxation

std::vector<Real> SIMPLESolveBase::_turbulence_field_relaxation
protectedinherited

The user-defined relaxation parameter(s) for the turbulence field(s)

Definition at line 196 of file SIMPLESolveBase.h.

Referenced by SIMPLESolveBase::SIMPLESolveBase(), and LinearAssemblySegregatedSolve::solve().

◆ _turbulence_l_abs_tol

const Real SIMPLESolveBase::_turbulence_l_abs_tol
protectedinherited

Absolute linear tolerance for the turbulence equation(s).

We need to store this, because it needs to be scaled with a representative flux.

Definition at line 209 of file SIMPLESolveBase.h.

Referenced by LinearAssemblySegregatedSolve::solve().

◆ _turbulence_linear_control

SIMPLESolverConfiguration SIMPLESolveBase::_turbulence_linear_control
protectedinherited

Options for the linear solver of the turbulence equation(s)

Definition at line 205 of file SIMPLESolveBase.h.

Referenced by SIMPLESolveBase::SIMPLESolveBase(), and LinearAssemblySegregatedSolve::solve().

◆ _turbulence_petsc_options

Moose::PetscSupport::PetscOptions SIMPLESolveBase::_turbulence_petsc_options
protectedinherited

Options which hold the petsc settings for the turbulence equation(s)

Definition at line 202 of file SIMPLESolveBase.h.

Referenced by SIMPLESolveBase::SIMPLESolveBase(), and LinearAssemblySegregatedSolve::solve().

◆ _turbulence_system_names

const std::vector<SolverSystemName>& SIMPLESolveBase::_turbulence_system_names
protectedinherited

◆ _turbulence_system_numbers

std::vector<unsigned int> SIMPLESolveBase::_turbulence_system_numbers
protectedinherited

◆ _turbulence_systems

std::vector<LinearSystem *> LinearAssemblySegregatedSolve::_turbulence_systems
protectedinherited

Pointer(s) to the system(s) corresponding to the turbulence equation(s)

Definition at line 109 of file LinearAssemblySegregatedSolve.h.

Referenced by checkIntegrity(), LinearAssemblySegregatedSolve::LinearAssemblySegregatedSolve(), and LinearAssemblySegregatedSolve::solve().


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