dune-grid  2.3.1
Classes | Public Types | Public Member Functions | Static Public Member Functions | Static Public Attributes | Protected Types | Protected Member Functions | Static Protected Member Functions | Protected Attributes | Friends | List of all members
Dune::ALUCubeGrid< 3, 3 > Class Template Reference

constructor for creating ALUCubeGrid from given macro grid file More...

#include <dune/grid/alugrid/3d/alugrid.hh>

Inheritance diagram for Dune::ALUCubeGrid< 3, 3 >:
Inheritance graph

Classes

struct  Partition
 

Public Types

enum  { dimension =BaseType::dimension, dimensionworld =BaseType::dimensionworld }
 
typedef
BaseType::DuneBoundaryProjectionType 
DuneBoundaryProjectionType
 type of boundary projection More...
 
typedef
BaseType::DuneBoundaryProjectionVector 
DuneBoundaryProjectionVector
 type of boundary projection More...
 
typedef BaseType::ctype ctype
 
typedef BaseType::GridFamily GridFamily
 
typedef GridFamily::Traits Traits
 
typedef BaseType::LocalIdSetImp LocalIdSetImp
 
typedef Traits::GlobalIdSet GlobalIdSet
 
typedef Traits::LocalIdSet LocalIdSet
 
typedef
GridFamily::LevelIndexSetImp 
LevelIndexSetImp
 
typedef GridFamily::LeafIndexSetImp LeafIndexSetImp
 
typedef BaseType::LeafIteratorImp LeafIteratorImp
 
typedef Traits::Codim
< 0 >::LeafIterator 
LeafIteratorType
 
typedef Traits::Codim
< 0 >::LeafIterator 
LeafIterator
 
typedef
BaseType::HierarchicIteratorImp 
HierarchicIteratorImp
 
typedef BaseType::ObjectStreamType ObjectStreamType
 
typedef Partition
< All_Partition >
::LevelGridView 
LevelGridView
 
typedef Partition
< All_Partition >
::LeafGridView 
LeafGridView
 
enum  
 
typedef
ALU3dGridIntersectionIterator
< const ThisType
IntersectionIteratorImp
 
typedef
ALU3dGridIntersectionIterator
< const ThisType
LeafIntersectionIteratorImp
 
typedef
ALU3dGridLevelIntersectionIterator
< const ThisType
LevelIntersectionIteratorImp
 
typedef ObjectStreamType InStreamType
 
typedef ObjectStreamType OutStreamType
 
typedef
ALU3dGridHierarchicIndexSet
< elType, Comm > 
HierarchicIndexSet
 Type of the hierarchic index set. More...
 
typedef ReferenceElement
< alu3d_ctype, dimension
ReferenceElementType
 reference element type More...
 
typedef ALU3DSPACE ProjectVertex ALUGridVertexProjectionType
 type of ALUGrid Vertex Projection Interface More...
 
typedef
Traits::CollectiveCommunication 
CollectiveCommunication
 type of collective communication object More...
 
typedef
MakeableInterfaceObject
< typename Traits::template
Codim< 0 >::Entity
EntityObject
 
typedef
MakeableInterfaceObject
< typename Traits::template
Codim< 1 >::Entity
FaceObject
 
typedef
MakeableInterfaceObject
< typename Traits::template
Codim< 2 >::Entity
EdgeObject
 
typedef
MakeableInterfaceObject
< typename Traits::template
Codim< 3 >::Entity
VertexObject
 
typedef ALUGridObjectFactory
< ThisType
GridObjectFactoryType
 
typedef
ALU3dGridCommunications
< elType, Comm > 
Communications
 
Exported constants
enum  { dimension =dim }
 A constant that exports the template parameter dim. More...
 
enum  { dimensionworld =dimworld }
 A constant that exports the template parameter dimworld. More...
 
Exported types
typedef
GridFamily::Traits::LeafIntersection 
LeafIntersection
 A type that is a model of Dune::Intersection, an intersections of two codimension 1 of two codimension 0 entities in the leaf view. More...
 
typedef
GridFamily::Traits::LevelIntersection 
LevelIntersection
 A type that is a model of Dune::Intersection, an intersections of two codimension 1 of two codimension 0 entities in a level view. More...
 
typedef
GridFamily::Traits::LeafIntersectionIterator 
LeafIntersectionIterator
 A type that is a model of Dune::IntersectionIterator which is an iterator that allows to examine, but not to modify, the intersections of codimension 1 of an leaf element (entity of codimension 0) with other leaf elements. More...
 
typedef
GridFamily::Traits::LevelIntersectionIterator 
LevelIntersectionIterator
 A type that is a model of Dune::IntersectionIterator which is an iterator that allows to examine, but not to modify, the intersections of codimension 1 of an element (entity of codimension 0) with other elements on the same level. More...
 
typedef
GridFamily::Traits::HierarchicIterator 
HierarchicIterator
 A type that is a model of Dune::HierarchicIterator A type of iterator that allows to examine, but not to modify, entities of codimension 0 that result from refinement of an entity of codimension 0. More...
 
typedef
GridFamily::Traits::LevelIndexSet 
LevelIndexSet
 A type that is a model of Dune::IndexSet which provides a consecutive, but non persistent, numbering for entities on a grid level. More...
 
typedef
GridFamily::Traits::LeafIndexSet 
LeafIndexSet
 A type that is a model of Dune::IndexSet which provides a consecutive, but non persistent, numbering for entities in the leaf grid. More...
 

Public Member Functions

 ALUCubeGrid (const std::string macroName, const MPICommunicatorType mpiComm=BaseType::defaultCommunicator(), const DuneBoundaryProjectionType *bndProject=0, const DuneBoundaryProjectionVector *bndVector=0, const bool verb=true)
 constructor for creating ALUCubeGrid from given macro grid file More...
 
 ALUCubeGrid (const MPICommunicatorType mpiComm, const DuneBoundaryProjectionType *bndProject, const DuneBoundaryProjectionVector *bndVector, const std::string macroName, const bool verb=true)
 constructor called from ALUGridFactory for creating ALUCubeGrid from given macro grid file More...
 
 ALUCubeGrid (const MPICommunicatorType mpiComm=BaseType::defaultCommunicator())
 constructor creating empty grid More...
 
template<PartitionIteratorType pitype>
Partition< pitype >::LevelGridView levelView (int level) const
 
template<PartitionIteratorType pitype>
Partition< pitype >::LeafGridView leafView () const
 
