https://mooseframework.inl.gov
Public Member Functions | Static Public Member Functions | Protected Member Functions | Protected Attributes | List of all members
NavierStokesLHDGAssemblyHelper Class Reference

Implements all the methods for assembling a hybridized local discontinuous Galerkin (LDG-H), which is a type of HDG method, discretization of the incompressible Navier-Stokes equations. More...

#include <NavierStokesLHDGAssemblyHelper.h>

Inheritance diagram for NavierStokesLHDGAssemblyHelper:
[legend]

Public Member Functions

 NavierStokesLHDGAssemblyHelper (const MooseObject *moose_obj, MaterialPropertyInterface *mpi, MooseVariableDependencyInterface *mvdi, const TransientInterface *const ti, const FEProblemBase &fe_problem, SystemBase &sys, const MooseMesh &mesh, const THREAD_ID tid)
 
void checkCoupling ()
 

Static Public Member Functions

static InputParameters validParams ()
 
static std::string deduceFunctorName (const std::string &name, const InputParameters &params)
 

Protected Member Functions

RealVectorValue rhoVelCrossVelResidual (const MooseArray< Number > &u_sol, const MooseArray< Number > &v_sol, const unsigned int qp, const unsigned int vel_component)
 
RealVectorValue rhoVelCrossVelJacobian (const MooseArray< Number > &u_sol, const MooseArray< Number > &v_sol, const unsigned int qp, const unsigned int vel_component, const unsigned int vel_j_component, const MooseArray< std::vector< Real >> &phi, const unsigned int j)
 
void scalarVolumeResidual (const MooseArray< Gradient > &vel_gradient, const unsigned int vel_component, const Moose::Functor< Real > &body_force, const MooseArray< Real > &JxW, const libMesh::QBase &qrule, const Elem *const current_elem, const MooseArray< Point > &q_point, DenseVector< Number > &scalar_re)
 Compute the volumetric contributions to a velocity residual for a provided velocity gradient and stress. More...
 
void scalarVolumeJacobian (const unsigned int vel_component, const MooseArray< Real > &JxW, const libMesh::QBase &qrule, DenseMatrix< Number > &scalar_vector_jac, DenseMatrix< Number > &scalar_u_vel_jac, DenseMatrix< Number > &scalar_v_vel_jac, DenseMatrix< Number > &scalar_p_jac)
 Compute the volumetric contributions to a velocity Jacobian. More...
 
void pressureVolumeResidual (const Moose::Functor< Real > &pressure_mms_forcing_function, const MooseArray< Real > &JxW, const libMesh::QBase &qrule, const Elem *const current_elem, const MooseArray< Point > &q_point, DenseVector< Number > &pressure_re, DenseVector< Number > &global_lm_re)
 Compute the volumetric contributions to the pressure residual, e.g. More...
 
void pressureVolumeJacobian (const MooseArray< Real > &JxW, const libMesh::QBase &qrule, DenseMatrix< Number > &p_u_vel_jac, DenseMatrix< Number > &p_v_vel_jac, DenseMatrix< Number > &p_global_lm_jac, DenseMatrix< Number > &global_lm_p_jac)
 Compute the volumetric contributions to the pressure Jacobian, e.g. More...
 
void pressureFaceResidual (const MooseArray< Real > &JxW_face, const libMesh::QBase &qrule_face, const MooseArray< Point > &normals, DenseVector< Number > &pressure_re)
 
void pressureFaceJacobian (const MooseArray< Real > &JxW_face, const libMesh::QBase &qrule_face, const MooseArray< Point > &normals, DenseMatrix< Number > &p_lm_u_vel_jac, DenseMatrix< Number > &p_lm_v_vel_jac)
 
void scalarFaceResidual (const MooseArray< Gradient > &vector_sol, const MooseArray< Number > &scalar_sol, const MooseArray< Number > &lm_sol, const unsigned int vel_component, const MooseArray< Real > &JxW_face, const libMesh::QBase &qrule_face, const MooseArray< Point > &normals, DenseVector< Number > &scalar_re)
 
void scalarFaceJacobian (const unsigned int vel_component, const MooseArray< Real > &JxW_face, const libMesh::QBase &qrule_face, const MooseArray< Point > &normals, DenseMatrix< Number > &scalar_vector_jac, DenseMatrix< Number > &scalar_scalar_jac, DenseMatrix< Number > &scalar_lm_jac, DenseMatrix< Number > &scalar_p_jac, DenseMatrix< Number > &scalar_lm_u_vel_jac, DenseMatrix< Number > &scalar_lm_v_vel_jac)
 
void lmFaceResidual (const MooseArray< Gradient > &vector_sol, const MooseArray< Number > &scalar_sol, const MooseArray< Number > &lm_sol, const unsigned int vel_component, const MooseArray< Real > &JxW_face, const libMesh::QBase &qrule_face, const MooseArray< Point > &normals, const Elem *const neigh, DenseVector< Number > &lm_re)
 
void lmFaceJacobian (const unsigned int vel_component, const MooseArray< Real > &JxW_face, const libMesh::QBase &qrule_face, const MooseArray< Point > &normals, const Elem *const neigh, DenseMatrix< Number > &lm_vec_jac, DenseMatrix< Number > &lm_scalar_jac, DenseMatrix< Number > &lm_lm_jac, DenseMatrix< Number > &lm_p_jac, DenseMatrix< Number > &lm_lm_u_vel_jac, DenseMatrix< Number > &lm_lm_v_vel_jac)
 
void pressureDirichletResidual (const std::array< const Moose::Functor< Real > *, 3 > &dirichlet_vel, const MooseArray< Real > &JxW_face, const libMesh::QBase &qrule_face, const MooseArray< Point > &normals, const Elem *const current_elem, const unsigned int current_side, const MooseArray< Point > &q_point_face, DenseVector< Number > &pressure_re)
 
void scalarDirichletResidual (const MooseArray< Gradient > &vector_sol, const MooseArray< Number > &scalar_sol, const unsigned int vel_component, const std::array< const Moose::Functor< Real > *, 3 > &dirichlet_vel, const MooseArray< Real > &JxW_face, const libMesh::QBase &qrule_face, const MooseArray< Point > &normals, const Elem *const current_elem, const unsigned int current_side, const MooseArray< Point > &q_point_face, DenseVector< Number > &scalar_re)
 
void scalarDirichletJacobian (const unsigned int vel_component, const MooseArray< Real > &JxW_face, const libMesh::QBase &qrule_face, const MooseArray< Point > &normals, DenseMatrix< Number > &scalar_vector_jac, DenseMatrix< Number > &scalar_scalar_jac, DenseMatrix< Number > &scalar_pressure_jac)
 
std::string deduceFunctorName (const std::string &name) const
 
void vectorVolumeResidual (const MooseArray< Gradient > &vector_sol, const MooseArray< Number > &scalar_sol, const MooseArray< Real > &JxW, const libMesh::QBase &qrule, DenseVector< Number > &vector_re)
 
void vectorVolumeJacobian (const MooseArray< Real > &JxW, const libMesh::QBase &qrule, DenseMatrix< Number > &vector_vector_jac, DenseMatrix< Number > &vector_scalar_jac)
 
void scalarVolumeResidual (const MooseArray< Gradient > &vector_field, const Moose::Functor< Real > &source, const MooseArray< Real > &JxW, const libMesh::QBase &qrule, const Elem *const current_elem, const MooseArray< Point > &q_point, DenseVector< Number > &scalar_re)
 
void scalarVolumeJacobian (const MooseArray< Real > &JxW, const libMesh::QBase &qrule, DenseMatrix< Number > &scalar_vector_jac)
 
void vectorFaceResidual (const MooseArray< Number > &lm_sol, const MooseArray< Real > &JxW_face, const libMesh::QBase &qrule_face, const MooseArray< Point > &normals, DenseVector< Number > &vector_re)
 
void vectorFaceJacobian (const MooseArray< Real > &JxW_face, const libMesh::QBase &qrule_face, const MooseArray< Point > &normals, DenseMatrix< Number > &vector_lm_jac)
 
void scalarFaceResidual (const MooseArray< Gradient > &vector_sol, const MooseArray< Number > &scalar_sol, const MooseArray< Number > &lm_sol, const MooseArray< Real > &JxW_face, const libMesh::QBase &qrule_face, const MooseArray< Point > &normals, DenseVector< Number > &scalar_re)
 
void scalarFaceJacobian (const MooseArray< Real > &JxW_face, const libMesh::QBase &qrule_face, const MooseArray< Point > &normals, DenseMatrix< Number > &scalar_vector_jac, DenseMatrix< Number > &scalar_scalar_jac, DenseMatrix< Number > &scalar_lm_jac)
 
void lmFaceResidual (const MooseArray< Gradient > &vector_sol, const MooseArray< Number > &scalar_sol, const MooseArray< Number > &lm_sol, const MooseArray< Real > &JxW_face, const libMesh::QBase &qrule_face, const MooseArray< Point > &normals, DenseVector< Number > &lm_re)
 
