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 | Private Member Functions | List of all members
WCNSLinearFVFluidHeatTransferPhysics Class Referencefinal

Creates all the objects needed to solve the Navier Stokes energy equation using a linear finite volume discretization. More...

#include <WCNSLinearFVFluidHeatTransferPhysics.h>

Inheritance diagram for WCNSLinearFVFluidHeatTransferPhysics:
[legend]

Public Types

typedef DataFileName DataFileParameterType
 

Public Member Functions

 WCNSLinearFVFluidHeatTransferPhysics (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
 
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 ()
 
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 ()
 
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 unique_action_name_param
 
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
 
static constexpr auto SYSTEM
 
static constexpr auto NAME
 

Protected Member Functions

void actOnAdditionalTasks () override
 
void addInitialConditions () override
 
void addFVKernels () override
 
void addFVBCs () override
 
unsigned short getNumberAlgebraicGhostingLayersNeeded () const override
 Return the number of ghosting layers needed. More...
 
bool processThermalConductivity ()
 Process thermal conductivity (multiple functor input options are available). More...
 
void defineKOverCpFunctors (const bool use_ad)
 Define the k/cp diffusion coefficients when solving for enthalpy. 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 flagInvalidSolutionInternal (const InvalidSolutionID invalid_solution_id) const
 
InvalidSolutionID registerInvalidSolutionInternal (const std::string &message, const bool warning) 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
 
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
 
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 addSolverVariables () override
 
virtual void addAuxiliaryVariables () override
 
virtual void addAuxiliaryKernels () override
 
virtual void addMaterials () override
 
void addEnergyTimeKernels () override
 Functions adding kernels for the incompressible / weakly compressible energy equation. More...
 
void addEnergyHeatConductionKernels () override
 
void addEnergyAdvectionKernels () override
 
void addEnergyAmbientConvection () override
 
void addEnergyExternalHeatSource () override
 
void addEnergyInletBC () override
 Functions adding boundary conditions for the incompressible / weakly compressible energy equation. More...
 
void addEnergyWallBC () override
 
void addEnergyOutletBC () override
 
void addEnergySeparatorBC () override
 

Detailed Description

Creates all the objects needed to solve the Navier Stokes energy equation using a linear finite volume discretization.

Definition at line 19 of file WCNSLinearFVFluidHeatTransferPhysics.h.

Constructor & Destructor Documentation

◆ WCNSLinearFVFluidHeatTransferPhysics()

WCNSLinearFVFluidHeatTransferPhysics::WCNSLinearFVFluidHeatTransferPhysics ( const InputParameters parameters)

Definition at line 45 of file WCNSLinearFVFluidHeatTransferPhysics.C.

48 {
50  paramError("porous_medium_treatment", "Porous media not supported at this time");
51  checkSecondParamSetOnlyIfFirstOneTrue("solve_for_enthalpy", NS::fluid);
52 }
void paramError(const std::string &param, Args... args) const
const InputParameters & parameters() const
static const std::string fluid
Definition: NS.h:87
const bool _porous_medium_treatment
Switch to show if porous medium treatment is requested or not.
WCNSFVFluidHeatTransferPhysicsBase(const InputParameters &parameters)
void checkSecondParamSetOnlyIfFirstOneTrue(const std::string &param1, const std::string &param2) const

Member Function Documentation

◆ actOnAdditionalTasks()

void WCNSFVFluidHeatTransferPhysicsBase::actOnAdditionalTasks ( )
overrideprotectedvirtualinherited

Reimplemented from PhysicsBase.

Definition at line 158 of file WCNSFVFluidHeatTransferPhysicsBase.C.

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

◆ addAuxiliaryKernels()

void WCNSLinearFVFluidHeatTransferPhysics::addAuxiliaryKernels ( )
overrideprivatevirtual

Reimplemented from PhysicsBase.

Definition at line 244 of file WCNSLinearFVFluidHeatTransferPhysics.C.

245 {
247  {
248  // Keep temperature updated
249  const std::string kernel_type = "FunctorAux";
250  InputParameters params = getFactory().getValidParams(kernel_type);
251  params.set<AuxVariableName>("variable") = _fluid_temperature_name;
252  assignBlocks(params, _blocks);
253  params.set<MooseFunctorName>("functor") = "T_from_p_h";
254  params.set<ExecFlagEnum>("execute_on") = {EXEC_NONLINEAR};
255  getProblem().addAuxKernel(kernel_type, prefix() + "update_temperature", params);
256  }
257 }
std::string prefix() const
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
virtual void addAuxKernel(const std::string &kernel_name, const std::string &name, InputParameters &parameters)
VariableName _fluid_temperature_name
Fluid temperature name.
std::vector< SubdomainName > _blocks
virtual FEProblemBase & getProblem()
const ExecFlagType EXEC_NONLINEAR
const bool _solve_for_enthalpy
User-selected option to solve for enthalpy.

◆ addAuxiliaryVariables()

void WCNSLinearFVFluidHeatTransferPhysics::addAuxiliaryVariables ( )
overrideprivatevirtual

Reimplemented from PhysicsBase.

Definition at line 220 of file WCNSLinearFVFluidHeatTransferPhysics.C.

221 {
223  {
224  // Dont add if the user already defined the variable
226  /*error_if_aux=*/false))
228  getProblem().getVariable(0, _fluid_temperature_name).blocks());
229  else if (_define_variables)
230  {
231  const auto var_type = "MooseLinearVariableFVReal";
232  auto params = getFactory().getValidParams(var_type);
233  assignBlocks(params, _blocks);
235  }
236  else
237  paramError("fluid_temperature_variable",
238  "Variable (" + _fluid_temperature_name +
239  ") supplied to the WCNSLinearFVFluidHeatTransferPhysics does not exist!");
240  }
241 }
void assignBlocks(InputParameters &params, const std::vector< SubdomainName > &blocks) const
Factory & getFactory()
void paramError(const std::string &param, Args... args) const
InputParameters getValidParams(const std::string &name) const
const std::vector< SubdomainName > & blocks() const
VariableName _fluid_temperature_name
Fluid temperature name.
virtual void addAuxVariable(const std::string &var_type, const std::string &var_name, InputParameters &params)
std::vector< SubdomainName > _blocks
virtual FEProblemBase & getProblem()
bool variableExists(const VariableName &var_name, bool error_if_aux) const
bool checkBlockRestrictionIdentical(const std::string &object_name, const std::vector< SubdomainName > &blocks, const bool error_if_not_identical=true) const
bool _define_variables
Whether to define variables if they do not exist.
const bool _solve_for_enthalpy
User-selected option to solve for enthalpy.

◆ addEnergyAdvectionKernels()

void WCNSLinearFVFluidHeatTransferPhysics::addEnergyAdvectionKernels ( )
overrideprivatevirtual

Implements WCNSFVFluidHeatTransferPhysicsBase.

Definition at line 99 of file WCNSLinearFVFluidHeatTransferPhysics.C.

100 {
101  std::string kernel_type = "LinearFVEnergyAdvection";
102  std::string kernel_name = prefix() + "ins_energy_advection";
103 
104  InputParameters params = getFactory().getValidParams(kernel_type);
105  assignBlocks(params, _blocks);
106  if (!getParam<bool>("solve_for_enthalpy"))
107  {
108  params.set<LinearVariableName>("variable") = _fluid_temperature_name;
109  params.set<MooseEnum>("advected_quantity") = "temperature";
110  if (!MooseUtils::isFloat(_specific_heat_name))
111  paramError("specific_heat", "Must be a Real number. Functors not supported at this time");
112  params.set<Real>("cp") = std::atof(_specific_heat_name.c_str());
113  }
114  else
115  params.set<LinearVariableName>("variable") = _fluid_enthalpy_name;
116  params.set<UserObjectName>("rhie_chow_user_object") = _flow_equations_physics->rhieChowUOName();
117  params.set<MooseEnum>("advected_interp_method") =
118  getParam<MooseEnum>("energy_advection_interpolation");
119 
120  getProblem().addLinearFVKernel(kernel_type, kernel_name, params);
121 }
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
Factory & getFactory()
void paramError(const std::string &param, Args... args) const
T & set(const std::string &name, bool quiet_mode=false)
InputParameters getValidParams(const std::string &name) const
VariableName _fluid_temperature_name
Fluid temperature name.
std::vector< SubdomainName > _blocks
virtual FEProblemBase & getProblem()
virtual UserObjectName rhieChowUOName() const =0
Return the name of the Rhie Chow user object.
const VariableName _fluid_enthalpy_name
Name of the fluid specific enthalpy.
virtual void addLinearFVKernel(const std::string &kernel_name, const std::string &name, InputParameters &parameters)
DIE A HORRIBLE DEATH HERE typedef LIBMESH_DEFAULT_SCALAR_TYPE Real
const WCNSFVFlowPhysicsBase * _flow_equations_physics
Flow physics.

◆ addEnergyAmbientConvection()

void WCNSLinearFVFluidHeatTransferPhysics::addEnergyAmbientConvection ( )
overrideprivatevirtual

Implements WCNSFVFluidHeatTransferPhysicsBase.

Definition at line 169 of file WCNSLinearFVFluidHeatTransferPhysics.C.

170 {
171  unsigned int num_convection_blocks = _ambient_convection_blocks.size();
172  unsigned int num_used_blocks = num_convection_blocks ? num_convection_blocks : 1;
173 
174  const std::string kernel_type = "LinearFVVolumetricHeatTransfer";
175  InputParameters params = getFactory().getValidParams(kernel_type);
176  params.set<LinearVariableName>("variable") =
178  params.set<VariableName>(NS::T_fluid) = _fluid_temperature_name;
179  params.set<bool>("is_solid") = false;
180 
181  for (unsigned int block_i = 0; block_i < num_used_blocks; ++block_i)
182  {
183  std::string block_name = "";
184  if (num_convection_blocks)
185  {
186  params.set<std::vector<SubdomainName>>("block") = _ambient_convection_blocks[block_i];
187  block_name = Moose::stringify(_ambient_convection_blocks[block_i]);
188  }
189  else
190  {
191  assignBlocks(params, _blocks);
192  block_name = std::to_string(block_i);
193  }
194 
195  params.set<MooseFunctorName>("h_solid_fluid") = _ambient_convection_alpha[block_i];
196  params.set<VariableName>(NS::T_solid) = _ambient_temperature[block_i];
197 
199  kernel_type, prefix() + "ambient_convection_" + block_name, params);
200  }
201 }
std::string prefix() const
void assignBlocks(InputParameters &params, const std::vector< SubdomainName > &blocks) const
Factory & getFactory()
std::vector< MooseFunctorName > _ambient_temperature
Name of the solid domain temperature for each block-group.
static const std::string T_solid
Definition: NS.h:107
T & set(const std::string &name, bool quiet_mode=false)
InputParameters getValidParams(const std::string &name) const
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.
std::vector< SubdomainName > _blocks
virtual FEProblemBase & getProblem()
static const std::string T_fluid
Definition: NS.h:106
std::string stringify(const T &t)
const VariableName _fluid_enthalpy_name
Name of the fluid specific enthalpy.
virtual void addLinearFVKernel(const std::string &kernel_name, const std::string &name, InputParameters &parameters)
const bool _solve_for_enthalpy
User-selected option to solve for enthalpy.
std::vector< MooseFunctorName > _ambient_convection_alpha
Name of the ambient convection heat transfer coefficients for each block-group.

◆ addEnergyExternalHeatSource()

void WCNSLinearFVFluidHeatTransferPhysics::addEnergyExternalHeatSource ( )
overrideprivatevirtual

Implements WCNSFVFluidHeatTransferPhysicsBase.

Definition at line 204 of file WCNSLinearFVFluidHeatTransferPhysics.C.

205 {
206  const std::string kernel_type = "LinearFVSource";
207  InputParameters params = getFactory().getValidParams(kernel_type);
208  params.set<LinearVariableName>("variable") =
210  assignBlocks(params, _blocks);
211  params.set<MooseFunctorName>("source_density") =
212  getParam<MooseFunctorName>("external_heat_source");
213  params.set<MooseFunctorName>("scaling_factor") =
214  std::to_string(getParam<Real>("external_heat_source_coeff"));
215 
216  getProblem().addLinearFVKernel(kernel_type, prefix() + "external_heat_source", params);
217 }
std::string prefix() const
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
VariableName _fluid_temperature_name
Fluid temperature name.
std::vector< SubdomainName > _blocks
virtual FEProblemBase & getProblem()
const VariableName _fluid_enthalpy_name
Name of the fluid specific enthalpy.
virtual void addLinearFVKernel(const std::string &kernel_name, const std::string &name, InputParameters &parameters)
const bool _solve_for_enthalpy
User-selected option to solve for enthalpy.

◆ addEnergyHeatConductionKernels()

