Dune Namespace Reference
Detailed Description
Some simple static information for a given GridType.put vtk io intro here ...
Classes | |
class | CommunicatorInterface |
class | AGMemoryProvider |
organize the memory management for entitys used by the NeighborIterator More... | |
class | AlbertaMarkerVector |
class | AlbertaGridGeometry |
class | AlbertaGridEntity |
class | AlbertaGridEntity< 0, dim, GridImp > |
class | AlbertaGridEntityPointer |
class | AlbertaGridHierarchicIterator |
class | AlbertaGridIntersectionIterator |
class | AlbertaGridTreeIterator |
class | AlbertaGridLevelIterator |
class | AlbertaGridLeafIterator |
LeafIterator which is just a hull for the LevelIterator. More... | |
class | AlbertaGrid |
[ provides Dune::Grid ] Provides the simplicial meshes of the finite element tool box ALBERTA (http://www.alberta-fem.de/) written by Kunibert Siebert and Alfred Schmidt. More... | |
struct | AlbertaGridHierarchicIteratorTypes |
HierarchicIndexSet uses LeafIterator tpyes for all codims and partition types. More... | |
class | AlbertaGridIdSet |
hierarchic index set of AlbertaGrid More... | |
class | ALU2dGridEntity |
class | ALU2dGridEntity< 0, dim, GridImp > |
class | ALU2dGridEntityPointer |
class | ALU2dGridGeometry |
class | ALU2dGrid |
[ provides Dune::Grid ] 2D grid, will provide non conform grids The ALU2dGrid implements the Dune GridInterface for 2d meshes. This grid can be locally adapted and will provide non conform grids. More... | |
struct | ALU2dGridHierarchicIteratorTypes |
HierarchicIndexSet uses LeafIterator tpyes for all codims and partition types. More... | |
class | ALU2dGridHierarchicIndexSet |
hierarchic index set of ALU2dGrid More... | |
class | ALU2dGridLocalIdSet |
hierarchic index set of ALU3dGrid More... | |
class | ALU2dGridIntersectionBase |
class | ALU2dGridHierarchicIterator |
Hierarichic Iterator of ALU2dGrid. More... | |
class | ALU3dGridVertexList |
class | ALU3dGridLeafVertexList |
class | ALU3dGridEntity |
class | ALU3dGridEntity< 0, dim, GridImp > |
class | ALU3dGridEntityPointerBase |
class | ALU3dGridEntityPointer< 0, GridImp > |
class | ALU3dGridGeometricFaceInfoBase |
class | ALU3dGridGeometricFaceInfoTetra |
class | ALU3dGridGeometricFaceInfoHexa |
class | ALU3dGridGeometry |
class | ALU3dGridGeometry< mydim, cdim, const ALU3dGrid< 3, 3, tetra > > |
Specialisation for tetrahedra. More... | |
class | ALU3dGridGeometry< mydim, cdim, const ALU3dGrid< 3, 3, hexa > > |
Specialisation for hexahedra. More... | |
class | ALU3dGrid |
[ provides Dune::Grid ] 3D grid with support for hexahedrons and tetrahedrons. The ALU3dGrid implements the Dune GridInterface for 3d tetrahedral and hexahedral meshes. This grid can be locally adapted and used in parallel computations using dynamcic load balancing. More... | |
struct | ALU3dGridHierarchicIteratorTypes |
HierarchicIndexSet uses LeafIterator tpyes for all codims and partition types. More... | |
class | ALU3dGridHierarchicIndexSet |
hierarchic index set of ALU3dGrid More... | |
class | ALU3dGridGlobalIdSet |
global id set for ALU3dGrid More... | |
class | ALU3dGridLocalIdSet |
hierarchic index set of ALU3dGrid More... | |
class | ALU3dGridIntersectionIterator |
class | ALU3dGridLevelIterator |
class | ALU3dGridLeafIterator |
Leaf iterator. More... | |
class | TrilinearMapping |
class | BilinearSurfaceMapping |
A bilinear surface mapping. More... | |
class | NonConformingFaceMapping |
class | NonConformingFaceMapping< tetra > |
Non-conforming face mappings for tetrahedra. More... | |
class | NonConformingFaceMapping< hexa > |
Non-conforming face mappings for hexahedra. More... | |
class | ALUFastMemoryProvider |
organize the memory management for entitys used by the NeighborIterator More... | |
class | ALUMemoryProvider |
organize the memory management for entitys used by the NeighborIterator More... | |
class | ElementTopologyMapping |
class | FaceTopologyMapping |
class | ALUCubeGrid |
[ provides Dune::Grid ] 3D grid with support for hexahedrons. More... | |
class | ALUCubeGrid< 3, 3 > |
[ provides Dune::Grid ] 3D grid with support for hexahedrons. More... | |
class | ALUSimplexGrid |
[ provides Dune::Grid ] grid with support for simplicial mesh in 2d and 3d. More... | |
class | ALUSimplexGrid< 3, 3 > |
[ provides Dune::Grid ] grid with support for simplicial mesh in 3d. More... | |
class | ALUSimplexGrid< 2, 2 > |
[ provides Dune::Grid ] grid with support for simplicial mesh in 2d. More... | |
class | ALUConformGrid |
[ provides Dune::Grid ] grid with support for simplicial mesh in 2d and 3d. More... | |
class | ALUConformGrid< 2, 2 > |
[ provides Dune::Grid ] grid with support for simplicial mesh in 2d. More... | |
class | BoundarySegment |
Base class for classes implementing geometries of boundary segments. More... | |
class | MessageBufferIF |
Communication message buffer interface. This class describes the interface for reading and writing data to the communication message buffer. As message buffers might be deeply implemented in various packages the message buffers implementations cannot be derived from this interface class. Therefore we just apply the engine concept to wrap the message buffer call and make sure that the interface is fulfilled. More... | |
class | CommDataHandleIF |
CommDataHandleIF describes the features of a data handle for communication in parallel runs using the Grid::communicate methods. Here the Barton-Nackman trick is used to interprete data handle objects as it's interface. Therefore usable data handle classes need to be derived from this class. More... | |
class | DefaultEmptyIndexSet |
class | IndexSetWrapper |
class | DefaultGridIndexSetBase |
default base class for index set implementations for FR numerics More... | |
class | WrappedLevelIndexSet |
Wraps LevelIndexSet for use with LagrangeFunctionSpace. More... | |
class | HierarchicIndexSetSelector |
compile time chooser for hierarchic or leaf index set More... | |
class | WrappedHierarchicIndexSet |
Wraps HierarchicIndex Sets of AlbertaGrid and ALUGrid. More... | |
class | WrappedLeafIndexSet |
Wraps LeafIndexSet of Dune Grids for use with LagrangeFunctionSpace. More... | |
struct | CheckLevelForCodim |
DefaultLevelIndexSet generates a level index set for a grid out of a grids hierarchic index set by storing for each entity in the grid a number in an array. More... | |
class | DefaultLevelIndexSet |
DefaultLevelIndexSet creates a LevelIndexSet for a Grid by using its HierarchicIndexSet. More... | |
struct | DefaultLeafIteratorTypes |
LeafIterator tpyes for all codims and partition types. More... | |
class | DefaultLeafIndexSet |
Default LeafIndexSet. More... | |
class | CombinedAdaptProlongRestrict |
class for combining 2 index sets together for adaptation process More... | |
class | Entity |
Wrapper class for entities. More... | |
class | Entity< 0, dim, GridImp, EntityImp > |
Template specialization of Dune::Entity for Elements (codim==0). More... | |
class | EntityDefaultImplementation |
Default Implementations for EntityImp. More... | |
class | EntityDefaultImplementation< 0, dim, GridImp, EntityImp > |
Default Implementations for EntityImp (Elements [cd=0]). More... | |
class | EntityPointer |
Wrapper class for pointers to entities. More... | |
class | EntityPointerDefaultImplementation |
Default implementation of EntityPointer. More... | |
class | Geometry |
Wrapper class for geometries. More... | |
class | GeometryDefaultImplementation |
Default implementation for class Geometry. More... | |
class | GridError |
Base class for exceptions in Dune grid modules. More... | |
class | Grid |
Grid abstract base class. More... | |
class | GridDefaultImplementation |
struct | GridTraits |
A traits struct that collects all associated types of one grid model. More... | |
struct | MakeableInterfaceObject |
class | GridPartInterface |
Interface for the GridPart classes A GridPart class allows to access only a specific subset of a grid's entities. A GridPart implementation provides the corresponding index set and a begin/end iterator pair for accessing those entities, the corresponding intersection iterators and a appropriate communication method. GridParts are used to parametrize spaces (see DiscreteFunctionSpaceDefault [in dune-fem]). More... | |
class | GridPartDefault |
Default implementation for the GridPart classes. More... | |
class | LevelGridPart |
Selects a specific level of a grid. More... | |
struct | LevelGridPartTraits |
Type definitions for the LevelGridPart class. More... | |
class | LeafGridPart |
Selects the leaf level of a grid. More... | |
struct | LeafGridPartTraits |
Type definitions for the LeafGridPart class. More... | |
class | HierarchicGridPart |
Selects the leaf level of a grid. More... | |
struct | HierarchicGridPartTraits |
Type definitions for the LeafGridPart class. More... | |
class | HierarchicIterator |
Enables iteration over all codim zero entities in a subtree See also the documentation of Dune::EntityPointer. More... | |
class | HierarchicIteratorDefaultImplementation |
Default Implementations for HierarchicIteratorImp. More... | |
class | IndexSet |
Index Set Interface base class. More... | |
class | IndexSetDefaultImplementation |
Provide default implementation of method if IndexSet. More... | |
class | IdSet |
Id Set Interface. More... | |
class | IdSetDefaultImplementation |
Id Set DefaultImplementation. More... | |
class | IndexStack |
class | IntersectionIterator |
Mesh entities of codimension 0 ("elements") allow to visit all intersections with "neighboring" elements and with the domain boundary. More... | |
class | IntersectionIteratorDefaultImplementation |
Default Implementations for IntersectionIteratorImp. More... | |
class | IntersectionIteratorWrapper |
Class that wraps IntersectionIteratorImp of a grid and gets it's internal object from a object stack hold by the grid. More... | |
class | LeafIntersectionIteratorWrapper |
Class that wraps IntersectionIteratorImp of a grid and gets it's internal object from a object stack hold by the grid. More... | |
class | LevelIntersectionIteratorWrapper |
Class that wraps IntersectionIteratorImp of a grid and gets it's internal object from a object stack hold by the grid. More... | |
class | LeafIterator |
Enables iteration over all leaf entities of a codimension zero of a grid. See also the documentation of Dune::EntityPointer. More... | |
class | LeafIteratorDefaultImplementation |
Default Implementations for LevelIteratorImp. More... | |
class | LevelIterator |
Enables iteration over all entities of a given codimension and level of a grid. See also the documentation of Dune::EntityPointer. More... | |
class | LevelIteratorDefaultImplementation |
Default Implementations for LevelIteratorImp. More... | |
class | Mapper |
Mapper interface. More... | |
class | MultipleCodimMultipleGeomTypeMapper |
Implementation class for a multiple codim and multiple geometry type mapper. More... | |
class | LeafMultipleCodimMultipleGeomTypeMapper |
Multiple codim and multiple geometry type mapper for leaf entities. More... | |
class | LevelMultipleCodimMultipleGeomTypeMapper |
Multiple codim and multiple geometry type mapper for entities of one level. More... | |
struct | SimplexQuadraturePointsSingleton |
class | QuadratureOrderOutOfRange |
Exception thrown if an desired QuadratureRule is not available, because the order is to high. More... | |
class | QuadraturePoint |
Single evaluation point in a quadrature rule. More... | |
class | QuadratureRule |
Abstract base class for quadrature rules. More... | |
class | QuadratureRules |
A container for all quadrature rules of dimension dim . More... | |
class | CubeQuadratureRule |
Gauss quadrature for the n-dimensional cube. More... | |
class | CubeQuadratureRule< ct, 0 > |
class | CubeQuadratureRule< ct, 1 > |
class | Jacobi1QuadratureRule< ct, 1 > |
Jacobi-Gauss quadrature for alpha=1, beta=0. More... | |
class | Jacobi2QuadratureRule< ct, 1 > |
Jacobi-Gauss quadrature for alpha=2, beta=0. More... | |
class | SimplexQuadratureRule< ct, 2 > |
Quadrature rules for triangles. More... | |
class | SimplexQuadratureRule< ct, 3 > |
Quadrature rules for tetrahedra. More... | |
class | PrismQuadraturePoints< 3 > |
struct | PrismQuadraturePointsSingleton |
Singleton holding the Prism Quadrature points. More... | |
struct | PrismQuadraturePointsSingleton< 3 > |
Singleton holding the Prism Quadrature points. More... | |
class | PrismQuadratureRule< ct, 3 > |
Quadrature rules for prisms. More... | |
class | PyramidQuadraturePoints |
struct | PyramidQuadraturePointsSingleton |
Singleton holding the pyramid quadrature points. More... | |
struct | PyramidQuadraturePointsSingleton< 3 > |
Singleton holding the pyramid quadrature points. More... | |
class | PyramidQuadratureRule< ct, 3 > |
Quadrature rules for Pyramids. More... | |
class | QuadratureRuleFactory |
Factory class for creation of quadrature rules, depending on GeometryType, order and QuadratureType. More... | |
class | ReferenceElement |
This is the abstract base class for reference elements. More... | |
class | ReferenceElementWrapper |
The wrapper allows Imp to be used as a reference element without making methods of Imp virtual. More... | |
class | ReferenceCube |
This is the reference cube without virtual functions. More... | |
class | ReferenceCube< ctype, 0 > |
specialization for d=0 More... | |
class | ReferenceCubeContainer |
Make the reference cube accessible as a container. More... | |
class | ReferenceSimplex |
Reference simplex. More... | |
class | ReferenceSimplex< ctype, 0 > |
specialization for d=0 More... | |
class | ReferenceSimplexContainer |
Make the reference simplex accessible as a container. More... | |
class | ReferencePrismContainer |
Make the reference Prism accessible as a container. More... | |
class | ReferencePyramidContainer |
Make the reference Pyramid accessible as a container. More... | |
class | ReferenceElementContainer |
Combines all reference elements. More... | |
class | ReferenceElementContainer< ctype, 3 > |
Combines all reference elements for dim==3. More... | |
class | Refinement |
Wrap each Refinement implementation to get a consistent interface. More... | |
class | SingleCodimSingleGeomTypeMapper |
Implementation class for a single codim and single geometry type mapper. More... | |
class | LeafSingleCodimSingleGeomTypeMapper |
Single codim and single geometry type mapper for leaf entities. More... | |
class | LevelSingleCodimSingleGeomTypeMapper |
Single codim and single geometry type mapper for entities of one level. More... | |
class | SingleTypeSizeCache |
organizes the caching of sizes for one grid and one GeometryType More... | |
class | SizeCache |
oranizes the caching of sizes for one grid More... | |
class | UniversalMapper |
Implements a mapper for an arbitrary subset of entities. More... | |
class | GlobalUniversalMapper |
Universal mapper based on global ids. More... | |
class | LocalUniversalMapper |
Universal mapper based on local ids. More... | |
class | VirtualRefinement |
VirtualRefinement base class. More... | |
class | AmiraMeshReader< UGGrid< 3 > > |
Read a 3d coarse grid from an AmiraMesh file into a UGGrid. More... | |
class | AmiraMeshReader< UGGrid< 2 > > |
Read a 2d coarse grid from an AmiraMesh file into a UGGrid. More... | |
class | AmiraMeshReader |
Provides file reading facilities in the AmiraMesh format. More... | |
class | AmiraMeshWriter |
Provides file writing facilities in the AmiraMesh format. More... | |
class | LevelAmiraMeshWriter |
Provides file writing facilities in the AmiraMesh format for level grids. More... | |
class | LeafAmiraMeshWriter |
Provides file writing facilities in the AmiraMesh format for leaf grids. More... | |
class | DGFException |
exception class for IO errors in the DGF parser More... | |
class | GridPtr |
Class for constructing grids from DGF files. More... | |
struct | VTKOptions |
options for VTK output More... | |
class | VTKWriter |
Writer for the ouput of grid functions in the vtk format. More... | |
class | LeafVTKWriter |
VTKWriter on the leaf grid. More... | |
class | LevelVTKWriter |
VTKWriter on a given level grid. More... | |
class | CombinedGrapeDisplay |
Combines GrapeDataDisplays to one so that visualisation for parallel grid is more easy to handle. More... | |
class | GrapeDataDisplay |
class | GrapeGridDisplay |
class | OneDGrid |
[ provides Dune::Grid ] Onedimensional adaptive grid More... | |
class | LexOrder |
generate lexicographic ordering in a cube of dimension dim with arbitry size per direction More... | |
class | JoinOrder |
generate consecutive numbering of dim sets of size N_i More... | |
class | CubeMapper |
class | SGeometry |
class | SGeometry< 0, cdim, GridImp > |
specialization for dim=0, this is a vertex More... | |
class | SEntityBase |
class | SEntity |
class | SEntity< 0, dim, GridImp > |
class | SEntity< dim, dim, GridImp > |
struct | SHierarchicStackElem |
class | SIntersectionIterator |
class | SEntityPointer |
class | SLevelIterator |
struct | SGridLevelIndexSetTypes |
implementation of index set More... | |
class | SGridGlobalIdSet |
persistent, globally unique Ids More... | |
class | SGrid |
[ provides Dune::Grid ] A structured mesh in d dimensions consisting of "cubes" (pilot implementation of the Dune grid interface, for debugging only). More... | |
class | UGGrid |
[ provides Dune::Grid ] Provides the meshes of the finite element toolbox UG. (http://sit.iwr.uni-heidelberg.de/~ug). More... | |
class | HierarchicSearch |
Search an IndexSet for an Entity containing a given point. More... | |
struct | LevelTag |
A tag to identify that we work on a level of a grid. More... | |
struct | LeafTag |
A tag to identify that we work on the leaf of a grid. More... | |
struct | IntersectionIteratorGetter |
Utility class to get the Intersection Iterator the right way. More... | |
class | YGrid |
class | SubYGrid |
class | Torus |
class | MultiYGrid |
class | YaspSpecialGeometry |
class | YaspGeometry |
The general version implements dimworld==dimworld. If this is not the case an error is thrown. More... | |
class | YaspGeometry< mydim, mydim, GridImp > |
specialize for dim=dimworld, i.e. a volume element More... | |
class | YaspGeometry< 0, cdim, GridImp > |
specialization for dim=0, this is a vertex More... | |
class | YaspSpecialEntity |
class | YaspIntersectionIterator |
class | YaspHierarchicIterator |
class | YaspEntityPointer |
class | YaspLevelIterator |
struct | YaspLevelIndexSetTypes |
level-wise, non-persistent, consecutive index More... | |
class | YaspGlobalIdSet |
persistent, globally unique Ids More... | |
class | YaspGrid |
[ provides Dune::Grid ] Provides a distributed structured cube mesh. More... | |
Namespaces | |
namespace | Capabilities |
Contains all capabilities classes. | |
namespace | QuadratureType |
Defines an enum for currently available quadrature rules. | |
namespace | RefinementImp |
This namespace contains the implementation of Refinement. | |
Typedefs | |
typedef double | sgrid_ctype |
typedef double | yaspgrid_ctype |
Enumerations | |
enum | PartitionType { InteriorEntity = 0, BorderEntity = 1, OverlapEntity = 2, FrontEntity = 3, GhostEntity = 4 } |
Attributes used in the generic overlap model. More... | |
enum | InterfaceType { InteriorBorder_InteriorBorder_Interface = 0, InteriorBorder_All_Interface = 1, Overlap_OverlapFront_Interface = 2, Overlap_All_Interface = 3, All_All_Interface = 4 } |
Parameter to be used for the communication functions. More... | |
enum | PartitionIteratorType { Interior_Partition = 0, InteriorBorder_Partition = 1, Overlap_Partition = 2, OverlapFront_Partition = 3, All_Partition = 4, Ghost_Partition = 5 } |
Parameter to be used for the parallel level- and leaf iterators. More... | |
enum | CommunicationDirection { ForwardCommunication, BackwardCommunication } |
Define a type for communication direction parameter. More... | |
enum | GrapePartitionIteratorType |
the internal grape partition iterator types | |
enum | GrapeIteratorType |
the internal grape partition iterator types need to be these exact values to associate with combo button value. | |
enum | GrapeIOFileFormatType { ascii = 0, xdr = 1 } |
Functions | |
std::string | PartitionName (PartitionType type) |
Provide names for the partition types. | |
template<class G> | |
void | gridinfo (const G &grid, std::string prefix="") |
A function to print some information about the grid as a whole. | |
template<class G> | |
void | gridlevellist (const G &grid, int level, std::string prefix) |
A function to print info about a grid level and its entities. | |
template<class G> | |
void | gridleaflist (const G &grid, std::string prefix) |
A function to print info about a leaf grid and its entities. | |
template<class RT, int codim> | |
FieldVector< typename RT::CoordType, RT::d > | mapGlobal (const RT &refElem, const FieldVector< typename RT::CoordType, RT::d-codim > &l, int i, int cdim) |
template<int dimension, class CoordType> | |
VirtualRefinement< dimension, CoordType > & | buildRefinement (GeometryType geometryType, GeometryType coerceTo) |
return a reference to the VirtualRefinement according to the parameters | |
template<int dimension, class CoordType> | |
VirtualRefinement< dimension, CoordType > & | buildRefinement (GeometryType::BasicType geometryType, GeometryType::BasicType coerceTo) |
return a reference to the VirtualRefinement according to the parameters | |
static GRAPE_ElementType | convertToGrapeType (GeometryType type, int dim) |
convert dune geometry types to grape geometry types with numbers | |
template<typename T> | |
GrapeIOStringType | typeIdentifier () |
convert type to string | |
template<int d, typename ct> | |
std::ostream & | operator<< (std::ostream &s, YGrid< d, ct > e) |
Output operator for grids. | |
template<int d, typename ct> | |
std::ostream & | operator<< (std::ostream &s, typename YGrid< d, ct >::Iterator &e) |
Output operator for Iterators. | |
template<int d, typename ct> | |
std::ostream & | operator<< (std::ostream &s, SubYGrid< d, ct > e) |
Output operator for subgrids. | |
template<int d, typename ct> | |
std::ostream & | operator<< (std::ostream &s, typename SubYGrid< d, ct >::TransformingSubIterator &e) |
Output operator for subgrids. | |
template<int d> | |
std::ostream & | operator<< (std::ostream &s, const Torus< d > &t) |
Output operator for Torus. | |
template<int d, class ct> | |
std::ostream & | operator<< (std::ostream &s, MultiYGrid< d, ct > &mg) |
Output operator for multigrids. | |
Variables | |
static FixedArray< int, 2 > | zrefGlob |
Typedef Documentation
typedef double Dune::sgrid_ctype |
define name for floating point type used for coordinates in sgrid. You can change the type for coordinates by changing this single typedef.
typedef double Dune::yaspgrid_ctype |
define name for floating point type used for coordinates in yaspgrid. You can change the type for coordinates by changing this single typedef.
Enumeration Type Documentation
Function Documentation
VirtualRefinement<dimension, CoordType>& Dune::buildRefinement | ( | GeometryType::BasicType | geometryType, | |
GeometryType::BasicType | coerceTo | |||
) |
return a reference to the VirtualRefinement according to the parameters
- Parameters:
-
dimension Dimension of the element to refine CoordType C++ type of the coordinates
- Exceptions:
-
NotImplemented There is no Refinement implementation for the specified parameters.
- Parameters:
-
geometryType geometry type of the refined element coerceTo geometry type of the subelements
VirtualRefinement< dimension, CoordType > & Dune::buildRefinement | ( | GeometryType | geometryType, | |
GeometryType | coerceTo | |||
) |
return a reference to the VirtualRefinement according to the parameters
- Parameters:
-
dimension Dimension of the element to refine CoordType C++ type of the coordinates
- Exceptions:
-
NotImplemented There is no Refinement implementation for the specified parameters.
- Parameters:
-
geometryType geometry type of the refined element coerceTo geometry type of the subelements
FieldVector<typename RT::CoordType, RT::d> Dune::@74::mapGlobal | ( | const RT & | refElem, | |
const FieldVector< typename RT::CoordType, RT::d-codim > & | l, | |||
int | i, | |||
int | cdim | |||
) | [static] |
- Todo:
- Please doc me!
Variable Documentation
FixedArray<int,2> Dune::zrefGlob [static] |
A Grid is a container of grid entities. An entity is parametrized by the codimension. An entity of codimension c in dimension d is a d-c dimensional object.
Entities of codimension 0 ("elements") are defined through template specialization. Note that this specialization has an extended interface compared to the general case
Entities of codimension 0 allow to visit all neighbors, where a neighbor is an entity of codimension 0 which has a common entity of codimension 1 with the entity. These neighbors are accessed via an iterator. This allows the implementation of non-matching meshes. The number of neigbors may be different from the number of faces/edges of an element!