void lmFaceJacobian (const MooseArray< Real > &JxW_face, const libMesh::QBase &qrule_face, const MooseArray< Point > &normals, DenseMatrix< Number > &lm_vec_jac, DenseMatrix< Number > &lm_scalar_jac, DenseMatrix< Number > &lm_lm_jac)
 
void vectorDirichletResidual (const Moose::Functor< Real > &dirichlet_value, const MooseArray< Real > &JxW_face, const libMesh::QBase &qrule_face, const MooseArray< Point > &normals, const Elem *const current_elem, const unsigned int current_side, const MooseArray< Point > &q_point_face, DenseVector< Number > &vector_re)
 
void scalarDirichletResidual (const MooseArray< Gradient > &vector_sol, const MooseArray< Number > &scalar_sol, const Moose::Functor< Real > &dirichlet_value, const MooseArray< Real > &JxW_face, const libMesh::QBase &qrule_face, const MooseArray< Point > &normals, const Elem *const current_elem, const unsigned int current_side, const MooseArray< Point > &q_point_face, DenseVector< Number > &scalar_re)
 
void scalarDirichletJacobian (const MooseArray< Real > &JxW_face, const libMesh::QBase &qrule_face, const MooseArray< Point > &normals, DenseMatrix< Number > &scalar_vector_jac, DenseMatrix< Number > &scalar_scalar_jac)
 
void createIdentityResidual (const MooseArray< Real > &JxW, const libMesh::QBase &qrule, const MooseArray< std::vector< Real >> &phi, const MooseArray< Number > &sol, DenseVector< Number > &re)
 
void createIdentityJacobian (const MooseArray< Real > &JxW, const libMesh::QBase &qrule, const MooseArray< std::vector< Real >> &phi, DenseMatrix< Number > &ke)
 
const Moose::Functor< T > & getFunctor (const std::string &name)
 
const Moose::Functor< T > & getFunctor (const std::string &name, THREAD_ID tid)
 
const Moose::Functor< T > & getFunctor (const std::string &name, SubProblem &subproblem)
 
const Moose::Functor< T > & getFunctor (const std::string &name, SubProblem &subproblem, THREAD_ID tid)
 
bool isFunctor (const std::string &name) const
 
bool isFunctor (const std::string &name, const SubProblem &subproblem) const
 
Moose::ElemArg makeElemArg (const Elem *elem, bool correct_skewnewss=false) const
 
void checkFunctorSupportsSideIntegration (const std::string &name, bool qp_integration)
 

Protected Attributes

const MooseVariableFE< Real > & _v_var
 
const MooseVariableFE< Real > *const _w_var
 
const MooseVariableFE< RealVectorValue > & _grad_v_var
 
const MooseVariableFE< RealVectorValue > *const _grad_w_var
 
const MooseVariableFE< Real > & _v_face_var
 
const MooseVariableFE< Real > *const _w_face_var
 
const MooseVariableFE< Real > & _pressure_var
 
const MooseVariableScalar *const _enclosure_lm_var
 
const std::vector< dof_id_type > & _qv_dof_indices
 Containers for dof indices. More...
 
const std::vector< dof_id_type > & _v_dof_indices
 
const std::vector< dof_id_type > & _lm_v_dof_indices
 
const std::vector< dof_id_type > *const _qw_dof_indices
 
const std::vector< dof_id_type > *const _w_dof_indices
 
const std::vector< dof_id_type > *const _lm_w_dof_indices
 
const std::vector< dof_id_type > & _p_dof_indices
 
const std::vector< dof_id_type > *const _global_lm_dof_indices
 
const MooseArray< Gradient > & _qv_sol
 local solutions at quadrature points More...
 
const MooseArray< Number > & _v_sol
 
const MooseArray< Number > & _lm_v_sol
 
const MooseArray< Gradient > *const _qw_sol
 
const MooseArray< Number > *const _w_sol
 
const MooseArray< Number > *const _lm_w_sol
 
const MooseArray< Number > & _p_sol
 
const MooseArray< Number > *const _global_lm_dof_value
 
const Real _rho
 The density. More...
 
DenseVector< Number_grad_u_vel_re
 
DenseVector< Number_grad_v_vel_re
 
DenseVector< Number_u_vel_re
 
DenseVector< Number_v_vel_re
 
DenseVector< Number_lm_u_vel_re
 
DenseVector< Number_lm_v_vel_re
 
DenseVector< Number_p_re
 
DenseVector< Number_global_lm_re
 
DenseMatrix< Number_grad_u_grad_u_jac
 
DenseMatrix< Number_grad_u_u_jac
 
DenseMatrix< Number_grad_v_grad_v_jac
 
DenseMatrix< Number_grad_v_v_jac
 
DenseMatrix< Number_u_grad_u_jac
 
DenseMatrix< Number_v_grad_v_jac
 
DenseMatrix< Number_u_u_jac
 
DenseMatrix< Number_u_v_jac
 
DenseMatrix< Number_v_u_jac
 
DenseMatrix< Number_v_v_jac
 
DenseMatrix< Number_u_p_jac
 
DenseMatrix< Number_v_p_jac
 
DenseMatrix< Number_p_u_jac
 
DenseMatrix< Number_p_v_jac
 
DenseMatrix< Number_p_global_lm_jac
 
DenseMatrix< Number_global_lm_p_jac
 
DenseMatrix< Number_grad_u_lm_u_jac
 
DenseMatrix< Number_grad_v_lm_v_jac
 
DenseMatrix< Number_u_lm_u_jac
 
DenseMatrix< Number_v_lm_v_jac
 
DenseMatrix< Number_u_lm_v_jac
 
DenseMatrix< Number_v_lm_u_jac
 
DenseMatrix< Number_lm_u_grad_u_jac
 
DenseMatrix< Number_lm_v_grad_v_jac
 
DenseMatrix< Number_lm_u_u_jac
 
DenseMatrix< Number_lm_v_v_jac
 
DenseMatrix< Number_lm_u_lm_u_jac
 
DenseMatrix< Number_lm_v_lm_v_jac
 
DenseMatrix< Number_lm_u_p_jac
 
DenseMatrix< Number_lm_v_p_jac
 
DenseMatrix< Number_lm_u_lm_v_jac
 
DenseMatrix< Number_lm_v_lm_u_jac
 
DenseMatrix< Number_p_lm_u_jac
 
DenseMatrix< Number_p_lm_v_jac
 
const MooseVariableFE< Real > & _u_var
 
const MooseVariableFE< RealVectorValue > & _grad_u_var
 
const MooseVariableFE< Real > & _u_face_var
 
const std::vector< dof_id_type > & _qu_dof_indices
 
const std::vector< dof_id_type > & _u_dof_indices
 
const std::vector< dof_id_type > & _lm_u_dof_indices
 
const MooseArray< libMesh::Gradient > & _qu_sol
 
const MooseArray< Number > & _u_sol
 
const MooseArray< Number > & _lm_u_sol
 
const MooseArray< std::vector< RealVectorValue > > & _vector_phi
 
const MooseArray< std::vector< Real > > & _scalar_phi
 
const MooseArray< std::vector< RealVectorValue > > & _grad_scalar_phi
 
const MooseArray< std::vector< Real > > & _div_vector_phi
 
const MooseArray< std::vector< RealVectorValue > > & _vector_phi_face
 
const MooseArray< std::vector< Real > > & _scalar_phi_face
 
const MooseArray< std::vector< Real > > & _lm_phi_face
 
const MaterialProperty< Real > & _diff
 
const TransientInterface_ti
 
const Real _tau
 
const Elem * _cached_elem
 
DenseVector< Number_vector_re
 
DenseVector< Number_scalar_re
 
DenseVector< Number_lm_re
 
DenseMatrix< Number_vector_vector_jac
 
DenseMatrix< Number_vector_scalar_jac
 
DenseMatrix< Number_scalar_vector_jac
 
DenseMatrix< Number_scalar_scalar_jac
 
DenseMatrix< Number_scalar_lm_jac
 
DenseMatrix< Number_lm_scalar_jac
 
DenseMatrix< Number_lm_lm_jac
 
DenseMatrix< Number_vector_lm_jac
 
DenseMatrix< Number_lm_vector_jac
 

Detailed Description

Implements all the methods for assembling a hybridized local discontinuous Galerkin (LDG-H), which is a type of HDG method, discretization of the incompressible Navier-Stokes equations.

These routines may be called by both HDG kernels and integrated boundary conditions. The implementation here is based on "An implicit high-order hybridizable discontinuous Galerkin method for the incompressible Navier-Stokes equations" by Nguyen and Cockburn

Definition at line 21 of file NavierStokesLHDGAssemblyHelper.h.

Constructor & Destructor Documentation

◆ NavierStokesLHDGAssemblyHelper()

NavierStokesLHDGAssemblyHelper::NavierStokesLHDGAssemblyHelper ( const MooseObject moose_obj,
MaterialPropertyInterface mpi,
MooseVariableDependencyInterface mvdi,
const TransientInterface *const  ti,
const FEProblemBase fe_problem,
SystemBase sys,
const MooseMesh mesh,
const THREAD_ID  tid 
)

Definition at line 44 of file NavierStokesLHDGAssemblyHelper.C.

53  : DiffusionLHDGAssemblyHelper(moose_obj, mpi, mvdi, ti, fe_problem, sys, tid),
54  // vars
55  _v_var(sys.getFieldVariable<Real>(tid, moose_obj->getParam<NonlinearVariableName>("v"))),
56  _w_var(mesh.dimension() > 2
57  ? &sys.getFieldVariable<Real>(tid, moose_obj->getParam<NonlinearVariableName>("w"))
58  : nullptr),
59  _grad_v_var(sys.getFieldVariable<RealVectorValue>(
60  tid, moose_obj->getParam<NonlinearVariableName>("grad_v"))),
61  _grad_w_var(mesh.dimension() > 2
62  ? &sys.getFieldVariable<RealVectorValue>(
63  tid, moose_obj->getParam<NonlinearVariableName>("grad_w"))
64  : nullptr),
66  sys.getFieldVariable<Real>(tid, moose_obj->getParam<NonlinearVariableName>("face_v"))),
68  mesh.dimension() > 2
69  ? &sys.getFieldVariable<Real>(tid, moose_obj->getParam<NonlinearVariableName>("face_w"))
70  : nullptr),
72  sys.getFieldVariable<Real>(tid, moose_obj->getParam<NonlinearVariableName>(NS::pressure))),
73  _enclosure_lm_var(moose_obj->isParamValid("enclosure_lm")
74  ? &sys.getScalarVariable(
75  tid, moose_obj->getParam<NonlinearVariableName>("enclosure_lm"))
76  : nullptr),
77  // dof indices
78  _qv_dof_indices(_grad_v_var.dofIndices()),
79  _v_dof_indices(_v_var.dofIndices()),
80  _lm_v_dof_indices(_v_face_var.dofIndices()),
81  _qw_dof_indices(_grad_w_var ? &_grad_w_var->dofIndices() : nullptr),
82  _w_dof_indices(_w_var ? &_w_var->dofIndices() : nullptr),
83  _lm_w_dof_indices(_w_face_var ? &_w_face_var->dofIndices() : nullptr),
84  _p_dof_indices(_pressure_var.dofIndices()),
86  // solutions
87  _qv_sol(_grad_v_var.sln()),
88  _v_sol(_v_var.sln()),
89  _lm_v_sol(_v_face_var.sln()),
90  _qw_sol(_grad_w_var ? &_grad_w_var->sln() : nullptr),
91  _w_sol(_w_var ? &_w_var->sln() : nullptr),
92  _lm_w_sol(_w_face_var ? &_w_face_var->sln() : nullptr),
93  _p_sol(_pressure_var.sln()),
95  _rho(moose_obj->getParam<Real>(NS::density))
96 {
97  if (mesh.dimension() > 2)
98  mooseError("3D not yet implemented");
99 
104 
105  const auto vel_type = _u_var.feType();
106  auto check_type = [&vel_type](const auto & var)
107  {
108  if (vel_type != var.feType())
109  mooseError(
110  var.name(),
111  "does not have the same finite element type as the x-component velocity. All scalar "
112  "field finite element types must be the same for the Navier-Stokes L-HDG implementation");
113  };
114  check_type(_v_var);
115  if (_w_var)
116  check_type(*_w_var);
117  check_type(_pressure_var);
118 
119  const auto grad_type = _grad_u_var.feType();
120  auto check_grad_type = [&grad_type](const auto & var)
121  {
122  if (grad_type != var.feType())
123  mooseError(
124  var.name(),
125  "does not have the same finite element type as the x-component velocity gradient. All "
126  "vector field finite element types must be the same for the Navier-Stokes L-HDG "
127  "implementation");
128  };
129  check_grad_type(_grad_v_var);
130  if (_grad_w_var)
131  check_grad_type(*_grad_w_var);
132 
133  const auto lm_type = _u_face_var.feType();
134  auto check_lm_type = [&lm_type](const auto & var)
135  {
136  if (lm_type != var.feType())
137  mooseError(var.name(),
138  "does not have the same finite element type as the x-component face variable. All "
139  "face variable finite element types must be the same for the Navier-Stokes L-HDG "
140  "implementation");
141  };
142  check_lm_type(_v_face_var);
143  if (_w_face_var)
144  check_lm_type(*_w_face_var);
145 }
const std::vector< dof_id_type > *const _lm_w_dof_indices
const std::vector< dof_id_type > *const _global_lm_dof_indices
const libMesh::FEType & feType() const
const MooseVariableFE< Real > & _v_var
void mooseError(Args &&... args)
const MooseVariableFE< Real > *const _w_var
const MooseVariableFE< Real > & _v_face_var
MeshBase & mesh
static const std::string density
Definition: NS.h:33
const std::vector< dof_id_type > *const _qw_dof_indices
const std::vector< dof_id_type > & _qv_dof_indices
Containers for dof indices.
const MooseVariableFE< RealVectorValue > & _grad_v_var
const std::vector< dof_id_type > & _lm_v_dof_indices
const T & getParam(const std::string &name) const
const MooseArray< Gradient > *const _qw_sol
const std::vector< dof_id_type > & _v_dof_indices
const MooseVariableFE< RealVectorValue > *const _grad_w_var
const std::vector< dof_id_type > *const _w_dof_indices
const MooseVariableFE< Real > & _pressure_var
const MooseVariableFE< Real > & _u_face_var
void addMooseVariableDependency(MooseVariableFieldBase *var)
const std::vector< dof_id_type > & _p_dof_indices
DIE A HORRIBLE DEATH HERE typedef LIBMESH_DEFAULT_SCALAR_TYPE Real
MooseVariableFE< T > & getFieldVariable(THREAD_ID tid, const std::string &var_name)
const MooseVariableFE< Real > & _u_var
static const std::string pressure
Definition: NS.h:56
const MooseArray< Gradient > & _qv_sol
local solutions at quadrature points
const MooseVariableFE< RealVectorValue > & _grad_u_var
const MooseArray< Number > *const _lm_w_sol
const MooseVariableFE< Real > *const _w_face_var
const MooseArray< Number > *const _w_sol
DiffusionLHDGAssemblyHelper(const MooseObject *const moose_obj, MaterialPropertyInterface *const mpi, MooseVariableDependencyInterface *const mvdi, const TransientInterface *const ti, const FEProblemBase &fe_problem, SystemBase &sys, const THREAD_ID tid)
const MooseVariableScalar *const _enclosure_lm_var
const MooseArray< Number > *const _global_lm_dof_value

Member Function Documentation

◆ lmFaceJacobian()

void NavierStokesLHDGAssemblyHelper::lmFaceJacobian ( const unsigned int  vel_component,
const MooseArray< Real > &  JxW_face,
const libMesh::QBase qrule_face,
const MooseArray< Point > &  normals,
const Elem *const  neigh,
DenseMatrix< Number > &  lm_vec_jac,
DenseMatrix< Number > &  lm_scalar_jac,
DenseMatrix< Number > &  lm_lm_jac,
DenseMatrix< Number > &  lm_p_jac,
DenseMatrix< Number > &  lm_lm_u_vel_jac,
DenseMatrix< Number > &  lm_lm_v_vel_jac 
)
protected

Definition at line 478 of file NavierStokesLHDGAssemblyHelper.C.

Referenced by NavierStokesLHDGOutflowBC::computeJacobian(), and NavierStokesLHDGKernel::computeJacobianOnSide().

