30 "fluid_heat_transfer_physics",
32 "WCNSLinearFVFluidHeatTransferPhysics generating the fluid energy equation");
34 params.addParamNamesToGroup(
"fluid_heat_transfer_physics",
"Phase change");
35 params.addClassDescription(
"Define the additional terms for a mixture model for the two phase " 36 "weakly-compressible Navier Stokes equations using the linearized " 37 "segregated finite volume discretization");
40 params.addParam<
bool>(
"add_gravity_term_in_slip_velocity",
42 "Whether to add the gravity term in the slip velocity vector computation");
49 _add_phase_equation(_has_scalar_equation),
50 _phase_1_fraction_name(getParam<MooseFunctorName>(
"phase_1_fraction_name")),
51 _phase_2_fraction_name(_passive_scalar_names[0]),
52 _phase_1_density(getParam<MooseFunctorName>(
"phase_1_density_name")),
53 _phase_1_viscosity(getParam<MooseFunctorName>(
"phase_1_viscosity_name")),
54 _phase_1_specific_heat(getParam<MooseFunctorName>(
"phase_1_specific_heat_name")),
55 _phase_1_thermal_conductivity(getParam<MooseFunctorName>(
"phase_1_thermal_conductivity_name")),
56 _phase_2_density(getParam<MooseFunctorName>(
"phase_2_density_name")),
57 _phase_2_viscosity(getParam<MooseFunctorName>(
"phase_2_viscosity_name")),
58 _phase_2_specific_heat(getParam<MooseFunctorName>(
"phase_2_specific_heat_name")),
59 _phase_2_thermal_conductivity(getParam<MooseFunctorName>(
"phase_2_thermal_conductivity_name")),
60 _use_external_mixture_properties(getParam<bool>(
"use_external_mixture_properties")),
61 _use_drift_flux(getParam<bool>(
"add_drift_flux_momentum_terms")),
62 _use_advection_slip(getParam<bool>(
"add_advection_slip_term"))
66 paramError(
"phase_fraction_name",
"Only one phase fraction currently supported.");
68 paramError(
"phase_fraction_inlet_functors",
"Only one phase fraction currently supported");
74 getParam<PhysicsName>(
"fluid_heat_transfer_physics"),
true);
77 !getCoupledPhysics<const WCNSLinearFVFluidHeatTransferPhysics>(
true).empty())
79 "fluid_heat_transfer_physics",
80 "We currently do not support creating both a phase transport equation and fluid heat " 81 "transfer physics that are not coupled together");
100 mooseError(
"Specific heat name for Physics '",
102 "' should be 'cp_mixture'");
108 "' should be 'rho_mixture'");
120 if (
isParamSetByUser(
"alpha_exchange") && getParam<bool>(
"add_phase_change_energy_term"))
122 "A phase exchange coefficient cannot be specified if the phase change is handled " 123 "with a phase change heat loss model");
126 "First phase fraction name should be different from second phase fraction name");
129 "Drift flux model cannot be used at the same time as the advection slip model");
130 if (!getParam<bool>(
"add_drift_flux_momentum_terms"))
132 if (!getParam<bool>(
"use_dispersed_phase_drag_model"))
145 const auto tol = 1e-2;
146 if (
_problem->mesh().allFaceInfo().empty())
147 _problem->mesh().setupFiniteVolumeMeshData();
148 for (
const auto & fi :
_problem->mesh().allFaceInfo())
150 if (fi.skewnessCorrectionVector().norm() >
tol * fi.dCNMag())
153 " requires skewness correction. We currently do not support mixture flow with " 154 "buoyancy and mesh skewness. Please contact a MOOSE or Navier Stokes module " 155 "developer if you require this.");
169 getParam<bool>(
"add_phase_change_energy_term"))
181 params.
set<MooseFunctorName>(
"u_slip") =
"vel_slip_x";
183 params.
set<MooseFunctorName>(
"v_slip") =
"vel_slip_y";
185 params.
set<MooseFunctorName>(
"w_slip") =
"vel_slip_z";
196 params.set<MooseFunctorName>(
"coeff") = getParam<MooseFunctorName>(
NS::alpha_exchange);
198 "LinearFVReaction",
prefix() +
"phase_interface_reaction", params);
205 params.set<MooseFunctorName>(
"scaling_factor") = getParam<MooseFunctorName>(
NS::alpha_exchange);
213 mooseError(
"Phase change energy source not implemented at this time for linear finite volume");
219 const std::vector<std::string> components = {
"x",
"y",
"z"};
222 const auto object_type =
"LinearWCNSFV2PMomentumDriftFlux";
229 params.set<
MooseEnum>(
"momentum_component") = components[
dim];
230 params.set<
MooseEnum>(
"density_interp_method") = getParam<MooseEnum>(
"density_interp_method");
239 mooseError(
"Phase advection slip not implemented at this time for linear finite volume");
254 params.set<std::vector<OutputName>>(
"outputs") = {
"all"};
260 paramError(
"Phase 2 fraction should be defined as a variable or auxiliary variable");
270 params.set<std::vector<OutputName>>(
"outputs") = {
"all"};
279 params.set<std::vector<MooseFunctorName>>(
"prop_names") = {
280 "rho_mixture",
"mu_mixture",
"cp_mixture",
"k_mixture"};
284 params.set<std::vector<MooseFunctorName>>(
"phase_2_names") = {
_phase_1_density,
288 params.set<std::vector<MooseFunctorName>>(
"phase_1_names") = {
_phase_2_density,
293 if (getParam<bool>(
"output_all_properties"))
294 params.set<std::vector<OutputName>>(
"outputs") = {
"all"};
295 params.set<
bool>(
"limit_phase_fraction") =
true;
297 "WCNSLinearFVMixtureFunctorMaterial",
prefix() +
"mixture_material", params);
304 const std::vector<std::string> vel_components = {
"u",
"v",
"w"};
305 const std::vector<std::string> components = {
"x",
"y",
"z"};
310 params.set<MooseFunctorName>(
"slip_velocity_name") =
"vel_slip_" + components[
dim];
311 params.set<
MooseEnum>(
"momentum_component") = components[
dim];
313 params.set<std::vector<VariableName>>(vel_components[
j]) = {
316 params.set<MooseFunctorName>(
NS::mu) =
"mu_mixture";
318 if (getParam<bool>(
"add_gravity_term_in_slip_velocity"))
321 params.set<MooseFunctorName>(
"linear_coef_name") =
322 getParam<MooseFunctorName>(
"slip_linear_friction_name");
323 else if (getParam<bool>(
"use_dispersed_phase_drag_model"))
324 params.set<MooseFunctorName>(
"linear_coef_name") =
"Darcy_coefficient";
328 params.set<MooseFunctorName>(
"linear_coef_name") =
331 params.set<MooseFunctorName>(
"linear_coef_name") =
"0";
335 "WCNSFV2PSlipVelocityFunctorMaterial created by this Physics required a scalar " 336 "field linear friction factor.");
337 params.set<MooseFunctorName>(
"particle_diameter") =
338 getParam<MooseFunctorName>(
"particle_diameter");
339 if (getParam<bool>(
"output_all_properties"))
342 params.set<std::vector<OutputName>>(
"outputs") = {
"all"};
345 "Slip velocity functor material output currently unsupported in Physics " 346 "in transient conditions.");
349 "WCNSFV2PSlipVelocityFunctorMaterial",
prefix() +
"slip_" + components[
dim], params);
354 if (getParam<bool>(
"use_dispersed_phase_drag_model"))
356 const std::vector<std::string> vel_components = {
"u",
"v",
"w"};
360 params.set<MooseFunctorName>(
"drag_coef_name") =
"Darcy_coefficient";
362 params.set<MooseFunctorName>(vel_components[
j]) = {
364 params.set<MooseFunctorName>(
NS::density) =
"rho_mixture";
365 params.set<MooseFunctorName>(
NS::mu) =
"mu_mixture";
366 params.set<MooseFunctorName>(
"particle_diameter") =
367 getParam<MooseFunctorName>(
"particle_diameter");
368 if (getParam<bool>(
"output_all_properties"))
369 params.set<std::vector<OutputName>>(
"outputs") = {
"all"};
371 "NSFVDispersePhaseDragFunctorMaterial",
prefix() +
"dispersed_drag", params);
std::string prefix() const
static InputParameters validParams()
bool hasFlowEquations() const
Whether the physics is actually creating the flow equations.
const std::vector< std::string > & getVelocityNames() const
To interface with other Physics.
void assignBlocks(InputParameters ¶ms, const std::vector< SubdomainName > &blocks) const
auto norm() const -> decltype(std::norm(Real()))
registerMooseAction("NavierStokesApp", WCNSLinearFVTwoPhaseMixturePhysics, "add_material")
void addAdvectionSlipTerm()
const bool _use_advection_slip
Whether to add the advection slip term to each component of the momentum equation.
virtual void addMaterial(const std::string &material_name, const std::string &name, InputParameters ¶meters)
const MooseFunctorName _phase_1_thermal_conductivity
Name of the thermal conductivity of the first phase.
const MooseFunctorName _phase_1_specific_heat
Name of the specific heat of the first phase.
void addPhaseDriftFluxTerm()
static const std::string density
InputParameters getValidParams(const std::string &name) const
void mooseInfoRepeated(Args &&... args)
const bool _add_phase_equation
Convenience boolean to keep track of whether the phase transport equation is requested.
Creates all the objects needed to solve the Navier Stokes scalar transport equations using the linear...
std::vector< NonlinearVariableName > _passive_scalar_names
Names of the passive scalar variables.
virtual MooseFunctorName getLinearFrictionCoefName() const =0
Get the name of the linear friction coefficient. Returns an empty string if no friction.
virtual const std::string & name() const
std::vector< SubdomainName > _blocks
unsigned int dimension() const
registerWCNSFVScalarTransportBaseTasks("NavierStokesApp", WCNSLinearFVTwoPhaseMixturePhysics)
const MooseFunctorName & densityName() const
Return the name of the density functor.
void addPhaseChangeEnergySource()
const MooseFunctorName _phase_2_thermal_conductivity
Name of the thermal conductivity of the other phase.
const MooseFunctorName _phase_1_fraction_name
Name of the first phase fraction (usually, liquid)
bool _has_energy_equation
Convenience boolean to keep track of whether the fluid energy equation is present.
bool isParamValid(const std::string &name) const
std::vector< std::vector< MooseFunctorName > > _passive_scalar_inlet_functors
Functors describing the inlet boundary values. See passive_scalar_inlet_types for what the functors a...
const MooseFunctorName _phase_1_density
Name of the density of the first phase.
virtual FEProblemBase & getProblem()
WCNSLinearFVTwoPhaseMixturePhysics(const InputParameters ¶meters)
const MooseFunctorName _phase_2_fraction_name
Name of the second phase fraction (usually, dispersed or advected by the liquid)
virtual UserObjectName rhieChowUOName() const =0
Return the name of the Rhie Chow user object.
void addPhaseInterfaceTerm()
Functions adding kernels for the other physics.
const MooseFunctorName & getSpecificHeatName() const
Get the name of the specific heat material property.
RealVectorValue gravityVector() const
Return the gravity vector.
bool hasEnergyEquation() const
Whether the physics is actually creating the heat equation.
static const std::string mu
static InputParameters commonMixtureParams()
const bool _use_drift_flux
Whether to add the drift flux momentum terms to each component momentum equation. ...
const MooseFunctorName _phase_2_viscosity
Name of the dynamic viscosity of the other phase.
virtual void addFVKernels() override
void paramError(const std::string ¶m, Args... args) const
static const std::string alpha_exchange
const MooseFunctorName _phase_1_viscosity
Name of the dynamic viscosity of the first phase.
const WCNSLinearFVFluidHeatTransferPhysics * _fluid_energy_physics
Fluid heat transfer physics.
virtual void addLinearFVKernel(const std::string &kernel_name, const std::string &name, InputParameters ¶meters)
bool isParamSetByUser(const std::string &nm) const
static InputParameters validParams()
static void renamePassiveScalarToMixtureParams(InputParameters ¶ms)
const bool _use_external_mixture_properties
Whether to define the mixture model internally or use fluid properties instead.
Creates all the objects needed to solve the mixture model for the weakly-compressible and incompressi...
const MooseFunctorName _phase_2_specific_heat
Name of the specific heat of the other phase.
IntRange< T > make_range(T beg, T end)
registerNavierStokesPhysicsBaseTasks("NavierStokesApp", WCNSLinearFVTwoPhaseMixturePhysics)
void mooseError(Args &&... args) const
virtual void setSlipVelocityParams(InputParameters ¶ms) const override
Adds the slip velocity parameters.
std::shared_ptr< FEProblemBase > & _problem
static const std::complex< double > j(0, 1)
Complex number "j" (also known as "i")
const MooseFunctorName & densityName() const
virtual void addFVKernels() override
void paramInfo(const std::string ¶m, Args... args) const
virtual void addMaterials() override
const WCNSFVFlowPhysicsBase * _flow_equations_physics
Flow physics.
const MooseFunctorName _phase_2_density
Name of the density of the other phase.
virtual void checkIntegrity() const override