This is the base class all materials should use if you are trying to use the Navier-Stokes Kernels.
More...
#include <NavierStokesMaterial.h>
This is the base class all materials should use if you are trying to use the Navier-Stokes Kernels.
Note that the derived class just needs to compute dynamic_viscocity then call this class's computeProperties() function.
Also make sure that the derived class's validParams function just adds to this class's validParams.
Finally, note that this Material isn't registered with the MaterialFactory. The reason is that by itself this material doesn't work! You must derive from this material and compute dynamic_viscocity!
Definition at line 36 of file NavierStokesMaterial.h.
◆ NavierStokesMaterial()
NavierStokesMaterial::NavierStokesMaterial |
( |
const InputParameters & |
parameters | ) |
|
Definition at line 49 of file NavierStokesMaterial.C.
50 : Material(parameters),
64 _calA(declareProperty<std::vector<RealTensorValue>>(
"calA")),
67 _calC(declareProperty<std::vector<RealTensorValue>>(
"calC")),
70 _calE(declareProperty<std::vector<std::vector<RealTensorValue>>>(
"calE")),
103 _hsupg(declareProperty<Real>(
"hsupg")),
104 _tauc(declareProperty<Real>(
"tauc")),
105 _taum(declareProperty<Real>(
"taum")),
106 _taue(declareProperty<Real>(
"taue")),
◆ computeHSUPG()
void NavierStokesMaterial::computeHSUPG |
( |
unsigned int |
qp | ) |
|
|
private |
◆ computeProperties()
void NavierStokesMaterial::computeProperties |
( |
| ) |
|
|
protectedvirtual |
Must be called after the child class computes dynamic_viscocity.
Must be called after the child class computes dynamic_viscosity.
Reimplemented in Air.
Definition at line 116 of file NavierStokesMaterial.C.
118 for (
unsigned int qp = 0; qp < _qrule->n_points(); ++qp)
125 grad_outer_u += grad_outer_u.transpose();
128 for (
unsigned int i = 0; i < 3; ++i)
132 for (
unsigned int i = 0; i < 3; ++i)
133 grad_outer_u(i, i) -= 2.0 / 3.0 * div_vel;
153 const Real Pr = 0.71;
Referenced by Air::computeProperties().
◆ computeStrongResiduals()
void NavierStokesMaterial::computeStrongResiduals |
( |
unsigned int |
qp | ) |
|
|
private |
◆ computeTau()
void NavierStokesMaterial::computeTau |
( |
unsigned int |
qp | ) |
|
|
private |
◆ _calA
MaterialProperty<std::vector<RealTensorValue> >& NavierStokesMaterial::_calA |
|
protected |
◆ _calC
MaterialProperty<std::vector<RealTensorValue> >& NavierStokesMaterial::_calC |
|
protected |
◆ _calE
MaterialProperty<std::vector<std::vector<RealTensorValue> > >& NavierStokesMaterial::_calE |
|
protected |
◆ _drho_dt
const VariableValue& NavierStokesMaterial::_drho_dt |
|
protected |
◆ _drhoE_dt
const VariableValue& NavierStokesMaterial::_drhoE_dt |
|
protected |
◆ _drhou_dt
const VariableValue& NavierStokesMaterial::_drhou_dt |
|
protected |
◆ _drhov_dt
const VariableValue& NavierStokesMaterial::_drhov_dt |
|
protected |
◆ _drhow_dt
const VariableValue& NavierStokesMaterial::_drhow_dt |
|
protected |
◆ _dynamic_viscosity
MaterialProperty<Real>& NavierStokesMaterial::_dynamic_viscosity |
|
protected |
◆ _enthalpy
const VariableValue& NavierStokesMaterial::_enthalpy |
|
protected |
◆ _fp
◆ _grad_rho
const VariableGradient& NavierStokesMaterial::_grad_rho |
|
protected |
◆ _grad_rho_E
const VariableGradient& NavierStokesMaterial::_grad_rho_E |
|
protected |
◆ _grad_rho_u
const VariableGradient& NavierStokesMaterial::_grad_rho_u |
|
protected |
◆ _grad_rho_v
const VariableGradient& NavierStokesMaterial::_grad_rho_v |
|
protected |
◆ _grad_rho_w
const VariableGradient& NavierStokesMaterial::_grad_rho_w |
|
protected |
◆ _grad_u
const VariableGradient& NavierStokesMaterial::_grad_u |
|
protected |
◆ _grad_v
const VariableGradient& NavierStokesMaterial::_grad_v |
|
protected |
◆ _grad_w
const VariableGradient& NavierStokesMaterial::_grad_w |
|
protected |
◆ _hsupg
MaterialProperty<Real>& NavierStokesMaterial::_hsupg |
|
protected |
◆ _mesh_dimension
const unsigned int NavierStokesMaterial::_mesh_dimension |
|
protected |
◆ _rho
const VariableValue& NavierStokesMaterial::_rho |
|
protected |
◆ _rho_E
const VariableValue& NavierStokesMaterial::_rho_E |
|
protected |
◆ _rho_u
const VariableValue& NavierStokesMaterial::_rho_u |
|
protected |
◆ _rho_v
const VariableValue& NavierStokesMaterial::_rho_v |
|
protected |
◆ _rho_w
const VariableValue& NavierStokesMaterial::_rho_w |
|
protected |
◆ _strong_residuals
MaterialProperty<std::vector<Real> >& NavierStokesMaterial::_strong_residuals |
|
protected |
◆ _tauc
MaterialProperty<Real>& NavierStokesMaterial::_tauc |
|
protected |
◆ _taue
MaterialProperty<Real>& NavierStokesMaterial::_taue |
|
protected |
◆ _taum
MaterialProperty<Real>& NavierStokesMaterial::_taum |
|
protected |
◆ _temperature
const VariableValue& NavierStokesMaterial::_temperature |
|
protected |
◆ _thermal_conductivity
MaterialProperty<Real>& NavierStokesMaterial::_thermal_conductivity |
|
protected |
◆ _u_vel
const VariableValue& NavierStokesMaterial::_u_vel |
|
protected |
◆ _v_vel
const VariableValue& NavierStokesMaterial::_v_vel |
|
protected |
◆ _vel_grads
std::vector<const VariableGradient *> NavierStokesMaterial::_vel_grads |
|
protected |
◆ _viscous_stress_tensor
MaterialProperty<RealTensorValue>& NavierStokesMaterial::_viscous_stress_tensor |
|
protected |
◆ _w_vel
const VariableValue& NavierStokesMaterial::_w_vel |
|
protected |
The documentation for this class was generated from the following files:
const std::string velocity_x
const VariableValue & _drhoE_dt
const VariableValue & _w_vel
const unsigned int _mesh_dimension
const VariableGradient & _grad_rho_v
MaterialProperty< RealTensorValue > & _viscous_stress_tensor
const VariableValue & _enthalpy
Ideal gas fluid properties Default parameters are for air at atmospheric pressure and temperature.
const std::string velocity_y
void computeHSUPG(unsigned int qp)
const VariableValue & _rho_E
const VariableValue & _rho_u
const VariableValue & _u_vel
const std::string velocity_z
const VariableValue & _rho_w
const std::string momentum_y
std::vector< const VariableGradient * > _vel_grads
MaterialProperty< Real > & _thermal_conductivity
const VariableGradient & _grad_u
MaterialProperty< std::vector< RealTensorValue > > & _calC
MaterialProperty< std::vector< std::vector< RealTensorValue > > > & _calE
MaterialProperty< Real > & _tauc
MaterialProperty< std::vector< RealTensorValue > > & _calA
const VariableGradient & _grad_rho_w
const VariableValue & _temperature
const VariableValue & _drhou_dt
const VariableValue & _v_vel
const std::string density
const std::string enthalpy
const VariableValue & _rho
const std::string momentum_z
const VariableValue & _drho_dt
const std::string momentum_x
const VariableGradient & _grad_rho
const VariableGradient & _grad_rho_E
MaterialProperty< Real > & _taum
const VariableGradient & _grad_v
MaterialProperty< Real > & _dynamic_viscosity
const VariableValue & _drhov_dt
const VariableValue & _drhow_dt
void computeTau(unsigned int qp)
const VariableGradient & _grad_rho_u
const std::string temperature
const VariableValue & _rho_v
MaterialProperty< Real > & _hsupg
const IdealGasFluidProperties & _fp
MaterialProperty< std::vector< Real > > & _strong_residuals
void computeStrongResiduals(unsigned int qp)
const std::string total_energy
MaterialProperty< Real > & _taue
const VariableGradient & _grad_w