MFEM  v4.4.0
Finite element discretization library
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Pages
Public Member Functions | Protected Attributes | List of all members
mfem::SBM2NeumannIntegrator Class Reference

#include <sbm_solver.hpp>

Inheritance diagram for mfem::SBM2NeumannIntegrator:
[legend]
Collaboration diagram for mfem::SBM2NeumannIntegrator:
[legend]

Public Member Functions

 SBM2NeumannIntegrator (const ParMesh *pmesh, VectorCoefficient &vD_, ShiftedVectorFunctionCoefficient &vN_, Array< int > &elem_marker_, Array< int > &cut_marker_, bool include_cut_cell_=false, int nterms_=1)
 
virtual void AssembleFaceMatrix (const FiniteElement &el1, const FiniteElement &el2, FaceElementTransformations &Trans, DenseMatrix &elmat)
 
bool GetTrimFlag () const
 
virtual ~SBM2NeumannIntegrator ()
 
- Public Member Functions inherited from mfem::BilinearFormIntegrator
virtual void AssemblePA (const FiniteElementSpace &fes)
 Method defining partial assembly. More...
 
virtual void AssemblePA (const FiniteElementSpace &trial_fes, const FiniteElementSpace &test_fes)
 
virtual void AssemblePAInteriorFaces (const FiniteElementSpace &fes)
 
virtual void AssemblePABoundaryFaces (const FiniteElementSpace &fes)
 
virtual void AssembleDiagonalPA (Vector &diag)
 Assemble diagonal and add it to Vector diag. More...
 
virtual void AssembleDiagonalPA_ADAt (const Vector &D, Vector &diag)
 Assemble diagonal of ADA^T (A is this integrator) and add it to diag. More...
 
virtual void AddMultPA (const Vector &x, Vector &y) const
 Method for partially assembled action. More...
 
virtual void AddMultTransposePA (const Vector &x, Vector &y) const
 Method for partially assembled transposed action. More...
 
virtual void AssembleEA (const FiniteElementSpace &fes, Vector &emat, const bool add=true)
 Method defining element assembly. More...
 
virtual void AssembleMF (const FiniteElementSpace &fes)
 Method defining matrix-free assembly. More...
 
virtual void AddMultMF (const Vector &x, Vector &y) const
 
virtual void AddMultTransposeMF (const Vector &x, Vector &y) const
 
virtual void AssembleDiagonalMF (Vector &diag)
 Assemble diagonal and add it to Vector diag. More...
 
virtual void AssembleEAInteriorFaces (const FiniteElementSpace &fes, Vector &ea_data_int, Vector &ea_data_ext, const bool add=true)
 
virtual void AssembleEABoundaryFaces (const FiniteElementSpace &fes, Vector &ea_data_bdr, const bool add=true)
 
virtual void AssembleElementMatrix (const FiniteElement &el, ElementTransformation &Trans, DenseMatrix &elmat)
 Given a particular Finite Element computes the element matrix elmat. More...
 
virtual void AssembleElementMatrix2 (const FiniteElement &trial_fe, const FiniteElement &test_fe, ElementTransformation &Trans, DenseMatrix &elmat)
 
virtual void AssembleFaceMatrix (const FiniteElement &trial_face_fe, const FiniteElement &test_fe1, const FiniteElement &test_fe2, FaceElementTransformations &Trans, DenseMatrix &elmat)
 
virtual void AssembleElementVector (const FiniteElement &el, ElementTransformation &Tr, const Vector &elfun, Vector &elvect)
 Perform the local action of the BilinearFormIntegrator. Note that the default implementation in the base class is general but not efficient. More...
 
virtual void AssembleFaceVector (const FiniteElement &el1, const FiniteElement &el2, FaceElementTransformations &Tr, const Vector &elfun, Vector &elvect)
 Perform the local action of the BilinearFormIntegrator resulting from a face integral term. Note that the default implementation in the base class is general but not efficient. More...
 
virtual void AssembleElementGrad (const FiniteElement &el, ElementTransformation &Tr, const Vector &elfun, DenseMatrix &elmat)
 Assemble the local gradient matrix. More...
 
virtual void AssembleFaceGrad (const FiniteElement &el1, const FiniteElement &el2, FaceElementTransformations &Tr, const Vector &elfun, DenseMatrix &elmat)
 Assemble the local action of the gradient of the NonlinearFormIntegrator resulting from a face integral term. More...
 
virtual void ComputeElementFlux (const FiniteElement &el, ElementTransformation &Trans, Vector &u, const FiniteElement &fluxelem, Vector &flux, bool with_coef=true)
 Virtual method required for Zienkiewicz-Zhu type error estimators. More...
 
virtual double ComputeFluxEnergy (const FiniteElement &fluxelem, ElementTransformation &Trans, Vector &flux, Vector *d_energy=NULL)
 Virtual method required for Zienkiewicz-Zhu type error estimators. More...
 
virtual ~BilinearFormIntegrator ()
 
- Public Member Functions inherited from mfem::NonlinearFormIntegrator
virtual void SetIntRule (const IntegrationRule *ir)
 Prescribe a fixed IntegrationRule to use (when ir != NULL) or let the integrator choose (when ir == NULL). More...
 
void SetIntegrationRule (const IntegrationRule &ir)
 Prescribe a fixed IntegrationRule to use. More...
 
void SetPAMemoryType (MemoryType mt)
 
const IntegrationRuleGetIntegrationRule () const
 Get the integration rule of the integrator (possibly NULL). More...
 
virtual double GetElementEnergy (const FiniteElement &el, ElementTransformation &Tr, const Vector &elfun)
 Compute the local energy. More...
 