void WCNSLinearFVFluidHeatTransferPhysics::addEnergyHeatConductionKernels ( )
overrideprivatevirtual

Implements WCNSFVFluidHeatTransferPhysicsBase.

Definition at line 124 of file WCNSLinearFVFluidHeatTransferPhysics.C.

125 {
126  const auto num_blocks = _thermal_conductivity_blocks.size();
127  const auto num_used_blocks = num_blocks ? num_blocks : 1;
128 
129  for (const auto block_i : make_range(num_used_blocks))
130  {
131  std::string block_name = "";
132  if (num_blocks)
133  block_name = Moose::stringify(_thermal_conductivity_blocks[block_i]);
134  else
135  block_name = "all";
136 
137  const std::string kernel_type = "LinearFVDiffusion";
138  InputParameters params = getFactory().getValidParams(kernel_type);
139  if (!_solve_for_enthalpy)
140  {
141  params.set<LinearVariableName>("variable") = _fluid_temperature_name;
142  params.set<MooseFunctorName>("diffusion_coeff") = _thermal_conductivity_name[block_i];
143  }
144  else
145  {
146  params.set<LinearVariableName>("variable") = _fluid_enthalpy_name;
147  params.set<MooseFunctorName>("diffusion_coeff") =
148  _thermal_conductivity_name[block_i] + "_by_cp";
149  }
150  std::vector<SubdomainName> block_names =
151  num_blocks ? _thermal_conductivity_blocks[block_i] : _blocks;
152  assignBlocks(params, block_names);
153  // NOTE: vector conductivities not supported at this time
154  bool has_vector = processThermalConductivity();
155  if (has_vector)
156  paramError("thermal_conductivity",
157  "Vector thermal conductivities not currently supported with the linear finite "
158  "volume discretization");
159 
160  params.set<bool>("use_nonorthogonal_correction") =
161  getParam<bool>("use_nonorthogonal_correction");
162 
164  kernel_type, prefix() + "ins_energy_diffusion_" + block_name, params);
165  }
166 }
std::string prefix() const
void assignBlocks(InputParameters &params, const std::vector< SubdomainName > &blocks) const
Factory & getFactory()
void paramError(const std::string &param, Args... args) const
T & set(const std::string &name, bool quiet_mode=false)
InputParameters getValidParams(const std::string &name) const
VariableName _fluid_temperature_name
Fluid temperature name.
std::vector< SubdomainName > _blocks
virtual FEProblemBase & getProblem()
std::string stringify(const T &t)
const VariableName _fluid_enthalpy_name
Name of the fluid specific enthalpy.
virtual void addLinearFVKernel(const std::string &kernel_name, const std::string &name, InputParameters &parameters)
std::vector< std::vector< SubdomainName > > _thermal_conductivity_blocks
Vector of subdomain groups where we want to have different thermal conduction.
bool processThermalConductivity()
Process thermal conductivity (multiple functor input options are available).
std::vector< MooseFunctorName > _thermal_conductivity_name
Name of the thermal conductivity functor for each block-group.
IntRange< T > make_range(T beg, T end)
const bool _solve_for_enthalpy
User-selected option to solve for enthalpy.

◆ addEnergyInletBC()

void WCNSLinearFVFluidHeatTransferPhysics::addEnergyInletBC ( )
overrideprivatevirtual

Functions adding boundary conditions for the incompressible / weakly compressible energy equation.

Implements WCNSFVFluidHeatTransferPhysicsBase.

Definition at line 260 of file WCNSLinearFVFluidHeatTransferPhysics.C.

261 {
262  const auto & inlet_boundaries = _flow_equations_physics->getInletBoundaries();
263  // These are parameter errors for now. If Components add boundaries to Physics, the error
264  // may not be due to parameters anymore.
265  if (inlet_boundaries.size() != _energy_inlet_types.size())
266  paramError("energy_inlet_types",
267  "Energy inlet types (size " + std::to_string(_energy_inlet_types.size()) +
268  ") should be the same size as inlet_boundaries (size " +
269  std::to_string(inlet_boundaries.size()) + ")");
270  if (inlet_boundaries.size() != _energy_inlet_functors.size())
271  paramError("energy_inlet_functors",
272  "Energy inlet functors (size " + std::to_string(_energy_inlet_functors.size()) +
273  ") should be the same size as inlet_boundaries (size " +
274  std::to_string(inlet_boundaries.size()) + ")");
275 
276  for (const auto bc_ind : index_range(_energy_inlet_types))
277  {
278  if (_energy_inlet_types[bc_ind] == "fixed-temperature")
279  {
280  const std::string bc_type = "LinearFVAdvectionDiffusionFunctorDirichletBC";
281  InputParameters params = getFactory().getValidParams(bc_type);
282  params.set<LinearVariableName>("variable") = _fluid_temperature_name;
283  params.set<MooseFunctorName>("functor") = _energy_inlet_functors[bc_ind];
284  params.set<std::vector<BoundaryName>>("boundary") = {inlet_boundaries[bc_ind]};
285 
287  bc_type, _fluid_temperature_name + "_" + inlet_boundaries[bc_ind], params);
288 
289  // Boundary condition on temperature must be forwarded to enthalpy
291  {
292  params.set<LinearVariableName>("variable") = _fluid_enthalpy_name;
293  params.set<MooseFunctorName>("functor") = "h_from_p_T";
295  bc_type, _fluid_enthalpy_name + "_" + inlet_boundaries[bc_ind], params);
296  }
297  }
298  else if (_energy_inlet_types[bc_ind] == "heatflux")
299  paramError("energy_inlet_types", "Heat flux inlet boundary conditions not yet supported");
300  else if (_energy_inlet_types[bc_ind] == "flux-mass" ||
301  _energy_inlet_types[bc_ind] == "flux-velocity")
302  paramError("energy_inlet_types", "Flux inlet boundary conditions not yet supported");
303  }
304 }
Factory & getFactory()
void paramError(const std::string &param, Args... args) const
const std::vector< BoundaryName > & getInletBoundaries() const
Get the inlet boundaries.
T & set(const std::string &name, bool quiet_mode=false)
InputParameters getValidParams(const std::string &name) const
unsigned int size() const
VariableName _fluid_temperature_name
Fluid temperature name.
MultiMooseEnum _energy_inlet_types
Energy inlet boundary types.
virtual FEProblemBase & getProblem()
const VariableName _fluid_enthalpy_name
Name of the fluid specific enthalpy.
std::vector< MooseFunctorName > _energy_inlet_functors
Functors describing the inlet boundary values. See energy_inlet_types for what the functors actually ...
virtual void addLinearFVBC(const std::string &fv_bc_name, const std::string &name, InputParameters &parameters)
const bool _solve_for_enthalpy
User-selected option to solve for enthalpy.
const WCNSFVFlowPhysicsBase * _flow_equations_physics
Flow physics.
auto index_range(const T &sizable)

