18 #include "libmesh/quadrature.h" 34 _var(*mooseVariable()),
35 _normals(_assembly.normals()),
36 _phi(_assembly.phiFace(_var)),
37 _test(_var.phiFace()),
38 _u(_is_implicit ? _var.sln() : _var.slnOld()),
54 "saved-in auxiliary variable is incompatible with the object's nonlinear variable: ",
70 "saved-in auxiliary variable is incompatible with the object's nonlinear variable: ",
94 "Size of local residual is not equal to the number of array variable compoments");
104 Threads::spin_mutex::scoped_lock lock(Threads::spin_mtx);
111 mooseError(
"Save-in variable for an array kernel must be an array variable");
138 Threads::spin_mutex::scoped_lock lock(Threads::spin_mtx);
145 mooseError(
"Save-in variable for an array kernel must be an array variable");
153 return RealEigenVector::Zero(
_var.
count());
167 auto phi_size = jvar.dofIndices().size();
173 for (
_j = 0;
_j < phi_size;
_j++)
186 Threads::spin_mutex::scoped_lock lock(Threads::spin_mtx);
193 mooseError(
"Save-in variable for an array kernel must be an array variable");
const libMesh::FEType & feType() const
Get the type of finite element object.
RealEigenVector _work_vector
Work vector for residual.
void accumulateTaggedLocalResidual()
Local residual blocks will be appended by adding the current local kernel residual.
std::vector< MooseVariableFEBase * > _diag_save_in
Class for stuff related to variables.
const ArrayVariablePhiValue & _phi
shape function values (in QPs)
virtual void computeQpResidual(RealEigenVector &residual)=0
Method for computing the residual at quadrature points, to be filled in residual. ...
std::string incompatVarMsg(MooseVariableFieldBase &var1, MooseVariableFieldBase &var2)
Builds and returns a string of the form:
std::vector< MooseVariableFEBase * > _save_in
unsigned int number() const
Get variable number coming from libMesh.
void saveDiagLocalArrayJacobian(DenseMatrix< Number > &ke, unsigned int i, unsigned int ntest, unsigned int j, unsigned int nphi, unsigned int ivar, const RealEigenVector &v) const
Helper function for assembling diagonal Jacobian contriubutions on local quadrature points for an arr...
void addSolution(const DenseVector< libMesh::Number > &v)
Add passed in local DOF values onto the current solution.
unsigned int count() const
Get the number of components Note: For standard and vector variables, the number is one...
unsigned int _i
i-th, j-th index for enumerating test and shape functions
This class provides an interface for common operations on field variables of both FE and FV types wit...
const unsigned int _count
Number of components of the array variable.
static InputParameters validParams()
void saveLocalArrayResidual(DenseVector< Number > &re, unsigned int i, unsigned int ntest, const RealEigenVector &v) const
Helper function for assembling residual contriubutions on local quadrature points for an array kernel...
virtual RealEigenMatrix computeQpOffDiagJacobianScalar(const MooseVariableScalar &jvar)
This is the virtual that derived classes should override for computing a full Jacobian component...
THREAD_ID _tid
The thread ID for this kernel.
DenseVector< Real > getJacobianDiagonal(DenseMatrix< Number > &ke)
ArrayIntegratedBC(const InputParameters ¶meters)
DenseMatrix< Number > _local_ke
Holds local Jacobian entries as they are accumulated by this Kernel.
const MooseVariableFieldBase & getVariable(unsigned int jvar_num) const
Retrieve the variable object from our system associated with jvar_num.
unsigned int _qp
quadrature point index
virtual void computeJacobian() override
Compute this object's contribution to the diagonal Jacobian entries.
virtual RealEigenMatrix computeQpOffDiagJacobian(const MooseVariableFEBase &jvar)
Method for computing an off-diagonal jacobian component at quadrature points.
SystemBase & _sys
Reference to the EquationSystem object.
MooseVariableFE< RealEigenVector > * mooseVariable() const
Return the MooseVariableFE object that this interface acts on.
void computeOffDiagJacobianScalar(unsigned int jvar) override
Computes jacobian block with respect to a scalar variable.
unsigned int size() const
The number of elements that can currently be stored in the array.
std::vector< AuxVariableName > _save_in_strings
SubProblem & _subproblem
Reference to this kernel's SubProblem.
virtual void initQpJacobian()
Put necessary evaluations depending on qp but independent on test and shape functions here...
VarKindType
Framework-wide stuff.
ArrayMooseVariable & _var
virtual void initQpResidual()
Put necessary evaluations depending on qp but independent on test functions here. ...
virtual ArrayMooseVariable & getArrayVariable(const THREAD_ID tid, const std::string &var_name)=0
Returns the variable reference for requested ArrayMooseVariable which may be in any system...
void paramError(const std::string ¶m, Args... args) const
Emits an error prefixed with the file and line number of the given param (from the input file) along ...
Eigen::Matrix< Real, Eigen::Dynamic, Eigen::Dynamic > RealEigenMatrix
void accumulateTaggedLocalMatrix()
Local Jacobian blocks will be appended by adding the current local kernel Jacobian.
const MooseArray< Real > & _coord
coordinate transformation
bool _has_save_in
The aux variables to save the residual contributions to.
Assembly & _assembly
Reference to this Kernel's assembly object.
virtual void computeOffDiagJacobian(unsigned int jvar) override
Computes d-ivar-residual / d-jvar...
libMesh::Order order() const
Get the order of this variable Note: Order enum can be implicitly converted to unsigned int...
virtual MooseVariableScalar & getScalarVariable(THREAD_ID tid, const std::string &var_name) const
Gets a reference to a scalar variable with specified number.
const QBase *const & _qrule
active quadrature rule
void addMooseVariableDependency(MooseVariableFieldBase *var)
Call this function to add the passed in MooseVariableFieldBase as a variable that this object depends...
virtual void initQpOffDiagJacobian(const MooseVariableFEBase &)
Put necessary evaluations depending on qp but independent on test and shape functions here for off-di...
std::vector< AuxVariableName > _diag_save_in_strings
virtual void addVariableToZeroOnResidual(std::string var_name)
Adds this variable to the list of variables to be zeroed during each residual evaluation.
const ArrayVariableTestValue & _test
test function values (in QPs)
DenseVector< Number > _local_re
Holds local residual entries as they are accumulated by this Kernel.
static InputParameters validParams()
Interface for objects that need to get values of MooseVariables.
Class for scalar variables (they are different).
void mooseError(Args &&... args) const
Emits an error prefixed with object name and type.
Base class for deriving any boundary condition of a integrated type.
virtual void addVariableToZeroOnJacobian(std::string var_name)
Adds this variable to the list of variables to be zeroed during each Jacobian evaluation.
Eigen::Matrix< Real, Eigen::Dynamic, 1 > RealEigenVector
MOOSE now contains C++17 code, so give a reasonable error message stating what the user can do to add...
void prepareVectorTag(Assembly &assembly, unsigned int ivar)
Prepare data for computing element residual according to active tags.
void prepareMatrixTag(Assembly &assembly, unsigned int ivar, unsigned int jvar)
Prepare data for computing element jacobian according to the active tags.
void saveFullLocalArrayJacobian(DenseMatrix< Number > &ke, unsigned int i, unsigned int ntest, unsigned int j, unsigned int nphi, unsigned int ivar, unsigned int jvar, const RealEigenMatrix &v) const
Helper function for assembling full Jacobian contriubutions on local quadrature points for an array k...
bool _has_diag_save_in
The aux variables to save the diagonal Jacobian contributions to.
SystemBase & sys()
Get the system this variable is part of.
void ErrorVector unsigned int
const MooseArray< Real > & _JxW
transformed Jacobian weights
virtual void computeResidual() override
Compute this object's contribution to the residual.
virtual RealEigenVector computeQpJacobian()
Method for computing the diagonal Jacobian at quadrature points.