dune-grid  2.3beta2
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
typedef
BaseType::DuneBoundaryProjectionVector 
DuneBoundaryProjectionVector
 type of boundary projection
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.
typedef ReferenceElement
< alu3d_ctype, dimension
ReferenceElementType
 reference element type
typedef ALU3DSPACE ProjectVertex ALUGridVertexProjectionType
 type of ALUGrid Vertex Projection Interface
typedef
Traits::CollectiveCommunication 
CollectiveCommunication
 type of collective communication object
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.
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.
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.
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.
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.
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.
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.

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
 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
 ALUCubeGrid (const MPICommunicatorType mpiComm=BaseType::defaultCommunicator())
 constructor creating empty grid
template<PartitionIteratorType pitype>
Partition< pitype >::LevelGridView levelView (int level) const
 View for a grid level.
template<PartitionIteratorType pitype>
Partition< pitype >::LeafGridView leafView () const
 View for the leaf grid.
LevelGridView levelView (int level) const
 View for a grid level.
LeafGridView leafView () const
 View for the leaf grid.
template<PartitionIteratorType pitype>
Partition< pitype >::LevelGridView levelGridView (int level) const
 View for a grid level.
template<PartitionIteratorType pitype>
Partition< pitype >::LeafGridView leafGridView () const
 View for the leaf grid.
LevelGridView levelGridView (int level) const
 View for a grid level.
LeafGridView leafGridView () const
 View for the leaf grid.
int maxLevel () const
 Return maximum level defined in this grid. Levels are numbered maxLevel with 0 the coarsest level.
Traits::template Codim< cd >
::template Partition< pitype >
::LevelIterator 
lbegin (int level) const
 Iterator to first entity of given codim on level.
Traits::template Codim< cd >
::template Partition
< All_Partition >
::LevelIterator 
lbegin (int level) const
 Iterator to first entity of given codim on level.
Traits::template Codim< cd >
::template Partition< pitype >
::LevelIterator 
lend (int level) const
 one past the end on this level
Traits::template Codim< cd >
::template Partition
< All_Partition >
::LevelIterator 
lend (int level) const
 one past the end on this level
Traits::template Codim< codim >
::template Partition< pitype >
::LeafIterator 
leafbegin () const
 General definiton for a leaf iterator.
Traits::template Codim< codim >
::LeafIterator 
leafbegin () const
 General definiton for a leaf iterator.
Traits::template Codim< codim >
::template Partition< pitype >
::LeafIterator 
leafend () const
 General definition for an end iterator on leaf level.
Traits::template Codim< codim >
::LeafIterator 
leafend () const
 General definition for an end iterator on leaf level.
int size (int level, int cd) const
 number of grid entities per level and codim
int size (int codim) const
 number of leaf entities per codim in this process
int size (int level, GeometryType type) const
 number of entities per level and geometry type in this process
int size (GeometryType type) const
 number of leaf entities per geometry type in this process
size_t numBoundarySegments () const
 number of boundary segments
int global_size (int cd) const
 number of grid entities on all levels for given codim
int hierSetSize (int cd) const
const GlobalIdSetglobalIdSet () const
 get global id set of grid
const LocalIdSetlocalIdSet () const
 get global id set of grid
const Traits::LeafIndexSet & leafIndexSet () const
 get leaf index set of the grid
const Traits::LevelIndexSet & levelIndexSet (int level) const
 get level index set of the grid
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.
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.
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
int ghostSize (int codim) const
 ghostSize is one for codim 0 and zero otherwise for this grid
int overlapSize (int level, int codim) const
 overlapSize is zero for this grid
int overlapSize (int codim) const
 overlapSize is zero for this grid
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.
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.
const CollectiveCommunicationcomm () const
 return const reference to a collective communication object. The return type is a model of Dune::CollectiveCommunication.
bool preAdapt ()
 returns if a least one entity was marked for coarsening
void postAdapt ()
 clear all entity new markers
bool adapt ()
 Refine all positive marked leaf entities, coarsen all negative marked entities if possible.
bool adapt (AdaptDataHandleInterface< GridImp, DataHandle > &handle)
 Refine all positive marked leaf entities, coarsen all negative marked entities if possible.
void globalRefine (int refCount)
 uses the interface, mark on entity and refineLocal
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
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
bool writeMacroGrid (const std::string path, const std::string filename) const
 write macro grid in ALUGrid macro format to path/filename.rank
bool readGrid (const std::string filename, alu3d_ctype &time)
 read Grid from file filename and store time of mesh in time
void backup (std::ostream &) const
 backup to ostream
void restore (std::istream &)
 restore from istream
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.
int getMark (const typename Traits::template Codim< 0 >::Entity &e) const
 returns adaptation mark for given entity
const std::vector< GeometryType > & geomTypes (int codim) const
 deliver all geometry types used in this grid
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
Traits::template Codim
< EntitySeed::codimension >
::EntityPointer 
entityPointer (const EntitySeed &seed) const
 obtain EntityPointer from EntitySeed.
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.
int getMark (const typename Codim< 0 >::Entity &e) const
 returns adaptation mark for given entity

Static Public Member Functions

static std::string name ()
 for grid identification
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
void calcMaxLevel ()
 calculate maxlevel
void recalcGlobalSize ()
 make grid walkthrough and calc global size
void checkMacroGridFile (const std::string filename)
 check whether macro grid format is of our type
void checkMacroGrid ()
 check whether macro grid has the right element type
const DuneBoundaryProjectionTypeboundaryProjection (const int segmentIndex) const
 return boudanry projection for given segment Id
const Communicationscommunications () const
const GridObjectFactoryTypefactory () const
GridImp & asImp ()
 Barton-Nackman trick.
const GridImp & asImp () const
 Barton-Nackman trick.

Static Protected Member Functions

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

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 >
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< elType, Comm >::ALUGridVertexProjectionType
inherited

type of ALUGrid Vertex Projection Interface

typedef Traits::CollectiveCommunication Dune::ALU3dGrid< elType, Comm >::CollectiveCommunication
inherited

type of collective communication object

typedef ALU3dGridCommunications< elType, Comm > Dune::ALU3dGrid< elType, Comm >::Communications
inherited
typedef BaseType::ctype Dune::ALUCubeGrid< 3, 3 >::ctype
typedef BaseType :: DuneBoundaryProjectionType Dune::ALUCubeGrid< 3, 3 >::DuneBoundaryProjectionType

type of boundary projection

type of boundary projection

typedef MakeableInterfaceObject<typename Traits::template Codim<2>::Entity> Dune::ALU3dGrid< elType, Comm >::EdgeObject
inherited
typedef MakeableInterfaceObject<typename Traits::template Codim<0>::Entity> Dune::ALU3dGrid< elType, Comm >::EntityObject
inherited
typedef MakeableInterfaceObject<typename Traits::template Codim<1>::Entity> Dune::ALU3dGrid< elType, Comm >::FaceObject
inherited
typedef MakeableInterfaceObject< typename Traits::template Codim< 0 >::Geometry > Dune::ALU3dGrid< elType, Comm >::GeometryObject
protectedinherited
typedef ALU3dImplTraits< elType, Comm >::GitterImplType Dune::ALU3dGrid< elType, Comm >::GitterImplType
protectedinherited
typedef Traits :: GlobalIdSet Dune::ALUCubeGrid< 3, 3 >::GlobalIdSet
typedef GridFamily::GlobalIdSetImp Dune::ALU3dGrid< elType, Comm >::GlobalIdSetImp
protectedinherited
typedef BaseType::GridFamily Dune::ALUCubeGrid< 3, 3 >::GridFamily
typedef ALUGridObjectFactory< ThisType > Dune::ALU3dGrid< elType, Comm >::GridObjectFactoryType
inherited
typedef ALU3dGridHierarchicIndexSet< elType, Comm > Dune::ALU3dGrid< elType, Comm >::HierarchicIndexSet
inherited

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.

typedef BaseType::HierarchicIteratorImp Dune::ALUCubeGrid< 3, 3 >::HierarchicIteratorImp
typedef ObjectStreamType Dune::ALU3dGrid< elType, Comm >::InStreamType
inherited
typedef Partition< All_Partition >:: LeafGridView Dune::ALUCubeGrid< 3, 3 >::LeafGridView
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.

typedef GridFamily :: LeafIndexSetImp Dune::ALUCubeGrid< 3, 3 >::LeafIndexSetImp
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 Traits::Codim<0>::LeafIterator Dune::ALUCubeGrid< 3, 3 >::LeafIterator
typedef BaseType::LeafIteratorImp Dune::ALUCubeGrid< 3, 3 >::LeafIteratorImp
typedef Traits::Codim<0>::LeafIterator Dune::ALUCubeGrid< 3, 3 >::LeafIteratorType
typedef ALU3dGridLeafVertexList< Comm > Dune::ALU3dGrid< elType, Comm >::LeafVertexListType
protectedinherited
typedef Partition< All_Partition >:: LevelGridView Dune::ALUCubeGrid< 3, 3 >::LevelGridView
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.

typedef GridFamily :: LevelIndexSetImp Dune::ALUCubeGrid< 3, 3 >::LevelIndexSetImp
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 Traits :: LocalIdSet Dune::ALUCubeGrid< 3, 3 >::LocalIdSet
typedef BaseType::LocalIdSetImp Dune::ALUCubeGrid< 3, 3 >::LocalIdSetImp
typedef BaseType::ObjectStreamType Dune::ALUCubeGrid< 3, 3 >::ObjectStreamType
typedef ObjectStreamType Dune::ALU3dGrid< elType, Comm >::OutStreamType
inherited
typedef ReferenceElement< alu3d_ctype, dimension > Dune::ALU3dGrid< elType, Comm >::ReferenceElementType
inherited

reference element type

typedef SizeCache<MyType> Dune::ALU3dGrid< elType, Comm >::SizeCacheType
protectedinherited
typedef GridFamily::Traits Dune::ALUCubeGrid< 3, 3 >::Traits
typedef ALU3dGridVertexList< Comm > Dune::ALU3dGrid< elType, Comm >::VertexListType
protectedinherited
typedef MakeableInterfaceObject<typename Traits::template Codim<3>::Entity> Dune::ALU3dGrid< elType, Comm >::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< elType, Comm >::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:

Reimplemented from Dune::GridDefaultImplementation< 3, 3, alu3d_ctype, ALU3dGridFamily< elType, Comm > >.

bool Dune::ALU3dGrid< elType, Comm >::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:

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, _ctype, SGridFamily< dim, dimworld, _ctype > >::adapt(), Dune::Grid< dim, dimworld, _ctype, SGridFamily< dim, dimworld, _ctype > >::comm(), Dune::Grid< dim, dimworld, _ctype, SGridFamily< dim, dimworld, _ctype > >::communicate(), Dune::Grid< dim, dimworld, _ctype, SGridFamily< dim, dimworld, _ctype > >::entityPointer(), Dune::Grid< dim, dimworld, _ctype, SGridFamily< dim, dimworld, _ctype > >::getMark(), Dune::Grid< dim, dimworld, _ctype, SGridFamily< dim, dimworld, _ctype > >::ghostSize(), Dune::Grid< dim, dimworld, _ctype, SGridFamily< dim, dimworld, _ctype > >::globalIdSet(), Dune::Grid< dim, dimworld, _ctype, SGridFamily< dim, dimworld, _ctype > >::globalRefine(), Dune::Grid< dim, dimworld, _ctype, SGridFamily< dim, dimworld, _ctype > >::lbegin(), Dune::Grid< dim, dimworld, _ctype, SGridFamily< dim, dimworld, _ctype > >::leafbegin(), Dune::Grid< dim, dimworld, _ctype, SGridFamily< dim, dimworld, _ctype > >::leafend(), Dune::Grid< dim, dimworld, _ctype, SGridFamily< dim, dimworld, _ctype > >::leafGridView(), Dune::GridDefaultImplementation< dim, dimworld, _ctype, SGridFamily< dim, dimworld, _ctype > >::leafGridView(), Dune::Grid< dim, dimworld, _ctype, SGridFamily< dim, dimworld, _ctype > >::leafIndexSet(), Dune::Grid< dim, dimworld, _ctype, SGridFamily< dim, dimworld, _ctype > >::leafView(), Dune::GridDefaultImplementation< dim, dimworld, _ctype, SGridFamily< dim, dimworld, _ctype > >::leafView(), Dune::Grid< dim, dimworld, _ctype, SGridFamily< dim, dimworld, _ctype > >::lend(), Dune::Grid< dim, dimworld, _ctype, SGridFamily< dim, dimworld, _ctype > >::levelGridView(), Dune::GridDefaultImplementation< dim, dimworld, _ctype, SGridFamily< dim, dimworld, _ctype > >::levelGridView(), Dune::Grid< dim, dimworld, _ctype, SGridFamily< dim, dimworld, _ctype > >::levelIndexSet(), Dune::Grid< dim, dimworld, _ctype, SGridFamily< dim, dimworld, _ctype > >::levelView(), Dune::GridDefaultImplementation< dim, dimworld, _ctype, SGridFamily< dim, dimworld, _ctype > >::levelView(), Dune::Grid< dim, dimworld, _ctype, SGridFamily< dim, dimworld, _ctype > >::loadBalance(), Dune::Grid< dim, dimworld, _ctype, SGridFamily< dim, dimworld, _ctype > >::localIdSet(), Dune::Grid< dim, dimworld, _ctype, SGridFamily< dim, dimworld, _ctype > >::mark(), Dune::Grid< dim, dimworld, _ctype, SGridFamily< dim, dimworld, _ctype > >::maxLevel(), Dune::Grid< dim, dimworld, _ctype, SGridFamily< dim, dimworld, _ctype > >::numBoundarySegments(), Dune::Grid< dim, dimworld, _ctype, SGridFamily< dim, dimworld, _ctype > >::overlapSize(), Dune::Grid< dim, dimworld, _ctype, SGridFamily< dim, dimworld, _ctype > >::postAdapt(), Dune::Grid< dim, dimworld, _ctype, SGridFamily< dim, dimworld, _ctype > >::preAdapt(), and Dune::Grid< dim, dimworld, _ctype, SGridFamily< dim, dimworld, _ctype > >::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< elType, Comm >::backup ( std::ostream &  ) const
inherited