◆ addEnergyOutletBC()

void WCNSLinearFVFluidHeatTransferPhysics::addEnergyOutletBC ( )
overrideprivatevirtual

Implements WCNSFVFluidHeatTransferPhysicsBase.

Definition at line 387 of file WCNSLinearFVFluidHeatTransferPhysics.C.

388 {
389  const auto & outlet_boundaries = _flow_equations_physics->getOutletBoundaries();
390  if (outlet_boundaries.empty())
391  return;
392 
393  for (const auto & outlet_bdy : outlet_boundaries)
394  {
395  const std::string bc_type = "LinearFVAdvectionDiffusionOutflowBC";
397  InputParameters params = getFactory().getValidParams(bc_type);
398  params.set<std::vector<BoundaryName>>("boundary") = {outlet_bdy};
399  params.set<bool>("use_two_term_expansion") = getParam<bool>("energy_two_term_bc_expansion");
400 
401  params.set<LinearVariableName>("variable") = variable_name;
402  getProblem().addLinearFVBC(bc_type, variable_name + "_" + outlet_bdy, params);
403  }
404 }
Factory & getFactory()
const std::vector< BoundaryName > & getOutletBoundaries() const
Get the outlet boundaries.
T & set(const std::string &name, bool quiet_mode=false)
InputParameters getValidParams(const std::string &name) const
VariableName _fluid_temperature_name
Fluid temperature name.
virtual FEProblemBase & getProblem()
const VariableName _fluid_enthalpy_name
Name of the fluid specific enthalpy.
virtual void addLinearFVBC(const std::string &fv_bc_name, const std::string &name, InputParameters &parameters)
const bool _solve_for_enthalpy
User-selected option to solve for enthalpy.
const WCNSFVFlowPhysicsBase * _flow_equations_physics
Flow physics.

◆ addEnergySeparatorBC()

void WCNSLinearFVFluidHeatTransferPhysics::addEnergySeparatorBC ( )
inlineoverrideprivatevirtual

Implements WCNSFVFluidHeatTransferPhysicsBase.

Definition at line 45 of file WCNSLinearFVFluidHeatTransferPhysics.h.

45 {}

◆ addEnergyTimeKernels()

void WCNSLinearFVFluidHeatTransferPhysics::addEnergyTimeKernels ( )
overrideprivatevirtual

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

Implements WCNSFVFluidHeatTransferPhysicsBase.

Definition at line 81 of file WCNSLinearFVFluidHeatTransferPhysics.C.

82 {
83  std::string kernel_type = "LinearFVTimeDerivative";
84  std::string kernel_name = prefix() + "ins_energy_time";
85 
86  InputParameters params = getFactory().getValidParams(kernel_type);
87  params.set<LinearVariableName>("variable") =
89  assignBlocks(params, _blocks);
91  params.set<MooseFunctorName>("factor") = "rho_cp";
92  else
93  params.set<MooseFunctorName>("factor") = _density_name;
94 
95  getProblem().addLinearFVKernel(kernel_type, kernel_name, params);
96 }
std::string prefix() const
void assignBlocks(InputParameters &params, const std::vector< SubdomainName > &blocks) const
const MooseFunctorName _density_name
Name of the density material property.
Factory & getFactory()
T & set(const std::string &name, bool quiet_mode=false)
InputParameters getValidParams(const std::string &name) const
VariableName _fluid_temperature_name
Fluid temperature name.
std::vector< SubdomainName > _blocks
virtual FEProblemBase & getProblem()
const VariableName _fluid_enthalpy_name
Name of the fluid specific enthalpy.
virtual void addLinearFVKernel(const std::string &kernel_name, const std::string &name, InputParameters &parameters)
const bool _solve_for_enthalpy
User-selected option to solve for enthalpy.

◆ addEnergyWallBC()

void WCNSLinearFVFluidHeatTransferPhysics::addEnergyWallBC ( )
overrideprivatevirtual

Implements WCNSFVFluidHeatTransferPhysicsBase.

Definition at line 307 of file WCNSLinearFVFluidHeatTransferPhysics.C.

