Creates all the objects needed to add a turbulence model to an incompressible / weakly-compressible Navier Stokes finite volume flow simulation. More...
#include <WCNSFVTurbulencePhysics.h>
Public Types | |
typedef DataFileName | DataFileParameterType |
Public Member Functions | |
WCNSFVTurbulencePhysics (const InputParameters ¶meters) | |
bool | hasTurbulenceModel () const |
Whether a turbulence model is in use. More... | |
std::vector< BoundaryName > | turbulenceWalls () const |
The names of the boundaries with turbulence wall functions. More... | |
MooseEnum | turbulenceEpsilonWallTreatment () const |
The turbulence epsilon wall treatment (same for all turbulence walls currently) More... | |
MooseEnum | turbulenceTemperatureWallTreatment () const |
The turbulence temperature wall treatment (same for all turbulence walls currently) More... | |
MooseFunctorName | tkeName () const |
The name of the turbulent kinetic energy variable. More... | |
virtual void | act () override final |
void | addBlocks (const std::vector< SubdomainName > &blocks) |
void | addBlocksById (const std::vector< SubdomainID > &block_ids) |
const std::vector< SubdomainName > & | blocks () const |
bool | checkBlockRestrictionIdentical (const std::string &object_name, const std::vector< SubdomainName > &blocks, const bool error_if_not_identical=true) const |
const T * | getCoupledPhysics (const PhysicsName &phys_name, const bool allow_fail=false) const |
const std::vector< T *> | getCoupledPhysics (const bool allow_fail=false) const |
unsigned int | dimension () const |
const ActionComponent & | getActionComponent (const ComponentName &comp_name) const |
void | checkComponentType (const ActionComponent &component) const |
virtual void | addComponent (const ActionComponent &component) |
const std::vector< VariableName > & | solverVariableNames () const |
const std::vector< VariableName > & | auxVariableNames () const |
void | timedAct () |
MooseObjectName | uniqueActionName () const |
const std::string & | specificTaskName () const |
const std::set< std::string > & | getAllTasks () const |
void | appendTask (const std::string &task) |
MooseApp & | getMooseApp () const |
const std::string & | type () const |
virtual const std::string & | name () const |
std::string | typeAndName () const |
std::string | errorPrefix (const std::string &error_type) const |
void | callMooseError (std::string msg, const bool with_prefix) const |
MooseObjectParameterName | uniqueParameterName (const std::string ¶meter_name) const |
const InputParameters & | parameters () const |
MooseObjectName | uniqueName () const |
const T & | getParam (const std::string &name) const |
std::vector< std::pair< T1, T2 > > | getParam (const std::string ¶m1, const std::string ¶m2) const |
const T * | queryParam (const std::string &name) const |
const T & | getRenamedParam (const std::string &old_name, const std::string &new_name) const |
T | getCheckedPointerParam (const std::string &name, const std::string &error_string="") const |
bool | isParamValid (const std::string &name) const |
bool | isParamSetByUser (const std::string &nm) const |
void | paramError (const std::string ¶m, Args... args) const |
void | paramWarning (const std::string ¶m, Args... args) const |
void | paramInfo (const std::string ¶m, Args... args) const |
void | connectControllableParams (const std::string ¶meter, const std::string &object_type, const std::string &object_name, const std::string &object_parameter) const |
void | mooseError (Args &&... args) const |
void | mooseErrorNonPrefixed (Args &&... args) const |
void | mooseDocumentedError (const std::string &repo_name, const unsigned int issue_num, Args &&... args) const |
void | mooseWarning (Args &&... args) const |
void | mooseWarningNonPrefixed (Args &&... args) const |
void | mooseDeprecated (Args &&... args) const |
void | mooseInfo (Args &&... args) const |
std::string | getDataFileName (const std::string ¶m) const |
std::string | getDataFileNameByName (const std::string &relative_path) const |
std::string | getDataFilePath (const std::string &relative_path) const |
PerfGraph & | perfGraph () |
void | assertParamDefined (const std::string &libmesh_dbg_var(param)) const |
const Parallel::Communicator & | comm () const |
processor_id_type | n_processors () const |
processor_id_type | processor_id () const |
const WCNSFVFlowPhysicsBase * | getCoupledFlowPhysics () const |
const WCNSFVTurbulencePhysics * | getCoupledTurbulencePhysics () const |
MooseFunctorName | getPorosityFunctorName (bool smoothed) const |
Return the porosity functor name. More... | |
const MooseFunctorName & | densityName () const |
const MooseFunctorName & | dynamicViscosityName () const |
Static Public Member Functions | |
static InputParameters | validParams () |
Public Attributes | |
const ConsoleStream | _console |
Static Public Attributes | |
static constexpr auto | SYSTEM |
static constexpr auto | NAME |
Protected Member Functions | |
unsigned short | getNumberAlgebraicGhostingLayersNeeded () const override |
Return the number of ghosting layers needed. More... | |
bool | usingNavierStokesFVSyntax () const |
Detects if we are using the new Physics syntax or the old NavierStokesFV action. More... | |
InputParameters | getAdditionalRMParams () const override |
Parameters to change or add relationship managers. More... | |
void | assertParamDefined (const std::string ¶m) const |
bool | isTransient () const |
Factory & | getFactory () |
Factory & | getFactory () const |
virtual FEProblemBase & | getProblem () |
virtual const FEProblemBase & | getProblem () const |
void | prepareCopyVariablesFromMesh () const |
void | copyVariablesFromMesh (const std::vector< VariableName > &variables_to_copy, bool are_nonlinear=true) |
std::string | prefix () const |
void | saveSolverVariableName (const VariableName &var_name) |
void | saveAuxVariableName (const VariableName &var_name) |
bool | variableExists (const VariableName &var_name, bool error_if_aux) const |
bool | solverVariableExists (const VariableName &var_name) const |
const SolverSystemName & | getSolverSystem (unsigned int variable_index) const |
const SolverSystemName & | getSolverSystem (const VariableName &variable_name) const |
void | addRequiredPhysicsTask (const std::string &task) |
void | assignBlocks (InputParameters ¶ms, const std::vector< SubdomainName > &blocks) const |
bool | allMeshBlocks (const std::vector< SubdomainName > &blocks) const |
bool | allMeshBlocks (const std::set< SubdomainName > &blocks) const |
std::set< SubdomainID > | getSubdomainIDs (const std::set< SubdomainName > &blocks) const |
std::vector< std::string > | getSubdomainNamesAndIDs (const std::set< SubdomainID > &blocks) const |
void | addPetscPairsToPetscOptions (const std::vector< std::pair< MooseEnumItem, std::string >> &petsc_pair_options) |
bool | isVariableFV (const VariableName &var_name) const |
bool | isVariableScalar (const VariableName &var_name) const |
bool | shouldCreateVariable (const VariableName &var_name, const std::vector< SubdomainName > &blocks, const bool error_if_aux) |
bool | shouldCreateIC (const VariableName &var_name, const std::vector< SubdomainName > &blocks, const bool ic_is_default_ic, const bool error_if_already_defined) const |
bool | shouldCreateTimeDerivative (const VariableName &var_name, const std::vector< SubdomainName > &blocks, const bool error_if_already_defined) const |
void | reportPotentiallyMissedParameters (const std::vector< std::string > ¶m_names, const std::string &object_type) const |
bool | addRelationshipManagers (Moose::RelationshipManagerType when_type, const InputParameters &moose_object_pars) |
void | associateWithParameter (const std::string ¶m_name, InputParameters ¶ms) const |
void | associateWithParameter (const InputParameters &from_params, const std::string ¶m_name, InputParameters ¶ms) const |
const T & | getMeshProperty (const std::string &data_name, const std::string &prefix) |
const T & | getMeshProperty (const std::string &data_name) |
bool | hasMeshProperty (const std::string &data_name, const std::string &prefix) const |
bool | hasMeshProperty (const std::string &data_name, const std::string &prefix) const |
bool | hasMeshProperty (const std::string &data_name) const |
bool | hasMeshProperty (const std::string &data_name) const |
std::string | meshPropertyName (const std::string &data_name) const |
PerfID | registerTimedSection (const std::string §ion_name, const unsigned int level) const |
PerfID | registerTimedSection (const std::string §ion_name, const unsigned int level, const std::string &live_message, const bool print_dots=true) const |
std::string | timedSectionName (const std::string §ion_name) const |
void | checkParamsBothSetOrNotSet (const std::string ¶m1, const std::string ¶m2) const |
void | checkSecondParamSetOnlyIfFirstOneTrue (const std::string ¶m1, const std::string ¶m2) const |
void | checkSecondParamSetOnlyIfFirstOneSet (const std::string ¶m1, const std::string ¶m2) const |
void | checkSecondParamNotSetIfFirstOneSet (const std::string ¶m1, const std::string ¶m2) const |
void | checkVectorParamsSameLength (const std::string ¶m1, const std::string ¶m2) const |
void | checkVectorParamAndMultiMooseEnumLength (const std::string ¶m1, const std::string ¶m2) const |
void | checkTwoDVectorParamsSameLength (const std::string ¶m1, const std::string ¶m2) const |
void | checkVectorParamsNoOverlap (const std::vector< std::string > ¶m_vecs) const |
void | checkTwoDVectorParamsNoRespectiveOverlap (const std::vector< std::string > ¶m_vecs) const |
void | checkTwoDVectorParamInnerSameLengthAsOneDVector (const std::string ¶m1, const std::string ¶m2) const |
void | checkTwoDVectorParamMultiMooseEnumSameLength (const std::string ¶m1, const std::string ¶m2, const bool error_for_param2) const |
void | checkVectorParamNotEmpty (const std::string ¶m1) const |
void | checkVectorParamsSameLengthIfSet (const std::string ¶m1, const std::string ¶m2, const bool ignore_empty_default_param2=false) const |
void | checkVectorParamLengthSameAsCombinedOthers (const std::string ¶m1, const std::string ¶m2, const std::string ¶m3) const |
void | checkBlockwiseConsistency (const std::string &block_param_name, const std::vector< std::string > ¶meter_names) const |
bool | parameterConsistent (const InputParameters &other_param, const std::string ¶m_name) const |
void | warnInconsistent (const InputParameters ¶meters, const std::string ¶m_name) const |
void | errorDependentParameter (const std::string ¶m1, const std::string &value_not_set, const std::vector< std::string > &dependent_params) const |
void | errorInconsistentDependentParameter (const std::string ¶m1, const std::string &value_set, const std::vector< std::string > &dependent_params) const |
Static Protected Member Functions | |
static std::string | meshPropertyName (const std::string &data_name, const std::string &prefix) |
Protected Attributes | |
bool | _define_variables |
Whether to define variables if they do not exist. More... | |
std::vector< SolverSystemName > | _system_names |
std::vector< unsigned int > | _system_numbers |
const bool | _verbose |
const MooseEnum & | _preconditioning |
std::vector< SubdomainName > | _blocks |
std::string | _registered_identifier |
std::string | _specific_task_name |
std::set< std::string > | _all_tasks |
ActionWarehouse & | _awh |
const std::string & | _current_task |
std::shared_ptr< MooseMesh > & | _mesh |
std::shared_ptr< MooseMesh > & | _displaced_mesh |
std::shared_ptr< FEProblemBase > & | _problem |
PerfID | _act_timer |
MooseApp & | _app |
const std::string | _type |
const std::string | _name |
const InputParameters & | _pars |
Factory & | _factory |
ActionFactory & | _action_factory |
MooseApp & | _pg_moose_app |
const std::string | _prefix |
const Parallel::Communicator & | _communicator |
const NavierStokesPhysicsBase * | _advection_physics |
The Physics class using this helper. More... | |
const WCNSFVFlowPhysicsBase * | _flow_equations_physics |
Flow physics. More... | |
const WCNSFVTurbulencePhysics * | _turbulence_physics |
Turbulence. More... | |
const MooseEnum | _compressibility |
Compressibility type, can be compressible, incompressible or weakly-compressible. More... | |
const bool | _porous_medium_treatment |
Switch to show if porous medium treatment is requested or not. More... | |
const std::vector< std::string > | _velocity_names |
Velocity names. More... | |
const NonlinearVariableName | _pressure_name |
Pressure name. More... | |
const MooseFunctorName | _density_name |
Name of the density material property. More... | |
const MooseFunctorName | _dynamic_viscosity_name |
Name of the dynamic viscosity material property. More... | |
const MooseEnum | _velocity_interpolation |
The velocity / momentum face interpolation method for advecting other quantities. More... | |
Private Member Functions | |
virtual void | initializePhysicsAdditional () override |
virtual void | actOnAdditionalTasks () override |
void | retrieveCoupledPhysics () |
Retrieve the other WCNSFVPhysics at play in the simulation to be able to add the relevant terms (turbulent diffusion notably) More... | |
virtual void | addSolverVariables () override |
virtual void | addAuxiliaryVariables () override |
virtual void | addFVKernels () override |
virtual void | addFVBCs () override |
virtual void | addInitialConditions () override |
virtual void | addAuxiliaryKernels () override |
virtual void | addMaterials () override |
void | addFlowTurbulenceKernels () |
Functions adding kernels for turbulence in the other equation(s) More... | |
void | addFluidEnergyTurbulenceKernels () |
void | addScalarAdvectionTurbulenceKernels () |
void | addKEpsilonTimeDerivatives () |
Functions adding kernels for the k-epsilon to the k-epsilon equations. More... | |
void | addKEpsilonAdvection () |
void | addKEpsilonDiffusion () |
void | addKEpsilonSink () |
Private Attributes | |
const MooseEnum | _turbulence_model |
Turbulence model to create the equation(s) for. More... | |
bool | _has_flow_equations |
bool | _has_energy_equation |
bool | _has_scalar_equations |
const WCNSFVFluidHeatTransferPhysics * | _fluid_energy_physics |
The heat advection physics to add turbulent mixing for. More... | |
const WCNSFVScalarTransportPhysics * | _scalar_transport_physics |
The scalar advection physics to add turbulent mixing for. More... | |
const VariableName | _mixing_length_name |
Name of the mixing length auxiliary variable. More... | |
std::vector< BoundaryName > | _turbulence_walls |
List of boundaries to act as walls for turbulence models. More... | |
MooseEnum | _wall_treatment_eps |
Turbulence wall treatment for epsilon (same for all walls currently) More... | |
MooseEnum | _wall_treatment_temp |
Turbulence wall treatment for temperature (same for all walls currently) More... | |
const VariableName | _tke_name |
Name of the turbulent kinetic energy. More... | |
const VariableName | _tked_name |
Name of the turbulent kinetic energy dissipation. More... | |
const VariableName | _turbulent_viscosity_name = NS::mu_t |
Name of the turbulence viscosity auxiliary variable (or property) More... | |
Creates all the objects needed to add a turbulence model to an incompressible / weakly-compressible Navier Stokes finite volume flow simulation.
Definition at line 23 of file WCNSFVTurbulencePhysics.h.
WCNSFVTurbulencePhysics::WCNSFVTurbulencePhysics | ( | const InputParameters & | parameters | ) |
Definition at line 187 of file WCNSFVTurbulencePhysics.C.
|
overrideprivatevirtual |
Reimplemented from PhysicsBase.
Definition at line 253 of file WCNSFVTurbulencePhysics.C.
|
overrideprivatevirtual |
Reimplemented from PhysicsBase.
Definition at line 730 of file WCNSFVTurbulencePhysics.C.
|
overrideprivatevirtual |
Reimplemented from PhysicsBase.
Definition at line 385 of file WCNSFVTurbulencePhysics.C.
|
private |
Functions adding kernels for turbulence in the other equation(s)
Definition at line 448 of file WCNSFVTurbulencePhysics.C.
Referenced by addFVKernels().
|
private |
Definition at line 517 of file WCNSFVTurbulencePhysics.C.
Referenced by addFVKernels().
|
overrideprivatevirtual |
Reimplemented from PhysicsBase.
Definition at line 791 of file WCNSFVTurbulencePhysics.C.
|
overrideprivatevirtual |
Reimplemented from PhysicsBase.
Definition at line 423 of file WCNSFVTurbulencePhysics.C.
|
overrideprivatevirtual |
Reimplemented from PhysicsBase.
Definition at line 818 of file WCNSFVTurbulencePhysics.C.
|
private |
Definition at line 622 of file WCNSFVTurbulencePhysics.C.
Referenced by addFVKernels().
|
private |
Definition at line 647 of file WCNSFVTurbulencePhysics.C.
Referenced by addFVKernels().
|
private |
Definition at line 683 of file WCNSFVTurbulencePhysics.C.
Referenced by addFVKernels().
|
private |
Functions adding kernels for the k-epsilon to the k-epsilon equations.
Definition at line 607 of file WCNSFVTurbulencePhysics.C.
Referenced by addFVKernels().
|
overrideprivatevirtual |
Reimplemented from PhysicsBase.
Definition at line 885 of file WCNSFVTurbulencePhysics.C.
|
private |
Definition at line 555 of file WCNSFVTurbulencePhysics.C.
Referenced by addFVKernels().
|
overrideprivatevirtual |
Reimplemented from PhysicsBase.
Definition at line 333 of file WCNSFVTurbulencePhysics.C.
|
inlineinherited |
Definition at line 36 of file WCNSFVCoupledAdvectionPhysicsHelper.h.
Referenced by WCNSFVTwoPhaseMixturePhysics::WCNSFVTwoPhaseMixturePhysics(), and WCNSLinearFVTwoPhaseMixturePhysics::WCNSLinearFVTwoPhaseMixturePhysics().
|
inlineinherited |
Definition at line 37 of file WCNSFVCoupledAdvectionPhysicsHelper.h.
|
overrideprotectedvirtualinherited |
Parameters to change or add relationship managers.
Reimplemented from PhysicsBase.
Definition at line 42 of file NavierStokesPhysicsBase.C.
|
inherited |
Definition at line 53 of file WCNSFVCoupledAdvectionPhysicsHelper.C.
|
inherited |
Definition at line 77 of file WCNSFVCoupledAdvectionPhysicsHelper.C.
Referenced by WCNSFVFluidHeatTransferPhysicsBase::actOnAdditionalTasks().
|
overrideprotectedvirtual |
Return the number of ghosting layers needed.
Implements NavierStokesPhysicsBase.
Definition at line 997 of file WCNSFVTurbulencePhysics.C.
|
inherited |
Return the porosity functor name.
It is important to forward to the Physics so we do not get the smoothing status wrong
Definition at line 47 of file WCNSFVCoupledAdvectionPhysicsHelper.C.
|
inline |
Whether a turbulence model is in use.
Definition at line 32 of file WCNSFVTurbulencePhysics.h.
Referenced by WCNSFVFlowPhysicsBase::hasTurbulencePhysics().
|
overrideprivatevirtual |
Reimplemented from PhysicsBase.
Definition at line 246 of file WCNSFVTurbulencePhysics.C.
|
private |
Retrieve the other WCNSFVPhysics at play in the simulation to be able to add the relevant terms (turbulent diffusion notably)
Definition at line 262 of file WCNSFVTurbulencePhysics.C.
Referenced by actOnAdditionalTasks().
|
inline |
The name of the turbulent kinetic energy variable.
Definition at line 40 of file WCNSFVTurbulencePhysics.h.
Referenced by WCNSFVFluidHeatTransferPhysics::addEnergyWallBC().
|
inline |
The turbulence epsilon wall treatment (same for all turbulence walls currently)
Definition at line 36 of file WCNSFVTurbulencePhysics.h.
|
inline |
The turbulence temperature wall treatment (same for all turbulence walls currently)
Definition at line 38 of file WCNSFVTurbulencePhysics.h.
Referenced by WCNSFVFluidHeatTransferPhysics::addEnergyWallBC().
|
inline |
The names of the boundaries with turbulence wall functions.
Definition at line 34 of file WCNSFVTurbulencePhysics.h.
Referenced by WCNSFVFluidHeatTransferPhysics::addEnergyWallBC().
|
inlineprotectedinherited |
Detects if we are using the new Physics syntax or the old NavierStokesFV action.
Definition at line 32 of file NavierStokesPhysicsBase.h.
|
static |
Definition at line 30 of file WCNSFVTurbulencePhysics.C.
|
protectedinherited |
The Physics class using this helper.
Definition at line 41 of file WCNSFVCoupledAdvectionPhysicsHelper.h.
Referenced by WCNSFVCoupledAdvectionPhysicsHelper::getCoupledFlowPhysics(), and WCNSFVCoupledAdvectionPhysicsHelper::getCoupledTurbulencePhysics().
|
protectedinherited |
Compressibility type, can be compressible, incompressible or weakly-compressible.
Definition at line 48 of file WCNSFVCoupledAdvectionPhysicsHelper.h.
Referenced by WCNSFVFluidHeatTransferPhysics::addEnergyTimeKernels().
|
protectedinherited |
Whether to define variables if they do not exist.
Definition at line 44 of file NavierStokesPhysicsBase.h.
Referenced by WCNSLinearFVFluidHeatTransferPhysics::addAuxiliaryVariables(), addAuxiliaryVariables(), addInitialConditions(), WCNSFVFluidHeatTransferPhysicsBase::addInitialConditions(), WCNSFVScalarTransportPhysicsBase::addInitialConditions(), WCNSFVFlowPhysicsBase::addInitialConditions(), WCNSFVFluidHeatTransferPhysics::addSolverVariables(), WCNSLinearFVFluidHeatTransferPhysics::addSolverVariables(), WCNSFVFlowPhysics::addSolverVariables(), WCNSLinearFVFlowPhysics::addSolverVariables(), addSolverVariables(), and WCNSFVFlowPhysicsBase::WCNSFVFlowPhysicsBase().
|
protectedinherited |
Name of the density material property.
Definition at line 59 of file WCNSFVCoupledAdvectionPhysicsHelper.h.
Referenced by WCNSFVFluidHeatTransferPhysics::addEnergyInletBC(), WCNSFVFluidHeatTransferPhysics::addEnergyTimeKernels(), WCNSLinearFVFluidHeatTransferPhysics::addEnergyTimeKernels(), WCNSFVFluidHeatTransferPhysics::addEnergyWallBC(), addFlowTurbulenceKernels(), addFluidEnergyTurbulenceKernels(), addMaterials(), WCNSFVFluidHeatTransferPhysicsBase::addMaterials(), WCNSFVScalarTransportPhysics::addScalarInletBC(), and WCNSFVCoupledAdvectionPhysicsHelper::densityName().
|
protectedinherited |
Name of the dynamic viscosity material property.
Definition at line 61 of file WCNSFVCoupledAdvectionPhysicsHelper.h.
Referenced by WCNSFVFluidHeatTransferPhysics::addEnergyWallBC(), addMaterials(), and WCNSFVCoupledAdvectionPhysicsHelper::dynamicViscosityName().
|
protectedinherited |
Flow physics.
Definition at line 43 of file WCNSFVCoupledAdvectionPhysicsHelper.h.
Referenced by WCNSFVTwoPhaseMixturePhysics::addAdvectionSlipTerm(), addAuxiliaryKernels(), WCNSFVFluidHeatTransferPhysics::addEnergyAdvectionKernels(), WCNSLinearFVFluidHeatTransferPhysics::addEnergyAdvectionKernels(), WCNSFVFluidHeatTransferPhysics::addEnergyHeatConductionKernels(), WCNSFVFluidHeatTransferPhysics::addEnergyInletBC(), WCNSLinearFVFluidHeatTransferPhysics::addEnergyInletBC(), WCNSLinearFVFluidHeatTransferPhysics::addEnergyOutletBC(), WCNSFVFluidHeatTransferPhysics::addEnergySeparatorBC(), WCNSFVFluidHeatTransferPhysics::addEnergyTimeKernels(), WCNSLinearFVFluidHeatTransferPhysics::addEnergyWallBC(), WCNSFVFluidHeatTransferPhysics::addEnergyWallBC(), addFlowTurbulenceKernels(), addFluidEnergyTurbulenceKernels(), addFVBCs(), WCNSLinearFVTwoPhaseMixturePhysics::addFVKernels(), WCNSFVTwoPhaseMixturePhysics::addFVKernels(), addInitialConditions(), addKEpsilonAdvection(), addKEpsilonDiffusion(), addKEpsilonSink(), WCNSLinearFVTwoPhaseMixturePhysics::addMaterials(), WCNSFVTwoPhaseMixturePhysics::addMaterials(), addMaterials(), WCNSFVFluidHeatTransferPhysicsBase::addMaterials(), WCNSLinearFVTwoPhaseMixturePhysics::addPhaseDriftFluxTerm(), WCNSFVTwoPhaseMixturePhysics::addPhaseDriftFluxTerm(), WCNSLinearFVScalarTransportPhysics::addScalarAdvectionKernels(), WCNSFVScalarTransportPhysics::addScalarAdvectionKernels(), WCNSLinearFVScalarTransportPhysics::addScalarInletBC(), WCNSFVScalarTransportPhysics::addScalarInletBC(), WCNSLinearFVScalarTransportPhysics::addScalarOutletBC(), WCNSLinearFVTwoPhaseMixturePhysics::checkIntegrity(), getNumberAlgebraicGhostingLayersNeeded(), WCNSFVFluidHeatTransferPhysicsBase::getNumberAlgebraicGhostingLayersNeeded(), WCNSFVScalarTransportPhysicsBase::getNumberAlgebraicGhostingLayersNeeded(), WCNSFVCoupledAdvectionPhysicsHelper::getPorosityFunctorName(), retrieveCoupledPhysics(), WCNSFVFluidHeatTransferPhysicsBase::WCNSFVFluidHeatTransferPhysicsBase(), WCNSFVTwoPhaseMixturePhysics::WCNSFVTwoPhaseMixturePhysics(), WCNSLinearFVScalarTransportPhysics::WCNSLinearFVScalarTransportPhysics(), and WCNSLinearFVTwoPhaseMixturePhysics::WCNSLinearFVTwoPhaseMixturePhysics().
|
private |
The heat advection physics to add turbulent mixing for.
Definition at line 83 of file WCNSFVTurbulencePhysics.h.
Referenced by addAuxiliaryKernels(), addFluidEnergyTurbulenceKernels(), addMaterials(), and retrieveCoupledPhysics().
|
private |
Definition at line 79 of file WCNSFVTurbulencePhysics.h.
Referenced by addAuxiliaryKernels(), addFVKernels(), addMaterials(), and retrieveCoupledPhysics().
|
private |
Definition at line 78 of file WCNSFVTurbulencePhysics.h.
Referenced by addFVKernels(), and retrieveCoupledPhysics().
|
private |
Definition at line 80 of file WCNSFVTurbulencePhysics.h.
Referenced by addFVKernels(), addMaterials(), and retrieveCoupledPhysics().
|
private |
Name of the mixing length auxiliary variable.
Definition at line 89 of file WCNSFVTurbulencePhysics.h.
Referenced by addAuxiliaryKernels(), addAuxiliaryVariables(), addFlowTurbulenceKernels(), addFluidEnergyTurbulenceKernels(), addMaterials(), addScalarAdvectionTurbulenceKernels(), and WCNSFVTurbulencePhysics().
|
protectedinherited |
Switch to show if porous medium treatment is requested or not.
Definition at line 51 of file WCNSFVCoupledAdvectionPhysicsHelper.h.
Referenced by WCNSFVFluidHeatTransferPhysics::addEnergyAdvectionKernels(), WCNSFVFluidHeatTransferPhysics::addEnergyHeatConductionKernels(), WCNSFVFluidHeatTransferPhysics::addEnergyTimeKernels(), addFlowTurbulenceKernels(), addFluidEnergyTurbulenceKernels(), WCNSFVScalarTransportPhysics::addScalarAdvectionKernels(), WCNSFVFluidHeatTransferPhysicsBase::processThermalConductivity(), WCNSLinearFVFluidHeatTransferPhysics::WCNSLinearFVFluidHeatTransferPhysics(), and WCNSLinearFVScalarTransportPhysics::WCNSLinearFVScalarTransportPhysics().
|
protectedinherited |
Pressure name.
Definition at line 56 of file WCNSFVCoupledAdvectionPhysicsHelper.h.
|
private |
The scalar advection physics to add turbulent mixing for.
Definition at line 85 of file WCNSFVTurbulencePhysics.h.
Referenced by addScalarAdvectionTurbulenceKernels(), and retrieveCoupledPhysics().
|
private |
Name of the turbulent kinetic energy.
Definition at line 97 of file WCNSFVTurbulencePhysics.h.
Referenced by addAuxiliaryKernels(), addAuxiliaryVariables(), addFVBCs(), addInitialConditions(), addKEpsilonAdvection(), addKEpsilonDiffusion(), addKEpsilonSink(), addKEpsilonTimeDerivatives(), addMaterials(), addSolverVariables(), tkeName(), and WCNSFVTurbulencePhysics().
|
private |
Name of the turbulent kinetic energy dissipation.
Definition at line 99 of file WCNSFVTurbulencePhysics.h.
Referenced by addAuxiliaryKernels(), addInitialConditions(), addKEpsilonAdvection(), addKEpsilonDiffusion(), addKEpsilonSink(), addKEpsilonTimeDerivatives(), addMaterials(), addSolverVariables(), and WCNSFVTurbulencePhysics().
|
private |
Turbulence model to create the equation(s) for.
Definition at line 76 of file WCNSFVTurbulencePhysics.h.
Referenced by addAuxiliaryKernels(), addAuxiliaryVariables(), addFlowTurbulenceKernels(), addFluidEnergyTurbulenceKernels(), addFVBCs(), addFVKernels(), addInitialConditions(), addMaterials(), addScalarAdvectionTurbulenceKernels(), addSolverVariables(), getNumberAlgebraicGhostingLayersNeeded(), hasTurbulenceModel(), initializePhysicsAdditional(), retrieveCoupledPhysics(), and WCNSFVTurbulencePhysics().
|
protectedinherited |
Turbulence.
Definition at line 45 of file WCNSFVCoupledAdvectionPhysicsHelper.h.
Referenced by WCNSFVFluidHeatTransferPhysicsBase::actOnAdditionalTasks(), and WCNSFVFluidHeatTransferPhysics::addEnergyWallBC().
|
private |
List of boundaries to act as walls for turbulence models.
Definition at line 91 of file WCNSFVTurbulencePhysics.h.
Referenced by addAuxiliaryKernels(), addFVBCs(), addKEpsilonAdvection(), addKEpsilonDiffusion(), addKEpsilonSink(), and turbulenceWalls().
|
private |
Name of the turbulence viscosity auxiliary variable (or property)
Definition at line 101 of file WCNSFVTurbulencePhysics.h.
Referenced by addAuxiliaryKernels(), addAuxiliaryVariables(), addFlowTurbulenceKernels(), addFVBCs(), addInitialConditions(), addKEpsilonDiffusion(), addKEpsilonSink(), addMaterials(), and WCNSFVTurbulencePhysics().
|
protectedinherited |
The velocity / momentum face interpolation method for advecting other quantities.
Definition at line 64 of file WCNSFVCoupledAdvectionPhysicsHelper.h.
Referenced by WCNSFVFluidHeatTransferPhysics::addEnergyAdvectionKernels(), addKEpsilonAdvection(), and WCNSFVScalarTransportPhysics::addScalarAdvectionKernels().
|
protectedinherited |
Velocity names.
Definition at line 54 of file WCNSFVCoupledAdvectionPhysicsHelper.h.
Referenced by addAuxiliaryKernels(), WCNSFVFluidHeatTransferPhysics::addEnergyInletBC(), WCNSFVFluidHeatTransferPhysics::addEnergyWallBC(), addFlowTurbulenceKernels(), addFluidEnergyTurbulenceKernels(), addFVBCs(), addKEpsilonSink(), addMaterials(), addScalarAdvectionTurbulenceKernels(), and WCNSFVScalarTransportPhysics::addScalarInletBC().
|
private |
Turbulence wall treatment for epsilon (same for all walls currently)
Definition at line 93 of file WCNSFVTurbulencePhysics.h.
Referenced by addAuxiliaryKernels(), addFVBCs(), addKEpsilonSink(), and turbulenceEpsilonWallTreatment().
|
private |
Turbulence wall treatment for temperature (same for all walls currently)
Definition at line 95 of file WCNSFVTurbulencePhysics.h.
Referenced by turbulenceTemperatureWallTreatment().