LevelGridView levelView (int level) const
 
LeafGridView leafView () const
 
template<PartitionIteratorType pitype>
Partition< pitype >::LevelGridView levelGridView (int level) const
 
template<PartitionIteratorType pitype>
Partition< pitype >::LeafGridView leafGridView () const
 
LevelGridView levelGridView (int level) const
 
LeafGridView leafGridView () const
 
int maxLevel () const
 Return maximum level defined in this grid. Levels are numbered maxLevel with 0 the coarsest level. More...
 
Traits::template Codim< cd >
::template Partition< pitype >
::LevelIterator 
lbegin (int level) const
 Iterator to first entity of given codim on level. More...
 
Traits::template Codim< cd >
::template Partition
< All_Partition >
::LevelIterator 
lbegin (int level) const
 Iterator to first entity of given codim on level. More...
 
Traits::template Codim< cd >
::template Partition< pitype >
::LevelIterator 
lend (int level) const
 one past the end on this level More...
 
Traits::template Codim< cd >
::template Partition
< All_Partition >
::LevelIterator 
lend (int level) const
 one past the end on this level More...
 
Traits::template Codim< codim >
::template Partition< pitype >
::LeafIterator 
leafbegin () const
 General definiton for a leaf iterator. More...
 
Traits::template Codim< codim >
::LeafIterator 
leafbegin () const
 General definiton for a leaf iterator. More...
 
Traits::template Codim< codim >
::template Partition< pitype >
::LeafIterator 
leafend () const
 General definition for an end iterator on leaf level. More...
 
Traits::template Codim< codim >
::LeafIterator 
leafend () const
 General definition for an end iterator on leaf level. More...
 
int size (int level, int cd) const
 number of grid entities per level and codim More...
 
int size (int codim) const
 number of leaf entities per codim in this process More...
 
int size (int level, GeometryType type) const
 number of entities per level and geometry type in this process More...
 
int size (GeometryType type) const
 number of leaf entities per geometry type in this process More...
 
size_t numBoundarySegments () const
 number of boundary segments More...
 
int global_size (int cd) const
 number of grid entities on all levels for given codim More...
 
int hierSetSize (int cd) const
 
const GlobalIdSetglobalIdSet () const
 get global id set of grid More...
 
const LocalIdSetlocalIdSet () const
 get global id set of grid More...
 
const Traits::LeafIndexSetleafIndexSet () const
 get leaf index set of the grid More...
 
const Traits::LevelIndexSetlevelIndexSet (int level) const
 get level index set of the grid More...
 
bool loadBalance ()
 Calculates load of each process and repartition the grid if neccessary. For parameters of the load balancing process see the README file of the ALUGrid package. More...
 
bool loadBalance (DataHandle &data)
 Calculates load of each process and repartition the grid if neccessary. For parameters of the load balancing process see the README file of the ALUGrid package. More...
 
bool loadBalance (CommDataHandleIF< DataHandleImpl, Data > &dataHandle)
 
int ghostSize (int level, int codim) const
 ghostSize is one for codim 0 and zero otherwise for this grid More...
 
int ghostSize (int codim) const
 ghostSize is one for codim 0 and zero otherwise for this grid More...
 
int overlapSize (int level, int codim) const
 overlapSize is zero for this grid More...
 
int overlapSize (int codim) const
 overlapSize is zero for this grid More...
 
void communicate (CommDataHandleIF< DataHandleImp, DataTypeImp > &data, InterfaceType iftype, CommunicationDirection dir, int level) const
 Communicate information on distributed entities on a given level Template parameter is a model of Dune::CommDataHandleIF. More...
 
void communicate (CommDataHandleIF< DataHandleImp, DataTypeImp > &data, InterfaceType iftype, CommunicationDirection dir) const
 Communicate information on distributed entities on the leaf grid. Template parameter is a model of Dune::CommDataHandleIF. More...
 
const CollectiveCommunicationcomm () const
 return const reference to a collective communication object. The return type is a model of Dune::CollectiveCommunication. More...
 
bool preAdapt ()
 returns if a least one entity was marked for coarsening More...
 
void postAdapt ()
 clear all entity new markers More...
 
bool adapt ()
 Refine all positive marked leaf entities, coarsen all negative marked entities if possible. More...
 
bool adapt (AdaptDataHandleInterface< GridImp, DataHandle > &handle)
 Refine all positive marked leaf entities, coarsen all negative marked entities if possible. More...
 
void globalRefine (int refCount)
 uses the interface, mark on entity and refineLocal More...
 
void globalRefine (int refCount, AdaptDataHandleInterface< GridImp, DataHandle > &handle)
 
bool writeGrid (const std::string filename, alu3d_ctype time) const
 write Grid to file in specified FileFormatType More...
 
bool writeGrid_Xdr (const std::string filename, alu3d_ctype time) const
 
bool writeGrid_Ascii (const std::string filename, alu3d_ctype time, bool scientific=false) const
 write leaf grid in macro grid format to ascii file More...
 
bool writeMacroGrid (const std::string path, const std::string filename) const
 write macro grid in ALUGrid macro format to path/filename.rank More...
 
bool readGrid (const std::string filename, alu3d_ctype &time)
 read Grid from file filename and store time of mesh in time More...
 
void backup (std::ostream &) const
 backup to ostream More...
 
void restore (std::istream &)
 restore from istream More...
 
const HierarchicIndexSethierarchicIndexSet () const
 
void setMaxLevel (int mxl)
 
void updateStatus ()
 
bool mark (int refCount, const typename Traits::template Codim< 0 >::Entity &e)
 Marks an entity to be refined/coarsened in a subsequent adapt. More...
 
int getMark (const typename Traits::template Codim< 0 >::Entity &e) const
 returns adaptation mark for given entity More...
 
const std::vector< GeometryType > & geomTypes (int codim) const
 deliver all geometry types used in this grid More...
 
GitterImplTypemyGrid () const
 
virtual GitterImplTypecreateALUGrid (const std::string &macroName)
 
virtual GitterImplTypecreateALUGrid (std::istream &stream)
 
ALUGridVertexProjectionTypevertexProjection ()
 
virtual ALU3DSPACE
Gitter::Geometric::BuilderIF & 
getBuilder () const
 
virtual void duneNotifyMacroGridChanges ()
 
const ReferenceElementTypereferenceElement () const
 return reference to Dune reference element according to elType More...
 