489 {
491  JxW_face, qrule_face, normals, lm_vec_jac, lm_scalar_jac, lm_lm_jac);
492 
493  for (const auto i : make_range(lm_p_jac.m()))
494  for (const auto qp : make_range(qrule_face.n_points()))
495  {
496  for (const auto j : make_range(lm_p_jac.n()))
497  {
498  Gradient p_phi;
499  p_phi(vel_component) = _scalar_phi_face[j][qp];
500  lm_p_jac(i, j) += JxW_face[qp] * _lm_phi_face[i][qp] * (p_phi * normals[qp]);
501  }
502 
503  for (const auto j : make_range(lm_lm_u_vel_jac.n()))
504  if (neigh)
505  {
506  // derivatives wrt 0th component of velocity
507  {
508  const auto rho_vel_cross_vel =
509  rhoVelCrossVelJacobian(_lm_u_sol, _lm_v_sol, qp, vel_component, 0, _lm_phi_face, j);
510  lm_lm_u_vel_jac(i, j) +=
511  JxW_face[qp] * _lm_phi_face[i][qp] * rho_vel_cross_vel * normals[qp];
512  }
513  // derivatives wrt 1th component of velocity
514  {
515  const auto rho_vel_cross_vel =
516  rhoVelCrossVelJacobian(_lm_u_sol, _lm_v_sol, qp, vel_component, 1, _lm_phi_face, j);
517  lm_lm_v_vel_jac(i, j) +=
518  JxW_face[qp] * _lm_phi_face[i][qp] * rho_vel_cross_vel * normals[qp];
519  }
520  }
521  }
522 }
const MooseArray< std::vector< Real > > & _scalar_phi_face
RealVectorValue rhoVelCrossVelJacobian(const MooseArray< Number > &u_sol, const MooseArray< Number > &v_sol, const unsigned int qp, const unsigned int vel_component, const unsigned int vel_j_component, const MooseArray< std::vector< Real >> &phi, const unsigned int j)
const MooseArray< std::vector< Real > > & _lm_phi_face
unsigned int m() const
void lmFaceJacobian(const MooseArray< Real > &JxW_face, const libMesh::QBase &qrule_face, const MooseArray< Point > &normals, DenseMatrix< Number > &lm_vec_jac, DenseMatrix< Number > &lm_scalar_jac, DenseMatrix< Number > &lm_lm_jac)
unsigned int n_points() const
const MooseArray< Number > & _lm_u_sol
IntRange< T > make_range(T beg, T end)
static const std::complex< double > j(0, 1)
Complex number "j" (also known as "i")
unsigned int n() const

◆ lmFaceResidual()

void NavierStokesLHDGAssemblyHelper::lmFaceResidual ( const MooseArray< Gradient > &  vector_sol,
const MooseArray< Number > &  scalar_sol,
const MooseArray< Number > &  lm_sol,
const unsigned int  vel_component,
const MooseArray< Real > &  JxW_face,
const libMesh::QBase qrule_face,
const MooseArray< Point > &  normals,
const Elem *const  neigh,
DenseVector< Number > &  lm_re 
)
protected

Definition at line 444 of file NavierStokesLHDGAssemblyHelper.C.

Referenced by NavierStokesLHDGOutflowBC::computeResidual(), and NavierStokesLHDGKernel::computeResidualOnSide().

453 {
455  vector_sol, scalar_sol, lm_sol, JxW_face, qrule_face, normals, lm_re);
456 
457  for (const auto qp : make_range(qrule_face.n_points()))
458  {
459  Gradient qp_p;
460  qp_p(vel_component) = _p_sol[qp];
461  const auto rho_vel_cross_vel = rhoVelCrossVelResidual(_lm_u_sol, _lm_v_sol, qp, vel_component);
462 
463  for (const auto i : make_range(lm_re.size()))
464  {
465  // pressure
466  lm_re(i) += JxW_face[qp] * _lm_phi_face[i][qp] * (qp_p * normals[qp]);
467 
468  // If we are an internal face we add the convective term. On the outflow boundary we do not
469  // zero out the convection term, e.g. we are going to set q + p + tau * (u - u_hat) to zero
470  if (neigh)
471  // lm from convection term
472  lm_re(i) += JxW_face[qp] * _lm_phi_face[i][qp] * rho_vel_cross_vel * normals[qp];
473  }
474  }
475 }
const MooseArray< std::vector< Real > > & _lm_phi_face
RealVectorValue rhoVelCrossVelResidual(const MooseArray< Number > &u_sol, const MooseArray< Number > &v_sol, const unsigned int qp, const unsigned int vel_component)
void lmFaceResidual(const MooseArray< Gradient > &vector_sol, const MooseArray< Number > &scalar_sol, const MooseArray< Number > &lm_sol, const MooseArray< Real > &JxW_face, const libMesh::QBase &qrule_face, const MooseArray< Point > &normals, DenseVector< Number > &lm_re)
unsigned int n_points() const
const MooseArray< Number > & _lm_u_sol
IntRange< T > make_range(T beg, T end)
virtual unsigned int size() const override final

◆ pressureDirichletResidual()

void NavierStokesLHDGAssemblyHelper::pressureDirichletResidual ( const std::array< const Moose::Functor< Real > *, 3 > &  dirichlet_vel,
const MooseArray< Real > &  JxW_face,
const libMesh::QBase qrule_face,
const MooseArray< Point > &  normals,
const Elem *const  current_elem,
const unsigned int  current_side,
const MooseArray< Point > &  q_point_face,
DenseVector< Number > &  pressure_re 
)
protected

Definition at line 525 of file NavierStokesLHDGAssemblyHelper.C.

Referenced by NavierStokesLHDGVelocityDirichletBC::computeResidual().

534 {
535  for (const auto qp : make_range(qrule_face.n_points()))
536  {
537  const Moose::ElemSideQpArg elem_side_qp_arg{
538  current_elem, current_side, qp, &qrule_face, q_point_face[qp]};
539  const auto time_arg = _ti.determineState();
540  const RealVectorValue dirichlet_velocity((*dirichlet_vel[0])(elem_side_qp_arg, time_arg),
541  (*dirichlet_vel[1])(elem_side_qp_arg, time_arg),
542  (*dirichlet_vel[2])(elem_side_qp_arg, time_arg));
543  const auto vdotn = dirichlet_velocity * normals[qp];
544  for (const auto i : make_range(pressure_re.size()))
545  pressure_re(i) += JxW_face[qp] * vdotn * _scalar_phi_face[i][qp];
546  }
547 }
const MooseArray< std::vector< Real > > & _scalar_phi_face
Moose::StateArg determineState() const
unsigned int n_points() const
const TransientInterface & _ti
IntRange< T > make_range(T beg, T end)
virtual unsigned int size() const override final

◆ pressureFaceJacobian()

void NavierStokesLHDGAssemblyHelper::pressureFaceJacobian ( const MooseArray< Real > &  JxW_face,
const libMesh::QBase qrule_face,
const MooseArray< Point > &  normals,
DenseMatrix< Number > &  p_lm_u_vel_jac,
DenseMatrix< Number > &  p_lm_v_vel_jac 
)
protected

Definition at line 337 of file NavierStokesLHDGAssemblyHelper.C.

Referenced by NavierStokesLHDGOutflowBC::computeJacobian(), and NavierStokesLHDGKernel::computeJacobianOnSide().

342 {
343  mooseAssert((p_lm_u_vel_jac.m() == p_lm_v_vel_jac.m()) &&
344  (p_lm_u_vel_jac.n() == p_lm_v_vel_jac.n()),
345  "We already checked that lm finite element types are the same, so these matrices "
346  "should be the same size");
347  for (const auto i : make_range(p_lm_u_vel_jac.m()))
348  for (const auto j : make_range(p_lm_u_vel_jac.n()))
349  for (const auto qp : make_range(qrule_face.n_points()))
350  {
351  {
352  const Gradient phi(_lm_phi_face[j][qp], 0);
353  p_lm_u_vel_jac(i, j) += JxW_face[qp] * phi * normals[qp] * _scalar_phi_face[i][qp];
354  }
355  {
356  const Gradient phi(0, _lm_phi_face[j][qp]);
357  p_lm_v_vel_jac(i, j) += JxW_face[qp] * phi * normals[qp] * _scalar_phi_face[i][qp];
358  }
359  }
360 }
const MooseArray< std::vector< Real > > & _scalar_phi_face
const MooseArray< std::vector< Real > > & _lm_phi_face
unsigned int m() const
unsigned int n_points() const
IntRange< T > make_range(T beg, T end)
static const std::complex< double > j(0, 1)
Complex number "j" (also known as "i")
unsigned int n() const

◆ pressureFaceResidual()

void NavierStokesLHDGAssemblyHelper::pressureFaceResidual ( const MooseArray< Real > &  JxW_face,
const libMesh::QBase qrule_face,
const MooseArray< Point > &  normals,
DenseVector< Number > &  pressure_re 
)
protected

Definition at line 322 of file NavierStokesLHDGAssemblyHelper.C.

Referenced by NavierStokesLHDGOutflowBC::computeResidual(), and NavierStokesLHDGKernel::computeResidualOnSide().

326 {
327  for (const auto qp : make_range(qrule_face.n_points()))
328  {
329  const Gradient vel(_lm_u_sol[qp], _lm_v_sol[qp]);
330  const auto vdotn = vel * normals[qp];
331  for (const auto i : make_range(pressure_re.size()))
332  pressure_re(i) += JxW_face[qp] * vdotn * _scalar_phi_face[i][qp];
333  }
334 }
const MooseArray< std::vector< Real > > & _scalar_phi_face
unsigned int n_points() const
const MooseArray< Number > & _lm_u_sol
IntRange< T > make_range(T beg, T end)
virtual unsigned int size() const override final

◆ pressureVolumeJacobian()

void NavierStokesLHDGAssemblyHelper::pressureVolumeJacobian ( const MooseArray< Real > &  JxW,
const libMesh::QBase qrule,
DenseMatrix< Number > &  p_u_vel_jac,
DenseMatrix< Number > &  p_v_vel_jac,
DenseMatrix< Number > &  p_global_lm_jac,
DenseMatrix< Number > &  global_lm_p_jac 
)
protected

Compute the volumetric contributions to the pressure Jacobian, e.g.

the conservation of mass equation

Parameters
i_offsetThe local degree of freedom offset for the pressure
u_j_offsetThe local degree of freedom offset for the x-component of velocity
v_j_offsetThe local degree of freedom offset for the y-component of velocity
p_j_offsetThe local degree of freedom offset for the pressure
global_lm_i_offsetThe local degree of freedom offset for the global Lagrange multiplier that removes the pressure nullspace

Definition at line 258 of file NavierStokesLHDGAssemblyHelper.C.

Referenced by NavierStokesLHDGKernel::computeJacobian().

264 {
265  for (const auto qp : make_range(qrule.n_points()))
266  {
267  for (const auto i : make_range(p_u_vel_jac.m()))
268  {
269  for (const auto j : make_range(p_u_vel_jac.n()))
270  {
271  {
272  const Gradient phi(_scalar_phi[j][qp], 0);
273  p_u_vel_jac(i, j) -= JxW[qp] * (_grad_scalar_phi[i][qp] * phi);
274  }
275  {
276  const Gradient phi(0, _scalar_phi[j][qp]);
277  p_v_vel_jac(i, j) -= JxW[qp] * (_grad_scalar_phi[i][qp] * phi);
278  }
279  }
280  if (_enclosure_lm_var)
281  p_global_lm_jac(i, 0) -= JxW[qp] * _scalar_phi[i][qp];
282  }
283 
284  if (_enclosure_lm_var)
285  {
286  for (const auto j : make_range(global_lm_p_jac.n()))
287  global_lm_p_jac(0, j) -= JxW[qp] * _scalar_phi[j][qp];
288  }
289  }
290 }
const MooseArray< std::vector< Real > > & _scalar_phi
const MooseArray< std::vector< RealVectorValue > > & _grad_scalar_phi
unsigned int m() const
unsigned int n_points() const
IntRange< T > make_range(T beg, T end)
static const std::complex< double > j(0, 1)
Complex number "j" (also known as "i")
unsigned int n() const
const MooseVariableScalar *const _enclosure_lm_var

◆ pressureVolumeResidual()

void NavierStokesLHDGAssemblyHelper::pressureVolumeResidual ( const Moose::Functor< Real > &  pressure_mms_forcing_function,
const MooseArray< Real > &  JxW,
const libMesh::QBase qrule,
const Elem *const  current_elem,
const MooseArray< Point > &  q_point,
DenseVector< Number > &  pressure_re,
DenseVector< Number > &  global_lm_re 
)
protected

Compute the volumetric contributions to the pressure residual, e.g.

the conservation of mass equation

Parameters
i_offsetThe local degree of freedom offset for the pressure
global_lm_i_offsetThe local degree of freedom offset for the global Lagrange multiplier that removes the pressure nullspace

Definition at line 220 of file NavierStokesLHDGAssemblyHelper.C.

Referenced by NavierStokesLHDGKernel::computeResidual().

228 {
229  for (const auto qp : make_range(qrule.n_points()))
230  {
231  // Prepare forcing function
232  const auto f = pressure_mms_forcing_function(
233  Moose::ElemQpArg{current_elem, qp, &qrule, q_point[qp]}, _ti.determineState());
234 
235  const Gradient vel(_u_sol[qp], _v_sol[qp]);
236  for (const auto i : make_range(pressure_re.size()))
237  {
238  pressure_re(i) -= JxW[qp] * (_grad_scalar_phi[i][qp] * vel);
239 
240  // Pressure equation forcing function RHS
241  pressure_re(i) -= JxW[qp] * _scalar_phi[i][qp] * f;
242 
243  if (_enclosure_lm_var)
244  {
245  mooseAssert(
246  _global_lm_dof_value->size() == 1,
247  "There should only be one degree of freedom for removing the pressure nullspace");
248  pressure_re(i) -= JxW[qp] * _scalar_phi[i][qp] * (*_global_lm_dof_value)[0];
249  }
250  }
251 
252  if (_enclosure_lm_var)
253  global_lm_re(0) -= JxW[qp] * _p_sol[qp];
254  }
255 }
const MooseArray< Number > & _u_sol
const MooseArray< std::vector< Real > > & _scalar_phi
Moose::StateArg determineState() const
const MooseArray< std::vector< RealVectorValue > > & _grad_scalar_phi
unsigned int size() const
Real f(Real x)
Test function for Brents method.
unsigned int n_points() const
const TransientInterface & _ti
IntRange< T > make_range(T beg, T end)
virtual unsigned int size() const override final
const MooseVariableScalar *const _enclosure_lm_var
const MooseArray< Number > *const _global_lm_dof_value

◆ rhoVelCrossVelJacobian()

RealVectorValue NavierStokesLHDGAssemblyHelper::rhoVelCrossVelJacobian ( const MooseArray< Number > &  u_sol,
const MooseArray< Number > &  v_sol,
const unsigned int  qp,
const unsigned int  vel_component,
const unsigned int  vel_j_component,
const MooseArray< std::vector< Real >> &  phi,
const unsigned int  j 
)
protected
Parameters
u_solThe x-velocity solution, can correspond to either the volumetric or face velocity
v_solThe y-velocity solution, can correspond to either the volumetric or face velocity

Definition at line 303 of file NavierStokesLHDGAssemblyHelper.C.

Referenced by lmFaceJacobian(), scalarFaceJacobian(), and scalarVolumeJacobian().

310 {
311  const RealVectorValue U(u_sol[qp], v_sol[qp]);
312  RealVectorValue vector_phi;
313  vector_phi(vel_j_component) = phi[j][qp];
314  auto ret = vector_phi * U(vel_component);
315  if (vel_component == vel_j_component)
316  ret += U * phi[j][qp];
317  ret *= _rho;
318  return ret;
319 }
static const std::complex< double > j(0, 1)
Complex number "j" (also known as "i")

◆ rhoVelCrossVelResidual()

RealVectorValue NavierStokesLHDGAssemblyHelper::rhoVelCrossVelResidual ( const MooseArray< Number > &  u_sol,
const MooseArray< Number > &  v_sol,
const unsigned int  qp,
const unsigned int  vel_component 
)
protected
Parameters
u_solThe x-velocity solution, can correspond to either the volumetric or face velocity
v_solThe y-velocity solution, can correspond to either the volumetric or face velocity

Definition at line 293 of file NavierStokesLHDGAssemblyHelper.C.

Referenced by lmFaceResidual(), scalarFaceResidual(), and scalarVolumeResidual().

297 {
298  const RealVectorValue U(u_sol[qp], v_sol[qp]);
299  return _rho * U * U(vel_component);
300 }

◆ scalarDirichletJacobian()

void NavierStokesLHDGAssemblyHelper::scalarDirichletJacobian ( const unsigned int  vel_component,
const MooseArray< Real > &  JxW_face,
const libMesh::QBase qrule_face,
const MooseArray< Point > &  normals,
DenseMatrix< Number > &  scalar_vector_jac,
DenseMatrix< Number > &  scalar_scalar_jac,
DenseMatrix< Number > &  scalar_pressure_jac 
)
protected

Definition at line 600 of file NavierStokesLHDGAssemblyHelper.C.

Referenced by NavierStokesLHDGVelocityDirichletBC::computeJacobian().

607 {
609  JxW_face, qrule_face, normals, scalar_vector_jac, scalar_scalar_jac);
610 
611  for (const auto i : make_range(scalar_pressure_jac.m()))
612  for (const auto j : make_range(scalar_pressure_jac.n()))
613  for (const auto qp : make_range(qrule_face.n_points()))
614  {
615  Gradient p_phi;
616  p_phi(vel_component) = _scalar_phi_face[j][qp];
617  // pressure
618  scalar_pressure_jac(i, j) += JxW_face[qp] * _scalar_phi_face[i][qp] * (p_phi * normals[qp]);
619  }
620 }
const MooseArray< std::vector< Real > > & _scalar_phi_face
unsigned int m() const
void scalarDirichletJacobian(const MooseArray< Real > &JxW_face, const libMesh::QBase &qrule_face, const MooseArray< Point > &normals, DenseMatrix< Number > &scalar_vector_jac, DenseMatrix< Number > &scalar_scalar_jac)
unsigned int n_points() const
IntRange< T > make_range(T beg, T end)
static const std::complex< double > j(0, 1)
Complex number "j" (also known as "i")
unsigned int n() const

◆ scalarDirichletResidual()

