NavierStokesFV System
This syntax is deprecated. Please refer to the section on how to transition to the new Physics syntax for guidance on how to use the current syntax.
Overview
The NavierStokesFV system is dedicated to decrease the effort required by the user to prepare simulations which need to solve the Navier Stokes equations. The action is capable of setting up:
Incompressible and weakly-compressible simulations for
Clean fluids and flows in porous media
The action handles boundary conditions, necessary materials for fluid properties, variables, variable initialization and various objects for turbulence modeling.
This action only supports Rhie-Chow interpolation for the determination of face velocities in the advection terms. The face interpolation of the advected quantities (e.g. upwind, average) can be controlled through the *_advection_interpolation
action parameters.
Automatically defined variables
The NavierStokesFV action automatically sets up the variables which are necessary for the solution of a given problem. These variables can then be used to couple fluid flow simulations with other physics. The list of variable names commonly used in the action syntax is presented below:
Velocities for non-porous-medium simulations:
(contrib/moose/modules/navier_stokes/include/base/NS.h)static const std::string velocity_x = "vel_x"; static const std::string velocity_y = "vel_y"; static const std::string velocity_z = "vel_z";
Velocities for porous medium simulations:
(contrib/moose/modules/navier_stokes/include/base/NS.h)static const std::string superficial_velocity_x = "superficial_vel_x"; static const std::string superficial_velocity_y = "superficial_vel_y"; static const std::string superficial_velocity_z = "superficial_vel_z";
Pressure and temperature:
(contrib/moose/modules/navier_stokes/include/base/NS.h)static const std::string pressure = "pressure";
(contrib/moose/modules/navier_stokes/include/base/NS.h)static const std::string T_fluid = "T_fluid";
For the default names of other variables used in this action, visit this site.
Bernoulli pressure jump treatment
Please see the Bernoulli pressure variable documentation for more information.
Examples
Incompressible fluid flow in a lid-driven cavity
In the following examples we present how the NavierStokesFV action can be utilized to simplify input files. We start with the simple lid-driven cavity problem with an Incompressible Navier Stokes formulation. The original description of the problem is available under the following link. First, we present the input file where the simulation is set up manually, by defining every kernel, boundary condition and material explicitly.
mu = 1
rho = 1
k = .01
cp = 1
velocity_interp_method = 'rc'
advected_interp_method = 'average'
[GlobalParams]
rhie_chow_user_object = 'rc'
[]
[UserObjects]
[rc]
type = INSFVRhieChowInterpolator
u = vel_x
v = vel_y
pressure = pressure
[]
[]
[Mesh]
[gen]
type = GeneratedMeshGenerator
dim = 2
xmin = 0
xmax = 1
ymin = 0
ymax = 1
nx = 32
ny = 32
[]
[]
[Variables]
[vel_x]
type = INSFVVelocityVariable
[]
[vel_y]
type = INSFVVelocityVariable
[]
[pressure]
type = INSFVPressureVariable
[]
[T_fluid]
type = INSFVEnergyVariable
[]
[lambda]
family = SCALAR
order = FIRST
[]
[]
[AuxVariables]
[U]
order = CONSTANT
family = MONOMIAL
fv = true
[]
[]
[AuxKernels]
[mag]
type = VectorMagnitudeAux
variable = U
x = vel_x
y = vel_y
[]
[]
[FVKernels]
[mass]
type = INSFVMassAdvection
variable = pressure
advected_interp_method = ${advected_interp_method}
velocity_interp_method = ${velocity_interp_method}
rho = ${rho}
[]
[mean_zero_pressure]
type = FVIntegralValueConstraint
variable = pressure
lambda = lambda
[]
[u_advection]
type = INSFVMomentumAdvection
variable = vel_x
velocity_interp_method = ${velocity_interp_method}
advected_interp_method = ${advected_interp_method}
rho = ${rho}
momentum_component = 'x'
[]
[u_viscosity]
type = INSFVMomentumDiffusion
variable = vel_x
mu = ${mu}
momentum_component = 'x'
[]
[u_pressure]
type = INSFVMomentumPressure
variable = vel_x
momentum_component = 'x'
pressure = pressure
[]
[v_advection]
type = INSFVMomentumAdvection
variable = vel_y
velocity_interp_method = ${velocity_interp_method}
advected_interp_method = ${advected_interp_method}
rho = ${rho}
momentum_component = 'y'
[]
[v_viscosity]
type = INSFVMomentumDiffusion
variable = vel_y
mu = ${mu}
momentum_component = 'y'
[]
[v_pressure]
type = INSFVMomentumPressure
variable = vel_y
momentum_component = 'y'
pressure = pressure
[]
[temp_conduction]
type = FVDiffusion
coeff = 'k'
variable = T_fluid
[]
[temp_advection]
type = INSFVEnergyAdvection
variable = T_fluid
velocity_interp_method = ${velocity_interp_method}
advected_interp_method = ${advected_interp_method}
[]
[]
[FVBCs]
[top_x]
type = INSFVNoSlipWallBC
variable = vel_x
boundary = 'top'
function = 'lid_function'
[]
[no_slip_x]
type = INSFVNoSlipWallBC
variable = vel_x
boundary = 'left right bottom'
function = 0
[]
[no_slip_y]
type = INSFVNoSlipWallBC
variable = vel_y
boundary = 'left right top bottom'
function = 0
[]
[T_hot]
type = FVDirichletBC
variable = T_fluid
boundary = 'bottom'
value = 1
[]
[T_cold]
type = FVDirichletBC
variable = T_fluid
boundary = 'top'
value = 0
[]
[]
[FunctorMaterials]
[functor_constants]
type = ADGenericFunctorMaterial
prop_names = 'cp k'
prop_values = '${cp} ${k}'
[]
[ins_fv]
type = INSFVEnthalpyFunctorMaterial
temperature = 'T_fluid'
rho = ${rho}
[]
[]
[Functions]
[lid_function]
type = ParsedFunction
expression = '4*x*(1-x)'
[]
[]
[Executioner]
type = Steady
solve_type = 'NEWTON'
petsc_options_iname = '-pc_type -pc_factor_shift_type'
petsc_options_value = 'lu NONZERO'
nl_rel_tol = 1e-12
[]
[Outputs]
exodus = true
[]
Careful! The utilization of central difference (average
) advected interpolation may lead to oscillatory behavior in certain scenarios. Even though it is not the case for this example, if this phenomenon arises, we recommend using first order upwind
or second order TVD schemes.
The same simulation can be set up using the action syntax which improves input file readability:
mu = 1
rho = 1
k = .01
cp = 1
[Mesh]
[gen]
type = GeneratedMeshGenerator
dim = 2
xmin = 0
xmax = 1
ymin = 0
ymax = 1
nx = 32
ny = 32
[]
[]
[Modules]
[NavierStokesFV]
compressibility = 'incompressible'
add_energy_equation = true
density = 'rho'
dynamic_viscosity = 'mu'
thermal_conductivity = 'k'
specific_heat = 'cp'
initial_pressure = 0.0
initial_temperature = 0.0
inlet_boundaries = 'top'
momentum_inlet_types = 'fixed-velocity'
momentum_inlet_function = 'lid_function 0'
energy_inlet_types = 'fixed-temperature'
energy_inlet_function = '0'
wall_boundaries = 'left right bottom'
momentum_wall_types = 'noslip noslip noslip'
energy_wall_types = 'heatflux heatflux fixed-temperature'
energy_wall_function = '0 0 1'
pin_pressure = true
pinned_pressure_type = average
pinned_pressure_value = 0
mass_advection_interpolation = 'average'
momentum_advection_interpolation = 'average'
energy_advection_interpolation = 'average'
[]
[]
[AuxVariables]
[U]
order = CONSTANT
family = MONOMIAL
fv = true
[]
[]
[AuxKernels]
[mag]
type = VectorMagnitudeAux
variable = U
x = vel_x
y = vel_y
[]
[]
[FunctorMaterials]
[functor_constants]
type = ADGenericFunctorMaterial
prop_names = 'cp k rho mu'
prop_values = '${cp} ${k} ${rho} ${mu}'
[]
[]
[Functions]
[lid_function]
type = ParsedFunction
expression = '4*x*(1-x)'
[]
[]
[Executioner]
type = Steady
solve_type = 'NEWTON'
petsc_options_iname = '-pc_type -pc_factor_shift_type'
petsc_options_value = 'lu NONZERO'
nl_rel_tol = 1e-12
[]
[Outputs]
exodus = true
[]
It is visible that in this case we defined the "compressibility" parameter to be incompressible
. Furthermore, the energy (enthalpy) equation is solved as well. The user can request this by setting "add_energy_equation" to true
. The boundary types are grouped into wall, inlet and outlet types. For more information on the available boundary types, see the list of parameters at the bottom of the page.
Incompressible fluid flow in porous medium
The following input file sets up a simulation of an incompressible fluid flow within a channel which contains a homogenized structure that is treated as a porous medium. The model accounts for the heat exchange between the fluid and the homogenized structure as well. For more description on the used model, visit the Porous medium Incompressible Navier Stokes page. First, the input file with the manually defined kernels and boundary conditions is presented:
mu = 1
rho = 1
k = 1e-3
cp = 1
u_inlet = 1
T_inlet = 200
advected_interp_method = 'average'
velocity_interp_method = 'rc'
[Mesh]
[mesh]
type = CartesianMeshGenerator
dim = 2
dx = '5 5'
dy = '1.0'
ix = '50 50'
iy = '20'
subdomain_id = '1 2'
[]
[]
[GlobalParams]
rhie_chow_user_object = 'rc'
[]
[UserObjects]
[rc]
type = PINSFVRhieChowInterpolator
u = superficial_vel_x
v = superficial_vel_y
pressure = pressure
porosity = porosity
[]
[]
[Variables]
inactive = 'T_solid'
[superficial_vel_x]
type = PINSFVSuperficialVelocityVariable
initial_condition = ${u_inlet}
[]
[superficial_vel_y]
type = PINSFVSuperficialVelocityVariable
initial_condition = 1e-6
[]
[pressure]
type = INSFVPressureVariable
[]
[T_fluid]
type = INSFVEnergyVariable
[]
[T_solid]
family = 'MONOMIAL'
order = 'CONSTANT'
fv = true
[]
[]
[AuxVariables]
[T_solid]
family = 'MONOMIAL'
order = 'CONSTANT'
fv = true
initial_condition = 100
[]
[porosity]
family = MONOMIAL
order = CONSTANT
fv = true
initial_condition = 0.5
[]
[]
[FVKernels]
inactive = 'solid_energy_diffusion solid_energy_convection'
[mass]
type = PINSFVMassAdvection
variable = pressure
advected_interp_method = ${advected_interp_method}
velocity_interp_method = ${velocity_interp_method}
rho = ${rho}
[]
[u_advection]
type = PINSFVMomentumAdvection
variable = superficial_vel_x
advected_interp_method = ${advected_interp_method}
velocity_interp_method = ${velocity_interp_method}
rho = ${rho}
porosity = porosity
momentum_component = 'x'
[]
[u_viscosity]
type = PINSFVMomentumDiffusion
variable = superficial_vel_x
mu = ${mu}
porosity = porosity
momentum_component = 'x'
[]
[u_pressure]
type = PINSFVMomentumPressure
variable = superficial_vel_x
momentum_component = 'x'
pressure = pressure
porosity = porosity
[]
[v_advection]
type = PINSFVMomentumAdvection
variable = superficial_vel_y
advected_interp_method = ${advected_interp_method}
velocity_interp_method = ${velocity_interp_method}
rho = ${rho}
porosity = porosity
momentum_component = 'y'
[]
[v_viscosity]
type = PINSFVMomentumDiffusion
variable = superficial_vel_y
mu = ${mu}
porosity = porosity
momentum_component = 'y'
[]
[v_pressure]
type = PINSFVMomentumPressure
variable = superficial_vel_y
momentum_component = 'y'
pressure = pressure
porosity = porosity
[]
[energy_advection]
type = PINSFVEnergyAdvection
variable = T_fluid
velocity_interp_method = ${velocity_interp_method}
advected_interp_method = ${advected_interp_method}
[]
[energy_diffusion]
type = PINSFVEnergyDiffusion
k = ${k}
variable = T_fluid
porosity = porosity
[]
[energy_convection]
type = PINSFVEnergyAmbientConvection
variable = T_fluid
is_solid = false
T_fluid = 'T_fluid'
T_solid = 'T_solid'
h_solid_fluid = 'h_cv'
[]
[solid_energy_diffusion]
type = FVDiffusion
coeff = ${k}
variable = T_solid
[]
[solid_energy_convection]
type = PINSFVEnergyAmbientConvection
variable = T_solid
is_solid = true
T_fluid = 'T_fluid'
T_solid = 'T_solid'
h_solid_fluid = 'h_cv'
[]
[]
[FVBCs]
inactive = 'heated-side'
[inlet-u]
type = INSFVInletVelocityBC
boundary = 'left'
variable = superficial_vel_x
function = ${u_inlet}
[]
[inlet-v]
type = INSFVInletVelocityBC
boundary = 'left'
variable = superficial_vel_y
function = 0
[]
[inlet-T]
type = FVNeumannBC
variable = T_fluid
value = '${fparse u_inlet * rho * cp * T_inlet}'
boundary = 'left'
[]
[no-slip-u]
type = INSFVNoSlipWallBC
boundary = 'top'
variable = superficial_vel_x
function = 0
[]
[no-slip-v]
type = INSFVNoSlipWallBC
boundary = 'top'
variable = superficial_vel_y
function = 0
[]
[heated-side]
type = FVDirichletBC
boundary = 'top'
variable = 'T_solid'
value = 150
[]
[symmetry-u]
type = PINSFVSymmetryVelocityBC
boundary = 'bottom'
variable = superficial_vel_x
u = superficial_vel_x
v = superficial_vel_y
mu = ${mu}
momentum_component = 'x'
[]
[symmetry-v]
type = PINSFVSymmetryVelocityBC
boundary = 'bottom'
variable = superficial_vel_y
u = superficial_vel_x
v = superficial_vel_y
mu = ${mu}
momentum_component = 'y'
[]
[symmetry-p]
type = INSFVSymmetryPressureBC
boundary = 'bottom'
variable = pressure
[]
[outlet-p]
type = INSFVOutletPressureBC
boundary = 'right'
variable = pressure
function = 0.1
[]
[]
[FunctorMaterials]
[constants]
type = ADGenericFunctorMaterial
prop_names = 'h_cv'
prop_values = '1'
[]
[functor_constants]
type = ADGenericFunctorMaterial
prop_names = 'cp'
prop_values = '${cp}'
[]
[ins_fv]
type = INSFVEnthalpyFunctorMaterial
rho = ${rho}
temperature = 'T_fluid'
[]
[]
[Executioner]
type = Steady
solve_type = 'NEWTON'
petsc_options_iname = '-pc_type -pc_factor_shift_type'
petsc_options_value = 'lu NONZERO'
nl_rel_tol = 1e-14
[]
# Some basic Postprocessors to examine the solution
[Postprocessors]
[inlet-p]
type = SideAverageValue
variable = pressure
boundary = 'left'
[]
[outlet-u]
type = SideAverageValue
variable = superficial_vel_x
boundary = 'right'
[]
[outlet-temp]
type = SideAverageValue
variable = T_fluid
boundary = 'right'
[]
[solid-temp]
type = ElementAverageValue
variable = T_solid
[]
[]
[Outputs]
exodus = true
csv = false
[]
Careful! The utilization of central difference (average
) advected interpolation may lead to oscillatory behavior in certain scenarios. Even though it is not the case for this example, if this phenomenon arises, we recommend using first order upwind
or second order TVD schemes.
The same simulation can also be set up using the NavierStokesFV action syntax:
mu = 1
rho = 1
k = 1e-3
cp = 1
u_inlet = 1
T_inlet = 200
h_cv = 1.0
[Mesh]
[mesh]
type = CartesianMeshGenerator
dim = 2
dx = '5 5'
dy = '1.0'
ix = '50 50'
iy = '20'
subdomain_id = '1 2'
[]
[]
[Variables]
[T_solid]
type = MooseVariableFVReal
[]
[]
[AuxVariables]
[porosity]
type = MooseVariableFVReal
initial_condition = 0.5
[]
[]
[Modules]
[NavierStokesFV]
compressibility = 'incompressible'
porous_medium_treatment = true
add_energy_equation = true
density = ${rho}
dynamic_viscosity = ${mu}
thermal_conductivity = ${k}
specific_heat = ${cp}
porosity = 'porosity'
# Reference file sets effective_conductivity by default that way
# so the conductivity is multiplied by the porosity in the kernel
effective_conductivity = false
initial_velocity = '${u_inlet} 1e-6 0'
initial_pressure = 0.0
initial_temperature = 0.0
inlet_boundaries = 'left'
momentum_inlet_types = 'fixed-velocity'
momentum_inlet_function = '${u_inlet} 0'
energy_inlet_types = 'heatflux'
energy_inlet_function = '${fparse u_inlet * rho * cp * T_inlet}'
wall_boundaries = 'top bottom'
momentum_wall_types = 'noslip symmetry'
energy_wall_types = 'heatflux heatflux'
energy_wall_function = '0 0'
outlet_boundaries = 'right'
momentum_outlet_types = 'fixed-pressure'
pressure_function = '0.1'
ambient_convection_alpha = ${h_cv}
ambient_temperature = 'T_solid'
mass_advection_interpolation = 'average'
momentum_advection_interpolation = 'average'
energy_advection_interpolation = 'average'
[]
[]
[FVKernels]
[solid_energy_diffusion]
type = FVDiffusion
coeff = ${k}
variable = T_solid
[]
[solid_energy_convection]
type = PINSFVEnergyAmbientConvection
variable = 'T_solid'
is_solid = true
T_fluid = 'T_fluid'
T_solid = 'T_solid'
h_solid_fluid = ${h_cv}
[]
[]
[FVBCs]
[heated-side]
type = FVDirichletBC
boundary = 'top'
variable = 'T_solid'
value = 150
[]
[]
[Executioner]
type = Steady
solve_type = 'NEWTON'
petsc_options_iname = '-pc_type -pc_factor_shift_type'
petsc_options_value = 'lu NONZERO'
nl_rel_tol = 1e-14
[]
# Some basic Postprocessors to examine the solution
[Postprocessors]
[inlet-p]
type = SideAverageValue
variable = pressure
boundary = 'left'
[]
[outlet-u]
type = SideAverageValue
variable = superficial_vel_x
boundary = 'right'
[]
[outlet-temp]
type = SideAverageValue
variable = T_fluid
boundary = 'right'
[]
[solid-temp]
type = ElementAverageValue
variable = T_solid
[]
[]
[Outputs]
exodus = true
csv = false
[]
Compared to the previous example, we see that in this case the porous medium treatment is enabled by setting "porous_medium_treatment" to true
. The corresponding porosity can be supplied through the "porosity" parameter. Furthermore, the heat exchange between the fluid and the homogenized structure is enabled using the "ambient_temperature" and "ambient_convection_alpha" parameters.
Weakly-compressible fluid flow
The last example is dedicated to demonstrating a transient flow in a channel using a weakly-compressible approximation. The following examples shows how this simulation is set up by manually defining the kernels and boundary conditions. For more information on the weakly-compressible treatment, visit the Weakly-compressible Navier Stokes page.
rho = 'rho'
l = 10
velocity_interp_method = 'rc'
advected_interp_method = 'average'
# Artificial fluid properties
# For a real case, use a GeneralFluidFunctorProperties and a viscosity rampdown
# or initialize very well!
k = 1
cp = 1000
mu = 1e2
# Operating conditions
inlet_temp = 300
outlet_pressure = 1e5
inlet_v = 0.001
[Mesh]
[gen]
type = GeneratedMeshGenerator
dim = 2
xmin = 0
xmax = ${l}
ymin = 0
ymax = 1
nx = 20
ny = 10
[]
[]
[GlobalParams]
rhie_chow_user_object = 'rc'
[]
[UserObjects]
[rc]
type = INSFVRhieChowInterpolator
u = vel_x
v = vel_y
pressure = pressure
[]
[]
[Variables]
[vel_x]
type = INSFVVelocityVariable
initial_condition = ${inlet_v}
[]
[vel_y]
type = INSFVVelocityVariable
initial_condition = 1e-15
[]
[pressure]
type = INSFVPressureVariable
initial_condition = ${outlet_pressure}
[]
[T_fluid]
type = INSFVEnergyVariable
initial_condition = ${inlet_temp}
[]
[]
[AuxVariables]
[mixing_length]
type = MooseVariableFVReal
[]
[power_density]
type = MooseVariableFVReal
initial_condition = 1e4
[]
[]
[FVKernels]
inactive = 'u_turb v_turb temp_turb'
[mass_time]
type = WCNSFVMassTimeDerivative
variable = pressure
drho_dt = drho_dt
[]
[mass]
type = WCNSFVMassAdvection
variable = pressure
advected_interp_method = ${advected_interp_method}
velocity_interp_method = ${velocity_interp_method}
rho = ${rho}
[]
[u_time]
type = WCNSFVMomentumTimeDerivative
variable = vel_x
drho_dt = drho_dt
rho = rho
momentum_component = 'x'
[]
[u_advection]
type = INSFVMomentumAdvection
variable = vel_x
velocity_interp_method = ${velocity_interp_method}
advected_interp_method = ${advected_interp_method}
rho = ${rho}
momentum_component = 'x'
[]
[u_viscosity]
type = INSFVMomentumDiffusion
variable = vel_x
mu = ${mu}
momentum_component = 'x'
[]
[u_pressure]
type = INSFVMomentumPressure
variable = vel_x
momentum_component = 'x'
pressure = pressure
[]
[u_turb]
type = INSFVMixingLengthReynoldsStress
variable = vel_x
rho = ${rho}
mixing_length = 'mixing_length'
momentum_component = 'x'
u = vel_x
v = vel_y
[]
[v_time]
type = WCNSFVMomentumTimeDerivative
variable = vel_y
drho_dt = drho_dt
rho = rho
momentum_component = 'y'
[]
[v_advection]
type = INSFVMomentumAdvection
variable = vel_y
velocity_interp_method = ${velocity_interp_method}
advected_interp_method = ${advected_interp_method}
rho = ${rho}
momentum_component = 'y'
[]
[v_viscosity]
type = INSFVMomentumDiffusion
variable = vel_y
momentum_component = 'y'
mu = ${mu}
[]
[v_pressure]
type = INSFVMomentumPressure
variable = vel_y
momentum_component = 'y'
pressure = pressure
[]
[v_turb]
type = INSFVMixingLengthReynoldsStress
variable = vel_y
rho = ${rho}
mixing_length = 'mixing_length'
momentum_component = 'y'
u = vel_x
v = vel_y
[]
[temp_time]
type = WCNSFVEnergyTimeDerivative
variable = T_fluid
rho = rho
drho_dt = drho_dt
h = h
dh_dt = dh_dt
[]
[temp_conduction]
type = FVDiffusion
coeff = 'k'
variable = T_fluid
[]
[temp_advection]
type = INSFVEnergyAdvection
variable = T_fluid
velocity_interp_method = ${velocity_interp_method}
advected_interp_method = ${advected_interp_method}
[]
[heat_source]
type = FVCoupledForce
variable = T_fluid
v = power_density
[]
[temp_turb]
type = WCNSFVMixingLengthEnergyDiffusion
variable = T_fluid
rho = rho
cp = cp
mixing_length = 'mixing_length'
schmidt_number = 1
u = vel_x
v = vel_y
[]
[]
[FVBCs]
[no_slip_x]
type = INSFVNoSlipWallBC
variable = vel_x
boundary = 'top bottom'
function = 0
[]
[no_slip_y]
type = INSFVNoSlipWallBC
variable = vel_y
boundary = 'top bottom'
function = 0
[]
# Inlet
[inlet_u]
type = INSFVInletVelocityBC
variable = vel_x
boundary = 'left'
function = ${inlet_v}
[]
[inlet_v]
type = INSFVInletVelocityBC
variable = vel_y
boundary = 'left'
function = 0
[]
[inlet_T]
type = FVDirichletBC
variable = T_fluid
boundary = 'left'
value = ${inlet_temp}
[]
[outlet_p]
type = INSFVOutletPressureBC
variable = pressure
boundary = 'right'
function = ${outlet_pressure}
[]
[]
[FluidProperties]
[fp]
type = FlibeFluidProperties
[]
[]
[FunctorMaterials]
[const_functor]
type = ADGenericFunctorMaterial
prop_names = 'cp k'
prop_values = '${cp} ${k}'
[]
[rho]
type = RhoFromPTFunctorMaterial
fp = fp
temperature = T_fluid
pressure = pressure
[]
[ins_fv]
type = INSFVEnthalpyFunctorMaterial
temperature = 'T_fluid'
rho = ${rho}
[]
[]
[AuxKernels]
inactive = 'mixing_len'
[mixing_len]
type = WallDistanceMixingLengthAux
walls = 'top'
variable = mixing_length
execute_on = 'initial'
delta = 0.5
[]
[]
[Executioner]
type = Transient
solve_type = 'NEWTON'
petsc_options_iname = '-pc_type -pc_factor_shift_type'
petsc_options_value = 'lu NONZERO'
[TimeStepper]
type = IterationAdaptiveDT
dt = 1e-3
optimal_iterations = 6
[]
end_time = 15
nl_abs_tol = 1e-9
nl_max_its = 50
line_search = 'none'
automatic_scaling = true
off_diagonals_in_auto_scaling = true
compute_scaling_once = false
[]
[Outputs]
exodus = true
[]
Careful! The utilization of central difference (average
) advected interpolation may lead to oscillatory behavior in certain scenarios. Even though it is not the case for this example, if this phenomenon arises, we recommend using first order upwind
or second order TVD schemes.
The same simulation can be set up using the action syntax as follows:
l = 10
# Artificial fluid properties
# For a real case, use a GeneralFluidFunctorProperties and a viscosity rampdown
# or initialize very well!
k = 1
cp = 1000
mu = 1e2
# Operating conditions
inlet_temp = 300
outlet_pressure = 1e5
inlet_v = 0.001
[Mesh]
[gen]
type = GeneratedMeshGenerator
dim = 2
xmin = 0
xmax = ${l}
ymin = 0
ymax = 1
nx = 20
ny = 10
[]
[]
[Modules]
[NavierStokesFV]
compressibility = 'weakly-compressible'
add_energy_equation = true
density = 'rho'
dynamic_viscosity = 'mu'
thermal_conductivity = 'k'
specific_heat = 'cp'
initial_velocity = '${inlet_v} 1e-15 0'
initial_temperature = '${inlet_temp}'
initial_pressure = '${outlet_pressure}'
inlet_boundaries = 'left'
momentum_inlet_types = 'fixed-velocity'
momentum_inlet_functors = '${inlet_v} 0'
energy_inlet_types = 'fixed-temperature'
energy_inlet_functors = '${inlet_temp}'
wall_boundaries = 'top bottom'
momentum_wall_types = 'noslip noslip'
energy_wall_types = 'heatflux heatflux'
energy_wall_functors = '0 0'
outlet_boundaries = 'right'
momentum_outlet_types = 'fixed-pressure'
pressure_functors = '${outlet_pressure}'
external_heat_source = 'power_density'
mass_advection_interpolation = 'average'
momentum_advection_interpolation = 'average'
energy_advection_interpolation = 'average'
[]
[]
[AuxVariables]
[power_density]
type = MooseVariableFVReal
initial_condition = 1e4
[]
[]
[FluidProperties]
[fp]
type = FlibeFluidProperties
[]
[]
[FunctorMaterials]
[const_functor]
type = ADGenericFunctorMaterial
prop_names = 'cp k mu'
prop_values = '${cp} ${k} ${mu}'
[]
[rho]
type = RhoFromPTFunctorMaterial
fp = fp
temperature = T_fluid
pressure = pressure
[]
[]
[Executioner]
type = Transient
solve_type = 'NEWTON'
petsc_options_iname = '-pc_type -pc_factor_shift_type'
petsc_options_value = 'lu NONZERO'
[TimeStepper]
type = IterationAdaptiveDT
dt = 1e-3
optimal_iterations = 6
[]
end_time = 15
nl_abs_tol = 1e-9
nl_max_its = 50
line_search = 'none'
automatic_scaling = true
off_diagonals_in_auto_scaling = true
compute_scaling_once = false
[]
[Outputs]
exodus = true
[]
We note that the weakly-compressible handling can be enabled by setting "compressibility" to weakly-compressible
. As shown in the example, an arbitrary energy source function can also be supplied to the incorporated energy equation using the "external_heat_source" parameter.
How to transition to the Physics syntax
The /Modules/NavierStokes
action syntax and (Physics/NavierStokes/Flow/..
, Physics/NavierStokes/FluidHeatTransfer/..
, Physics/NavierStokes/ScalarTransport/..
, Physics/NavierStokes/Turbulence/..
) syntax create the exact same objects in the background. We currently do not expect any difference in results, notably because /Modules/NavierStokes
has been changed to create the relevant Physics
under the hood!
To transition, you will have to split the /Modules/NavierStokes
parameters into four groups below. Your simulation may only feature only one of these groups, in which case you will only need to create a single Physics
:
mass and momentum (conservation) equations
heat transfer / energy (conservation) equation
scalar conservation equations
turbulence parameters
and copy paste the mass/momentum parameters into the [Physics/NavierStokes/Flow/<name>]
syntax as shown in this example:
[Physics]
[NavierStokes]
[Flow]
[flow]
compressibility = 'incompressible'
density = 'rho'
dynamic_viscosity = 'mu'
initial_velocity = '${u_inlet} 1e-12 0'
initial_pressure = 0.0
inlet_boundaries = 'left'
momentum_inlet_types = 'fixed-velocity'
momentum_inlet_function = '${u_inlet} 0'
wall_boundaries = 'bottom top'
momentum_wall_types = 'symmetry noslip'
outlet_boundaries = 'right'
momentum_outlet_types = 'fixed-pressure-zero-gradient'
pressure_function = '${p_outlet}'
mass_advection_interpolation = 'average'
momentum_advection_interpolation = 'average'
[]
[]
[]
[]
# This separation is introduced for documentation purposes.
# Both Physics could be nested under Physics/NavierStokes
[Physics/NavierStokes]
the energy conservation parameters into this [Physics/NavierStokes/FluidHeatTransfer/<name>]
syntax:
# Both Physics could be nested under Physics/NavierStokes
[Physics/NavierStokes]
[FluidHeatTransfer]
[heat]
thermal_conductivity = 'k'
specific_heat = 'cp'
fluid_temperature_variable = 'T_fluid'
initial_temperature = '${T_inlet}'
energy_inlet_types = 'heatflux'
energy_inlet_functors = '${fparse u_inlet * rho * cp * T_inlet}'
energy_wall_types = 'heatflux heatflux'
energy_wall_functors = '0 0'
ambient_convection_alpha = 'h_cv'
ambient_temperature = 'T_solid'
energy_advection_interpolation = 'average'
[]
[]
[]
the scalar conservation equations parameters into this [Physics/NavierStokes/ScalarTransport/<name>]
syntax:
# Both could be nested under Physics/NavierStokes
[Physics/NavierStokes]
[ScalarTransport]
[heat]
passive_scalar_names = 'scalar'
passive_scalar_diffusivity = ${diff}
passive_scalar_source = 0.1
passive_scalar_coupled_source = U
passive_scalar_coupled_source_coeff = 0.1
passive_scalar_inlet_types = 'fixed-value'
passive_scalar_inlet_function = '1'
passive_scalar_advection_interpolation = 'average'
[]
[]
[]
and finally the turbulence parameters into this [Physics/NavierStokes/Turbulence/<name>]
syntax:
# Both could be nested under Physics/NavierStokes
[Physics/NavierStokes]
[Turbulence]
[mixing-length]
turbulence_handling = 'mixing-length'
coupled_flow_physics = flow
scalar_transport_physics = scalars
passive_scalar_schmidt_number = 1.0
von_karman_const = ${von_karman_const}
mixing_length_delta = 1e9
mixing_length_walls = 'top bottom'
mixing_length_aux_execute_on = 'initial'
[]
[]
[]
All NavierStokes
Physics
may be nested under the same [NavierStokes]
sub-block. The separation in the examples into different Physics
blocks is only for the purpose of simplifying the examples.
If all goes well, the input will give exactly the same result. Some parameters have been renamed but the old names are currently still supported, even in the new syntax. If it does not go well, you can use the DumpObjectsProblem with the "dump_path" parameter set to:
Modules/NavierStokesFV
for the initial inputPhysics/NavierStokes/...
for the new input
to compare all the objects and parameters of both syntaxes. They should match rigorously. Any difference should be reported on the MOOSE discussions forum. Please attach both inputs and a description of the differences found to facilitate our analysis.
Available Actions
- Navier Stokes App
- NSFVActionDeprecationHelper class to smooth the deprecation of the NSFV Action
- WCNSFVFlowPhysicsDefine the Navier Stokes weakly-compressible mass and momentum equations
- WCNSFVFluidHeatTransferPhysicsDefine the Navier Stokes weakly-compressible energy equation
- WCNSFVScalarTransportPhysicsDefine the Navier Stokes weakly-compressible scalar field transport equation(s)
- WCNSFVTurbulencePhysicsDefine a turbulence model for a incompressible or weakly-compressible Navier Stokes flow with a finite volume discretization
(contrib/moose/modules/navier_stokes/include/base/NS.h)
// This file is part of the MOOSE framework
// https://www.mooseframework.org
//
// All rights reserved, see COPYRIGHT for full restrictions
// https://github.com/idaholab/moose/blob/master/COPYRIGHT
//
// Licensed under LGPL 2.1, please see LICENSE for details
// https://www.gnu.org/licenses/lgpl-2.1.html
#pragma once
#include <string>
#include "MathUtils.h"
#include "MooseTypes.h"
#include "libmesh/vector_value.h"
#include "HeatConductionNames.h"
namespace NS
{
using namespace HeatConduction;
static const std::string directions[3] = {"x", "y", "z"};
// geometric quantities
static const std::string pebble_diameter = "pebble_diameter";
static const std::string infinite_porosity = "infinite_porosity";
static const std::string axis = "axis";
static const std::string center = "center";
static const std::string wall_porosity = "wall_porosity";
static const std::string wall_distance = "wall_distance";
// Names defined in Navier-Stokes
static const std::string density = "rho";
static const std::string superficial_density = "superficial_rho";
static const std::string momentum_x = "rhou";
static const std::string momentum_y = "rhov";
static const std::string momentum_z = "rhow";
static const std::string momentum_vector[3] = {momentum_x, momentum_y, momentum_z};
static const std::string superficial_momentum_x = "superficial_rhou";
static const std::string superficial_momentum_y = "superficial_rhov";
static const std::string superficial_momentum_z = "superficial_rhow";
static const std::string superficial_momentum_vector[3] = {
superficial_momentum_x, superficial_momentum_y, superficial_momentum_z};
static const std::string velocity = "velocity";
static const std::string velocity_x = "vel_x";
static const std::string velocity_y = "vel_y";
static const std::string velocity_z = "vel_z";
const std::string velocity_vector[3] = {velocity_x, velocity_y, velocity_z};
static const std::string superficial_velocity_x = "superficial_vel_x";
static const std::string superficial_velocity_y = "superficial_vel_y";
static const std::string superficial_velocity_z = "superficial_vel_z";
static const std::string superficial_velocity = "superficial_velocity";
static const std::string superficial_velocity_vector[3] = {
superficial_velocity_x, superficial_velocity_y, superficial_velocity_z};
static const std::string pressure = "pressure";
static const std::string temperature = "temperature";
static const std::string internal_energy = "internal_energy";
static const std::string specific_internal_energy = "e";
static const std::string specific_total_energy = "et";
static const std::string internal_energy_density = "rho_e";
static const std::string total_energy_density = "rho_et";
static const std::string superficial_total_energy_density = "superficial_rho_et";
static const std::string specific_enthalpy = "h";
static const std::string specific_total_enthalpy = "ht";
static const std::string enthalpy_density = "rho_h";
static const std::string total_enthalpy_density = "rho_ht";
static const std::string superficial_total_enthalpy_density = "superficial_rho_ht";
static const std::string mixing_length = "mixing_length";
static const std::string wall_shear_stress = "wall_shear_stress";
static const std::string wall_yplus = "wall_yplus";
static const std::string eddy_viscosity = "eddy_viscosity";
static const std::string total_viscosity = "total_viscosity";
static const std::string mach_number = "Mach";
static const std::string specific_volume = "specific_volume";
static const std::string momentum = "momentum";
static const std::string v = "v";
static const std::string acceleration = "acceleration";
static const std::string fluid = "fp";
// for Navier-Stokes material props representing gradients of nonlin+aux vars
inline std::string
grad(const std::string & var)
{
return MathUtils::gradName(var);
}
// for Navier-Stokes material props representing time derivatives of nonlin+aux vars
inline std::string
time_deriv(const std::string & var)
{
return MathUtils::timeDerivName(var);
}
// Navier-Stokes Variables
// Relating to porous media
static const std::string porosity = "porosity";
static const std::string smoothed_porosity = "smoothed_porosity";
static const std::string T_fluid = "T_fluid";
static const std::string T_solid = "T_solid";
static const std::string heat_source = "heat_source";
// Navier-Stokes Materials
static const std::string cL = "Darcy_coefficient";
static const std::string cQ = "Forchheimer_coefficient";
static const std::string alpha_boussinesq = "alpha_b";
static const std::string drhos_dTs = "drhos_dTs";
static const std::string dks_dTs = "dks_dTs";
static const std::string kappa = "kappa";
static const std::string kappa_s = "kappa_s";
static const std::string rho_s = "rho_s";
static const std::string cp_s = "cp_s";
static const std::string k_s = "k_s";
static const std::string cp = "cp";
static const std::string cv = "cv";
static const std::string mu = "mu";
// Turbulent dynamic viscosity
static const std::string mu_t = "mu_t";
// Turbulent dynamic scalar viscosity
static const std::string mu_t_passive_scalar = "mu_t_passive_scalar";
// Effective viscosity = sum of viscosities
static const std::string mu_eff = "mu_eff";
static const std::string k = "k";
// Turbulence 'conductivity'
static const std::string k_t = "k_t";
static const std::string thermal_diffusivity = "thermal_diffusivity";
static const std::string alpha = "alpha";
static const std::string alpha_wall = "alpha_wall";
static const std::string solid = "solid";
static const std::string Prandtl = "Pr";
static const std::string turbulent_Prandtl = "Pr_t";
static const std::string Reynolds = "Re";
static const std::string Reynolds_hydraulic = "Re_h";
static const std::string Reynolds_interstitial = "Re_i";
static const std::string c = "c";
static const std::string speed = "speed";
static const std::string sound_speed = "sound_speed";
// Two phase mixture materials
static const std::string latent_heat = "latent_heat";
static const std::string T_liquidus = "T_liquidus";
static const std::string T_solidus = "T_solidus";
static const std::string alpha_exchange = "alpha_exchange";
// other Navier-Stokes terms
static const std::string component = "component";
static const std::string source_scaling = "source_scaling";
// SUPG terms
static const std::string matrix_tau = "matrix_tau";
static const std::string vector_tau = "vector_tau";
static const std::string scalar_tau = "scalar_tau";
static const std::string diagonal_tau = "diagonal_tau";
static const std::string A = "A";
static const std::string R = "R";
static const std::string S = "S";
static const std::string dS_dTs = "dS_dTs";
static const std::string F = "F";
static const std::string G = "G";
static const std::string dUdt = "dUdt";
static const std::string C = "C";
static const std::string Z = "Z";
static const std::string K = "K";
static const std::string mass_flux = "mass_flux";
// Turbulence
// Turbulence variables
static const std::string TKE = "tke";
static const std::string TKED = "epsilon";
/**
* Wall treatment options
*/
enum class WallTreatmentEnum
{
EQ_NEWTON = 0,
EQ_INCREMENTAL = 1,
EQ_LINEARIZED = 2,
NEQ = 3
};
// Turbulence constants
static constexpr Real von_karman_constant = 0.4187;
static constexpr Real E_turb_constant = 9.793;
// Lower limit for mu_t
static constexpr Real mu_t_low_limit = 1.0e-8;
// Lower limit for epsilon in the k-epsilon
static constexpr Real epsilon_low_limit = 1.0e-8;
// Lower limit for y_plus
static constexpr Real min_y_plus = 1e-10;
}
namespace NS_DEFAULT_VALUES
{
static const Real infinite_porosity = 0.4;
static const int bed_axis = 2;
static const Real wall_porosity = 1.0;
static const Real k_epsilon = 1e-6;
static const Real vel_epsilon = 1e-8;
static const RealVectorValue center(0.0, 0.0, 0.0);
static const RealVectorValue acceleration(0.0, 0.0, 0.0);
// assumed that the RZ geometry is not annular unless otherwise specified
static const Real inner_radius = 0.0;
}
namespace NS_CONSTANTS
{
using namespace HeatConduction::Constants;
}
(contrib/moose/modules/navier_stokes/include/base/NS.h)
// This file is part of the MOOSE framework
// https://www.mooseframework.org
//
// All rights reserved, see COPYRIGHT for full restrictions
// https://github.com/idaholab/moose/blob/master/COPYRIGHT
//
// Licensed under LGPL 2.1, please see LICENSE for details
// https://www.gnu.org/licenses/lgpl-2.1.html
#pragma once
#include <string>
#include "MathUtils.h"
#include "MooseTypes.h"
#include "libmesh/vector_value.h"
#include "HeatConductionNames.h"
namespace NS
{
using namespace HeatConduction;
static const std::string directions[3] = {"x", "y", "z"};
// geometric quantities
static const std::string pebble_diameter = "pebble_diameter";
static const std::string infinite_porosity = "infinite_porosity";
static const std::string axis = "axis";
static const std::string center = "center";
static const std::string wall_porosity = "wall_porosity";
static const std::string wall_distance = "wall_distance";
// Names defined in Navier-Stokes
static const std::string density = "rho";
static const std::string superficial_density = "superficial_rho";
static const std::string momentum_x = "rhou";
static const std::string momentum_y = "rhov";
static const std::string momentum_z = "rhow";
static const std::string momentum_vector[3] = {momentum_x, momentum_y, momentum_z};
static const std::string superficial_momentum_x = "superficial_rhou";
static const std::string superficial_momentum_y = "superficial_rhov";
static const std::string superficial_momentum_z = "superficial_rhow";
static const std::string superficial_momentum_vector[3] = {
superficial_momentum_x, superficial_momentum_y, superficial_momentum_z};
static const std::string velocity = "velocity";
static const std::string velocity_x = "vel_x";
static const std::string velocity_y = "vel_y";
static const std::string velocity_z = "vel_z";
const std::string velocity_vector[3] = {velocity_x, velocity_y, velocity_z};
static const std::string superficial_velocity_x = "superficial_vel_x";
static const std::string superficial_velocity_y = "superficial_vel_y";
static const std::string superficial_velocity_z = "superficial_vel_z";
static const std::string superficial_velocity = "superficial_velocity";
static const std::string superficial_velocity_vector[3] = {
superficial_velocity_x, superficial_velocity_y, superficial_velocity_z};
static const std::string pressure = "pressure";
static const std::string temperature = "temperature";
static const std::string internal_energy = "internal_energy";
static const std::string specific_internal_energy = "e";
static const std::string specific_total_energy = "et";
static const std::string internal_energy_density = "rho_e";
static const std::string total_energy_density = "rho_et";
static const std::string superficial_total_energy_density = "superficial_rho_et";
static const std::string specific_enthalpy = "h";
static const std::string specific_total_enthalpy = "ht";
static const std::string enthalpy_density = "rho_h";
static const std::string total_enthalpy_density = "rho_ht";
static const std::string superficial_total_enthalpy_density = "superficial_rho_ht";
static const std::string mixing_length = "mixing_length";
static const std::string wall_shear_stress = "wall_shear_stress";
static const std::string wall_yplus = "wall_yplus";
static const std::string eddy_viscosity = "eddy_viscosity";
static const std::string total_viscosity = "total_viscosity";
static const std::string mach_number = "Mach";
static const std::string specific_volume = "specific_volume";
static const std::string momentum = "momentum";
static const std::string v = "v";
static const std::string acceleration = "acceleration";
static const std::string fluid = "fp";
// for Navier-Stokes material props representing gradients of nonlin+aux vars
inline std::string
grad(const std::string & var)
{
return MathUtils::gradName(var);
}
// for Navier-Stokes material props representing time derivatives of nonlin+aux vars
inline std::string
time_deriv(const std::string & var)
{
return MathUtils::timeDerivName(var);
}
// Navier-Stokes Variables
// Relating to porous media
static const std::string porosity = "porosity";
static const std::string smoothed_porosity = "smoothed_porosity";
static const std::string T_fluid = "T_fluid";
static const std::string T_solid = "T_solid";
static const std::string heat_source = "heat_source";
// Navier-Stokes Materials
static const std::string cL = "Darcy_coefficient";
static const std::string cQ = "Forchheimer_coefficient";
static const std::string alpha_boussinesq = "alpha_b";
static const std::string drhos_dTs = "drhos_dTs";
static const std::string dks_dTs = "dks_dTs";
static const std::string kappa = "kappa";
static const std::string kappa_s = "kappa_s";
static const std::string rho_s = "rho_s";
static const std::string cp_s = "cp_s";
static const std::string k_s = "k_s";
static const std::string cp = "cp";
static const std::string cv = "cv";
static const std::string mu = "mu";
// Turbulent dynamic viscosity
static const std::string mu_t = "mu_t";
// Turbulent dynamic scalar viscosity
static const std::string mu_t_passive_scalar = "mu_t_passive_scalar";
// Effective viscosity = sum of viscosities
static const std::string mu_eff = "mu_eff";
static const std::string k = "k";
// Turbulence 'conductivity'
static const std::string k_t = "k_t";
static const std::string thermal_diffusivity = "thermal_diffusivity";
static const std::string alpha = "alpha";
static const std::string alpha_wall = "alpha_wall";
static const std::string solid = "solid";
static const std::string Prandtl = "Pr";
static const std::string turbulent_Prandtl = "Pr_t";
static const std::string Reynolds = "Re";
static const std::string Reynolds_hydraulic = "Re_h";
static const std::string Reynolds_interstitial = "Re_i";
static const std::string c = "c";
static const std::string speed = "speed";
static const std::string sound_speed = "sound_speed";
// Two phase mixture materials
static const std::string latent_heat = "latent_heat";
static const std::string T_liquidus = "T_liquidus";
static const std::string T_solidus = "T_solidus";
static const std::string alpha_exchange = "alpha_exchange";
// other Navier-Stokes terms
static const std::string component = "component";
static const std::string source_scaling = "source_scaling";
// SUPG terms
static const std::string matrix_tau = "matrix_tau";
static const std::string vector_tau = "vector_tau";
static const std::string scalar_tau = "scalar_tau";
static const std::string diagonal_tau = "diagonal_tau";
static const std::string A = "A";
static const std::string R = "R";
static const std::string S = "S";
static const std::string dS_dTs = "dS_dTs";
static const std::string F = "F";
static const std::string G = "G";
static const std::string dUdt = "dUdt";
static const std::string C = "C";
static const std::string Z = "Z";
static const std::string K = "K";
static const std::string mass_flux = "mass_flux";
// Turbulence
// Turbulence variables
static const std::string TKE = "tke";
static const std::string TKED = "epsilon";
/**
* Wall treatment options
*/
enum class WallTreatmentEnum
{
EQ_NEWTON = 0,
EQ_INCREMENTAL = 1,
EQ_LINEARIZED = 2,
NEQ = 3
};
// Turbulence constants
static constexpr Real von_karman_constant = 0.4187;
static constexpr Real E_turb_constant = 9.793;
// Lower limit for mu_t
static constexpr Real mu_t_low_limit = 1.0e-8;
// Lower limit for epsilon in the k-epsilon
static constexpr Real epsilon_low_limit = 1.0e-8;
// Lower limit for y_plus
static constexpr Real min_y_plus = 1e-10;
}
namespace NS_DEFAULT_VALUES
{
static const Real infinite_porosity = 0.4;
static const int bed_axis = 2;
static const Real wall_porosity = 1.0;
static const Real k_epsilon = 1e-6;
static const Real vel_epsilon = 1e-8;
static const RealVectorValue center(0.0, 0.0, 0.0);
static const RealVectorValue acceleration(0.0, 0.0, 0.0);
// assumed that the RZ geometry is not annular unless otherwise specified
static const Real inner_radius = 0.0;
}
namespace NS_CONSTANTS
{
using namespace HeatConduction::Constants;
}
(contrib/moose/modules/navier_stokes/include/base/NS.h)
// This file is part of the MOOSE framework
// https://www.mooseframework.org
//
// All rights reserved, see COPYRIGHT for full restrictions
// https://github.com/idaholab/moose/blob/master/COPYRIGHT
//
// Licensed under LGPL 2.1, please see LICENSE for details
// https://www.gnu.org/licenses/lgpl-2.1.html
#pragma once
#include <string>
#include "MathUtils.h"
#include "MooseTypes.h"
#include "libmesh/vector_value.h"
#include "HeatConductionNames.h"
namespace NS
{
using namespace HeatConduction;
static const std::string directions[3] = {"x", "y", "z"};
// geometric quantities
static const std::string pebble_diameter = "pebble_diameter";
static const std::string infinite_porosity = "infinite_porosity";
static const std::string axis = "axis";
static const std::string center = "center";
static const std::string wall_porosity = "wall_porosity";
static const std::string wall_distance = "wall_distance";
// Names defined in Navier-Stokes
static const std::string density = "rho";
static const std::string superficial_density = "superficial_rho";
static const std::string momentum_x = "rhou";
static const std::string momentum_y = "rhov";
static const std::string momentum_z = "rhow";
static const std::string momentum_vector[3] = {momentum_x, momentum_y, momentum_z};
static const std::string superficial_momentum_x = "superficial_rhou";
static const std::string superficial_momentum_y = "superficial_rhov";
static const std::string superficial_momentum_z = "superficial_rhow";
static const std::string superficial_momentum_vector[3] = {
superficial_momentum_x, superficial_momentum_y, superficial_momentum_z};
static const std::string velocity = "velocity";
static const std::string velocity_x = "vel_x";
static const std::string velocity_y = "vel_y";
static const std::string velocity_z = "vel_z";
const std::string velocity_vector[3] = {velocity_x, velocity_y, velocity_z};
static const std::string superficial_velocity_x = "superficial_vel_x";
static const std::string superficial_velocity_y = "superficial_vel_y";
static const std::string superficial_velocity_z = "superficial_vel_z";
static const std::string superficial_velocity = "superficial_velocity";
static const std::string superficial_velocity_vector[3] = {
superficial_velocity_x, superficial_velocity_y, superficial_velocity_z};
static const std::string pressure = "pressure";
static const std::string temperature = "temperature";
static const std::string internal_energy = "internal_energy";
static const std::string specific_internal_energy = "e";
static const std::string specific_total_energy = "et";
static const std::string internal_energy_density = "rho_e";
static const std::string total_energy_density = "rho_et";
static const std::string superficial_total_energy_density = "superficial_rho_et";
static const std::string specific_enthalpy = "h";
static const std::string specific_total_enthalpy = "ht";
static const std::string enthalpy_density = "rho_h";
static const std::string total_enthalpy_density = "rho_ht";
static const std::string superficial_total_enthalpy_density = "superficial_rho_ht";
static const std::string mixing_length = "mixing_length";
static const std::string wall_shear_stress = "wall_shear_stress";
static const std::string wall_yplus = "wall_yplus";
static const std::string eddy_viscosity = "eddy_viscosity";
static const std::string total_viscosity = "total_viscosity";
static const std::string mach_number = "Mach";
static const std::string specific_volume = "specific_volume";
static const std::string momentum = "momentum";
static const std::string v = "v";
static const std::string acceleration = "acceleration";
static const std::string fluid = "fp";
// for Navier-Stokes material props representing gradients of nonlin+aux vars
inline std::string
grad(const std::string & var)
{
return MathUtils::gradName(var);
}
// for Navier-Stokes material props representing time derivatives of nonlin+aux vars
inline std::string
time_deriv(const std::string & var)
{
return MathUtils::timeDerivName(var);
}
// Navier-Stokes Variables
// Relating to porous media
static const std::string porosity = "porosity";
static const std::string smoothed_porosity = "smoothed_porosity";
static const std::string T_fluid = "T_fluid";
static const std::string T_solid = "T_solid";
static const std::string heat_source = "heat_source";
// Navier-Stokes Materials
static const std::string cL = "Darcy_coefficient";
static const std::string cQ = "Forchheimer_coefficient";
static const std::string alpha_boussinesq = "alpha_b";
static const std::string drhos_dTs = "drhos_dTs";
static const std::string dks_dTs = "dks_dTs";
static const std::string kappa = "kappa";
static const std::string kappa_s = "kappa_s";
static const std::string rho_s = "rho_s";
static const std::string cp_s = "cp_s";
static const std::string k_s = "k_s";
static const std::string cp = "cp";
static const std::string cv = "cv";
static const std::string mu = "mu";
// Turbulent dynamic viscosity
static const std::string mu_t = "mu_t";
// Turbulent dynamic scalar viscosity
static const std::string mu_t_passive_scalar = "mu_t_passive_scalar";
// Effective viscosity = sum of viscosities
static const std::string mu_eff = "mu_eff";
static const std::string k = "k";
// Turbulence 'conductivity'
static const std::string k_t = "k_t";
static const std::string thermal_diffusivity = "thermal_diffusivity";
static const std::string alpha = "alpha";
static const std::string alpha_wall = "alpha_wall";
static const std::string solid = "solid";
static const std::string Prandtl = "Pr";
static const std::string turbulent_Prandtl = "Pr_t";
static const std::string Reynolds = "Re";
static const std::string Reynolds_hydraulic = "Re_h";
static const std::string Reynolds_interstitial = "Re_i";
static const std::string c = "c";
static const std::string speed = "speed";
static const std::string sound_speed = "sound_speed";
// Two phase mixture materials
static const std::string latent_heat = "latent_heat";
static const std::string T_liquidus = "T_liquidus";
static const std::string T_solidus = "T_solidus";
static const std::string alpha_exchange = "alpha_exchange";
// other Navier-Stokes terms
static const std::string component = "component";
static const std::string source_scaling = "source_scaling";
// SUPG terms
static const std::string matrix_tau = "matrix_tau";
static const std::string vector_tau = "vector_tau";
static const std::string scalar_tau = "scalar_tau";
static const std::string diagonal_tau = "diagonal_tau";
static const std::string A = "A";
static const std::string R = "R";
static const std::string S = "S";
static const std::string dS_dTs = "dS_dTs";
static const std::string F = "F";
static const std::string G = "G";
static const std::string dUdt = "dUdt";
static const std::string C = "C";
static const std::string Z = "Z";
static const std::string K = "K";
static const std::string mass_flux = "mass_flux";
// Turbulence
// Turbulence variables
static const std::string TKE = "tke";
static const std::string TKED = "epsilon";
/**
* Wall treatment options
*/
enum class WallTreatmentEnum
{
EQ_NEWTON = 0,
EQ_INCREMENTAL = 1,
EQ_LINEARIZED = 2,
NEQ = 3
};
// Turbulence constants
static constexpr Real von_karman_constant = 0.4187;
static constexpr Real E_turb_constant = 9.793;
// Lower limit for mu_t
static constexpr Real mu_t_low_limit = 1.0e-8;
// Lower limit for epsilon in the k-epsilon
static constexpr Real epsilon_low_limit = 1.0e-8;
// Lower limit for y_plus
static constexpr Real min_y_plus = 1e-10;
}
namespace NS_DEFAULT_VALUES
{
static const Real infinite_porosity = 0.4;
static const int bed_axis = 2;
static const Real wall_porosity = 1.0;
static const Real k_epsilon = 1e-6;
static const Real vel_epsilon = 1e-8;
static const RealVectorValue center(0.0, 0.0, 0.0);
static const RealVectorValue acceleration(0.0, 0.0, 0.0);
// assumed that the RZ geometry is not annular unless otherwise specified
static const Real inner_radius = 0.0;
}
namespace NS_CONSTANTS
{
using namespace HeatConduction::Constants;
}
(contrib/moose/modules/navier_stokes/include/base/NS.h)
// This file is part of the MOOSE framework
// https://www.mooseframework.org
//
// All rights reserved, see COPYRIGHT for full restrictions
// https://github.com/idaholab/moose/blob/master/COPYRIGHT
//
// Licensed under LGPL 2.1, please see LICENSE for details
// https://www.gnu.org/licenses/lgpl-2.1.html
#pragma once
#include <string>
#include "MathUtils.h"
#include "MooseTypes.h"
#include "libmesh/vector_value.h"
#include "HeatConductionNames.h"
namespace NS
{
using namespace HeatConduction;
static const std::string directions[3] = {"x", "y", "z"};
// geometric quantities
static const std::string pebble_diameter = "pebble_diameter";
static const std::string infinite_porosity = "infinite_porosity";
static const std::string axis = "axis";
static const std::string center = "center";
static const std::string wall_porosity = "wall_porosity";
static const std::string wall_distance = "wall_distance";
// Names defined in Navier-Stokes
static const std::string density = "rho";
static const std::string superficial_density = "superficial_rho";
static const std::string momentum_x = "rhou";
static const std::string momentum_y = "rhov";
static const std::string momentum_z = "rhow";
static const std::string momentum_vector[3] = {momentum_x, momentum_y, momentum_z};
static const std::string superficial_momentum_x = "superficial_rhou";
static const std::string superficial_momentum_y = "superficial_rhov";
static const std::string superficial_momentum_z = "superficial_rhow";
static const std::string superficial_momentum_vector[3] = {
superficial_momentum_x, superficial_momentum_y, superficial_momentum_z};
static const std::string velocity = "velocity";
static const std::string velocity_x = "vel_x";
static const std::string velocity_y = "vel_y";
static const std::string velocity_z = "vel_z";
const std::string velocity_vector[3] = {velocity_x, velocity_y, velocity_z};
static const std::string superficial_velocity_x = "superficial_vel_x";
static const std::string superficial_velocity_y = "superficial_vel_y";
static const std::string superficial_velocity_z = "superficial_vel_z";
static const std::string superficial_velocity = "superficial_velocity";
static const std::string superficial_velocity_vector[3] = {
superficial_velocity_x, superficial_velocity_y, superficial_velocity_z};
static const std::string pressure = "pressure";
static const std::string temperature = "temperature";
static const std::string internal_energy = "internal_energy";
static const std::string specific_internal_energy = "e";
static const std::string specific_total_energy = "et";
static const std::string internal_energy_density = "rho_e";
static const std::string total_energy_density = "rho_et";
static const std::string superficial_total_energy_density = "superficial_rho_et";
static const std::string specific_enthalpy = "h";
static const std::string specific_total_enthalpy = "ht";
static const std::string enthalpy_density = "rho_h";
static const std::string total_enthalpy_density = "rho_ht";
static const std::string superficial_total_enthalpy_density = "superficial_rho_ht";
static const std::string mixing_length = "mixing_length";
static const std::string wall_shear_stress = "wall_shear_stress";
static const std::string wall_yplus = "wall_yplus";
static const std::string eddy_viscosity = "eddy_viscosity";
static const std::string total_viscosity = "total_viscosity";
static const std::string mach_number = "Mach";
static const std::string specific_volume = "specific_volume";
static const std::string momentum = "momentum";
static const std::string v = "v";
static const std::string acceleration = "acceleration";
static const std::string fluid = "fp";
// for Navier-Stokes material props representing gradients of nonlin+aux vars
inline std::string
grad(const std::string & var)
{
return MathUtils::gradName(var);
}
// for Navier-Stokes material props representing time derivatives of nonlin+aux vars
inline std::string
time_deriv(const std::string & var)
{
return MathUtils::timeDerivName(var);
}
// Navier-Stokes Variables
// Relating to porous media
static const std::string porosity = "porosity";
static const std::string smoothed_porosity = "smoothed_porosity";
static const std::string T_fluid = "T_fluid";
static const std::string T_solid = "T_solid";
static const std::string heat_source = "heat_source";
// Navier-Stokes Materials
static const std::string cL = "Darcy_coefficient";
static const std::string cQ = "Forchheimer_coefficient";
static const std::string alpha_boussinesq = "alpha_b";
static const std::string drhos_dTs = "drhos_dTs";
static const std::string dks_dTs = "dks_dTs";
static const std::string kappa = "kappa";
static const std::string kappa_s = "kappa_s";
static const std::string rho_s = "rho_s";
static const std::string cp_s = "cp_s";
static const std::string k_s = "k_s";
static const std::string cp = "cp";
static const std::string cv = "cv";
static const std::string mu = "mu";
// Turbulent dynamic viscosity
static const std::string mu_t = "mu_t";
// Turbulent dynamic scalar viscosity
static const std::string mu_t_passive_scalar = "mu_t_passive_scalar";
// Effective viscosity = sum of viscosities
static const std::string mu_eff = "mu_eff";
static const std::string k = "k";
// Turbulence 'conductivity'
static const std::string k_t = "k_t";
static const std::string thermal_diffusivity = "thermal_diffusivity";
static const std::string alpha = "alpha";
static const std::string alpha_wall = "alpha_wall";
static const std::string solid = "solid";
static const std::string Prandtl = "Pr";
static const std::string turbulent_Prandtl = "Pr_t";
static const std::string Reynolds = "Re";
static const std::string Reynolds_hydraulic = "Re_h";
static const std::string Reynolds_interstitial = "Re_i";
static const std::string c = "c";
static const std::string speed = "speed";
static const std::string sound_speed = "sound_speed";
// Two phase mixture materials
static const std::string latent_heat = "latent_heat";
static const std::string T_liquidus = "T_liquidus";
static const std::string T_solidus = "T_solidus";
static const std::string alpha_exchange = "alpha_exchange";
// other Navier-Stokes terms
static const std::string component = "component";
static const std::string source_scaling = "source_scaling";
// SUPG terms
static const std::string matrix_tau = "matrix_tau";
static const std::string vector_tau = "vector_tau";
static const std::string scalar_tau = "scalar_tau";
static const std::string diagonal_tau = "diagonal_tau";
static const std::string A = "A";
static const std::string R = "R";
static const std::string S = "S";
static const std::string dS_dTs = "dS_dTs";
static const std::string F = "F";
static const std::string G = "G";
static const std::string dUdt = "dUdt";
static const std::string C = "C";
static const std::string Z = "Z";
static const std::string K = "K";
static const std::string mass_flux = "mass_flux";
// Turbulence
// Turbulence variables
static const std::string TKE = "tke";
static const std::string TKED = "epsilon";
/**
* Wall treatment options
*/
enum class WallTreatmentEnum
{
EQ_NEWTON = 0,
EQ_INCREMENTAL = 1,
EQ_LINEARIZED = 2,
NEQ = 3
};
// Turbulence constants
static constexpr Real von_karman_constant = 0.4187;
static constexpr Real E_turb_constant = 9.793;
// Lower limit for mu_t
static constexpr Real mu_t_low_limit = 1.0e-8;
// Lower limit for epsilon in the k-epsilon
static constexpr Real epsilon_low_limit = 1.0e-8;
// Lower limit for y_plus
static constexpr Real min_y_plus = 1e-10;
}
namespace NS_DEFAULT_VALUES
{
static const Real infinite_porosity = 0.4;
static const int bed_axis = 2;
static const Real wall_porosity = 1.0;
static const Real k_epsilon = 1e-6;
static const Real vel_epsilon = 1e-8;
static const RealVectorValue center(0.0, 0.0, 0.0);
static const RealVectorValue acceleration(0.0, 0.0, 0.0);
// assumed that the RZ geometry is not annular unless otherwise specified
static const Real inner_radius = 0.0;
}
namespace NS_CONSTANTS
{
using namespace HeatConduction::Constants;
}
(contrib/moose/modules/navier_stokes/include/base/NS.h)
// This file is part of the MOOSE framework
// https://www.mooseframework.org
//
// All rights reserved, see COPYRIGHT for full restrictions
// https://github.com/idaholab/moose/blob/master/COPYRIGHT
//
// Licensed under LGPL 2.1, please see LICENSE for details
// https://www.gnu.org/licenses/lgpl-2.1.html
#pragma once
#include <string>
#include "MathUtils.h"
#include "MooseTypes.h"
#include "libmesh/vector_value.h"
#include "HeatConductionNames.h"
namespace NS
{
using namespace HeatConduction;
static const std::string directions[3] = {"x", "y", "z"};
// geometric quantities
static const std::string pebble_diameter = "pebble_diameter";
static const std::string infinite_porosity = "infinite_porosity";
static const std::string axis = "axis";
static const std::string center = "center";
static const std::string wall_porosity = "wall_porosity";
static const std::string wall_distance = "wall_distance";
// Names defined in Navier-Stokes
static const std::string density = "rho";
static const std::string superficial_density = "superficial_rho";
static const std::string momentum_x = "rhou";
static const std::string momentum_y = "rhov";
static const std::string momentum_z = "rhow";
static const std::string momentum_vector[3] = {momentum_x, momentum_y, momentum_z};
static const std::string superficial_momentum_x = "superficial_rhou";
static const std::string superficial_momentum_y = "superficial_rhov";
static const std::string superficial_momentum_z = "superficial_rhow";
static const std::string superficial_momentum_vector[3] = {
superficial_momentum_x, superficial_momentum_y, superficial_momentum_z};
static const std::string velocity = "velocity";
static const std::string velocity_x = "vel_x";
static const std::string velocity_y = "vel_y";
static const std::string velocity_z = "vel_z";
const std::string velocity_vector[3] = {velocity_x, velocity_y, velocity_z};
static const std::string superficial_velocity_x = "superficial_vel_x";
static const std::string superficial_velocity_y = "superficial_vel_y";
static const std::string superficial_velocity_z = "superficial_vel_z";
static const std::string superficial_velocity = "superficial_velocity";
static const std::string superficial_velocity_vector[3] = {
superficial_velocity_x, superficial_velocity_y, superficial_velocity_z};
static const std::string pressure = "pressure";
static const std::string temperature = "temperature";
static const std::string internal_energy = "internal_energy";
static const std::string specific_internal_energy = "e";
static const std::string specific_total_energy = "et";
static const std::string internal_energy_density = "rho_e";
static const std::string total_energy_density = "rho_et";
static const std::string superficial_total_energy_density = "superficial_rho_et";
static const std::string specific_enthalpy = "h";
static const std::string specific_total_enthalpy = "ht";
static const std::string enthalpy_density = "rho_h";
static const std::string total_enthalpy_density = "rho_ht";
static const std::string superficial_total_enthalpy_density = "superficial_rho_ht";
static const std::string mixing_length = "mixing_length";
static const std::string wall_shear_stress = "wall_shear_stress";
static const std::string wall_yplus = "wall_yplus";
static const std::string eddy_viscosity = "eddy_viscosity";
static const std::string total_viscosity = "total_viscosity";
static const std::string mach_number = "Mach";
static const std::string specific_volume = "specific_volume";
static const std::string momentum = "momentum";
static const std::string v = "v";
static const std::string acceleration = "acceleration";
static const std::string fluid = "fp";
// for Navier-Stokes material props representing gradients of nonlin+aux vars
inline std::string
grad(const std::string & var)
{
return MathUtils::gradName(var);
}
// for Navier-Stokes material props representing time derivatives of nonlin+aux vars
inline std::string
time_deriv(const std::string & var)
{
return MathUtils::timeDerivName(var);
}
// Navier-Stokes Variables
// Relating to porous media
static const std::string porosity = "porosity";
static const std::string smoothed_porosity = "smoothed_porosity";
static const std::string T_fluid = "T_fluid";
static const std::string T_solid = "T_solid";
static const std::string heat_source = "heat_source";
// Navier-Stokes Materials
static const std::string cL = "Darcy_coefficient";
static const std::string cQ = "Forchheimer_coefficient";
static const std::string alpha_boussinesq = "alpha_b";
static const std::string drhos_dTs = "drhos_dTs";
static const std::string dks_dTs = "dks_dTs";
static const std::string kappa = "kappa";
static const std::string kappa_s = "kappa_s";
static const std::string rho_s = "rho_s";
static const std::string cp_s = "cp_s";
static const std::string k_s = "k_s";
static const std::string cp = "cp";
static const std::string cv = "cv";
static const std::string mu = "mu";
// Turbulent dynamic viscosity
static const std::string mu_t = "mu_t";
// Turbulent dynamic scalar viscosity
static const std::string mu_t_passive_scalar = "mu_t_passive_scalar";
// Effective viscosity = sum of viscosities
static const std::string mu_eff = "mu_eff";
static const std::string k = "k";
// Turbulence 'conductivity'
static const std::string k_t = "k_t";
static const std::string thermal_diffusivity = "thermal_diffusivity";
static const std::string alpha = "alpha";
static const std::string alpha_wall = "alpha_wall";
static const std::string solid = "solid";
static const std::string Prandtl = "Pr";
static const std::string turbulent_Prandtl = "Pr_t";
static const std::string Reynolds = "Re";
static const std::string Reynolds_hydraulic = "Re_h";
static const std::string Reynolds_interstitial = "Re_i";
static const std::string c = "c";
static const std::string speed = "speed";
static const std::string sound_speed = "sound_speed";
// Two phase mixture materials
static const std::string latent_heat = "latent_heat";
static const std::string T_liquidus = "T_liquidus";
static const std::string T_solidus = "T_solidus";
static const std::string alpha_exchange = "alpha_exchange";
// other Navier-Stokes terms
static const std::string component = "component";
static const std::string source_scaling = "source_scaling";
// SUPG terms
static const std::string matrix_tau = "matrix_tau";
static const std::string vector_tau = "vector_tau";
static const std::string scalar_tau = "scalar_tau";
static const std::string diagonal_tau = "diagonal_tau";
static const std::string A = "A";
static const std::string R = "R";
static const std::string S = "S";
static const std::string dS_dTs = "dS_dTs";
static const std::string F = "F";
static const std::string G = "G";
static const std::string dUdt = "dUdt";
static const std::string C = "C";
static const std::string Z = "Z";
static const std::string K = "K";
static const std::string mass_flux = "mass_flux";
// Turbulence
// Turbulence variables
static const std::string TKE = "tke";
static const std::string TKED = "epsilon";
/**
* Wall treatment options
*/
enum class WallTreatmentEnum
{
EQ_NEWTON = 0,
EQ_INCREMENTAL = 1,
EQ_LINEARIZED = 2,
NEQ = 3
};
// Turbulence constants
static constexpr Real von_karman_constant = 0.4187;
static constexpr Real E_turb_constant = 9.793;
// Lower limit for mu_t
static constexpr Real mu_t_low_limit = 1.0e-8;
// Lower limit for epsilon in the k-epsilon
static constexpr Real epsilon_low_limit = 1.0e-8;
// Lower limit for y_plus
static constexpr Real min_y_plus = 1e-10;
}
namespace NS_DEFAULT_VALUES
{
static const Real infinite_porosity = 0.4;
static const int bed_axis = 2;
static const Real wall_porosity = 1.0;
static const Real k_epsilon = 1e-6;
static const Real vel_epsilon = 1e-8;
static const RealVectorValue center(0.0, 0.0, 0.0);
static const RealVectorValue acceleration(0.0, 0.0, 0.0);
// assumed that the RZ geometry is not annular unless otherwise specified
static const Real inner_radius = 0.0;
}
namespace NS_CONSTANTS
{
using namespace HeatConduction::Constants;
}
(contrib/moose/modules/navier_stokes/test/tests/finite_volume/ins/lid-driven/lid-driven-with-energy.i)
mu = 1
rho = 1
k = .01
cp = 1
velocity_interp_method = 'rc'
advected_interp_method = 'average'
[GlobalParams]
rhie_chow_user_object = 'rc'
[]
[UserObjects]
[rc]
type = INSFVRhieChowInterpolator
u = vel_x
v = vel_y
pressure = pressure
[]
[]
[Mesh]
[gen]
type = GeneratedMeshGenerator
dim = 2
xmin = 0
xmax = 1
ymin = 0
ymax = 1
nx = 32
ny = 32
[]
[]
[Variables]
[vel_x]
type = INSFVVelocityVariable
[]
[vel_y]
type = INSFVVelocityVariable
[]
[pressure]
type = INSFVPressureVariable
[]
[T_fluid]
type = INSFVEnergyVariable
[]
[lambda]
family = SCALAR
order = FIRST
[]
[]
[AuxVariables]
[U]
order = CONSTANT
family = MONOMIAL
fv = true
[]
[]
[AuxKernels]
[mag]
type = VectorMagnitudeAux
variable = U
x = vel_x
y = vel_y
[]
[]
[FVKernels]
[mass]
type = INSFVMassAdvection
variable = pressure
advected_interp_method = ${advected_interp_method}
velocity_interp_method = ${velocity_interp_method}
rho = ${rho}
[]
[mean_zero_pressure]
type = FVIntegralValueConstraint
variable = pressure
lambda = lambda
[]
[u_advection]
type = INSFVMomentumAdvection
variable = vel_x
velocity_interp_method = ${velocity_interp_method}
advected_interp_method = ${advected_interp_method}
rho = ${rho}
momentum_component = 'x'
[]
[u_viscosity]
type = INSFVMomentumDiffusion
variable = vel_x
mu = ${mu}
momentum_component = 'x'
[]
[u_pressure]
type = INSFVMomentumPressure
variable = vel_x
momentum_component = 'x'
pressure = pressure
[]
[v_advection]
type = INSFVMomentumAdvection
variable = vel_y
velocity_interp_method = ${velocity_interp_method}
advected_interp_method = ${advected_interp_method}
rho = ${rho}
momentum_component = 'y'
[]
[v_viscosity]
type = INSFVMomentumDiffusion
variable = vel_y
mu = ${mu}
momentum_component = 'y'
[]
[v_pressure]
type = INSFVMomentumPressure
variable = vel_y
momentum_component = 'y'
pressure = pressure
[]
[temp_conduction]
type = FVDiffusion
coeff = 'k'
variable = T_fluid
[]
[temp_advection]
type = INSFVEnergyAdvection
variable = T_fluid
velocity_interp_method = ${velocity_interp_method}
advected_interp_method = ${advected_interp_method}
[]
[]
[FVBCs]
[top_x]
type = INSFVNoSlipWallBC
variable = vel_x
boundary = 'top'
function = 'lid_function'
[]
[no_slip_x]
type = INSFVNoSlipWallBC
variable = vel_x
boundary = 'left right bottom'
function = 0
[]
[no_slip_y]
type = INSFVNoSlipWallBC
variable = vel_y
boundary = 'left right top bottom'
function = 0
[]
[T_hot]
type = FVDirichletBC
variable = T_fluid
boundary = 'bottom'
value = 1
[]
[T_cold]
type = FVDirichletBC
variable = T_fluid
boundary = 'top'
value = 0
[]
[]
[FunctorMaterials]
[functor_constants]
type = ADGenericFunctorMaterial
prop_names = 'cp k'
prop_values = '${cp} ${k}'
[]
[ins_fv]
type = INSFVEnthalpyFunctorMaterial
temperature = 'T_fluid'
rho = ${rho}
[]
[]
[Functions]
[lid_function]
type = ParsedFunction
expression = '4*x*(1-x)'
[]
[]
[Executioner]
type = Steady
solve_type = 'NEWTON'
petsc_options_iname = '-pc_type -pc_factor_shift_type'
petsc_options_value = 'lu NONZERO'
nl_rel_tol = 1e-12
[]
[Outputs]
exodus = true
[]
(contrib/moose/modules/navier_stokes/test/tests/finite_volume/ins/lid-driven/lid-driven-with-energy-action.i)
mu = 1
rho = 1
k = .01
cp = 1
[Mesh]
[gen]
type = GeneratedMeshGenerator
dim = 2
xmin = 0
xmax = 1
ymin = 0
ymax = 1
nx = 32
ny = 32
[]
[]
[Modules]
[NavierStokesFV]
compressibility = 'incompressible'
add_energy_equation = true
density = 'rho'
dynamic_viscosity = 'mu'
thermal_conductivity = 'k'
specific_heat = 'cp'
initial_pressure = 0.0
initial_temperature = 0.0
inlet_boundaries = 'top'
momentum_inlet_types = 'fixed-velocity'
momentum_inlet_function = 'lid_function 0'
energy_inlet_types = 'fixed-temperature'
energy_inlet_function = '0'
wall_boundaries = 'left right bottom'
momentum_wall_types = 'noslip noslip noslip'
energy_wall_types = 'heatflux heatflux fixed-temperature'
energy_wall_function = '0 0 1'
pin_pressure = true
pinned_pressure_type = average
pinned_pressure_value = 0
mass_advection_interpolation = 'average'
momentum_advection_interpolation = 'average'
energy_advection_interpolation = 'average'
[]
[]
[AuxVariables]
[U]
order = CONSTANT
family = MONOMIAL
fv = true
[]
[]
[AuxKernels]
[mag]
type = VectorMagnitudeAux
variable = U
x = vel_x
y = vel_y
[]
[]
[FunctorMaterials]
[functor_constants]
type = ADGenericFunctorMaterial
prop_names = 'cp k rho mu'
prop_values = '${cp} ${k} ${rho} ${mu}'
[]
[]
[Functions]
[lid_function]
type = ParsedFunction
expression = '4*x*(1-x)'
[]
[]
[Executioner]
type = Steady
solve_type = 'NEWTON'
petsc_options_iname = '-pc_type -pc_factor_shift_type'
petsc_options_value = 'lu NONZERO'
nl_rel_tol = 1e-12
[]
[Outputs]
exodus = true
[]
compressibility
Default:incompressible
C++ Type:MooseEnum
Unit:(no unit assumed)
Options:incompressible, weakly-compressible
Controllable:No
Description:Compressibility constraint for the Navier-Stokes equations.
add_energy_equation
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
(contrib/moose/modules/navier_stokes/test/tests/finite_volume/pins/channel-flow/heated/2d-rc-heated.i)
mu = 1
rho = 1
k = 1e-3
cp = 1
u_inlet = 1
T_inlet = 200
advected_interp_method = 'average'
velocity_interp_method = 'rc'
[Mesh]
[mesh]
type = CartesianMeshGenerator
dim = 2
dx = '5 5'
dy = '1.0'
ix = '50 50'
iy = '20'
subdomain_id = '1 2'
[]
[]
[GlobalParams]
rhie_chow_user_object = 'rc'
[]
[UserObjects]
[rc]
type = PINSFVRhieChowInterpolator
u = superficial_vel_x
v = superficial_vel_y
pressure = pressure
porosity = porosity
[]
[]
[Variables]
inactive = 'T_solid'
[superficial_vel_x]
type = PINSFVSuperficialVelocityVariable
initial_condition = ${u_inlet}
[]
[superficial_vel_y]
type = PINSFVSuperficialVelocityVariable
initial_condition = 1e-6
[]
[pressure]
type = INSFVPressureVariable
[]
[T_fluid]
type = INSFVEnergyVariable
[]
[T_solid]
family = 'MONOMIAL'
order = 'CONSTANT'
fv = true
[]
[]
[AuxVariables]
[T_solid]
family = 'MONOMIAL'
order = 'CONSTANT'
fv = true
initial_condition = 100
[]
[porosity]
family = MONOMIAL
order = CONSTANT
fv = true
initial_condition = 0.5
[]
[]
[FVKernels]
inactive = 'solid_energy_diffusion solid_energy_convection'
[mass]
type = PINSFVMassAdvection
variable = pressure
advected_interp_method = ${advected_interp_method}
velocity_interp_method = ${velocity_interp_method}
rho = ${rho}
[]
[u_advection]
type = PINSFVMomentumAdvection
variable = superficial_vel_x
advected_interp_method = ${advected_interp_method}
velocity_interp_method = ${velocity_interp_method}
rho = ${rho}
porosity = porosity
momentum_component = 'x'
[]
[u_viscosity]
type = PINSFVMomentumDiffusion
variable = superficial_vel_x
mu = ${mu}
porosity = porosity
momentum_component = 'x'
[]
[u_pressure]
type = PINSFVMomentumPressure
variable = superficial_vel_x
momentum_component = 'x'
pressure = pressure
porosity = porosity
[]
[v_advection]
type = PINSFVMomentumAdvection
variable = superficial_vel_y
advected_interp_method = ${advected_interp_method}
velocity_interp_method = ${velocity_interp_method}
rho = ${rho}
porosity = porosity
momentum_component = 'y'
[]
[v_viscosity]
type = PINSFVMomentumDiffusion
variable = superficial_vel_y
mu = ${mu}
porosity = porosity
momentum_component = 'y'
[]
[v_pressure]
type = PINSFVMomentumPressure
variable = superficial_vel_y
momentum_component = 'y'
pressure = pressure
porosity = porosity
[]
[energy_advection]
type = PINSFVEnergyAdvection
variable = T_fluid
velocity_interp_method = ${velocity_interp_method}
advected_interp_method = ${advected_interp_method}
[]
[energy_diffusion]
type = PINSFVEnergyDiffusion
k = ${k}
variable = T_fluid
porosity = porosity
[]
[energy_convection]
type = PINSFVEnergyAmbientConvection
variable = T_fluid
is_solid = false
T_fluid = 'T_fluid'
T_solid = 'T_solid'
h_solid_fluid = 'h_cv'
[]
[solid_energy_diffusion]
type = FVDiffusion
coeff = ${k}
variable = T_solid
[]
[solid_energy_convection]
type = PINSFVEnergyAmbientConvection
variable = T_solid
is_solid = true
T_fluid = 'T_fluid'
T_solid = 'T_solid'
h_solid_fluid = 'h_cv'
[]
[]
[FVBCs]
inactive = 'heated-side'
[inlet-u]
type = INSFVInletVelocityBC
boundary = 'left'
variable = superficial_vel_x
function = ${u_inlet}
[]
[inlet-v]
type = INSFVInletVelocityBC
boundary = 'left'
variable = superficial_vel_y
function = 0
[]
[inlet-T]
type = FVNeumannBC
variable = T_fluid
value = '${fparse u_inlet * rho * cp * T_inlet}'
boundary = 'left'
[]
[no-slip-u]
type = INSFVNoSlipWallBC
boundary = 'top'
variable = superficial_vel_x
function = 0
[]
[no-slip-v]
type = INSFVNoSlipWallBC
boundary = 'top'
variable = superficial_vel_y
function = 0
[]
[heated-side]
type = FVDirichletBC
boundary = 'top'
variable = 'T_solid'
value = 150
[]
[symmetry-u]
type = PINSFVSymmetryVelocityBC
boundary = 'bottom'
variable = superficial_vel_x
u = superficial_vel_x
v = superficial_vel_y
mu = ${mu}
momentum_component = 'x'
[]
[symmetry-v]
type = PINSFVSymmetryVelocityBC
boundary = 'bottom'
variable = superficial_vel_y
u = superficial_vel_x
v = superficial_vel_y
mu = ${mu}
momentum_component = 'y'
[]
[symmetry-p]
type = INSFVSymmetryPressureBC
boundary = 'bottom'
variable = pressure
[]
[outlet-p]
type = INSFVOutletPressureBC
boundary = 'right'
variable = pressure
function = 0.1
[]
[]
[FunctorMaterials]
[constants]
type = ADGenericFunctorMaterial
prop_names = 'h_cv'
prop_values = '1'
[]
[functor_constants]
type = ADGenericFunctorMaterial
prop_names = 'cp'
prop_values = '${cp}'
[]
[ins_fv]
type = INSFVEnthalpyFunctorMaterial
rho = ${rho}
temperature = 'T_fluid'
[]
[]
[Executioner]
type = Steady
solve_type = 'NEWTON'
petsc_options_iname = '-pc_type -pc_factor_shift_type'
petsc_options_value = 'lu NONZERO'
nl_rel_tol = 1e-14
[]
# Some basic Postprocessors to examine the solution
[Postprocessors]
[inlet-p]
type = SideAverageValue
variable = pressure
boundary = 'left'
[]
[outlet-u]
type = SideAverageValue
variable = superficial_vel_x
boundary = 'right'
[]
[outlet-temp]
type = SideAverageValue
variable = T_fluid
boundary = 'right'
[]
[solid-temp]
type = ElementAverageValue
variable = T_solid
[]
[]
[Outputs]
exodus = true
csv = false
[]
(contrib/moose/modules/navier_stokes/test/tests/finite_volume/pins/channel-flow/heated/2d-rc-heated-action.i)
mu = 1
rho = 1
k = 1e-3
cp = 1
u_inlet = 1
T_inlet = 200
h_cv = 1.0
[Mesh]
[mesh]
type = CartesianMeshGenerator
dim = 2
dx = '5 5'
dy = '1.0'
ix = '50 50'
iy = '20'
subdomain_id = '1 2'
[]
[]
[Variables]
[T_solid]
type = MooseVariableFVReal
[]
[]
[AuxVariables]
[porosity]
type = MooseVariableFVReal
initial_condition = 0.5
[]
[]
[Modules]
[NavierStokesFV]
compressibility = 'incompressible'
porous_medium_treatment = true
add_energy_equation = true
density = ${rho}
dynamic_viscosity = ${mu}
thermal_conductivity = ${k}
specific_heat = ${cp}
porosity = 'porosity'
# Reference file sets effective_conductivity by default that way
# so the conductivity is multiplied by the porosity in the kernel
effective_conductivity = false
initial_velocity = '${u_inlet} 1e-6 0'
initial_pressure = 0.0
initial_temperature = 0.0
inlet_boundaries = 'left'
momentum_inlet_types = 'fixed-velocity'
momentum_inlet_function = '${u_inlet} 0'
energy_inlet_types = 'heatflux'
energy_inlet_function = '${fparse u_inlet * rho * cp * T_inlet}'
wall_boundaries = 'top bottom'
momentum_wall_types = 'noslip symmetry'
energy_wall_types = 'heatflux heatflux'
energy_wall_function = '0 0'
outlet_boundaries = 'right'
momentum_outlet_types = 'fixed-pressure'
pressure_function = '0.1'
ambient_convection_alpha = ${h_cv}
ambient_temperature = 'T_solid'
mass_advection_interpolation = 'average'
momentum_advection_interpolation = 'average'
energy_advection_interpolation = 'average'
[]
[]
[FVKernels]
[solid_energy_diffusion]
type = FVDiffusion
coeff = ${k}
variable = T_solid
[]
[solid_energy_convection]
type = PINSFVEnergyAmbientConvection
variable = 'T_solid'
is_solid = true
T_fluid = 'T_fluid'
T_solid = 'T_solid'
h_solid_fluid = ${h_cv}
[]
[]
[FVBCs]
[heated-side]
type = FVDirichletBC
boundary = 'top'
variable = 'T_solid'
value = 150
[]
[]
[Executioner]
type = Steady
solve_type = 'NEWTON'
petsc_options_iname = '-pc_type -pc_factor_shift_type'
petsc_options_value = 'lu NONZERO'
nl_rel_tol = 1e-14
[]
# Some basic Postprocessors to examine the solution
[Postprocessors]
[inlet-p]
type = SideAverageValue
variable = pressure
boundary = 'left'
[]
[outlet-u]
type = SideAverageValue
variable = superficial_vel_x
boundary = 'right'
[]
[outlet-temp]
type = SideAverageValue
variable = T_fluid
boundary = 'right'
[]
[solid-temp]
type = ElementAverageValue
variable = T_solid
[]
[]
[Outputs]
exodus = true
csv = false
[]
porous_medium_treatment
Default:False
C++ Type:bool
Unit:(no unit assumed)
Controllable:No
Description:Whether to use porous medium kernels or not.
porosity
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.
ambient_temperature
C++ Type:std::vector<MooseFunctorName>
Unit:(no unit assumed)
Controllable:No
Description:The ambient temperature for each block in 'ambient_convection_blocks'.
ambient_convection_alpha
C++ Type:std::vector<MooseFunctorName>
Unit:(no unit assumed)
Controllable:No
Description:The heat exchange coefficients for each block in 'ambient_convection_blocks'.
(contrib/moose/modules/navier_stokes/test/tests/finite_volume/wcns/channel-flow/2d-transient.i)
rho = 'rho'
l = 10
velocity_interp_method = 'rc'
advected_interp_method = 'average'
# Artificial fluid properties
# For a real case, use a GeneralFluidFunctorProperties and a viscosity rampdown
# or initialize very well!
k = 1
cp = 1000
mu = 1e2
# Operating conditions
inlet_temp = 300
outlet_pressure = 1e5
inlet_v = 0.001
[Mesh]
[gen]
type = GeneratedMeshGenerator
dim = 2
xmin = 0
xmax = ${l}
ymin = 0
ymax = 1
nx = 20
ny = 10
[]
[]
[GlobalParams]
rhie_chow_user_object = 'rc'
[]
[UserObjects]
[rc]
type = INSFVRhieChowInterpolator
u = vel_x
v = vel_y
pressure = pressure
[]
[]
[Variables]
[vel_x]
type = INSFVVelocityVariable
initial_condition = ${inlet_v}
[]
[vel_y]
type = INSFVVelocityVariable
initial_condition = 1e-15
[]
[pressure]
type = INSFVPressureVariable
initial_condition = ${outlet_pressure}
[]
[T_fluid]
type = INSFVEnergyVariable
initial_condition = ${inlet_temp}
[]
[]
[AuxVariables]
[mixing_length]
type = MooseVariableFVReal
[]
[power_density]
type = MooseVariableFVReal
initial_condition = 1e4
[]
[]
[FVKernels]
inactive = 'u_turb v_turb temp_turb'
[mass_time]
type = WCNSFVMassTimeDerivative
variable = pressure
drho_dt = drho_dt
[]
[mass]
type = WCNSFVMassAdvection
variable = pressure
advected_interp_method = ${advected_interp_method}
velocity_interp_method = ${velocity_interp_method}
rho = ${rho}
[]
[u_time]
type = WCNSFVMomentumTimeDerivative
variable = vel_x
drho_dt = drho_dt
rho = rho
momentum_component = 'x'
[]
[u_advection]
type = INSFVMomentumAdvection
variable = vel_x
velocity_interp_method = ${velocity_interp_method}
advected_interp_method = ${advected_interp_method}
rho = ${rho}
momentum_component = 'x'
[]
[u_viscosity]
type = INSFVMomentumDiffusion
variable = vel_x
mu = ${mu}
momentum_component = 'x'
[]
[u_pressure]
type = INSFVMomentumPressure
variable = vel_x
momentum_component = 'x'
pressure = pressure
[]
[u_turb]
type = INSFVMixingLengthReynoldsStress
variable = vel_x
rho = ${rho}
mixing_length = 'mixing_length'
momentum_component = 'x'
u = vel_x
v = vel_y
[]
[v_time]
type = WCNSFVMomentumTimeDerivative
variable = vel_y
drho_dt = drho_dt
rho = rho
momentum_component = 'y'
[]
[v_advection]
type = INSFVMomentumAdvection
variable = vel_y
velocity_interp_method = ${velocity_interp_method}
advected_interp_method = ${advected_interp_method}
rho = ${rho}
momentum_component = 'y'
[]
[v_viscosity]
type = INSFVMomentumDiffusion
variable = vel_y
momentum_component = 'y'
mu = ${mu}
[]
[v_pressure]
type = INSFVMomentumPressure
variable = vel_y
momentum_component = 'y'
pressure = pressure
[]
[v_turb]
type = INSFVMixingLengthReynoldsStress
variable = vel_y
rho = ${rho}
mixing_length = 'mixing_length'
momentum_component = 'y'
u = vel_x
v = vel_y
[]
[temp_time]
type = WCNSFVEnergyTimeDerivative
variable = T_fluid
rho = rho
drho_dt = drho_dt
h = h
dh_dt = dh_dt
[]
[temp_conduction]
type = FVDiffusion
coeff = 'k'
variable = T_fluid
[]
[temp_advection]
type = INSFVEnergyAdvection
variable = T_fluid
velocity_interp_method = ${velocity_interp_method}
advected_interp_method = ${advected_interp_method}
[]
[heat_source]
type = FVCoupledForce
variable = T_fluid
v = power_density
[]
[temp_turb]
type = WCNSFVMixingLengthEnergyDiffusion
variable = T_fluid
rho = rho
cp = cp
mixing_length = 'mixing_length'
schmidt_number = 1
u = vel_x
v = vel_y
[]
[]
[FVBCs]
[no_slip_x]
type = INSFVNoSlipWallBC
variable = vel_x
boundary = 'top bottom'
function = 0
[]
[no_slip_y]
type = INSFVNoSlipWallBC
variable = vel_y
boundary = 'top bottom'
function = 0
[]
# Inlet
[inlet_u]
type = INSFVInletVelocityBC
variable = vel_x
boundary = 'left'
function = ${inlet_v}
[]
[inlet_v]
type = INSFVInletVelocityBC
variable = vel_y
boundary = 'left'
function = 0
[]
[inlet_T]
type = FVDirichletBC
variable = T_fluid
boundary = 'left'
value = ${inlet_temp}
[]
[outlet_p]
type = INSFVOutletPressureBC
variable = pressure
boundary = 'right'
function = ${outlet_pressure}
[]
[]
[FluidProperties]
[fp]
type = FlibeFluidProperties
[]
[]
[FunctorMaterials]
[const_functor]
type = ADGenericFunctorMaterial
prop_names = 'cp k'
prop_values = '${cp} ${k}'
[]
[rho]
type = RhoFromPTFunctorMaterial
fp = fp
temperature = T_fluid
pressure = pressure
[]
[ins_fv]
type = INSFVEnthalpyFunctorMaterial
temperature = 'T_fluid'
rho = ${rho}
[]
[]
[AuxKernels]
inactive = 'mixing_len'
[mixing_len]
type = WallDistanceMixingLengthAux
walls = 'top'
variable = mixing_length
execute_on = 'initial'
delta = 0.5
[]
[]
[Executioner]
type = Transient
solve_type = 'NEWTON'
petsc_options_iname = '-pc_type -pc_factor_shift_type'
petsc_options_value = 'lu NONZERO'
[TimeStepper]
type = IterationAdaptiveDT
dt = 1e-3
optimal_iterations = 6
[]
end_time = 15
nl_abs_tol = 1e-9
nl_max_its = 50
line_search = 'none'
automatic_scaling = true
off_diagonals_in_auto_scaling = true
compute_scaling_once = false
[]
[Outputs]
exodus = true
[]
(contrib/moose/modules/navier_stokes/test/tests/finite_volume/wcns/channel-flow/2d-transient-action.i)
l = 10
# Artificial fluid properties
# For a real case, use a GeneralFluidFunctorProperties and a viscosity rampdown
# or initialize very well!
k = 1
cp = 1000
mu = 1e2
# Operating conditions
inlet_temp = 300
outlet_pressure = 1e5
inlet_v = 0.001
[Mesh]
[gen]
type = GeneratedMeshGenerator
dim = 2
xmin = 0
xmax = ${l}
ymin = 0
ymax = 1
nx = 20
ny = 10
[]
[]
[Modules]
[NavierStokesFV]
compressibility = 'weakly-compressible'
add_energy_equation = true
density = 'rho'
dynamic_viscosity = 'mu'
thermal_conductivity = 'k'
specific_heat = 'cp'
initial_velocity = '${inlet_v} 1e-15 0'
initial_temperature = '${inlet_temp}'
initial_pressure = '${outlet_pressure}'
inlet_boundaries = 'left'
momentum_inlet_types = 'fixed-velocity'
momentum_inlet_functors = '${inlet_v} 0'
energy_inlet_types = 'fixed-temperature'
energy_inlet_functors = '${inlet_temp}'
wall_boundaries = 'top bottom'
momentum_wall_types = 'noslip noslip'
energy_wall_types = 'heatflux heatflux'
energy_wall_functors = '0 0'
outlet_boundaries = 'right'
momentum_outlet_types = 'fixed-pressure'
pressure_functors = '${outlet_pressure}'
external_heat_source = 'power_density'
mass_advection_interpolation = 'average'
momentum_advection_interpolation = 'average'
energy_advection_interpolation = 'average'
[]
[]
[AuxVariables]
[power_density]
type = MooseVariableFVReal
initial_condition = 1e4
[]
[]
[FluidProperties]
[fp]
type = FlibeFluidProperties
[]
[]
[FunctorMaterials]
[const_functor]
type = ADGenericFunctorMaterial
prop_names = 'cp k mu'
prop_values = '${cp} ${k} ${mu}'
[]
[rho]
type = RhoFromPTFunctorMaterial
fp = fp
temperature = T_fluid
pressure = pressure
[]
[]
[Executioner]
type = Transient
solve_type = 'NEWTON'
petsc_options_iname = '-pc_type -pc_factor_shift_type'
petsc_options_value = 'lu NONZERO'
[TimeStepper]
type = IterationAdaptiveDT
dt = 1e-3
optimal_iterations = 6
[]
end_time = 15
nl_abs_tol = 1e-9
nl_max_its = 50
line_search = 'none'
automatic_scaling = true
off_diagonals_in_auto_scaling = true
compute_scaling_once = false
[]
[Outputs]
exodus = true
[]
compressibility
Default:incompressible
C++ Type:MooseEnum
Unit:(no unit assumed)
Options:incompressible, weakly-compressible
Controllable:No
Description:Compressibility constraint for the Navier-Stokes equations.
external_heat_source
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.
(contrib/moose/modules/navier_stokes/test/tests/finite_volume/ins/channel-flow/2d-rc-transient-physics.i)
# Fluid properties
mu = 1.1
rho = 1.1
cp = 1.1
k = 1e-3
# Operating conditions
u_inlet = 1
T_inlet = 200
T_solid = 190
p_outlet = 10
h_fs = 0.01
[Mesh]
[gen]
type = GeneratedMeshGenerator
dim = 2
xmin = 0
xmax = 5
ymin = -1
ymax = 1
nx = 50
ny = 20
[]
[]
[Physics]
[NavierStokes]
[Flow]
[flow]
compressibility = 'incompressible'
density = 'rho'
dynamic_viscosity = 'mu'
initial_velocity = '${u_inlet} 1e-12 0'
initial_pressure = 0.0
inlet_boundaries = 'left'
momentum_inlet_types = 'fixed-velocity'
momentum_inlet_function = '${u_inlet} 0'
wall_boundaries = 'bottom top'
momentum_wall_types = 'symmetry noslip'
outlet_boundaries = 'right'
momentum_outlet_types = 'fixed-pressure-zero-gradient'
pressure_function = '${p_outlet}'
mass_advection_interpolation = 'average'
momentum_advection_interpolation = 'average'
[]
[]
[]
[]
# This separation is introduced for documentation purposes.
# Both Physics could be nested under Physics/NavierStokes
[Physics/NavierStokes]
[FluidHeatTransfer]
[heat]
thermal_conductivity = 'k'
specific_heat = 'cp'
fluid_temperature_variable = 'T_fluid'
initial_temperature = '${T_inlet}'
energy_inlet_types = 'heatflux'
energy_inlet_functors = '${fparse u_inlet * rho * cp * T_inlet}'
energy_wall_types = 'heatflux heatflux'
energy_wall_functors = '0 0'
ambient_convection_alpha = 'h_cv'
ambient_temperature = 'T_solid'
energy_advection_interpolation = 'average'
[]
[]
[]
[FunctorMaterials]
[constants]
type = ADGenericFunctorMaterial
prop_names = 'h_cv T_solid rho mu cp k'
prop_values = '${h_fs} ${T_solid} ${rho} ${mu} ${cp} ${k}'
[]
[]
[Executioner]
type = Transient
solve_type = 'NEWTON'
petsc_options_iname = '-pc_type -pc_factor_shift_type'
petsc_options_value = 'lu NONZERO'
line_search = 'none'
nl_rel_tol = 7e-13
dt = 0.4
end_time = 0.8
[]
[Outputs]
exodus = true
csv = true
[]
(contrib/moose/modules/navier_stokes/test/tests/finite_volume/ins/channel-flow/2d-rc-transient-physics.i)
# Fluid properties
mu = 1.1
rho = 1.1
cp = 1.1
k = 1e-3
# Operating conditions
u_inlet = 1
T_inlet = 200
T_solid = 190
p_outlet = 10
h_fs = 0.01
[Mesh]
[gen]
type = GeneratedMeshGenerator
dim = 2
xmin = 0
xmax = 5
ymin = -1
ymax = 1
nx = 50
ny = 20
[]
[]
[Physics]
[NavierStokes]
[Flow]
[flow]
compressibility = 'incompressible'
density = 'rho'
dynamic_viscosity = 'mu'
initial_velocity = '${u_inlet} 1e-12 0'
initial_pressure = 0.0
inlet_boundaries = 'left'
momentum_inlet_types = 'fixed-velocity'
momentum_inlet_function = '${u_inlet} 0'
wall_boundaries = 'bottom top'
momentum_wall_types = 'symmetry noslip'
outlet_boundaries = 'right'
momentum_outlet_types = 'fixed-pressure-zero-gradient'
pressure_function = '${p_outlet}'
mass_advection_interpolation = 'average'
momentum_advection_interpolation = 'average'
[]
[]
[]
[]
# This separation is introduced for documentation purposes.
# Both Physics could be nested under Physics/NavierStokes
[Physics/NavierStokes]
[FluidHeatTransfer]
[heat]
thermal_conductivity = 'k'
specific_heat = 'cp'
fluid_temperature_variable = 'T_fluid'
initial_temperature = '${T_inlet}'
energy_inlet_types = 'heatflux'
energy_inlet_functors = '${fparse u_inlet * rho * cp * T_inlet}'
energy_wall_types = 'heatflux heatflux'
energy_wall_functors = '0 0'
ambient_convection_alpha = 'h_cv'
ambient_temperature = 'T_solid'
energy_advection_interpolation = 'average'
[]
[]
[]
[FunctorMaterials]
[constants]
type = ADGenericFunctorMaterial
prop_names = 'h_cv T_solid rho mu cp k'
prop_values = '${h_fs} ${T_solid} ${rho} ${mu} ${cp} ${k}'
[]
[]
[Executioner]
type = Transient
solve_type = 'NEWTON'
petsc_options_iname = '-pc_type -pc_factor_shift_type'
petsc_options_value = 'lu NONZERO'
line_search = 'none'
nl_rel_tol = 7e-13
dt = 0.4
end_time = 0.8
[]
[Outputs]
exodus = true
csv = true
[]
(contrib/moose/modules/navier_stokes/test/tests/finite_volume/ins/channel-flow/2d-scalar-transport-physics.i)
mu = 1
rho = 1
k = 1e-3
diff = 1e-3
cp = 1
[Mesh]
[gen]
type = GeneratedMeshGenerator
dim = 2
xmin = 0
xmax = 10
ymin = -1
ymax = 1
nx = 100
ny = 20
[]
[]
[Variables]
inactive = 'vel_x vel_y pressure T_fluid scalar'
[vel_x]
type = 'INSFVVelocityVariable'
initial_condition = 1
[]
[vel_y]
type = 'INSFVVelocityVariable'
initial_condition = 1
[]
[pressure]
type = 'INSFVPressureVariable'
initial_condition = 0
[]
[T_fluid]
type = 'INSFVEnergyVariable'
initial_condition = 0
[]
[scalar]
type = MooseVariableFVReal
initial_condition = 0
[]
[]
[Physics]
[NavierStokes]
[Flow]
[flow]
compressibility = 'incompressible'
density = ${rho}
dynamic_viscosity = ${mu}
inlet_boundaries = 'left'
momentum_inlet_types = 'fixed-velocity'
momentum_inlet_function = '1 0'
wall_boundaries = 'top bottom'
momentum_wall_types = 'noslip noslip'
outlet_boundaries = 'right'
momentum_outlet_types = 'fixed-pressure'
pressure_function = '0'
mass_advection_interpolation = 'average'
momentum_advection_interpolation = 'average'
[]
[]
[FluidHeatTransfer]
[heat]
thermal_conductivity = ${k}
specific_heat = ${cp}
energy_inlet_types = 'fixed-temperature'
energy_inlet_function = '1'
energy_wall_types = 'heatflux heatflux'
energy_wall_function = '0 0'
energy_advection_interpolation = 'average'
[]
[]
[]
[]
# This separation is introduced for documentation purposes.
# Both could be nested under Physics/NavierStokes
[Physics/NavierStokes]
[ScalarTransport]
[heat]
passive_scalar_names = 'scalar'
passive_scalar_diffusivity = ${diff}
passive_scalar_source = 0.1
passive_scalar_coupled_source = U
passive_scalar_coupled_source_coeff = 0.1
passive_scalar_inlet_types = 'fixed-value'
passive_scalar_inlet_function = '1'
passive_scalar_advection_interpolation = 'average'
[]
[]
[]
[AuxVariables]
[U]
order = CONSTANT
family = MONOMIAL
fv = true
[]
[]
[AuxKernels]
[mag]
type = VectorMagnitudeAux
variable = U
x = vel_x
y = vel_y
[]
[]
[Executioner]
type = Steady
solve_type = 'NEWTON'
petsc_options_iname = '-pc_type -pc_factor_shift_type'
petsc_options_value = 'lu NONZERO'
nl_rel_tol = 1e-12
[]
[Outputs]
exodus = true
csv = true
[]
(contrib/moose/modules/navier_stokes/test/tests/finite_volume/ins/channel-flow/2d-mixing-length-physics.i)
Re = 1e4
von_karman_const = 0.2
D = 1
rho = 1
bulk_u = 1
mu = '${fparse rho * bulk_u * D / Re}'
advected_interp_method = 'upwind'
[Mesh]
[gen]
type = GeneratedMeshGenerator
dim = 2
xmin = 0
xmax = 5
ymin = 0
ymax = '${fparse 0.5 * D}'
nx = 20
ny = 10
bias_y = '${fparse 1 / 1.2}'
[]
[]
[Physics]
[NavierStokes]
[Flow]
[flow]
compressibility = 'incompressible'
density = ${rho}
dynamic_viscosity = ${mu}
initial_velocity = '1 1 0'
initial_pressure = 0.0
inlet_boundaries = 'left'
momentum_inlet_types = 'fixed-velocity'
momentum_inlet_function = '1 0'
wall_boundaries = 'top bottom'
momentum_wall_types = 'noslip symmetry'
outlet_boundaries = 'right'
momentum_outlet_types = 'fixed-pressure'
pressure_function = '0'
momentum_advection_interpolation = ${advected_interp_method}
mass_advection_interpolation = ${advected_interp_method}
[]
[]
[ScalarTransport]
[scalars]
add_scalar_equation = true
passive_scalar_names = 'scalar'
passive_scalar_source = 0.1
passive_scalar_inlet_types = 'fixed-value'
passive_scalar_inlet_function = '1'
passive_scalar_advection_interpolation = ${advected_interp_method}
[]
[]
[]
[]
# This separation is introduced for documentation purposes.
# Both could be nested under Physics/NavierStokes
[Physics/NavierStokes]
[Turbulence]
[mixing-length]
turbulence_handling = 'mixing-length'
coupled_flow_physics = flow
scalar_transport_physics = scalars
passive_scalar_schmidt_number = 1.0
von_karman_const = ${von_karman_const}
mixing_length_delta = 1e9
mixing_length_walls = 'top bottom'
mixing_length_aux_execute_on = 'initial'
[]
[]
[]
[Executioner]
type = Steady
solve_type = 'NEWTON'
petsc_options_iname = '-pc_type -pc_factor_shift_type'
petsc_options_value = 'lu NONZERO'
nl_rel_tol = 1e-12
[]
[Outputs]
exodus = true
[]
dump_path
Default:all
C++ Type:std::string
Unit:(no unit assumed)
Controllable:No
Description:Syntax path of the action of which to dump the generated syntax