12#ifndef MFEM_NONLININTEG
13#define MFEM_NONLININTEG
335 DenseMatrix DSh, DS, Jrt, Jpr, Jpt, P, PMatI, PMatO;
365 DenseMatrix DSh_u, DS_u, J0i, J, J1, Finv, P, F, FinvT;
366 DenseMatrix PMatI_u, PMatO_u, PMatI_p, PMatO_p, Z, G, C;
394 DenseMatrix dshape, dshapex, EF, gradEF, ELV, elmat_comp;
439 DenseMatrix dshape, dshapex, EF, gradEF, ELV, elmat_comp;
462 DenseMatrix dshape, dshapex, EF, gradEF, ELV, elmat_comp;
Dynamic 2D array using row-major layout.
Base class Coefficients that optionally depend on space and time. These are used by the BilinearFormI...
ConvectiveVectorConvectionNLFIntegrator()=default
virtual void AssembleElementGrad(const FiniteElement &el, ElementTransformation &trans, const Vector &elfun, DenseMatrix &elmat)
Assemble the local gradient matrix.
ConvectiveVectorConvectionNLFIntegrator(Coefficient &q)
Data type dense matrix using column-major storage.
Structure representing the matrices/tensors needed to evaluate (in reference space) the values,...
Class FiniteElementSpace - responsible for providing FEM view of the mesh, mainly managing the set of...
Abstract class for all finite elements.
Structure for storing mesh geometric factors: coordinates, Jacobians, and determinants of the Jacobia...
Abstract class for hyperelastic models.
virtual void AssembleH(const DenseMatrix &Jpt, const DenseMatrix &DS, const real_t weight, DenseMatrix &A) const =0
Evaluate the derivative of the 1st Piola-Kirchhoff stress tensor and assemble its contribution to the...
virtual real_t EvalW(const DenseMatrix &Jpt) const =0
Evaluate the strain energy density function, W = W(Jpt).
ElementTransformation * Ttr
virtual ~HyperelasticModel()
virtual void EvalP(const DenseMatrix &Jpt, DenseMatrix &P) const =0
Evaluate the 1st Piola-Kirchhoff stress tensor, P = P(Jpt).
void SetTransformation(ElementTransformation &Ttr_)
virtual void AssembleElementGrad(const FiniteElement &el, ElementTransformation &Ttr, const Vector &elfun, DenseMatrix &elmat)
Assemble the local gradient matrix.
virtual real_t GetElementEnergy(const FiniteElement &el, ElementTransformation &Ttr, const Vector &elfun)
Computes the integral of W(Jacobian(Trt)) over a target zone.
HyperelasticNLFIntegrator(HyperelasticModel *m)
virtual void AssembleElementVector(const FiniteElement &el, ElementTransformation &Ttr, const Vector &elfun, Vector &elvect)
Perform the local action of the NonlinearFormIntegrator.
virtual void AssembleElementVector(const Array< const FiniteElement * > &el, ElementTransformation &Tr, const Array< const Vector * > &elfun, const Array< Vector * > &elvec)
Perform the local action of the NonlinearFormIntegrator.
virtual void AssembleElementGrad(const Array< const FiniteElement * > &el, ElementTransformation &Tr, const Array< const Vector * > &elfun, const Array2D< DenseMatrix * > &elmats)
Assemble the local gradient matrix.
IncompressibleNeoHookeanIntegrator(Coefficient &mu_)
virtual real_t GetElementEnergy(const Array< const FiniteElement * > &el, ElementTransformation &Tr, const Array< const Vector * > &elfun)
Compute the local energy.
Class for an integration rule - an Array of IntegrationPoint.
virtual void AssembleH(const DenseMatrix &J, const DenseMatrix &DS, const real_t weight, DenseMatrix &A) const
Evaluate the derivative of the 1st Piola-Kirchhoff stress tensor and assemble its contribution to the...
virtual real_t EvalW(const DenseMatrix &J) const
Evaluate the strain energy density function, W = W(Jpt).
virtual void EvalP(const DenseMatrix &J, DenseMatrix &P) const
Evaluate the 1st Piola-Kirchhoff stress tensor, P = P(Jpt).
Class for defining different integration rules on each NURBS patch.
virtual void EvalP(const DenseMatrix &J, DenseMatrix &P) const
Evaluate the 1st Piola-Kirchhoff stress tensor, P = P(Jpt).
virtual real_t EvalW(const DenseMatrix &J) const
Evaluate the strain energy density function, W = W(Jpt).
virtual void AssembleH(const DenseMatrix &J, const DenseMatrix &DS, const real_t weight, DenseMatrix &A) const
Evaluate the derivative of the 1st Piola-Kirchhoff stress tensor and assemble its contribution to the...
NeoHookeanModel(real_t mu_, real_t K_, real_t g_=1.0)
NeoHookeanModel(Coefficient &mu_, Coefficient &K_, Coefficient *g_=NULL)
SkewSymmetricVectorConvectionNLFIntegrator()=default
virtual void AssembleElementGrad(const FiniteElement &el, ElementTransformation &trans, const Vector &elfun, DenseMatrix &elmat)
Assemble the local gradient matrix.
SkewSymmetricVectorConvectionNLFIntegrator(Coefficient &q)
virtual void AssemblePA(const FiniteElementSpace &fes)
Method defining partial assembly.
virtual void AddMultPA(const Vector &x, Vector &y) const
Method for partially assembled action.
virtual void AssembleMF(const FiniteElementSpace &fes)
Method defining fully unassembled operator.
virtual void AssembleElementVector(const FiniteElement &el, ElementTransformation &trans, const Vector &elfun, Vector &elvect)
Perform the local action of the NonlinearFormIntegrator.
VectorConvectionNLFIntegrator()=default
virtual void AssembleElementGrad(const FiniteElement &el, ElementTransformation &trans, const Vector &elfun, DenseMatrix &elmat)
Assemble the local gradient matrix.
static const IntegrationRule & GetRule(const FiniteElement &fe, ElementTransformation &T)
virtual void AddMultMF(const Vector &x, Vector &y) const
VectorConvectionNLFIntegrator(Coefficient &q)
void trans(const Vector &u, Vector &x)
MemoryType
Memory types supported by MFEM.