Traits::template Codim
< EntitySeed::codimension >
::EntityPointer 
entityPointer (const EntitySeed &seed) const
 
int nlinks () const
 
LeafVertexListTypegetLeafVertexList () const
 
int getLevelOfLeafVertex (const typename ALU3dImplTraits< elType, Comm >::VertexType &vertex) const
 
VertexListTypegetVertexList (int level) const
 
ALU3dGridItemListTypegetGhostLeafList (int codim) const
 
ALU3dGridItemListTypegetGhostLevelList (int codim, int level) const
 
ALU3dGridItemListTypegetEdgeList (int level) const
 
bool conformingRefinement () const
 
bool ghostCellsEnabled () const
 
Adaptivity and grid refinement
bool mark (int refCount, const typename Codim< 0 >::Entity &e)
 Marks an entity to be refined/coarsened in a subsequent adapt. More...
 
int getMark (const typename Codim< 0 >::Entity &e) const
 returns adaptation mark for given entity More...
 

Static Public Member Functions

static std::string name ()
 for grid identification More...
 
static MPICommunicatorType defaultCommunicator ()
 
static const
BaseType::template
ReturnImplementationType
< IntersectionType >
::ImplementationType & 
getRealIntersection (const IntersectionType &intersection)
 

Static Public Attributes

static const ALU3dGridElementType elementType
 

Protected Types

enum  
 max number of levels More...
 
enum  
 element chunk for refinement More...
 
enum  
 upper estimate on number of elements that could be created when a new element is created More...
 
enum  
 
typedef
MakeableInterfaceObject
< typename Traits::template
Codim< 0 >::Geometry
GeometryObject
 
typedef
ALUGridBoundaryProjection
< ThisType, alu3d_ctype
ALUGridBoundaryProjectionType
 
typedef GridFamily::GlobalIdSetImp GlobalIdSetImp
 
typedef ALU3dImplTraits
< elType, Comm >
::GitterImplType 
GitterImplType
 
typedef ALU3dGridVertexList< Comm > VertexListType
 
typedef
ALU3dGridLeafVertexList< Comm > 
LeafVertexListType
 
typedef SizeCache< MyTypeSizeCacheType
 

Protected Member Functions

void calcExtras ()
 reset size and global size, update Level- and LeafIndexSet, if they exist More...
 
void calcMaxLevel ()
 calculate maxlevel More...
 
void recalcGlobalSize ()
 make grid walkthrough and calc global size More...
 
void checkMacroGridFile (const std::string filename)
 check whether macro grid format is of our type More...
 
void checkMacroGrid ()
 check whether macro grid has the right element type More...
 
const DuneBoundaryProjectionTypeboundaryProjection (const int segmentIndex) const
 return boudanry projection for given segment Id More...
 
const Communicationscommunications () const
 
const GridObjectFactoryTypefactory () const
 
GridImp & asImp ()
 Barton-Nackman trick. More...
 
const GridImp & asImp () const
 Barton-Nackman trick. More...
 

Static Protected Member Functions

static
ReturnImplementationType
< InterfaceType >
::ImplementationType & 
getRealImplementation (InterfaceType &i)
 return real implementation of interface class More...
 

Protected Attributes

GitterImplTypemygrid_
 
int maxlevel_
 
int coarsenMarked_
 
int refineMarked_
 
std::vector< std::vector
< GeometryType > > 
geomTypes_
 
HierarchicIndexSet hIndexSet_
 
GlobalIdSetImpglobalIdSet_
 
LocalIdSetImp localIdSet_
 
std::vector< LevelIndexSetImp * > levelIndexVec_
 
LeafIndexSetImpleafIndexSet_
 
const ReferenceElementTypereferenceElement_
 
VertexListType vertexList_ [MAXL]
 
ALU3dGridItemListType ghostLeafList_ [dimension]
 
ALU3dGridItemListType ghostLevelList_ [dimension][MAXL]
 
ALU3dGridItemListType levelEdgeList_ [MAXL]
 
LeafVertexListType leafVertexList_
 
SizeCacheTypesizeCache_
 
GridObjectFactoryType factory_
 
bool lockPostAdapt_
 
const DuneBoundaryProjectionTypebndPrj_
 
const
DuneBoundaryProjectionVector
bndVec_
 
ALUGridBoundaryProjectionTypevertexProjection_
 
Communicationscommunications_
 
const ALUGridRefinementType refinementType_
 

Friends

class Conversion< ALUCubeGrid< dimension, dimensionworld >, HasObjectStream >
 
class Conversion< const ALUCubeGrid< dimension, dimensionworld >, HasObjectStream >
 
class Conversion< ALUCubeGrid< dimension, dimensionworld >, HasHierarchicIndexSet >
 
class Conversion< const ALUCubeGrid< dimension, dimensionworld >, HasHierarchicIndexSet >
 
template<class >
class ALU3dGridFactory
 

Detailed Description

template<>
class Dune::ALUCubeGrid< 3, 3 >

constructor for creating ALUCubeGrid from given macro grid file

Parameters
macroNamefilename for macro grid in ALUGrid hexa format
mpiCommMPI Communicator (when HAVE_MPI == 1 then mpiComm is of type MPI_Comm and the default value is MPI_COMM_WORLD)
bndProjectglobal boundary projection pointer
bndVectorpointer to vector holding boundary projection for each boundary segment. ALUGrid takes ownership of this pointer and will delete it in the desctructor
verbWhether to write a notice about grid creation to stdout.
Deprecated:
Use ALUGrid< 3, 3, cube, nonconforming > instead.
Deprecated:

[ provides Dune::Grid ] 3D grid with support for hexahedrons.

Deprecated:
Use ALUGrid< 3, 3, cube, nonconforming > instead.

Member Typedef Documentation

typedef ALU3DSPACE ProjectVertex Dune::ALU3dGrid< ALU3dGridElementType, class >::ALUGridVertexProjectionType
inherited

type of ALUGrid Vertex Projection Interface

type of collective communication object

typedef ALU3dGridCommunications< elType, Comm > Dune::ALU3dGrid< ALU3dGridElementType, class >::Communications
inherited

type of boundary projection

type of boundary projection

typedef MakeableInterfaceObject<typename Traits::template Codim<2>::Entity> Dune::ALU3dGrid< ALU3dGridElementType, class >::EdgeObject
inherited
typedef MakeableInterfaceObject<typename Traits::template Codim<0>::Entity> Dune::ALU3dGrid< ALU3dGridElementType, class >::EntityObject
inherited
typedef MakeableInterfaceObject<typename Traits::template Codim<1>::Entity> Dune::ALU3dGrid< ALU3dGridElementType, class >::FaceObject
inherited
typedef MakeableInterfaceObject< typename Traits::template Codim< 0 >::Geometry > Dune::ALU3dGrid< ALU3dGridElementType, class >::GeometryObject
protectedinherited
typedef ALU3dImplTraits< elType, Comm >::GitterImplType Dune::ALU3dGrid< ALU3dGridElementType, class >::GitterImplType
protectedinherited

Type of the hierarchic index set.

template<int dim, int dimworld, class ct , class GridFamily >
typedef GridFamily::Traits::HierarchicIterator Dune::Grid< dim, dimworld, ct, GridFamily >::HierarchicIterator
inherited

A type that is a model of Dune::HierarchicIterator A type of iterator that allows to examine, but not to modify, entities of codimension 0 that result from refinement of an entity of codimension 0.

template<int dim, int dimworld, class ct , class GridFamily >
typedef GridFamily::Traits::LeafIndexSet Dune::Grid< dim, dimworld, ct, GridFamily >::LeafIndexSet
inherited

A type that is a model of Dune::IndexSet which provides a consecutive, but non persistent, numbering for entities in the leaf grid.

template<int dim, int dimworld, class ct , class GridFamily >
typedef GridFamily::Traits::LeafIntersection Dune::Grid< dim, dimworld, ct, GridFamily >::LeafIntersection
inherited

A type that is a model of Dune::Intersection, an intersections of two codimension 1 of two codimension 0 entities in the leaf view.

template<int dim, int dimworld, class ct , class GridFamily >
typedef GridFamily::Traits::LeafIntersectionIterator Dune::Grid< dim, dimworld, ct, GridFamily >::LeafIntersectionIterator
inherited

A type that is a model of Dune::IntersectionIterator which is an iterator that allows to examine, but not to modify, the intersections of codimension 1 of an leaf element (entity of codimension 0) with other leaf elements.

typedef ALU3dGridLeafVertexList< Comm > Dune::ALU3dGrid< ALU3dGridElementType, class >::LeafVertexListType
protectedinherited
template<int dim, int dimworld, class ct , class GridFamily >
typedef GridFamily::Traits::LevelIndexSet Dune::Grid< dim, dimworld, ct, GridFamily >::LevelIndexSet
inherited

A type that is a model of Dune::IndexSet which provides a consecutive, but non persistent, numbering for entities on a grid level.

template<int dim, int dimworld, class ct , class GridFamily >
typedef GridFamily::Traits::LevelIntersection Dune::Grid< dim, dimworld, ct, GridFamily >::LevelIntersection
inherited

A type that is a model of Dune::Intersection, an intersections of two codimension 1 of two codimension 0 entities in a level view.

template<int dim, int dimworld, class ct , class GridFamily >
typedef GridFamily::Traits::LevelIntersectionIterator Dune::Grid< dim, dimworld, ct, GridFamily >::LevelIntersectionIterator
inherited

A type that is a model of Dune::IntersectionIterator which is an iterator that allows to examine, but not to modify, the intersections of codimension 1 of an element (entity of codimension 0) with other elements on the same level.

typedef ReferenceElement< alu3d_ctype, dimension > Dune::ALU3dGrid< ALU3dGridElementType, class >::ReferenceElementType
inherited

reference element type

typedef SizeCache<MyType> Dune::ALU3dGrid< ALU3dGridElementType, class >::SizeCacheType
protectedinherited
typedef ALU3dGridVertexList< Comm > Dune::ALU3dGrid< ALU3dGridElementType, class >::VertexListType
protectedinherited
typedef MakeableInterfaceObject<typename Traits::template Codim<3>::Entity> Dune::ALU3dGrid< ALU3dGridElementType, class >::VertexObject
inherited

Member Enumeration Documentation

template<int dim, int dimworld, class ct , class GridFamily >
anonymous enum
inherited

A constant that exports the template parameter dim.

Enumerator
dimension 

The dimension of the grid.

template<int dim, int dimworld, class ct , class GridFamily >
anonymous enum
inherited

A constant that exports the template parameter dimworld.

Enumerator
dimensionworld 

The dimension of the world the grid lives in.

anonymous enum
Enumerator
dimension 
dimensionworld 
anonymous enum
inherited
anonymous enum
protectedinherited

max number of levels

anonymous enum
protectedinherited

element chunk for refinement

anonymous enum
protectedinherited

upper estimate on number of elements that could be created when a new element is created

anonymous enum
protectedinherited

Constructor & Destructor Documentation

Dune::ALUCubeGrid< 3, 3 >::ALUCubeGrid ( const std::string  macroName,
const MPICommunicatorType  mpiComm = BaseType::defaultCommunicator(),
const DuneBoundaryProjectionType bndProject = 0,
const DuneBoundaryProjectionVector bndVector = 0,
const bool  verb = true 
)
inline

constructor for creating ALUCubeGrid from given macro grid file

Parameters
macroNamefilename for macro grid in ALUGrid hexa format
mpiCommMPI Communicator (when HAVE_MPI == 1 then mpiComm is of type MPI_Comm and the default value is MPI_COMM_WORLD)
bndProjectglobal boundary projection pointer
bndVectorpointer to vector holding boundary projection for each boundary segment. ALUGrid takes ownership of this pointer and will delete it in the desctructor
verbWhether to write a notice about grid creation to stdout.
Deprecated:
Use ALUGrid< 3, 3, cube, nonconforming > instead.
Deprecated:

References Dune::ALUGridParallelSerial().

Dune::ALUCubeGrid< 3, 3 >::ALUCubeGrid ( const MPICommunicatorType  mpiComm,
const DuneBoundaryProjectionType bndProject,
const DuneBoundaryProjectionVector bndVector,
const std::string  macroName,
const bool  verb = true 
)
inline

constructor called from ALUGridFactory for creating ALUCubeGrid from given macro grid file

Parameters
mpiCommMPI Communicator (when HAVE_MPI == 1 then mpiComm is of type MPI_Comm)
bndProjectglobal boundary projection pointer
bndVectorpointer to vector holding boundary projection for each boundary segment
Note
ALUGrid takes ownership of this pointer and will delete it in the desctructor
Parameters
macroNamefilename from which ALUGrid is being generated
verbWhether to write a notice about grid creation to stdout.
Deprecated:
Use ALUGrid< 3, 3, cube, nonconforming > instead.
Deprecated:

References Dune::ALUGridParallelSerial().

Dune::ALUCubeGrid< 3, 3 >::ALUCubeGrid ( const MPICommunicatorType  mpiComm = BaseType::defaultCommunicator())
inline

constructor creating empty grid

Deprecated:
Use ALUGrid< 3, 3, cube, nonconforming > instead.
Deprecated:

Member Function Documentation

bool Dune::ALU3dGrid< ALU3dGridElementType, class >::adapt ( )
inherited

Refine all positive marked leaf entities, coarsen all negative marked entities if possible.

Returns
true if a least one entity was refined

The complete adaptation process works as follows:

bool Dune::ALU3dGrid< ALU3dGridElementType, class >::adapt ( AdaptDataHandleInterface< GridImp, DataHandle > &  handle)
inherited

Refine all positive marked leaf entities, coarsen all negative marked entities if possible.

Returns
true if a least one entity was refined

The complete adaptation process works as follows:

  • mark entities with the mark() method
  • call preAdapt()
  • if preAdapt() returned true: possibly save current solution
  • call adapt()
  • if adapt() returned true: possibly interpolate the (saved) solution
  • call postAdapt()
    Parameters
    handlehandler for restriction and prolongation operations which is a Model of the AdaptDataHandleInterface class.
template<int dim, int dimworld, class ct , class GridFamily >
GridImp& Dune::Grid< dim, dimworld, ct, GridFamily >::asImp ( )
inlineprotectedinherited

Barton-Nackman trick.

Referenced by Dune::Grid< dim, dimworld, ct, GridFamily >::adapt(), Dune::Grid< dim, dimworld, ct, GridFamily >::comm(), Dune::Grid< dim, dimworld, ct, GridFamily >::communicate(), Dune::Grid< dim, dimworld, ct, GridFamily >::entityPointer(), Dune::Grid< dim, dimworld, ct, GridFamily >::getMark(), Dune::Grid< dim, dimworld, ct, GridFamily >::ghostSize(), Dune::Grid< dim, dimworld, ct, GridFamily >::globalIdSet(), Dune::Grid< dim, dimworld, ct, GridFamily >::globalRefine(), Dune::Grid< dim, dimworld, ct, GridFamily >::lbegin(), Dune::Grid< dim, dimworld, ct, GridFamily >::leafbegin(), Dune::Grid< dim, dimworld, ct, GridFamily >::leafend(), Dune::Grid< dim, dimworld, ct, GridFamily >::leafGridView(), Dune::GridDefaultImplementation< dim, dimworld, _ctype, SGridFamily< dim, dimworld, _ctype > >::leafGridView(), Dune::Grid< dim, dimworld, ct, GridFamily >::leafIndexSet(), Dune::Grid< dim, dimworld, ct, GridFamily >::leafView(), Dune::GridDefaultImplementation< dim, dimworld, _ctype, SGridFamily< dim, dimworld, _ctype > >::leafView(), Dune::Grid< dim, dimworld, ct, GridFamily >::lend(), Dune::Grid< dim, dimworld, ct, GridFamily >::levelGridView(), Dune::GridDefaultImplementation< dim, dimworld, _ctype, SGridFamily< dim, dimworld, _ctype > >::levelGridView(), Dune::Grid< dim, dimworld, ct, GridFamily >::levelIndexSet(), Dune::Grid< dim, dimworld, ct, GridFamily >::levelView(), Dune::GridDefaultImplementation< dim, dimworld, _ctype, SGridFamily< dim, dimworld, _ctype > >::levelView(), Dune::Grid< dim, dimworld, ct, GridFamily >::loadBalance(), Dune::Grid< dim, dimworld, ct, GridFamily >::localIdSet(), Dune::Grid< dim, dimworld, ct, GridFamily >::mark(), Dune::Grid< dim, dimworld, ct, GridFamily >::maxLevel(), Dune::Grid< dim, dimworld, ct, GridFamily >::numBoundarySegments(), Dune::Grid< dim, dimworld, ct, GridFamily >::overlapSize(), Dune::Grid< dim, dimworld, ct, GridFamily >::postAdapt(), Dune::Grid< dim, dimworld, ct, GridFamily >::preAdapt(), and Dune::Grid< dim, dimworld, ct, GridFamily >::size().

template<int dim, int dimworld, class ct , class GridFamily >
const GridImp& Dune::Grid< dim, dimworld, ct, GridFamily >::asImp ( ) const
inlineprotectedinherited

Barton-Nackman trick.

void Dune::ALU3dGrid< ALU3dGridElementType, class >::backup ( std::ostream &  ) const
inherited

backup to ostream

const DuneBoundaryProjectionType* Dune::ALU3dGrid< ALU3dGridElementType, class >::boundaryProjection ( const int  segmentIndex) const
inlineprotectedinherited
void Dune::ALU3dGrid< ALU3dGridElementType, class >::calcExtras ( )
protectedinherited

reset size and global size, update Level- and LeafIndexSet, if they exist

void Dune::ALU3dGrid< ALU3dGridElementType, class >::calcMaxLevel ( )
protectedinherited

calculate maxlevel

void Dune::ALU3dGrid< ALU3dGridElementType, class >::checkMacroGrid ( )
protectedinherited

check whether macro grid has the right element type

void Dune::ALU3dGrid< ALU3dGridElementType, class >::checkMacroGridFile ( const std::string  filename)
protectedinherited

check whether macro grid format is of our type

const CollectiveCommunication& Dune::ALU3dGrid< ALU3dGridElementType, class >::comm ( ) const
inlineinherited

return const reference to a collective communication object. The return type is a model of Dune::CollectiveCommunication.

References Dune::ALU3dGrid< ALU3dGridElementType, class >::communications().

void Dune::ALU3dGrid< ALU3dGridElementType, class >::communicate ( CommDataHandleIF< DataHandleImp, DataTypeImp > &  data,
InterfaceType  iftype,
CommunicationDirection  dir,
int  level 
) const
inherited

Communicate information on distributed entities on a given level Template parameter is a model of Dune::CommDataHandleIF.