backup to ostream

const DuneBoundaryProjectionType* Dune::ALU3dGrid< elType, Comm >::boundaryProjection ( const int  segmentIndex) const
inlineprotectedinherited

return boudanry projection for given segment Id

References Dune::ALU3dGrid< elType, Comm >::bndPrj_, and Dune::ALU3dGrid< elType, Comm >::bndVec_.

void Dune::ALU3dGrid< elType, Comm >::calcExtras ( )
protectedinherited

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

void Dune::ALU3dGrid< elType, Comm >::calcMaxLevel ( )
protectedinherited

calculate maxlevel

void Dune::ALU3dGrid< elType, Comm >::checkMacroGrid ( )
protectedinherited

check whether macro grid has the right element type

void Dune::ALU3dGrid< elType, Comm >::checkMacroGridFile ( const std::string  filename)
protectedinherited

check whether macro grid format is of our type

const CollectiveCommunication& Dune::ALU3dGrid< elType, Comm >::comm ( ) const
inlineinherited

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

Reimplemented from Dune::Grid< dim, dimworld, ct, GridFamily >.

References Dune::ALU3dGrid< elType, Comm >::communications().

void Dune::ALU3dGrid< elType, Comm >::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.

Reimplemented from Dune::GridDefaultImplementation< 3, 3, alu3d_ctype, ALU3dGridFamily< elType, Comm > >.

void Dune::ALU3dGrid< elType, Comm >::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.

Reimplemented from Dune::GridDefaultImplementation< 3, 3, alu3d_ctype, ALU3dGridFamily< elType, Comm > >.

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

deliver all geometry types used in this grid

References Dune::ALU3dGrid< elType, Comm >::geomTypes_.

virtual ALU3DSPACE Gitter::Geometric::BuilderIF& Dune::ALU3dGrid< elType, Comm >::getBuilder ( ) const
inlinevirtualinherited
ALU3dGridItemListType& Dune::ALU3dGrid< elType, Comm >::getEdgeList ( int  level) const
inlineinherited
ALU3dGridItemListType& Dune::ALU3dGrid< elType, Comm >::getGhostLeafList ( int  codim) const
inlineinherited
ALU3dGridItemListType& Dune::ALU3dGrid< elType, Comm >::getGhostLevelList ( int  codim,
int  level 
) const
inlineinherited
LeafVertexListType& Dune::ALU3dGrid< elType, Comm >::getLeafVertexList ( ) const
inlineinherited
int Dune::ALU3dGrid< elType, Comm >::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
int Dune::ALU3dGrid< elType, Comm >::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