308 {
309  const auto & wall_boundaries = isParamSetByUser("energy_wall_boundaries")
310  ? getParam<std::vector<BoundaryName>>("energy_wall_boundaries")
312  if (wall_boundaries.size() != _energy_wall_types.size())
313  paramError("energy_wall_types",
314  "Energy wall types (size " + std::to_string(_energy_wall_types.size()) +
315  ") should be the same size as wall_boundaries (size " +
316  std::to_string(wall_boundaries.size()) + ")");
317  if (wall_boundaries.size() != _energy_wall_functors.size())
318  paramError("energy_wall_functors",
319  "Energy wall functors (size " + std::to_string(_energy_wall_functors.size()) +
320  ") should be the same size as wall_boundaries (size " +
321  std::to_string(wall_boundaries.size()) + ")");
322 
323  for (unsigned int bc_ind = 0; bc_ind < _energy_wall_types.size(); ++bc_ind)
324  {
325  if (_energy_wall_types[bc_ind] == "fixed-temperature")
326  {
327  const std::string bc_type = "LinearFVAdvectionDiffusionFunctorDirichletBC";
328  InputParameters params = getFactory().getValidParams(bc_type);
329  params.set<LinearVariableName>("variable") = _fluid_temperature_name;
330  params.set<MooseFunctorName>("functor") = _energy_wall_functors[bc_ind];
331  params.set<std::vector<BoundaryName>>("boundary") = {wall_boundaries[bc_ind]};
332 
334  bc_type, _fluid_temperature_name + "_" + wall_boundaries[bc_ind], params);
335 
336  // Boundary condition on temperature must be forwarded to enthalpy
338  {
339  params.set<LinearVariableName>("variable") = _fluid_enthalpy_name;
340  params.set<MooseFunctorName>("functor") = "h_from_p_T";
342  bc_type, _fluid_enthalpy_name + "_" + wall_boundaries[bc_ind], params);
343  }
344  }
345  else if (_energy_wall_types[bc_ind] == "heatflux")
346  {
347  const std::string bc_type = "LinearFVAdvectionDiffusionFunctorNeumannBC";
348  InputParameters params = getFactory().getValidParams(bc_type);
350  params.set<LinearVariableName>("variable") = var_name;
351  params.set<MooseFunctorName>("functor") = _energy_wall_functors[bc_ind];
352  params.set<std::vector<BoundaryName>>("boundary") = {wall_boundaries[bc_ind]};
353 
355  bc_type, var_name + "_heatflux_" + wall_boundaries[bc_ind], params);
356  }
357  else if (_energy_wall_types[bc_ind] == "convection")
358  {
359  const std::string bc_type = "LinearFVConvectiveHeatTransferBC";
360  InputParameters params = getFactory().getValidParams(bc_type);
361  params.set<LinearVariableName>("variable") =
363  params.set<MooseFunctorName>(NS::T_fluid) = _fluid_temperature_name;
364  const auto Tinf_htc_functors =
365  MooseUtils::split(_energy_wall_functors[bc_ind], /*delimiter=*/":", /*max_count=*/1);
366  if (Tinf_htc_functors.size() != 2)
367  paramError("energy_wall_functors",
368  "'convection' wall types require two functors specified as "
369  "<Tinf_functor>:<htc_functor>.");
370  params.set<MooseFunctorName>(NS::T_solid) = Tinf_htc_functors[0];
371  params.set<MooseFunctorName>("h") = Tinf_htc_functors[1];
372  params.set<std::vector<BoundaryName>>("boundary") = {wall_boundaries[bc_ind]};
373 
375  bc_type,
377  wall_boundaries[bc_ind],
378  params);
379  }
380  else
381  paramError(
382  "energy_wall_types", _energy_wall_types[bc_ind], " wall type is currently unsupported.");
383  }
384 }
Factory & getFactory()
void paramError(const std::string &param, Args... args) const
static const std::string T_solid
Definition: NS.h:107
T & set(const std::string &name, bool quiet_mode=false)
InputParameters getValidParams(const std::string &name) const
unsigned int size() const
VariableName _fluid_temperature_name
Fluid temperature name.
MultiMooseEnum _energy_wall_types
Energy wall boundary types.
std::vector< MooseFunctorName > _energy_wall_functors
Functors describing the wall boundary values. See energy_wall_types for what the functors actually re...
virtual FEProblemBase & getProblem()
static const std::string T_fluid
Definition: NS.h:106
const VariableName _fluid_enthalpy_name
Name of the fluid specific enthalpy.
virtual void addLinearFVBC(const std::string &fv_bc_name, const std::string &name, InputParameters &parameters)
const bool _solve_for_enthalpy
User-selected option to solve for enthalpy.
std::vector< std::string > split(const std::string &str, const std::string &delimiter, std::size_t max_count)
bool isParamSetByUser(const std::string &name) const
const WCNSFVFlowPhysicsBase * _flow_equations_physics
Flow physics.
const std::vector< BoundaryName > & getWallBoundaries() const
Get the wall boundaries.

◆ addFVBCs()

void WCNSFVFluidHeatTransferPhysicsBase::addFVBCs ( )
overrideprotectedvirtualinherited

Reimplemented from PhysicsBase.

Definition at line 145 of file WCNSFVFluidHeatTransferPhysicsBase.C.

146 {
147  // For compatibility with Modules/NavierStokesFV syntax
149  return;
150 
152  addEnergyWallBC();
155 }
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 ( )
overrideprotectedvirtualinherited

Reimplemented from PhysicsBase.

Definition at line 124 of file WCNSFVFluidHeatTransferPhysicsBase.C.

125 {
126  // For compatibility with Modules/NavierStokesFV syntax
128  return;
129 
132  _blocks,
133  /*error if already defined*/ false))
135 
138  if (getParam<std::vector<MooseFunctorName>>("ambient_temperature").size())
140  if (isParamValid("external_heat_source"))
142 }
virtual void addEnergyExternalHeatSource()=0
virtual void addEnergyTimeKernels()=0
Functions adding kernels for the incompressible / weakly compressible energy equation.
const T & getParam(const std::string &name) const
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
virtual void addEnergyAdvectionKernels()=0
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.
bool isParamValid(const std::string &name) const
virtual void addEnergyHeatConductionKernels()=0

◆ addInitialConditions()

void WCNSFVFluidHeatTransferPhysicsBase::addInitialConditions ( )
overrideprotectedvirtualinherited

Reimplemented from PhysicsBase.

Definition at line 211 of file WCNSFVFluidHeatTransferPhysicsBase.C.