Parameters
dataA data handle telling the method what data is communicated and how this should be done.
interfaceThe communication interface to use.
dirThe direction of the communication along the interface (forward or backward.
levelThe index of the grid level where the communication should happen.
void Dune::ALU3dGrid< ALU3dGridElementType, class >::communicate ( CommDataHandleIF< DataHandleImp, DataTypeImp > &  data,
InterfaceType  iftype,
CommunicationDirection  dir 
) const
inherited

Communicate information on distributed entities on the leaf grid. Template parameter is a model of Dune::CommDataHandleIF.

const Communications& Dune::ALU3dGrid< ALU3dGridElementType, class >::communications ( ) const
inlineprotectedinherited
bool Dune::ALU3dGrid< ALU3dGridElementType, class >::conformingRefinement ( ) const
inlineinherited
virtual GitterImplType* Dune::ALU3dGrid< ALU3dGridElementType, class >::createALUGrid ( const std::string &  macroName)
inlinevirtualinherited
virtual GitterImplType* Dune::ALU3dGrid< ALU3dGridElementType, class >::createALUGrid ( std::istream &  stream)
inlinevirtualinherited
static MPICommunicatorType Dune::ALU3dGrid< ALU3dGridElementType, class >::defaultCommunicator ( )
inlinestaticinherited
virtual void Dune::ALU3dGrid< ALU3dGridElementType, class >::duneNotifyMacroGridChanges ( )
inlinevirtualinherited
Traits :: template Codim< EntitySeed :: codimension >:: EntityPointer Dune::ALU3dGrid< ALU3dGridElementType, class >::entityPointer ( const EntitySeed seed) const
inlineinherited
const GridObjectFactoryType& Dune::ALU3dGrid< ALU3dGridElementType, class >::factory ( ) const
inlineprotectedinherited
const std::vector<GeometryType>& Dune::ALU3dGrid< ALU3dGridElementType, class >::geomTypes ( int  codim) const
inlineinherited

deliver all geometry types used in this grid

References Dune::ALU3dGrid< ALU3dGridElementType, class >::geomTypes_.

virtual ALU3DSPACE Gitter::Geometric::BuilderIF& Dune::ALU3dGrid< ALU3dGridElementType, class >::getBuilder ( ) const
inlinevirtualinherited
ALU3dGridItemListType& Dune::ALU3dGrid< ALU3dGridElementType, class >::getEdgeList ( int  level) const
inlineinherited
ALU3dGridItemListType& Dune::ALU3dGrid< ALU3dGridElementType, class >::getGhostLeafList ( int  codim) const
inlineinherited
ALU3dGridItemListType& Dune::ALU3dGrid< ALU3dGridElementType, class >::getGhostLevelList ( int  codim,
int  level 
) const
inlineinherited
LeafVertexListType& Dune::ALU3dGrid< ALU3dGridElementType, class >::getLeafVertexList ( ) const
inlineinherited
int Dune::ALU3dGrid< ALU3dGridElementType, class >::getLevelOfLeafVertex ( const typename ALU3dImplTraits< elType, Comm >::VertexType &  vertex) const
inlineinherited
template<int dim, int dimworld, class ct , class GridFamily >
int Dune::Grid< dim, dimworld, ct, GridFamily >::getMark ( const typename Codim< 0 >::Entity e) const
inlineinherited

returns adaptation mark for given entity

Parameters
[in]eEntity for which adaptation mark should be determined
Returns
int adaptation mark currently set for given Entity e

References Dune::Grid< dim, dimworld, ct, GridFamily >::asImp().

int Dune::ALU3dGrid< ALU3dGridElementType, class >::getMark ( const typename Traits::template Codim< 0 >::Entity e) const
inherited

returns adaptation mark for given entity

Parameters
[in]eEntity for which adaptation mark should be determined
Returns
int adaptation mark currently set for given Entity e
static ReturnImplementationType<InterfaceType>::ImplementationType& Dune::GridDefaultImplementation< dim, dimworld, alu3d_ctype , ALU3dGridFamily< elType, Comm > >::getRealImplementation ( InterfaceType i)
inlinestaticprotectedinherited
static const BaseType :: template ReturnImplementationType< IntersectionType >:: ImplementationType& Dune::ALU3dGrid< ALU3dGridElementType, class >::getRealIntersection ( const IntersectionType &  intersection)
inlinestaticinherited
VertexListType& Dune::ALU3dGrid< ALU3dGridElementType, class >::getVertexList ( int  level) const
inlineinherited
bool Dune::ALU3dGrid< ALU3dGridElementType, class >::ghostCellsEnabled ( ) const
inlineinherited
int Dune::ALU3dGrid< ALU3dGridElementType, class >::ghostSize ( int  level,
int  codim 
) const
inherited

ghostSize is one for codim 0 and zero otherwise for this grid

int Dune::ALU3dGrid< ALU3dGridElementType, class >::ghostSize ( int  codim) const
inherited

ghostSize is one for codim 0 and zero otherwise for this grid

int Dune::ALU3dGrid< ALU3dGridElementType, class >::global_size ( int  cd) const
inherited

number of grid entities on all levels for given codim

const GlobalIdSet& Dune::ALU3dGrid< ALU3dGridElementType, class >::globalIdSet ( ) const
inlineinherited

get global id set of grid

References Dune::ALU3dGrid< ALU3dGridElementType, class >::globalIdSet_.

void Dune::ALU3dGrid< ALU3dGridElementType, class >::globalRefine ( int  refCount)
inherited

uses the interface, mark on entity and refineLocal

void Dune::ALU3dGrid< ALU3dGridElementType, class >::globalRefine ( int  refCount,
AdaptDataHandleInterface< GridImp, DataHandle > &  handle 
)
inherited
const HierarchicIndexSet& Dune::ALU3dGrid< ALU3dGridElementType, class >::hierarchicIndexSet ( ) const
inlineinherited
int Dune::ALU3dGrid< ALU3dGridElementType, class >::hierSetSize ( int  cd) const
inherited
Traits::template Codim<cd>::template Partition<pitype>::LevelIterator Dune::ALU3dGrid< ALU3dGridElementType, class >::lbegin ( int  level) const
inherited

Iterator to first entity of given codim on level.

Traits::template Codim<cd>:: template Partition<All_Partition>::LevelIterator Dune::ALU3dGrid< ALU3dGridElementType, class >::lbegin ( int  level) const
inherited

Iterator to first entity of given codim on level.

Traits::template Codim<codim>::template Partition<pitype>::LeafIterator Dune::ALU3dGrid< ALU3dGridElementType, class >::leafbegin ( ) const
inherited

General definiton for a leaf iterator.

Traits::template Codim<codim>::LeafIterator Dune::ALU3dGrid< ALU3dGridElementType, class >::leafbegin ( ) const
inherited

General definiton for a leaf iterator.

Traits::template Codim<codim>::template Partition<pitype>::LeafIterator Dune::ALU3dGrid< ALU3dGridElementType, class >::leafend ( ) const
inherited

General definition for an end iterator on leaf level.

Traits::template Codim<codim>::LeafIterator Dune::ALU3dGrid< ALU3dGridElementType, class >::leafend ( ) const
inherited

General definition for an end iterator on leaf level.

template<PartitionIteratorType pitype>
Partition< pitype >::LeafGridView Dune::ALUCubeGrid< 3, 3 >::leafGridView ( ) const
inline
LeafGridView Dune::ALUCubeGrid< 3, 3 >::leafGridView ( ) const
inline
const Traits :: LeafIndexSet& Dune::ALU3dGrid< ALU3dGridElementType, class >::leafIndexSet ( ) const
inherited

get leaf index set of the grid

template<PartitionIteratorType pitype>
Partition< pitype >::LeafGridView Dune::ALUCubeGrid< 3, 3 >::leafView ( ) const
inline
LeafGridView Dune::ALUCubeGrid< 3, 3 >::leafView ( ) const
inline
Traits::template Codim<cd>::template Partition<pitype>::LevelIterator Dune::ALU3dGrid< ALU3dGridElementType, class >::lend ( int  level) const
inherited

one past the end on this level

Traits::template Codim<cd>:: template Partition<All_Partition>::LevelIterator Dune::ALU3dGrid< ALU3dGridElementType, class >::lend ( int  level) const
inherited

one past the end on this level

template<PartitionIteratorType pitype>
Partition< pitype >::LevelGridView Dune::ALUCubeGrid< 3, 3 >::levelGridView ( int  level) const
inline
LevelGridView Dune::ALUCubeGrid< 3, 3 >::levelGridView ( int  level) const
inline
const Traits :: LevelIndexSet& Dune::ALU3dGrid< ALU3dGridElementType, class >::levelIndexSet ( int  level) const
inherited

get level index set of the grid

template<PartitionIteratorType pitype>
Partition< pitype >::LevelGridView Dune::ALUCubeGrid< 3, 3 >::levelView ( int  level) const
inline
LevelGridView Dune::ALUCubeGrid< 3, 3 >::levelView ( int  level) const
inline
bool Dune::ALU3dGrid< ALU3dGridElementType, class >::loadBalance ( )
inherited

Calculates load of each process and repartition the grid if neccessary. For parameters of the load balancing process see the README file of the ALUGrid package.

bool Dune::ALU3dGrid< ALU3dGridElementType, class >::loadBalance ( DataHandle &  data)
inherited

Calculates load of each process and repartition the grid if neccessary. For parameters of the load balancing process see the README file of the ALUGrid package.

Parameters
datathe data handler class that must implement three methods:
// calls data inline on macro element. From there the data of
// all children can be written to the message buffer.
// MessageBufferImp implements the MessageBufferIF interface.
template<class MessageBufferImp>
void inlineData ( MessageBufferImp& buff, Dune::Entity<0> & e);
// calls data xtract on macro element. From there the data of
// all children can be restored from the message buffer.
// numChildren is the number of all children underneath the
// macro element e.
// MessageBufferImp implements the MessageBufferIF interface.
template<class MessageBufferImp>
void xtractData ( MessageBufferImp& buff, Dune::Entity<0> & e, size_t numChildren );
// This method is called at the end of the load balancing process
// before adaptation markers are removed. Here the user can apply
// a data compression or other features. This method can be
// empty if nothing should be done.
void compress ();
bool Dune::ALU3dGrid< ALU3dGridElementType, class >::loadBalance ( CommDataHandleIF< DataHandleImpl, Data > &  dataHandle)
inlineinherited
const LocalIdSet& Dune::ALU3dGrid< ALU3dGridElementType, class >::localIdSet ( ) const
inlineinherited

get global id set of grid

References Dune::ALU3dGrid< ALU3dGridElementType, class >::localIdSet_.

template<int dim, int dimworld, class ct , class GridFamily >
bool Dune::Grid< dim, dimworld, ct, GridFamily >::mark ( int  refCount,
const typename Codim< 0 >::Entity e 
)
inlineinherited

Marks an entity to be refined/coarsened in a subsequent adapt.

Parameters
[in]refCountNumber of subdivisions that should be applied. Negative value means coarsening.
[in]eEntity that should be marked
Returns
true if Entity was marked, false otherwise.

References Dune::Grid< dim, dimworld, ct, GridFamily >::asImp().

bool Dune::ALU3dGrid< ALU3dGridElementType, class >::mark ( int  refCount,
const typename Traits::template Codim< 0 >::Entity e 
)
inherited

Marks an entity to be refined/coarsened in a subsequent adapt.

Parameters
[in]refCountNumber of subdivisions that should be applied. Negative value means coarsening.
[in]eEntity that should be marked
Returns
true if Entity was marked, false otherwise.
int Dune::ALU3dGrid< ALU3dGridElementType, class >::maxLevel ( ) const
inherited

Return maximum level defined in this grid. Levels are numbered maxLevel with 0 the coarsest level.

GitterImplType& Dune::ALU3dGrid< ALU3dGridElementType, class >::myGrid ( ) const
inherited
static std::string Dune::ALU3dGrid< ALU3dGridElementType, class >::name ( )
inlinestaticinherited

for grid identification

int Dune::ALU3dGrid< ALU3dGridElementType, class >::nlinks ( ) const
inlineinherited
size_t Dune::ALU3dGrid< ALU3dGridElementType, class >::numBoundarySegments ( ) const
inherited

number of boundary segments

int Dune::ALU3dGrid< ALU3dGridElementType, class >::overlapSize ( int  level,
int  codim 
) const
inlineinherited

overlapSize is zero for this grid

int Dune::ALU3dGrid< ALU3dGridElementType, class >::overlapSize ( int  codim) const
inlineinherited

overlapSize is zero for this grid

void Dune::ALU3dGrid< ALU3dGridElementType, class >::postAdapt ( )
inherited

clear all entity new markers

bool Dune::ALU3dGrid< ALU3dGridElementType, class >::preAdapt ( )
inherited

returns if a least one entity was marked for coarsening

bool Dune::ALU3dGrid< ALU3dGridElementType, class >::readGrid ( const std::string  filename,
alu3d_ctype time 
)
inherited

read Grid from file filename and store time of mesh in time

void Dune::ALU3dGrid< ALU3dGridElementType, class >::recalcGlobalSize ( )
protectedinherited

make grid walkthrough and calc global size

const ReferenceElementType& Dune::ALU3dGrid< ALU3dGridElementType, class >::referenceElement ( ) const
inlineinherited

return reference to Dune reference element according to elType

References Dune::ALU3dGrid< ALU3dGridElementType, class >::referenceElement_.

void Dune::ALU3dGrid< ALU3dGridElementType, class >::restore ( std::istream &  )
inherited

restore from istream

void Dune::ALU3dGrid< ALU3dGridElementType, class >::setMaxLevel ( int  mxl)
inherited
int Dune::ALU3dGrid< ALU3dGridElementType, class >::size ( int  level,
int  cd 
) const
inherited

number of grid entities per level and codim

int Dune::ALU3dGrid< ALU3dGridElementType, class >::size ( int  codim) const
inherited

number of leaf entities per codim in this process

int Dune::ALU3dGrid< ALU3dGridElementType, class >::size ( int  level,
GeometryType  type 
) const
inherited

number of entities per level and geometry type in this process

int Dune::ALU3dGrid< ALU3dGridElementType, class >::size ( GeometryType  type) const
inherited

number of leaf entities per geometry type in this process

void Dune::ALU3dGrid< ALU3dGridElementType, class >::updateStatus ( )
inherited
ALUGridVertexProjectionType* Dune::ALU3dGrid< ALU3dGridElementType, class >::vertexProjection ( )
inlineinherited
bool Dune::ALU3dGrid< ALU3dGridElementType, class >::writeGrid ( const std::string  filename,
alu3d_ctype  time 
) const
inherited

write Grid to file in specified FileFormatType

bool Dune::ALU3dGrid< ALU3dGridElementType, class >::writeGrid_Ascii ( const std::string  filename,
alu3d_ctype  time,
bool  scientific = false 
) const
inherited

write leaf grid in macro grid format to ascii file

bool Dune::ALU3dGrid< ALU3dGridElementType, class >::writeGrid_Xdr ( const std::string  filename,
alu3d_ctype  time 
) const
inherited
bool Dune::ALU3dGrid< ALU3dGridElementType, class >::writeMacroGrid ( const std::string  path,
const std::string  filename 
) const
inherited

write macro grid in ALUGrid macro format to path/filename.rank

Friends And Related Function Documentation

template<class >
friend class ALU3dGridFactory
friend
friend class Conversion< ALUCubeGrid< dimension, dimensionworld >, HasHierarchicIndexSet >
friend
friend class Conversion< ALUCubeGrid< dimension, dimensionworld >, HasObjectStream >
friend
friend class Conversion< const ALUCubeGrid< dimension, dimensionworld >, HasHierarchicIndexSet >
friend
friend class Conversion< const ALUCubeGrid< dimension, dimensionworld >, HasObjectStream >
friend

Member Data Documentation

const DuneBoundaryProjectionType* Dune::ALU3dGrid< ALU3dGridElementType, class >::bndPrj_
protectedinherited
const DuneBoundaryProjectionVector* Dune::ALU3dGrid< ALU3dGridElementType, class >::bndVec_
protectedinherited
int Dune::ALU3dGrid< ALU3dGridElementType, class >::coarsenMarked_
mutableprotectedinherited
Communications* Dune::ALU3dGrid< ALU3dGridElementType, class >::communications_
protectedinherited
const ALU3dGridElementType Dune::ALU3dGrid< ALU3dGridElementType, class >::elementType
staticinherited
GridObjectFactoryType Dune::ALU3dGrid< ALU3dGridElementType, class >::factory_
protectedinherited
std::vector< std::vector<GeometryType> > Dune::ALU3dGrid< ALU3dGridElementType, class >::geomTypes_
protectedinherited
ALU3dGridItemListType Dune::ALU3dGrid< ALU3dGridElementType, class >::ghostLeafList_[dimension]
mutableprotectedinherited
ALU3dGridItemListType Dune::ALU3dGrid< ALU3dGridElementType, class >::ghostLevelList_[dimension][MAXL]
mutableprotectedinherited
GlobalIdSetImp* Dune::ALU3dGrid< ALU3dGridElementType, class >::globalIdSet_
mutableprotectedinherited
HierarchicIndexSet Dune::ALU3dGrid< ALU3dGridElementType, class >::hIndexSet_
protectedinherited
LeafIndexSetImp* Dune::ALU3dGrid< ALU3dGridElementType, class >::leafIndexSet_
mutableprotectedinherited
LeafVertexListType Dune::ALU3dGrid< ALU3dGridElementType, class >::leafVertexList_
mutableprotectedinherited
ALU3dGridItemListType Dune::ALU3dGrid< ALU3dGridElementType, class >::levelEdgeList_[MAXL]
mutableprotectedinherited
std::vector< LevelIndexSetImp * > Dune::ALU3dGrid< ALU3dGridElementType, class >::levelIndexVec_
mutableprotectedinherited
LocalIdSetImp Dune::ALU3dGrid< ALU3dGridElementType, class >::localIdSet_
protectedinherited
bool Dune::ALU3dGrid< ALU3dGridElementType, class >::lockPostAdapt_
protectedinherited
int Dune::ALU3dGrid< ALU3dGridElementType, class >::maxlevel_
protectedinherited
GitterImplType* Dune::ALU3dGrid< ALU3dGridElementType, class >::mygrid_
mutableprotectedinherited
const ReferenceElementType& Dune::ALU3dGrid< ALU3dGridElementType, class >::referenceElement_
protectedinherited
int Dune::ALU3dGrid< ALU3dGridElementType, class >::refineMarked_
mutableprotectedinherited
const ALUGridRefinementType Dune::ALU3dGrid< ALU3dGridElementType, class >::refinementType_
protectedinherited
SizeCacheType* Dune::ALU3dGrid< ALU3dGridElementType, class >::sizeCache_
protectedinherited
VertexListType Dune::ALU3dGrid< ALU3dGridElementType, class >::vertexList_[MAXL]
mutableprotectedinherited
ALUGridBoundaryProjectionType* Dune::ALU3dGrid< ALU3dGridElementType, class >::vertexProjection_
protectedinherited

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