Reimplemented from Dune::GridDefaultImplementation< 3, 3, alu3d_ctype, ALU3dGridFamily< elType, Comm > >.

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< elType, Comm >::getRealIntersection ( const IntersectionType &  intersection)
inlinestaticinherited
VertexListType& Dune::ALU3dGrid< elType, Comm >::getVertexList ( int  level) const
inlineinherited
bool Dune::ALU3dGrid< elType, Comm >::ghostCellsEnabled ( ) const
inlineinherited
int Dune::ALU3dGrid< elType, Comm >::ghostSize ( int  level,
int  codim 
) const
inherited

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

Reimplemented from Dune::GridDefaultImplementation< 3, 3, alu3d_ctype, ALU3dGridFamily< elType, Comm > >.

int Dune::ALU3dGrid< elType, Comm >::ghostSize ( int  codim) const
inherited

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

Reimplemented from Dune::GridDefaultImplementation< 3, 3, alu3d_ctype, ALU3dGridFamily< elType, Comm > >.

int Dune::ALU3dGrid< elType, Comm >::global_size ( int  cd) const
inherited

number of grid entities on all levels for given codim

const GlobalIdSet& Dune::ALU3dGrid< elType, Comm >::globalIdSet ( ) const
inlineinherited

get global id set of grid

Reimplemented from Dune::Grid< dim, dimworld, ct, GridFamily >.

References Dune::ALU3dGrid< elType, Comm >::globalIdSet_.

void Dune::ALU3dGrid< elType, Comm >::globalRefine ( int  refCount)
inherited

uses the interface, mark on entity and refineLocal

Reimplemented from Dune::Grid< dim, dimworld, ct, GridFamily >.

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

Iterator to first entity of given codim on level.

Reimplemented from Dune::Grid< dim, dimworld, ct, GridFamily >.

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

Iterator to first entity of given codim on level.

Reimplemented from Dune::Grid< dim, dimworld, ct, GridFamily >.

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

General definiton for a leaf iterator.

Reimplemented from Dune::Grid< dim, dimworld, ct, GridFamily >.

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

General definiton for a leaf iterator.

Reimplemented from Dune::Grid< dim, dimworld, ct, GridFamily >.

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

General definition for an end iterator on leaf level.

Reimplemented from Dune::Grid< dim, dimworld, ct, GridFamily >.

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

General definition for an end iterator on leaf level.

Reimplemented from Dune::Grid< dim, dimworld, ct, GridFamily >.

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< elType, Comm >::leafIndexSet ( ) const
inherited

get leaf index set of the grid

Reimplemented from Dune::Grid< dim, dimworld, ct, GridFamily >.

template<PartitionIteratorType pitype>
Partition< pitype >::LeafGridView Dune::ALUCubeGrid< 3, 3 >::leafView ( ) const
inline

View for the leaf grid.

Deprecated:
"The method levelView has been renamed to leafGridView."

Reimplemented from Dune::GridDefaultImplementation< 3, 3, alu3d_ctype, ALU3dGridFamily< elType, Comm > >.

LeafGridView Dune::ALUCubeGrid< 3, 3 >::leafView ( ) const
inline

View for the leaf grid.

Deprecated:
"The method levelView has been renamed to leafGridView."

Reimplemented from Dune::GridDefaultImplementation< 3, 3, alu3d_ctype, ALU3dGridFamily< elType, Comm > >.

Traits::template Codim<cd>::template Partition<pitype>::LevelIterator Dune::ALU3dGrid< elType, Comm >::lend ( int  level) const
inherited

one past the end on this level

Reimplemented from Dune::Grid< dim, dimworld, ct, GridFamily >.

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

one past the end on this level

Reimplemented from Dune::Grid< dim, dimworld, ct, GridFamily >.

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< elType, Comm >::levelIndexSet ( int  level) const
inherited

get level index set of the grid

Reimplemented from Dune::Grid< dim, dimworld, ct, GridFamily >.

template<PartitionIteratorType pitype>
Partition< pitype >::LevelGridView Dune::ALUCubeGrid< 3, 3 >::levelView ( int  level) const
inline

View for a grid level.

Deprecated:
"The method levelView has been renamed to levelGridView."