212 {
213  // For compatibility with Modules/NavierStokesFV syntax
215  return;
216  if (!_define_variables && parameters().isParamSetByUser("initial_temperature"))
217  paramError(
218  "initial_temperature",
219  "T_fluid is defined externally of WCNSFVFluidHeatTransferPhysicsBase, so should the inital "
220  "condition");
221  // do not set initial conditions if we are not defining variables
222  if (!_define_variables)
223  {
224  reportPotentiallyMissedParameters({"initial_temperature", "initial_enthalpy"}, "FunctionIC");
225  return;
226  }
227 
228  InputParameters params = getFactory().getValidParams("FVFunctionIC");
229  assignBlocks(params, _blocks);
230 
231  // initial_temperature has a default so we should almost always set it (see shouldCreateIC logic)
232  {
233  bool temperature_ic_used = false;
236  _blocks,
237  /*whether IC is a default*/ !isParamSetByUser("initial_temperature"),
238  /*error if already an IC*/ isParamSetByUser("initial_temperature")))
239  {
240  params.set<VariableName>("variable") = _fluid_temperature_name;
241  params.set<FunctionName>("function") = getParam<FunctionName>("initial_temperature");
242 
243  getProblem().addFVInitialCondition("FVFunctionIC", _fluid_temperature_name + "_ic", params);
244  temperature_ic_used = true;
245  }
246  // Needed to solve for enthalpy: an initial condition on enthalpy based on the initial
247  // temperature
248  if (isParamValid(NS::fluid) && _solve_for_enthalpy && !isParamValid("initial_enthalpy") &&
250  _blocks,
251  /*whether IC is a default*/ !isParamSetByUser("initial_temperature"),
252  /*error if already an IC*/ isParamSetByUser("initial_temperature")))
253  {
254  // from the FluidProperties module
255  InputParameters params =
256  getFactory().getValidParams("SpecificEnthalpyFromPressureTemperatureIC");
257  assignBlocks(params, _blocks);
258  params.set<VariableName>("variable") = _fluid_enthalpy_name;
259  params.set<UserObjectName>(NS::fluid) = getParam<UserObjectName>(NS::fluid);
260  params.set<std::vector<VariableName>>("p") = {_flow_equations_physics->getPressureName()};
261  Real temp;
262  if (MooseUtils::parsesToReal(getParam<FunctionName>("initial_temperature"), &temp))
263  {
264  params.defaultCoupledValue("T", temp, 0);
265  params.set<std::vector<VariableName>>("T") = {};
266  }
267  else
268  paramError("initial_temperature", "Only Real values supported when solving for enthalpy");
270  "SpecificEnthalpyFromPressureTemperatureIC", _fluid_enthalpy_name + "_ic", params);
271  temperature_ic_used = true;
272  }
273 
274  if (!temperature_ic_used && isParamSetByUser("initial_temperature"))
275  reportPotentiallyMissedParameters({"initial_temperature"}, "FunctionIC");
276  }
277  if (isParamValid("initial_enthalpy") && _solve_for_enthalpy &&
279  _blocks,
280  /*whether IC is a default*/ false,
281  /*error if already an IC*/ false))
282  {
283  params.set<VariableName>("variable") = _fluid_enthalpy_name;
284  params.set<FunctionName>("function") = getParam<FunctionName>("initial_enthalpy");
285 
286  getProblem().addFVInitialCondition("FVFunctionIC", _fluid_enthalpy_name + "_ic", params);
287  }
288  else if (isParamValid("initial_enthalpy"))
289  reportPotentiallyMissedParameters({"initial_enthalpy"}, "FunctionIC");
290 }
virtual void addFVInitialCondition(const std::string &ic_name, const std::string &name, InputParameters &parameters)
void assignBlocks(InputParameters &params, const std::vector< SubdomainName > &blocks) const
Factory & getFactory()
void paramError(const std::string &param, Args... args) const
const InputParameters & parameters() const
T & set(const std::string &name, bool quiet_mode=false)
InputParameters getValidParams(const std::string &name) const
static const std::string fluid
Definition: NS.h:87
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
virtual void addInitialCondition(const std::string &ic_name, const std::string &name, InputParameters &parameters)
virtual FEProblemBase & getProblem()
Real defaultCoupledValue(const std::string &coupling_name, unsigned int i=0) 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 variableExists(const VariableName &var_name, bool error_if_aux) const
bool _define_variables
Whether to define variables if they do not exist.
DIE A HORRIBLE DEATH HERE typedef LIBMESH_DEFAULT_SCALAR_TYPE Real
const bool _solve_for_enthalpy
User-selected option to solve for enthalpy.
bool isParamValid(const std::string &name) const
void reportPotentiallyMissedParameters(const std::vector< std::string > &param_names, const std::string &object_type) const
bool parsesToReal(const std::string &input, Real *parsed_real)
bool isParamSetByUser(const std::string &name) const
const WCNSFVFlowPhysicsBase * _flow_equations_physics
Flow physics.
const NonlinearVariableName & getPressureName() const

◆ addMaterials()

void WCNSLinearFVFluidHeatTransferPhysics::addMaterials ( )
overrideprivatevirtual

Reimplemented from PhysicsBase.

Definition at line 407 of file WCNSLinearFVFluidHeatTransferPhysics.C.

408 {
409  // For compatibility with Modules/NavierStokesFV syntax
411  return;
412 
413  // Note that this material choice would not work for Newton-INSFV + solve_for_enthalpy
414  const auto object_type = "LinearFVEnthalpyFunctorMaterial";
415 
416  InputParameters params = getFactory().getValidParams(object_type);
417  assignBlocks(params, _blocks);
418  params.set<MooseFunctorName>(NS::pressure) = _flow_equations_physics->getPressureName();
419  params.set<MooseFunctorName>(NS::T_fluid) = _fluid_temperature_name;
420  params.set<MooseFunctorName>(NS::specific_enthalpy) = _fluid_enthalpy_name;
421 
423  {
424  if (isParamValid(NS::fluid))
425  params.set<UserObjectName>(NS::fluid) = getParam<UserObjectName>(NS::fluid);
426  else
427  {
428  if (!getProblem().hasFunctor("h_from_p_T_functor", 0) ||
429  !getProblem().hasFunctor("T_from_p_h_functor", 0))
431  "Either 'fp' must be specified or the 'h_from_p_T_functor' and "
432  "'T_from_p_h_functor' must be defined outside the Physics");
433  // Note: we could define those in the Physics if cp is constant
434  params.set<MooseFunctorName>("h_from_p_T_functor") = "h_from_p_T_functor";
435  params.set<MooseFunctorName>("T_from_p_h_functor") = "T_from_p_h_functor";
436  }
437  }
438 
439  // We don't need it so far otherwise
441  getProblem().addMaterial(object_type, prefix() + "enthalpy_material", params);
442 
445 }
std::string prefix() const
void defineKOverCpFunctors(const bool use_ad)
Define the k/cp diffusion coefficients when solving for enthalpy.
void assignBlocks(InputParameters &params, const std::vector< SubdomainName > &blocks) const
Factory & getFactory()
void paramError(const std::string &param, Args... args) const
virtual void addMaterial(const std::string &material_name, const std::string &name, InputParameters &parameters)
T & set(const std::string &name, bool quiet_mode=false)
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
virtual FEProblemBase & getProblem()
static const std::string T_fluid
Definition: NS.h:106
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 isParamValid(const std::string &name) const
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

◆ addSolverVariables()

void WCNSLinearFVFluidHeatTransferPhysics::addSolverVariables ( )
overrideprivatevirtual

Reimplemented from PhysicsBase.

Definition at line 55 of file WCNSLinearFVFluidHeatTransferPhysics.C.

56 {
57  // For compatibility with Modules/NavierStokesFV syntax
59  return;
60 
62 
63  // Dont add if the user already defined the variable
64  if (!shouldCreateVariable(variable_name, _blocks, /*error if aux*/ true))
65  reportPotentiallyMissedParameters({"system_names"}, "MooseLinearVariableFVReal");
66  else if (_define_variables)
67  {
68  const auto var_type = "MooseLinearVariableFVReal";
69  auto params = getFactory().getValidParams(var_type);
70  assignBlocks(params, _blocks);
71  params.set<SolverSystemName>("solver_sys") = getSolverSystem(variable_name);
72  getProblem().addVariable(var_type, variable_name, params);
73  }
74  else
75  paramError(_solve_for_enthalpy ? "solve_for_enthalpy" : "fluid_temperature_variable",
76  "Variable (" + variable_name +
77  ") supplied to the WCNSLinearFVFluidHeatTransferPhysics does not exist!");
78 }
void assignBlocks(InputParameters &params, const std::vector< SubdomainName > &blocks) const
bool shouldCreateVariable(const VariableName &var_name, const std::vector< SubdomainName > &blocks, const bool error_if_aux)
Factory & getFactory()
void paramError(const std::string &param, Args... args) const
InputParameters getValidParams(const std::string &name) const
VariableName _fluid_temperature_name
Fluid temperature name.
std::vector< SubdomainName > _blocks
virtual FEProblemBase & getProblem()
const SolverSystemName & getSolverSystem(unsigned int variable_index) const
const VariableName _fluid_enthalpy_name
Name of the fluid specific enthalpy.
virtual void addVariable(const std::string &var_type, const std::string &var_name, InputParameters &params)
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.
const bool _solve_for_enthalpy
User-selected option to solve for enthalpy.
void reportPotentiallyMissedParameters(const std::vector< std::string > &param_names, const std::string &object_type) const

◆ defineKOverCpFunctors()

void WCNSFVFluidHeatTransferPhysicsBase::defineKOverCpFunctors ( const bool  use_ad)
protectedinherited

Define the k/cp diffusion coefficients when solving for enthalpy.

Definition at line 293 of file WCNSFVFluidHeatTransferPhysicsBase.C.

Referenced by WCNSFVFluidHeatTransferPhysics::addMaterials(), and addMaterials().

294 {
295  // Define alpha, the diffusion coefficient when solving for enthalpy, on each block
296  for (unsigned int i = 0; i < _thermal_conductivity_name.size(); ++i)
297  {
298  const auto object_type = use_ad ? "ADParsedFunctorMaterial" : "ParsedFunctorMaterial";
299  InputParameters params = getFactory().getValidParams(object_type);
300  assignBlocks(params, _blocks);
301  std::vector<std::string> f_names;
303  f_names.push_back(_thermal_conductivity_name[i]);
305  f_names.push_back(getSpecificHeatName());
306  params.set<std::vector<std::string>>("functor_names") = f_names;
307  params.set<std::string>("expression") =
309  params.set<std::string>("property_name") = _thermal_conductivity_name[i] + "_by_cp";
311  object_type, prefix() + "rho_alpha_from_" + _thermal_conductivity_name[i], params);
312  }
313 }
std::string prefix() const
void assignBlocks(InputParameters &params, const std::vector< SubdomainName > &blocks) const
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)
InputParameters getValidParams(const std::string &name) const
std::vector< SubdomainName > _blocks
virtual FEProblemBase & getProblem()
const MooseFunctorName & getSpecificHeatName() const
Get the name of the specific heat material property.
std::vector< MooseFunctorName > _thermal_conductivity_name
Name of the thermal conductivity functor for each block-group.
bool parsesToReal(const std::string &input, Real *parsed_real)

◆ 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
inlineinherited

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
inlineinherited

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 }
const T & getParam(const std::string &name) const
void mooseError(Args &&... args)
const T * getCoupledPhysics(const PhysicsName &phys_name, const bool allow_fail=false) const
Base class for Physics which create the Navier Stokes flow equations.
bool checkBlockRestrictionIdentical(const std::string &object_name, const std::vector< SubdomainName > &blocks, const bool error_if_not_identical=true) const
bool isParamValid(const std::string &name) 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 WCNSFVFluidHeatTransferPhysicsBase::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 & getParam(const std::string &name) const
const T * getCoupledPhysics(const PhysicsName &phys_name, const bool allow_fail=false) const
bool checkBlockRestrictionIdentical(const std::string &object_name, const std::vector< SubdomainName > &blocks, const bool error_if_not_identical=true) const
bool isParamValid(const std::string &name) const
const NavierStokesPhysicsBase * _advection_physics
The Physics class using this helper.

◆ getFluidTemperatureName()

const VariableName& WCNSFVFluidHeatTransferPhysicsBase::getFluidTemperatureName ( ) const
inlineinherited

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
overrideprotectedvirtualinherited

Return the number of ghosting layers needed.

Implements NavierStokesPhysicsBase.

Definition at line 316 of file WCNSFVFluidHeatTransferPhysicsBase.C.

317 {
318  unsigned short necessary_layers = getParam<unsigned short>("ghost_layers");
319  necessary_layers =
321  if (getParam<MooseEnum>("energy_face_interpolation") == "skewness-corrected")
322  necessary_layers = std::max(necessary_layers, (unsigned short)3);
323 
324  return necessary_layers;
325 }
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
inlineinherited

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
inlineinherited

◆ getThermalConductivityName()

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

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
inlineinherited

◆ processThermalConductivity()

bool WCNSFVFluidHeatTransferPhysicsBase::processThermalConductivity ( )
protectedinherited

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

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

Definition at line 166 of file WCNSFVFluidHeatTransferPhysicsBase.C.

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

167 {
168  checkBlockwiseConsistency<MooseFunctorName>("thermal_conductivity_blocks",
169  {"thermal_conductivity"});
170  bool have_scalar = false;
171  bool have_vector = false;
172 
173  for (unsigned int i = 0; i < _thermal_conductivity_name.size(); ++i)
174  {
175  // First, check if the name is just a number (only in case of isotropic conduction)
177  have_scalar = true;
178  // Now we determine what kind of functor we are dealing with
179  else
180  {
182  /*thread_id=*/0) ||
184  /*thread_id=*/0))
185  have_scalar = true;
186  else
187  {
189  /*thread_id=*/0))
190  have_vector = true;
191  else
192  paramError("thermal_conductivity",
193  "We only allow functor of type Real/ADReal or ADRealVectorValue for thermal "
194  "conductivity! Functor '" +
195  _thermal_conductivity_name[i] + "' is not of the requested type.");
196  }
197  }
198  }
199 
200  if (have_vector && !_porous_medium_treatment)
201  paramError("thermal_conductivity", "Cannot use anisotropic diffusion with non-porous flows!");
202 
203  if (have_vector == have_scalar)
204  paramError("thermal_conductivity",
205  "The entries on thermal conductivity shall either be scalars of vectors, mixing "
206  "them is not supported!");
207  return have_vector;
208 }
void paramError(const std::string &param, Args... args) const
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.
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.
bool parsesToReal(const std::string &input, Real *parsed_real)

◆ 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 WCNSLinearFVFluidHeatTransferPhysics::validParams ( )
static