virtual void AssembleGradPA (const Vector &x, const FiniteElementSpace &fes)
 Prepare the integrator for partial assembly (PA) gradient evaluations on the given FE space fes at the state x. More...
 
virtual double GetLocalStateEnergyPA (const Vector &x) const
 Compute the local (to the MPI rank) energy with partial assembly. More...
 
virtual void AddMultGradPA (const Vector &x, Vector &y) const
 Method for partially assembled gradient action. More...
 
virtual void AssembleGradDiagonalPA (Vector &diag) const
 Method for computing the diagonal of the gradient with partial assembly. More...
 
virtual bool SupportsCeed () const
 Indicates whether this integrator can use a Ceed backend. More...
 
ceed::Operator & GetCeedOp ()
 
virtual ~NonlinearFormIntegrator ()
 

Protected Attributes

ShiftedVectorFunctionCoefficientvN
 
VectorCoefficientvD
 
Array< int > * elem_marker
 
bool include_cut_cell
 
int nterms
 
int NEproc
 
int par_shared_face_count
 
Array< int > cut_marker
 
Vector shape
 
Vector dshapedn
 
Vector nor
 
Vector nh
 
Vector ni
 
DenseMatrix dshape
 
DenseMatrix adjJ
 
- Protected Attributes inherited from mfem::NonlinearFormIntegrator
const IntegrationRuleIntRule
 
ceed::Operator * ceedOp
 
MemoryType pa_mt = MemoryType::DEFAULT
 

Additional Inherited Members

- Protected Member Functions inherited from mfem::BilinearFormIntegrator
 BilinearFormIntegrator (const IntegrationRule *ir=NULL)
 
- Protected Member Functions inherited from mfem::NonlinearFormIntegrator
 NonlinearFormIntegrator (const IntegrationRule *ir=NULL)
 

Detailed Description

BilinearFormIntegrator for Neumann boundaries using the shifted boundary method. A(u,w) = <[nabla u + nabla(nabla u).d + h.o.t.].nhat(n.nhat),w>-<grad u.n,w> where h.o.t are the high-order terms due to Taylor expansion for nabla u, nhat is the normal vector at the true boundary, n is the normal vector at the surrogate boundary. Since this interior face integrator is applied to the surrogate boundary (see marking.hpp for notes on how the surrogate faces are determined and elements are marked), this integrator adds contribution to only the element that is adjacent to that face (Trans.Elem1 or Trans.Elem2) and is part of the surrogate domain.

Definition at line 208 of file sbm_solver.hpp.

Constructor & Destructor Documentation

mfem::SBM2NeumannIntegrator::SBM2NeumannIntegrator ( const ParMesh pmesh,
VectorCoefficient vD_,
ShiftedVectorFunctionCoefficient vN_,
Array< int > &  elem_marker_,
Array< int > &  cut_marker_,
bool  include_cut_cell_ = false,
int  nterms_ = 1 
)
inline

Definition at line 229 of file sbm_solver.hpp.

virtual mfem::SBM2NeumannIntegrator::~SBM2NeumannIntegrator ( )
inlinevirtual

Definition at line 252 of file sbm_solver.hpp.

Member Function Documentation

void mfem::SBM2NeumannIntegrator::AssembleFaceMatrix ( const FiniteElement el1,
const FiniteElement el2,
FaceElementTransformations Trans,
DenseMatrix elmat 
)
virtual

Reimplemented from mfem::BilinearFormIntegrator.

Definition at line 646 of file sbm_solver.cpp.

bool mfem::SBM2NeumannIntegrator::GetTrimFlag ( ) const
inline

Definition at line 250 of file sbm_solver.hpp.

Member Data Documentation

DenseMatrix mfem::SBM2NeumannIntegrator::adjJ
protected

Definition at line 225 of file sbm_solver.hpp.

Array<int> mfem::SBM2NeumannIntegrator::cut_marker
protected

Definition at line 220 of file sbm_solver.hpp.

DenseMatrix mfem::SBM2NeumannIntegrator::dshape
protected

Definition at line 225 of file sbm_solver.hpp.

Vector mfem::SBM2NeumannIntegrator::dshapedn
protected

Definition at line 224 of file sbm_solver.hpp.

Array<int>* mfem::SBM2NeumannIntegrator::elem_marker
protected

Definition at line 213 of file sbm_solver.hpp.

bool mfem::SBM2NeumannIntegrator::include_cut_cell
protected

Definition at line 215 of file sbm_solver.hpp.

int mfem::SBM2NeumannIntegrator::NEproc
protected

Definition at line 218 of file sbm_solver.hpp.

Vector mfem::SBM2NeumannIntegrator::nh
protected

Definition at line 224 of file sbm_solver.hpp.

Vector mfem::SBM2NeumannIntegrator::ni
protected

Definition at line 224 of file sbm_solver.hpp.

Vector mfem::SBM2NeumannIntegrator::nor
protected

Definition at line 224 of file sbm_solver.hpp.

int mfem::SBM2NeumannIntegrator::nterms
protected

Definition at line 216 of file sbm_solver.hpp.

int mfem::SBM2NeumannIntegrator::par_shared_face_count
protected

Definition at line 219 of file sbm_solver.hpp.

Vector mfem::SBM2NeumannIntegrator::shape
protected

Definition at line 224 of file sbm_solver.hpp.

VectorCoefficient* mfem::SBM2NeumannIntegrator::vD
protected

Definition at line 212 of file sbm_solver.hpp.

ShiftedVectorFunctionCoefficient* mfem::SBM2NeumannIntegrator::vN
protected

Definition at line 211 of file sbm_solver.hpp.


The documentation for this class was generated from the following files: