23 if (pf) {
pfes = pf; }
37 MFEM_ASSERT(
pfes != NULL,
"not a ParFiniteElementSpace");
61 MPI_Allreduce(&local, ¶llel, 1, MPI_C_BOOL, MPI_LAND,
pfes->
GetComm());
82 int Elem2Nbr = tr->Elem2No - pmesh->
GetNE();
83 fes -> GetElementVDofs (tr -> Elem1No, vdofs);
85 AssembleRHSElementVect(*
fes->
GetFE(tr->Elem1No),
Class FiniteElementSpace - responsible for providing FEM view of the mesh, mainly managing the set of...
virtual const FiniteElement * GetFE(int i) const
Returns pointer to the FiniteElement in the FiniteElementCollection associated with i'th element in t...
Wrapper for hypre's parallel vector class.
int GetNE() const
Returns number of elements.
virtual void MultTranspose(const Vector &x, Vector &y) const
Action of the transpose operator: y=A^t(x). The default behavior in class Operator is to generate an ...
Abstract parallel finite element space.
void ExchangeFaceNbrData()
HypreParVector * NewTrueDofVector()
const Operator * GetProlongationMatrix() const override
The returned Operator is owned by the FiniteElementSpace.
ParMesh * GetParMesh() const
const FiniteElement * GetFaceNbrFE(int i) const
Class for parallel meshes.
int GetNSharedFaces() const
Return the number of shared faces (3D), edges (2D), vertices (1D)
FaceElementTransformations * GetSharedFaceTransformations(int sf, bool fill2=true)
Get the FaceElementTransformations for the given shared face (edge 2D) using the shared face index sf...
void AddElementVector(const Array< int > &dofs, const Vector &elemvect)
Add elements of the elemvect Vector to the entries listed in dofs. Negative dof values cause the -dof...
std::function< real_t(const Vector &)> f(real_t mass_coeff)