Definition at line 22 of file WCNSLinearFVFluidHeatTransferPhysics.C.

23 {
25  params.addParam<bool>(
26  "use_nonorthogonal_correction",
27  true,
28  "Whether to use a non-orthogonal correction. This can potentially slow down convergence "
29  ", but reduces numerical dispersion on non-orthogonal meshes. Can be safely turned off on "
30  "orthogonal meshes.");
31  params.set<std::vector<SolverSystemName>>("system_names") = {"energy_system"};
32 
33  // We could split between discretization and solver here.
34  params.addParamNamesToGroup("use_nonorthogonal_correction system_names", "Numerical scheme");
35 
36  // Not implemented
37  params.suppressParameter<bool>("effective_conductivity");
38  // Not needed
39  params.suppressParameter<bool>("add_energy_equation");
40  params.suppressParameter<MooseEnum>("preconditioning");
41 
42  return params;
43 }
void addParam(const std::string &name, const std::initializer_list< typename T::value_type > &value, const std::string &doc_string)
T & set(const std::string &name, bool quiet_mode=false)
void suppressParameter(const std::string &name)
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
protectedinherited

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

Definition at line 107 of file WCNSFVFluidHeatTransferPhysicsBase.h.

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

◆ _ambient_convection_blocks

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

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

Definition at line 105 of file WCNSFVFluidHeatTransferPhysicsBase.h.

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

◆ _ambient_temperature

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

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

Definition at line 109 of file WCNSFVFluidHeatTransferPhysicsBase.h.

Referenced by WCNSFVFluidHeatTransferPhysics::addEnergyAmbientConvection(), and 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
protectedinherited

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

Definition at line 114 of file WCNSFVFluidHeatTransferPhysicsBase.h.

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

◆ _energy_inlet_types

MultiMooseEnum WCNSFVFluidHeatTransferPhysicsBase::_energy_inlet_types
protectedinherited

Energy inlet boundary types.

Definition at line 112 of file WCNSFVFluidHeatTransferPhysicsBase.h.

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

◆ _energy_wall_functors

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

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

Definition at line 118 of file WCNSFVFluidHeatTransferPhysicsBase.h.

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

◆ _energy_wall_types

MultiMooseEnum WCNSFVFluidHeatTransferPhysicsBase::_energy_wall_types
protectedinherited

Energy wall boundary types.

Definition at line 116 of file WCNSFVFluidHeatTransferPhysicsBase.h.

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

◆ _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(), addEnergyAdvectionKernels(), WCNSFVFluidHeatTransferPhysics::addEnergyAdvectionKernels(), WCNSFVFluidHeatTransferPhysics::addEnergyHeatConductionKernels(), addEnergyInletBC(), WCNSFVFluidHeatTransferPhysics::addEnergyInletBC(), addEnergyOutletBC(), WCNSFVFluidHeatTransferPhysics::addEnergySeparatorBC(), WCNSFVFluidHeatTransferPhysics::addEnergyTimeKernels(), addEnergyWallBC(), WCNSFVFluidHeatTransferPhysics::addEnergyWallBC(), WCNSFVTurbulencePhysics::addFlowTurbulenceKernels(), WCNSFVTurbulencePhysics::addFluidEnergyTurbulenceKernels(), WCNSFVTurbulencePhysics::addFVBCs(), WCNSLinearFVTwoPhaseMixturePhysics::addFVKernels(), WCNSFVTwoPhaseMixturePhysics::addFVKernels(), WCNSFVTurbulencePhysics::addInitialConditions(), WCNSFVFluidHeatTransferPhysicsBase::addInitialConditions(), WCNSFVTurbulencePhysics::addKEpsilonAdvection(), WCNSFVTurbulencePhysics::addKEpsilonDiffusion(), WCNSFVTurbulencePhysics::addKEpsilonSink(), WCNSFVFluidHeatTransferPhysics::addMaterials(), addMaterials(), WCNSLinearFVTwoPhaseMixturePhysics::addMaterials(), WCNSFVTwoPhaseMixturePhysics::addMaterials(), WCNSFVTurbulencePhysics::addMaterials(), WCNSLinearFVTwoPhaseMixturePhysics::addPhaseDriftFluxTerm(), WCNSFVTwoPhaseMixturePhysics::addPhaseDriftFluxTerm(), WCNSFVScalarTransportPhysics::addScalarAdvectionKernels(), WCNSLinearFVScalarTransportPhysics::addScalarAdvectionKernels(), WCNSLinearFVScalarTransportPhysics::addScalarInletBC(), WCNSFVScalarTransportPhysics::addScalarInletBC(), WCNSLinearFVScalarTransportPhysics::addScalarOutletBC(), WCNSLinearFVTwoPhaseMixturePhysics::checkIntegrity(), WCNSFVTurbulencePhysics::getNumberAlgebraicGhostingLayersNeeded(), WCNSFVFluidHeatTransferPhysicsBase::getNumberAlgebraicGhostingLayersNeeded(), WCNSFVScalarTransportPhysicsBase::getNumberAlgebraicGhostingLayersNeeded(), WCNSFVCoupledAdvectionPhysicsHelper::getPorosityFunctorName(), WCNSFVTurbulencePhysics::retrieveCoupledPhysics(), WCNSFVFluidHeatTransferPhysicsBase::WCNSFVFluidHeatTransferPhysicsBase(), WCNSFVTwoPhaseMixturePhysics::WCNSFVTwoPhaseMixturePhysics(), WCNSLinearFVScalarTransportPhysics::WCNSLinearFVScalarTransportPhysics(), and WCNSLinearFVTwoPhaseMixturePhysics::WCNSLinearFVTwoPhaseMixturePhysics().

◆ _fluid_enthalpy_name

const VariableName WCNSFVFluidHeatTransferPhysicsBase::_fluid_enthalpy_name
protectedinherited

◆ _fluid_temperature_name

VariableName WCNSFVFluidHeatTransferPhysicsBase::_fluid_temperature_name
protectedinherited

◆ _has_energy_equation

const bool WCNSFVFluidHeatTransferPhysicsBase::_has_energy_equation
protectedinherited

◆ _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
protectedinherited

◆ _specific_heat_name

MooseFunctorName WCNSFVFluidHeatTransferPhysicsBase::_specific_heat_name
protectedinherited

◆ _thermal_conductivity_blocks

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

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

Definition at line 100 of file WCNSFVFluidHeatTransferPhysicsBase.h.

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

◆ _thermal_conductivity_name

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

◆ _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: