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

Creates all the objects needed to solve the Navier Stokes energy equation. More...

#include <WCNSFVFluidHeatTransferPhysicsBase.h>

Inheritance diagram for WCNSFVFluidHeatTransferPhysicsBase:
[legend]

Public Types

typedef DataFileName DataFileParameterType
 

Public Member Functions

 WCNSFVFluidHeatTransferPhysicsBase (const InputParameters &parameters)
 
const VariableName & getFluidTemperatureName () const
 Get the name of the fluid temperature variable. More...
 
const MooseFunctorName & getSpecificHeatName () const
 Get the name of the specific heat material property. More...
 
MooseFunctorName getSpecificEnthalpyName () const
 
const std::vector< MooseFunctorName > & getThermalConductivityName () const
 
const std::vector< std::vector< SubdomainName > > & getAmbientConvectionBlocks () const
 Get the ambient convection parameters for parameter checking. More...
 
const std::vector< MooseFunctorName > & getAmbientConvectionHTCs () const
 Name of the ambient convection heat transfer coefficients for each block-group. More...
 
bool hasEnergyEquation () const
 Whether the physics is actually creating the heat equation. 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 ActionComponentgetActionComponent (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)
 
MooseAppgetMooseApp () 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 &parameter_name) const
 
const InputParametersparameters () const
 
MooseObjectName uniqueName () 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 &nm) const
 
void paramError (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
 
void connectControllableParams (const std::string &parameter, 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 &param) const
 
std::string getDataFileNameByName (const std::string &relative_path) const
 
std::string getDataFilePath (const std::string &relative_path) const
 
PerfGraphperfGraph ()
 
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 WCNSFVFlowPhysicsBasegetCoupledFlowPhysics () const
 
const WCNSFVTurbulencePhysicsgetCoupledTurbulencePhysics () 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

void actOnAdditionalTasks () override
 
void addInitialConditions () override
 
void addFVKernels () override
 
void addFVBCs () override
 
void addMaterials () override
 
unsigned short getNumberAlgebraicGhostingLayersNeeded () const override
 Return the number of ghosting layers needed. More...
 
virtual void addEnergyTimeKernels ()=0
 Functions adding kernels for the incompressible / weakly compressible energy equation. More...
 
virtual void addEnergyHeatConductionKernels ()=0
 
virtual void addEnergyAdvectionKernels ()=0
 
virtual void addEnergyAmbientConvection ()=0
 
virtual void addEnergyExternalHeatSource ()=0
 
virtual void addEnergyInletBC ()=0
 Functions adding boundary conditions for the fluid heat transfer equation. More...
 
virtual void addEnergyWallBC ()=0
 
virtual void addEnergyOutletBC ()=0
 
virtual void addEnergySeparatorBC ()=0
 
bool processThermalConductivity ()
 Process thermal conductivity (multiple functor input options are available). 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 &param) const
 
bool isTransient () const
 
FactorygetFactory ()
 
FactorygetFactory () const
 
virtual FEProblemBasegetProblem ()
 
virtual const FEProblemBasegetProblem () 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 &params, const std::vector< SubdomainName > &blocks) const
 
bool allMeshBlocks (const std::vector< SubdomainName > &blocks) const
 
bool allMeshBlocks (const std::set< SubdomainName > &blocks) const
 
std::set< SubdomainIDgetSubdomainIDs (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 > &param_names, const std::string &object_type) const
 
bool addRelationshipManagers (Moose::RelationshipManagerType when_type, const InputParameters &moose_object_pars)
 
void associateWithParameter (const std::string &param_name, InputParameters &params) const
 
void associateWithParameter (const InputParameters &from_params, const std::string &param_name, InputParameters &params) 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 &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
 
void checkParamsBothSetOrNotSet (const std::string &param1, const std::string &param2) const
 
void checkSecondParamSetOnlyIfFirstOneTrue (const std::string &param1, const std::string &param2) const
 
void checkSecondParamSetOnlyIfFirstOneSet (const std::string &param1, const std::string &param2) const
 
void checkSecondParamNotSetIfFirstOneSet (const std::string &param1, const std::string &param2) const
 
void checkVectorParamsSameLength (const std::string &param1, const std::string &param2) const
 
void checkVectorParamAndMultiMooseEnumLength (const std::string &param1, const std::string &param2) const
 
void checkTwoDVectorParamsSameLength (const std::string &param1, const std::string &param2) const
 
void checkVectorParamsNoOverlap (const std::vector< std::string > &param_vecs) const
 
void checkTwoDVectorParamsNoRespectiveOverlap (const std::vector< std::string > &param_vecs) const
 
void checkTwoDVectorParamInnerSameLengthAsOneDVector (const std::string &param1, const std::string &param2) const
 
void checkTwoDVectorParamMultiMooseEnumSameLength (const std::string &param1, const std::string &param2, const bool error_for_param2) const
 
void checkVectorParamNotEmpty (const std::string &param1) const
 
void checkVectorParamsSameLengthIfSet (const std::string &param1, const std::string &param2, const bool ignore_empty_default_param2=false) const
 
void checkVectorParamLengthSameAsCombinedOthers (const std::string &param1, const std::string &param2, const std::string &param3) const
 
void checkBlockwiseConsistency (const std::string &block_param_name, const std::vector< std::string > &parameter_names) const
 
bool parameterConsistent (const InputParameters &other_param, const std::string &param_name) const
 
void warnInconsistent (const InputParameters &parameters, const std::string &param_name) const
 
void errorDependentParameter (const std::string &param1, const std::string &value_not_set, const std::vector< std::string > &dependent_params) const
 
