- active__all__ If specified only the blocks named will be visited and made active
Default:__all__
C++ Type:std::vector<std::string>
Unit:(no unit assumed)
Controllable:No
Description:If specified only the blocks named will be visited and made active
- inactiveIf specified blocks matching these identifiers will be skipped.
C++ Type:std::vector<std::string>
Unit:(no unit assumed)
Controllable:No
Description:If specified blocks matching these identifiers will be skipped.
- add_flow_equationsTrueWhether to add the flow equations. This parameter is not necessary when using the Physics syntax
Default:True
C++ Type:bool
Unit:(no unit assumed)
Controllable:No
Description:Whether to add the flow equations. This parameter is not necessary when using the Physics syntax
- blockBlocks (subdomains) that this Physics is active on.
C++ Type:std::vector<SubdomainName>
Unit:(no unit assumed)
Controllable:No
Description:Blocks (subdomains) that this Physics is active on.
- compressibilityincompressibleCompressibility constraint for the Navier-Stokes equations.
Default:incompressible
C++ Type:MooseEnum
Unit:(no unit assumed)
Controllable:No
Description:Compressibility constraint for the Navier-Stokes equations.
- density_for_gravity_termsIf specified, replaces the 'density' for the Boussinesq and gravity momentum kernels. A functor is any of the following: a variable, a functor material property, a function, a post-processor, or a number.
C++ Type:MooseFunctorName
Unit:(no unit assumed)
Controllable:No
Description:If specified, replaces the 'density' for the Boussinesq and gravity momentum kernels. A functor is any of the following: a variable, a functor material property, a function, a post-processor, or a number.
- fluid_temperature_variableT_fluidName of the fluid temperature variable
Default:T_fluid
C++ Type:NonlinearVariableName
Unit:(no unit assumed)
Controllable:No
Description:Name of the fluid temperature variable
- flux_inlet_directionsThe directions which can be used to define the orientation of the flux with respect to the mesh. This can be used to define a flux which is incoming with an angle or to adjust the flux direction with respect to the normal. If the inlet surface is defined on an internal face, this is necessary to ensure the arbitrary orientation of the normal does not result in non-physical results.
C++ Type:std::vector<libMesh::Point>
Unit:(no unit assumed)
Controllable:No
Description:The directions which can be used to define the orientation of the flux with respect to the mesh. This can be used to define a flux which is incoming with an angle or to adjust the flux direction with respect to the normal. If the inlet surface is defined on an internal face, this is necessary to ensure the arbitrary orientation of the normal does not result in non-physical results.
- flux_inlet_ppsThe name of the postprocessors which compute the mass flow/ velocity magnitude. Mainly used for coupling between different applications.
C++ Type:std::vector<PostprocessorName>
Unit:(no unit assumed)
Controllable:No
Description:The name of the postprocessors which compute the mass flow/ velocity magnitude. Mainly used for coupling between different applications.
- include_deviatoric_stressFalseWhether to include the full expansion (the transposed term as well) of the stress tensor
Default:False
C++ Type:bool
Unit:(no unit assumed)
Controllable:No
Description:Whether to include the full expansion (the transposed term as well) of the stress tensor
- porosityporosityThe name of the auxiliary variable for the porosity field. A functor is any of the following: a variable, a functor material property, a function, a post-processor, or a number. A functor is any of the following: a variable, a functor material property, a function, a post-processor, or a number.
Default:porosity
C++ Type:MooseFunctorName
Unit:(no unit assumed)
Controllable:No
Description:The name of the auxiliary variable for the porosity field. A functor is any of the following: a variable, a functor material property, a function, a post-processor, or a number. A functor is any of the following: a variable, a functor material property, a function, a post-processor, or a number.
- porous_medium_treatmentFalseWhether to use porous medium kernels or not.
Default:False
C++ Type:bool
Unit:(no unit assumed)
Controllable:No
Description:Whether to use porous medium kernels or not.
- preconditioningnoneWhich preconditioning to use for this Physics
Default:none
C++ Type:MooseEnum
Unit:(no unit assumed)
Controllable:No
Description:Which preconditioning to use for this Physics
- transientsame_as_problemWhether the physics is to be solved as a transient
Default:same_as_problem
C++ Type:MooseEnum
Unit:(no unit assumed)
Controllable:No
Description:Whether the physics is to be solved as a transient
- verboseFalseFlag to facilitate debugging a Physics
Default:False
C++ Type:bool
Unit:(no unit assumed)
Controllable:No
Description:Flag to facilitate debugging a Physics
- add_energy_equationFalseWhether to add the energy equation. This parameter is not necessary if using the Physics syntax
Default:False
C++ Type:bool
Unit:(no unit assumed)
Controllable:No
Description:Whether to add the energy equation. This parameter is not necessary if using the Physics syntax
- effective_conductivityTrueWhether the conductivity should be multiplied by porosity, or whether the provided conductivity is an effective conductivity taking porosity effects into account
Default:True
C++ Type:bool
Unit:(no unit assumed)
Controllable:No
Description:Whether the conductivity should be multiplied by porosity, or whether the provided conductivity is an effective conductivity taking porosity effects into account
- initial_temperature300The initial temperature, assumed constant everywhere
Default:300
C++ Type:FunctionName
Unit:(no unit assumed)
Controllable:No
Description:The initial temperature, assumed constant everywhere
- add_scalar_equationFalseWhether to add the scalar transport equation. This parameter is not necessary if using the Physics syntax
Default:False
C++ Type:bool
Unit:(no unit assumed)
Controllable:No
Description:Whether to add the scalar transport equation. This parameter is not necessary if using the Physics syntax
- C_pl10Production Limiter Constant Multiplier.
Default:10
C++ Type:double
Unit:(no unit assumed)
Controllable:No
Description:Production Limiter Constant Multiplier.
- Pr_tPr_tTurbulent Prandtl number. A functor is any of the following: a variable, a functor material property, a function, a post-processor, or a number.
Default:Pr_t
C++ Type:MooseFunctorName
Unit:(no unit assumed)
Controllable:No
Description:Turbulent Prandtl number. A functor is any of the following: a variable, a functor material property, a function, a post-processor, or a number.
- initial_mu_tInitial value for the turbulence viscosity
C++ Type:FunctionName
Unit:(no unit assumed)
Controllable:No
Description:Initial value for the turbulence viscosity
- neglect_advection_derivativesFalseWhether to remove the off-diagonal velocity term in the TKE and TKED advection term
Default:False
C++ Type:bool
Unit:(no unit assumed)
Controllable:No
Description:Whether to remove the off-diagonal velocity term in the TKE and TKED advection term
- output_mu_tTrueWhether to add mu_t to the field outputs
Default:True
C++ Type:bool
Unit:(no unit assumed)
Controllable:No
Description:Whether to add mu_t to the field outputs
- tke_advection_interpolationupwindThe numerical scheme to interpolate the TKE to the face when in the advection kernel.
Default:upwind
C++ Type:MooseEnum
Unit:(no unit assumed)
Controllable:No
Description:The numerical scheme to interpolate the TKE to the face when in the advection kernel.
- tke_nametkeName of the turbulent kinetic energy variable. A functor is any of the following: a variable, a functor material property, a function, a post-processor, or a number.
Default:tke
C++ Type:MooseFunctorName
Unit:(no unit assumed)
Controllable:No
Description:Name of the turbulent kinetic energy variable. A functor is any of the following: a variable, a functor material property, a function, a post-processor, or a number.
- tked_advection_interpolationupwindThe numerical scheme to interpolate the TKED to the face when in the advection kernel.
Default:upwind
C++ Type:MooseEnum
Unit:(no unit assumed)
Controllable:No
Description:The numerical scheme to interpolate the TKED to the face when in the advection kernel.
- tked_nameepsilonName of the turbulent kinetic energy dissipation variable. A functor is any of the following: a variable, a functor material property, a function, a post-processor, or a number.
Default:epsilon
C++ Type:MooseFunctorName
Unit:(no unit assumed)
Controllable:No
Description:Name of the turbulent kinetic energy dissipation variable. A functor is any of the following: a variable, a functor material property, a function, a post-processor, or a number.
- turbulence_handlingnoneThe way turbulent diffusivities are determined in the turbulent regime.
Default:none
C++ Type:MooseEnum
Unit:(no unit assumed)
Controllable:No
Description:The way turbulent diffusivities are determined in the turbulent regime.
NavierStokesFV Action
This class allows us to set up Navier-Stokes equations for porous medium or clean fluid flows using incompressible or weakly compressible approximations with a finite volume discretization.
This action is deprecated and is replaced by the WCNSFVPhysics
classes. The deprecated syntax can currently still be used. Please refer to the section on how to transition to the new Physics syntax for guidance on how to use the current syntax.
Overview
This action is used for setting up the Navier-Stokes equations over a subdomain using a finite volume discretization. Furthermore, the action is able to handle regular (clean fluid flow) or porous medium (flow within homogenized structures) formulations using incompressible and weakly-compressible approximations. This action is triggered with /Modules/NavierStokesFV input syntax. For more information, visit NavierStokesFV. For more information regarding the friction implemenation, visit Friction Kernel
Example Input File Syntax
In this example, the equations, the wall/inlet/outlet boundary conditions and their parameters are all set automatically by the NavierStokesFV
action.
Input Parameters
- control_tagsAdds user-defined labels for accessing object parameters via control logic.
C++ Type:std::vector<std::string>
Unit:(no unit assumed)
Controllable:No
Description:Adds user-defined labels for accessing object parameters via control logic.
- active__all__ If specified only the blocks named will be visited and made active
Default:__all__
C++ Type:std::vector<std::string>
Unit:(no unit assumed)
Controllable:No
Description:If specified only the blocks named will be visited and made active
- define_variablesTrueWhether to define variables if the variables with the specified names do not exist. Note that if the variables are defined externally from the Physics, the initial conditions will not be created in the Physics either.
Default:True
C++ Type:bool
Unit:(no unit assumed)
Controllable:No
Description:Whether to define variables if the variables with the specified names do not exist. Note that if the variables are defined externally from the Physics, the initial conditions will not be created in the Physics either.
- ghost_layers2Number of layers of elements to ghost near process domain boundaries
Default:2
C++ Type:unsigned short
Unit:(no unit assumed)
Controllable:No
Description:Number of layers of elements to ghost near process domain boundaries
- inactiveIf specified blocks matching these identifiers will be skipped.
C++ Type:std::vector<std::string>
Unit:(no unit assumed)
Controllable:No
Description:If specified blocks matching these identifiers will be skipped.
Advanced Parameters
- boussinesq_approximationFalseTrue to have Boussinesq approximation
Default:False
C++ Type:bool
Unit:(no unit assumed)
Controllable:No
Description:True to have Boussinesq approximation
- gravity0 0 0The gravitational acceleration vector.
Default:0 0 0
C++ Type:libMesh::VectorValue<double>
Unit:(no unit assumed)
Controllable:No
Description:The gravitational acceleration vector.
- ref_temperature273.15Value for reference temperature in case of Boussinesq approximation
Default:273.15
C++ Type:double
Unit:(no unit assumed)
Controllable:No
Description:Value for reference temperature in case of Boussinesq approximation
- thermal_expansionalphaThe name of the thermal expansion coefficient in the Boussinesq approximation. A functor is any of the following: a variable, a functor material property, a function, a post-processor, or a number.
Default:alpha
C++ Type:MooseFunctorName
Unit:(no unit assumed)
Controllable:No
Description:The name of the thermal expansion coefficient in the Boussinesq approximation. A functor is any of the following: a variable, a functor material property, a function, a post-processor, or a number.
Gravity Treatment Parameters
- characteristic_speedThe characteristic speed. For porous medium simulations, this characteristic speed should correspond to the superficial velocity, not the interstitial.
C++ Type:double
Unit:(no unit assumed)
Controllable:No
Description:The characteristic speed. For porous medium simulations, this characteristic speed should correspond to the superficial velocity, not the interstitial.
- mass_advection_interpolationupwindThe numerical scheme to use for interpolating density, as an advected quantity, to the face.
Default:upwind
C++ Type:MooseEnum
Unit:(no unit assumed)
Controllable:No
Description:The numerical scheme to use for interpolating density, as an advected quantity, to the face.
- mass_scaling1The scaling factor for the mass variables (for incompressible simulation this is pressure scaling).
Default:1
C++ Type:double
Unit:(no unit assumed)
Controllable:No
Description:The scaling factor for the mass variables (for incompressible simulation this is pressure scaling).
- momentum_advection_interpolationupwindThe numerical scheme to use for interpolating momentum/velocity, as an advected quantity, to the face.
Default:upwind
C++ Type:MooseEnum
Unit:(no unit assumed)
Controllable:No
Description:The numerical scheme to use for interpolating momentum/velocity, as an advected quantity, to the face.
- momentum_face_interpolationaverageThe numerical scheme to interpolate the velocity/momentum to the face (separate from the advected quantity interpolation).
Default:average
C++ Type:MooseEnum
Unit:(no unit assumed)
Controllable:No
Description:The numerical scheme to interpolate the velocity/momentum to the face (separate from the advected quantity interpolation).
- momentum_scaling1The scaling factor for the momentum variables.
Default:1
C++ Type:double
Unit:(no unit assumed)
Controllable:No
Description:The scaling factor for the momentum variables.
- momentum_two_term_bc_expansionTrueIf a two-term Taylor expansion is needed for the determination of the boundary valuesof the velocity/momentum.
Default:True
C++ Type:bool
Unit:(no unit assumed)
Controllable:No
Description:If a two-term Taylor expansion is needed for the determination of the boundary valuesof the velocity/momentum.
- mu_interp_methodharmonicSwitch that can select face interpolation method for the viscosity.
Default:harmonic
C++ Type:MooseEnum
Unit:(no unit assumed)
Controllable:No
Description:Switch that can select face interpolation method for the viscosity.
- pressure_face_interpolationaverageThe numerical scheme to interpolate the pressure to the face (separate from the advected quantity interpolation).
Default:average
C++ Type:MooseEnum
Unit:(no unit assumed)
Controllable:No
Description:The numerical scheme to interpolate the pressure to the face (separate from the advected quantity interpolation).
- pressure_two_term_bc_expansionTrueIf a two-term Taylor expansion is needed for the determination of the boundary valuesof the pressure.
Default:True
C++ Type:bool
Unit:(no unit assumed)
Controllable:No
Description:If a two-term Taylor expansion is needed for the determination of the boundary valuesof the pressure.
- velocity_interpolationrcThe interpolation to use for the velocity. Options are 'average' and 'rc' which stands for Rhie-Chow. The default is Rhie-Chow.
Default:rc
C++ Type:MooseEnum
Unit:(no unit assumed)
Controllable:No
Description:The interpolation to use for the velocity. Options are 'average' and 'rc' which stands for Rhie-Chow. The default is Rhie-Chow.
- energy_advection_interpolationupwindThe numerical scheme to use for interpolating energy/temperature, as an advected quantity, to the face.
Default:upwind
C++ Type:MooseEnum
Unit:(no unit assumed)
Controllable:No
Description:The numerical scheme to use for interpolating energy/temperature, as an advected quantity, to the face.
- energy_face_interpolationaverageThe numerical scheme to interpolate the temperature/energy to the face (separate from the advected quantity interpolation).
Default:average
C++ Type:MooseEnum
Unit:(no unit assumed)
Controllable:No
Description:The numerical scheme to interpolate the temperature/energy to the face (separate from the advected quantity interpolation).
- energy_scaling1The scaling factor for the energy variable.
Default:1
C++ Type:double
Unit:(no unit assumed)
Controllable:No
Description:The scaling factor for the energy variable.
- energy_two_term_bc_expansionTrueIf a two-term Taylor expansion is needed for the determination of the boundary valuesof the temperature/energy.
Default:True
C++ Type:bool
Unit:(no unit assumed)
Controllable:No
Description:If a two-term Taylor expansion is needed for the determination of the boundary valuesof the temperature/energy.
- passive_scalar_advection_interpolationupwindThe numerical scheme to use for interpolating passive scalar field, as an advected quantity, to the face.
Default:upwind
C++ Type:MooseEnum
Unit:(no unit assumed)
Controllable:No
Description:The numerical scheme to use for interpolating passive scalar field, as an advected quantity, to the face.
- passive_scalar_face_interpolationaverageThe numerical scheme to interpolate the passive scalar field variables to the face (separate from the advected quantity interpolation).
Default:average
C++ Type:MooseEnum
Unit:(no unit assumed)
Controllable:No
Description:The numerical scheme to interpolate the passive scalar field variables to the face (separate from the advected quantity interpolation).
- passive_scalar_scalingThe scaling factor for the passive scalar field variables.
C++ Type:std::vector<double>
Unit:(no unit assumed)
Controllable:No
Description:The scaling factor for the passive scalar field variables.
- passive_scalar_two_term_bc_expansionTrueIf a two-term Taylor expansion is needed for the determination of the boundary valuesof the advected passive scalar field.
Default:True
C++ Type:bool
Unit:(no unit assumed)
Controllable:No
Description:If a two-term Taylor expansion is needed for the determination of the boundary valuesof the advected passive scalar field.
Numerical Scheme Parameters
- consistent_scalingScaling parameter for the friction correction in the momentum equation (if requested).
C++ Type:double
Unit:(no unit assumed)
Controllable:No
Description:Scaling parameter for the friction correction in the momentum equation (if requested).
- porosity_interface_pressure_treatmentautomaticHow to treat pressure at a porosity interface
Default:automatic
C++ Type:MooseEnum
Unit:(no unit assumed)
Controllable:No
Description:How to treat pressure at a porosity interface
- porosity_smoothing_layersThe number of interpolation-reconstruction operations to perform on the porosity.
C++ Type:unsigned short
Unit:(no unit assumed)
Controllable:No
Description:The number of interpolation-reconstruction operations to perform on the porosity.
- pressure_allow_expansion_on_bernoulli_facesFalseSwitch to enable the two-term extrapolation on porosity jump faces. WARNING: Depending on the mesh, enabling this parameter may lead to termination in parallel runs due to insufficient ghosting between processors. An example can be the presence of multiple porosity jumps separated by only one cell while using the Bernoulli pressure treatment. In such cases adjust the `ghost_layers` parameter.
Default:False
C++ Type:bool
Unit:(no unit assumed)
Controllable:No
Description:Switch to enable the two-term extrapolation on porosity jump faces. WARNING: Depending on the mesh, enabling this parameter may lead to termination in parallel runs due to insufficient ghosting between processors. An example can be the presence of multiple porosity jumps separated by only one cell while using the Bernoulli pressure treatment. In such cases adjust the `ghost_layers` parameter.
- use_friction_correctionFalseIf friction correction should be applied in the momentum equation.
Default:False
C++ Type:bool
Unit:(no unit assumed)
Controllable:No
Description:If friction correction should be applied in the momentum equation.
Flow Medium Discontinuity Treatment Parameters
- coupled_turbulence_physicsTurbulence Physics coupled with this Physics
C++ Type:PhysicsName
Unit:(no unit assumed)
Controllable:No
Description:Turbulence Physics coupled with this Physics
- coupled_flow_physicsWCNSFVFlowPhysics generating the velocities
C++ Type:PhysicsName
Unit:(no unit assumed)
Controllable:No
Description:WCNSFVFlowPhysics generating the velocities
- Sc_tTurbulent Schmidt numbers used for the passive scalar fields.
C++ Type:std::vector<double>
Unit:(no unit assumed)
Controllable:No
Description:Turbulent Schmidt numbers used for the passive scalar fields.
- fluid_heat_transfer_physicsNavierStokesFVWCNSFVFluidHeatTransferPhysics generating the heat advection equations
Default:NavierStokesFV
C++ Type:PhysicsName
Unit:(no unit assumed)
Controllable:No
Description:WCNSFVFluidHeatTransferPhysics generating the heat advection equations
- scalar_transport_physicsNavierStokesFVWCNSFVScalarTransportPhysics generating the scalar advection equations
Default:NavierStokesFV
C++ Type:PhysicsName
Unit:(no unit assumed)
Controllable:No
Description:WCNSFVScalarTransportPhysics generating the scalar advection equations
- turbulent_prandtl1Turbulent Prandtl number for energy turbulent diffusion
Default:1
C++ Type:double
Unit:(no unit assumed)
Controllable:No
Description:Turbulent Prandtl number for energy turbulent diffusion
Coupled Physics Parameters
- densityrhoThe name of the density. A functor is any of the following: a variable, a functor material property, a function, a post-processor, or a number.
Default:rho
C++ Type:MooseFunctorName
Unit:(no unit assumed)
Controllable:No
Description:The name of the density. A functor is any of the following: a variable, a functor material property, a function, a post-processor, or a number.
- dynamic_viscositymuThe name of the dynamic viscosity. A functor is any of the following: a variable, a functor material property, a function, a post-processor, or a number.
Default:mu
C++ Type:MooseFunctorName
Unit:(no unit assumed)
Controllable:No
Description:The name of the dynamic viscosity. A functor is any of the following: a variable, a functor material property, a function, a post-processor, or a number.
- specific_heatcpThe name of the specific heat. A functor is any of the following: a variable, a functor material property, a function, a post-processor, or a number.
Default:cp
C++ Type:MooseFunctorName
Unit:(no unit assumed)
Controllable:No
Description:The name of the specific heat. A functor is any of the following: a variable, a functor material property, a function, a post-processor, or a number.
- thermal_conductivityk The name of the fluid thermal conductivity for each block
Default:k
C++ Type:std::vector<MooseFunctorName>
Unit:(no unit assumed)
Controllable:No
Description:The name of the fluid thermal conductivity for each block
- thermal_conductivity_blocksThe blocks where the user wants define different thermal conductivities.
C++ Type:std::vector<std::vector<SubdomainName>>
Unit:(no unit assumed)
Controllable:No
Description:The blocks where the user wants define different thermal conductivities.
- use_external_enthalpy_materialFalseTo indicate if the enthalpy material is set up outside of the action.
Default:False
C++ Type:bool
Unit:(no unit assumed)
Controllable:No
Description:To indicate if the enthalpy material is set up outside of the action.
Material Properties Parameters
- friction_blocksThe blocks where the friction factors are applied to emulate flow resistances.
C++ Type:std::vector<std::vector<SubdomainName>>
Unit:(no unit assumed)
Controllable:No
Description:The blocks where the friction factors are applied to emulate flow resistances.
- friction_coeffsThe friction coefficients for every item in 'friction_types'. Note that if 'porous_medium_treatment' is enabled, the coefficients already contain a velocity multiplier but they are not multiplied with density yet!
C++ Type:std::vector<std::vector<std::string>>
Unit:(no unit assumed)
Controllable:No
Description:The friction coefficients for every item in 'friction_types'. Note that if 'porous_medium_treatment' is enabled, the coefficients already contain a velocity multiplier but they are not multiplied with density yet!
- friction_typesThe types of friction forces for every block in 'friction_blocks'.
C++ Type:std::vector<std::vector<std::string>>
Unit:(no unit assumed)
Controllable:No
Description:The types of friction forces for every block in 'friction_blocks'.
- standard_friction_formulationTrueFlag to enable the standard friction formulation or its alternative, which is a simplified version (see user documentation for PINSFVMomentumFriction).
Default:True
C++ Type:bool
Unit:(no unit assumed)
Controllable:No
Description:Flag to enable the standard friction formulation or its alternative, which is a simplified version (see user documentation for PINSFVMomentumFriction).
Friction Control Parameters
- initial_from_file_timestepLATESTGives the time step number (or "LATEST") for which to read the Exodus solution
Default:LATEST
C++ Type:std::string
Unit:(no unit assumed)
Controllable:No
Description:Gives the time step number (or "LATEST") for which to read the Exodus solution
- initialize_variables_from_mesh_fileFalseDetermines if the variables that are added by the action are initializedfrom the mesh file (only for Exodus format)
Default:False
C++ Type:bool
Unit:(no unit assumed)
Controllable:No
Description:Determines if the variables that are added by the action are initializedfrom the mesh file (only for Exodus format)
Restart From Exodus Parameters
- initial_pressure1e5The initial pressure, assumed constant everywhere
Default:1e5
C++ Type:FunctionName
Unit:(no unit assumed)
Controllable:No
Description:The initial pressure, assumed constant everywhere
- initial_velocity1e-15 1e-15 1e-15 The initial velocity, assumed constant everywhere
Default:1e-15 1e-15 1e-15
C++ Type:std::vector<FunctionName>
Unit:(no unit assumed)
Controllable:No
Description:The initial velocity, assumed constant everywhere
- pressure_variableIf supplied, the system checks for available pressure variable. Otherwise, it is created within the action.
C++ Type:NonlinearVariableName
Unit:(no unit assumed)
Controllable:No
Description:If supplied, the system checks for available pressure variable. Otherwise, it is created within the action.
- velocity_variableIf supplied, the system checks for available velocity variables. Otherwise, they are created within the action.
C++ Type:std::vector<std::string>
Unit:(no unit assumed)
Controllable:No
Description:If supplied, the system checks for available velocity variables. Otherwise, they are created within the action.
Variables Parameters
- inlet_boundariesNames of inlet boundaries
C++ Type:std::vector<BoundaryName>
Unit:(no unit assumed)
Controllable:No
Description:Names of inlet boundaries
- momentum_inlet_functorsFunctions for inlet boundary velocities or pressures (for fixed-pressure option). Provide a double vector where the leading dimension corresponds to the number of fixed-velocity and fixed-pressure entries in momentum_inlet_types and the second index runs either over dimensions for fixed-velocity boundaries or is a single function name for pressure inlets.
C++ Type:std::vector<std::vector<MooseFunctorName>>
Unit:(no unit assumed)
Controllable:No
Description:Functions for inlet boundary velocities or pressures (for fixed-pressure option). Provide a double vector where the leading dimension corresponds to the number of fixed-velocity and fixed-pressure entries in momentum_inlet_types and the second index runs either over dimensions for fixed-velocity boundaries or is a single function name for pressure inlets.
- momentum_inlet_typesTypes of inlet boundaries for the momentum equation.
C++ Type:MultiMooseEnum
Unit:(no unit assumed)
Controllable:No
Description:Types of inlet boundaries for the momentum equation.
- energy_inlet_functorsFunctions for fixed-value boundaries in the energy equation.
C++ Type:std::vector<MooseFunctorName>
Unit:(no unit assumed)
Controllable:No
Description:Functions for fixed-value boundaries in the energy equation.
- energy_inlet_typesTypes for the inlet boundaries for the energy equation.
C++ Type:MultiMooseEnum
Unit:(no unit assumed)
Controllable:No
Description:Types for the inlet boundaries for the energy equation.
Inlet Boundary Conditions Parameters
- momentum_outlet_typesTypes of outlet boundaries for the momentum equation
C++ Type:MultiMooseEnum
Unit:(no unit assumed)
Controllable:No
Description:Types of outlet boundaries for the momentum equation
- outlet_boundariesNames of outlet boundaries
C++ Type:std::vector<BoundaryName>
Unit:(no unit assumed)
Controllable:No
Description:Names of outlet boundaries
- pressure_functorsFunctions for boundary pressures at outlets.
C++ Type:std::vector<MooseFunctorName>
Unit:(no unit assumed)
Controllable:No
Description:Functions for boundary pressures at outlets.
Outlet Boundary Conditions Parameters
- momentum_wall_functorsFunctors for each component of the velocity value on walls. This is only necessary for the fixed-velocity momentum wall types.
C++ Type:std::vector<std::vector<MooseFunctorName>>
Unit:(no unit assumed)
Controllable:No
Description:Functors for each component of the velocity value on walls. This is only necessary for the fixed-velocity momentum wall types.
- momentum_wall_typesTypes of wall boundaries for the momentum equation
C++ Type:MultiMooseEnum
Unit:(no unit assumed)
Controllable:No
Description:Types of wall boundaries for the momentum equation
- wall_boundariesNames of wall boundaries
C++ Type:std::vector<BoundaryName>
Unit:(no unit assumed)
Controllable:No
Description:Names of wall boundaries
- energy_wall_functorsFunctions for Dirichlet/Neumann boundaries in the energy equation.
C++ Type:std::vector<MooseFunctorName>
Unit:(no unit assumed)
Controllable:No
Description:Functions for Dirichlet/Neumann boundaries in the energy equation.
- energy_wall_typesTypes for the wall boundaries for the energy equation.
C++ Type:MultiMooseEnum
Unit:(no unit assumed)
Controllable:No
Description:Types for the wall boundaries for the energy equation.
Wall Boundary Conditions Parameters
- pin_pressureFalseSwitch to enable pressure shifting for incompressible simulations.
Default:False
C++ Type:bool
Unit:(no unit assumed)
Controllable:No
Description:Switch to enable pressure shifting for incompressible simulations.
- pinned_pressure_point0 0 0The XYZ coordinates where pressure needs to be pinned for incompressible simulations.
Default:0 0 0
C++ Type:libMesh::Point
Unit:(no unit assumed)
Controllable:No
Description:The XYZ coordinates where pressure needs to be pinned for incompressible simulations.
- pinned_pressure_typeaverage-uoTypes for shifting (pinning) the pressure in case of incompressible simulations.
Default:average-uo
C++ Type:MooseEnum
Unit:(no unit assumed)
Controllable:No
Description:Types for shifting (pinning) the pressure in case of incompressible simulations.
- pinned_pressure_value1e5The value used for pinning the pressure (point value/domain average).
Default:1e5
C++ Type:PostprocessorName
Unit:(no unit assumed)
Controllable:No
Description:The value used for pinning the pressure (point value/domain average).
Incompressible Flow Pressure Constraint Parameters
- time_derivative_contributes_to_RC_coefficientsTrueWhether the time derivative term should contribute to the Rhie Chow coefficients. This adds stabilization, but makes the solution dependent on the time step size
Default:True
C++ Type:bool
Unit:(no unit assumed)
Controllable:No
Description:Whether the time derivative term should contribute to the Rhie Chow coefficients. This adds stabilization, but makes the solution dependent on the time step size
Characteristic_Speed Numerical Scheme Parameters
- ambient_convection_alphaThe heat exchange coefficients for each block in 'ambient_convection_blocks'.
C++ Type:std::vector<MooseFunctorName>
Unit:(no unit assumed)
Controllable:No
Description:The heat exchange coefficients for each block in 'ambient_convection_blocks'.
- ambient_convection_blocksThe blocks where the ambient convection is present.
C++ Type:std::vector<std::vector<SubdomainName>>
Unit:(no unit assumed)
Controllable:No
Description:The blocks where the ambient convection is present.
- ambient_temperatureThe ambient temperature for each block in 'ambient_convection_blocks'.
C++ Type:std::vector<MooseFunctorName>
Unit:(no unit assumed)
Controllable:No
Description:The ambient temperature for each block in 'ambient_convection_blocks'.
Volumetric Heat Convection Parameters
- external_heat_sourceThe name of a functor which contains the external heat source for the energy equation. A functor is any of the following: a variable, a functor material property, a function, a post-processor, or a number.
C++ Type:MooseFunctorName
Unit:(no unit assumed)
Controllable:No
Description:The name of a functor which contains the external heat source for the energy equation. A functor is any of the following: a variable, a functor material property, a function, a post-processor, or a number.
- external_heat_source_coeff1Multiplier for the coupled heat source term.
Default:1
C++ Type:double
Unit:(no unit assumed)
Controllable:No
Description:Multiplier for the coupled heat source term.
Heat Source Parameters
- initial_scalar_variablesInitial values of the passive scalar variables.
C++ Type:std::vector<FunctionName>
Unit:(no unit assumed)
Controllable:No
Description:Initial values of the passive scalar variables.
- passive_scalar_namesVector containing the names of the advected scalar variables.
C++ Type:std::vector<NonlinearVariableName>
Unit:(no unit assumed)
Controllable:No
Description:Vector containing the names of the advected scalar variables.
Variable Parameters
- passive_scalar_coupled_sourceCoupled variable names for the sources used for the passive scalar fields. If multiple sources for each equation are specified, major (outer) ordering by equation.
C++ Type:std::vector<std::vector<MooseFunctorName>>
Unit:(no unit assumed)
Controllable:No
Description:Coupled variable names for the sources used for the passive scalar fields. If multiple sources for each equation are specified, major (outer) ordering by equation.
- passive_scalar_coupled_source_coeffCoupled variable multipliers for the sources used for the passive scalar fields. If multiple sources for each equation are specified, major (outer) ordering by equation.
C++ Type:std::vector<std::vector<double>>
Unit:(no unit assumed)
Controllable:No
Description:Coupled variable multipliers for the sources used for the passive scalar fields. If multiple sources for each equation are specified, major (outer) ordering by equation.
- passive_scalar_diffusivityFunctor names for the diffusivities used for the passive scalar fields.
C++ Type:std::vector<MooseFunctorName>
Unit:(no unit assumed)
Controllable:No
Description:Functor names for the diffusivities used for the passive scalar fields.
- passive_scalar_sourcePassive scalar sources
C++ Type:std::vector<MooseFunctorName>
Unit:(no unit assumed)
Controllable:No
Description:Passive scalar sources
Passive Scalar Control Parameters
- passive_scalar_inlet_functorsFunctors for inlet boundaries in the passive scalar equations.
C++ Type:std::vector<std::vector<MooseFunctorName>>
Unit:(no unit assumed)
Controllable:No
Description:Functors for inlet boundaries in the passive scalar equations.
- passive_scalar_inlet_typesTypes for the inlet boundaries for the passive scalar equation.
C++ Type:MultiMooseEnum
Unit:(no unit assumed)
Controllable:No
Description:Types for the inlet boundaries for the passive scalar equation.
Inlet Boundary Parameters
- C1_epsC1 coefficient for the turbulent kinetic energy dissipation equation
C++ Type:double
Unit:(no unit assumed)
Controllable:No
Description:C1 coefficient for the turbulent kinetic energy dissipation equation
- C2_epsC2 coefficient for the turbulent kinetic energy dissipation equation
C++ Type:double
Unit:(no unit assumed)
Controllable:No
Description:C2 coefficient for the turbulent kinetic energy dissipation equation
- initial_tke0Initial value for the turbulence kinetic energy
Default:0
C++ Type:FunctionName
Unit:(no unit assumed)
Controllable:No
Description:Initial value for the turbulence kinetic energy
- initial_tked0Initial value for the turbulence kinetic energy dissipation
Default:0
C++ Type:FunctionName
Unit:(no unit assumed)
Controllable:No
Description:Initial value for the turbulence kinetic energy dissipation
- sigma_epsScaling coefficient for the turbulent kinetic energy dissipation diffusion term. A functor is any of the following: a variable, a functor material property, a function, a post-processor, or a number.
C++ Type:MooseFunctorName
Unit:(no unit assumed)
Controllable:No
Description:Scaling coefficient for the turbulent kinetic energy dissipation diffusion term. A functor is any of the following: a variable, a functor material property, a function, a post-processor, or a number.
- sigma_kScaling coefficient for the turbulent kinetic energy diffusion term. A functor is any of the following: a variable, a functor material property, a function, a post-processor, or a number.
C++ Type:MooseFunctorName
Unit:(no unit assumed)
Controllable:No
Description:Scaling coefficient for the turbulent kinetic energy diffusion term. A functor is any of the following: a variable, a functor material property, a function, a post-processor, or a number.
K-Epsilon Model Parameters
- C_mu0.09Coupled turbulent kinetic energy closure.
Default:0.09
C++ Type:double
Unit:(no unit assumed)
Controllable:No
Description:Coupled turbulent kinetic energy closure.
- bulk_wall_treatmentTrueWhether to treat the wall cell as bulk
Default:True
C++ Type:bool
Unit:(no unit assumed)
Controllable:No
Description:Whether to treat the wall cell as bulk
- wall_treatment_TneqThe method used for computing the temperature wall functions
Default:neq
C++ Type:MooseEnum
Unit:(no unit assumed)
Controllable:No
Description:The method used for computing the temperature wall functions
- wall_treatment_epsneqThe method used for computing the epsilon wall functions
Default:neq
C++ Type:MooseEnum
Unit:(no unit assumed)
Controllable:No
Description:The method used for computing the epsilon wall functions
K-Epsilon Wall Function Parameters
- k_t_as_aux_variableFalseWhether to use an auxiliary variable for the turbulent conductivity
Default:False
C++ Type:bool
Unit:(no unit assumed)
Controllable:No
Description:Whether to use an auxiliary variable for the turbulent conductivity
- linearize_sink_sourcesFalseWhether to linearize the source term
Default:False
C++ Type:bool
Unit:(no unit assumed)
Controllable:No
Description:Whether to linearize the source term
- mu_t_as_aux_variableFalseWhether to use an auxiliary variable instead of a functor material property for the turbulent viscosity
Default:False
C++ Type:bool
Unit:(no unit assumed)
Controllable:No
Description:Whether to use an auxiliary variable instead of a functor material property for the turbulent viscosity
- tke_face_interpolationaverageThe numerical scheme to interpolate the TKE to the face (separate from the advected quantity interpolation).
Default:average
C++ Type:MooseEnum
Unit:(no unit assumed)
Controllable:No
Description:The numerical scheme to interpolate the TKE to the face (separate from the advected quantity interpolation).
- tke_scaling1The scaling factor for the turbulent kinetic energy equation.
Default:1
C++ Type:double
Unit:(no unit assumed)
Controllable:No
Description:The scaling factor for the turbulent kinetic energy equation.
- tke_two_term_bc_expansionTrueIf a two-term Taylor expansion is needed for the determination of the boundary valuesof the turbulent kinetic energy.
Default:True
C++ Type:bool
Unit:(no unit assumed)
Controllable:No
Description:If a two-term Taylor expansion is needed for the determination of the boundary valuesof the turbulent kinetic energy.
- tked_face_interpolationaverageThe numerical scheme to interpolate the TKED to the face (separate from the advected quantity interpolation).
Default:average
C++ Type:MooseEnum
Unit:(no unit assumed)
Controllable:No
Description:The numerical scheme to interpolate the TKED to the face (separate from the advected quantity interpolation).
- tked_scaling1The scaling factor for the turbulent kinetic energy dissipation equation.
Default:1
C++ Type:double
Unit:(no unit assumed)
Controllable:No
Description:The scaling factor for the turbulent kinetic energy dissipation equation.
- tked_two_term_bc_expansionTrueIf a two-term Taylor expansion is needed for the determination of the boundary valuesof the turbulent kinetic energy dissipation.
Default:True
C++ Type:bool
Unit:(no unit assumed)
Controllable:No
Description:If a two-term Taylor expansion is needed for the determination of the boundary valuesof the turbulent kinetic energy dissipation.
- turbulent_viscosity_interp_methodharmonicFace interpolation method for the turbulent viscosity
Default:harmonic
C++ Type:MooseEnum
Unit:(no unit assumed)
Controllable:No
Description:Face interpolation method for the turbulent viscosity
- turbulent_viscosity_two_term_bc_expansionTrueIf a two-term Taylor expansion is needed for the determination of the boundary valuesof the turbulent viscosity.
Default:True
C++ Type:bool
Unit:(no unit assumed)
Controllable:No
Description:If a two-term Taylor expansion is needed for the determination of the boundary valuesof the turbulent viscosity.
K-Epsilon Model Numerical Parameters
- mixing_length_aux_execute_onWhen the mixing length aux kernels should be executed.
C++ Type:ExecFlagEnum
Unit:(no unit assumed)
Controllable:No
Description:When the mixing length aux kernels should be executed.
- mixing_length_delta1Tunable parameter related to the thickness of the boundary layer.When it is not specified, Prandtl's original unbounded wall distance mixing length model isretrieved. A functor is any of the following: a variable, a functor material property, a function, a post-processor, or a number.
Default:1
C++ Type:MooseFunctorName
Unit:(no unit assumed)
Controllable:No
Description:Tunable parameter related to the thickness of the boundary layer.When it is not specified, Prandtl's original unbounded wall distance mixing length model isretrieved. A functor is any of the following: a variable, a functor material property, a function, a post-processor, or a number.
- mixing_length_namemixing_lengthName of the mixing length auxiliary variable
Default:mixing_length
C++ Type:AuxVariableName
Unit:(no unit assumed)
Controllable:No
Description:Name of the mixing length auxiliary variable
- mixing_length_two_term_bc_expansionTrueIf a two-term Taylor expansion is needed for the determination of the boundary valuesof the mixing length field.
Default:True
C++ Type:bool
Unit:(no unit assumed)
Controllable:No
Description:If a two-term Taylor expansion is needed for the determination of the boundary valuesof the mixing length field.
- turbulence_wallsWalls where the mixing length model should be utilized.
C++ Type:std::vector<BoundaryName>
Unit:(no unit assumed)
Controllable:No
Description:Walls where the mixing length model should be utilized.
- von_karman_const0.41Von Karman parameter for the mixing length model. A functor is any of the following: a variable, a functor material property, a function, a post-processor, or a number.
Default:0.41
C++ Type:MooseFunctorName
Unit:(no unit assumed)
Controllable:No
Description:Von Karman parameter for the mixing length model. A functor is any of the following: a variable, a functor material property, a function, a post-processor, or a number.
- von_karman_const_00.09'Escudier' model parameter. A functor is any of the following: a variable, a functor material property, a function, a post-processor, or a number.
Default:0.09
C++ Type:MooseFunctorName
Unit:(no unit assumed)
Controllable:No
Description:'Escudier' model parameter. A functor is any of the following: a variable, a functor material property, a function, a post-processor, or a number.