An advection kernel that implements the advection term for the enthalpy in the energy equation. More...
#include <LinearFVEnergyAdvection.h>
Public Types | |
enum | ResidualTagType { ResidualTagType::NonReference, ResidualTagType::Reference } |
typedef DataFileName | DataFileParameterType |
Public Member Functions | |
LinearFVEnergyAdvection (const InputParameters ¶ms) | |
virtual Real | computeElemMatrixContribution () override |
virtual Real | computeNeighborMatrixContribution () override |
virtual Real | computeElemRightHandSideContribution () override |
virtual Real | computeNeighborRightHandSideContribution () override |
virtual Real | computeBoundaryMatrixContribution (const LinearFVBoundaryCondition &bc) override |
virtual Real | computeBoundaryRHSContribution (const LinearFVBoundaryCondition &bc) override |
virtual void | setupFaceData (const FaceInfo *face_info) override |
virtual void | addMatrixContribution () override |
virtual void | addRightHandSideContribution () override |
virtual bool | hasFaceSide (const FaceInfo &fi, bool fi_elem_side) const override |
void | setCurrentFaceArea (const Real area) |
virtual const MooseLinearVariableFV< Real > & | variable () const override |
void | linkTaggedVectorsAndMatrices (const std::set< TagID > &vector_tags, const std::set< TagID > &matrix_tags) |
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 | initialSetup () |
virtual void | timestepSetup () |
virtual void | jacobianSetup () |
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 |
MooseVariableBase * | mooseVariableBase () const |
MooseVariableField< Real > & | mooseVariableField () |
MooseVariableFE< Real > * | mooseVariable () const |
MooseVariableFV< Real > * | mooseVariableFV () const |
MooseLinearVariableFV< Real > * | mooseLinearVariableFV () 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) |
Moose::FaceArg | makeFace (const FaceInfo &fi, const Moose::FV::LimiterType limiter_type, const bool elem_is_upwind, const bool correct_skewness=false, const Moose::StateArg *state_limiter=nullptr) const |
Moose::FaceArg | makeCDFace (const FaceInfo &fi, const bool correct_skewness=false) 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 Parallel::Communicator & | comm () const |
processor_id_type | n_processors () const |
processor_id_type | processor_id () const |
Static Public Member Functions | |
static InputParameters | validParams () |
static std::string | deduceFunctorName (const std::string &name, const InputParameters ¶ms) |
static void | setRMParamsAdvection (const InputParameters &obj_params, InputParameters &rm_params, const unsigned short conditional_extended_layers) |
static void | setRMParamsDiffusion (const InputParameters &obj_params, InputParameters &rm_params, const unsigned short conditional_extended_layers) |
Public Attributes | |
const ConsoleStream | _console |
Protected Types | |
enum | AdvectedQuantityEnum { AdvectedQuantityEnum::ENTHALPY = 0, AdvectedQuantityEnum::TEMPERATURE = 1 } |
The advected quantity options. More... | |
Protected Member Functions | |
std::string | deduceFunctorName (const std::string &name) const |
Moose::FaceArg | singleSidedFaceArg (const FaceInfo *fi, Moose::FV::LimiterType limiter_type=Moose::FV::LimiterType::CentralDifference, bool correct_skewness=false) 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 | 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 () |
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) |
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 () |
Private Attributes | |
std::pair< Real, Real > | _advected_interp_coeffs |
Container for the current advected interpolation coefficients on the face to make sure we don't compute it multiple times for different terms. More... | |
Real | _face_mass_flux |
Container for the mass flux on the face which will be reused in the advection term's matrix and right hand side contribution. More... | |
Moose::FV::InterpMethod | _advected_interp_method |
The interpolation method to use for the advected quantity. More... | |
An advection kernel that implements the advection term for the enthalpy in the energy equation.
Definition at line 20 of file LinearFVEnergyAdvection.h.
|
strongprotected |
The advected quantity options.
Enumerator | |
---|---|
ENTHALPY | |
TEMPERATURE |
Definition at line 42 of file LinearFVEnergyAdvection.h.
LinearFVEnergyAdvection::LinearFVEnergyAdvection | ( | const InputParameters & | params | ) |
Definition at line 34 of file LinearFVEnergyAdvection.C.
|
overridevirtual |
Implements LinearFVFluxKernel.
Definition at line 76 of file LinearFVEnergyAdvection.C.
|
overridevirtual |
Implements LinearFVFluxKernel.
Definition at line 90 of file LinearFVEnergyAdvection.C.
|
overridevirtual |
Implements LinearFVFluxKernel.
Definition at line 52 of file LinearFVEnergyAdvection.C.
|
overridevirtual |
Implements LinearFVFluxKernel.
Definition at line 64 of file LinearFVEnergyAdvection.C.
|
overridevirtual |
Implements LinearFVFluxKernel.
Definition at line 58 of file LinearFVEnergyAdvection.C.
|
overridevirtual |
Implements LinearFVFluxKernel.
Definition at line 70 of file LinearFVEnergyAdvection.C.
Reimplemented from LinearFVFluxKernel.
Definition at line 103 of file LinearFVEnergyAdvection.C.
|
static |
Definition at line 18 of file LinearFVEnergyAdvection.C.
Container for the current advected interpolation coefficients on the face to make sure we don't compute it multiple times for different terms.
Definition at line 61 of file LinearFVEnergyAdvection.h.
Referenced by computeElemMatrixContribution(), computeNeighborMatrixContribution(), and setupFaceData().
|
private |
The interpolation method to use for the advected quantity.
Definition at line 68 of file LinearFVEnergyAdvection.h.
Referenced by LinearFVEnergyAdvection(), and setupFaceData().
|
protected |
The advected quantity.
Definition at line 49 of file LinearFVEnergyAdvection.h.
Referenced by LinearFVEnergyAdvection().
|
protected |
The constant specific heat value.
Only needed for temperature advection, with the assumption of constant cp.
Definition at line 53 of file LinearFVEnergyAdvection.h.
Referenced by computeBoundaryMatrixContribution(), computeBoundaryRHSContribution(), computeElemMatrixContribution(), and computeNeighborMatrixContribution().
|
private |
Container for the mass flux on the face which will be reused in the advection term's matrix and right hand side contribution.
Definition at line 65 of file LinearFVEnergyAdvection.h.
Referenced by computeBoundaryMatrixContribution(), computeBoundaryRHSContribution(), computeElemMatrixContribution(), computeNeighborMatrixContribution(), and setupFaceData().
|
protected |
The Rhie-Chow user object that provides us with the face velocity.
Definition at line 56 of file LinearFVEnergyAdvection.h.
Referenced by setupFaceData().