void errorInconsistentDependentParameter (const std::string &param1, 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

const bool _has_energy_equation
 A boolean to help compatibility with the old Modules/NavierStokesFV syntax. More...
 
const bool _solve_for_enthalpy
 User-selected option to solve for enthalpy. More...
 
const VariableName _fluid_enthalpy_name
 Name of the fluid specific enthalpy. More...
 
VariableName _fluid_temperature_name
 Fluid temperature name. More...
 
MooseFunctorName _specific_heat_name
 Name of the specific heat material property. More...
 
std::vector< std::vector< SubdomainName > > _thermal_conductivity_blocks
 Vector of subdomain groups where we want to have different thermal conduction. More...
 
std::vector< MooseFunctorName > _thermal_conductivity_name
 Name of the thermal conductivity functor for each block-group. More...
 
std::vector< std::vector< SubdomainName > > _ambient_convection_blocks
 Vector of subdomain groups where we want to have different ambient convection. More...
 
std::vector< MooseFunctorName > _ambient_convection_alpha
 Name of the ambient convection heat transfer coefficients for each block-group. More...
 
std::vector< MooseFunctorName > _ambient_temperature
 Name of the solid domain temperature for each block-group. More...
 
MultiMooseEnum _energy_inlet_types
 Energy inlet boundary types. More...
 
std::vector< MooseFunctorName > _energy_inlet_functors
 Functors describing the inlet boundary values. See energy_inlet_types for what the functors actually represent. More...
 
MultiMooseEnum _energy_wall_types
 Energy wall boundary types. More...
 
std::vector< MooseFunctorName > _energy_wall_functors
 Functors describing the wall boundary values. See energy_wall_types for what the functors actually represent. More...
 
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...
 

Detailed Description

Creates all the objects needed to solve the Navier Stokes energy equation.

Definition at line 27 of file WCNSFVFluidHeatTransferPhysicsBase.h.

Constructor & Destructor Documentation

◆ WCNSFVFluidHeatTransferPhysicsBase()

WCNSFVFluidHeatTransferPhysicsBase::WCNSFVFluidHeatTransferPhysicsBase ( const InputParameters parameters)

Definition at line 64 of file WCNSFVFluidHeatTransferPhysicsBase.C.

69  isParamValid("add_energy_equation")
70  ? getParam<bool>("add_energy_equation")
71  : (usingNavierStokesFVSyntax() ? isParamSetByUser("energy_inlet_function") : true)),
72  _solve_for_enthalpy(getParam<bool>("solve_for_enthalpy")),
74  _fluid_temperature_name(getParam<NonlinearVariableName>("fluid_temperature_variable")),
75  _specific_heat_name(getParam<MooseFunctorName>("specific_heat")),
77  parameters.isParamValid("thermal_conductivity_blocks")
78  ? getParam<std::vector<std::vector<SubdomainName>>>("thermal_conductivity_blocks")
79  : std::vector<std::vector<SubdomainName>>()),
80  _thermal_conductivity_name(getParam<std::vector<MooseFunctorName>>("thermal_conductivity")),
82  getParam<std::vector<std::vector<SubdomainName>>>("ambient_convection_blocks")),
83  _ambient_convection_alpha(getParam<std::vector<MooseFunctorName>>("ambient_convection_alpha")),
84  _ambient_temperature(getParam<std::vector<MooseFunctorName>>("ambient_temperature")),
85  _energy_inlet_types(getParam<MultiMooseEnum>("energy_inlet_types")),
86  _energy_inlet_functors(getParam<std::vector<MooseFunctorName>>("energy_inlet_functors")),
87  _energy_wall_types(getParam<MultiMooseEnum>("energy_wall_types")),
88  _energy_wall_functors(getParam<std::vector<MooseFunctorName>>("energy_wall_functors"))
89 {
90  // For compatibility with Modules/NavierStokesFV syntax
92  return;
93 
96  else
98 
99  // set block restrictions if not set by user
100  // This should probably be done for all the coupled physics, tbd
101  if (!isParamSetByUser("block"))
103 
104  // Parameter checks
105  checkSecondParamSetOnlyIfFirstOneTrue("solve_for_enthalpy", "initial_enthalpy");
106  checkVectorParamsSameLengthIfSet<MooseFunctorName, MooseFunctorName>("ambient_convection_alpha",
107  "ambient_temperature");
108  checkSecondParamSetOnlyIfFirstOneSet("external_heat_source", "external_heat_source_coeff");
109 
110  // Check boundary parameters if provided.
111  // The boundaries are checked again when the boundary conditions are added as we want
112  // to be able to more boundary conditions to a Physics dynamically
113  if (isParamValid("energy_inlet_types"))
114  checkVectorParamAndMultiMooseEnumLength<MooseFunctorName>("energy_inlet_functors",
115  "energy_inlet_types");
116  if (isParamSetByUser("energy_wall_boundaries"))
117  checkVectorParamsSameLengthIfSet<BoundaryName, MooseFunctorName>(
118  "energy_wall_boundaries", "energy_wall_functors", false);
119  if (isParamValid("energy_wall_types"))
120  checkVectorParamAndMultiMooseEnumLength<MooseFunctorName>("energy_wall_functors",
121  "energy_wall_types");
122 }
MooseFunctorName _specific_heat_name
Name of the specific heat material property.
std::vector< MooseFunctorName > _ambient_temperature
Name of the solid domain temperature for each block-group.
const std::vector< SubdomainName > & blocks() const
WCNSFVCoupledAdvectionPhysicsHelper(const NavierStokesPhysicsBase *derived_physics)
VariableName _fluid_temperature_name
Fluid temperature name.
std::vector< std::vector< SubdomainName > > _ambient_convection_blocks
Vector of subdomain groups where we want to have different ambient convection.
MultiMooseEnum _energy_wall_types
Energy wall boundary types.
std::vector< SubdomainName > _blocks
std::vector< MooseFunctorName > _energy_wall_functors
Functors describing the wall boundary values. See energy_wall_types for what the functors actually re...
bool isParamValid(const std::string &name) const
MultiMooseEnum _energy_inlet_types
Energy inlet boundary types.
void checkSecondParamSetOnlyIfFirstOneSet(const std::string &param1, const std::string &param2) const
const T & getParam(const std::string &name) const
NavierStokesPhysicsBase(const InputParameters &parameters)
const VariableName _fluid_enthalpy_name
Name of the fluid specific enthalpy.
const bool _has_energy_equation
A boolean to help compatibility with the old Modules/NavierStokesFV syntax.
std::vector< std::vector< SubdomainName > > _thermal_conductivity_blocks
Vector of subdomain groups where we want to have different thermal conduction.
bool isParamSetByUser(const std::string &nm) const
std::vector< MooseFunctorName > _energy_inlet_functors
Functors describing the inlet boundary values. See energy_inlet_types for what the functors actually ...
std::vector< MooseFunctorName > _thermal_conductivity_name
Name of the thermal conductivity functor for each block-group.
const bool _solve_for_enthalpy
User-selected option to solve for enthalpy.
const InputParameters & parameters() const
std::vector< MooseFunctorName > _ambient_convection_alpha
Name of the ambient convection heat transfer coefficients for each block-group.
void checkSecondParamSetOnlyIfFirstOneTrue(const std::string &param1, const std::string &param2) const
void saveSolverVariableName(const VariableName &var_name)
const WCNSFVFlowPhysicsBase * _flow_equations_physics
Flow physics.
bool usingNavierStokesFVSyntax() const
Detects if we are using the new Physics syntax or the old NavierStokesFV action.
bool isParamValid(const std::string &name) const

Member Function Documentation

◆ actOnAdditionalTasks()

void WCNSFVFluidHeatTransferPhysicsBase::actOnAdditionalTasks ( )
overrideprotectedvirtual

Reimplemented from PhysicsBase.

Definition at line 159 of file WCNSFVFluidHeatTransferPhysicsBase.C.

160 {
161  // Turbulence physics would not be initialized before this task
162  if (_current_task == "get_turbulence_physics")
164 }
const WCNSFVTurbulencePhysics * _turbulence_physics
Turbulence.
const std::string & _current_task
const WCNSFVTurbulencePhysics * getCoupledTurbulencePhysics() const

◆ addEnergyAdvectionKernels()

virtual void WCNSFVFluidHeatTransferPhysicsBase::addEnergyAdvectionKernels ( )
protectedpure virtual

◆ addEnergyAmbientConvection()

virtual void WCNSFVFluidHeatTransferPhysicsBase::addEnergyAmbientConvection ( )
protectedpure virtual

◆ addEnergyExternalHeatSource()

virtual void WCNSFVFluidHeatTransferPhysicsBase::addEnergyExternalHeatSource ( )
protectedpure virtual

◆ addEnergyHeatConductionKernels()

virtual void WCNSFVFluidHeatTransferPhysicsBase::addEnergyHeatConductionKernels ( )
protectedpure virtual

◆ addEnergyInletBC()

virtual void WCNSFVFluidHeatTransferPhysicsBase::addEnergyInletBC ( )
protectedpure virtual

Functions adding boundary conditions for the fluid heat transfer equation.

Implemented in WCNSFVFluidHeatTransferPhysics, and WCNSLinearFVFluidHeatTransferPhysics.

Referenced by addFVBCs().

◆ addEnergyOutletBC()

virtual void WCNSFVFluidHeatTransferPhysicsBase::addEnergyOutletBC ( )
protectedpure virtual

◆ addEnergySeparatorBC()

virtual void WCNSFVFluidHeatTransferPhysicsBase::addEnergySeparatorBC ( )
protectedpure virtual

◆ addEnergyTimeKernels()

virtual void WCNSFVFluidHeatTransferPhysicsBase::addEnergyTimeKernels ( )
protectedpure virtual

Functions adding kernels for the incompressible / weakly compressible energy equation.

Implemented in WCNSLinearFVFluidHeatTransferPhysics, and WCNSFVFluidHeatTransferPhysics.

Referenced by addFVKernels().

◆ addEnergyWallBC()

virtual void WCNSFVFluidHeatTransferPhysicsBase::addEnergyWallBC ( )
protectedpure virtual

◆ addFVBCs()

void WCNSFVFluidHeatTransferPhysicsBase::addFVBCs ( )
overrideprotectedvirtual

Reimplemented from PhysicsBase.

Definition at line 146 of file WCNSFVFluidHeatTransferPhysicsBase.C.

147 {
148  // For compatibility with Modules/NavierStokesFV syntax
150  return;
151 
153  addEnergyWallBC();
156 }
const bool _has_energy_equation
A boolean to help compatibility with the old Modules/NavierStokesFV syntax.
virtual void addEnergyInletBC()=0
Functions adding boundary conditions for the fluid heat transfer equation.

◆ addFVKernels()

void WCNSFVFluidHeatTransferPhysicsBase::addFVKernels ( )
overrideprotectedvirtual

Reimplemented from PhysicsBase.

Definition at line 125 of file WCNSFVFluidHeatTransferPhysicsBase.C.

126 {
127  // For compatibility with Modules/NavierStokesFV syntax
129  return;
130 
133  _blocks,
134  /*error if already defined*/ false))
136 
139  if (getParam<std::vector<MooseFunctorName>>("ambient_temperature").size())
141  if (isParamValid("external_heat_source"))
143 }
virtual void addEnergyExternalHeatSource()=0
virtual void addEnergyTimeKernels()=0
Functions adding kernels for the incompressible / weakly compressible energy equation.
bool shouldCreateTimeDerivative(const VariableName &var_name, const std::vector< SubdomainName > &blocks, const bool error_if_already_defined) const
VariableName _fluid_temperature_name
Fluid temperature name.
std::vector< SubdomainName > _blocks
virtual void addEnergyAmbientConvection()=0
bool isParamValid(const std::string &name) const
virtual void addEnergyAdvectionKernels()=0
const T & getParam(const std::string &name) const
const VariableName _fluid_enthalpy_name
Name of the fluid specific enthalpy.
const bool _has_energy_equation
A boolean to help compatibility with the old Modules/NavierStokesFV syntax.
const bool _solve_for_enthalpy
User-selected option to solve for enthalpy.
virtual void addEnergyHeatConductionKernels()=0

◆ addInitialConditions()

void WCNSFVFluidHeatTransferPhysicsBase::addInitialConditions ( )
overrideprotectedvirtual

Reimplemented from PhysicsBase.

Definition at line 212 of file WCNSFVFluidHeatTransferPhysicsBase.C.

213 {
214  // For compatibility with Modules/NavierStokesFV syntax
216  return;
217  if (!_define_variables && parameters().isParamSetByUser("initial_temperature"))
218  paramError(
219  "initial_temperature",
220  "T_fluid is defined externally of WCNSFVFluidHeatTransferPhysicsBase, so should the inital "
221  "condition");
222  // do not set initial conditions if we are not defining variables
223  if (!_define_variables)
224  return;
225 
226  InputParameters params = getFactory().getValidParams("FunctionIC");
227  assignBlocks(params, _blocks);
228 
230  _blocks,
231  /*whether IC is a default*/ !isParamSetByUser("initial_temperature"),
232  /*error if already an IC*/ isParamSetByUser("initial_temperature")))
233  {
234  params.set<VariableName>("variable") = _fluid_temperature_name;
235  params.set<FunctionName>("function") = getParam<FunctionName>("initial_temperature");
236 
237  getProblem().addInitialCondition("FunctionIC", _fluid_temperature_name + "_ic", params);
238  }
239  if (parameters().isParamValid("initial_enthalpy") &&
241  _blocks,
242  /*whether IC is a default*/ false,
243  /*error if already an IC*/ true))
244  {
245  params.set<VariableName>("variable") = _fluid_enthalpy_name;
246  params.set<FunctionName>("function") = getParam<FunctionName>("initial_enthalpy");
247 
248  getProblem().addInitialCondition("FunctionIC", _fluid_enthalpy_name + "_ic", params);
249  }
250 }
void assignBlocks(InputParameters &params, const std::vector< SubdomainName > &blocks) const
Factory & getFactory()
T & set(const std::string &name, bool quiet_mode=false)
InputParameters getValidParams(const std::string &name) const
bool shouldCreateIC(const VariableName &var_name, const std::vector< SubdomainName > &blocks, const bool ic_is_default_ic, const bool error_if_already_defined) const
VariableName _fluid_temperature_name
Fluid temperature name.
std::vector< SubdomainName > _blocks
bool isParamValid(const std::string &name) const
virtual void addInitialCondition(const std::string &ic_name, const std::string &name, InputParameters &parameters)
virtual FEProblemBase & getProblem()
void paramError(const std::string &param, Args... args) const
const VariableName _fluid_enthalpy_name
Name of the fluid specific enthalpy.
const bool _has_energy_equation
A boolean to help compatibility with the old Modules/NavierStokesFV syntax.
bool _define_variables
Whether to define variables if they do not exist.
bool isParamSetByUser(const std::string &nm) const
const InputParameters & parameters() const

◆ addMaterials()

void WCNSFVFluidHeatTransferPhysicsBase::addMaterials ( )
overrideprotectedvirtual

Reimplemented from PhysicsBase.

Reimplemented in WCNSLinearFVFluidHeatTransferPhysics.

Definition at line 253 of file WCNSFVFluidHeatTransferPhysicsBase.C.

Referenced by WCNSLinearFVFluidHeatTransferPhysics::addMaterials().

254 {
255  // For compatibility with Modules/NavierStokesFV syntax
257  return;
258 
259  // Note that this material choice would not work for Newton-INSFV + solve_for_enthalpy
260  const auto object_type =
261  _solve_for_enthalpy ? "LinearFVEnthalpyFunctorMaterial" : "INSFVEnthalpyFunctorMaterial";
262 
263  InputParameters params = getFactory().getValidParams(object_type);
264  assignBlocks(params, _blocks);
265 
267  {
268  params.set<MooseFunctorName>(NS::pressure) = _flow_equations_physics->getPressureName();
269  params.set<MooseFunctorName>(NS::T_fluid) = _fluid_temperature_name;
270  params.set<MooseFunctorName>(NS::specific_enthalpy) = _fluid_enthalpy_name;
271  if (isParamValid(NS::fluid))
272  params.set<UserObjectName>(NS::fluid) = getParam<UserObjectName>(NS::fluid);
273  else
274  {
275  if (!getProblem().hasFunctor("h_from_p_T_functor", 0) ||
276  !getProblem().hasFunctor("T_from_p_h_functor", 0))
278  "Either 'fp' must be specified or the 'h_from_p_T_functor' and "
279  "'T_from_p_h_functor' must be defined outside the Physics");
280  // Note: we could define those in the Physics if cp is constant
281  params.set<MooseFunctorName>("h_from_p_T_functor") = "h_from_p_T_functor";
282  params.set<MooseFunctorName>("T_from_p_h_functor") = "T_from_p_h_functor";
283  }
284  }
285  else
286  {
287  params.set<MooseFunctorName>(NS::density) = _density_name;
288  params.set<MooseFunctorName>(NS::cp) = _specific_heat_name;
289  params.set<MooseFunctorName>("temperature") = _fluid_temperature_name;
290  }
291 
292  getProblem().addMaterial(object_type, prefix() + "enthalpy_material", params);
293 }
std::string prefix() const
MooseFunctorName _specific_heat_name
Name of the specific heat material property.
void assignBlocks(InputParameters &params, const std::vector< SubdomainName > &blocks) const
const MooseFunctorName _density_name
Name of the density material property.
Factory & getFactory()
virtual void addMaterial(const std::string &material_name, const std::string &name, InputParameters &parameters)
T & set(const std::string &name, bool quiet_mode=false)
static const std::string density
Definition: NS.h:33
InputParameters getValidParams(const std::string &name) const
static const std::string fluid
Definition: NS.h:87
VariableName _fluid_temperature_name
Fluid temperature name.
std::vector< SubdomainName > _blocks
bool isParamValid(const std::string &name) const
virtual FEProblemBase & getProblem()
static const std::string cp
Definition: NS.h:121
static const std::string T_fluid
Definition: NS.h:106
void paramError(const std::string &param, Args... args) const
const VariableName _fluid_enthalpy_name
Name of the fluid specific enthalpy.
const bool _has_energy_equation
A boolean to help compatibility with the old Modules/NavierStokesFV syntax.
static const std::string pressure
Definition: NS.h:56
const bool _solve_for_enthalpy
User-selected option to solve for enthalpy.
bool hasFunctor(const std::string &name, const THREAD_ID tid) const
const WCNSFVFlowPhysicsBase * _flow_equations_physics
Flow physics.
static const std::string specific_enthalpy
Definition: NS.h:68
const NonlinearVariableName & getPressureName() const

◆ densityName()

const MooseFunctorName& WCNSFVCoupledAdvectionPhysicsHelper::densityName ( ) const
inlineinherited

◆ dynamicViscosityName()

const MooseFunctorName& WCNSFVCoupledAdvectionPhysicsHelper::dynamicViscosityName ( ) const
inlineinherited

Definition at line 37 of file WCNSFVCoupledAdvectionPhysicsHelper.h.

37 { return _dynamic_viscosity_name; }
const MooseFunctorName _dynamic_viscosity_name
Name of the dynamic viscosity material property.

◆ getAdditionalRMParams()

InputParameters NavierStokesPhysicsBase::getAdditionalRMParams ( ) const
overrideprotectedvirtualinherited

Parameters to change or add relationship managers.

Reimplemented from PhysicsBase.

Definition at line 42 of file NavierStokesPhysicsBase.C.

43 {
44  unsigned short necessary_layers = getParam<unsigned short>("ghost_layers");
45  necessary_layers = std::max(necessary_layers, getNumberAlgebraicGhostingLayersNeeded());
46 
47  // Just an object that has a ghost_layers parameter
48  const std::string kernel_type = "INSFVMixingLengthReynoldsStress";
49  InputParameters params = getFactory().getValidParams(kernel_type);
50  params.template set<unsigned short>("ghost_layers") = necessary_layers;
51 
52  return params;
53 }
Factory & getFactory()
InputParameters getValidParams(const std::string &name) const
virtual unsigned short getNumberAlgebraicGhostingLayersNeeded() const =0
Return the number of ghosting layers needed.

◆ getAmbientConvectionBlocks()

const std::vector<std::vector<SubdomainName> >& WCNSFVFluidHeatTransferPhysicsBase::getAmbientConvectionBlocks ( ) const
inline

Get the ambient convection parameters for parameter checking.

Definition at line 47 of file WCNSFVFluidHeatTransferPhysicsBase.h.

Referenced by PNSFVSolidHeatTransferPhysics::checkFluidAndSolidHeatTransferPhysicsParameters().

48  {
50  }
std::vector< std::vector< SubdomainName > > _ambient_convection_blocks
Vector of subdomain groups where we want to have different ambient convection.

◆ getAmbientConvectionHTCs()

const std::vector<MooseFunctorName>& WCNSFVFluidHeatTransferPhysicsBase::getAmbientConvectionHTCs ( ) const
inline

Name of the ambient convection heat transfer coefficients for each block-group.

Definition at line 52 of file WCNSFVFluidHeatTransferPhysicsBase.h.

Referenced by PNSFVSolidHeatTransferPhysics::checkFluidAndSolidHeatTransferPhysicsParameters().

53  {
55  }
std::vector< MooseFunctorName > _ambient_convection_alpha
Name of the ambient convection heat transfer coefficients for each block-group.

◆ getCoupledFlowPhysics()

const WCNSFVFlowPhysicsBase * WCNSFVCoupledAdvectionPhysicsHelper::getCoupledFlowPhysics ( ) const
inherited

Definition at line 53 of file WCNSFVCoupledAdvectionPhysicsHelper.C.

54 {
55  // User passed it, just use that
56  if (_advection_physics->isParamValid("coupled_flow_physics"))
58  _advection_physics->getParam<PhysicsName>("coupled_flow_physics"));
59  // Look for any physics of the right type, and check the block restriction
60  else
61  {
62  const auto all_flow_physics =
64  for (const auto physics : all_flow_physics)
66  physics->name(), physics->blocks(), /*error_if_not_identical=*/false))
67  {
68  return physics;
69  }
70  }
71  mooseError("No coupled flow Physics found of type derived from 'WCNSFVFlowPhysicsBase'. Use the "
72  "'coupled_flow_physics' parameter to give the name of the desired "
73  "WCNSFVFlowPhysicsBase-derived Physics to couple with");
74 }
void mooseError(Args &&... args)
const T * getCoupledPhysics(const PhysicsName &phys_name, const bool allow_fail=false) const
bool isParamValid(const std::string &name) const
Base class for Physics which create the Navier Stokes flow equations.
const T & getParam(const std::string &name) const
bool checkBlockRestrictionIdentical(const std::string &object_name, const std::vector< SubdomainName > &blocks, const bool error_if_not_identical=true) const
const NavierStokesPhysicsBase * _advection_physics
The Physics class using this helper.

◆ getCoupledTurbulencePhysics()

const WCNSFVTurbulencePhysics * WCNSFVCoupledAdvectionPhysicsHelper::getCoupledTurbulencePhysics ( ) const
inherited

Definition at line 77 of file WCNSFVCoupledAdvectionPhysicsHelper.C.

Referenced by actOnAdditionalTasks().

78 {
79  // User passed it, just use that
80  if (_advection_physics->isParamValid("coupled_turbulence_physics"))
82  _advection_physics->getParam<PhysicsName>("coupled_turbulence_physics"));
83  // Look for any physics of the right type, and check the block restriction
84  else
85  {
86  const auto all_turbulence_physics =
88  for (const auto physics : all_turbulence_physics)
90  physics->name(), physics->blocks(), /*error_if_not_identical=*/false))
91  return physics;
92  }
93  // Did not find one
94  return nullptr;
95 }
Creates all the objects needed to add a turbulence model to an incompressible / weakly-compressible N...
const T * getCoupledPhysics(const PhysicsName &phys_name, const bool allow_fail=false) const
bool isParamValid(const std::string &name) const
const T & getParam(const std::string &name) const
bool checkBlockRestrictionIdentical(const std::string &object_name, const std::vector< SubdomainName > &blocks, const bool error_if_not_identical=true) const
const NavierStokesPhysicsBase * _advection_physics
The Physics class using this helper.

◆ getFluidTemperatureName()

const VariableName& WCNSFVFluidHeatTransferPhysicsBase::getFluidTemperatureName ( ) const
inline

Get the name of the fluid temperature variable.

Definition at line 36 of file WCNSFVFluidHeatTransferPhysicsBase.h.

Referenced by WCNSFVTwoPhaseMixturePhysics::addPhaseChangeEnergySource().

36 { return _fluid_temperature_name; }
VariableName _fluid_temperature_name
Fluid temperature name.

