- active__all__ If specified only the blocks named will be visited and made active
Default:__all__
C++ Type:std::vector<std::string>
Controllable:No
Description:If specified only the blocks named will be visited and made active
- blockThe list of blocks on which NS equations are defined on
C++ Type:std::vector<SubdomainName>
Controllable:No
Description:The list of blocks on which NS equations are defined on
- characteristic_speedThe characteristic speed. For porous medium simulations, this characteristic speed should correspond to the superficial velocity, not the interstitial.
C++ Type:double
Controllable:No
Description:The characteristic speed. For porous medium simulations, this characteristic speed should correspond to the superficial velocity, not the interstitial.
- control_tagsAdds user-defined labels for accessing object parameters via control logic.
C++ Type:std::vector<std::string>
Controllable:No
Description:Adds user-defined labels for accessing object parameters via control logic.
- inactiveIf specified blocks matching these identifiers will be skipped.
C++ Type:std::vector<std::string>
Controllable:No
Description:If specified blocks matching these identifiers will be skipped.
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.
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.
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.
[NavierStokesFV]
# General parameters
compressibility = 'incompressible'
porous_medium_treatment = false
add_energy_equation = true
# Material properties
density = 'rho'
dynamic_viscosity = 'mu'
thermal_conductivity = 'k'
specific_heat = 'cp'
# Initial conditions
initial_velocity = '1 1 0'
initial_pressure = 0.0
initial_temperature = 0.0
# Inlet boundary conditions
inlet_boundaries = 'left'
momentum_inlet_types = 'fixed-velocity'
momentum_inlet_function = '1 0'
energy_inlet_types = 'fixed-temperature'
energy_inlet_function = '1'
# Wall boundary conditions
wall_boundaries = 'top bottom'
momentum_wall_types = 'noslip noslip'
energy_wall_types = 'heatflux heatflux'
energy_wall_function = '0 0'
# Outlet boundary conditions
outlet_boundaries = 'right'
momentum_outlet_types = 'fixed-pressure'
pressure_function = '0'
# Ambient convection volumetric heat source
ambient_convection_alpha = 'alpha'
ambient_temperature = '100'
mass_advection_interpolation = 'average'
momentum_advection_interpolation = 'average'
energy_advection_interpolation = 'average'
[]
(moose/modules/navier_stokes/test/tests/finite_volume/ins/channel-flow/2d-rc-ambient-convection-action.i)Input Parameters
- add_energy_equationFalseTrue to add energy equation
Default:False
C++ Type:bool
Controllable:No
Description:True to add energy equation
- add_flow_equationsTrueTrue to add mass and momentum equations
Default:True
C++ Type:bool
Controllable:No
Description:True to add mass and momentum equations
- add_scalar_equationFalseTrue to add advected scalar(s) equation
Default:False
C++ Type:bool
Controllable:No
Description:True to add advected scalar(s) equation
- compressibilityincompressibleCompressibility constraint for the Navier-Stokes equations.
Default:incompressible
C++ Type:MooseEnum
Controllable:No
Description:Compressibility constraint for the Navier-Stokes equations.
- porous_medium_treatmentFalseWhether to use porous medium kernels or not.
Default:False
C++ Type:bool
Controllable:No
Description:Whether to use porous medium kernels or not.
- turbulence_handlingnoneThe way additional diffusivities are determined in the turbulent regime.
Default:none
C++ Type:MooseEnum
Controllable:No
Description:The way additional diffusivities are determined in the turbulent regime.
General Control Parameters
- ambient_convection_alphaThe heat exchange coefficients for each block in 'ambient_convection_blocks'.
C++ Type:std::vector<MooseFunctorName>
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>>
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>
Controllable:No
Description:The ambient temperature for each block in 'ambient_convection_blocks'.
- external_heat_sourceThe name of a functor which contains the external heat source for the energy equation.
C++ Type:MooseFunctorName
Controllable:No
Description:The name of a functor which contains the external heat source for the energy equation.
- external_heat_source_coeff1Multiplier for the coupled heat source term.
Default:1
C++ Type:double
Controllable:No
Description:Multiplier for the coupled heat source term.
- use_external_enthalpy_materialFalseTo indicate if the enthalpy material is set up outside of the action.
Default:False
C++ Type:bool
Controllable:No
Description:To indicate if the enthalpy material is set up outside of the action.
Energy Equation Parameters
- boussinesq_approximationFalseTrue to have Boussinesq approximation
Default:False
C++ Type:bool
Controllable:No
Description:True to have Boussinesq approximation
- gravity0 0 0The gravitational acceleration vector.
Default:0 0 0
C++ Type:libMesh::VectorValue<double>
Controllable:No
Description:The gravitational acceleration vector.
- pin_pressureFalseSwitch to enable pressure shifting for incompressible simulations.
Default:False
C++ Type:bool
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
Controllable:No
Description:The XYZ coordinates where pressure needs to be pinned for incompressible simulations.
- pinned_pressure_typeaverageTypes for shifting (pinning) the pressure in case of incompressible simulations.
Default:average
C++ Type:MooseEnum
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
Controllable:No
Description:The value used for pinning the pressure (point value/domain average).
- ref_temperature273.15Value for reference temperature in case of Boussinesq approximation
Default:273.15
C++ Type:double
Controllable:No
Description:Value for reference temperature in case of Boussinesq approximation
Momentum Equation Parameters
- consistent_scalingScaling parameter for the friction correction in the momentum equation (if requested).
C++ Type:double
Controllable:No
Description:Scaling parameter for the friction correction in the momentum equation (if requested).
- porosityporosityThe name of the auxiliary variable for the porosity field.
Default:porosity
C++ Type:MooseFunctorName
Controllable:No
Description:The name of the auxiliary variable for the porosity field.
- porosity_interface_pressure_treatmentautomaticHow to treat pressure at a porosity interface
Default:automatic
C++ Type:MooseEnum
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
Controllable:No
Description:The number of interpolation-reconstruction operations to perform on the porosity.
- use_friction_correctionFalseIf friction correction should be applied in the momentum equation.
Default:False
C++ Type:bool
Controllable:No
Description:If friction correction should be applied in the momentum equation.
Porous Medium Treatment Parameters
- densityrhoThe name of the density
Default:rho
C++ Type:MooseFunctorName
Controllable:No
Description:The name of the density
- dynamic_viscositymuThe name of the dynamic viscosity
Default:mu
C++ Type:MooseFunctorName
Controllable:No
Description:The name of the dynamic viscosity
- specific_heatcpThe name of the specific heat
Default:cp
C++ Type:MooseFunctorName
Controllable:No
Description:The name of the specific heat
- thermal_conductivityk The name of the fluid thermal conductivity for each block
Default:k
C++ Type:std::vector<MooseFunctorName>
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>>
Controllable:No
Description:The blocks where the user wants define different thermal conductivities.
- thermal_expansionalphaThe name of the thermal expansion coefficient in the Boussinesq approximation
Default:alpha
C++ Type:MooseFunctorName
Controllable:No
Description:The name of the thermal expansion coefficient in the Boussinesq approximation
Material Property Parameters
- energy_advection_interpolationupwindThe numerical scheme to use for interpolating energy/temperature, as an advected quantity, to the face.
Default:upwind
C++ Type:MooseEnum
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
Controllable:No
Description:The numerical scheme to interpolate the temperature/energy to the face (separate from the advected quantity interpolation).
- 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
Controllable:No
Description:If a two-term Taylor expansion is needed for the determination of the boundary valuesof the temperature/energy.
- mass_advection_interpolationupwindThe numerical scheme to use for interpolating density, as an advected quantity, to the face.
Default:upwind
C++ Type:MooseEnum
Controllable:No
Description:The numerical scheme to use for interpolating density, as an advected quantity, to the face.
- 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
Controllable:No
Description:If a two-term Taylor expansion is needed for the determination of the boundary valuesof the mixing length field.
- momentum_advection_interpolationupwindThe numerical scheme to use for interpolating momentum/velocity, as an advected quantity, to the face.
Default:upwind
C++ Type:MooseEnum
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
Controllable:No
Description:The numerical scheme to interpolate the velocity/momentum to the face (separate from the advected quantity interpolation).
- 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
Controllable:No
Description:If a two-term Taylor expansion is needed for the determination of the boundary valuesof the velocity/momentum.
- 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
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
Controllable:No
Description:The numerical scheme to interpolate the passive scalar field variables to the face (separate from the advected quantity interpolation).
- 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
Controllable:No
Description:If a two-term Taylor expansion is needed for the determination of the boundary valuesof the advected passive scalar field.
- 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
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.
- pressure_face_interpolationaverageThe numerical scheme to interpolate the pressure to the face (separate from the advected quantity interpolation).
Default:average
C++ Type:MooseEnum
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
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
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.
Numerical Scheme Parameters
- energy_inlet_functionFunctions for fixed-value boundaries in the energy equation.
C++ Type:std::vector<std::string>
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
Controllable:No
Description:Types for the inlet boundaries for the energy equation.
- energy_wall_functionFunctions for Dirichlet/Neumann boundaries in the energy equation.
C++ Type:std::vector<FunctionName>
Controllable:No
Description:Functions for Dirichlet/Neumann boundaries in the energy equation.
- energy_wall_typesheatfluxTypes for the wall boundaries for the energy equation.
Default:heatflux
C++ Type:MultiMooseEnum
Controllable:No
Description:Types for the wall boundaries for the energy equation.
- 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>
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>
Controllable:No
Description:The name of the postprocessors which compute the mass flow/ velocity magnitude. Mainly used for coupling between different applications.
- inlet_boundariesNames of inlet boundaries
C++ Type:std::vector<BoundaryName>
Controllable:No
Description:Names of inlet boundaries
- momentum_inlet_functionFunctions 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<FunctionName>>
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
Controllable:No
Description:Types of inlet boundaries for the momentum equation.
- momentum_outlet_typesTypes of outlet boundaries for the momentum equation
C++ Type:MultiMooseEnum
Controllable:No
Description:Types of outlet boundaries for the momentum equation
- momentum_wall_typesnoslipTypes of wall boundaries for the momentum equation
Default:noslip
C++ Type:MultiMooseEnum
Controllable:No
Description:Types of wall boundaries for the momentum equation
- outlet_boundariesNames of outlet boundaries
C++ Type:std::vector<BoundaryName>
Controllable:No
Description:Names of outlet boundaries
- passive_scalar_inlet_functionFunctions for inlet boundaries in the passive scalar equations.
C++ Type:std::vector<std::vector<std::string>>
Controllable:No
Description:Functions for inlet boundaries in the passive scalar equations.
- passive_scalar_inlet_typesfixed-valueTypes for the inlet boundaries for the passive scalar equation.
Default:fixed-value
C++ Type:MultiMooseEnum
Controllable:No
Description:Types for the inlet boundaries for the passive scalar equation.
- pressure_functionFunctions for boundary pressures at outlets.
C++ Type:std::vector<FunctionName>
Controllable:No
Description:Functions for boundary pressures at outlets.
- wall_boundariesNames of wall boundaries
C++ Type:std::vector<BoundaryName>
Controllable:No
Description:Names of wall boundaries
Boundary Condition Parameters
- energy_scaling1The scaling factor for the energy variable.
Default:1
C++ Type:double
Controllable:No
Description:The scaling factor for the energy variable.
- mass_scaling1The scaling factor for the mass variables (for incompressible simulation this is pressure scaling).
Default:1
C++ Type:double
Controllable:No
Description:The scaling factor for the mass variables (for incompressible simulation this is pressure scaling).
- momentum_scaling1The scaling factor for the momentum variables.
Default:1
C++ Type:double
Controllable:No
Description:The scaling factor for the momentum variables.
- passive_scalar_scaling1The scaling factor for the passive scalar field variables.
Default:1
C++ Type:double
Controllable:No
Description:The scaling factor for the passive scalar field variables.
Scaling Parameters
- fluid_temperature_variableIf supplied, the system checks for available fluid temperature variable. Otherwise, it is created within the action.
C++ Type:NonlinearVariableName
Controllable:No
Description:If supplied, the system checks for available fluid temperature variable. Otherwise, it is created within the action.
- pressure_variableIf supplied, the system checks for available pressure variable. Otherwise, it is created within the action.
C++ Type:NonlinearVariableName
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>
Controllable:No
Description:If supplied, the system checks for available velocity variables. Otherwise, they are created within the action.
External Variable Parameters
- friction_blocksThe blocks where the friction factors are applied to emulate flow resistances.
C++ Type:std::vector<std::vector<SubdomainName>>
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>>
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>>
Controllable:No
Description:The types of friction forces for every block in 'friction_blocks'.
Friction Control Parameters
- ghost_layers2The number of geometric/algebraic/coupling layers to ghost.
Default:2
C++ Type:unsigned short
Controllable:No
Description:The number of geometric/algebraic/coupling layers to ghost.
- pull_all_nonlocal_aFalseWhether to pull all nonlocal 'a' coefficient data to our process. Note that 'nonlocal' means elements that we have access to (this may not be all the elements in the mesh if the mesh is distributed) but that we do not own.
Default:False
C++ Type:bool
Controllable:No
Description:Whether to pull all nonlocal 'a' coefficient data to our process. Note that 'nonlocal' means elements that we have access to (this may not be all the elements in the mesh if the mesh is distributed) but that we do not own.
Parallel Execution Tuning Parameters
- initial_from_file_timestepLATESTGives the timestep (or "LATEST") for which to read a solution from a file for a given variable. (Default: LATEST)
Default:LATEST
C++ Type:std::string
Controllable:No
Description:Gives the timestep (or "LATEST") for which to read a solution from a file for a given variable. (Default: LATEST)
- initial_pressure1e5The initial pressure, assumed constant everywhere
Default:1e5
C++ Type:FunctionName
Controllable:No
Description:The initial pressure, assumed constant everywhere
- initial_scalar_variablesInitial values of the passive scalar variables.
C++ Type:std::vector<FunctionName>
Controllable:No
Description:Initial values of the passive scalar variables.
- initial_temperature300The initial temperature, assumed constant everywhere
Default:300
C++ Type:FunctionName
Controllable:No
Description:The initial temperature, 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>
Controllable:No
Description:The initial velocity, assumed constant everywhere
- initialize_variables_from_mesh_fileFalseDetermines if the variables that are added by the action are initialized from the mesh file (only for Exodus format)
Default:False
C++ Type:bool
Controllable:No
Description:Determines if the variables that are added by the action are initialized from the mesh file (only for Exodus format)
Initial Condition Parameters
- mass_momentum_systemnl0The nonlinear system in which the monolithic momentum and continuity equations are located.
Default:nl0
C++ Type:NonlinearSystemName
Controllable:No
Description:The nonlinear system in which the monolithic momentum and continuity equations are located.
Nonlinear Solver Parameters
- mixing_length_aux_execute_onWhen the mixing length aux kernels should be executed.
C++ Type:ExecFlagEnum
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.
Default:1
C++ Type:MooseFunctorName
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.
- mixing_length_wallsWalls where the mixing length model should be utilized.
C++ Type:std::vector<BoundaryName>
Controllable:No
Description:Walls where the mixing length model should be utilized.
- turbulent_prandtl1Turbulent Prandtl number for energy turbulent diffusion
Default:1
C++ Type:double
Controllable:No
Description:Turbulent Prandtl number for energy turbulent diffusion
- von_karman_const0.41Von Karman parameter for the mixing length model
Default:0.41
C++ Type:MooseFunctorName
Controllable:No
Description:Von Karman parameter for the mixing length model
- von_karman_const_00.09'Escudier' model parameter
Default:0.09
C++ Type:MooseFunctorName
Controllable:No
Description:'Escudier' model parameter
Turbulence 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>>
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>>
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>
Controllable:No
Description:Functor names for the diffusivities used for the passive scalar fields.
- passive_scalar_namesVector containing the names of the advected scalar variables.
C++ Type:std::vector<NonlinearVariableName>
Controllable:No
Description:Vector containing the names of the advected scalar variables.
- passive_scalar_schmidt_numberSchmidt numbers used for the passive scalar fields.
C++ Type:std::vector<double>
Controllable:No
Description:Schmidt numbers used for the passive scalar fields.
- passive_scalar_sourceFunctor names for the sources used for the passive scalar fields.
C++ Type:std::vector<MooseFunctorName>
Controllable:No
Description:Functor names for the sources used for the passive scalar fields.