void NavierStokesLHDGAssemblyHelper::scalarDirichletResidual ( const MooseArray< Gradient > &  vector_sol,
const MooseArray< Number > &  scalar_sol,
const unsigned int  vel_component,
const std::array< const Moose::Functor< Real > *, 3 > &  dirichlet_vel,
const MooseArray< Real > &  JxW_face,
const libMesh::QBase qrule_face,
const MooseArray< Point > &  normals,
const Elem *const  current_elem,
const unsigned int  current_side,
const MooseArray< Point > &  q_point_face,
DenseVector< Number > &  scalar_re 
)
protected

Definition at line 550 of file NavierStokesLHDGAssemblyHelper.C.

Referenced by NavierStokesLHDGVelocityDirichletBC::computeResidual().

562 {
564  scalar_sol,
565  *dirichlet_vel[vel_component],
566  JxW_face,
567  qrule_face,
568  normals,
569  current_elem,
570  current_side,
571  q_point_face,
572  scalar_re);
573 
574  for (const auto qp : make_range(qrule_face.n_points()))
575  {
576  Gradient qp_p;
577  qp_p(vel_component) = _p_sol[qp];
578 
579  const Moose::ElemSideQpArg elem_side_qp_arg{
580  current_elem, current_side, qp, &qrule_face, q_point_face[qp]};
581  const auto time_arg = _ti.determineState();
582  const RealVectorValue dirichlet_velocity((*dirichlet_vel[0])(elem_side_qp_arg, time_arg),
583  (*dirichlet_vel[1])(elem_side_qp_arg, time_arg),
584  (*dirichlet_vel[2])(elem_side_qp_arg, time_arg));
585  const auto scalar_value = dirichlet_velocity(vel_component);
586 
587  for (const auto i : make_range(scalar_re.size()))
588  {
589  // pressure
590  scalar_re(i) += JxW_face[qp] * _scalar_phi_face[i][qp] * (qp_p * normals[qp]);
591 
592  // dirichlet lm from advection term
593  scalar_re(i) += JxW_face[qp] * _scalar_phi_face[i][qp] *
594  (_rho * dirichlet_velocity * normals[qp]) * scalar_value;
595  }
596  }
597 }
const MooseArray< std::vector< Real > > & _scalar_phi_face
void scalarDirichletResidual(const MooseArray< Gradient > &vector_sol, const MooseArray< Number > &scalar_sol, const Moose::Functor< Real > &dirichlet_value, const MooseArray< Real > &JxW_face, const libMesh::QBase &qrule_face, const MooseArray< Point > &normals, const Elem *const current_elem, const unsigned int current_side, const MooseArray< Point > &q_point_face, DenseVector< Number > &scalar_re)
Moose::StateArg determineState() const
unsigned int n_points() const
const TransientInterface & _ti
IntRange< T > make_range(T beg, T end)
virtual unsigned int size() const override final

◆ scalarFaceJacobian()

void NavierStokesLHDGAssemblyHelper::scalarFaceJacobian ( const unsigned int  vel_component,
const MooseArray< Real > &  JxW_face,
const libMesh::QBase qrule_face,
const MooseArray< Point > &  normals,
DenseMatrix< Number > &  scalar_vector_jac,
DenseMatrix< Number > &  scalar_scalar_jac,
DenseMatrix< Number > &  scalar_lm_jac,
DenseMatrix< Number > &  scalar_p_jac,
DenseMatrix< Number > &  scalar_lm_u_vel_jac,
DenseMatrix< Number > &  scalar_lm_v_vel_jac 
)
protected

Definition at line 393 of file NavierStokesLHDGAssemblyHelper.C.

Referenced by NavierStokesLHDGOutflowBC::computeJacobian(), and NavierStokesLHDGKernel::computeJacobianOnSide().

404 {
406  JxW_face, qrule_face, normals, scalar_vector_jac, scalar_scalar_jac, scalar_lm_jac);
407 
408  for (const auto i : make_range(scalar_lm_u_vel_jac.m()))
409  for (const auto qp : make_range(qrule_face.n_points()))
410  {
411  for (const auto j : make_range(scalar_p_jac.n()))
412  {
413  Gradient p_phi;
414  p_phi(vel_component) = _scalar_phi_face[j][qp];
415  // pressure
416  scalar_p_jac(i, j) += JxW_face[qp] * _scalar_phi_face[i][qp] * (p_phi * normals[qp]);
417  }
418 
419  for (const auto j : make_range(scalar_lm_u_vel_jac.n()))
420  {
421  //
422  // from convection term
423  //
424 
425  // derivatives wrt 0th component of velocity
426  {
427  const auto rho_vel_cross_vel =
428  rhoVelCrossVelJacobian(_lm_u_sol, _lm_v_sol, qp, vel_component, 0, _lm_phi_face, j);
429  scalar_lm_u_vel_jac(i, j) +=
430  JxW_face[qp] * _scalar_phi_face[i][qp] * rho_vel_cross_vel * normals[qp];
431  }
432  // derivatives wrt 1th component of velocity
433  {
434  const auto rho_vel_cross_vel =
435  rhoVelCrossVelJacobian(_lm_u_sol, _lm_v_sol, qp, vel_component, 1, _lm_phi_face, j);
436  scalar_lm_v_vel_jac(i, j) +=
437  JxW_face[qp] * _scalar_phi_face[i][qp] * rho_vel_cross_vel * normals[qp];
438  }
439  }
440  }
441 }
const MooseArray< std::vector< Real > > & _scalar_phi_face
RealVectorValue rhoVelCrossVelJacobian(const MooseArray< Number > &u_sol, const MooseArray< Number > &v_sol, const unsigned int qp, const unsigned int vel_component, const unsigned int vel_j_component, const MooseArray< std::vector< Real >> &phi, const unsigned int j)
const MooseArray< std::vector< Real > > & _lm_phi_face
unsigned int m() const
void scalarFaceJacobian(const MooseArray< Real > &JxW_face, const libMesh::QBase &qrule_face, const MooseArray< Point > &normals, DenseMatrix< Number > &scalar_vector_jac, DenseMatrix< Number > &scalar_scalar_jac, DenseMatrix< Number > &scalar_lm_jac)
unsigned int n_points() const
const MooseArray< Number > & _lm_u_sol
IntRange< T > make_range(T beg, T end)
static const std::complex< double > j(0, 1)
Complex number "j" (also known as "i")
unsigned int n() const

◆ scalarFaceResidual()

void NavierStokesLHDGAssemblyHelper::scalarFaceResidual ( const MooseArray< Gradient > &  vector_sol,
const MooseArray< Number > &  scalar_sol,
const MooseArray< Number > &  lm_sol,
const unsigned int  vel_component,
const MooseArray< Real > &  JxW_face,
const libMesh::QBase qrule_face,
const MooseArray< Point > &  normals,
DenseVector< Number > &  scalar_re 
)
protected

Definition at line 363 of file NavierStokesLHDGAssemblyHelper.C.

Referenced by NavierStokesLHDGOutflowBC::computeResidual(), and NavierStokesLHDGKernel::computeResidualOnSide().

371 {
373  vector_sol, scalar_sol, lm_sol, JxW_face, qrule_face, normals, scalar_re);
374 
375  for (const auto qp : make_range(qrule_face.n_points()))
376  {
377  Gradient qp_p;
378  qp_p(vel_component) = _p_sol[qp];
379  const auto rho_vel_cross_vel = rhoVelCrossVelResidual(_lm_u_sol, _lm_v_sol, qp, vel_component);
380 
381  for (const auto i : make_range(scalar_re.size()))
382  {
383  // pressure
384  scalar_re(i) += JxW_face[qp] * _scalar_phi_face[i][qp] * (qp_p * normals[qp]);
385 
386  // lm from convection term
387  scalar_re(i) += JxW_face[qp] * _scalar_phi_face[i][qp] * rho_vel_cross_vel * normals[qp];
388  }
389  }
390 }
const MooseArray< std::vector< Real > > & _scalar_phi_face
RealVectorValue rhoVelCrossVelResidual(const MooseArray< Number > &u_sol, const MooseArray< Number > &v_sol, const unsigned int qp, const unsigned int vel_component)
unsigned int n_points() const
const MooseArray< Number > & _lm_u_sol
IntRange< T > make_range(T beg, T end)
virtual unsigned int size() const override final
void scalarFaceResidual(const MooseArray< Gradient > &vector_sol, const MooseArray< Number > &scalar_sol, const MooseArray< Number > &lm_sol, const MooseArray< Real > &JxW_face, const libMesh::QBase &qrule_face, const MooseArray< Point > &normals, DenseVector< Number > &scalar_re)

◆ scalarVolumeJacobian()

void NavierStokesLHDGAssemblyHelper::scalarVolumeJacobian ( const unsigned int  vel_component,
const MooseArray< Real > &  JxW,
const libMesh::QBase qrule,
DenseMatrix< Number > &  scalar_vector_jac,
DenseMatrix< Number > &  scalar_u_vel_jac,
DenseMatrix< Number > &  scalar_v_vel_jac,
DenseMatrix< Number > &  scalar_p_jac 
)
protected