Reimplemented from Dune::GridDefaultImplementation< 3, 3, alu3d_ctype, ALU3dGridFamily< elType, Comm > >.

LevelGridView Dune::ALUCubeGrid< 3, 3 >::levelView ( int  level) const
inline

View for a grid level.

Deprecated:
"The method levelView has been renamed to levelGridView."

Reimplemented from Dune::GridDefaultImplementation< 3, 3, alu3d_ctype, ALU3dGridFamily< elType, Comm > >.

bool Dune::ALU3dGrid< elType, Comm >::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.

Reimplemented from Dune::GridDefaultImplementation< 3, 3, alu3d_ctype, ALU3dGridFamily< elType, Comm > >.

bool Dune::ALU3dGrid< elType, Comm >::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 ();

Reimplemented from Dune::GridDefaultImplementation< 3, 3, alu3d_ctype, ALU3dGridFamily< elType, Comm > >.

bool Dune::ALU3dGrid< elType, Comm >::loadBalance ( CommDataHandleIF< DataHandleImpl, Data > &  dataHandle)
inlineinherited
const LocalIdSet& Dune::ALU3dGrid< elType, Comm >::localIdSet ( ) const
inlineinherited

get global id set of grid

Reimplemented from Dune::Grid< dim, dimworld, ct, GridFamily >.

References Dune::ALU3dGrid< elType, Comm >::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.
bool Dune::ALU3dGrid< elType, Comm >::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.

Reimplemented from Dune::GridDefaultImplementation< 3, 3, alu3d_ctype, ALU3dGridFamily< elType, Comm > >.

int Dune::ALU3dGrid< elType, Comm >::maxLevel ( ) const
inherited

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

Reimplemented from Dune::Grid< dim, dimworld, ct, GridFamily >.

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

for grid identification

int Dune::ALU3dGrid< elType, Comm >::nlinks ( ) const
inlineinherited
size_t Dune::ALU3dGrid< elType, Comm >::numBoundarySegments ( ) const
inherited

number of boundary segments

Reimplemented from Dune::Grid< dim, dimworld, ct, GridFamily >.

int Dune::ALU3dGrid< elType, Comm >::overlapSize ( int  level,
int  codim 
) const
inlineinherited
int Dune::ALU3dGrid< elType, Comm >::overlapSize ( int  codim) const
inlineinherited
void Dune::ALU3dGrid< elType, Comm >::postAdapt ( )
inherited
bool Dune::ALU3dGrid< elType, Comm >::preAdapt ( )
inherited

returns if a least one entity was marked for coarsening

Reimplemented from Dune::GridDefaultImplementation< 3, 3, alu3d_ctype, ALU3dGridFamily< elType, Comm > >.

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

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

void Dune::ALU3dGrid< elType, Comm >::recalcGlobalSize ( )
protectedinherited

make grid walkthrough and calc global size

const ReferenceElementType& Dune::ALU3dGrid< elType, Comm >::referenceElement ( ) const
inlineinherited

return reference to Dune reference element according to elType

References Dune::ALU3dGrid< elType, Comm >::referenceElement_.

void Dune::ALU3dGrid< elType, Comm >::restore ( std::istream &  )
inherited

restore from istream

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

number of grid entities per level and codim

Reimplemented from Dune::Grid< dim, dimworld, ct, GridFamily >.

int Dune::ALU3dGrid< elType, Comm >::size ( int  codim) const
inherited

number of leaf entities per codim in this process

Reimplemented from Dune::Grid< dim, dimworld, ct, GridFamily >.

int Dune::ALU3dGrid< elType, Comm >::size ( int  level,
GeometryType  type 
) const
inherited

number of entities per level and geometry type in this process

Reimplemented from Dune::Grid< dim, dimworld, ct, GridFamily >.

int Dune::ALU3dGrid< elType, Comm >::size ( GeometryType  type) const
inherited

number of leaf entities per geometry type in this process

Reimplemented from Dune::Grid< dim, dimworld, ct, GridFamily >.

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

write Grid to file in specified FileFormatType

bool Dune::ALU3dGrid< elType, Comm >::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< elType, Comm >::writeGrid_Xdr ( const std::string  filename,
alu3d_ctype  time 
) const
inherited
bool Dune::ALU3dGrid< elType, Comm >::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

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

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