18 #include "libmesh/numeric_vector.h" 19 #include "libmesh/dof_map.h" 20 #include "libmesh/elem.h" 21 #include "libmesh/quadrature.h" 22 #include "libmesh/dense_vector.h" 23 #include "libmesh/enum_fe_family.h" 42 template <
typename OutputType>
84 virtual bool isFV()
const override {
return true; }
143 virtual bool isNodal() const override final {
return false; }
152 virtual const Elem *
const &
currentElem()
const override;
170 [[noreturn]]
void adError()
const;
186 const std::vector<std::unique_ptr<libMesh::NumericVector<libMesh::Number>>> &
_grad_container;
216 const StateArg & state)
const override final;
218 const StateArg & state)
const override final;
220 const StateArg & state)
const override final;
222 const StateArg &)
const override final;
224 const StateArg &)
const override final;
226 const StateArg &)
const override final;
257 std::vector<dof_id_type> & dof_indices)
const override;
259 virtual void setDofValues(
const DenseVector<OutputData> & values)
override;
284 virtual void setNodalValue(
const OutputType & value,
unsigned int idx = 0)
override;
288 virtual const std::vector<dof_id_type> &
dofIndices() const final;
295 virtual void reinitNodes(
const std::vector<dof_id_type> & )
override final {}
318 virtual void setActiveTags(
const std::set<TagID> & vtags)
override;
426 [[noreturn]]
virtual std::size_t
phiLowerSize() const override final;
429 template <typename OutputType>
433 const auto & elem_info = this->
_mesh.
elemInfo(elem_arg.elem->id());
437 template <
typename OutputType>
446 template <
typename OutputType>
454 template <
typename OutputType>
462 template <
typename OutputType>
471 template <
typename OutputType>
480 template <
typename OutputType>
485 mooseAssert(face.
fi,
"We must have a non-null face information");
489 template <
typename OutputType>
493 mooseError(
"MooseLinearVariableFV does not support time integration at the moment! The variable " 494 "which is causing the issue: ",
498 template <
typename OutputType>
502 mooseError(
"Lower dimensional element support not implemented for finite volume variables!The " 503 "variable which is causing the issue: ",
507 template <
typename OutputType>
511 mooseError(
"FV variables don't support nodal variable treatment! The variable which is causing " 516 template <
typename OutputType>
520 mooseError(
"Linear FV variable does not support automatic differentiation, the variable which is " 521 "attempting it is: ",
virtual const FieldVariablePhiGradient & gradPhiFace() const override final
Return the gradients of the variable's shape functions on an element face.
virtual const DoFValue & vectorTagDofValue(TagID tag) const override
virtual void clearAllDofIndices() override final
typename OutputTools< typename Moose::ADType< T >::type >::VariableSecond ADTemplateVariableSecond
virtual const MooseArray< libMesh::Number > & dofValuesDuDotDotDuNeighbor() const override
virtual void setActiveTags(const std::set< TagID > &vtags) override
Set the active vector tags.
typename OutputTools< typename Moose::ADType< T >::type >::VariableCurl ADTemplateVariableCurl
MooseLinearVariableFV< Real > MooseLinearVariableFVReal
virtual bool isExtrapolatedBoundaryFace(const FaceInfo &fi, const Elem *elem, const Moose::StateArg &state) const override
Returns whether this (sided) face is an extrapolated boundary face for this functor.
virtual const DoFValue & dofValuesOldNeighbor() const override
virtual void prepare() override final
Prepare the elemental degrees of freedom.
virtual void computeElemValuesFace() override
Compute values at facial quadrature points.
Base class for boundary conditions for linear FV systems.
virtual const MooseArray< OutputType > & nodalValueOlderArray() const override
virtual void reinitAuxNeighbor() override final
virtual const ADTemplateVariableCurl< OutputType > & adCurlSln() const override
AD curl solution getter.
usingMooseVariableBaseMembers
virtual DotType evaluateDot(const ElemArg &elem, const StateArg &) const override final
Evaluate the functor time derivative with a given element.
void adError() const
Throw an error when somebody wants to use this variable with automatic differentiation.
std::unordered_map< BoundaryID, LinearFVBoundaryCondition * > _boundary_id_to_bc
Map for easily accessing the boundary conditions based on the boundary IDs.
virtual const FieldVariableValue & sln() const override
virtual const DoFValue & dofValuesOlder() const override
virtual bool isDirichletBoundaryFace(const FaceInfo &fi) const
If the variable has a dirichlet boundary condition at face described by fi .
const FieldVariablePhiGradient & _grad_phi_face
Class for stuff related to variables.
const FieldVariablePhiGradient & _grad_phi_face_neighbor
virtual const MooseArray< OutputType > & nodalValueArray() const override
Methods for retrieving values of variables at the nodes in a MooseArray for AuxKernelBase.
const FieldVariablePhiGradient & _grad_phi_neighbor
virtual const Elem *const & currentElem() const override
Current element this variable is evaluated at.
virtual void setDofValues(const DenseVector< OutputData > &values) override
Set local DOF values and evaluate the values on quadrature points.
virtual const ADTemplateVariableGradient< OutputType > & adGradSlnDot() const override
AD grad of time derivative solution getter.
virtual const DoFValue & dofValuesDotOld() const override
virtual const FieldVariablePhiSecond & secondPhiFace() const override final
Return the rank-2 tensor of second derivatives of the variable's shape functions on an element face...
virtual bool isNodal() const override final
Is this variable nodal.
typename MooseVariableField< OutputType >::FieldVariablePhiSecond FieldVariablePhiSecond
const FieldVariablePhiDivergence & divPhi() const override final
Divergence of the shape functions.
virtual const FieldVariablePhiSecond & secondPhiFaceNeighbor() const override final
Return the rank-2 tensor of second derivatives of the variable's shape functions on a neighboring ele...
virtual const ADTemplateVariableValue< OutputType > & adSln() const override
AD solution getter.
virtual const FieldVariableGradient & gradSlnOldNeighbor() const override
virtual void residualSetup() override
virtual const DoFValue & nodalMatrixTagValue(TagID tag) const override
Base class for finite volume Dirichlet boundaray conditions.
const unsigned int _sys_num
Cache the number of the system this variable belongs to.
virtual const DoFValue & dofValues() const override
dof values getters
virtual std::size_t phiFaceSize() const override final
Return phiFace size.
const std::string & name() const override
Get the variable name.
typename OutputTools< typename Moose::ADType< T >::type >::VariableValue ADTemplateVariableValue
virtual const FieldVariablePhiValue & phiFace() const override final
Return the variable's shape functions on an element face.
virtual const MooseArray< ADReal > & adDofValues() const override
Return the AD dof values.
virtual void getDofIndices(const Elem *elem, std::vector< dof_id_type > &dof_indices) const override
virtual const DoFValue & dofValuesPreviousNL() const override
virtual const FieldVariablePhiValue & phi() const override final
Return the variable's elemental shape functions.
virtual const FieldVariablePhiGradient & gradPhi() const override final
Return the gradients of the variable's elemental shape functions.
RealVectorValue _cell_gradient
Temporary storage for the cell gradient to avoid unnecessary allocations.
virtual void prepareNeighbor() override final
Prepare the neighbor element degrees of freedom.
virtual void setNodalValue(const OutputType &value, unsigned int idx=0) override
LinearFVBoundaryCondition * getBoundaryCondition(const BoundaryID bd_id) const
Get the boundary condition object which corresponds to the given boundary ID.
virtual const std::vector< dof_id_type > & dofIndicesNeighbor() const final
Get neighbor DOF indices for currently selected element.
virtual const DoFValue & dofValuesDotNeighbor() const override
virtual const FieldVariablePhiSecond & secondPhi() const override final
Return the rank-2 tensor of second derivatives of the variable's elemental shape functions.
A structure that is used to evaluate Moose functors at an arbitrary physical point contained within a...
The following methods are specializations for using the libMesh::Parallel::packed_range_* routines fo...
virtual void initialSetup() override
Gets called at the beginning of the simulation before this object is asked to do its job...
const FieldVariablePhiValue & _phi_face_neighbor
DualNumber< Real, DNDerivativeType, true > ADReal
virtual bool supportsElemSideQpArg() const override final
Whether this functor supports evaluation with ElemSideQpArg.
virtual void clearDofIndices() override
Clear out the dof indices.
virtual const std::vector< dof_id_type > & dofIndices() const final
Get local DoF indices.
virtual void computeElemValues() override
Compute values at interior quadrature points.
typename FunctorReturnType< Moose::ADType< OutputType >::type, FunctorEvaluationKind::Gradient >::type GradientType
This rigmarole makes it so that a user can create functors that return containers (std::vector...
virtual const ADTemplateVariableCurl< OutputType > & adCurlSlnNeighbor() const override
AD curl neighbor solution getter.
void lowerDError() const
Throw and error when somebody requests lower-dimensional data from this variable. ...
Moose::DOFType< Real >::type OutputData
virtual const MooseArray< libMesh::Number > & dofValuesDuDotDuNeighbor() const override
virtual const FieldVariablePhiSecond & secondPhiNeighbor() const override final
Return the rank-2 tensor of second derivatives of the variable's shape functions on a neighboring ele...
virtual const ADTemplateVariableValue< OutputType > & adUDotDot() const override
AD second time derivative getter.
virtual void prepareLowerD() override final
Prepare a lower dimensional element's degrees of freedom.
libMesh::TensorTools::DecrementRank< OutputShape >::type OutputShapeDivergence
virtual const ADTemplateVariableGradient< OutputType > & adGradSlnNeighbor() const override
AD grad neighbor solution getter.
This data structure is used to store geometric and variable related metadata about each cell face in ...
virtual bool supportsFaceArg() const override final
Whether this functor supports evaluation with FaceArg.
virtual bool isFV() const override
virtual const FieldVariableValue & slnOld() const override
typename MooseVariableField< OutputType >::FieldVariablePhiValue FieldVariablePhiValue
void timeIntegratorError() const
Throw an error when somebody requests time-related data from this variable.
virtual std::size_t phiSize() const override final
Return phi size.
A structure defining a "face" evaluation calling argument for Moose functors.
const std::vector< std::unique_ptr< libMesh::NumericVector< libMesh::Number > > > & _grad_container
Pointer to the cell gradients which are stored on the linear system.
typename MooseVariableField< OutputType >::FieldVariablePhiGradient FieldVariablePhiGradient
virtual const MooseArray< ADReal > & adDofValuesNeighbor() const override
Return the AD neighbor dof values.
virtual void insertLower(libMesh::NumericVector< libMesh::Number > &vector) override
Insert the currently cached degree of freedom values for a lower-dimensional element into the provide...
const FaceInfo * fi
a face information object which defines our location in space
virtual const FieldVariablePhiValue & phiLower() const override
Return the variable's shape functions on a lower-dimensional element.
boundary_id_type BoundaryID
Point point
The physical location of the quadrature point.
virtual void reinitNode() override final
const FieldVariablePhiGradient & _grad_phi
virtual const FieldVariableValue & matrixTagValue(TagID tag) const override
const libMesh::Elem * elem
typename OutputTools< typename Moose::ADType< T >::type >::VariableGradient ADTemplateVariableGradient
const libMesh::Elem * elem
virtual void reinitNodes(const std::vector< dof_id_type > &) override final
Provides an interface for computing residual contributions from finite volume numerical fluxes comput...
std::unique_ptr< MooseVariableDataLinearFV< OutputType > > _element_data
Holder for all the data associated with the "main" element.
virtual const ADTemplateVariableGradient< OutputType > & adGradSlnNeighborDot() const override
AD grad of time derivative neighbor solution getter.
virtual unsigned int numberOfDofsNeighbor() override final
A structure that is used to evaluate Moose functors logically at an element/cell center.
typename MooseVariableField< OutputType >::FieldVariableGradient FieldVariableGradient
MooseLinearVariableFV(const InputParameters ¶meters)
Argument for requesting functor evaluation at a quadrature point location in an element.
virtual const dof_id_type & nodalDofIndex() const override final
virtual const MooseArray< libMesh::Number > & dofValuesDuDotDu() const override
const libMesh::Elem * elem
The element.
virtual const ADTemplateVariableSecond< OutputType > & adSecondSln() const override
AD second solution getter.
const FieldVariablePhiValue & curlPhi() const override final
Curl of the shape functions.
virtual const DoFValue & dofValuesDotDotNeighbor() const override
void nodalError() const
Throw an error when somebody wants to use this variable as a nodal variable.
virtual void jacobianSetup() override
virtual void prepareAux() override final
virtual void setDofValue(const OutputData &, unsigned int) override
Degree of freedom value setters.
virtual void reinitNodesNeighbor(const std::vector< dof_id_type > &) override final
virtual bool hasDoFsOnNodes() const override final
Does this variable have DoFs on nodes.
virtual const std::vector< dof_id_type > & dofIndicesLower() const override final
Get dof indices for the current lower dimensional element (this is meaningful when performing mortar ...
virtual bool computingSecond() const override final
Whether or not this variable is computing any second derivatives.
virtual const FieldVariablePhiGradient & gradPhiFaceNeighbor() const override final
Return the gradients of the variable's shape functions on a neighboring element face.
virtual const FieldVariableValue & slnNeighbor() const override
virtual bool isNodalDefined() const override final
Is this variable defined at nodes.
virtual const FieldVariableGradient & gradSlnNeighbor() const override
neighbor solution gradients
virtual const FieldVariableGradient & gradSlnOld() const override
virtual const FieldVariablePhiValue & phiNeighbor() const override final
Return the variable's shape functions on a neighboring element.
virtual const DoFValue & dofValuesOlderNeighbor() const override
virtual const MooseArray< OutputType > & nodalValueOldArray() const override
MooseMesh & _mesh
mesh the variable is active in
virtual const DoFValue & dofValuesDotDotOldNeighbor() const override
virtual void computeNodalNeighborValues() override final
Compute nodal values of this variable in the neighbor.
virtual void reinitAux() override final
virtual void add(libMesh::NumericVector< libMesh::Number > &vector) override
Add the currently cached degree of freedom values into the provided vector.
DIE A HORRIBLE DEATH HERE typedef LIBMESH_DEFAULT_SCALAR_TYPE Real
virtual void computeNeighborValuesFace() override
Compute values at facial quadrature points for the neighbor.
virtual const DoFValue & dofValuesNeighbor() const override
virtual bool usesSecondPhiNeighbor() const override final
Whether or not this variable is actually using the shape function second derivatives.
virtual const FieldVariableValue & vectorTagValue(TagID tag) const override
tag values getters
const FieldVariablePhiValue & _phi_face
std::unique_ptr< MooseVariableDataLinearFV< OutputType > > _neighbor_data
Holder for all the data associated with the "neighbor" element.
Moose::ADType< OutputType >::type ValueType
virtual void computeNodalValues() override final
Compute nodal values of this variable.
virtual void setLowerDofValues(const DenseVector< OutputData > &values) override
Set local DOF values for a lower dimensional element and evaluate the values on quadrature points...
const std::unordered_map< BoundaryID, LinearFVBoundaryCondition * > & getBoundaryConditionMap()
static InputParameters validParams()
virtual const DoFValue & dofValuesOld() const override
virtual std::size_t phiFaceNeighborSize() const override final
Return phiFaceNeighbor size.
virtual const dof_id_type & nodalDofIndexNeighbor() const override final
typename MooseVariableField< OutputType >::FieldVariablePhiDivergence FieldVariablePhiDivergence
Real getElemValue(const ElemInfo &elem_info, const StateArg &state) const
Get the solution value for the provided element and seed the derivative for the corresponding dof ind...
virtual void computeLowerDValues() override final
compute values at quadrature points on the lower dimensional element
void cacheBoundaryBCMap()
Setup the boundary to Dirichlet BC map.
virtual std::size_t phiLowerSize() const override final
Return the number of shape functions on the lower dimensional element for this variable.
virtual const DoFValue & dofValuesDot() const override
const FieldVariablePhiValue & _phi
Shape functions, only used when we are postprocessing or using this variable in an auxiliary system...
typename MooseVariableField< OutputType >::FieldVariableValue FieldVariableValue
void mooseError(Args &&... args) const
Emits an error prefixed with object name and type.
virtual const DoFValue & dofValuesPreviousNLNeighbor() const override
virtual const DoFValue & dofValuesDotOldNeighbor() const override
virtual void insert(libMesh::NumericVector< libMesh::Number > &vector) override
Insert the currently cached degree of freedom values into the provided vector.
virtual const ADTemplateVariableValue< OutputType > & adUDotNeighbor() const override
AD neighbor time derivative getter.
const InputParameters & parameters() const
Get the parameters of the object.
State argument for evaluating functors.
virtual std::size_t phiNeighborSize() const override final
Return phiNeighbor size.
virtual void computeFaceValues(const FaceInfo &) override
Compute values at face quadrature points for the element+neighbor (both sides of the face)...
virtual const ADTemplateVariableValue< OutputType > & adSlnNeighbor() const override
AD neighbor solution getter.
virtual void prepareIC() override
Prepare the initial condition.
virtual bool needsGradientVectorStorage() const override
Check if cell gradient computations were requested for this variable.
virtual bool computingCurl() const override final
Whether or not this variable is computing any curl quantities.
libMesh::TensorTools::DecrementRank< Real >::type OutputDivergence
virtual const DoFValue & dofValuesDotDot() const override
virtual const ADTemplateVariableSecond< OutputType > & adSecondSlnNeighbor() const override
AD second neighbor solution getter.
virtual void computeNeighborValues() override
Compute values at quadrature points for the neighbor.
Class used for caching additional information for elements such as the volume and centroid...
virtual libMesh::FEContinuity getContinuity() const override
Return the continuity of this variable.
const libMesh::NumericVector< libMesh::Number > *const & _solution
The current (ghosted) solution.
virtual const FieldVariablePhiGradient & gradPhiNeighbor() const override final
Return the gradients of the variable's shape functions on a neighboring element.
void computeCellGradients()
Switch to request cell gradient computations.
virtual const MooseArray< libMesh::Number > & dofValuesDuDotDotDu() const override
virtual unsigned int oldestSolutionStateRequested() const override final
The oldest solution state that is requested for this variable (0 = current, 1 = old, 2 = older, etc).
virtual const DoFValue & dofValuesDotDotOld() const override
const libMesh::Elem * elem
The element.
virtual const MooseArray< ADReal > & adDofValuesDot() const override
Return the AD time derivatives at dofs.
typename MooseVariableField< OutputType >::DoFValue DoFValue
const FieldVariablePhiValue & _phi_neighbor
This class provides variable solution interface for linear finite volume problems.
virtual unsigned int numberOfDofs() const override final
Get the number of local DoFs.
virtual const FieldVariableValue & slnOlder() const override
virtual const ADTemplateVariableValue< OutputType > & adUDot() const override
AD time derivative getter.
virtual bool computingDiv() const override final
Whether or not this variable is computing any divergence quantities.
virtual const FieldVariableGradient & gradSln() const override
element gradients
virtual const ADTemplateVariableGradient< OutputType > & adGradSln() const override
AD grad solution getter.
virtual GradientType evaluateGradient(const ElemQpArg &qp_arg, const StateArg &) const override final
Argument for requesting functor evaluation at quadrature point locations on an element side...
virtual const FieldVariablePhiValue & phiFaceNeighbor() const override final
Return the variable's shape functions on a neighboring element face.
const ElemInfo & elemInfo(const dof_id_type id) const
Accessor for the elemInfo object for a given element ID.
Moose::ShapeType< Real >::type OutputShape
virtual const DoFValue & nodalVectorTagValue(TagID) const override
bool _needs_cell_gradients
Boolean to check if this variable needs gradient computations.
virtual const FieldVariableValue & slnOldNeighbor() const override
virtual ValueType evaluate(const ElemArg &elem, const StateArg &) const override final
Evaluate the functor with a given element.
virtual const ADTemplateVariableValue< OutputType > & adUDotDotNeighbor() const override
AD neighbor second time derivative getter.