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>
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 ¶ms) |
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) |
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.
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.
|
protected |
Definition at line 478 of file NavierStokesLHDGAssemblyHelper.C.
Referenced by NavierStokesLHDGOutflowBC::computeJacobian(), and NavierStokesLHDGKernel::computeJacobianOnSide().
|
protected |
Definition at line 444 of file NavierStokesLHDGAssemblyHelper.C.
Referenced by NavierStokesLHDGOutflowBC::computeResidual(), and NavierStokesLHDGKernel::computeResidualOnSide().
|
protected |
Definition at line 525 of file NavierStokesLHDGAssemblyHelper.C.
Referenced by NavierStokesLHDGVelocityDirichletBC::computeResidual().
|
protected |
Definition at line 337 of file NavierStokesLHDGAssemblyHelper.C.
Referenced by NavierStokesLHDGOutflowBC::computeJacobian(), and NavierStokesLHDGKernel::computeJacobianOnSide().
|
protected |
Definition at line 322 of file NavierStokesLHDGAssemblyHelper.C.
Referenced by NavierStokesLHDGOutflowBC::computeResidual(), and NavierStokesLHDGKernel::computeResidualOnSide().
|
protected |
Compute the volumetric contributions to the pressure Jacobian, e.g.
the conservation of mass equation
i_offset | The local degree of freedom offset for the pressure |
u_j_offset | The local degree of freedom offset for the x-component of velocity |
v_j_offset | The local degree of freedom offset for the y-component of velocity |
p_j_offset | The local degree of freedom offset for the pressure |
global_lm_i_offset | The 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().
|
protected |
Compute the volumetric contributions to the pressure residual, e.g.
the conservation of mass equation
i_offset | The local degree of freedom offset for the pressure |
global_lm_i_offset | The 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().
|
protected |
u_sol | The x-velocity solution, can correspond to either the volumetric or face velocity |
v_sol | The 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().
|
protected |
u_sol | The x-velocity solution, can correspond to either the volumetric or face velocity |
v_sol | The 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().
|
protected |
Definition at line 600 of file NavierStokesLHDGAssemblyHelper.C.
Referenced by NavierStokesLHDGVelocityDirichletBC::computeJacobian().
|
protected |
Definition at line 550 of file NavierStokesLHDGAssemblyHelper.C.
Referenced by NavierStokesLHDGVelocityDirichletBC::computeResidual().
|
protected |
Definition at line 393 of file NavierStokesLHDGAssemblyHelper.C.
Referenced by NavierStokesLHDGOutflowBC::computeJacobian(), and NavierStokesLHDGKernel::computeJacobianOnSide().
|
protected |
Definition at line 363 of file NavierStokesLHDGAssemblyHelper.C.
Referenced by NavierStokesLHDGOutflowBC::computeResidual(), and NavierStokesLHDGKernel::computeResidualOnSide().
|
protected |
Compute the volumetric contributions to a velocity Jacobian.
i_offset | The local degree of freedom offset for the velocity component |
vel_gradient_j_offset | The local degree of freedom offset for the associated velocity gradient |
p_j_offset | The local degree of freedom offset for the pressure |
vel_component | The velocity component |
u_j_offset | The local degree of freedom offset for the x-component velocity |
v_j_offset | The local degree of freedom offset for the y-component velocity |
Definition at line 178 of file NavierStokesLHDGAssemblyHelper.C.
Referenced by NavierStokesLHDGKernel::computeJacobian().
|
protected |
Compute the volumetric contributions to a velocity residual for a provided velocity gradient and stress.
i_offset | The local degree of freedom offset for the velocity component |
vel_gradient | The velocity gradient component |
vel_component | The velocity component |
Definition at line 148 of file NavierStokesLHDGAssemblyHelper.C.
Referenced by NavierStokesLHDGKernel::computeResidual().
|
static |
Definition at line 22 of file NavierStokesLHDGAssemblyHelper.C.
Referenced by NavierStokesLHDGKernel::validParams(), NavierStokesLHDGVelocityDirichletBC::validParams(), and NavierStokesLHDGOutflowBC::validParams().
|
protected |
Definition at line 216 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGKernel::additionalROVariables(), NavierStokesLHDGKernel::computeJacobian(), NavierStokesLHDGKernel::computeResidual(), pressureVolumeJacobian(), and pressureVolumeResidual().
|
protected |
Definition at line 226 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGKernel::computeJacobian(), and NavierStokesLHDGKernel::computeResidual().
|
protected |
Definition at line 236 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by pressureVolumeResidual().
|
protected |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGKernel::computeJacobian().
|
protected |
Definition at line 241 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGKernel::computeResidual().
|
protected |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGKernel::computeJacobian().
|
protected |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGOutflowBC::computeJacobian(), and NavierStokesLHDGKernel::computeJacobianOnSide().
|
protected |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGKernel::computeJacobian().
|
protected |
|
protected |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGKernel::computeJacobian().
|
protected |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGOutflowBC::computeJacobian(), and NavierStokesLHDGKernel::computeJacobianOnSide().
|
protected |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGKernel::computeJacobian().
|
protected |
Definition at line 211 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGKernel::additionalROVariables(), NavierStokesLHDGKernel::computeJacobian(), NavierStokesLHDGOutflowBC::computeJacobian(), NavierStokesLHDGKernel::computeJacobianOnSide(), NavierStokesLHDGKernel::computeResidual(), NavierStokesLHDGVelocityDirichletBC::computeResidual(), NavierStokesLHDGOutflowBC::computeResidual(), NavierStokesLHDGKernel::computeResidualOnSide(), and NavierStokesLHDGAssemblyHelper().
|
protected |
|
protected |
Definition at line 212 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGAssemblyHelper().
|
protected |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGOutflowBC::computeJacobian(), and NavierStokesLHDGKernel::computeJacobianOnSide().
|
protected |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGVelocityDirichletBC::computeJacobian(), NavierStokesLHDGOutflowBC::computeJacobian(), and NavierStokesLHDGKernel::computeJacobianOnSide().
|
protected |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGOutflowBC::computeJacobian(), and NavierStokesLHDGKernel::computeJacobianOnSide().
|
protected |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGOutflowBC::computeJacobian(), and NavierStokesLHDGKernel::computeJacobianOnSide().
|
protected |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGOutflowBC::computeJacobian(), and NavierStokesLHDGKernel::computeJacobianOnSide().
|
protected |
Definition at line 241 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGVelocityDirichletBC::computeResidual(), NavierStokesLHDGOutflowBC::computeResidual(), and NavierStokesLHDGKernel::computeResidualOnSide().
|
protected |
Definition at line 221 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGVelocityDirichletBC::computeJacobian(), NavierStokesLHDGOutflowBC::computeJacobian(), NavierStokesLHDGKernel::computeJacobianOnSide(), NavierStokesLHDGVelocityDirichletBC::computeResidual(), NavierStokesLHDGOutflowBC::computeResidual(), and NavierStokesLHDGKernel::computeResidualOnSide().
|
protected |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGOutflowBC::computeJacobian(), and NavierStokesLHDGKernel::computeJacobianOnSide().
|
protected |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGOutflowBC::computeJacobian(), and NavierStokesLHDGKernel::computeJacobianOnSide().
|
protected |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGVelocityDirichletBC::computeJacobian(), NavierStokesLHDGOutflowBC::computeJacobian(), and NavierStokesLHDGKernel::computeJacobianOnSide().
|
protected |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGOutflowBC::computeJacobian(), and NavierStokesLHDGKernel::computeJacobianOnSide().
|
protected |
Definition at line 231 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGVelocityDirichletBC::computeResidual(), NavierStokesLHDGOutflowBC::computeResidual(), NavierStokesLHDGKernel::computeResidualOnSide(), lmFaceJacobian(), lmFaceResidual(), pressureFaceResidual(), scalarFaceJacobian(), and scalarFaceResidual().
|
protected |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGOutflowBC::computeJacobian(), and NavierStokesLHDGKernel::computeJacobianOnSide().
|
protected |
Definition at line 241 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGVelocityDirichletBC::computeResidual(), NavierStokesLHDGOutflowBC::computeResidual(), and NavierStokesLHDGKernel::computeResidualOnSide().
|
protected |
Definition at line 224 of file NavierStokesLHDGAssemblyHelper.h.
|
protected |
Definition at line 234 of file NavierStokesLHDGAssemblyHelper.h.
|
protected |
Definition at line 225 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGVelocityDirichletBC::computeJacobian(), NavierStokesLHDGKernel::computeJacobian(), NavierStokesLHDGOutflowBC::computeJacobian(), NavierStokesLHDGKernel::computeJacobianOnSide(), NavierStokesLHDGKernel::computeResidual(), NavierStokesLHDGVelocityDirichletBC::computeResidual(), NavierStokesLHDGOutflowBC::computeResidual(), and NavierStokesLHDGKernel::computeResidualOnSide().
|
protected |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGKernel::computeJacobian().
|
protected |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGOutflowBC::computeJacobian(), and NavierStokesLHDGKernel::computeJacobianOnSide().
|
protected |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGOutflowBC::computeJacobian(), and NavierStokesLHDGKernel::computeJacobianOnSide().
|
protected |
|
protected |
Definition at line 235 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by lmFaceResidual(), pressureVolumeResidual(), scalarDirichletResidual(), scalarFaceResidual(), and scalarVolumeResidual().
|
protected |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGKernel::computeJacobian().
|
protected |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGKernel::computeJacobian().
|
protected |
Definition at line 215 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGKernel::additionalROVariables(), NavierStokesLHDGKernel::computeJacobian(), NavierStokesLHDGOutflowBC::computeJacobian(), NavierStokesLHDGKernel::computeJacobianOnSide(), NavierStokesLHDGKernel::computeResidual(), NavierStokesLHDGVelocityDirichletBC::computeResidual(), NavierStokesLHDGOutflowBC::computeResidual(), NavierStokesLHDGKernel::computeResidualOnSide(), and NavierStokesLHDGAssemblyHelper().
|
protected |
Containers for dof indices.
Definition at line 219 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGVelocityDirichletBC::computeJacobian(), NavierStokesLHDGKernel::computeJacobian(), NavierStokesLHDGOutflowBC::computeJacobian(), NavierStokesLHDGKernel::computeJacobianOnSide(), NavierStokesLHDGKernel::computeResidual(), NavierStokesLHDGVelocityDirichletBC::computeResidual(), NavierStokesLHDGOutflowBC::computeResidual(), and NavierStokesLHDGKernel::computeResidualOnSide().
|
protected |
local solutions at quadrature points
Definition at line 229 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGKernel::computeResidual(), NavierStokesLHDGVelocityDirichletBC::computeResidual(), NavierStokesLHDGOutflowBC::computeResidual(), and NavierStokesLHDGKernel::computeResidualOnSide().
|
protected |
Definition at line 222 of file NavierStokesLHDGAssemblyHelper.h.
|
protected |
Definition at line 232 of file NavierStokesLHDGAssemblyHelper.h.
|
protected |
The density.
Definition at line 239 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by rhoVelCrossVelJacobian(), rhoVelCrossVelResidual(), and scalarDirichletResidual().
|
protected |
|
protected |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGOutflowBC::computeJacobian(), and NavierStokesLHDGKernel::computeJacobianOnSide().
|
protected |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGOutflowBC::computeJacobian(), and NavierStokesLHDGKernel::computeJacobianOnSide().
|
protected |
|
protected |
|
protected |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGKernel::computeJacobian().
|
protected |
|
protected |
Definition at line 220 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGVelocityDirichletBC::computeJacobian(), NavierStokesLHDGKernel::computeJacobian(), NavierStokesLHDGOutflowBC::computeJacobian(), NavierStokesLHDGKernel::computeJacobianOnSide(), NavierStokesLHDGKernel::computeResidual(), NavierStokesLHDGVelocityDirichletBC::computeResidual(), NavierStokesLHDGOutflowBC::computeResidual(), and NavierStokesLHDGKernel::computeResidualOnSide().
|
protected |
Definition at line 213 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGKernel::additionalROVariables(), NavierStokesLHDGVelocityDirichletBC::computeJacobian(), NavierStokesLHDGOutflowBC::computeJacobian(), NavierStokesLHDGKernel::computeJacobianOnSide(), NavierStokesLHDGVelocityDirichletBC::computeResidual(), NavierStokesLHDGOutflowBC::computeResidual(), NavierStokesLHDGKernel::computeResidualOnSide(), and NavierStokesLHDGAssemblyHelper().
|
protected |
|
protected |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGOutflowBC::computeJacobian(), and NavierStokesLHDGKernel::computeJacobianOnSide().
|
protected |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGOutflowBC::computeJacobian(), and NavierStokesLHDGKernel::computeJacobianOnSide().
|
protected |
|
protected |
Definition at line 230 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGKernel::computeResidual(), NavierStokesLHDGVelocityDirichletBC::computeResidual(), NavierStokesLHDGOutflowBC::computeResidual(), NavierStokesLHDGKernel::computeResidualOnSide(), pressureVolumeResidual(), scalarVolumeJacobian(), and scalarVolumeResidual().
|
protected |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGKernel::computeJacobian().
|
protected |
|
protected |
Definition at line 209 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGKernel::additionalROVariables(), NavierStokesLHDGVelocityDirichletBC::computeJacobian(), NavierStokesLHDGKernel::computeJacobian(), NavierStokesLHDGOutflowBC::computeJacobian(), NavierStokesLHDGKernel::computeJacobianOnSide(), NavierStokesLHDGKernel::computeResidual(), NavierStokesLHDGVelocityDirichletBC::computeResidual(), NavierStokesLHDGOutflowBC::computeResidual(), NavierStokesLHDGKernel::computeResidualOnSide(), and NavierStokesLHDGAssemblyHelper().
|
protected |
|
protected |
Definition at line 223 of file NavierStokesLHDGAssemblyHelper.h.
|
protected |
Definition at line 214 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGAssemblyHelper().
|
protected |
Definition at line 233 of file NavierStokesLHDGAssemblyHelper.h.
|
protected |
Definition at line 210 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGAssemblyHelper().