Dune Core Modules (2.4.2)

Class Hierarchy
This inheritance list is sorted roughly, but not completely, alphabetically:
[detail level 1234567]
 CDune::AdaptDataHandleInterface< Grid, Impl >Interface class for the Grid's adapt method where the parameter is a AdaptDataHandleInterface
 CDune::AdderSelector< T, X, S >Template meta program for choosing how to add the correction
 CDune::AdditiveSchwarzModeTag that the tells the schwarz method to be additive
 CDune::AddPtrTypeEvaluator< T >TypeEvaluator to turn a type T into a pointer to T
 CDune::AddRefTypeEvaluator< T >TypeEvaluator to turn a type T into a reference to T
 CDune::AffineGeometry< ct, mydim, cdim >Implementation of the Geometry interface for affine geometries
 CDune::Amg::Aggregate< G, S >A class for temporarily storing the vertices of an aggregate in
 CDune::Amg::Aggregate< MatrixGraph, VertexSet >
 CDune::Amg::AggregatesMap< V >Class providing information about the mapping of the vertices onto aggregates
 CDune::Amg::AggregatesMap< Vertex >
 CDune::Amg::AggregatesPublisher< T, O, OwnerOverlapCopyCommunication< T1, T2 > >Utility class for publishing the aggregate number of the DOFs in the overlap to other processors and convert them to local indices
 CDune::Amg::AggregationCriterion< T >Base class of all aggregation criterions
 CDune::Amg::Aggregator< G >Class for building the aggregates
 CDune::AlbertaGridEntityPointer< codim, GridImp >EntityPointer implementation for AlbertaGrid
 CDune::AlbertaGridEntityPointer< 0, GridImp >
 CDune::AlbertaGridGeometry< mydim, cdim, GridImp >Geometry implementation for AlbertaGrid
 CDune::AlbertaMarkerVector< dim, dimworld >Marker assigning subentities to one element containing them
 CDune::AlbertaMarkerVector< dim, Alberta::dimWorld >
 CDune::AlignmentOf< T >Calculates the alignment requirement of a type
 CDune::AllSet< TA >A set containing everything
 CDune::ALU2dGridEntityPointer< codim, GridImp >
 CDune::ALU2dGridEntityPointer< 0, GridImp >
 CDune::ALU2dGridEntityPointer< 1, GridImp >
 CDune::ALU2dGridEntityPointer< 2, GridImp >
 CDune::ALU2dGridEntityPointer< cdim, GridImp >
 CDune::ALU2dGridEntitySeed< 0, GridImp >
 CDune::ALU2dGridIntersectionBase< GridImp >
 CDune::ALU3dGridEntityPointerBase< codim, GridImp >
 CDune::ALU3dGridEntityPointerBase< 0, GridImp >
 CDune::ALU3dGridEntityPointerBase< cd, GridImp >
 CDune::ALU3dGridEntitySeed< 0, GridImp >
 CDune::ALU3dGridGeometricFaceInfoBase< type, Comm >
 CDune::ALU3dGridGeometricFaceInfoBase< hexa, Comm >
 CDune::ALU3dGridGeometricFaceInfoBase< tetra, Comm >
 CDune::ALU3dGridIntersectionIterator< GridImp >
 CDune::ALU3dGridLeafVertexList< Comm >
 CDune::ALU3dGridVertexList< Comm >
 CDune::ALUGrid< dim, dimworld, elType, refineType, Comm >[ provides Dune::Grid ]
 CDune::ALUGridBoundaryProjection< GridImp, ctype >ALUGrid boundary projection implementation DuneBndProjection has to fulfil the DuneBoundaryProjection interface
 CDune::ALUMemoryProvider< Object >Organize the memory management for entitys used by the NeighborIterator
 CDune::ALUMemoryProvider< EdgeObject >
 CDune::ALUMemoryProvider< EntityObject >
 CDune::ALUMemoryProvider< FaceObject >
 CDune::ALUMemoryProvider< LeafIntersectionIteratorImp >
 CDune::ALUMemoryProvider< LevelIntersectionIteratorImp >
 CDune::ALUMemoryProvider< VertexObject >
 CDune::AlwaysFalse< T >Template which always yields a false value
 CDune::AlwaysTrue< T >Template which always yields a true value
 CDune::AmiraMeshWriter< GridView >Provides file writing facilities in the AmiraMesh format
 CDune::AmiraMeshWriter< GridType::LeafGridView >
 CDune::AmiraMeshWriter< GridType::LevelGridView >
 CDune::AnalyticalCoordFunctionInterface< ct, dimD, dimR, Impl >Interface class for using an analytical function to define the geometry of a Dune::GeometryGrid. An implementation should be derived from Dune::AnalyticalCoordFunction and the evaluate method mapping \( R^d\to R^r \) has to be supplied
 CDune::AnalyticalCoordFunctionInterface< ctype, dimD, dimR, IdenticalCoordFunction< ctype, dim > >
 CDune::AnalyticalCoordFunctionInterface< double, dimD, dimR, DGFCoordFunction< dimD, dimR > >
 CDune::AnalyticalCoordFunctionInterface< HostGrid::ctype, dimD, dimR, IdenticalCoordFunction< HostGrid::ctype, dim > >
 CDune::ArrayList< T, N, A >A dynamically growing random access list
 CDune::ArrayList< Dune::IndexPair, 100 >
 CDune::ArrayList< Dune::IndexPair, N >
 CDune::ArrayList< IndexPair< TG, TL >, N, std::allocator< Dune::IndexPair< TG, TL > > >
 CDune::ArrayList< T, N, A >
 CDune::AssociativePropertyMap< T >An adapter to turn an unique associative container into a property map
 CDune::At< N >Reverse element access
 CDune::AtType< N, Tuple >Type for reverse element access
 CDune::AxisAlignedCubeGeometry< CoordType, dim, coorddim >A geometry implementation for axis-aligned hypercubes
 CDune::AxisAlignedCubeGeometry< GridImp::ctype, 0, cdim >
 CDune::AxisAlignedCubeGeometry< GridImp::ctype, mydim, cdim >
 CDune::AxisAlignedCubeGeometry< GridImp::ctype, mydim, mydim >
 CDune::b64chunkUnion representing the three byte text aswell as the four 6 bit chunks
 CDune::b64data
 CDune::b64txtStruct with three bytes of text
 CDune::BackupRestoreFacility< Grid >Facility for writing and reading grids
 CDune::BackupRestoreFacility< ALUGrid< dim, dimworld, elType, refineType, Comm > >facility for writing and reading grids
 CDune::BackupRestoreFacility< Dune::YaspGrid< dim, Coordinates > >facility for writing and reading grids
 CDune::BackupRestoreFacility< YaspGrid< dim, TensorProductCoordinates< ctype, dim > > >facility for writing and reading grids
 CDune::Base64StreamClass to base64 encode a stream of data
 CDune::base_array_unmanaged< B, A >A simple array container for objects of type B
 CDune::base_array_unmanaged< B, std::allocator< B > >
 CDune::base_array_unmanaged< double, std::allocator< double > >
 CDune::base_array_unmanaged< Dune::FieldVector< T, n >, A >
 CDune::base_array_unmanaged< T, std::allocator< T > >
 CDune::BCRSMatrix< B, A >A sparse block matrix with compressed row storage
 CDune::BCRSMatrix< B, std::allocator< B > >
 CDune::BidirectionalIteratorFacade< T, V, R, D >Facade class for stl conformant bidirectional iterators
 CDune::BidirectionalIteratorFacade< ContainerWrapperIterator< CW, T, R >, T, R, int >
 CDune::BidirectionalIteratorFacade< LevelIterator< C, T1 >, T1, T1 & >
 CDune::BidirectionalIteratorFacade< RealIterator< T >, T >
 CDune::bigunsignedint< k >Portable very large unsigned integers
 CDune::BilinearMapping< cdim >A bilinear mapping
 CDune::BitSetVectorConstReference< block_size, Alloc >A proxy class that acts as a const reference to a single bitset in a BitSetVector
 CDune::BL< l >Compile-time parameter for block recursion depth
 CDune::BoundarySegment< dim, dimworld >Base class for classes implementing geometries of boundary segments
 CDune::BufferedCommunicatorA communicator that uses buffers to gather and scatter the data to be send or received
 CDune::Capabilities::canCommunicate< Grid, codim >Specialize with 'true' for all codims that a grid can communicate data on (default=false)
 CDune::Capabilities::canCommunicate< YaspGrid< dim, Coordinates >, codim >YaspGrid can communicate on all codimensions
 CDune::VTKWriter< GridView >::CellIteratorIterator over the grids elements
 CDune::CheckIfDiagonalPresent< Matrix, blocklevel, l >Check whether the a matrix has diagonal values on blocklevel recursion levels
 CDune::CloneableAn interface class for cloneable objects
 CDune::Amg::CoarsenCriterion< T >The criterion describing the stop criteria for the coarsening process
 CDune::AlbertaLeafGridView< GridImp, pitype >::Codim< cd >Codim Structure
 CDune::AlbertaLevelGridView< GridImp, pitype >::Codim< cd >Codim Structure
 CDune::Codim< codim >Static tag representing a codimension
 CDune::DefaultLeafGridView< GridImp, pitype >::Codim< cd >Codim Structure
 CDune::DefaultLeafIteratorTypes< GridImp >::Codim< cd >The types of the iterator
 CDune::DefaultLevelGridView< GridImp, pitype >::Codim< cd >Codim Structure
 CDune::DefaultLevelIteratorTypes< GridImp >::Codim< cd >The types
 CDune::Entity< 0, dim, GridImp, EntityImp >::Codim< cd >EntityPointer types of the different codimensions
 CDune::EntityPointer< GridImp, IteratorImp >::Codim< cd >EntityPointer types of the different codimensions
 CDune::GeometryGrid< HostGrid, CoordFunction, Allocator >::Codim< codim >Traits structure containing types for a codimension
 CDune::Grid< dim, dimworld, ct, GridFamily >::Codim< cd >A Traits struct that collects all associated types of one implementation
 CDune::GridTraits< dim, dimw, GridImp, GeometryImp, EntityImp, EntityPointerImp, LevelIteratorImp, LeafIntersectionImp, LevelIntersectionImp, LeafIntersectionIteratorImp, LevelIntersectionIteratorImp, HierarchicIteratorImp, LeafIteratorImp, LevelIndexSetImp, LeafIndexSetImp, GlobalIdSetImp, GIDType, LocalIdSetImp, LIDType, CCType, LevelGridViewTraits, LeafGridViewTraits, EntitySeedImp, LocalGeometryImp >::Codim< cd >Traits associated with a specific codim
 CDune::GridView< ViewTraits >::Codim< cd >A struct that collects all associated types of one implementation from the Traits class
 CDune::HostGridAccess< GeometryGrid< HG, CoordFunction, Allocator > >::Codim< codim >A Traits struct that collects return types of class member methods
 CDune::HostGridAccess< IdentityGrid< HG > >::Codim< codim >A Traits struct that collects return types of class member methods
 CDune::IndexSet< GridImp, IndexSetImp, IndexTypeImp, TypesImp >::Codim< cc >Export the type of the entity used as parameter in the index(...) method
 CDune::ReferenceElement< ctype, dim >::Codim< codim >Collection of types depending on the codimension
 CDune::StaticRefinement< topologyId, CoordType, coerceToId, dimension_ >::Codim< codimension >The Codim struct inherited from the Refinement implementation
 CDune::VirtualRefinement< dimension, CoordType >::Codim< codimension >Codim database of VirtualRefinement
 CDune::Codim< 0 >
 CDune::Codim< 1 >
 CDune::Codim< cd >
 CDune::Codim< codimension >
 CDune::Codim< CodimInHostGrid >
 CDune::Codim< dimension >
 CDune::ColCompMatrix< M >Utility class for converting an ISTL Matrix into a column-compressed matrix
 CDune::ColCompMatrix< BCRSMatrix< FieldMatrix< B, n, m >, TA > >Converter for BCRSMatrix to column-compressed Matrix. specialization for BCRSMatrix
 CDune::ColCompMatrix< Matrix >
 CDune::ColCompMatrixInitializer< M >Inititializer for the ColCompMatrix as needed by OverlappingSchwarz
 CDune::ColCompMatrixInitializer< BCRSMatrix< FieldMatrix< T, n, m >, A > >
 CDune::CollectiveCommunication< C >Collective communication interface and sequential default implementation
 CDune::CollectiveCommunication< Dune::IdentityGrid >
 CDune::CollectiveCommunication< Dune::SGrid >
 CDune::CollectiveCommunication< Dune::UGGrid >
 CDune::CollectiveCommunication< MPI_Comm >Specialization of CollectiveCommunication for MPI
 CDune::CollectiveCommunication< No_Comm >
 CDune::CollectiveCommunication< void * >
 CDune::CollectiveIterator< T, A >A collective iterator for moving over the remote indices for all processes collectively
 CDune::Combine< TI1, TI2, TA >A set combining two other sets
 CDune::CombinedAdaptProlongRestrict< A, B >Class for combining 2 index sets together for adaptation process
 CDune::CombinedGrapeDisplay< DisplayType >Combines GrapeDataDisplays to one so that visualisation for parallel grid is more easy to handle
 CDune::CommDataHandleIF< DataHandleImp, DataTypeImp >CommDataHandleIF describes the features of a data handle for communication in parallel runs using the Grid::communicate methods. Here the Barton-Nackman trick is used to interprete data handle objects as its interface. Therefore usable data handle classes need to be derived from this class
 CDune::CommDataHandleIF< CommDataHandle< Grid, WrappedHandle >, WrappedHandle::DataType >
 CDune::CommDataHandleIF< DataHandle, double >
 CDune::CommDataHandleIF< IndexExchange, Index >
 CDune::CommDataHandleIF< MinimumExchange< IS, V >, V::value_type >
 CDune::CommMatrixRow< M, I >Utility class for comunicating the matrix entries
 CDune::CommMatrixRowSize< M, RI >Utility class to communicate and set the row sizes of a redistributed matrix
 CDune::CommMatrixSparsityPattern< M, I >Utility class to communicate and build the sparsity pattern of a redistributed matrix
 CDune::common_bits< current, mask >Activate if current and mask have common bits switched on
 CDune::CommPolicy< V >Default policy used for communicating an indexed type
 CDune::compressed_base_array_unmanaged< B, A >A simple array container with non-consecutive index set
 CDune::compressed_base_array_unmanaged< B, A >
 CDune::compressed_base_array_unmanaged< B, std::allocator< B > >
 CDune::CompressionStatistics< size_type >Statistics about compression achieved in implicit mode
 CDune::Amg::BaseConnectivityConstructor::ConnectedBuilder< G, S, V >Visitor for identifying connected aggregates during a breadthFirstSearch
 CDune::const_reference< R >Get the 'const' version of a reference to a mutable object
 CDune::const_reference< BitSetVectorReference< block_size, Alloc > >
 CDune::ConstantVolatileTraits< T >Determines wether a type is const or volatile and provides the unqualified types
 CDune::ConstAssociativePropertyMap< T >An adaptor to turn an unique associative container into a property map
 CDune::VariableBlockVector< B, A >::ConstIteratorConstIterator class for sequential access
 CDune::Amg::ConstructionTraits< T >Traits class for generically constructing non default constructable types
 CDune::Amg::ConstructionTraits< ParSSOR< M, X, Y, C > >Policy for the construction of the ParSSOR smoother
 CDune::Amg::ConstructionTraits< SeqILU0< M, X, Y > >Policy for the construction of the SeqILUn smoother
 CDune::Amg::ConstructionTraits< SeqILUn< M, X, Y > >Policy for the construction of the SeqJac smoother
 CDune::Amg::ConstructionTraits< SeqJac< M, X, Y, l > >Policy for the construction of the SeqJac smoother
 CDune::Amg::ConstructionTraits< SeqSOR< M, X, Y, l > >Policy for the construction of the SeqSOR smoother
 CDune::Amg::ConstructionTraits< SeqSSOR< M, X, Y, l > >Policy for the construction of the SeqSSOR smoother
 CDune::Conversion< From, To >Checks wether a type is convertible to another
 CDune::CommPolicy< V >::CopyGatherScatter< T >GatherScatter default implementation that just copies data
 CDune::OwnerOverlapCopyCommunication< GlobalIdType, LocalIdType >::CopyGatherScatter< T >Gather/scatter callback for communcation
 CDune::VTK::Corner< Cell >Simple class representing a corner of a cell
 CDune::VTK::Corner< typename remove_const< typename std::iterator_traits< CellIterator >::value_type >::type >
 CDune::MultiLinearGeometryTraits< ct >::CornerStorage< mydim, cdim >Template specifying the storage for the corners
 CDune::BCRSMatrix< B, A >::CreateIteratorIterator class for sequential creation of blocks
 CDune::VariableBlockVector< B, A >::CreateIteratorIterator class for sequential creation of blocks
 CDune::VTK::DataArrayWriter< T >Base class for data array writers
 CDune::VTK::DataArrayWriter< float >
 CDune::VTK::DataArrayWriter< RF >
 CDune::VTK::DataArrayWriter< unsigned >
 CDune::VTK::DataArrayWriter< unsigned char >
 CDune::VTK::DataArrayWriterFactoryFactory for DataArrayWriters
 CDune::BCRSMatrix< B, A >::DeallocatorClass used by shared_ptr to deallocate memory using the proper allocator
 CDune::DebugAllocator< T >Allocators implementation which performs different kind of memory checks
 CDune::DebugStreamStateIntermediate class to implement tie-operation of DebugStream
 CDune::Amg::DefaultConstructionArgs< T >Construction Arguments for the default smoothers
 CDune::Amg::DefaultConstructionArgs< SeqILUn< M, X, Y > >
 CDune::Amg::DefaultConstructionArgs< SeqOverlappingSchwarz< M, X, TM, TS, TA > >
 CDune::FloatCmp::DefaultEpsilon< T, style >Mapping from a value type and a compare style to a default epsilon
 CDune::DefaultLeafIteratorTypes< GridImp >LeafIterator tpyes for all codims and partition types
 CDune::DefaultLevelIteratorTypes< GridImp >LevelIterator tpyes for all codims and partition types
 CDune::Amg::DefaultSmootherArgs< T >The default class for the smoother arguments
 CDune::DenseMatrix< MAT >A dense n x m matrix
 CDune::DenseMatrix< DynamicMatrix< K > >
 CDune::DenseMatrix< FieldMatrix< alu3d_ctype, ROWS, COLS > >
 CDune::DenseMatrix< FieldMatrix< ctype, ROWS, COLS > >
 CDune::DenseMatrix< FieldMatrix< K, ROWS, COLS > >
 CDune::DenseMatrix< FieldMatrix< Real, ROWS, COLS > >
 CDune::DenseMatrix< FieldMatrix< T, ROWS, COLS > >
 CDune::DenseMatrixAssigner< DenseMatrix, RHS >You have to specialize this structure for any type that should be assignable to a DenseMatrix
 CDune::DenseVector< V >Interface for a class of dense vectors over a given field
 CDune::DenseVector< DynamicVector< field_type, std::allocator< field_type > > >
 CDune::DenseVector< DynamicVector< K, std::allocator< K > > >
 CDune::DenseVector< FieldVector< alu3d_ctype, SIZE > >
 CDune::DenseVector< FieldVector< ct, SIZE > >
 CDune::DenseVector< FieldVector< ctype, SIZE > >
 CDune::DenseVector< FieldVector< double, SIZE > >
 CDune::DenseVector< FieldVector< int, SIZE > >
 CDune::DenseVector< FieldVector< K, SIZE > >
 CDune::DenseVector< FieldVector< Real, SIZE > >
 CDune::DenseVector< FieldVector< T, SIZE > >
 CDune::Amg::DependencyParametersParameters needed to check whether a node depends on another
 CDune::DGFBoundaryParameterContains types for additional features
 CDune::DGFGridFactory< YaspGrid< dim > >Grid factory for YaspGrid with equidistant coordinates
 CDune::DGFGridFactory< YaspGrid< dim, EquidistantOffsetCoordinates< double, dim > > >Grid factory for YaspGrid with equidistant coordinates
 CDune::DGFGridInfo< GridType >Some simple static information for a given GridType
 CDune::DGFWriter< GV >Write a GridView to a DGF file
 CDune::Amg::Diagonal< N >Norm that uses only the [N][N] entry of the block to determine couplings
 CDune::Amg::Diagonal< 0 >
 CDune::DiagonalMatrix< K, n >A diagonal matrix of static size
 CDune::Dim< dim >Static tag representing a dimension
 CDune::DiscreteCoordFunctionInterface< ct, dimR, Impl >Interface class for using a discrete function to define the geometry of a Dune::GeometryGrid. An implementation should be derived from Dune::DiscreteCoordinateFunction and the evaluate method taking an entity of the host grid together with the number of a vertex returns the coordinate in \( R^r \) of that corner. The user must ensure continuity of this mapping. In addition an adapt method is provided which is called whenever adapt() is called on the Dune::GeometryGrid
 CDune::DiscreteCoordFunctionInterface< CoordFunction::ctype, dimR, CachedCoordFunction< HostGrid, CoordFunction > >
 CDune::Amg::AggregatesMap< V >::DummyEdgeVisitorA Dummy visitor that does nothing for each visited edge
 Cdune_nullptr_tFallback implementation of nullptr
 CDune::DuneBoundaryProjection< dimworld >Interface class for vertex projection at the boundary
 CDune::GenericGeometry::DuneGeometryType< Topology, linetype >Statically convert a generic topology type into a GeometryType
 CDune::GenericGeometry::DuneGeometryTypeProvider< dim, linetype >Dynamically convert a generic topology type into a GeometryType
 CDune::DuneGridFormatParserThe DuneGridFormatParser class: reads a DGF file and stores build information in vector structures used by the MacroGrid class
 CDune::DynamicMatrixSubdomainSolver< M, X, Y >Exact subdomain solver using Dune::DynamicMatrix<T>::solve
 CDune::Amg::SubGraph< G, T >::EdgeIndexMapAn index map for mapping the edges to indices
 CDune::Amg::MatrixGraph< M >::EdgeIteratorT< C >Iterator over all edges starting from a vertex
 CDune::Amg::EdgePropertiesClass representing the properties of an ede in the matrix graph
 CDune::ElementTopologyMapping< type >
 CDune::EmptyJust an empty class
 CDune::EmptySet< TA >An empty set
 CDune::EnableIfInterOperable< T1, T2, Type >Enable typedef if two types are interoperable
 CDune::Entity< cd, dim, GridImp, EntityImp >Wrapper class for entities
 CDune::Entity< codim, dim, Grid, EntityImp >
 CDune::GeoGrid::EntityBase< codim, Grid, fake >Actual implementation of the entity
 CDune::GeoGrid::EntityBase< 0, Grid >
 CDune::GeoGrid::EntityBase< codim, Grid, false >actual implementation of the entity
 CDune::GeoGrid::EntityBase< codim, Grid, true >actual implementation of the entity
 CDune::EntityDefaultImplementation< cd, dim, GridImp, EntityImp >Default Implementations for EntityImp
 CDune::EntityDefaultImplementation< 0, dim, Grid, AlbertaGridEntity >
 CDune::EntityDefaultImplementation< 0, dim, GridImp, ALU2dGridEntity >
 CDune::EntityDefaultImplementation< 0, dim, GridImp, ALU3dGridEntity >
 CDune::EntityDefaultImplementation< 0, dim, GridImp, IdentityGridEntity >
 CDune::EntityDefaultImplementation< 0, dim, GridImp, YaspEntity >
 CDune::EntityDefaultImplementation< cd, dim, GridImp, ALU2dGridEntity >
 CDune::EntityDefaultImplementation< cd, dim, GridImp, ALU3dGridEntity >
 CDune::EntityDefaultImplementation< codim, dim, Grid, AlbertaGridEntity >
 CDune::EntityDefaultImplementation< codim, dim, GridImp, EntityImp >
 CDune::EntityDefaultImplementation< codim, dim, GridImp, IdentityGridEntity >
 CDune::EntityDefaultImplementation< codim, dim, GridImp, SEntity >
 CDune::EntityDefaultImplementation< codim, dim, GridImp, YaspEntity >
 CDune::EntityDefaultImplementation< dim, dim, GridImp, YaspEntity >
 CDune::EntityInfo< ctype >Structure to hold statistical information about one type of entity
 CDune::EntityPointer< GridImp, IteratorImp >Wrapper class for pointers to entities
 CDune::EntityPointer< Grid, IteratorImp >
 CDune::EntitySeed< GridImp, EntitySeedImp >Store a reference to an entity with a minimal memory footprint
 CDune::EnumItem< TA, item >A set consisting only of one item
 CDune::EnumRange< TA, from, end >A set representing a range including the borders
 CDune::FloatCmp::EpsilonType< T >Mapping of value type to epsilon type
 CDune::FloatCmp::EpsilonType< FieldVector< T, n > >Specialization of EpsilonType for Dune::FieldVector
 CDune::FloatCmp::EpsilonType< std::vector< T, A > >Specialization of EpsilonType for std::vector
 CDune::EquidistantCoordinates< ct, dim >Container for equidistant coordinates in a YaspGrid
 CDune::EquidistantOffsetCoordinates< ct, dim >Container for equidistant coordinates in a YaspGrid with non-trivial origin
 CDune::ExceptionBase class for Dune-Exceptions
 CDune::ExceptionHookBase class to add a hook to the Dune::Exception
 CDune::FaceTopologyMapping< type >
 CDune::Factorial< m >Calculates the factorial of m at compile time
 CDune::Factorial< 0 >End of recursion of factorial via specialization
 CDune::FakeMPIHelperA fake mpi helper
 CDune::VTK::FieldInfoDescriptor struct for VTK fields
 CDune::FirstPredicateIndex< Tuple, Predicate, start, size >Finding the index of a certain type in a tuple
 CDune::FirstPredicateIndex< Tuple, IsType< T >::template Predicate, 0 >
 CDune::FlattenTuple< TupleTuple >Flatten a tuple of tuples
 CDune::FloatCmpOps< T, cstyle_, rstyle_ >Class encapsulating a default epsilon
 CDune::fmatrix_assigner< T, n, m >Fmatrix assignment operator
 CDune::FMatrixPrecision< ctype >Precisions for calculations with FieldMatrix and FieldVector
 CDune::ForEachType< TypeEvaluator, TupleType >Helper template to clone the type definition of a tuple with the storage types replaced by a user-defined rule
 CDune::ForEachValue< TupleType >Helper template which implements iteration over all storage elements in a tuple
 CDune::ForEachValuePair< TupleType1, TupleType2 >Extension of ForEachValue to two tuples..
 CDune::ForLoop< Operation, first, last >A static loop using TMP
 CDune::ForwardIteratorFacade< T, V, R, D >Base class for stl conformant forward iterators
 CDune::ForwardIteratorFacade< BoundaryIterator< GV >, const GV::Intersection, const GV::Intersection &, std::iterator_traits< GV::template Codim< 0 >::Iterator >::difference_type >
 CDune::ForwardIteratorFacade< const_iterator, const Matrix::row_type >
 CDune::ForwardIteratorFacade< CornerIterator, const Entity, EntityReference, int >
 CDune::ForwardIteratorFacade< CornerIterator< CellIterator >, const Corner< remove_const< std::iterator_traits< CellIterator >::value_type >::type >, const Corner< remove_const< std::iterator_traits< CellIterator >::value_type >::type > &, std::iterator_traits< CellIterator >::difference_type >
 CDune::ForwardIteratorFacade< PointIterator< CellIterator, IS >, const Corner< remove_const< std::iterator_traits< CellIterator >::value_type >::type >, const Corner< remove_const< std::iterator_traits< CellIterator >::value_type >::type > &, std::iterator_traits< CellIterator >::difference_type >
 CDune::ForwardIteratorFacade< SLListConstIterator< T, A >, const T, const T &, std::size_t >
 CDune::ForwardIteratorFacade< SLListIterator< RemoteIndex, Allocator >, RemoteIndex, RemoteIndex &, std::size_t >
 CDune::ForwardIteratorFacade< SLListIterator< T, A >, T, T &, std::size_t >
 CDune::ForwardIteratorFacade< SLListModifyIterator< RemoteIndex, Allocator >, RemoteIndex, RemoteIndex &, std::size_t >
 CDune::ForwardIteratorFacade< SLListModifyIterator< T, A >, T, T &, std::size_t >
 CDune::ForwardIteratorFacade< VertexIterator, const Entity, EntityReference, int >
 CDune::ForwardIteratorFacade< VertexIterator, const VertexDescriptor >
 CDune::Function< Domain, Range >Base class template for function classes
 CDune::Function< const DomainType &, RangeType & >
 CDune::VTKWriter< GridView >::VTKLocalFunction::FunctionWrapperBaseBase class for polymorphic container of underlying data set
 CDune::VTK::FunctionWriterBase< Cell_ >Base class for function writers
 CDune::VTK::FunctionWriterBase< Cell >
 CDune::VTK::FunctionWriterBase< Func::Entity >
 CDune::VTK::FunctionWriterBase< Func::Traits::Cell >
 CDune::VTK::FunctionWriterBase< IteratorFactory::Cell >
 CDune::fvector_assigner< T, s >Fvector assignment operator
 CALUGridSpace::GatherScatterBaseImpl< GridType, DataCollectorType, codim >Corresponding interface class is defined in bsinclude.hh
 CALUGridSpace::GatherScatterBaseImpl< GridType, DataCollectorType, 0 >Corresponding interface class is defined in bsinclude.hh
 CALUGridSpace::GatherScatterLoadBalance< GridType, DataCollectorType, IndexOperatorType >Corresponding interface class is defined in bsinclude.hh
 CDune::GaussLobattoQuadratureInitHelper< ct, fundamental >
 CDune::GaussQuadratureInitHelper< ct, fundamental >
 CDune::Gcd< a, b >Calculator of the greatest common divisor
 CDune::GeneralVertexOrder< dim, Index_ >Class providing information on the ordering of vertices
 CDune::Geometry< mydim, cdim, GridImp, GeometryImp >Wrapper class for geometries
 CDune::GeometryDefaultImplementation< mydim, cdim, GridImp, GeometryImp >Default implementation for class Geometry
 CDune::GeometryDefaultImplementation< mydim, cdim, GridImp, ALU2dGridGeometry >
 CDune::GeometryDefaultImplementation< mydim, cdim, GridImp, ALU3dGridGeometry >
 CDune::GeometryDefaultImplementation< mydim, coorddim, GridImp, IdentityGridGeometry >
 CDune::GeometryGrid< HostGrid, CoordFunction, Allocator >Grid wrapper replacing the geometries
 CDune::MyALUGridGeometryImplementation< cdim >::GeometryImpl< dummy, dim, eltype >General type of geometry implementation
 CDune::GeometryTypeUnique label for each type of entities that can occur in DUNE grids
 CDune::GlobalGeometryTypeIndexCompute indices for geometry types, taking the dimension into account
 CDune::GlobalIndexSet< GridView >Calculate globally unique index over all processes in a Dune grid
 CDune::GlobalLookupIndexSet< I >Decorates an index set with the possibility to find a global index that is mapped to a specific local
 CDune::GlobalLookupIndexSet< ParallelIndexSet >
 CDune::GmshReader< GridType >Read Gmsh mesh file
 CDune::GmshReaderOptionsOptions for read operation
 CDune::GmshReaderParser< GridType >Dimension independent parts for GmshReaderParser
 CDune::GmshWriter< GridView >Write Gmsh mesh file
 CDune::GnuplotWriter< GridView >Writer for 1D grids in gnuplot format
 CDune::GnuplotWriter< G::LeafGridView >
 CDune::GnuplotWriter< G::LevelGridView >
 CDune::GrapeGridDisplay< GridType >
 CDune::Amg::GraphEdgePropertiesSelector< G >Wrapper to access the internal vertex properties of a graph via operator[]()
 CDune::Amg::GraphVertexPropertiesSelector< G >Wrapper to access the internal edge properties of a graph via operator[]()
 CDune::greater_or_equal< current, threshold >Greater or equal template test
 CDune::Grid< dim, dimworld, ct, GridFamily >Grid abstract base class
 CDune::Grid< dim, dimworld, Alberta::Real, AlbertaGridFamily< dim, Alberta::dimWorld > >
 CDune::Grid< dim, dimworld, Alberta::Real, AlbertaGridFamily< dim, dimworld > >
 CDune::Grid< dim, dimworld, alu2d_ctype, ALU2dGridFamily< dim, dimworld, eltype > >
 CDune::Grid< dim, dimworld, alu3d_ctype, ALU3dGridFamily< elType, Comm > >
 CDune::Grid< dim, dimworld, Coordinates::ctype, YaspGridFamily< dim, CoordCont > >
 CDune::Grid< dim, dimworld, Coordinates::ctype, YaspGridFamily< dim, EquidistantCoordinates< double, dim > > >
 CDune::Grid< dim, dimworld, double, OneDGridFamily< 1, 1 > >
 CDune::Grid< dim, dimworld, double, UGGridFamily< dim > >
 CDune::Grid< dim, dimworld, HostGrid::ctype, IdentityGridFamily< HostGrid::dimension, HostGrid > >
 CDune::Grid< dim, dimworld, sgrid_ctype, SGridFamily< dim, dimworld, sgrid_ctype > >
 CDune::GridFactoryInterface< GridType >Provide a generic factory class for unstructured grids
 CDune::GridFactoryInterface< AlbertaGrid< dim, dimworld > >
 CDune::GridFactoryInterface< Grid >
 CDune::GridFactoryInterface< UGGrid< dimworld > >
 CDune::GridObjectStreamOrDefault< GridImp, DefaultImp >Template to choose right Object stream type for a given class
 CDune::GridObjectStreamOrDefaultHelper< hasStream, GridImp, DefaultImp >
 CDune::GridObjectStreamOrDefaultHelper< false, GridImp, DefaultImp >
 CDune::dgf::GridParameterBlockCommon Grid parameters
 CDune::GridPtr< GridType >Class for constructing grids from DGF files
 CDune::GridTraits< dim, dimw, GridImp, GeometryImp, EntityImp, EntityPointerImp, LevelIteratorImp, LeafIntersectionImp, LevelIntersectionImp, LeafIntersectionIteratorImp, LevelIntersectionIteratorImp, HierarchicIteratorImp, LeafIteratorImp, LevelIndexSetImp, LeafIndexSetImp, GlobalIdSetImp, GIDType, LocalIdSetImp, LIDType, CCType, LevelGridViewTraits, LeafGridViewTraits, EntitySeedImp, LocalGeometryImp >A traits struct that collects all associated types of one grid model
 CDune::GridView< ViewTraits >Grid view abstract base class
 CDune::GridViewInfoGTCompareComparison object to sort GeometryType by majorly dimension
 CDune::Capabilities::hasBackupRestoreFacilities< Grid >Specialize with 'true' if implementation provides backup and restore facilities. (default=false)
 CDune::Capabilities::hasBackupRestoreFacilities< AlbertaGrid< dim, dimworld > >AlbertaGrid has backup and restore facilities
 CDune::Capabilities::hasEntity< Grid, codim >Specialize with 'true' for all codims that a grid implements entities for. (default=false)
 CDune::Capabilities::hasEntity< AlbertaGrid< dim, dimworld >, codim >AlbertaGrid has entities for all codimensions
 CDune::Capabilities::hasEntity< IdentityGrid< HostGrid >, codim >Has entities for some codimensions as host grid
 CDune::Capabilities::hasEntity< OneDGrid, cdim >OneDGrid has entities for all codimension
 CDune::Capabilities::hasEntity< SGrid< dim, dimw >, cdim >SGrid has entities for all codimension
 CDune::Capabilities::hasEntity< UGGrid< dim >, 0 >UGGrid has codim=0 entities (elements)
 CDune::Capabilities::hasEntity< UGGrid< dim >, dim >UGGrid has codim=dim entities (vertices)
 CDune::Capabilities::hasEntity< YaspGrid< dim, Coordinates >, codim >YaspGrid has entities for all codimensions
 CDune::hash< T >Functor for hashing objects of type T
 CDune::HasHierarchicIndexSetTagging interface to indicate that Grid has HierarchicIndexSet
 CDune::HasObjectStreamTagging interface to indicate that Grid provides typedef ObjectStreamType
 CDune::Capabilities::hasSingleGeometryType< Grid >Specialize with 'true' for if the codimension 0 entity of the grid has only one possible geometry type. In this case the topologyId of this geometry type has also to be specified. (default=false, topologyId=undefined)
 CDune::MultiLinearGeometryTraits< ct >::hasSingleGeometryType< dim >Will there be only one geometry type for a dimension?
 CDune::Capabilities::hasSingleGeometryType< AlbertaGrid< dim, dimworld > >AlbertaGrid has only one geometry type for codim 0 entities
 CDune::Capabilities::hasSingleGeometryType< OneDGrid >OneDGrid has only one geometry type for codim 0 entities
 CDune::Capabilities::hasSingleGeometryType< SGrid< dim, dimw > >SGrid has only one geometry type for codim 0 entities
 CDune::Capabilities::hasSingleGeometryType< YaspGrid< dim, Coordinates > >YaspGrid has only one geometry type for codim 0 entities
 CDune::HierarchicSearch< Grid, IS >Search an IndexSet for an Entity containing a given point
 CDune::Amg::Hierarchy< T, A >A hierarchy of coantainers (e.g. matrices or vectors)
 CDune::Amg::Hierarchy< Domain, A >
 CDune::Amg::Hierarchy< Domain, std::allocator< X > >
 CDune::Amg::Hierarchy< MatrixOperator, Allocator >
 CDune::Amg::Hierarchy< ParallelInformation, Allocator >
 CDune::Amg::Hierarchy< Range, A >
 CDune::Amg::Hierarchy< Range, std::allocator< X > >
 CDune::Amg::Hierarchy< Smoother, A >
 CDune::Amg::Hierarchy< Smoother, std::allocator< X > >
 CDune::HostGridAccess< Grid >Access to host grid objects from GeometryGrid
 CDune::IdentityGridEntityPointer< codim, GridImp, HostGridEntityPointer_ >
 CDune::IdentityGridEntityPointer< 0, GridImp, GridImp::HostGridType::template Codim< 0 >::Entity::HierarchicIterator >
 CDune::IdentityGridEntityPointer< codim, GridImp, GridImp::HostGridType::template Codim< codim >::template Partition< pitype >::LeafIterator >
 CDune::IdentityGridEntityPointer< codim, GridImp, GridImp::HostGridType::Traits::template Codim< codim >::template Partition< pitype >::LevelIterator >
 CDune::IdentityGridEntitySeed< codim, GridImp >The EntitySeed class provides the minimal information needed to restore an Entity using the grid
 CDune::IdentityGridLeafIntersection< GridImp >An intersection with a leaf neighbor elementMesh entities of codimension 0 ("elements") allow to visit all neighbors, where a neighbor is an entity of codimension 0 which has a common entity of codimension 1 These neighbors are accessed via a IntersectionIterator. This allows the implement non-matching meshes. The number of neighbors may be different from the number of an element!
 CDune::IdentityGridLeafIntersectionIterator< GridImp >Iterator over all element neighborsMesh entities of codimension 0 ("elements") allow to visit all neighbors, where a neighbor is an entity of codimension 0 which has a common entity of codimension 1 These neighbors are accessed via a IntersectionIterator. This allows the implement non-matching meshes. The number of neighbors may be different from the number of an element!
 CDune::IdentityGridLevelIntersection< GridImp >
 CDune::IdentityGridLevelIntersectionIterator< GridImp >
 CDune::IdentityMapA property map that applies the identity function to integers
 CDune::IdentityMatrix< K, N >Read-only identity matrix
 CDune::IdSet< GridImp, IdSetImp, IdTypeImp >Id Set Interface
 CDune::IdSet< AlbertaGrid< dim, dimworld >, AlbertaGridIdSet< dim, dimworld >, unsigned int >
 CDune::IdSet< ALU2dGrid< dim, dimworld, eltype >, ALU2dGridLocalIdSet< dim, dimworld, eltype >, int >
 CDune::IdSet< const Dune::IdentityGrid< HostGrid >, IdentityGridGlobalIdSet< const Dune::IdentityGrid< HostGrid > >, remove_const< const Dune::IdentityGrid< HostGrid > >::type::HostGridType::Traits::GlobalIdSet::IdType >
 CDune::IdSet< const Dune::IdentityGrid< HostGrid >, IdentityGridLocalIdSet< const Dune::IdentityGrid< HostGrid > >, remove_const< const Dune::IdentityGrid< HostGrid > >::type::HostGridType::Traits::LocalIdSet::IdType >
 CDune::IdSet< const Dune::SGrid< dim, dimworld >, SGridGlobalIdSet< const Dune::SGrid< dim, dimworld > >, remove_const< const Dune::SGrid< dim, dimworld > >::type::PersistentIndexType >
 CDune::IdSet< const Dune::YaspGrid< dim, CoordCont >, YaspGlobalIdSet< const Dune::YaspGrid< dim, CoordCont > >, remove_const< const Dune::YaspGrid< dim, CoordCont > >::type::PersistentIndexType >
 CDune::IdSet< const Dune::YaspGrid< dim, EquidistantCoordinates< double, dim > >, YaspGlobalIdSet< const Dune::YaspGrid< dim, EquidistantCoordinates< double, dim > > >, remove_const< const Dune::YaspGrid< dim, EquidistantCoordinates< double, dim > > >::type::PersistentIndexType >
 CDune::IdSet< Grid, IdSet< Grid, HostIdSet >, HostIdSet::IdType >
 CDune::IdSet< GridImp, IdentityGridGlobalIdSet< GridImp >, remove_const< GridImp >::type::HostGridType::Traits::GlobalIdSet::IdType >
 CDune::IdSet< GridImp, IdentityGridLocalIdSet< GridImp >, remove_const< GridImp >::type::HostGridType::Traits::LocalIdSet::IdType >
 CDune::IdSet< GridImp, SGridGlobalIdSet< GridImp >, remove_const< GridImp >::type::PersistentIndexType >
 CDune::IdSet< GridImp, YaspGlobalIdSet< GridImp >, remove_const< GridImp >::type::PersistentIndexType >
 CDune::ILUSubdomainSolver< M, X, Y >Base class encapsulating common algorithms of ILU0SubdomainSolver and ILUNSubdomainSolver
 CDune::ImplementationDefinedDummy struct used for documentation purposes
 CDune::ImplicitMatrixBuilder< M_ >A wrapper for uniform access to the BCRSMatrix during and after the build stage in implicit build mode
 CDune::IndentUtility class for handling nested indentation in output
 CDune::IndexInfoFromGrid< G, L >Information about the index distribution
 CDune::IndexPair< TG, TL >A pair consisting of a global and local index
 CDune::IndexSet< GridImp, IndexSetImp, IndexTypeImp, TypesImp >Index Set Interface base class
 CDune::IndexSet< AlbertaGrid< dim, dimworld >, AlbertaGridIndexSet< dim, dimworld >, int, std::array< GeometryType, 1 > >
 CDune::IndexSet< AlbertaGridFamily< dim, dimworld >, AlbertaGridHierarchicIndexSet< dim, dimworld >, int, std::array< GeometryType, 1 > >
 CDune::IndexSet< ALU2dGrid< dim, dimworld, eltype >, ALU2dGridHierarchicIndexSet< dim, dimworld, eltype >, int >
 CDune::IndexSet< ALU3dGrid< elType, Comm >, ALU3dGridHierarchicIndexSet< elType, Comm > >
 CDune::IndexSet< const Dune::IdentityGrid< HostGrid >, IdentityGridLeafIndexSet< const Dune::IdentityGrid< HostGrid > >, remove_const< const Dune::IdentityGrid< HostGrid > >::type::HostGridType::LeafGridView::IndexSet::IndexType, remove_const< const Dune::IdentityGrid< HostGrid > >::type::HostGridType::LeafGridView::IndexSet::Types >
 CDune::IndexSet< const Dune::IdentityGrid< HostGrid >, IdentityGridLevelIndexSet< const Dune::IdentityGrid< HostGrid > >, remove_const< const Dune::IdentityGrid< HostGrid > >::type::HostGridType::LevelGridView::IndexSet::IndexType, remove_const< const Dune::IdentityGrid< HostGrid > >::type::HostGridType::LevelGridView::IndexSet::Types >
 CDune::IndexSet< const Dune::SGrid< dim, dimworld >, SGridLevelIndexSet< const Dune::SGrid< dim, dimworld > > >
 CDune::IndexSet< const Dune::YaspGrid< dim, CoordCont >, YaspIndexSet< const Dune::YaspGrid< dim, CoordCont >, isLeafIndexSet >, unsigned int >
 CDune::IndexSet< const Dune::YaspGrid< dim, EquidistantCoordinates< double, dim > >, YaspIndexSet< const Dune::YaspGrid< dim, EquidistantCoordinates< double, dim > >, isLeafIndexSet >, unsigned int >
 CDune::IndexSet< Grid, IndexSet< Grid, HostIndexSet >, HostIndexSet::IndexType, HostIndexSet::Types >
 CDune::IndexSet< GridImp, DefaultIndexSet< GridImp, IteratorImp >, unsigned int >
 CDune::IndexSet< GridImp, IdentityGridLeafIndexSet< GridImp >, remove_const< GridImp >::type::HostGridType::LeafGridView::IndexSet::IndexType, remove_const< GridImp >::type::HostGridType::LeafGridView::IndexSet::Types >
 CDune::IndexSet< GridImp, IdentityGridLevelIndexSet< GridImp >, remove_const< GridImp >::type::HostGridType::LevelGridView::IndexSet::IndexType, remove_const< GridImp >::type::HostGridType::LevelGridView::IndexSet::Types >
 CDune::IndexSet< GridImp, IndexSetImp >
 CDune::IndexSet< GridImp, SGridLevelIndexSet< GridImp > >
 CDune::IndexSet< GridImp, YaspIndexSet< GridImp, isLeafIndexSet >, unsigned int >
 CDune::IndexStack< T, length >
 CDune::Amg::IndicesCoarsener< OwnerOverlapCopyCommunication< G, L >, E >Coarsen Indices in the parallel case
 CDune::Amg::IndicesCoarsener< SequentialInformation, E >Coarsen Indices in the sequential case
 CDune::IndicesSyncer< T >Class for recomputing missing indices of a distributed index set
 CDune::Std::integer_sequence< T, Ints >Implementation of std::integer_sequence to be introduced in C++14
 CDune::Std::integer_sequence< std::size_t, Ints... >
 CDune::InterfaceBuilderBase class of all classes representing a communication interface
 CDune::InterfaceInformationInformation describing an interface
 CDune::Intersection< GridImp, IntersectionImp >Intersection of a mesh entities of codimension 0 ("elements") with a "neighboring" element or with the domain boundary
 CDune::YGridList< Coordinates >::IntersectionType describing an intersection with a neighboring processor
 CDune::Intersection< const GridImp, Dune::SIntersection< const GridImp > >
 CDune::Intersection< GridImp, AlbertaGridLeafIntersection< GridImp > >
 CDune::IntersectionDefaultNormalVectors< GridImp, IntersectionImp >Default Implementations of integrationOuterNormal and unitOuterNormal for IntersectionImp
 CDune::IntersectionIterator< GridImp, IntersectionIteratorImp, IntersectionImp >Mesh entities of codimension 0 ("elements") allow to visit all intersections with "neighboring" elements and with the domain boundary
 CDune::IntersectionIteratorWrapper< GridImp, IntersectionIteratorImpl >Class that wraps IntersectionIteratorImp of a grid and gets it's internal object from a object stack hold by the grid
 CDune::IntersectionIteratorWrapper< GridImp, GridImp::LeafIntersectionIteratorImp >
 CDune::IntersectionIteratorWrapper< GridImp, GridImp::LevelIntersectionIteratorImp >
 CDune::InverseOperator< X, Y >Abstract base class for all solvers
 CDune::InverseOperator< BlockVector< FieldVector< T, m >, A::template rebind< FieldVector< T, m > >::other >, BlockVector< FieldVector< T, n >, A::template rebind< FieldVector< T, n > >::other > >
 CDune::InverseOperator< Domain, Range >
 CDune::InverseOperator< X, X >
 CDune::InverseOperatorResultStatistics about the application of an inverse operator
 CDune::ios_base_all_saverUtility class for storing and resetting stream attributes
 CDune::is_indexable< T, I >
 CDune::is_lvalue_reference< T >Determine whether a type is a lvalue reference type
 CDune::is_pointer< T >Is_pointer
 CDune::IsBaseOf< Base, Derived >Checks wether a type is derived from another
 CDune::Capabilities::isCartesian< Grid >Specialize with 'true' if the grid is a Cartesian grid. Cartesian grids satisfy the following properties:
 CDune::Capabilities::isCartesian< SGrid< dim, dimw > >SGrid is a Cartesian grid
 CDune::Capabilities::isCartesian< YaspGrid< dim, Coordinates > >YaspGrid is a Cartesian grid
 CDune::IsConst< T >Tests wether a type is constant
 CDune::IsDofManagerTagging interface to indicate that class is of Type DofManager
 CDune::IsFieldVectorSizeCorrect< C, SIZE >TMP to check the size of a DenseVectors statically, if possible
 CDune::IsInteroperable< T1, T2 >Checks wether two types are interoperable
 CDune::Capabilities::isLeafwiseConforming< Grid >Specialize with 'true' if implementation guarantees a conforming leaf grid. (default=false)
 CDune::Capabilities::isLeafwiseConforming< AlbertaGrid< dim, dimworld > >AlbertaGrid is leafwise conforming
 CDune::Capabilities::isLeafwiseConforming< IdentityGrid< HostGrid > >Has conforming leaf grids when host grid has
 CDune::Capabilities::isLeafwiseConforming< OneDGrid >OneDGrid is leafwise conforming
 CDune::Capabilities::isLeafwiseConforming< SGrid< dim, dimw > >SGrid is leafwise conforming
 CDune::Capabilities::isLeafwiseConforming< UGGrid< dim > >UGGrid may not be leafwise conforming
 CDune::Capabilities::isLeafwiseConforming< YaspGrid< dim, Coordinates > >YaspGrid is leafwise conforming
 CDune::Capabilities::isLevelwiseConforming< Grid >Specialize with 'true' if implementation guarantees conforming level grids. (default=false)
 CDune::Capabilities::isLevelwiseConforming< AlbertaGrid< dim, dimworld > >AlbertaGrid is not levelwise conforming (since it uses bisection)
 CDune::Capabilities::isLevelwiseConforming< IdentityGrid< HostGrid > >Has conforming level grids when host grid has
 CDune::Capabilities::isLevelwiseConforming< OneDGrid >OneDGrid is levelwise conforming
 CDune::Capabilities::isLevelwiseConforming< SGrid< dim, dimw > >SGrid is levelwise conforming
 CDune::Capabilities::isLevelwiseConforming< UGGrid< dim > >UGGrid is levelwise conforming
 CDune::Capabilities::isLevelwiseConforming< YaspGrid< dim, Coordinates > >YaspGrid is levelwise conforming
 CDune::IsMatrix< T >Test whether a type is an ISTL Matrix
 CDune::Capabilities::isParallel< Grid >Specialize with 'true' if implementation supports parallelism. (default=false)
 CDune::Capabilities::isParallel< OneDGrid >OneDGrid is not parallel
 CDune::IsType< T >Generator for predicates accepting one particular type
 CDune::IsVolatile< T >Tests wether a type is volatile
 CDune::CollectiveIterator< T, A >::iteratorIterator over the valid underlying iterators
 CDune::VariableBlockVector< B, A >::IteratorIterator class for sequential access
 CDune::YGrid< Coordinates >::IteratorIterator over a collection o YGrids A YGrid::Iterator is the heart of an entity in YaspGrid
 CDune::YGridComponent< Coordinates >::Iterator
 CDune::IteratorDirectionSelector< T1, T2, forward >Helper template meta program for application of overlapping schwarz
 CDune::IteratorPropertyMap< RAI, IM, T, R >Adapter to turn a random access iterator into a property map
 CDune::IteratorRange< Iterator >Simple range between a begin and an end iterator
 CDune::Jacobi1QuadratureInitHelper< ct, fundamental >
 CDune::Jacobi2QuadratureInitHelper< ct, fundamental >
 CDune::JoinTuples< Head, Tail >Join two tuples
 CDune::Lcm< m, n >Calculate the least common multiple of two numbers
 CDune::LeafIntersectionIteratorWrapper< GridImp >Class that wraps IntersectionIteratorImp of a grid and gets it's internal object from a object stack hold by the grid
 CDune::LevelIntersectionIteratorWrapper< GridImp >Class that wraps IntersectionIteratorImp of a grid and gets it's internal object from a object stack hold by the grid
 CDune::Amg::LevelTransferPolicy< FO, CO >Abstract base class for transfer between levels and creation of the coarse level system
 CDune::Amg::LevelTransferPolicy< FO, typename CSP::Operator >
 CDune::Amg::LevelTransferPolicy< O, O >
 CDune::LinearMapping< cdim, mydim >A linear mapping
 CDune::LinearMapping< cdim, 0 >
 CDune::LinearMapping< cdim, 1 >
 CDune::LinearMapping< cdim, 2 >
 CDune::LinearMapping< cdim, cdim >
 CDune::LinearMapping< cdim, dim >
 CDune::LinearOperator< X, Y >A linear operator
 CDune::LinearOperator< X, X >
 CDune::LocalGeometryTypeIndexCompute per-dimension indices for geometry types
 CDune::LocalIndexAn index present on the local process
 CDune::lru< _Key, _Tp, _Traits >LRU Cache Container
 CDune::MakeableInterfaceObject< InterfaceType >
 CDune::MallocAllocator< T >Allocators implementation which simply calls malloc/free
 Cstd::map< K, T >STL class
 CDune::Mapper< G, MapperImp, IndexType >Mapper interface
 CDune::Mapper< G, UniversalMapper< G, G::Traits::GlobalIdSet > >
 CDune::Mapper< G, UniversalMapper< G, G::Traits::LocalIdSet > >
 CDune::Mapper< G, UniversalMapper< G, IDS > >
 CDune::Mapper< GV::Grid, MultipleCodimMultipleGeomTypeMapper< G::LeafGridView, Layout >, GV::IndexSet::IndexType >
 CDune::Mapper< GV::Grid, MultipleCodimMultipleGeomTypeMapper< G::LevelGridView, Layout >, GV::IndexSet::IndexType >
 CDune::Mapper< GV::Grid, MultipleCodimMultipleGeomTypeMapper< GV, Layout >, GV::IndexSet::IndexType >
 CDune::Mapper< GV::Grid, MultipleCodimMultipleGeomTypeMapper< GV, MCMGElementLayout >, GV::IndexSet::IndexType >
 CDune::Mapper< GV::Grid, MultipleCodimMultipleGeomTypeMapper< GV, MCMGVertexLayout >, GV::IndexSet::IndexType >
 CDune::Mapper< GV::Grid, SingleCodimSingleGeomTypeMapper< G::LeafGridView, c >, GV::IndexSet::IndexType >
 CDune::Mapper< GV::Grid, SingleCodimSingleGeomTypeMapper< G::LevelGridView, c >, GV::IndexSet::IndexType >
 CDune::Mapper< GV::Grid, SingleCodimSingleGeomTypeMapper< GV, c >, GV::IndexSet::IndexType >
 CDune::MathematicalConstants< Field >Provides commonly used mathematical constants
 CDune::MatMultMatResult< M1, M2 >Helper TMP to get the result type of a sparse matrix matrix multiplication ( \(C=A*B\))
 CDune::Matrix< T, A >A generic dynamic dense matrix
 CDune::Matrix< double >
 CDune::Amg::MatrixGraph< M >The (undirected) graph of a matrix
 CDune::Amg::MatrixGraph< const M >
 CDune::Amg::MatrixHierarchy< M, PI, A >The hierarchies build by the coarsening process
 CDune::MatrixIndexSetStores the nonzero entries in a sparse matrix
 CDune::MatrixRowSet< M >Provides access to an iterator over all matrix rows
 CDune::MatrixRowSubset< M, S >Provides access to an iterator over an arbitrary subset of matrix rows
 CDune::MatrixMarketImpl::MatrixValuesSetter< D, brows, bcols >Functor to the data values of the matrix
 CMCMGElementEdgeLayout< dimgrid >Layout template for edges and elements This layout template is for use in the MultipleCodimMultipleGeomTypeMapper. It selects edges and elements (entities with dim=1 or dim=dimgrid)
 CDune::MCMGElementLayout< dimgrid >Layout template for elements
 CDune::MCMGElementLayout< GV::dimension >
 CDune::MCMGVertexLayout< dim >Layout template for vertices
 CDune::MCMGVertexLayout< GV::dimension >
 CDune::MessageBufferIF< MessageBufferImp >Communication message buffer interface. This class describes the interface for reading and writing data to the communication message buffer. As message buffers might be deeply implemented in various packages the message buffers implementations cannot be derived from this interface class. Therefore we just apply the engine concept to wrap the message buffer call and make sure that the interface is fulfilled
 CDune::MatrixMarketImpl::mm_block_structure_header< M >Metaprogram for writing the ISTL block structure header
 CDune::MatrixMarketImpl::mm_header_printer< M >Meta program to write the correct Matrix Market header
 CDune::MatrixMarketImpl::mm_numeric_type< T >Helper metaprogram to get the matrix market string representation of the numeric type
 CMPIErrorMPI Error. Thrown when an mpi error occurs
 CDune::MPIGuardDetects a thrown exception and communicates to all other processes
 CDune::MPIHelperA real mpi helper
 CDune::MPITraits< T >A traits class describing the mapping of types onto MPI_Datatypes
 CDune::MPITraits< IndexPair< TG, ParallelLocalIndex< TA > > >
 CDune::MPITraits< ParallelLocalIndex< T > >
 CDune::MultiLinearGeometry< ct, mydim, cdim, Traits >Generic geometry implementation based on corner coordinates
 CDune::MultiLinearGeometry< ct, mydim, cdim, MultiLinearGeometryTraits< ct > >
 CDune::MultiLinearGeometry< typename Base::CoordinateType::value_type, dim-1, dimworld >
 CDune::MultiLinearGeometryTraits< ct >Default traits class for MultiLinearGeometry
 CDune::MultiplicativeSchwarzModeTag that tells the Schwarz method to be multiplicative
 CDune::mutable_reference< R >Get the 'mutable' version of a reference to a const object
 CDune::NegateSet< S >The negation of a set. An item is contained in the set if and only if it is not contained in the negated set
 CDune::NonConformingFaceMapping< type, Comm >
 CDune::NonConformingFaceMapping< hexa, Comm >Non-conforming face mappings for hexahedra
 CDune::NonConformingFaceMapping< tetra, Comm >Non-conforming face mappings for tetrahedra
 CDune::null_deleter< T >Implements the Deleter concept of shared_ptr without deleting anything
 CDune::NullPointerInitialiser< Tuple >A helper template that initializes a tuple consisting of pointers to NULL
 CDune::MatrixMarketImpl::NumericWrapper< T >Wrapper class of numeric values
 CDune::Amg::OneStepAMGCoarseSolverPolicy< O, S, C >A policy class for solving the coarse level system using one step of AMG
 CDune::OverlappingSchwarzInitializer< I, S, D >Initializer for SuperLU Matrices representing the subdomains
 CDune::OwnerOverlapCopyAttributeSetAttribute set for overlapping schwarz
 CDune::OwnerOverlapCopyCommunication< GlobalIdType, LocalIdType >A class setting up standard communication for a two-valued attribute set with owner/overlap/copy semantics
 CDune::ParallelIndexSet< TG, TL, N >Manager class for the mapping between local indices and globally unique indices
 CDune::ParallelIndexSet< GlobalIdType, LI, 512 >
 CDune::ParallelIndexSet< TG, TL, N >
 CDune::ParallelLocalIndex< T >An index present on the local process with an additional attribute flag
 CDune::ParameterTreeHierarchical structure of string parameters
 CDune::ParameterTreeParserParsers to set up a ParameterTree from various input sources
 CDune::AlbertaLeafGridViewTraits< GridImp, pitype >::Codim< cd >::Partition< pit >Define types needed to iterate over entities of a given partition type
 CDune::AlbertaLevelGridViewTraits< GridImp, pitype >::Codim< cd >::Partition< pit >Define types needed to iterate over entities of a given partition type
 CDune::DefaultLeafGridViewTraits< GridImp, pitype >::Codim< cd >::Partition< pit >Define types needed to iterate over entities of a given partition type
 CDune::DefaultLevelGridViewTraits< GridImp, pitype >::Codim< cd >::Partition< pit >Define types needed to iterate over entities of a given partition type
 CDune::GeometryGrid< HostGrid, CoordFunction, Allocator >::Partition< pitype >Types for GridView
 CDune::Grid< dim, dimworld, ct, GridFamily >::Codim< cd >::Partition< pitype >A struct collecting all types depending on the partition iterator type
 CDune::Grid< dim, dimworld, ct, GridFamily >::Partition< pitype >Types for GridView
 CDune::GridTraits< dim, dimw, GridImp, GeometryImp, EntityImp, EntityPointerImp, LevelIteratorImp, LeafIntersectionImp, LevelIntersectionImp, LeafIntersectionIteratorImp, LevelIntersectionIteratorImp, HierarchicIteratorImp, LeafIteratorImp, LevelIndexSetImp, LeafIndexSetImp, GlobalIdSetImp, GIDType, LocalIdSetImp, LIDType, CCType, LevelGridViewTraits, LeafGridViewTraits, EntitySeedImp, LocalGeometryImp >::Codim< cd >::Partition< pitype >Traits associated with a specific grid partition type
 CDune::GridTraits< dim, dimw, GridImp, GeometryImp, EntityImp, EntityPointerImp, LevelIteratorImp, LeafIntersectionImp, LevelIntersectionImp, LeafIntersectionIteratorImp, LevelIntersectionIteratorImp, HierarchicIteratorImp, LeafIteratorImp, LevelIndexSetImp, LeafIndexSetImp, GlobalIdSetImp, GIDType, LocalIdSetImp, LIDType, CCType, LevelGridViewTraits, LeafGridViewTraits, EntitySeedImp, LocalGeometryImp >::Partition< pitype >Traits associated with a specific grid partition type
 CDune::GridView< ViewTraits >::Codim< cd >::Partition< pit >Define types needed to iterate over entities of a given partition type
 CDune::PartitionSet< partitions >A set of PartitionType values
 CDune::MatrixMarketImpl::PatternDummyUtility class for marking the pattern type of the MatrixMarket matrices
 CDune::PersistentContainerInterface< G, T >Persistent storage of data on all entities of a grid
 CDune::PersistentContainerMap< G, IdSet, Map >Map-based implementation of the PersistentContainer
 CDune::PersistentContainerMap< G, G::LocalIdSet, std::map< G::LocalIdSet::IdType, T > >
 CDune::PersistentContainerMap< Grid, G::LocalIdSet, std::map< G::LocalIdSet::IdType, T > >
 CDune::PersistentContainerMap< HostGrid, G::LocalIdSet, std::map< G::LocalIdSet::IdType, Coordinate > >
 CDune::PersistentContainerMap< HostGrid, G::LocalIdSet, std::map< G::LocalIdSet::IdType, RangeVector > >
 CDune::PersistentContainerMap< HostGrid, G::LocalIdSet, std::map< G::LocalIdSet::IdType, T > >
 CDune::PersistentContainerVector< G, IndexSet, Vector >Vector-based implementation of the PersistentContainer
 CDune::PersistentContainerVector< AlbertaGrid< dim, dimworld >, AlbertaGrid< dim, dimworld >::HierarchicIndexSet, std::vector< T > >
 CDune::PersistentContainerVector< YaspGrid< dim, CoordCont >, YaspPersistentContainerIndex< const YaspGrid< dim, CoordCont > >, std::vector< T > >
 CDune::PointerPairDeletor< Tuple >Deletes all objects pointed to in a tuple of pointers
 CDune::Pool< T, s >A memory pool of objects
 CDune::Pool< T, size >
 CDune::PoolAllocator< T, s >An allocator managing a pool of objects for reuse
 CDune::Power< p >Compute power for a run-time mantissa and a compile-time integer exponent
 CDune::Preconditioner< X, Y >Base class for matrix free definition of preconditioners
 CDune::Preconditioner< AMG::Domain, AMG::Range >
 CDune::Preconditioner< FO::domain_type, FO::range_type >
 CDune::Preconditioner< O::domain_type, O::range_type >
 CDune::Preconditioner< P::domain_type, P::range_type >
 CDune::Preconditioner< X, X >
 CDune::IsType< T >::Predicate< U >The actual predicate
 CDune::VTK::PrintType< T >Determine a type to safely put another type into a stream
 CDune::PrismQuadraturePoints< dim >
 CDune::PrismQuadraturePoints< 3 >
 CDune::PrismQuadraturePointsSingleton< dim >Singleton holding the Prism Quadrature points
 CDune::PrismQuadraturePointsSingleton< 3 >Singleton holding the Prism Quadrature points
 CDune::PrismQuadratureRule< ct, dim >Quadrature rules for prisms
 CDune::Torus< CollectiveCommunication, d >::ProcListIterator
 CDune::Amg::PropertiesGraph< G, VP, EP, VM, EM >Attaches properties to the edges and vertices of a graph
 CDune::PropertyMapTypeSelector< T, C >Selector for the property map type
 CDune::PushBackTuple< Tuple, T >Helper template to append a type to a tuple
 CDune::PushBackTuple< typenameCodimTable< Element, dim-1 >::ElementTuple, Element< dim > >
 CDune::PushBackTuple< typenameCodimTable< GeometryArray, dim-1 >::ElementTuple, GeometryArray< dim > >
 CDune::PushFrontTuple< Tuple, T >Helper template to prepend a type to a tuple
 CDune::VTK::PVTUWriterDump a .vtu/.vtp files contents to a stream
 CDune::QuadraturePoint< ct, dim >Single evaluation point in a quadrature rule
 CDune::QuadratureRuleFactory< ctype, dim >Factory class for creation of quadrature rules, depending on GeometryType, order and QuadratureType
 CDune::QuadratureRules< ctype, dim >A container for all quadrature rules of dimension dim
 CDune::Amg::RandomAccessBundledPropertyMap< C, K, i, T, R >A property map that extracts one property out of a bundle using operator[]()
 CDune::RandomAccessIteratorFacade< T, V, R, D >Base class for stl conformant forward iterators
 CDune::RandomAccessIteratorFacade< ArrayListIterator< T, N, A >, A::value_type, A::reference, A::difference_type >
 CDune::RandomAccessIteratorFacade< ConstArrayListIterator< IndexPair< TG, TL >, N, std::allocator< Dune::IndexPair< TG, TL > > >, const A::value_type, A::const_reference, A::difference_type >
 CDune::RandomAccessIteratorFacade< ConstArrayListIterator< T, N, A >, const A::value_type, A::const_reference, A::difference_type >
 CDune::RandomAccessIteratorFacade< DenseIterator< C, T, T & >, T, T &, std::ptrdiff_t >
 CDune::RandomAccessIteratorFacade< EdgeIterator, const EdgeDescriptor >
 CDune::RandomAccessIteratorFacade< GenericIterator< C, T, T &, std::ptrdiff_t, RandomAccessIteratorFacade >, T, T &, std::ptrdiff_t >
 CDune::RandomAccessIteratorFacade< iterator, const Index_ >
 CDune::RandomAccessIteratorFacade< RealIterator< T >, T >
 CDune::RandomAccessIteratorFacade< RealRowIterator< T >, T >
 CDune::RawStreamWrite out data in binary
 CDune::ReadablePropertyMapTagTag for the category of readable property maps
 CDune::PoolAllocator< T, s >::rebind< U >Rebind the allocator to another type
 CDune::ReduceTuple< F, Tuple, Seed, N >Apply reduce with meta binary function to template
 CDune::ReduceTuple< F, Tuple, Seed, 0 >Apply reduce with meta binary function to template
 CDune::ReferenceElement< ctype, dim >This class provides access to geometric and topological properties of a reference element
 CDune::ReferenceElements< ctype, dim >Class providing access to the singletons of the reference elements
 CDune::RefinementImp::HCube::RefinementImp< dimension_, CoordType >Refinement implementation for hypercubes
 CDune::RefinementImp::PrismTriangulation::RefinementImp< dimension_, CoordType >Implementation of the refinement of a prism into simplices
 CDune::RefinementImp::PyramidTriangulation::RefinementImp< dimension_, CoordType >Implementation of the refinement of a pyramid into simplices
 CDune::RefinementImp::HCube::RefinementSubEntityIteratorSpecial< dimension, CoordType, codimension >SubEntityIterator base class for hypercube refinement
 CDune::RemoteIndex< T1, T2 >Information about an index residing on another processor
 CDune::RemoteIndexListModifier< T, A, mode >Modifier for adding and/or deleting remote indices from the remote index list
 CDune::RemoteIndices< T, A >The indices present on remote processes
 CDune::RemoteIndices< PIS >
 CDune::remove_pointer< _Tp >Return the type a pointer type points to
 CDune::ReservedVector< T, n >A Vector class with statically reserved memory
 CDune::ReservedVector< Dune::SGridLevelIndexSet< const Dune::SGrid< dim, dimworld > > *, MAXL >
 CDune::ReservedVector< T, length >
 CDune::ReservedVector< YGridLevel, 32 >
 CDune::GridDefaultImplementation< dim, dimworld, ct, GridFamily >::ReturnImplementationType< T >Helper class to choose correct implementation return type for getRealImplementation
 CDune::ImplicitMatrixBuilder< M_ >::row_objectProxy row object for entry access
 CDune::Amg::RowSumFunctor using the row sum (infinity) norm to determine strong couplings
 CDune::ScalarProduct< X >Base class for scalar product and norm computation
 CDune::ScalarProductChooser< X, C, c >Choose the approriate scalar product for a solver category
 CDune::ScaledIdentityMatrix< K, n >A multiple of the identity matrix of static size
 CDune::Selection< TS, TG, TL, N >A cached selection of indices
 CDune::SelectionIterator< TS, TG, TL, N >A const iterator over an uncached selection
 CDune::SEntityPointer< codim, GridImp >
 CDune::SEntityPointer< 0, GridImp >
 CDune::SEntitySeed< codim, GridImp >
 CDune::SeqOverlappingSchwarzApplier< T >Helper template meta program for application of overlapping schwarz
 CDune::SeqOverlappingSchwarzDomainSize< M >
 CDune::SHierarchicStackElem
 CDune::Singleton< T >An adapter to turn a class into a singleton
 CDune::SIntersectionIterator< GridImp >
 CDune::GenericGeometry::Size< Topology, codim >Statically compute the number of subentities of a given codimension
 CDune::SizeCache< GridImp >Organizes the caching of sizes for one grid and one GeometryType
 CDune::SizeCache< AlbertaGrid< dim, Alberta::dimWorld > >
 CDune::SizeCache< AlbertaGrid< dim, dimworld > >
 CDune::SizeOneFlag for marking indexed data structures where data at each index is of the same size
 CDune::VTK::SkeletonFunctionInterface< GV, RF >A prototype for VTKFunctions on the skeleton
 CDune::SLList< T, A >A single linked list
 CDune::SLList< GlobalIndex, Allocator >
 CDune::SLList< RemoteIndex, Allocator >
 CDune::SLList< T, A >
 CDune::Amg::SmootherApplier< T >Helper class for applying the smoothers
 CDune::Amg::SmootherTraits< T >Traits class for getting the attribute class of a smoother
 CDune::Amg::SmootherTraits< S >
 CDune::Amg::SmootherTraits< Smoother >
 CDune::SolverCategoryCategories for the solvers
 CDune::Amg::SparsityBuilder< M >Functor for building the sparsity pattern of the matrix using examineConnectivity
 Cstd::stack< T >STL class
 CDune::StandardMathematicalConstants< T >Standard implementation of MathematicalConstants
 CDune::StarCDReader< GridType >File reader for the Star-CD format
 CDune::StaticPower< m, p >Calculates m^p at compile time
 CDune::StaticPower< m, 0 >End of recursion via specialization
 CDune::StaticRefinement< topologyId, CoordType, coerceToId, dimension_ >Wrap each Refinement implementation to get a consistent interface
 CDune::StructuredGridFactory< GridType >Construct structured cube and simplex grids in unstructured grid managers
 CDune::StructuredGridFactory< SGrid< dim, dim > >Specialization of the StructuredGridFactory for SGrid
 CDune::StructuredGridFactory< YaspGrid< dim, EquidistantCoordinates< ctype, dim > > >Specialization of the StructuredGridFactory for YaspGrid
 CDune::StructuredGridFactory< YaspGrid< dim, EquidistantOffsetCoordinates< ctype, dim > > >Specialization of the StructuredGridFactory for YaspGrid
 CDune::ReferenceElement< ctype, dim >::SubEntityInfoTopological information about the subentities of a reference element
 CDune::Amg::SubGraph< G, T >A subgraph of a graph
 CDune::Amg::SubGraph< Graph, T >
 CDune::GlobalIndexSet< GridView >::SubPartitionTypeProvider< Entity, Codim >Helper class to provide access to subentity PartitionTypes with a run-time codimension
 CDune::SuperLUMatrix< M >Utility class for converting an ISTL Matrix into a SuperLU Matrix
 CDune::SuperLUMatrix< Matrix >
 CDune::SurfaceNormalCalculatorA bilinear surface mapping
 CDune::SymmetricMultiplicativeSchwarzModeTag that tells the Schwarz method to be multiplicative and symmetric
 CDune::TensorGridFactory< Grid >A factory class for conveniently creating tensorproduct grids
 CDune::TensorGridFactory< Dune::Grid >
 CDune::TensorGridFactory< Dune::YaspGrid >
 CDune::TensorProductCoordinates< ct, dim >Coordinate container for a tensor product YaspGrid
 CDune::Capabilities::threadSafe< Grid >Specialize with 'true' if the grid implementation is thread safe. (default=false)
 CDune::TimerA simple stop watch
 CDune::Std::to_false_type< T >Template mapping a type to std::false_type
 CDune::Std::to_true_type< T >Template mapping a type to std::true_type
 CDune::TopologyFactory< Traits >Provide a factory over the generic topologies
 CDune::TopologySingletonFactory< Factory >A wrapper for a TopologyFactory providing singleton storage. Same usage as TopologyFactory but with empty release method an internal storage
 CDune::Torus< CollectiveCommunication, d >
 CDune::Torus< Dune::CollectiveCommunication< MPI_Comm >, dim >
 CDune::Function< Domain, Range >::TraitsTraits class containing raw types
 CDune::RefinementImp::Traits< topologyId, CoordType, coerceToId, dimension, Dummy >Mapping from geometryType, CoordType and coerceTo to a particular Refinement implementation
 CDune::TransformTupleFunctor< TE, A0, A1, A2, A3, A4, A5, A6, A7, A8, A9 >Helper class to implement transformTuple()
 CDune::TransposedMatMultMatResult< M1, M2 >Helper TMP to get the result type of a sparse matrix matrix multiplication ( \(C=A*B\))
 CDune::TrilinearMapping
 CDune::TransformTupleFunctor< TE, A0, A1, A2, A3, A4, A5, A6, A7, A8, A9 >::TypeEvaluator< T >Export the TypeEvaluator template class for genericTransformTuple()
 CDune::VTK::TypeName< T >Map type to its VTK name in data array
 CDune::TypeTraits< T >General type traits class to check whether type is reference or pointer type
 CDune::UMFPack< Matrix >Use the UMFPack package to directly solve linear systems – empty default class
 CDune::UncachedSelection< TS, TG, TL, N >An uncached selection of indices
 CDune::VariableSizeFlag for marking indexed data structures where the data at each index may be a variable multiple of another type
 CDune::VariableSizeCommunicator< Allocator >A buffered communicator where the amount of data sent does not have to be known a priori
 Cstd::vector< T >STL class
 CDune::Amg::MatrixGraph< M >::VertexIteratorT< C >The vertex iterator type of the graph
 CDune::VertexOrderByIdFactory< IdSet, Index >::VertexOrder< dim >Type of vertex order object may depend on the dimension of the element
 CDune::VertexOrderByIdFactory< IdSet, Index >Factory for GeneralVertexOrder objects using an IdSet
 CDune::Amg::VertexPropertiesClass representing a node in the matrix graph
 CDune::Amg::VertexPropertiesGraph< G, VP, VM >Attaches properties to the vertices of a graph
 CDune::Amg::VertexVisitedTagTag idnetifying the visited property of a vertex
 CDune::Capabilities::viewThreadSafe< Grid >Specialize with 'true' if the grid implementation is thread safe, while it is not modified. (default=false)
 CDune::VirtualRefinement< dimension, CoordType >VirtualRefinement base class
 CDune::VTKFunction< GridView >A base class for grid functions with any return type and dimension
 CDune::VTKFunction< GV >
 CDune::VTKWriter< GridView >::VTKLocalFunctionType erasure wrapper for VTK data sets
 CDune::VTKSequenceWriterBase< GridView >Base class to write pvd-files which contains a list of all collected vtk-files
 CDune::VTKWriter< GridView >Writer for the ouput of grid functions in the vtk format
 CDune::VTKWriter< Dune::GridView >
 CDune::VTK::VTUWriterDump a .vtu/.vtp files contents to a stream
 CDune::WritablePropertyMapTagTag for the category of writable property maps
 CDune::YaspEntityPointer< codim, GridImp >A pointer to a YaspGrid::Entity
 CDune::YaspEntityPointer< 0, GridImp >
 CDune::YaspEntitySeed< codim, GridImp >Describes the minimal information necessary to create a fully functional YaspEntity
 CDune::YaspIntersection< GridImp >YaspIntersection provides data about intersection with neighboring codim 0 entities
 CDune::YaspIntersectionIterator< GridImp >YaspIntersectionIterator enables iteration over intersections with neighboring codim 0 entities
 CDune::YaspPersistentContainerIndex< Grid >Implement a consecutive index for all entities of given codim of a YaspGrid
 CDune::YaspPersistentContainerIndex< const YaspGrid< dim, CoordCont > >
 CDune::YGrid< Coordinates >Implements a collection of YGridComponents which form a codimension Entities of given codimension c need to be represented by d choose c YgridComponents. All entities in one such component share the same set of spanning unit vectors. A YGrid is used to iterate over the entire set of components the codimension consists of. It doesnt hold any data, but instead holds an iterator range into an array of components (which is owned by YGridLevel)
 CDune::YGridComponent< Coordinates >
 CDune::YGridList< Coordinates >Implements a collection of multiple std::deque<Intersection> Intersections with neighboring processors are stored as std::deque<Intersection>. Eachsuch intersection only holds one YGridComponent. To do all communication associated with one codimension, multiple such deques have to be concatenated. YGridList manges this concatenation. As for YGrids, YGridList doesnt hold any data, but an iterator range into a data array owned by YGridLevel
 CDune::YLoadBalance< d >Base class for the yaspgrid partitioning strategy The name might be irritating. It will probably change to YaspPartitionerBase in a 3.0 release
Creative Commons License   |  Legal Statements / Impressum  |  Hosted by TU Dresden  |  generated with Hugo v0.111.3 (Jan 6, 23:30, 2025)