Implements the steady incompressible Navier-Stokes equations for a hybridized discretization. More...
#include <NavierStokesLHDGKernel.h>
Public Types | |
enum | ResidualTagType { ResidualTagType::NonReference, ResidualTagType::Reference } |
typedef DataFileName | DataFileParameterType |
Public Member Functions | |
NavierStokesLHDGKernel (const InputParameters ¶meters) | |
virtual void | computeResidual () override |
virtual void | computeJacobian () override |
Compute this object's entire element interior Jacobian, both on- and off-diagonal. More... | |
virtual void | computeOffDiagJacobian (unsigned int jvar) override |
Forwards to computeJacobian() the first time this is called for a given element. More... | |
virtual void | computeResidualOnSide () override |
virtual void | computeJacobianOnSide () override |
virtual void | initialSetup () override |
virtual void | jacobianSetup () override |
virtual std::set< std::string > | additionalROVariables () override |
virtual void | computeResidualAndJacobianOnSide () |
virtual void | computeResidualAndJacobian () override |
virtual void | computeOffDiagJacobianScalar (unsigned int jvar) override |
virtual const MooseVariable & | variable () const override |
virtual void | computeNonlocalJacobian () |
virtual void | computeNonlocalOffDiagJacobian (unsigned int) |
const SubProblem & | subProblem () const |
virtual void | prepareShapes (unsigned int var_num) |
virtual bool | enabled () const |
std::shared_ptr< MooseObject > | getSharedPtr () |
std::shared_ptr< const MooseObject > | getSharedPtr () const |
MooseApp & | getMooseApp () const |
const std::string & | type () const |
virtual const std::string & | name () const |
std::string | typeAndName () const |
std::string | errorPrefix (const std::string &error_type) const |
void | callMooseError (std::string msg, const bool with_prefix) const |
MooseObjectParameterName | uniqueParameterName (const std::string ¶meter_name) const |
const InputParameters & | parameters () const |
MooseObjectName | uniqueName () const |
const T & | getParam (const std::string &name) const |
std::vector< std::pair< T1, T2 > > | getParam (const std::string ¶m1, const std::string ¶m2) const |
const T * | queryParam (const std::string &name) const |
const T & | getRenamedParam (const std::string &old_name, const std::string &new_name) const |
T | getCheckedPointerParam (const std::string &name, const std::string &error_string="") const |
bool | isParamValid (const std::string &name) const |
bool | isParamSetByUser (const std::string &nm) const |
void | paramError (const std::string ¶m, Args... args) const |
void | paramWarning (const std::string ¶m, Args... args) const |
void | paramInfo (const std::string ¶m, Args... args) const |
void | connectControllableParams (const std::string ¶meter, const std::string &object_type, const std::string &object_name, const std::string &object_parameter) const |
void | mooseError (Args &&... args) const |
void | mooseErrorNonPrefixed (Args &&... args) const |
void | mooseDocumentedError (const std::string &repo_name, const unsigned int issue_num, Args &&... args) const |
void | mooseWarning (Args &&... args) const |
void | mooseWarningNonPrefixed (Args &&... args) const |
void | mooseDeprecated (Args &&... args) const |
void | mooseInfo (Args &&... args) const |
std::string | getDataFileName (const std::string ¶m) const |
std::string | getDataFileNameByName (const std::string &relative_path) const |
std::string | getDataFilePath (const std::string &relative_path) const |
virtual void | timestepSetup () |
virtual void | residualSetup () |
virtual void | subdomainSetup () |
virtual void | customSetup (const ExecFlagType &) |
const ExecFlagEnum & | getExecuteOnEnum () const |
const Function & | getFunction (const std::string &name) const |
const Function & | getFunctionByName (const FunctionName &name) const |
bool | hasFunction (const std::string ¶m_name) const |
bool | hasFunctionByName (const FunctionName &name) const |
UserObjectName | getUserObjectName (const std::string ¶m_name) const |
const T & | getUserObject (const std::string ¶m_name, bool is_dependency=true) const |
const T & | getUserObjectByName (const UserObjectName &object_name, bool is_dependency=true) const |
const UserObject & | getUserObjectBase (const std::string ¶m_name, bool is_dependency=true) const |
const UserObject & | getUserObjectBaseByName (const UserObjectName &object_name, bool is_dependency=true) const |
bool | isImplicit () |
Moose::StateArg | determineState () const |
bool | isDefaultPostprocessorValue (const std::string ¶m_name, const unsigned int index=0) const |
bool | hasPostprocessor (const std::string ¶m_name, const unsigned int index=0) const |
bool | hasPostprocessorByName (const PostprocessorName &name) const |
std::size_t | coupledPostprocessors (const std::string ¶m_name) const |
const PostprocessorName & | getPostprocessorName (const std::string ¶m_name, const unsigned int index=0) const |
const VectorPostprocessorValue & | getVectorPostprocessorValue (const std::string ¶m_name, const std::string &vector_name) const |
const VectorPostprocessorValue & | getVectorPostprocessorValue (const std::string ¶m_name, const std::string &vector_name, bool needs_broadcast) const |
const VectorPostprocessorValue & | getVectorPostprocessorValueByName (const VectorPostprocessorName &name, const std::string &vector_name) const |
const VectorPostprocessorValue & | getVectorPostprocessorValueByName (const VectorPostprocessorName &name, const std::string &vector_name, bool needs_broadcast) const |
const VectorPostprocessorValue & | getVectorPostprocessorValueOld (const std::string ¶m_name, const std::string &vector_name) const |
const VectorPostprocessorValue & | getVectorPostprocessorValueOld (const std::string ¶m_name, const std::string &vector_name, bool needs_broadcast) const |
const VectorPostprocessorValue & | getVectorPostprocessorValueOldByName (const VectorPostprocessorName &name, const std::string &vector_name) const |
const VectorPostprocessorValue & | getVectorPostprocessorValueOldByName (const VectorPostprocessorName &name, const std::string &vector_name, bool needs_broadcast) const |
const ScatterVectorPostprocessorValue & | getScatterVectorPostprocessorValue (const std::string ¶m_name, const std::string &vector_name) const |
const ScatterVectorPostprocessorValue & | getScatterVectorPostprocessorValueByName (const VectorPostprocessorName &name, const std::string &vector_name) const |
const ScatterVectorPostprocessorValue & | getScatterVectorPostprocessorValueOld (const std::string ¶m_name, const std::string &vector_name) const |
const ScatterVectorPostprocessorValue & | getScatterVectorPostprocessorValueOldByName (const VectorPostprocessorName &name, const std::string &vector_name) const |
bool | hasVectorPostprocessor (const std::string ¶m_name, const std::string &vector_name) const |
bool | hasVectorPostprocessor (const std::string ¶m_name) const |
bool | hasVectorPostprocessorByName (const VectorPostprocessorName &name, const std::string &vector_name) const |
bool | hasVectorPostprocessorByName (const VectorPostprocessorName &name) const |
const VectorPostprocessorName & | getVectorPostprocessorName (const std::string ¶m_name) const |
void | setRandomResetFrequency (ExecFlagType exec_flag) |
unsigned long | getRandomLong () const |
Real | getRandomReal () const |
unsigned int | getSeed (std::size_t id) |
unsigned int | getMasterSeed () const |
bool | isNodal () const |
ExecFlagType | getResetOnTime () const |
void | setRandomDataPointer (RandomData *random_data) |
virtual void | meshChanged () |
void | useVectorTag (const TagName &tag_name, VectorTagsKey) |
void | useVectorTag (TagID tag_id, VectorTagsKey) |
void | useMatrixTag (const TagName &tag_name, MatrixTagsKey) |
void | useMatrixTag (TagID tag_id, MatrixTagsKey) |
bool | isVectorTagged () |
bool | isMatrixTagged () |
bool | hasVectorTags () const |
const std::set< TagID > & | getVectorTags (VectorTagsKey) const |
const std::set< TagID > & | getMatrixTags (MatrixTagsKey) const |
const std::vector< SubdomainName > & | blocks () const |
unsigned int | numBlocks () const |
virtual const std::set< SubdomainID > & | blockIDs () const |
unsigned int | blocksMaxDimension () const |
bool | hasBlocks (const SubdomainName &name) const |
bool | hasBlocks (const std::vector< SubdomainName > &names) const |
bool | hasBlocks (const std::set< SubdomainName > &names) const |
bool | hasBlocks (SubdomainID id) const |
bool | hasBlocks (const std::vector< SubdomainID > &ids) const |
bool | hasBlocks (const std::set< SubdomainID > &ids) const |
bool | isBlockSubset (const std::set< SubdomainID > &ids) const |
bool | isBlockSubset (const std::vector< SubdomainID > &ids) const |
bool | hasBlockMaterialProperty (const std::string &prop_name) |
const std::set< SubdomainID > & | meshBlockIDs () const |
virtual bool | blockRestricted () const |
virtual void | checkVariable (const MooseVariableFieldBase &variable) const |
virtual const VariableValue & | coupledValueByName (const std::string &var_name) |
virtual const ArrayVariableValue & | coupledArrayValueByName (const std::string &var_name) |
const std::unordered_map< std::string, std::vector< MooseVariableFieldBase *> > & | getCoupledVars () const |
const std::vector< MooseVariableFieldBase *> & | getCoupledMooseVars () const |
const std::vector< MooseVariable *> & | getCoupledStandardMooseVars () const |
const std::vector< VectorMooseVariable *> & | getCoupledVectorMooseVars () const |
const std::vector< ArrayMooseVariable *> & | getCoupledArrayMooseVars () const |
void | addFEVariableCoupleableVectorTag (TagID tag) |
void | addFEVariableCoupleableMatrixTag (TagID tag) |
std::set< TagID > & | getFEVariableCoupleableVectorTags () |
const std::set< TagID > & | getFEVariableCoupleableVectorTags () const |
std::set< TagID > & | getFEVariableCoupleableMatrixTags () |
const std::set< TagID > & | getFEVariableCoupleableMatrixTags () const |
auto & | getWritableCoupledVariables () const |
bool | hasWritableCoupledVariables () const |
const ADVariableValue * | getADDefaultValue (const std::string &var_name) const |
const ADVectorVariableValue * | getADDefaultVectorValue (const std::string &var_name) const |
const ADVariableGradient & | getADDefaultGradient () const |
const ADVectorVariableGradient & | getADDefaultVectorGradient () const |
const ADVariableSecond & | getADDefaultSecond () const |
const ADVectorVariableCurl & | getADDefaultCurl () const |
const std::vector< MooseVariableScalar *> & | getCoupledMooseScalarVars () |
const std::set< TagID > & | getScalarVariableCoupleableVectorTags () const |
const std::set< TagID > & | getScalarVariableCoupleableMatrixTags () const |
const std::set< MooseVariableFieldBase *> & | getMooseVariableDependencies () const |
std::set< MooseVariableFieldBase *> | checkAllVariables (const DofObjectType &dof_object, const std::set< MooseVariableFieldBase * > &vars_to_omit={}) |
std::set< MooseVariableFieldBase *> | checkVariables (const DofObjectType &dof_object, const std::set< MooseVariableFieldBase * > &vars_to_check) |
void | addMooseVariableDependency (MooseVariableFieldBase *var) |
void | addMooseVariableDependency (const std::vector< MooseVariableFieldBase * > &vars) |
const GenericMaterialProperty< T, is_ad > & | getGenericMaterialProperty (const std::string &name, MaterialData &material_data, const unsigned int state=0) |
const GenericMaterialProperty< T, is_ad > & | getGenericMaterialProperty (const std::string &name, const unsigned int state=0) |
const GenericMaterialProperty< T, is_ad > & | getGenericMaterialProperty (const std::string &name, const unsigned int state=0) |
const MaterialProperty< T > & | getMaterialProperty (const std::string &name, MaterialData &material_data, const unsigned int state=0) |
const MaterialProperty< T > & | getMaterialProperty (const std::string &name, const unsigned int state=0) |
const MaterialProperty< T > & | getMaterialProperty (const std::string &name, const unsigned int state=0) |
const ADMaterialProperty< T > & | getADMaterialProperty (const std::string &name, MaterialData &material_data) |
const ADMaterialProperty< T > & | getADMaterialProperty (const std::string &name) |
const ADMaterialProperty< T > & | getADMaterialProperty (const std::string &name) |
const MaterialProperty< T > & | getMaterialPropertyOld (const std::string &name, MaterialData &material_data) |
const MaterialProperty< T > & | getMaterialPropertyOld (const std::string &name) |
const MaterialProperty< T > & | getMaterialPropertyOld (const std::string &name) |
const MaterialProperty< T > & | getMaterialPropertyOlder (const std::string &name, MaterialData &material_data) |
const MaterialProperty< T > & | getMaterialPropertyOlder (const std::string &name) |
const MaterialProperty< T > & | getMaterialPropertyOlder (const std::string &name) |
const GenericMaterialProperty< T, is_ad > & | getGenericMaterialPropertyByName (const MaterialPropertyName &name, MaterialData &material_data, const unsigned int state) |
const GenericMaterialProperty< T, is_ad > & | getGenericMaterialPropertyByName (const MaterialPropertyName &name, const unsigned int state=0) |
const GenericMaterialProperty< T, is_ad > & | getGenericMaterialPropertyByName (const MaterialPropertyName &name, const unsigned int state=0) |
const MaterialProperty< T > & | getMaterialPropertyByName (const MaterialPropertyName &name, MaterialData &material_data, const unsigned int state=0) |
const MaterialProperty< T > & | getMaterialPropertyByName (const MaterialPropertyName &name, const unsigned int state=0) |
const MaterialProperty< T > & | getMaterialPropertyByName (const MaterialPropertyName &name, const unsigned int state=0) |
const ADMaterialProperty< T > & | getADMaterialPropertyByName (const MaterialPropertyName &name, MaterialData &material_data) |
const ADMaterialProperty< T > & | getADMaterialPropertyByName (const MaterialPropertyName &name) |
const ADMaterialProperty< T > & | getADMaterialPropertyByName (const MaterialPropertyName &name) |
const MaterialProperty< T > & | getMaterialPropertyOldByName (const MaterialPropertyName &name, MaterialData &material_data) |
const MaterialProperty< T > & | getMaterialPropertyOldByName (const MaterialPropertyName &name) |
const MaterialProperty< T > & | getMaterialPropertyOldByName (const MaterialPropertyName &name) |
const MaterialProperty< T > & | getMaterialPropertyOlderByName (const MaterialPropertyName &name, MaterialData &material_data) |
const MaterialProperty< T > & | getMaterialPropertyOlderByName (const MaterialPropertyName &name) |
const MaterialProperty< T > & | getMaterialPropertyOlderByName (const MaterialPropertyName &name) |
std::pair< const MaterialProperty< T > *, std::set< SubdomainID > > | getBlockMaterialProperty (const MaterialPropertyName &name) |
const GenericMaterialProperty< T, is_ad > & | getGenericZeroMaterialProperty (const std::string &name) |
const GenericMaterialProperty< T, is_ad > & | getGenericZeroMaterialProperty () |
const GenericMaterialProperty< T, is_ad > & | getGenericZeroMaterialPropertyByName (const std::string &prop_name) |
const MaterialProperty< T > & | getZeroMaterialProperty (Ts... args) |
std::set< SubdomainID > | getMaterialPropertyBlocks (const std::string &name) |
std::vector< SubdomainName > | getMaterialPropertyBlockNames (const std::string &name) |
std::set< BoundaryID > | getMaterialPropertyBoundaryIDs (const std::string &name) |
std::vector< BoundaryName > | getMaterialPropertyBoundaryNames (const std::string &name) |
void | checkBlockAndBoundaryCompatibility (std::shared_ptr< MaterialBase > discrete) |
std::unordered_map< SubdomainID, std::vector< MaterialBase *> > | buildRequiredMaterials (bool allow_stateful=true) |
void | statefulPropertiesAllowed (bool) |
bool | getMaterialPropertyCalled () const |
virtual const std::unordered_set< unsigned int > & | getMatPropDependencies () const |
virtual void | resolveOptionalProperties () |
const GenericMaterialProperty< T, is_ad > & | getPossiblyConstantGenericMaterialPropertyByName (const MaterialPropertyName &prop_name, MaterialData &material_data, const unsigned int state) |
virtual unsigned int | getElementIDIndex (const std::string &id_parameter_name, unsigned int comp=0) const |
virtual unsigned int | getElementIDIndexByName (const std::string &id_name) const |
virtual const dof_id_type & | getElementID (const std::string &id_parameter_name, unsigned int comp=0) const |
dof_id_type | getElementID (const Elem *elem, unsigned int elem_id_index) const |
virtual const dof_id_type & | getElementIDNeighbor (const std::string &id_parameter_name, unsigned int comp=0) const |
virtual const dof_id_type & | getElementIDByName (const std::string &id_name) const |
virtual const dof_id_type & | getElementIDNeighborByName (const std::string &id_name) const |
bool | hasElementID (const std::string &id_name) const |
dof_id_type | maxElementID (unsigned int elem_id_index) const |
dof_id_type | minElementID (unsigned int elem_id_index) const |
bool | areElemIDsIdentical (const std::string &id_name1, const std::string &id_name2) const |
std::unordered_map< dof_id_type, std::set< dof_id_type > > | getElemIDMapping (const std::string &id_name1, const std::string &id_name2) const |
std::set< dof_id_type > | getAllElemIDs (unsigned int elem_id_index) const |
std::set< dof_id_type > | getElemIDsOnBlocks (unsigned int elem_id_index, const std::set< SubdomainID > &blks) const |
MooseVariableBase * | mooseVariableBase () const |
MooseVariableField< Real > & | mooseVariableField () |
MooseVariableFE< Real > * | mooseVariable () const |
MooseVariableFV< Real > * | mooseVariableFV () const |
MooseLinearVariableFV< Real > * | mooseLinearVariableFV () const |
bool | hasUserObject (const std::string ¶m_name) const |
bool | hasUserObject (const std::string ¶m_name) const |
bool | hasUserObject (const std::string ¶m_name) const |
bool | hasUserObject (const std::string ¶m_name) const |
bool | hasUserObjectByName (const UserObjectName &object_name) const |
bool | hasUserObjectByName (const UserObjectName &object_name) const |
bool | hasUserObjectByName (const UserObjectName &object_name) const |
bool | hasUserObjectByName (const UserObjectName &object_name) const |
const PostprocessorValue & | getPostprocessorValue (const std::string ¶m_name, const unsigned int index=0) const |
const PostprocessorValue & | getPostprocessorValue (const std::string ¶m_name, const unsigned int index=0) const |
const PostprocessorValue & | getPostprocessorValueOld (const std::string ¶m_name, const unsigned int index=0) const |
const PostprocessorValue & | getPostprocessorValueOld (const std::string ¶m_name, const unsigned int index=0) const |
const PostprocessorValue & | getPostprocessorValueOlder (const std::string ¶m_name, const unsigned int index=0) const |
const PostprocessorValue & | getPostprocessorValueOlder (const std::string ¶m_name, const unsigned int index=0) const |
virtual const PostprocessorValue & | getPostprocessorValueByName (const PostprocessorName &name) const |
virtual const PostprocessorValue & | getPostprocessorValueByName (const PostprocessorName &name) const |
const PostprocessorValue & | getPostprocessorValueOldByName (const PostprocessorName &name) const |
const PostprocessorValue & | getPostprocessorValueOldByName (const PostprocessorName &name) const |
const PostprocessorValue & | getPostprocessorValueOlderByName (const PostprocessorName &name) const |
const PostprocessorValue & | getPostprocessorValueOlderByName (const PostprocessorName &name) const |
bool | isVectorPostprocessorDistributed (const std::string ¶m_name) const |
bool | isVectorPostprocessorDistributed (const std::string ¶m_name) const |
bool | isVectorPostprocessorDistributedByName (const VectorPostprocessorName &name) const |
bool | isVectorPostprocessorDistributedByName (const VectorPostprocessorName &name) const |
const GenericOptionalMaterialProperty< T, is_ad > & | getGenericOptionalMaterialProperty (const std::string &name, const unsigned int state=0) |
const GenericOptionalMaterialProperty< T, is_ad > & | getGenericOptionalMaterialProperty (const std::string &name, const unsigned int state=0) |
const OptionalMaterialProperty< T > & | getOptionalMaterialProperty (const std::string &name, const unsigned int state=0) |
const OptionalMaterialProperty< T > & | getOptionalMaterialProperty (const std::string &name, const unsigned int state=0) |
const OptionalADMaterialProperty< T > & | getOptionalADMaterialProperty (const std::string &name) |
const OptionalADMaterialProperty< T > & | getOptionalADMaterialProperty (const std::string &name) |
const OptionalMaterialProperty< T > & | getOptionalMaterialPropertyOld (const std::string &name) |
const OptionalMaterialProperty< T > & | getOptionalMaterialPropertyOld (const std::string &name) |
const OptionalMaterialProperty< T > & | getOptionalMaterialPropertyOlder (const std::string &name) |
const OptionalMaterialProperty< T > & | getOptionalMaterialPropertyOlder (const std::string &name) |
MaterialBase & | getMaterial (const std::string &name) |
MaterialBase & | getMaterial (const std::string &name) |
MaterialBase & | getMaterialByName (const std::string &name, bool no_warn=false) |
MaterialBase & | getMaterialByName (const std::string &name, bool no_warn=false) |
bool | hasMaterialProperty (const std::string &name) |
bool | hasMaterialProperty (const std::string &name) |
bool | hasMaterialPropertyByName (const std::string &name) |
bool | hasMaterialPropertyByName (const std::string &name) |
bool | hasADMaterialProperty (const std::string &name) |
bool | hasADMaterialProperty (const std::string &name) |
bool | hasADMaterialPropertyByName (const std::string &name) |
bool | hasADMaterialPropertyByName (const std::string &name) |
bool | hasGenericMaterialProperty (const std::string &name) |
bool | hasGenericMaterialProperty (const std::string &name) |
bool | hasGenericMaterialPropertyByName (const std::string &name) |
bool | hasGenericMaterialPropertyByName (const std::string &name) |
PenetrationLocator & | getPenetrationLocator (const BoundaryName &primary, const BoundaryName &secondary, Order order) |
PenetrationLocator & | getQuadraturePenetrationLocator (const BoundaryName &primary, const BoundaryName &secondary, Order order) |
NearestNodeLocator & | getNearestNodeLocator (const BoundaryName &primary, const BoundaryName &secondary) |
NearestNodeLocator & | getQuadratureNearestNodeLocator (const BoundaryName &primary, const BoundaryName &secondary) |
bool | requiresGeometricSearch () const |
const Parallel::Communicator & | comm () const |
processor_id_type | n_processors () const |
processor_id_type | processor_id () const |
void | checkCoupling () |
Static Public Member Functions | |
static InputParameters | validParams () |
static std::string | deduceFunctorName (const std::string &name, const InputParameters ¶ms) |
Public Attributes | |
const ConsoleStream | _console |
Static Public Attributes | |
static constexpr PropertyValue::id_type | default_property_id |
static constexpr PropertyValue::id_type | zero_property_id |
Protected Member Functions | |
virtual Real | computeQpResidual () override |
virtual Real | computeQpJacobian () |
virtual Real | computeQpOffDiagJacobian (unsigned int) |
virtual Real | computeQpOffDiagJacobianScalar (unsigned int) |
virtual RealEigenVector | computeQpOffDiagJacobianArray (const ArrayMooseVariable &jvar) |
virtual void | precalculateResidual () |
virtual void | precalculateJacobian () |
virtual void | precalculateOffDiagJacobian (unsigned int) |
const MooseVariableFieldBase & | getVariable (unsigned int jvar_num) const |
virtual void | addUserObjectDependencyHelper (const UserObject &) const |
virtual void | addPostprocessorDependencyHelper (const PostprocessorName &) const |
virtual void | addVectorPostprocessorDependencyHelper (const VectorPostprocessorName &) const |
T & | declareRestartableData (const std::string &data_name, Args &&... args) |
ManagedValue< T > | declareManagedRestartableDataWithContext (const std::string &data_name, void *context, Args &&... args) |
const T & | getRestartableData (const std::string &data_name) const |
T & | declareRestartableDataWithContext (const std::string &data_name, void *context, Args &&... args) |
T & | declareRecoverableData (const std::string &data_name, Args &&... args) |
T & | declareRestartableDataWithObjectName (const std::string &data_name, const std::string &object_name, Args &&... args) |
T & | declareRestartableDataWithObjectNameWithContext (const std::string &data_name, const std::string &object_name, void *context, Args &&... args) |
std::string | restartableName (const std::string &data_name) const |
void | prepareVectorTag (Assembly &assembly, unsigned int ivar) |
void | prepareVectorTag (Assembly &assembly, unsigned int ivar, ResidualTagType tag_type) |
void | prepareVectorTag (Assembly &assembly, unsigned int ivar, ResidualTagType tag_type) |
void | prepareVectorTag (Assembly &assembly, unsigned int ivar, ResidualTagType tag_type) |
void | prepareVectorTag (Assembly &assembly, unsigned int ivar, ResidualTagType tag_type) |
void | prepareVectorTag (Assembly &assembly, unsigned int ivar, ResidualTagType tag_type) |
void | prepareVectorTagNeighbor (Assembly &assembly, unsigned int ivar) |
void | prepareVectorTagLower (Assembly &assembly, unsigned int ivar) |
void | prepareMatrixTag (Assembly &assembly, unsigned int ivar, unsigned int jvar) |
void | prepareMatrixTag (Assembly &assembly, unsigned int ivar, unsigned int jvar, DenseMatrix< Number > &k) const |
void | prepareMatrixTagNonlocal (Assembly &assembly, unsigned int ivar, unsigned int jvar) |
void | prepareMatrixTagNeighbor (Assembly &assembly, unsigned int ivar, unsigned int jvar, Moose::DGJacobianType type) |
void | prepareMatrixTagNeighbor (Assembly &assembly, unsigned int ivar, unsigned int jvar, Moose::DGJacobianType type, DenseMatrix< Number > &k) const |
void | prepareMatrixTagLower (Assembly &assembly, unsigned int ivar, unsigned int jvar, Moose::ConstraintJacobianType type) |
void | accumulateTaggedLocalResidual () |
void | assignTaggedLocalResidual () |
void | accumulateTaggedLocalMatrix () |
void | accumulateTaggedLocalMatrix (Assembly &assembly, unsigned int ivar, unsigned int jvar, const DenseMatrix< Number > &k) |
void | accumulateTaggedLocalMatrix (Assembly &assembly, unsigned int ivar, unsigned int jvar, Moose::DGJacobianType type, const DenseMatrix< Number > &k) |
void | accumulateTaggedNonlocalMatrix () |
void | assignTaggedLocalMatrix () |
void | addResiduals (Assembly &assembly, const Residuals &residuals, const Indices &dof_indices, Real scaling_factor) |
void | addResiduals (Assembly &assembly, const DenseVector< T > &residuals, const Indices &dof_indices, Real scaling_factor) |
void | addResiduals (Assembly &assembly, const ADResidualsPacket &packet) |
void | addResidualsAndJacobian (Assembly &assembly, const Residuals &residuals, const Indices &dof_indices, Real scaling_factor) |
void | addResidualsAndJacobian (Assembly &assembly, const ADResidualsPacket &packet) |
void | addJacobian (Assembly &assembly, const Residuals &residuals, const Indices &dof_indices, Real scaling_factor) |
void | addJacobian (Assembly &assembly, const ADResidualsPacket &packet) |
void | addJacobian (Assembly &assembly, DenseMatrix< Real > &local_k, const std::vector< dof_id_type > &row_indices, const std::vector< dof_id_type > &column_indices, Real scaling_factor) |
void | addResidualsWithoutConstraints (Assembly &assembly, const Residuals &residuals, const Indices &dof_indices, Real scaling_factor) |
void | addResidualsAndJacobianWithoutConstraints (Assembly &assembly, const Residuals &residuals, const Indices &dof_indices, Real scaling_factor) |
void | addJacobianWithoutConstraints (Assembly &assembly, const Residuals &residuals, const Indices &dof_indices, Real scaling_factor) |
void | addJacobianElement (Assembly &assembly, Real value, dof_id_type row_index, dof_id_type column_index, Real scaling_factor) |
void | setResidual (SystemBase &sys, const T &residual, MooseVariableFE< T > &var) |
void | setResidual (SystemBase &sys, Real residual, dof_id_type dof_index) |
void | setResidual (SystemBase &sys, SetResidualFunctor set_residual_functor) |
virtual bool | hasBlockMaterialPropertyHelper (const std::string &prop_name) |
void | initializeBlockRestrictable (const MooseObject *moose_object) |
Moose::CoordinateSystemType | getBlockCoordSystem () |
virtual void | coupledCallback (const std::string &, bool) const |
virtual bool | isCoupled (const std::string &var_name, unsigned int i=0) const |
virtual bool | isCoupledConstant (const std::string &var_name) const |
unsigned int | coupledComponents (const std::string &var_name) const |
VariableName | coupledName (const std::string &var_name, unsigned int comp=0) const |
std::vector< VariableName > | coupledNames (const std::string &var_name) const |
virtual unsigned int | coupled (const std::string &var_name, unsigned int comp=0) const |
std::vector< unsigned int > | coupledIndices (const std::string &var_name) const |
virtual const VariableValue & | coupledValue (const std::string &var_name, unsigned int comp=0) const |
std::vector< const VariableValue *> | coupledValues (const std::string &var_name) const |
std::vector< const VectorVariableValue *> | coupledVectorValues (const std::string &var_name) const |
const GenericVariableValue< is_ad > & | coupledGenericValue (const std::string &var_name, unsigned int comp=0) const |
const GenericVariableValue< false > & | coupledGenericValue (const std::string &var_name, unsigned int comp) const |
const GenericVariableValue< true > & | coupledGenericValue (const std::string &var_name, unsigned int comp) const |
const GenericVectorVariableValue< is_ad > & | coupledGenericVectorValue (const std::string &var_name, unsigned int comp=0) const |
const GenericVectorVariableValue< false > & | coupledGenericVectorValue (const std::string &var_name, unsigned int comp) const |
const GenericVectorVariableValue< true > & | coupledGenericVectorValue (const std::string &var_name, unsigned int comp) const |
std::vector< const GenericVariableValue< is_ad > *> | coupledGenericValues (const std::string &var_name) const |
std::vector< const GenericVariableValue< false > *> | coupledGenericValues (const std::string &var_name) const |
std::vector< const GenericVariableValue< true > *> | coupledGenericValues (const std::string &var_name) const |
const GenericVariableValue< is_ad > & | coupledGenericDofValue (const std::string &var_name, unsigned int comp=0) const |
const GenericVariableValue< false > & | coupledGenericDofValue (const std::string &var_name, unsigned int comp) const |
const GenericVariableValue< true > & | coupledGenericDofValue (const std::string &var_name, unsigned int comp) const |
const GenericVariableValue< is_ad > & | coupledGenericDot (const std::string &var_name, unsigned int comp=0) const |
const GenericVariableValue< false > & | coupledGenericDot (const std::string &var_name, unsigned int comp) const |
const GenericVariableValue< true > & | coupledGenericDot (const std::string &var_name, unsigned int comp) const |
const GenericVariableValue< is_ad > & | coupledGenericDotDot (const std::string &var_name, unsigned int comp=0) const |
const GenericVariableValue< false > & | coupledGenericDotDot (const std::string &var_name, unsigned int comp) const |
const GenericVariableValue< true > & | coupledGenericDotDot (const std::string &var_name, unsigned int comp) const |
virtual const VariableValue & | coupledValueLower (const std::string &var_name, unsigned int comp=0) const |
const ADVariableValue & | adCoupledValue (const std::string &var_name, unsigned int comp=0) const |
std::vector< const ADVariableValue *> | adCoupledValues (const std::string &var_name) const |
const ADVariableValue & | adCoupledLowerValue (const std::string &var_name, unsigned int comp=0) const |
const ADVectorVariableValue & | adCoupledVectorValue (const std::string &var_name, unsigned int comp=0) const |
std::vector< const ADVectorVariableValue *> | adCoupledVectorValues (const std::string &var_name) const |
virtual const VariableValue & | coupledVectorTagValue (const std::string &var_names, TagID tag, unsigned int index=0) const |
virtual const VariableValue & | coupledVectorTagValue (const std::string &var_names, const std::string &tag_name, unsigned int index=0) const |
std::vector< const VariableValue *> | coupledVectorTagValues (const std::string &var_names, TagID tag) const |
std::vector< const VariableValue *> | coupledVectorTagValues (const std::string &var_names, const std::string &tag_name) const |
virtual const ArrayVariableValue & | coupledVectorTagArrayValue (const std::string &var_names, TagID tag, unsigned int index=0) const |
virtual const ArrayVariableValue & | coupledVectorTagArrayValue (const std::string &var_names, const std::string &tag_name, unsigned int index=0) const |
std::vector< const ArrayVariableValue *> | coupledVectorTagArrayValues (const std::string &var_names, TagID tag) const |
std::vector< const ArrayVariableValue *> | coupledVectorTagArrayValues (const std::string &var_names, const std::string &tag_name) const |
virtual const VariableGradient & | coupledVectorTagGradient (const std::string &var_names, TagID tag, unsigned int index=0) const |
virtual const VariableGradient & | coupledVectorTagGradient (const std::string &var_names, const std::string &tag_name, unsigned int index=0) const |
std::vector< const VariableGradient *> | coupledVectorTagGradients (const std::string &var_names, TagID tag) const |
std::vector< const VariableGradient *> | coupledVectorTagGradients (const std::string &var_names, const std::string &tag_name) const |
virtual const ArrayVariableGradient & | coupledVectorTagArrayGradient (const std::string &var_names, TagID tag, unsigned int index=0) const |
virtual const ArrayVariableGradient & | coupledVectorTagArrayGradient (const std::string &var_names, const std::string &tag_name, unsigned int index=0) const |
std::vector< const ArrayVariableGradient *> | coupledVectorTagArrayGradients (const std::string &var_names, TagID tag) const |
std::vector< const ArrayVariableGradient *> | coupledVectorTagArrayGradients (const std::string &var_names, const std::string &tag_name) const |
virtual const VariableValue & | coupledVectorTagDofValue (const std::string &var_name, TagID tag, unsigned int index=0) const |
virtual const VariableValue & | coupledVectorTagDofValue (const std::string &var_names, const std::string &tag_name, unsigned int index=0) const |
const ArrayVariableValue & | coupledVectorTagArrayDofValue (const std::string &var_name, const std::string &tag_name, unsigned int comp=0) const |
std::vector< const VariableValue *> | coupledVectorTagDofValues (const std::string &var_names, TagID tag) const |
std::vector< const VariableValue *> | coupledVectorTagDofValues (const std::string &var_names, const std::string &tag_name) const |
virtual const VariableValue & | coupledMatrixTagValue (const std::string &var_names, TagID tag, unsigned int index=0) const |
virtual const VariableValue & | coupledMatrixTagValue (const std::string &var_names, const std::string &tag_name, unsigned int index=0) const |
std::vector< const VariableValue *> | coupledMatrixTagValues (const std::string &var_names, TagID tag) const |
std::vector< const VariableValue *> | coupledMatrixTagValues (const std::string &var_names, const std::string &tag_name) const |
virtual const VectorVariableValue & | coupledVectorValue (const std::string &var_name, unsigned int comp=0) const |
virtual const ArrayVariableValue & | coupledArrayValue (const std::string &var_name, unsigned int comp=0) const |
std::vector< const ArrayVariableValue *> | coupledArrayValues (const std::string &var_name) const |
MooseWritableVariable & | writableVariable (const std::string &var_name, unsigned int comp=0) |
virtual VariableValue & | writableCoupledValue (const std::string &var_name, unsigned int comp=0) |
void | checkWritableVar (MooseWritableVariable *var) |
virtual const VariableValue & | coupledValueOld (const std::string &var_name, unsigned int comp=0) const |
std::vector< const VariableValue *> | coupledValuesOld (const std::string &var_name) const |
std::vector< const VectorVariableValue *> | coupledVectorValuesOld (const std::string &var_name) const |
virtual const VariableValue & | coupledValueOlder (const std::string &var_name, unsigned int comp=0) const |
std::vector< const VariableValue *> | coupledValuesOlder (const std::string &var_name) const |
virtual const VariableValue & | coupledValuePreviousNL (const std::string &var_name, unsigned int comp=0) const |
virtual const VectorVariableValue & | coupledVectorValueOld (const std::string &var_name, unsigned int comp=0) const |
virtual const VectorVariableValue & | coupledVectorValueOlder (const std::string &var_name, unsigned int comp=0) const |
virtual const ArrayVariableValue & | coupledArrayValueOld (const std::string &var_name, unsigned int comp=0) const |
virtual const ArrayVariableValue & | coupledArrayValueOlder (const std::string &var_name, unsigned int comp=0) const |
virtual const VariableGradient & | coupledGradient (const std::string &var_name, unsigned int comp=0) const |
std::vector< const VariableGradient *> | coupledGradients (const std::string &var_name) const |
const ADVariableGradient & | adCoupledGradient (const std::string &var_name, unsigned int comp=0) const |
const ADVariableGradient & | adCoupledGradientDot (const std::string &var_name, unsigned int comp=0) const |
std::vector< const ADVariableGradient *> | adCoupledGradients (const std::string &var_name) const |
const GenericVariableGradient< is_ad > & | coupledGenericGradient (const std::string &var_name, unsigned int comp=0) const |
const GenericVariableGradient< false > & | coupledGenericGradient (const std::string &var_name, unsigned int comp) const |
const GenericVariableGradient< true > & | coupledGenericGradient (const std::string &var_name, unsigned int comp) const |
std::vector< const GenericVariableGradient< is_ad > *> | coupledGenericGradients (const std::string &var_name) const |
std::vector< const GenericVariableGradient< false > *> | coupledGenericGradients (const std::string &var_name) const |
std::vector< const GenericVariableGradient< true > *> | coupledGenericGradients (const std::string &var_name) const |
const ADVectorVariableGradient & | adCoupledVectorGradient (const std::string &var_name, unsigned int comp=0) const |
const ADVariableSecond & | adCoupledSecond (const std::string &var_name, unsigned int comp=0) const |
const ADVectorVariableSecond & | adCoupledVectorSecond (const std::string &var_name, unsigned int comp=0) const |
virtual const VariableGradient & | coupledGradientOld (const std::string &var_name, unsigned int comp=0) const |
std::vector< const VariableGradient *> | coupledGradientsOld (const std::string &var_name) const |
virtual const VariableGradient & | coupledGradientOlder (const std::string &var_name, unsigned int comp=0) const |
virtual const VariableGradient & | coupledGradientPreviousNL (const std::string &var_name, unsigned int comp=0) const |
virtual const VariableGradient & | coupledGradientDot (const std::string &var_name, unsigned int comp=0) const |
virtual const VariableGradient & | coupledGradientDotDot (const std::string &var_name, unsigned int comp=0) const |
virtual const VectorVariableGradient & | coupledVectorGradient (const std::string &var_name, unsigned int comp=0) const |
virtual const VectorVariableGradient & | coupledVectorGradientOld (const std::string &var_name, unsigned int comp=0) const |
virtual const VectorVariableGradient & | coupledVectorGradientOlder (const std::string &var_name, unsigned int comp=0) const |
virtual const ArrayVariableGradient & | coupledArrayGradient (const std::string &var_name, unsigned int comp=0) const |
virtual const ArrayVariableGradient & | coupledArrayGradientOld (const std::string &var_name, unsigned int comp=0) const |
virtual const ArrayVariableGradient & | coupledArrayGradientOlder (const std::string &var_name, unsigned int comp=0) const |
virtual const ArrayVariableGradient & | coupledArrayGradientDot (const std::string &var_name, unsigned int comp=0) const |
virtual const VectorVariableCurl & | coupledCurl (const std::string &var_name, unsigned int comp=0) const |
virtual const VectorVariableCurl & | coupledCurlOld (const std::string &var_name, unsigned int comp=0) const |
virtual const VectorVariableCurl & | coupledCurlOlder (const std::string &var_name, unsigned int comp=0) const |
const ADVectorVariableCurl & | adCoupledCurl (const std::string &var_name, unsigned int comp=0) const |
virtual const VectorVariableDivergence & | coupledDiv (const std::string &var_name, unsigned int comp=0) const |
virtual const VectorVariableDivergence & | coupledDivOld (const std::string &var_name, unsigned int comp=0) const |
virtual const VectorVariableDivergence & | coupledDivOlder (const std::string &var_name, unsigned int comp=0) const |
virtual const VariableSecond & | coupledSecond (const std::string &var_name, unsigned int comp=0) const |
virtual const VariableSecond & | coupledSecondOld (const std::string &var_name, unsigned int comp=0) const |
virtual const VariableSecond & | coupledSecondOlder (const std::string &var_name, unsigned int comp=0) const |
virtual const VariableSecond & | coupledSecondPreviousNL (const std::string &var_name, unsigned int comp=0) const |
virtual const VariableValue & | coupledDot (const std::string &var_name, unsigned int comp=0) const |
std::vector< const VariableValue *> | coupledDots (const std::string &var_name) const |
virtual const VariableValue & | coupledDotDot (const std::string &var_name, unsigned int comp=0) const |
virtual const VariableValue & | coupledDotOld (const std::string &var_name, unsigned int comp=0) const |
virtual const VariableValue & | coupledDotDotOld (const std::string &var_name, unsigned int comp=0) const |
const ADVariableValue & | adCoupledDot (const std::string &var_name, unsigned int comp=0) const |
std::vector< const ADVariableValue *> | adCoupledDots (const std::string &var_name) const |
const ADVariableValue & | adCoupledDotDot (const std::string &var_name, unsigned int comp=0) const |
const ADVectorVariableValue & | adCoupledVectorDot (const std::string &var_name, unsigned int comp=0) const |
virtual const VectorVariableValue & | coupledVectorDot (const std::string &var_name, unsigned int comp=0) const |
virtual const VectorVariableValue & | coupledVectorDotDot (const std::string &var_name, unsigned int comp=0) const |
virtual const VectorVariableValue & | coupledVectorDotOld (const std::string &var_name, unsigned int comp=0) const |
virtual const VectorVariableValue & | coupledVectorDotDotOld (const std::string &var_name, unsigned int comp=0) const |
virtual const VariableValue & | coupledVectorDotDu (const std::string &var_name, unsigned int comp=0) const |
virtual const VariableValue & | coupledVectorDotDotDu (const std::string &var_name, unsigned int comp=0) const |
virtual const ArrayVariableValue & | coupledArrayDot (const std::string &var_name, unsigned int comp=0) const |
virtual const ArrayVariableValue & | coupledArrayDotDot (const std::string &var_name, unsigned int comp=0) const |
virtual const ArrayVariableValue & | coupledArrayDotOld (const std::string &var_name, unsigned int comp=0) const |
virtual const ArrayVariableValue & | coupledArrayDotDotOld (const std::string &var_name, unsigned int comp=0) const |
virtual const VariableValue & | coupledDotDu (const std::string &var_name, unsigned int comp=0) const |
virtual const VariableValue & | coupledDotDotDu (const std::string &var_name, unsigned int comp=0) const |
const VariableValue & | coupledArrayDotDu (const std::string &var_name, unsigned int comp=0) const |
const T & | coupledNodalValue (const std::string &var_name, unsigned int comp=0) const |
const Moose::ADType< T >::type & | adCoupledNodalValue (const std::string &var_name, unsigned int comp=0) const |
const T & | coupledNodalValueOld (const std::string &var_name, unsigned int comp=0) const |
const T & | coupledNodalValueOlder (const std::string &var_name, unsigned int comp=0) const |
const T & | coupledNodalValuePreviousNL (const std::string &var_name, unsigned int comp=0) const |
const T & | coupledNodalDot (const std::string &var_name, unsigned int comp=0) const |
virtual const VariableValue & | coupledNodalDotDot (const std::string &var_name, unsigned int comp=0) const |
virtual const VariableValue & | coupledNodalDotOld (const std::string &var_name, unsigned int comp=0) const |
virtual const VariableValue & | coupledNodalDotDotOld (const std::string &var_name, unsigned int comp=0) const |
virtual const VariableValue & | coupledDofValues (const std::string &var_name, unsigned int comp=0) const |
std::vector< const VariableValue *> | coupledAllDofValues (const std::string &var_name) const |
virtual const VariableValue & | coupledDofValuesOld (const std::string &var_name, unsigned int comp=0) const |
std::vector< const VariableValue *> | coupledAllDofValuesOld (const std::string &var_name) const |
virtual const VariableValue & | coupledDofValuesOlder (const std::string &var_name, unsigned int comp=0) const |
std::vector< const VariableValue *> | coupledAllDofValuesOlder (const std::string &var_name) const |
virtual const ArrayVariableValue & | coupledArrayDofValues (const std::string &var_name, unsigned int comp=0) const |
virtual const ADVariableValue & | adCoupledDofValues (const std::string &var_name, unsigned int comp=0) const |
const ADVariableValue & | adZeroValue () const |
const ADVariableGradient & | adZeroGradient () const |
const ADVariableSecond & | adZeroSecond () const |
const GenericVariableValue< is_ad > & | genericZeroValue () |
const GenericVariableValue< false > & | genericZeroValue () |
const GenericVariableValue< true > & | genericZeroValue () |
const GenericVariableGradient< is_ad > & | genericZeroGradient () |
const GenericVariableGradient< false > & | genericZeroGradient () |
const GenericVariableGradient< true > & | genericZeroGradient () |
const GenericVariableSecond< is_ad > & | genericZeroSecond () |
const GenericVariableSecond< false > & | genericZeroSecond () |
const GenericVariableSecond< true > & | genericZeroSecond () |
bool | checkVar (const std::string &var_name, unsigned int comp=0, unsigned int comp_bound=0) const |
const MooseVariableFieldBase * | getFEVar (const std::string &var_name, unsigned int comp) const |
const MooseVariableFieldBase * | getFieldVar (const std::string &var_name, unsigned int comp) const |
MooseVariableFieldBase * | getFieldVar (const std::string &var_name, unsigned int comp) |
const T * | getVarHelper (const std::string &var_name, unsigned int comp) const |
T * | getVarHelper (const std::string &var_name, unsigned int comp) |
MooseVariable * | getVar (const std::string &var_name, unsigned int comp) |
const MooseVariable * | getVar (const std::string &var_name, unsigned int comp) const |
VectorMooseVariable * | getVectorVar (const std::string &var_name, unsigned int comp) |
const VectorMooseVariable * | getVectorVar (const std::string &var_name, unsigned int comp) const |
ArrayMooseVariable * | getArrayVar (const std::string &var_name, unsigned int comp) |
const ArrayMooseVariable * | getArrayVar (const std::string &var_name, unsigned int comp) const |
void | validateExecutionerType (const std::string &name, const std::string &fn_name) const |
std::vector< T > | coupledVectorHelper (const std::string &var_name, const Func &func) const |
bool | isCoupledScalar (const std::string &var_name, unsigned int i=0) const |
unsigned int | coupledScalarComponents (const std::string &var_name) const |
unsigned int | coupledScalar (const std::string &var_name, unsigned int comp=0) const |
libMesh::Order | coupledScalarOrder (const std::string &var_name, unsigned int comp=0) const |
const VariableValue & | coupledScalarValue (const std::string &var_name, unsigned int comp=0) const |
const ADVariableValue & | adCoupledScalarValue (const std::string &var_name, unsigned int comp=0) const |
const GenericVariableValue< is_ad > & | coupledGenericScalarValue (const std::string &var_name, unsigned int comp=0) const |
const GenericVariableValue< false > & | coupledGenericScalarValue (const std::string &var_name, const unsigned int comp) const |
const GenericVariableValue< true > & | coupledGenericScalarValue (const std::string &var_name, const unsigned int comp) const |
const VariableValue & | coupledVectorTagScalarValue (const std::string &var_name, TagID tag, unsigned int comp=0) const |
const VariableValue & | coupledMatrixTagScalarValue (const std::string &var_name, TagID tag, unsigned int comp=0) const |
const VariableValue & | coupledScalarValueOld (const std::string &var_name, unsigned int comp=0) const |
const VariableValue & | coupledScalarValueOlder (const std::string &var_name, unsigned int comp=0) const |
const VariableValue & | coupledScalarDot (const std::string &var_name, unsigned int comp=0) const |
const ADVariableValue & | adCoupledScalarDot (const std::string &var_name, unsigned int comp=0) const |
const VariableValue & | coupledScalarDotDot (const std::string &var_name, unsigned int comp=0) const |
const VariableValue & | coupledScalarDotOld (const std::string &var_name, unsigned int comp=0) const |
const VariableValue & | coupledScalarDotDotOld (const std::string &var_name, unsigned int comp=0) const |
const VariableValue & | coupledScalarDotDu (const std::string &var_name, unsigned int comp=0) const |
const VariableValue & | coupledScalarDotDotDu (const std::string &var_name, unsigned int comp=0) const |
const MooseVariableScalar * | getScalarVar (const std::string &var_name, unsigned int comp) const |
virtual void | checkMaterialProperty (const std::string &name, const unsigned int state) |
void | markMatPropRequested (const std::string &) |
MaterialPropertyName | getMaterialPropertyName (const std::string &name) const |
void | checkExecutionStage () |
virtual const OutputTools< Real >::VariableValue & | value () |
virtual const OutputTools< Real >::VariableValue & | valueOld () |
virtual const OutputTools< Real >::VariableValue & | valueOlder () |
virtual const OutputTools< Real >::VariableValue & | dot () |
virtual const OutputTools< Real >::VariableValue & | dotDot () |
virtual const OutputTools< Real >::VariableValue & | dotOld () |
virtual const OutputTools< Real >::VariableValue & | dotDotOld () |
virtual const VariableValue & | dotDu () |
virtual const VariableValue & | dotDotDu () |
virtual const OutputTools< Real >::VariableGradient & | gradient () |
virtual const OutputTools< Real >::VariableGradient & | gradientOld () |
virtual const OutputTools< Real >::VariableGradient & | gradientOlder () |
virtual const OutputTools< Real >::VariableSecond & | second () |
virtual const OutputTools< Real >::VariableSecond & | secondOld () |
virtual const OutputTools< Real >::VariableSecond & | secondOlder () |
virtual const OutputTools< Real >::VariableTestSecond & | secondTest () |
virtual const OutputTools< Real >::VariableTestSecond & | secondTestFace () |
virtual const OutputTools< Real >::VariablePhiSecond & | secondPhi () |
virtual const OutputTools< Real >::VariablePhiSecond & | secondPhiFace () |
const GenericMaterialProperty< T, is_ad > * | defaultGenericMaterialProperty (const std::string &name) |
const GenericMaterialProperty< T, is_ad > * | defaultGenericMaterialProperty (const std::string &name) |
const MaterialProperty< T > * | defaultMaterialProperty (const std::string &name) |
const MaterialProperty< T > * | defaultMaterialProperty (const std::string &name) |
const ADMaterialProperty< T > * | defaultADMaterialProperty (const std::string &name) |
const ADMaterialProperty< T > * | defaultADMaterialProperty (const std::string &name) |
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 | 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 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 | scalarVolumeJacobian (const MooseArray< Real > &JxW, const libMesh::QBase &qrule, DenseMatrix< Number > &scalar_vector_jac) |
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 | 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 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 | 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 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 | 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 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 | 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 | 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 | 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 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) |
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) |
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 | 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 | 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 | 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) |
Static Protected Attributes | |
static const std::string | _interpolated_old |
static const std::string | _interpolated_older |
Implements the steady incompressible Navier-Stokes equations for a hybridized discretization.
Definition at line 20 of file NavierStokesLHDGKernel.h.
NavierStokesLHDGKernel::NavierStokesLHDGKernel | ( | const InputParameters & | parameters | ) |
Definition at line 38 of file NavierStokesLHDGKernel.C.
|
overridevirtual |
Reimplemented from HDGKernel.
Definition at line 342 of file NavierStokesLHDGKernel.C.
|
overridevirtual |
Compute this object's entire element interior Jacobian, both on- and off-diagonal.
Reimplemented from HDGKernel.
Definition at line 95 of file NavierStokesLHDGKernel.C.
Referenced by computeOffDiagJacobian().
|
overridevirtual |
Implements HDGKernel.
Definition at line 198 of file NavierStokesLHDGKernel.C.
Forwards to computeJacobian()
the first time this is called for a given element.
Reimplemented from HDGKernel.
Definition at line 332 of file NavierStokesLHDGKernel.C.
|
overridevirtual |
Reimplemented from HDGKernel.
Definition at line 61 of file NavierStokesLHDGKernel.C.
|
overridevirtual |
Implements HDGKernel.
Definition at line 161 of file NavierStokesLHDGKernel.C.
|
overridevirtual |
Reimplemented from HDGKernel.
Definition at line 319 of file NavierStokesLHDGKernel.C.
|
overridevirtual |
Reimplemented from HDGKernel.
Definition at line 326 of file NavierStokesLHDGKernel.C.
|
protectedinherited |
Definition at line 478 of file NavierStokesLHDGAssemblyHelper.C.
Referenced by NavierStokesLHDGOutflowBC::computeJacobian(), and computeJacobianOnSide().
|
protectedinherited |
Definition at line 444 of file NavierStokesLHDGAssemblyHelper.C.
Referenced by NavierStokesLHDGOutflowBC::computeResidual(), and computeResidualOnSide().
|
protectedinherited |
Definition at line 525 of file NavierStokesLHDGAssemblyHelper.C.
Referenced by NavierStokesLHDGVelocityDirichletBC::computeResidual().
|
protectedinherited |
Definition at line 337 of file NavierStokesLHDGAssemblyHelper.C.
Referenced by NavierStokesLHDGOutflowBC::computeJacobian(), and computeJacobianOnSide().
|
protectedinherited |
Definition at line 322 of file NavierStokesLHDGAssemblyHelper.C.
Referenced by NavierStokesLHDGOutflowBC::computeResidual(), and computeResidualOnSide().
|
protectedinherited |
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 computeJacobian().
|
protectedinherited |
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 computeResidual().
|
protectedinherited |
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 NavierStokesLHDGAssemblyHelper::lmFaceJacobian(), NavierStokesLHDGAssemblyHelper::scalarFaceJacobian(), and NavierStokesLHDGAssemblyHelper::scalarVolumeJacobian().
|
protectedinherited |
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 NavierStokesLHDGAssemblyHelper::lmFaceResidual(), NavierStokesLHDGAssemblyHelper::scalarFaceResidual(), and NavierStokesLHDGAssemblyHelper::scalarVolumeResidual().
|
protectedinherited |
Definition at line 600 of file NavierStokesLHDGAssemblyHelper.C.
Referenced by NavierStokesLHDGVelocityDirichletBC::computeJacobian().
|
protectedinherited |
Definition at line 550 of file NavierStokesLHDGAssemblyHelper.C.
Referenced by NavierStokesLHDGVelocityDirichletBC::computeResidual().
|
protectedinherited |
Definition at line 393 of file NavierStokesLHDGAssemblyHelper.C.
Referenced by NavierStokesLHDGOutflowBC::computeJacobian(), and computeJacobianOnSide().
|
protectedinherited |
Definition at line 363 of file NavierStokesLHDGAssemblyHelper.C.
Referenced by NavierStokesLHDGOutflowBC::computeResidual(), and computeResidualOnSide().
|
protectedinherited |
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 computeJacobian().
|
protectedinherited |
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 computeResidual().
|
static |
Definition at line 18 of file NavierStokesLHDGKernel.C.
|
protected |
Definition at line 44 of file NavierStokesLHDGKernel.h.
Referenced by computeResidual(), and NavierStokesLHDGKernel().
|
protected |
Definition at line 45 of file NavierStokesLHDGKernel.h.
Referenced by computeResidual(), and NavierStokesLHDGKernel().
|
protected |
Definition at line 46 of file NavierStokesLHDGKernel.h.
Referenced by NavierStokesLHDGKernel().
|
protected |
Definition at line 47 of file NavierStokesLHDGKernel.h.
Referenced by NavierStokesLHDGKernel().
|
protected |
The current side when doing face evaluations.
Definition at line 63 of file NavierStokesLHDGKernel.h.
Referenced by computeJacobianOnSide(), and computeResidualOnSide().
|
protectedinherited |
Definition at line 216 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by additionalROVariables(), computeJacobian(), computeResidual(), NavierStokesLHDGAssemblyHelper::pressureVolumeJacobian(), and NavierStokesLHDGAssemblyHelper::pressureVolumeResidual().
|
protectedinherited |
Definition at line 226 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by computeJacobian(), and computeResidual().
|
protectedinherited |
Definition at line 236 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGAssemblyHelper::pressureVolumeResidual().
|
protectedinherited |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by computeJacobian().
|
protectedinherited |
Definition at line 241 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by computeResidual().
|
protectedinherited |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by computeJacobian().
|
protectedinherited |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGOutflowBC::computeJacobian(), and computeJacobianOnSide().
|
protectedinherited |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by computeJacobian().
|
protectedinherited |
Definition at line 241 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by computeResidual(), NavierStokesLHDGVelocityDirichletBC::computeResidual(), NavierStokesLHDGOutflowBC::computeResidual(), and computeResidualOnSide().
|
protectedinherited |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by computeJacobian().
|
protectedinherited |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGOutflowBC::computeJacobian(), and computeJacobianOnSide().
|
protectedinherited |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by computeJacobian().
|
protectedinherited |
Definition at line 211 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by additionalROVariables(), computeJacobian(), NavierStokesLHDGOutflowBC::computeJacobian(), computeJacobianOnSide(), computeResidual(), NavierStokesLHDGVelocityDirichletBC::computeResidual(), NavierStokesLHDGOutflowBC::computeResidual(), computeResidualOnSide(), and NavierStokesLHDGAssemblyHelper::NavierStokesLHDGAssemblyHelper().
|
protectedinherited |
Definition at line 241 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by computeResidual(), NavierStokesLHDGVelocityDirichletBC::computeResidual(), NavierStokesLHDGOutflowBC::computeResidual(), and computeResidualOnSide().
|
protectedinherited |
Definition at line 212 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGAssemblyHelper::NavierStokesLHDGAssemblyHelper().
|
protected |
transformed Jacobian weights on the current element face
Definition at line 57 of file NavierStokesLHDGKernel.h.
Referenced by computeJacobianOnSide(), and computeResidualOnSide().
|
protectedinherited |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGOutflowBC::computeJacobian(), and computeJacobianOnSide().
|
protectedinherited |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGVelocityDirichletBC::computeJacobian(), NavierStokesLHDGOutflowBC::computeJacobian(), and computeJacobianOnSide().
|
protectedinherited |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGOutflowBC::computeJacobian(), and computeJacobianOnSide().
|
protectedinherited |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGOutflowBC::computeJacobian(), and computeJacobianOnSide().
|
protectedinherited |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGOutflowBC::computeJacobian(), and computeJacobianOnSide().
|
protectedinherited |
Definition at line 241 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGVelocityDirichletBC::computeResidual(), NavierStokesLHDGOutflowBC::computeResidual(), and computeResidualOnSide().
|
protectedinherited |
Definition at line 221 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGVelocityDirichletBC::computeJacobian(), NavierStokesLHDGOutflowBC::computeJacobian(), computeJacobianOnSide(), NavierStokesLHDGVelocityDirichletBC::computeResidual(), NavierStokesLHDGOutflowBC::computeResidual(), and computeResidualOnSide().
|
protectedinherited |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGOutflowBC::computeJacobian(), and computeJacobianOnSide().
|
protectedinherited |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGOutflowBC::computeJacobian(), and computeJacobianOnSide().
|
protectedinherited |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGVelocityDirichletBC::computeJacobian(), NavierStokesLHDGOutflowBC::computeJacobian(), and computeJacobianOnSide().
|
protectedinherited |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGOutflowBC::computeJacobian(), and computeJacobianOnSide().
|
protectedinherited |
Definition at line 231 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGVelocityDirichletBC::computeResidual(), NavierStokesLHDGOutflowBC::computeResidual(), computeResidualOnSide(), NavierStokesLHDGAssemblyHelper::lmFaceJacobian(), NavierStokesLHDGAssemblyHelper::lmFaceResidual(), NavierStokesLHDGAssemblyHelper::pressureFaceResidual(), NavierStokesLHDGAssemblyHelper::scalarFaceJacobian(), and NavierStokesLHDGAssemblyHelper::scalarFaceResidual().
|
protectedinherited |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGOutflowBC::computeJacobian(), and computeJacobianOnSide().
|
protectedinherited |
Definition at line 241 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGVelocityDirichletBC::computeResidual(), NavierStokesLHDGOutflowBC::computeResidual(), and computeResidualOnSide().
|
protectedinherited |
Definition at line 224 of file NavierStokesLHDGAssemblyHelper.h.
|
protectedinherited |
Definition at line 234 of file NavierStokesLHDGAssemblyHelper.h.
|
protected |
face normals
Definition at line 60 of file NavierStokesLHDGKernel.h.
Referenced by computeJacobianOnSide(), and computeResidualOnSide().
|
protectedinherited |
Definition at line 225 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGVelocityDirichletBC::computeJacobian(), computeJacobian(), NavierStokesLHDGOutflowBC::computeJacobian(), computeJacobianOnSide(), computeResidual(), NavierStokesLHDGVelocityDirichletBC::computeResidual(), NavierStokesLHDGOutflowBC::computeResidual(), and computeResidualOnSide().
|
protectedinherited |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by computeJacobian().
|
protectedinherited |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGOutflowBC::computeJacobian(), and computeJacobianOnSide().
|
protectedinherited |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGOutflowBC::computeJacobian(), and computeJacobianOnSide().
|
protectedinherited |
Definition at line 241 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by computeResidual(), NavierStokesLHDGVelocityDirichletBC::computeResidual(), NavierStokesLHDGOutflowBC::computeResidual(), and computeResidualOnSide().
|
protectedinherited |
Definition at line 235 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGAssemblyHelper::lmFaceResidual(), NavierStokesLHDGAssemblyHelper::pressureVolumeResidual(), NavierStokesLHDGAssemblyHelper::scalarDirichletResidual(), NavierStokesLHDGAssemblyHelper::scalarFaceResidual(), and NavierStokesLHDGAssemblyHelper::scalarVolumeResidual().
|
protectedinherited |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by computeJacobian().
|
protectedinherited |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by computeJacobian().
|
protected |
Definition at line 48 of file NavierStokesLHDGKernel.h.
Referenced by computeResidual().
|
protectedinherited |
Definition at line 215 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by additionalROVariables(), computeJacobian(), NavierStokesLHDGOutflowBC::computeJacobian(), computeJacobianOnSide(), computeResidual(), NavierStokesLHDGVelocityDirichletBC::computeResidual(), NavierStokesLHDGOutflowBC::computeResidual(), computeResidualOnSide(), and NavierStokesLHDGAssemblyHelper::NavierStokesLHDGAssemblyHelper().
|
protected |
The physical locations of the quadrature points on the face.
Definition at line 54 of file NavierStokesLHDGKernel.h.
|
protected |
The face quadrature rule.
Definition at line 51 of file NavierStokesLHDGKernel.h.
Referenced by computeJacobianOnSide(), and computeResidualOnSide().
|
protectedinherited |
Containers for dof indices.
Definition at line 219 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGVelocityDirichletBC::computeJacobian(), computeJacobian(), NavierStokesLHDGOutflowBC::computeJacobian(), computeJacobianOnSide(), computeResidual(), NavierStokesLHDGVelocityDirichletBC::computeResidual(), NavierStokesLHDGOutflowBC::computeResidual(), and computeResidualOnSide().
|
protectedinherited |
local solutions at quadrature points
Definition at line 229 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by computeResidual(), NavierStokesLHDGVelocityDirichletBC::computeResidual(), NavierStokesLHDGOutflowBC::computeResidual(), and computeResidualOnSide().
|
protectedinherited |
Definition at line 222 of file NavierStokesLHDGAssemblyHelper.h.
|
protectedinherited |
Definition at line 232 of file NavierStokesLHDGAssemblyHelper.h.
|
protectedinherited |
The density.
Definition at line 239 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGAssemblyHelper::rhoVelCrossVelJacobian(), NavierStokesLHDGAssemblyHelper::rhoVelCrossVelResidual(), and NavierStokesLHDGAssemblyHelper::scalarDirichletResidual().
|
protectedinherited |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGVelocityDirichletBC::computeJacobian(), computeJacobian(), NavierStokesLHDGOutflowBC::computeJacobian(), and computeJacobianOnSide().
|
protectedinherited |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGOutflowBC::computeJacobian(), and computeJacobianOnSide().
|
protectedinherited |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGOutflowBC::computeJacobian(), and computeJacobianOnSide().
|
protectedinherited |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGVelocityDirichletBC::computeJacobian(), computeJacobian(), NavierStokesLHDGOutflowBC::computeJacobian(), and computeJacobianOnSide().
|
protectedinherited |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGVelocityDirichletBC::computeJacobian(), computeJacobian(), NavierStokesLHDGOutflowBC::computeJacobian(), and computeJacobianOnSide().
|
protectedinherited |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by computeJacobian().
|
protectedinherited |
Definition at line 241 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by computeResidual(), NavierStokesLHDGVelocityDirichletBC::computeResidual(), NavierStokesLHDGOutflowBC::computeResidual(), and computeResidualOnSide().
|
protectedinherited |
Definition at line 220 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGVelocityDirichletBC::computeJacobian(), computeJacobian(), NavierStokesLHDGOutflowBC::computeJacobian(), computeJacobianOnSide(), computeResidual(), NavierStokesLHDGVelocityDirichletBC::computeResidual(), NavierStokesLHDGOutflowBC::computeResidual(), and computeResidualOnSide().
|
protectedinherited |
Definition at line 213 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by additionalROVariables(), NavierStokesLHDGVelocityDirichletBC::computeJacobian(), NavierStokesLHDGOutflowBC::computeJacobian(), computeJacobianOnSide(), NavierStokesLHDGVelocityDirichletBC::computeResidual(), NavierStokesLHDGOutflowBC::computeResidual(), computeResidualOnSide(), and NavierStokesLHDGAssemblyHelper::NavierStokesLHDGAssemblyHelper().
|
protectedinherited |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGVelocityDirichletBC::computeJacobian(), computeJacobian(), NavierStokesLHDGOutflowBC::computeJacobian(), and computeJacobianOnSide().
|
protectedinherited |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGOutflowBC::computeJacobian(), and computeJacobianOnSide().
|
protectedinherited |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGOutflowBC::computeJacobian(), and computeJacobianOnSide().
|
protectedinherited |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGVelocityDirichletBC::computeJacobian(), computeJacobian(), NavierStokesLHDGOutflowBC::computeJacobian(), and computeJacobianOnSide().
|
protectedinherited |
Definition at line 230 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by computeResidual(), NavierStokesLHDGVelocityDirichletBC::computeResidual(), NavierStokesLHDGOutflowBC::computeResidual(), computeResidualOnSide(), NavierStokesLHDGAssemblyHelper::pressureVolumeResidual(), NavierStokesLHDGAssemblyHelper::scalarVolumeJacobian(), and NavierStokesLHDGAssemblyHelper::scalarVolumeResidual().
|
protectedinherited |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by computeJacobian().
|
protectedinherited |
Definition at line 243 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGVelocityDirichletBC::computeJacobian(), computeJacobian(), NavierStokesLHDGOutflowBC::computeJacobian(), and computeJacobianOnSide().
|
protectedinherited |
Definition at line 209 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by additionalROVariables(), NavierStokesLHDGVelocityDirichletBC::computeJacobian(), computeJacobian(), NavierStokesLHDGOutflowBC::computeJacobian(), computeJacobianOnSide(), computeResidual(), NavierStokesLHDGVelocityDirichletBC::computeResidual(), NavierStokesLHDGOutflowBC::computeResidual(), computeResidualOnSide(), and NavierStokesLHDGAssemblyHelper::NavierStokesLHDGAssemblyHelper().
|
protectedinherited |
Definition at line 241 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by computeResidual(), NavierStokesLHDGVelocityDirichletBC::computeResidual(), NavierStokesLHDGOutflowBC::computeResidual(), and computeResidualOnSide().
|
protectedinherited |
Definition at line 223 of file NavierStokesLHDGAssemblyHelper.h.
|
protectedinherited |
Definition at line 214 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGAssemblyHelper::NavierStokesLHDGAssemblyHelper().
|
protectedinherited |
Definition at line 233 of file NavierStokesLHDGAssemblyHelper.h.
|
protectedinherited |
Definition at line 210 of file NavierStokesLHDGAssemblyHelper.h.
Referenced by NavierStokesLHDGAssemblyHelper::NavierStokesLHDGAssemblyHelper().