◆ getNumberAlgebraicGhostingLayersNeeded()

unsigned short WCNSFVFluidHeatTransferPhysicsBase::getNumberAlgebraicGhostingLayersNeeded ( ) const
overrideprotectedvirtual

Return the number of ghosting layers needed.

Implements NavierStokesPhysicsBase.

Definition at line 296 of file WCNSFVFluidHeatTransferPhysicsBase.C.

297 {
298  unsigned short necessary_layers = getParam<unsigned short>("ghost_layers");
299  necessary_layers =
301  if (getParam<MooseEnum>("energy_face_interpolation") == "skewness-corrected")
302  necessary_layers = std::max(necessary_layers, (unsigned short)3);
303 
304  return necessary_layers;
305 }
unsigned short getNumberAlgebraicGhostingLayersNeeded() const override
Return the number of algebraic ghosting layers needed.
const WCNSFVFlowPhysicsBase * _flow_equations_physics
Flow physics.

◆ getPorosityFunctorName()

MooseFunctorName WCNSFVCoupledAdvectionPhysicsHelper::getPorosityFunctorName ( bool  smoothed) const
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.

48 {
50 }
MooseFunctorName getPorosityFunctorName(const bool smoothed) const
const WCNSFVFlowPhysicsBase * _flow_equations_physics
Flow physics.

◆ getSpecificEnthalpyName()

MooseFunctorName WCNSFVFluidHeatTransferPhysicsBase::getSpecificEnthalpyName ( ) const
inline

Definition at line 40 of file WCNSFVFluidHeatTransferPhysicsBase.h.

40 { return NS::specific_enthalpy; }
static const std::string specific_enthalpy
Definition: NS.h:68

◆ getSpecificHeatName()

const MooseFunctorName& WCNSFVFluidHeatTransferPhysicsBase::getSpecificHeatName ( ) const
inline

◆ getThermalConductivityName()

const std::vector<MooseFunctorName>& WCNSFVFluidHeatTransferPhysicsBase::getThermalConductivityName ( ) const
inline

Definition at line 41 of file WCNSFVFluidHeatTransferPhysicsBase.h.

42  {
44  }
std::vector< MooseFunctorName > _thermal_conductivity_name
Name of the thermal conductivity functor for each block-group.

◆ hasEnergyEquation()

bool WCNSFVFluidHeatTransferPhysicsBase::hasEnergyEquation ( ) const
inline

◆ processThermalConductivity()

bool WCNSFVFluidHeatTransferPhysicsBase::processThermalConductivity ( )
protected

Process thermal conductivity (multiple functor input options are available).

Return true if we have vector thermal conductivity and false if scalar

Definition at line 167 of file WCNSFVFluidHeatTransferPhysicsBase.C.

Referenced by WCNSFVFluidHeatTransferPhysics::addEnergyHeatConductionKernels(), and WCNSLinearFVFluidHeatTransferPhysics::addEnergyHeatConductionKernels().

168 {
169  checkBlockwiseConsistency<MooseFunctorName>("thermal_conductivity_blocks",
170  {"thermal_conductivity"});
171  bool have_scalar = false;
172  bool have_vector = false;
173 
174  for (unsigned int i = 0; i < _thermal_conductivity_name.size(); ++i)
175  {
176  // First, check if the name is just a number (only in case of isotropic conduction)
178  have_scalar = true;
179  // Now we determine what kind of functor we are dealing with
180  else
181  {
183  /*thread_id=*/0) ||
185  /*thread_id=*/0))
186  have_scalar = true;
187  else
188  {
190  /*thread_id=*/0))
191  have_vector = true;
192  else
193  paramError("thermal_conductivity",
194  "We only allow functor of type Real/ADReal or ADRealVectorValue for thermal "
195  "conductivity! Functor '" +
196  _thermal_conductivity_name[i] + "' is not of the requested type.");
197  }
198  }
199  }
200 
201  if (have_vector && !_porous_medium_treatment)
202  paramError("thermal_conductivity", "Cannot use anisotropic diffusion with non-porous flows!");
203 
204  if (have_vector == have_scalar)
205  paramError("thermal_conductivity",
206  "The entries on thermal conductivity shall either be scalars of vectors, mixing "
207  "them is not supported!");
208  return have_vector;
209 }
bool parsesToReal(const std::string &input)
DualNumber< Real, DNDerivativeType, true > ADReal
virtual FEProblemBase & getProblem()
bool hasFunctorWithType(const std::string &name, const THREAD_ID tid) const
const bool _porous_medium_treatment
Switch to show if porous medium treatment is requested or not.
void paramError(const std::string &param, Args... args) const
DIE A HORRIBLE DEATH HERE typedef LIBMESH_DEFAULT_SCALAR_TYPE Real
std::vector< MooseFunctorName > _thermal_conductivity_name
Name of the thermal conductivity functor for each block-group.

◆ usingNavierStokesFVSyntax()

bool NavierStokesPhysicsBase::usingNavierStokesFVSyntax ( ) const
inlineprotectedinherited

Detects if we are using the new Physics syntax or the old NavierStokesFV action.

Definition at line 32 of file NavierStokesPhysicsBase.h.

33  {
34  return (parameters().get<std::string>("registered_identifier") == "Modules/NavierStokesFV");
35  }
const InputParameters & parameters() const

◆ validParams()

InputParameters WCNSFVFluidHeatTransferPhysicsBase::validParams ( )
static

Definition at line 17 of file WCNSFVFluidHeatTransferPhysicsBase.C.

Referenced by WCNSFVFluidHeatTransferPhysics::validParams(), and WCNSLinearFVFluidHeatTransferPhysics::validParams().

18 {
21  params.addClassDescription("Define the Navier Stokes weakly-compressible energy equation");
22 
25  "effective_conductivity");
26 
27  // TODO Remove the parameter once NavierStokesFV syntax has been removed
28  params.addParam<bool>("add_energy_equation",
29  "Whether to add the energy equation. This parameter is not necessary if "
30  "using the Physics syntax");
31  params.addParam<bool>("solve_for_enthalpy",
32  false,
33  "Whether to solve for the enthalpy or the temperature of the fluid");
34  params.addParam<NonlinearVariableName>(
35  "fluid_temperature_variable", NS::T_fluid, "Name of the fluid temperature variable");
36 
37  // Initial conditions
38  params.addParam<FunctionName>(
39  "initial_enthalpy",
40  "Initial value of the enthalpy variable, only to be used when solving for enthalpy");
41 
42  // New functor boundary conditions
43  params.deprecateParam("energy_inlet_function", "energy_inlet_functors", "01/01/2025");
44  params.deprecateParam("energy_wall_function", "energy_wall_functors", "01/01/2025");
45 
46  // Spatial finite volume discretization scheme
47  params.transferParam<MooseEnum>(NSFVBase::validParams(), "energy_advection_interpolation");
48  params.transferParam<MooseEnum>(NSFVBase::validParams(), "energy_face_interpolation");
49  params.transferParam<bool>(NSFVBase::validParams(), "energy_two_term_bc_expansion");
50 
51  params.addParamNamesToGroup("specific_heat thermal_conductivity thermal_conductivity_blocks "
52  "use_external_enthalpy_material",
53  "Material properties");
54  params.addParamNamesToGroup("energy_advection_interpolation energy_face_interpolation "
55  "energy_two_term_bc_expansion",
56  "Numerical scheme");
57  params.addParamNamesToGroup("energy_inlet_types energy_inlet_functors",
58  "Inlet boundary conditions");
59  params.addParamNamesToGroup("energy_wall_types energy_wall_functors", "Wall boundary conditions");
60 
61  return params;
62 }
static InputParameters validParams()
Definition: NSFVBase.C:368
void addParam(const std::string &name, const std::initializer_list< typename T::value_type > &value, const std::string &doc_string)
static InputParameters validParams()
static const std::string T_fluid
Definition: NS.h:106
void deprecateParam(const std::string &old_name, const std::string &new_name, const std::string &removal_date)
void transferParam(const InputParameters &source_param, const std::string &name, const std::string &new_name="", const std::string &new_description="")
void addClassDescription(const std::string &doc_string)
static InputParameters commonFluidEnergyEquationParams()
Definition: NSFVBase.C:191
void addParamNamesToGroup(const std::string &space_delim_names, const std::string group_name)

Member Data Documentation

◆ _advection_physics

const NavierStokesPhysicsBase* WCNSFVCoupledAdvectionPhysicsHelper::_advection_physics
protectedinherited

◆ _ambient_convection_alpha

std::vector<MooseFunctorName> WCNSFVFluidHeatTransferPhysicsBase::_ambient_convection_alpha
protected

Name of the ambient convection heat transfer coefficients for each block-group.

Definition at line 106 of file WCNSFVFluidHeatTransferPhysicsBase.h.

Referenced by WCNSFVFluidHeatTransferPhysics::addEnergyAmbientConvection(), WCNSLinearFVFluidHeatTransferPhysics::addEnergyAmbientConvection(), and getAmbientConvectionHTCs().

◆ _ambient_convection_blocks

std::vector<std::vector<SubdomainName> > WCNSFVFluidHeatTransferPhysicsBase::_ambient_convection_blocks
protected

Vector of subdomain groups where we want to have different ambient convection.

Definition at line 104 of file WCNSFVFluidHeatTransferPhysicsBase.h.

Referenced by WCNSFVFluidHeatTransferPhysics::addEnergyAmbientConvection(), WCNSLinearFVFluidHeatTransferPhysics::addEnergyAmbientConvection(), and getAmbientConvectionBlocks().

◆ _ambient_temperature

std::vector<MooseFunctorName> WCNSFVFluidHeatTransferPhysicsBase::_ambient_temperature
protected

Name of the solid domain temperature for each block-group.

Definition at line 108 of file WCNSFVFluidHeatTransferPhysicsBase.h.

Referenced by WCNSFVFluidHeatTransferPhysics::addEnergyAmbientConvection(), and WCNSLinearFVFluidHeatTransferPhysics::addEnergyAmbientConvection().

◆ _compressibility

const MooseEnum WCNSFVCoupledAdvectionPhysicsHelper::_compressibility
protectedinherited

Compressibility type, can be compressible, incompressible or weakly-compressible.

Definition at line 48 of file WCNSFVCoupledAdvectionPhysicsHelper.h.

Referenced by WCNSFVFluidHeatTransferPhysics::addEnergyTimeKernels().

◆ _define_variables

bool NavierStokesPhysicsBase::_define_variables
protectedinherited

◆ _density_name

const MooseFunctorName WCNSFVCoupledAdvectionPhysicsHelper::_density_name
protectedinherited

◆ _dynamic_viscosity_name

const MooseFunctorName WCNSFVCoupledAdvectionPhysicsHelper::_dynamic_viscosity_name
protectedinherited

◆ _energy_inlet_functors

std::vector<MooseFunctorName> WCNSFVFluidHeatTransferPhysicsBase::_energy_inlet_functors
protected

Functors describing the inlet boundary values. See energy_inlet_types for what the functors actually represent.

Definition at line 113 of file WCNSFVFluidHeatTransferPhysicsBase.h.

Referenced by WCNSFVFluidHeatTransferPhysics::addEnergyInletBC(), and WCNSLinearFVFluidHeatTransferPhysics::addEnergyInletBC().

◆ _energy_inlet_types

MultiMooseEnum WCNSFVFluidHeatTransferPhysicsBase::_energy_inlet_types
protected

◆ _energy_wall_functors

std::vector<MooseFunctorName> WCNSFVFluidHeatTransferPhysicsBase::_energy_wall_functors
protected

Functors describing the wall boundary values. See energy_wall_types for what the functors actually represent.

Definition at line 117 of file WCNSFVFluidHeatTransferPhysicsBase.h.

Referenced by WCNSFVFluidHeatTransferPhysics::addEnergyWallBC(), and WCNSLinearFVFluidHeatTransferPhysics::addEnergyWallBC().

◆ _energy_wall_types

MultiMooseEnum WCNSFVFluidHeatTransferPhysicsBase::_energy_wall_types
protected

◆ _flow_equations_physics

const WCNSFVFlowPhysicsBase* WCNSFVCoupledAdvectionPhysicsHelper::_flow_equations_physics
protectedinherited

Flow physics.

Definition at line 43 of file WCNSFVCoupledAdvectionPhysicsHelper.h.

Referenced by WCNSFVTwoPhaseMixturePhysics::addAdvectionSlipTerm(), WCNSFVTurbulencePhysics::addAuxiliaryKernels(), WCNSFVFluidHeatTransferPhysics::addEnergyAdvectionKernels(), WCNSLinearFVFluidHeatTransferPhysics::addEnergyAdvectionKernels(), WCNSFVFluidHeatTransferPhysics::addEnergyHeatConductionKernels(), WCNSFVFluidHeatTransferPhysics::addEnergyInletBC(), WCNSLinearFVFluidHeatTransferPhysics::addEnergyInletBC(), WCNSLinearFVFluidHeatTransferPhysics::addEnergyOutletBC(), WCNSFVFluidHeatTransferPhysics::addEnergySeparatorBC(), WCNSFVFluidHeatTransferPhysics::addEnergyTimeKernels(), WCNSLinearFVFluidHeatTransferPhysics::addEnergyWallBC(), WCNSFVFluidHeatTransferPhysics::addEnergyWallBC(), WCNSFVTurbulencePhysics::addFlowTurbulenceKernels(), WCNSFVTurbulencePhysics::addFluidEnergyTurbulenceKernels(), WCNSFVTurbulencePhysics::addFVBCs(), WCNSLinearFVTwoPhaseMixturePhysics::addFVKernels(), WCNSFVTwoPhaseMixturePhysics::addFVKernels(), WCNSFVTurbulencePhysics::addInitialConditions(), WCNSFVTurbulencePhysics::addKEpsilonAdvection(), WCNSFVTurbulencePhysics::addKEpsilonDiffusion(), WCNSFVTurbulencePhysics::addKEpsilonSink(), WCNSLinearFVTwoPhaseMixturePhysics::addMaterials(), WCNSFVTwoPhaseMixturePhysics::addMaterials(), WCNSFVTurbulencePhysics::addMaterials(), addMaterials(), WCNSLinearFVTwoPhaseMixturePhysics::addPhaseDriftFluxTerm(), WCNSFVTwoPhaseMixturePhysics::addPhaseDriftFluxTerm(), WCNSLinearFVScalarTransportPhysics::addScalarAdvectionKernels(), WCNSFVScalarTransportPhysics::addScalarAdvectionKernels(), WCNSLinearFVScalarTransportPhysics::addScalarInletBC(), WCNSFVScalarTransportPhysics::addScalarInletBC(), WCNSLinearFVScalarTransportPhysics::addScalarOutletBC(), WCNSLinearFVTwoPhaseMixturePhysics::checkIntegrity(), WCNSFVTurbulencePhysics::getNumberAlgebraicGhostingLayersNeeded(), getNumberAlgebraicGhostingLayersNeeded(), WCNSFVScalarTransportPhysicsBase::getNumberAlgebraicGhostingLayersNeeded(), WCNSFVCoupledAdvectionPhysicsHelper::getPorosityFunctorName(), WCNSFVTurbulencePhysics::retrieveCoupledPhysics(), WCNSFVFluidHeatTransferPhysicsBase(), WCNSFVTwoPhaseMixturePhysics::WCNSFVTwoPhaseMixturePhysics(), WCNSLinearFVScalarTransportPhysics::WCNSLinearFVScalarTransportPhysics(), and WCNSLinearFVTwoPhaseMixturePhysics::WCNSLinearFVTwoPhaseMixturePhysics().

◆ _fluid_enthalpy_name

const VariableName WCNSFVFluidHeatTransferPhysicsBase::_fluid_enthalpy_name
protected

◆ _fluid_temperature_name

VariableName WCNSFVFluidHeatTransferPhysicsBase::_fluid_temperature_name
protected

◆ _has_energy_equation

const bool WCNSFVFluidHeatTransferPhysicsBase::_has_energy_equation
protected

◆ _porous_medium_treatment

const bool WCNSFVCoupledAdvectionPhysicsHelper::_porous_medium_treatment
protectedinherited

◆ _pressure_name

const NonlinearVariableName WCNSFVCoupledAdvectionPhysicsHelper::_pressure_name
protectedinherited

Pressure name.

Definition at line 56 of file WCNSFVCoupledAdvectionPhysicsHelper.h.

◆ _solve_for_enthalpy

const bool WCNSFVFluidHeatTransferPhysicsBase::_solve_for_enthalpy
protected

◆ _specific_heat_name

MooseFunctorName WCNSFVFluidHeatTransferPhysicsBase::_specific_heat_name
protected

◆ _thermal_conductivity_blocks

std::vector<std::vector<SubdomainName> > WCNSFVFluidHeatTransferPhysicsBase::_thermal_conductivity_blocks
protected

Vector of subdomain groups where we want to have different thermal conduction.

Definition at line 99 of file WCNSFVFluidHeatTransferPhysicsBase.h.

Referenced by WCNSFVFluidHeatTransferPhysics::addEnergyHeatConductionKernels(), and WCNSLinearFVFluidHeatTransferPhysics::addEnergyHeatConductionKernels().

◆ _thermal_conductivity_name

std::vector<MooseFunctorName> WCNSFVFluidHeatTransferPhysicsBase::_thermal_conductivity_name
protected

◆ _turbulence_physics

const WCNSFVTurbulencePhysics* WCNSFVCoupledAdvectionPhysicsHelper::_turbulence_physics
protectedinherited

◆ _velocity_interpolation

const MooseEnum WCNSFVCoupledAdvectionPhysicsHelper::_velocity_interpolation
protectedinherited

The velocity / momentum face interpolation method for advecting other quantities.

Definition at line 64 of file WCNSFVCoupledAdvectionPhysicsHelper.h.

Referenced by WCNSFVFluidHeatTransferPhysics::addEnergyAdvectionKernels(), WCNSFVTurbulencePhysics::addKEpsilonAdvection(), and WCNSFVScalarTransportPhysics::addScalarAdvectionKernels().

◆ _velocity_names

const std::vector<std::string> WCNSFVCoupledAdvectionPhysicsHelper::_velocity_names
protectedinherited

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