Compute the volumetric contributions to a velocity Jacobian.

Parameters
i_offsetThe local degree of freedom offset for the velocity component
vel_gradient_j_offsetThe local degree of freedom offset for the associated velocity gradient
p_j_offsetThe local degree of freedom offset for the pressure
vel_componentThe velocity component
u_j_offsetThe local degree of freedom offset for the x-component velocity
v_j_offsetThe local degree of freedom offset for the y-component velocity

Definition at line 178 of file NavierStokesLHDGAssemblyHelper.C.

Referenced by NavierStokesLHDGKernel::computeJacobian().

185 {
186  DiffusionLHDGAssemblyHelper::scalarVolumeJacobian(JxW, qrule, scalar_vector_jac);
187 
188  for (const auto i : make_range(scalar_vector_jac.m()))
189  for (const auto qp : make_range(qrule.n_points()))
190  {
191  // Scalar equation dependence on pressure dofs
192  for (const auto j : make_range(scalar_p_jac.n()))
193  {
194  Gradient p_phi;
195  p_phi(vel_component) = _scalar_phi[j][qp];
196  scalar_p_jac(i, j) -= JxW[qp] * (_grad_scalar_phi[i][qp] * p_phi);
197  }
198 
199  // Scalar equation dependence on scalar dofs
200  mooseAssert(scalar_u_vel_jac.n() == scalar_v_vel_jac.n(), "These must be the same size");
201  for (const auto j : make_range(scalar_u_vel_jac.n()))
202  {
203  // derivatives wrt 0th component of velocity
204  {
205  const auto rho_vel_cross_vel =
206  rhoVelCrossVelJacobian(_u_sol, _v_sol, qp, vel_component, 0, _scalar_phi, j);
207  scalar_u_vel_jac(i, j) -= JxW[qp] * (_grad_scalar_phi[i][qp] * rho_vel_cross_vel);
208  }
209  // derivatives wrt 1th component of velocity
210  {
211  const auto rho_vel_cross_vel =
212  rhoVelCrossVelJacobian(_u_sol, _v_sol, qp, vel_component, 1, _scalar_phi, j);
213  scalar_v_vel_jac(i, j) -= JxW[qp] * (_grad_scalar_phi[i][qp] * rho_vel_cross_vel);
214  }
215  }
216  }
217 }
const MooseArray< Number > & _u_sol
const MooseArray< std::vector< Real > > & _scalar_phi
RealVectorValue rhoVelCrossVelJacobian(const MooseArray< Number > &u_sol, const MooseArray< Number > &v_sol, const unsigned int qp, const unsigned int vel_component, const unsigned int vel_j_component, const MooseArray< std::vector< Real >> &phi, const unsigned int j)
const MooseArray< std::vector< RealVectorValue > > & _grad_scalar_phi
unsigned int m() const
unsigned int n_points() const
IntRange< T > make_range(T beg, T end)
void scalarVolumeJacobian(const MooseArray< Real > &JxW, const libMesh::QBase &qrule, DenseMatrix< Number > &scalar_vector_jac)
static const std::complex< double > j(0, 1)
Complex number "j" (also known as "i")
unsigned int n() const

◆ scalarVolumeResidual()

void NavierStokesLHDGAssemblyHelper::scalarVolumeResidual ( const MooseArray< Gradient > &  vel_gradient,
const unsigned int  vel_component,
const Moose::Functor< Real > &  body_force,
const MooseArray< Real > &  JxW,
const libMesh::QBase qrule,
const Elem *const  current_elem,
const MooseArray< Point > &  q_point,
DenseVector< Number > &  scalar_re 
)
protected

Compute the volumetric contributions to a velocity residual for a provided velocity gradient and stress.

Parameters
i_offsetThe local degree of freedom offset for the velocity component
vel_gradientThe velocity gradient component
vel_componentThe velocity component

Definition at line 148 of file NavierStokesLHDGAssemblyHelper.C.

Referenced by NavierStokesLHDGKernel::computeResidual().

156 {
158  vel_gradient, body_force, JxW, qrule, current_elem, q_point, scalar_re);
159 
160  for (const auto qp : make_range(qrule.n_points()))
161  {
162  const auto rho_vel_cross_vel = rhoVelCrossVelResidual(_u_sol, _v_sol, qp, vel_component);
163  Gradient qp_p;
164  qp_p(vel_component) = _p_sol[qp];
165 
166  for (const auto i : index_range(scalar_re))
167  {
168  // Scalar equation dependence on pressure dofs
169  scalar_re(i) -= JxW[qp] * (_grad_scalar_phi[i][qp] * qp_p);
170 
171  // Scalar equation dependence on scalar dofs
172  scalar_re(i) -= JxW[qp] * (_grad_scalar_phi[i][qp] * rho_vel_cross_vel);
173  }
174  }
175 }
const MooseArray< Number > & _u_sol
const MooseArray< std::vector< RealVectorValue > > & _grad_scalar_phi
RealVectorValue rhoVelCrossVelResidual(const MooseArray< Number > &u_sol, const MooseArray< Number > &v_sol, const unsigned int qp, const unsigned int vel_component)
unsigned int n_points() const
void scalarVolumeResidual(const MooseArray< Gradient > &vector_field, const Moose::Functor< Real > &source, const MooseArray< Real > &JxW, const libMesh::QBase &qrule, const Elem *const current_elem, const MooseArray< Point > &q_point, DenseVector< Number > &scalar_re)
IntRange< T > make_range(T beg, T end)
auto index_range(const T &sizable)

◆ validParams()

InputParameters NavierStokesLHDGAssemblyHelper::validParams ( )
static

Definition at line 22 of file NavierStokesLHDGAssemblyHelper.C.

Referenced by NavierStokesLHDGKernel::validParams(), NavierStokesLHDGVelocityDirichletBC::validParams(), and NavierStokesLHDGOutflowBC::validParams().

23 {
25  params.addRequiredParam<NonlinearVariableName>(NS::pressure, "The pressure variable.");
26  params.addRequiredParam<NonlinearVariableName>("v", "The y-component of velocity");
27  params.addParam<NonlinearVariableName>("w", "The z-component of velocity");
28  params.renameParam("gradient_variable", "grad_u", "The gradient of the x-component of velocity");
29  params.addRequiredParam<NonlinearVariableName>("grad_v",
30  "The gradient of the y-component of velocity");
31  params.addParam<NonlinearVariableName>("grad_w", "The gradient of the z-component of velocity");
32  params.renameParam("face_variable", "face_u", "The x-component of the face velocity");
33  params.addRequiredParam<NonlinearVariableName>("face_v", "The y-component of the face velocity");
34  params.addParam<NonlinearVariableName>("face_w", "The z-component of the face velocity");
35  params.addParam<NonlinearVariableName>(
36  "enclosure_lm",
37  "For enclosed problems like the lid driven cavity this variable can be provided to remove "
38  "the pressure nullspace");
39  params.renameParam("diffusivity", NS::mu, "The dynamic viscosity");
40  params.addRequiredParam<Real>(NS::density, "The density");
41  return params;
42 }
static const std::string density
Definition: NS.h:33
static const std::string mu
Definition: NS.h:123
static InputParameters validParams()
DIE A HORRIBLE DEATH HERE typedef LIBMESH_DEFAULT_SCALAR_TYPE Real
static const std::string pressure
Definition: NS.h:56

Member Data Documentation

◆ _enclosure_lm_var

const MooseVariableScalar* const NavierStokesLHDGAssemblyHelper::_enclosure_lm_var
protected

◆ _global_lm_dof_indices

const std::vector<dof_id_type>* const NavierStokesLHDGAssemblyHelper::_global_lm_dof_indices
protected

◆ _global_lm_dof_value

const MooseArray<Number>* const NavierStokesLHDGAssemblyHelper::_global_lm_dof_value
protected

Definition at line 236 of file NavierStokesLHDGAssemblyHelper.h.

Referenced by pressureVolumeResidual().

◆ _global_lm_p_jac

DenseMatrix<Number> NavierStokesLHDGAssemblyHelper::_global_lm_p_jac
protected

◆ _global_lm_re

DenseVector<Number> NavierStokesLHDGAssemblyHelper::_global_lm_re
protected

◆ _grad_u_grad_u_jac

DenseMatrix<Number> NavierStokesLHDGAssemblyHelper::_grad_u_grad_u_jac
protected

◆ _grad_u_lm_u_jac

DenseMatrix<Number> NavierStokesLHDGAssemblyHelper::_grad_u_lm_u_jac
protected

◆ _grad_u_u_jac

DenseMatrix<Number> NavierStokesLHDGAssemblyHelper::_grad_u_u_jac
protected

◆ _grad_u_vel_re

DenseVector<Number> NavierStokesLHDGAssemblyHelper::_grad_u_vel_re
protected

◆ _grad_v_grad_v_jac

DenseMatrix<Number> NavierStokesLHDGAssemblyHelper::_grad_v_grad_v_jac
protected

◆ _grad_v_lm_v_jac

DenseMatrix<Number> NavierStokesLHDGAssemblyHelper::_grad_v_lm_v_jac
protected

◆ _grad_v_v_jac

DenseMatrix<Number> NavierStokesLHDGAssemblyHelper::_grad_v_v_jac
protected

◆ _grad_v_var

const MooseVariableFE<RealVectorValue>& NavierStokesLHDGAssemblyHelper::_grad_v_var
protected

◆ _grad_v_vel_re

DenseVector<Number> NavierStokesLHDGAssemblyHelper::_grad_v_vel_re
protected

◆ _grad_w_var

const MooseVariableFE<RealVectorValue>* const NavierStokesLHDGAssemblyHelper::_grad_w_var
protected

Definition at line 212 of file NavierStokesLHDGAssemblyHelper.h.

Referenced by NavierStokesLHDGAssemblyHelper().

◆ _lm_u_grad_u_jac

DenseMatrix<Number> NavierStokesLHDGAssemblyHelper::_lm_u_grad_u_jac
protected

◆ _lm_u_lm_u_jac

DenseMatrix<Number> NavierStokesLHDGAssemblyHelper::_lm_u_lm_u_jac
protected

◆ _lm_u_lm_v_jac

DenseMatrix<Number> NavierStokesLHDGAssemblyHelper::_lm_u_lm_v_jac
protected

◆ _lm_u_p_jac

DenseMatrix<Number> NavierStokesLHDGAssemblyHelper::_lm_u_p_jac
protected

◆ _lm_u_u_jac

DenseMatrix<Number> NavierStokesLHDGAssemblyHelper::_lm_u_u_jac
protected

◆ _lm_u_vel_re

DenseVector<Number> NavierStokesLHDGAssemblyHelper::_lm_u_vel_re
protected

◆ _lm_v_dof_indices

const std::vector<dof_id_type>& NavierStokesLHDGAssemblyHelper::_lm_v_dof_indices
protected

◆ _lm_v_grad_v_jac

DenseMatrix<Number> NavierStokesLHDGAssemblyHelper::_lm_v_grad_v_jac
protected

◆ _lm_v_lm_u_jac

DenseMatrix<Number> NavierStokesLHDGAssemblyHelper::_lm_v_lm_u_jac
protected

◆ _lm_v_lm_v_jac

DenseMatrix<Number> NavierStokesLHDGAssemblyHelper::_lm_v_lm_v_jac
protected

◆ _lm_v_p_jac

DenseMatrix<Number> NavierStokesLHDGAssemblyHelper::_lm_v_p_jac
protected

◆ _lm_v_sol

const MooseArray<Number>& NavierStokesLHDGAssemblyHelper::_lm_v_sol
protected

◆ _lm_v_v_jac

DenseMatrix<Number> NavierStokesLHDGAssemblyHelper::_lm_v_v_jac
protected

◆ _lm_v_vel_re

DenseVector<Number> NavierStokesLHDGAssemblyHelper::_lm_v_vel_re
protected

◆ _lm_w_dof_indices

const std::vector<dof_id_type>* const NavierStokesLHDGAssemblyHelper::_lm_w_dof_indices
protected

Definition at line 224 of file NavierStokesLHDGAssemblyHelper.h.

◆ _lm_w_sol

const MooseArray<Number>* const NavierStokesLHDGAssemblyHelper::_lm_w_sol
protected

Definition at line 234 of file NavierStokesLHDGAssemblyHelper.h.

◆ _p_dof_indices

const std::vector<dof_id_type>& NavierStokesLHDGAssemblyHelper::_p_dof_indices
protected

◆ _p_global_lm_jac

DenseMatrix<Number> NavierStokesLHDGAssemblyHelper::_p_global_lm_jac
protected

◆ _p_lm_u_jac

DenseMatrix<Number> NavierStokesLHDGAssemblyHelper::_p_lm_u_jac
protected

◆ _p_lm_v_jac

DenseMatrix<Number> NavierStokesLHDGAssemblyHelper::_p_lm_v_jac
protected

◆ _p_re

DenseVector<Number> NavierStokesLHDGAssemblyHelper::_p_re
protected

◆ _p_sol

const MooseArray<Number>& NavierStokesLHDGAssemblyHelper::_p_sol
protected

◆ _p_u_jac

DenseMatrix<Number> NavierStokesLHDGAssemblyHelper::_p_u_jac
protected

◆ _p_v_jac

DenseMatrix<Number> NavierStokesLHDGAssemblyHelper::_p_v_jac
protected

◆ _pressure_var

const MooseVariableFE<Real>& NavierStokesLHDGAssemblyHelper::_pressure_var
protected

◆ _qv_dof_indices

const std::vector<dof_id_type>& NavierStokesLHDGAssemblyHelper::_qv_dof_indices
protected

◆ _qv_sol

const MooseArray<Gradient>& NavierStokesLHDGAssemblyHelper::_qv_sol
protected

◆ _qw_dof_indices

const std::vector<dof_id_type>* const NavierStokesLHDGAssemblyHelper::_qw_dof_indices
protected

Definition at line 222 of file NavierStokesLHDGAssemblyHelper.h.

◆ _qw_sol

const MooseArray<Gradient>* const NavierStokesLHDGAssemblyHelper::_qw_sol
protected

Definition at line 232 of file NavierStokesLHDGAssemblyHelper.h.

◆ _rho

const Real NavierStokesLHDGAssemblyHelper::_rho
protected

◆ _u_grad_u_jac

DenseMatrix<Number> NavierStokesLHDGAssemblyHelper::_u_grad_u_jac
protected

◆ _u_lm_u_jac

DenseMatrix<Number> NavierStokesLHDGAssemblyHelper::_u_lm_u_jac
protected

◆ _u_lm_v_jac

DenseMatrix<Number> NavierStokesLHDGAssemblyHelper::_u_lm_v_jac
protected

◆ _u_p_jac

DenseMatrix<Number> NavierStokesLHDGAssemblyHelper::_u_p_jac
protected

◆ _u_u_jac

DenseMatrix<Number> NavierStokesLHDGAssemblyHelper::_u_u_jac
protected

◆ _u_v_jac

DenseMatrix<Number> NavierStokesLHDGAssemblyHelper::_u_v_jac
protected

◆ _u_vel_re

DenseVector<Number> NavierStokesLHDGAssemblyHelper::_u_vel_re
protected

◆ _v_dof_indices

const std::vector<dof_id_type>& NavierStokesLHDGAssemblyHelper::_v_dof_indices
protected

◆ _v_face_var

const MooseVariableFE<Real>& NavierStokesLHDGAssemblyHelper::_v_face_var
protected

◆ _v_grad_v_jac

DenseMatrix<Number> NavierStokesLHDGAssemblyHelper::_v_grad_v_jac
protected

◆ _v_lm_u_jac

DenseMatrix<Number> NavierStokesLHDGAssemblyHelper::_v_lm_u_jac
protected

◆ _v_lm_v_jac

DenseMatrix<Number> NavierStokesLHDGAssemblyHelper::_v_lm_v_jac
protected

◆ _v_p_jac

DenseMatrix<Number> NavierStokesLHDGAssemblyHelper::_v_p_jac
protected

◆ _v_sol

const MooseArray<Number>& NavierStokesLHDGAssemblyHelper::_v_sol
protected

◆ _v_u_jac

DenseMatrix<Number> NavierStokesLHDGAssemblyHelper::_v_u_jac
protected

◆ _v_v_jac

DenseMatrix<Number> NavierStokesLHDGAssemblyHelper::_v_v_jac
protected

◆ _v_var

const MooseVariableFE<Real>& NavierStokesLHDGAssemblyHelper::_v_var
protected

◆ _v_vel_re

DenseVector<Number> NavierStokesLHDGAssemblyHelper::_v_vel_re
protected

◆ _w_dof_indices

const std::vector<dof_id_type>* const NavierStokesLHDGAssemblyHelper::_w_dof_indices
protected

Definition at line 223 of file NavierStokesLHDGAssemblyHelper.h.

◆ _w_face_var

const MooseVariableFE<Real>* const NavierStokesLHDGAssemblyHelper::_w_face_var
protected

Definition at line 214 of file NavierStokesLHDGAssemblyHelper.h.

Referenced by NavierStokesLHDGAssemblyHelper().

◆ _w_sol

const MooseArray<Number>* const NavierStokesLHDGAssemblyHelper::_w_sol
protected

Definition at line 233 of file NavierStokesLHDGAssemblyHelper.h.

◆ _w_var

const MooseVariableFE<Real>* const NavierStokesLHDGAssemblyHelper::_w_var
protected

Definition at line 210 of file NavierStokesLHDGAssemblyHelper.h.

Referenced by NavierStokesLHDGAssemblyHelper().


The documentation for this class was generated from the following files: