Dune Core Modules (2.9.0)

Class Hierarchy
This inheritance list is sorted roughly, but not completely, alphabetically:
[detail level 1234567]
 CDune::TypeTree::AccumulateType< Tree, Policy >Statically accumulate a type over the nodes of a TypeTree
 CDune::TypeTree::AccumulateValue< Tree, Functor, Reduction, startValue, ParentChildReduction >Statically accumulate a value over the nodes of a TypeTree
 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::MathOverloads::ADLTagTag to make sure the functions in this namespace can be found by ADL
 CDune::Simd::Overloads::ADLTag< i, bool >Tag used to force late-binding lookup in Dune::Simd::Overloads
 CDune::Simd::Overloads::ADLTag< i-1 >
 CDune::TypeTree::AdvancedFilterBase class for advanced filters
 CDune::TypeTree::AdvancedFilterTagTag describing an advanced filter that has full control over the construction of the list of FilterEntries
 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::AlbertaGridGeometry< mydim, cdim, GridImp >Geometry implementation for AlbertaGrid
 CDune::AlbertaGridHierarchicIterator< GridImp >
 CDune::AlbertaGridTreeIterator< codim, GridImp, leafIterator >
 CDune::AlbertaGridTreeIterator< codim, GridImp, false >
 CDune::AlbertaGridTreeIterator< codim, GridImp, true >
 CDune::AlbertaMarkerVector< dim, dimworld >Marker assigning subentities to one element containing them
 CDune::AlbertaMarkerVector< dim, Alberta::dimWorld >
 CDune::AlignedBase< align, Impl >CRTP base mixin class to check alignment
 CDune::AlignedBase< align, AlignedNumber< T, align > >
 CDune::AllSet< TA >A set containing everything
 CDune::ALU3dGridEntityPointerBase< codim, GridImp >
 CDune::ALU3dGridEntityPointerBase< 0, GridImp >
 CDune::ALU3dGridEntityPointerBase< cd, GridImp >
 CDune::ALU3dGridEntitySeed< 0, GridImp >
 CDune::ALU3dGridGeometricFaceInfoBase< dim, dimworld, type, Comm >
 CDune::ALU3dGridGeometricFaceInfoBase< 2, dimworld, hexa, Comm >
 CDune::ALU3dGridGeometricFaceInfoBase< 2, dimworld, tetra, Comm >
 CDune::ALU3dGridGeometricFaceInfoBase< 2, dimworld, type, Comm >
 CDune::ALU3dGridGeometricFaceInfoBase< dim, dimworld, hexa, Comm >
 CDune::ALU3dGridGeometricFaceInfoBase< dim, dimworld, tetra, Comm >
 CALUGrid::ALU3dGridGhostIteratorHigherCodim< codim >Ghost Iterator
 CALUGrid::ALU3dGridGhostIteratorHigherCodim< 1 >
 CALUGrid::ALU3dGridGhostIteratorHigherCodim< 2 >
 CALUGrid::ALU3dGridGhostIteratorHigherCodim< 3 >
 CDune::ALU3dGridIntersectionIterator< GridImp >
 CDune::ALU3dGridLeafVertexList< Comm >
 CDune::ALU3dGridVertexList< Comm >
 CDune::ALUGrid< dim, dimworld, elType, refineType, Comm >Unstructured parallel implementation of the DUNE grid interface
 CDune::ALUGridBoundaryProjection< GridImp, ctype >ALUGrid boundary projection implementation DuneBndProjection has to fulfil the DuneBoundaryProjection interface
 CDune::ALUGridMPICommType of class for specialization of parallel ALUGrid (MPI_Comm as communicator)
 CDune::ALUGridNoCommType of class for specialization of serial ALUGrid (No_Comm as communicator)
 CALUGrid::ALUMemoryProvider< Object >Organize the memory management for entitys used by the NeighborIterator
 CDune::AlwaysFalse< T >Template which always yields a false value
 CDune::AlwaysTrue< T >Template which always yields a true value
 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::Functions::AnalyticGridViewFunction< Range(Domain), GV, F, DerivativeTraits >Class wrapping any differentiable function as grid function
 CDune::TypeTree::and_< result_type >Statically combine two values of type result_type using &&
 CDune::TypeTree::AdvancedFilter::apply< Node, Children >Apply this filter to the given node and children
 CDune::TypeTree::filter< Filter >::apply< Node, Children >Apply the filter
 CDune::TypeTree::SimpleFilter::apply< Child, new_index, old_index >Applies the filter to the given child node
 CDune::ArPackPlusPlus_Algorithms< BCRSMatrix, BlockVector >Wrapper to use a range of ARPACK++ eigenvalue solvers
 Cstd::array< T >STL class
 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::AutonomousValueType< T >Type free of internal references that T can be converted to
 CDune::AutonomousValueType< Simd::VcImpl::Proxy< V >::value_type >
 CDune::AutonomousValueType< std::vector< bool >::reference >Specialization for the proxies of vector<bool>
 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::b64chunkStruct representing the three byte text as well as the four 6 bit chunks
 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::Imp::base_array_unmanaged< B, std::allocator< B > >
 CDune::Imp::base_array_unmanaged< double, std::allocator< double > >
 CDune::Imp::base_array_unmanaged< T, A >
 CDune::Imp::base_array_unmanaged< T, std::allocator< T > >
 CDune::BasisInterfaceInterface for global-valued shape functions
 CDune::BasisInterfaceSwitch< Basis, Dummy >Switch for uniform treatment of local and global basis classes
 CDune::ISTL::Impl::BCCSMatrix< BCRSMatrix< B, TA >::field_type, int >
 CDune::BCRSMatrix< B, A >A sparse block matrix with compressed row storage
 CDune::BCRSMatrix< B, std::allocator< B > >
 CDune::BDFMCubeLocalBasis< D, R, dim, order >Brezzi-Douglas-Fortin-Marini shape functions on a reference cube
 CDune::BDFMCubeLocalBasis< D, R, 2, 1 >First order Brezzi-Douglas-Fortin-Marini shape functions on the refrence quadrialteral
 CDune::BDFMCubeLocalBasis< D, R, 2, 2 >Second order Brezzi-Douglas-Fortin-Marini shape functions on the refrence quadrialteral
 CDune::BDFMCubeLocalBasis< D, R, 2, 3 >Third order Brezzi-Douglas-Fortin-Marini shape functions on the refrence quadrialteral
 CDune::BDFMCubeLocalFiniteElement< D, R, dim, order >Brezzi-Douglas-Fortin-Marini finite elements for cubes
 CDune::BDFMCubeLocalInterpolation< D, R, dim, order >Interpolation for Brezzi-Douglas-Fortin-Marini shape functions on cubes
 CDune::BDM1Cube2DLocalBasis< D, R >First order Brezzi-Douglas-Marini shape functions on the reference quadrilateral
 CDune::BDM1Cube2DLocalFiniteElement< D, R >First order Brezzi-Douglas-Marini shape functions on quadrilaterals
 CDune::BDM1Cube2DLocalInterpolation< LB >First order Brezzi-Douglas-Marini shape functions on the reference quadrilateral
 CDune::BDM1Cube2DLocalInterpolation< Dune::BDM1Cube2DLocalBasis< D, R > >
 CDune::BDM1Cube3DLocalBasis< D, R >First order Brezzi-Douglas-Marini shape functions on the reference hexahedron
 CDune::BDM1Cube3DLocalFiniteElement< D, R >First order Brezzi-Douglas-Marini shape functions on hexahedron
 CDune::BDM1Cube3DLocalInterpolation< LB >First order Brezzi-Douglas-Marini shape functions on the reference hexahedron
 CDune::BDM1Cube3DLocalInterpolation< Dune::BDM1Cube3DLocalBasis< D, R > >
 CDune::BDM1Simplex2DLocalBasis< D, R >First order Brezzi-Douglas-Marini shape functions on the reference triangle
 CDune::BDM1Simplex2DLocalFiniteElement< D, R >First order Brezzi-Douglas-Marini shape functions on triangles
 CDune::BDM1Simplex2DLocalInterpolation< LB >First order Brezzi-Douglas-Marini shape functions on the reference triangle
 CDune::BDM1Simplex2DLocalInterpolation< Dune::BDM1Simplex2DLocalBasis< D, R > >
 CDune::BDM2Cube2DLocalBasis< D, R >First order Brezzi-Douglas-Marini shape functions on quadrilaterals
 CDune::BDM2Cube2DLocalFiniteElement< D, R >Second order Brezzi-Douglas-Marini shape functions on quadrilaterals
 CDune::BDM2Cube2DLocalInterpolation< LB >First order Brezzi-Douglas-Marini shape functions on quadrilaterals
 CDune::BDM2Cube2DLocalInterpolation< Dune::BDM2Cube2DLocalBasis< D, R > >
 CDune::BDM2Simplex2DLocalBasis< D, R >First order Brezzi-Douglas-Marini shape functions on quadrilaterals
 CDune::BDM2Simplex2DLocalFiniteElement< D, R >Second order Brezzi-Douglas-Marini shape functions on triangles
 CDune::BDM2Simplex2DLocalInterpolation< LB >First order Brezzi-Douglas-Marini shape functions on triangles
 CDune::BDM2Simplex2DLocalInterpolation< Dune::BDM2Simplex2DLocalBasis< D, R > >
 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, ctype >Base class for classes implementing geometries of boundary segments
 CDune::BoundarySegment< dim >
 CDune::BrezziDouglasMariniCubeLocalFiniteElement< D, R, dim, order >Brezzi-Douglas-Marini local finite element for cubes
 CDune::BrezziDouglasMariniSimplexLocalFiniteElement< D, R, dim, order >Brezzi-Douglas-Marini local finite element for simplices
 CDune::Functions::BSplineLocalBasis< GV, R >LocalBasis class in the sense of dune-localfunctions, presenting the restriction of a B-spline patch to a knot span
 CDune::Functions::BSplineLocalBasis< GV, double >
 CDune::Functions::BSplineLocalCoefficients< dim >Attaches a shape function to an entity
 CDune::Functions::BSplineLocalFiniteElement< GV, R >LocalFiniteElement in the sense of dune-localfunctions, for the B-spline basis on tensor-product grids
 CDune::Functions::BSplineLocalFiniteElement< GV, double >
 CDune::Functions::BSplineLocalInterpolation< dim, LB >Local interpolation in the sense of dune-localfunctions, for the B-spline basis on tensor-product grids
 CDune::Functions::BSplineLocalInterpolation< dim, Dune::Functions::BSplineLocalBasis< GV, double > >
 CDune::Functions::BSplineLocalInterpolation< dim, Dune::Functions::BSplineLocalBasis< GV, R > >
 CDune::Functions::BSplinePreBasis< GV >Pre-basis for B-spline basis
 CDune::BufferedCommunicatorA communicator that uses buffers to gather and scatter the data to be send or received
 CDune::Functions::Concept::Callable< Args >Concept objects that can be called with given argument list
 CDune::Functions::CallableFunctionWrapper< F >Wrap a Dune::VirtualFunction into a callable object
 CDune::Capabilities::canCommunicate< Grid, codim >Specialize with 'true' for all codims that a grid can communicate data on (default=false)
 CDune::Capabilities::canCommunicate< ALUGrid< dim, dimworld, eltype, refinementtype, ALUGridMPIComm >, codim >ALUGrid can communicate
 CDune::Capabilities::canCommunicate< ALUGrid< dim, dimworld, eltype, refinementtype, ALUGridNoComm >, codim >ALUGrid can communicate when Comm == ALUGridMPIComm
 CDune::Capabilities::canCommunicate< IdentityGrid< HostGrid >, codim >IdentityGrid can communicate when the host grid can communicate
 CDune::Capabilities::canCommunicate< SPGrid< ct, dim, Ref, MPI_Comm >, codim >Can a parallel grid communicate on a given codimension?
 CDune::Capabilities::canCommunicate< UGGrid< dim >, codim >UGGrid can communicate on entities of all (existing) codimensions
 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::TypeTree::CompositeNode< Children >::Child< k >Access to the type and storage type of the i-th child
 CDune::TypeTree::FilteredCompositeNode< Node, Filter >::Child< k >Access to the type and storage type of the i-th child
 CDune::TypeTree::PowerNode< T, k >::Child< i >Access to the type and storage type of the i-th child
 CDune::TypeTree::StaticChildAccessors< ProxiedNode >::Child< k >Access to the type and storage type of the i-th child
 CDune::CloneableAn interface class for cloneable objects
 CDune::Amg::CoarsenCriterion< T >The criterion describing the stop criteria for the coarsening process
 CDune::AlbertaLeafGridView< GridImp >::Codim< cd >Codim Structure
 CDune::AlbertaLevelGridView< GridImp >::Codim< cd >Codim Structure
 CDune::ALU3dLeafGridView< GridImp, pitype >::Codim< cd >Codim Structure
 CDune::ALU3dLevelGridView< GridImp, pitype >::Codim< cd >Codim Structure
 CDune::Codim< codim >Static tag representing a codimension
 CDune::DefaultLeafGridView< GridImp >::Codim< cd >Codim Structure
 CDune::DefaultLeafIteratorTypes< GridImp >::Codim< cd >The types of the iterator
 CDune::DefaultLevelGridView< GridImp >::Codim< cd >Codim Structure
 CDune::DefaultLevelIteratorTypes< GridImp >::Codim< cd >The types
 CDune::Entity< 0, dim, GridImp, EntityImp >::Codim< cd >Entity types of the different codimensions
 CDune::Geo::ReferenceElement< Implementation >::Codim< codim >Collection of types depending on the codimension
 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, 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::IdSet< GridImp, IdSetImp, IdTypeImp >::Codim< cc >Export the type of the entity used as parameter in the id(...) method
 CDune::IndexSet< GridImp, IndexSetImp, IndexTypeImp, TypesImp >::Codim< cc >Export the type of the entity used as parameter in the index(...) method
 CDune::MacroGridView< GridImp, pitype >::Codim< cd >Codim Structure
 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< 2 >
 CDune::Codim< cd >
 CDune::Codim< codimension >
 CDune::Codim< CodimInHostGrid >
 CDune::Codim< dim >
 CDune::Codim< dimension >
 CDune::Codim< std::remove_const< Grid >::type::dimension - mydim >
 CDune::CoefficientsInterfaceInterface for global-valued coefficients
 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::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< CheckIdCommunicationDataHandle< VT >, GridView< VT >::Grid::GlobalIdSet::IdType >
 CDune::CommDataHandleIF< CommDataHandle< Grid, WrappedHandle >, WrappedHandle::DataType >
 CDune::CommDataHandleIF< DataHandle, char >
 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::Communication< Communicator >Collective communication interface and sequential default implementation
 CDune::Communication< MPI_Comm >Specialization of Communication for MPI
 CDune::Communication< No_Comm >
 CDune::Communication< void * >
 CDune::Functions::ComposedGridFunction< OF, IF >Composition of grid functions with another function
 CDune::TypeTree::CompositeNode< Children >Base class for composite nodes based on variadic templates
 CDune::TypeTree::CompositeNode< T... >
 CDune::TypeTree::CompositeNodeTagTag designating a composite node
 CDune::Functions::CompositePreBasis< IMS, SPB >A pre-basis for composite bases
 CDune::CompressionStatistics< size_type >Statistics about compression achieved in implicit mode
 CDune::Std::conjunction< B >Forms the logical conjunction of the type traits B..
 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::ConstAssociativePropertyMap< T >An adaptor to turn an unique associative container into a property map
 CDune::MatrixImp::DenseMatrixBase< 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< Richardson< X, Y > >Policy for the construction of the Richardson smoother
 CDune::Amg::ConstructionTraits< SeqILU< M, X, Y > >Policy for the construction of the SeqILU 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::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 std::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::CrouzeixRaviartLocalFiniteElement< D, R, dim >Crouzeix-Raviart finite element
 CDune::ILU::CRS< B, Alloc >Simple compressed row storage matrix class
 CDune::ILU::CRS< block_type, typename M::allocator_type >
 CDune::VTK::DataArrayWriterBase class for data array writers
 CDune::VTK::DataArrayWriterFactoryFactory for DataArrayWriters
 CDune::DebugStreamStateIntermediate class to implement tie-operation of DebugStream
 CDune::DefaultBoundarySegmentIndexSet< Grid >DefaultBoundarySegmentIndexSet creates an index set for the macro boundary segments
 CDune::DefaultBoundarySegmentIndexSet< ThisType >
 CDune::Amg::DefaultConstructionArgs< T >Construction Arguments for the default smoothers
 CDune::Amg::DefaultConstructionArgs< SeqILU< M, X, Y > >
 CDune::Amg::DefaultConstructionArgs< SeqOverlappingSchwarz< M, X, TM, TS, TA > >
 CDune::Functions::DefaultDerivativeTraits< Signature >Default implementation for derivative traits
 CDune::Functions::DefaultDerivativeTraits< double(double) >Default implementation for derivative traits
 CDune::Functions::DefaultDerivativeTraits< FieldMatrix< K, 1, m >(FieldVector< K, n >)>Default implementation for derivative traits
 CDune::Functions::DefaultDerivativeTraits< FieldVector< K, m >(FieldVector< K, n >)>Default implementation for derivative traits
 CDune::Functions::DefaultDerivativeTraits< K(FieldVector< K, n >)>Default implementation for derivative traits
 CDune::FloatCmp::DefaultEpsilon< T, style >Mapping from a value type and a compare style to a default epsilon
 CDune::Functions::DefaultGlobalBasis< PB >Global basis for given pre-basis
 CDune::TypeTree::Experimental::DefaultHybridVisitorHybrid visitor interface and base class for TypeTree hybrid visitors
 CDune::DefaultLeafIteratorTypes< GridImp >LeafIterator tpyes for all codims and partition types
 CDune::DefaultLevelIteratorTypes< GridImp >LevelIterator tpyes for all codims and partition types
 CDune::Functions::DefaultLocalView< GB >The restriction of a finite element basis to a single element
 CDune::Functions::DefaultNodeToRangeMap< Tree >A simple node to range map using lexicographic ordering
 CDune::TypeTree::DefaultPairVisitorVisitor interface and base class for visitors of pairs of TypeTrees
 CDune::Amg::DefaultSmootherArgs< T >The default class for the smoother arguments
 CDune::DefaultSVGMatrixOptionsDefault options class to write SVG matrices
 CDune::TypeTree::DefaultVisitorVisitor interface and base class for TypeTree visitors
 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< RF, ROWS, COLS > >
 CDune::DenseMatrix< ScalarMatrixView< K > >
 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< D, SIZE > >
 CDune::DenseVector< FieldVector< double, SIZE > >
 CDune::DenseVector< FieldVector< F, SIZE > >
 CDune::DenseVector< FieldVector< Field, SIZE > >
 CDune::DenseVector< FieldVector< field_type, SIZE > >
 CDune::DenseVector< FieldVector< int, SIZE > >
 CDune::DenseVector< FieldVector< K, SIZE > >
 CDune::DenseVector< FieldVector< Real, SIZE > >
 CDune::DenseVector< FieldVector< RF, SIZE > >
 CDune::DenseVector< FieldVector< ScalarDeriv, SIZE > >
 CDune::DenseVector< FieldVector< ThisLFETensor, SIZE > >
 CDune::DenseVector< ScalarVectorView< K > >
 CDune::Amg::DependencyParametersParameters needed to check whether a node depends on another
 CDune::DGFBoundaryParameterContains types for additional features
 CDune::DGFGridFactory< Dune::YaspGrid< dim, Dune::TensorProductCoordinates< ctype, dim > > >Placeholder for grid factory for YaspGrid with tensor product coordinates
 CDune::DGFGridFactory< YaspGrid< dim, EquidistantCoordinates< ctype, dim > > >Grid factory for YaspGrid with equidistant coordinates
 CDune::DGFGridFactory< YaspGrid< dim, EquidistantOffsetCoordinates< ctype, dim > > >Grid factory for YaspGrid with equidistant coordinates
 CDune::DGFGridInfo< GridType >Some simple static information for a given GridType
 CDGFWriter< GV >Write a GridView to a DGF file
 CDune::DGFWriter< GV >Write a GridView to a DGF file
 CDune::DGLocalCoefficientsA class providing local coefficients for dg spaces
 CDune::DGLocalCoefficientsFactory< BasisFactory >A factory class for the dg local coefficients
 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::DiagonalMatrix< D, dim >
 CDune::Functions::DifferentiableFunctionFromCallables< Range(Domain), DerivativeTraits, F >Wrap a list of callable objects as derivative sequence modelling Concept::DifferentiableFunction<Range(Domain), DerivativeTraits>
 CDune::Functions::DifferentiableFunctionFromCallables< Range(Domain), DerivativeTraits, F, DF, Derivatives... >Wrap a list of callable objects as derivative sequence modelling Concept::DifferentiableFunction<Range(Domain), DerivativeTraits>
 CDune::Dim< dim >Static tag representing a dimension
 CDune::DimSpecificPQkLocalFiniteElementFactory< D, R, d, k >Factory that only creates dimension specific local finite elements
 CDune::DimSpecificPQkLocalFiniteElementFactory< D, R, 3, k >Factory that only creates dimension specific local finite elements
 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::Functions::DiscreteGlobalBasisFunction< B, V, NTRE, R >A grid function induced by a global basis and a coefficient vector
 CDune::Functions::DiscreteGlobalBasisFunctionDerivative< DGBF >Derivative of a DiscreteGlobalBasisFunction
 CDune::Std::disjunction< B >Forms the logical disjunction of the type traits B..
 CDune::DualP1LocalBasis< D, R, dim, faceDualT >Dual Lagrange shape functions on the simplex
 CDune::DualP1LocalBasis< D, R, dim, false >
 CDune::DualP1LocalFiniteElement< D, R, dim, faceDual >The local dual p1 finite element on simplices
 CDune::DualQ1LocalBasis< D, R, dim >Dual Lagrange shape functions of order 1 on the reference cube
 CDune::DualQ1LocalFiniteElement< D, R, dim, faceDual >The local dual Q1 finite element on cubes
 CDune::DualQ1LocalInterpolation< dim, LB >
 CDune::DualQ1LocalInterpolation< dim, Dune::DualQ1LocalBasis< D, R, dim > >
 CDune::Amg::AggregatesMap< V >::DummyEdgeVisitorA Dummy visitor that does nothing for each visited edge
 CDune::DuneBoundaryProjection< dimworld >Interface class for vertex projection at the boundary
 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::TypeTree::DynamicPowerNode< T >Collect multiple instances of type T within a dune-typetree
 CDune::TypeTree::DynamicPowerNodeTagTag designating a power node with runtime degree
 CDune::TypeTree::DynamicTraversalMixin base class for visitors that only need a dynamic TreePath during traversal
 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::EdgeS0_5Common< dim, DF >Common base class for edge elements
 CDune::EdgeS0_5Common< Geometry::mydimension, Geometry::ctype >
 CDune::EdgeS0_5Common< Traits_::dimDomainLocal, Traits_::DomainField >
 CDune::EdgeS0_5FiniteElement< Geometry, RF >FiniteElement for lowest order edge elements on simplices
 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::Simd::EndMarkFinal element marker for RebindList
 CDune::Entity< cd, dim, GridImp, EntityImp >Wrapper class for entities
 CDune::Entity< codim, dim, const Grid, SPEntity >
 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, ALU3dGridEntity >
 CDune::EntityDefaultImplementation< 0, dim, GridImp, IdentityGridEntity >
 CDune::EntityDefaultImplementation< 0, dim, GridImp, YaspEntity >
 CDune::EntityDefaultImplementation< cd, dim, GridImp, ALU3dGridEntity >
 CDune::EntityDefaultImplementation< codim, dim, Grid, AlbertaGridEntity >
 CDune::EntityDefaultImplementation< codim, dim, GridImp, IdentityGridEntity >
 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::EntityIterator< codim, Grid, IteratorImp >Interface class for an iterator over grid entities
 CDune::EntityIterator< 0, Grid, SuperEntityIteratorImp< Grid > >
 CDune::EntitySeed< GridImp, EntitySeedImp >Store a reference to an entity with a minimal memory footprint
 CDune::Functions::Concept::EntitySetConcept for an entity set for a Concept::GridFunction<Range(Domain), EntitySet, DerivativeTraits>
 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::MonomImp::EvalAccess< Traits >Access output vector of evaluateFunction() and evaluate()
 CDune::MonomImp::Evaluate< Traits, c >
 CDune::MonomImp::Evaluate< Traits, 1 >
 CDune::TypeTree::evaluate_if_meta_function< F >Meta function that evaluates its argument iff it inherits from meta_function
 Cstd::exceptionSTL class
 CDune::ExceptionHookBase class to add a hook to the Dune::Exception
 CDune::Functions::FaceNormalGridFunction< GV >Grid function implementing the piecewise element face normal
 CDune::FaceTopologyMapping< type >
 CDune::Factorial< m >
 CDune::Factorial< 0 >End of recursion of factorial via specialization
 CDune::FakeMPIHelperA fake mpi helper
 CDune::VTK::FieldInfoDescriptor struct for VTK fields
 CDune::TypeTree::filter< Filter >Adapter class that takes a SimpleFilter, validated it and turns it into an AdvancedFilter
 CDune::TypeTree::FilteredCompositeNode< Node, Filter >Base class for composite nodes representing a filtered view on an underlying composite node
 CDune::TypeTree::FilterEntry< new_k, old_k >A filter entry describing the mapping of one child in the filtered node
 CDune::TypeTree::FilterResult< FilterEntries >The result of a filter
 CDune::FiniteElementFactoryInterface< Geometry, VertexOrder >Factory interface for global-valued finite elements
 CDune::FiniteElementInterfaceInterface for global-valued finite elements
 CDune::FiniteElementInterfaceSwitch< FiniteElement, Dummy >Switch for uniform treatment of finite element with either the local or the global interface
 CDune::FirstPredicateIndex< Tuple, Predicate, start, size >Finding the index of a certain type in a std::tuple
 CDune::FirstPredicateIndex< Tuple, IsType< T >::template Predicate, 0 >
 CDune::FlattenTuple< Tuple >Flatten a std::tuple of std::tuple's
 CDune::FloatCmpOps< T, cstyle_, rstyle_ >Class encapsulating a default epsilon
 CDune::FMatrixPrecision< ctype >Precisions for calculations with FieldMatrix and FieldVector
 CDune::ForEachType< TE, T >Helper template to clone the type definition of a std::tuple with the storage types replaced by a user-defined rule
 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< std::remove_const< std::iterator_traits< CellIterator >::value_type >::type >, const Corner< std::remove_const< std::iterator_traits< CellIterator >::value_type >::type > &, std::iterator_traits< CellIterator >::difference_type >
 CDune::ForwardIteratorFacade< PointIterator< CellIterator, IS >, const Corner< std::remove_const< std::iterator_traits< CellIterator >::value_type >::type >, const Corner< std::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 Domain &, Range & >
 CDune::Function< const DomainType &, RangeType & >
 CDune::Functions::FunctionFromCallable< Range(Domain), F, FunctionInterface >Wrap a callable object as Dune::Function or Dune::VirtualFunction
 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::Future< T >Type-erasure for future-like objects. A future-like object is a object satisfying the interface of FutureBase
 CDune::Future< void >
 CALUGrid::GatherScatterBaseImpl< GridType, DataCollectorType, codim >Corresponding interface class is defined in bsinclude.hh
 CALUGrid::GatherScatterBaseImpl< GridType, DataCollectorType, 0 >Corresponding interface class is defined in alu3dinclude.hh
 CDune::GeneralVertexOrder< dim, Index_ >Class providing information on the ordering of vertices
 CDune::Functions::BasisFactory::Experimental::GenericIndexingTransformation< IndexTransformation, SizeImplementation, minIS, maxIS >A generic implementation of a transformation
 CDune::GenericLocalFiniteElement< BasisF, CoeffF, InterpolF >A LocalFiniteElement implementation based on three TopologyFactories providing the LocalBasis, LocalCoefficients, and LocalInterpolations. Note the key type for all three factories must coincide
 CDune::GenericLocalFiniteElement< FE::BasisFactory, DGLocalCoefficientsFactory< FE::BasisFactory >, FE::InterpolationFactory >
 CDune::GenericLocalFiniteElement< FE::BasisFactory, DGLocalCoefficientsFactory< FE::BasisFactory >, LocalL2InterpolationFactory< FE::BasisFactory, false > >
 CDune::GenericLocalFiniteElement< LagrangeBasisFactory< LP, dimDomain, R, R >, LagrangeCoefficientsFactory< LP, dimDomain, R >, LagrangeInterpolationFactory< LP, dimDomain, R > >
 CDune::GenericLocalFiniteElement< OrthonormalBasisFactory< dimDomain, R, R >, DGLocalCoefficientsFactory< OrthonormalBasisFactory< dimDomain, R, R > >, LocalL2InterpolationFactory< OrthonormalBasisFactory< dimDomain, R, R >, true > >
 CDune::GenericLocalFiniteElement< RaviartThomasBasisFactory< dimDomain, R, R >, RaviartThomasCoefficientsFactory< dimDomain >, RaviartThomasL2InterpolationFactory< dimDomain, R > >
 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, 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
 CGlobalBasisMoc< dim >A Dummy global basis
 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::GMPField< precision >Number class for high precision floating point number using the GMP library mpf_class implementation
 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::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, alu3d_ctype, ALU3dGridFamily< dim, dimworld, 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, ct, SPGridFamily< ct, dim, Ref, Comm > >
 CDune::Grid< dim, dimworld, double, UGGridFamily< dim > >
 CDune::Grid< dim, dimworld, HostGrid::ctype, IdentityGridFamily< HostGrid::dimension, HostGrid > >
 CDune::Grid< dim, dimworld, OneDGridGeometry< 0, 1, OneDGrid >::ctype, OneDGridFamily >
 CDune::GridFactoryInterface< GridType >Provide a generic factory class for unstructured grids
 CDune::GridFactoryInterface< AlbertaGrid< dim, dimworld > >
 CDune::GridFactoryInterface< ALUGrid >
 CDune::GridFactoryInterface< ALUGrid< dim, dimw, eltype, refinementtype, Comm > >
 CDune::GridFactoryInterface< Dune::UGGrid< dim > >
 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, 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::Functions::GridViewEntitySet< GV, cd >An entity set for all entities of given codim in a grid view
 CDune::Functions::GridViewEntitySet< GridView, 0 >
 CDune::Functions::GridViewFunction< Range(Domain), GV, DerivativeTraits, bufferSize >Wrapper class for functions defined on a GridView
 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::hasBackupRestoreFacilities< ALUGrid< dim, dimworld, eltype, refinementtype, Comm > >ALUGrid has backup and restore facilities
 CDune::Capabilities::hasBackupRestoreFacilities< SPGrid< ct, dim, Ref, Comm > >Does a grid provide 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< ALUGrid< dim, dimworld, eltype, refinementtype, Comm >, cdim >ALUGrid has entities for all codimension
 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< SPGrid< ct, dim, Ref, Comm >, codim >Does a grid implement entities of a codimension?
 CDune::Capabilities::hasEntity< UGGrid< dim >, codim >UGGrid has entities of all codimensions
 CDune::Capabilities::hasEntity< YaspGrid< dim, Coordinates >, codim >YaspGrid has entities for all codimensions
 CDune::Capabilities::hasEntityIterator< Grid, codim >Specialize with 'true' for all codims that a grid provides an iterator for (default=hasEntity<codim>::v)
 CDune::Capabilities::hasEntityIterator< AlbertaGrid< dim, dimworld >, codim >AlbertaGrid can iterate over all codimensions
 CDune::Capabilities::hasEntityIterator< OneDGrid, codim >OneDGrid can iterate over all codimensions
 CDune::Capabilities::hasEntityIterator< UGGrid< dim >, 0 >UGGrid can iterate over codim=0 entities (elements)
 CDune::Capabilities::hasEntityIterator< UGGrid< dim >, codim >Set default for hasEntityIterator to false UGGrid can currently only iterate over elements and vertices
 CDune::Capabilities::hasEntityIterator< UGGrid< dim >, dim >UGGrid can iterate over codim=dim entities (vertices)
 CDune::Capabilities::hasEntityIterator< YaspGrid< dim, Coordinates >, codim >YaspGrid can iterate over all codimensions
 CDune::Capabilities::hasGeometry< Grid, codim >Specialize with 'false' for all codims that a grid does not implement geometries for. (default=true)
 CDune::hash< T >Functor for hashing objects of type T
 CDune::HasHierarchicIndexSetTagging interface to indicate that Grid has HierarchicIndexSet
 CDune::HasNaN< T >Whether this type has a value of NaN
 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< ALUGrid< dim, dimworld, eltype, refinementtype, Comm > >ALUGrid 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< SPGrid< ct, dim, Ref, Comm > >Do elements of a grid always have the same geometry type?
 CDune::Capabilities::hasSingleGeometryType< YaspGrid< dim, Coordinates > >YaspGrid has only one geometry type for codim 0 entities
 CDune::Functions::HierarchicalLagrangePreBasis< GV, k, R >A pre-basis for a hierarchical basis
 CDune::HierarchicalP2LocalFiniteElement< D, R, dim >
 CDune::HierarchicalP2WithElementBubbleLocalFiniteElement< D, R, dim >
 CDune::HierarchicalPrismP2LocalFiniteElement< D, R >
 CDune::HierarchicalPrismP2LocalInterpolation< LB >
 CDune::HierarchicalPrismP2LocalInterpolation< HierarchicalPrismP2LocalBasis< D, R > >
 CDune::HierarchicalSimplexP2LocalBasis< D, R, 1 >Hierarchical P2 basis in 1d
 CDune::HierarchicalSimplexP2LocalBasis< D, R, 2 >Hierarchical P2 basis in 2d
 CDune::HierarchicalSimplexP2LocalBasis< D, R, 3 >Hierarchical P2 basis in 3d
 CDune::HierarchicalSimplexP2LocalInterpolation< LB >
 CDune::HierarchicalSimplexP2LocalInterpolation< HierarchicalSimplexP2LocalBasis< D, R, dim > >
 CDune::HierarchicalSimplexP2WithElementBubbleLocalBasis< D, R, 1 >Hierarchical P2 basis in 1d
 CDune::HierarchicalSimplexP2WithElementBubbleLocalBasis< D, R, 2 >Hierarchical P2 basis in 1d
 CDune::HierarchicalSimplexP2WithElementBubbleLocalBasis< D, R, 3 >Hierarchical P2 basis in 1d
 CDune::HierarchicalSimplexP2WithElementBubbleLocalCoefficients< dim >The local finite element needed for the Zou-Kornhuber estimator for Signorini problems
 CDune::Functions::HierarchicNodeToRangeMapA simple node to range map using the nested tree indices
 CDune::HierarchicSearch< Grid, IS >Search an IndexSet for an Entity containing a given point
 CDune::Functions::HierarchicVectorWrapper< V, CO >A wrapper providing multiindex access to vector entries
 CDune::Amg::Hierarchy< T, A >A hierarchy of containers (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
 CHybridSizeInfoDummy< dim >A Dummy size provider
 CDune::TypeTree::HybridTreePath< T >A hybrid version of TreePath that supports both compile time and run time indices
 CDune::TypeTree::HybridTreePath<>
 CDune::Std::identityA function object type whose operator() returns its argument unchanged
 CDune::IdentityGridEntitySeed< codim, GridImp >The EntitySeed class provides the minimal information needed to restore an Entity using the grid
 CDune::IdentityGridHierarchicIterator< GridImp >Iterator over the descendants of an entity.Mesh entities of codimension 0 ("elements") allow to visit all entities of codimension 0 obtained through nested, hierarchic refinement of the entity. Iteration over this set of entities is provided by the HierarchicIterator, starting from a given entity
 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::IdentityGridLeafIterator< codim, pitype, GridImp >Iterator over all entities of a given codimension and level of a grid
 CDune::IdentityGridLevelIntersection< GridImp >
 CDune::IdentityGridLevelIntersectionIterator< GridImp >
 CDune::IdentityGridLevelIterator< codim, pitype, GridImp >Iterator over all entities of a given codimension and level of a grid
 CDune::IdentityMapA property map that applies the identity function to integers
 CDune::IdSet< GridImp, IdSetImp, IdTypeImp >Id Set Interface
 CDune::IdSet< AlbertaGrid< dim, dimworld >, AlbertaGridIdSet< dim, dimworld >, unsigned int >
 CDune::IdSet< const Dune::IdentityGrid< HostGrid >, IdentityGridGlobalIdSet< const Dune::IdentityGrid< HostGrid > >, std::remove_const< const Dune::IdentityGrid< HostGrid > >::type::HostGridType::Traits::GlobalIdSet::IdType >
 CDune::IdSet< const Dune::IdentityGrid< HostGrid >, IdentityGridLocalIdSet< const Dune::IdentityGrid< HostGrid > >, std::remove_const< const Dune::IdentityGrid< HostGrid > >::type::HostGridType::Traits::LocalIdSet::IdType >
 CDune::IdSet< const Dune::YaspGrid< dim, CoordCont >, YaspGlobalIdSet< const Dune::YaspGrid< dim, CoordCont > >, std::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 > > >, std::remove_const< const Dune::YaspGrid< dim, EquidistantCoordinates< double, dim > > >::type::PersistentIndexType >
 CDune::IdSet< Grid, IdSet< Grid, HostIdSet >, HostIdSet::IdType >
 CDune::IdSet< Grid, SPLocalIdSet< Grid >, unsigned long >
 CDune::IdSet< GridImp, IdentityGridGlobalIdSet< GridImp >, std::remove_const< GridImp >::type::HostGridType::Traits::GlobalIdSet::IdType >
 CDune::IdSet< GridImp, IdentityGridLocalIdSet< GridImp >, std::remove_const< GridImp >::type::HostGridType::Traits::LocalIdSet::IdType >
 CDune::IdSet< GridImp, YaspGlobalIdSet< GridImp >, std::remove_const< GridImp >::type::PersistentIndexType >
 CDune::ILUSubdomainSolver< M, X, Y >Base class encapsulating common algorithms of ILU0SubdomainSolver and ILUNSubdomainSolver
 CDune::SolverHelper< ISTLLinearSolver, BCRSMatrix >::Implementation< is_direct_solver, Dummy >Implementation that works together with iterative ISTL solvers, e.g. Dune::CGSolver or Dune::BiCGSTABSolver
 CDune::SolverHelper< ISTLLinearSolver, BCRSMatrix >::Implementation< true, Dummy >Implementation that works together with direct ISTL solvers, e.g. Dune::SuperLU or Dune::UMFPack
 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::Functions::BasisFactory::IndexMergingStrategyBase class for index merging strategies to simplify detection
 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< ALU3dGrid< dim, dimworld, elType, Comm >, ALU3dGridHierarchicIndexSet< dim, dimworld, elType, Comm > >
 CDune::IndexSet< const Dune::IdentityGrid< HostGrid >, IdentityGridLeafIndexSet< const Dune::IdentityGrid< HostGrid > >, std::remove_const< const Dune::IdentityGrid< HostGrid > >::type::HostGridType::LeafGridView::IndexSet::IndexType, std::remove_const< const Dune::IdentityGrid< HostGrid > >::type::HostGridType::LeafGridView::IndexSet::Types >
 CDune::IndexSet< const Dune::IdentityGrid< HostGrid >, IdentityGridLevelIndexSet< const Dune::IdentityGrid< HostGrid > >, std::remove_const< const Dune::IdentityGrid< HostGrid > >::type::HostGridType::LevelGridView::IndexSet::IndexType, std::remove_const< const Dune::IdentityGrid< HostGrid > >::type::HostGridType::LevelGridView::IndexSet::Types >
 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< const This, SPHierarchyIndexSet< const This >, unsigned int, std::array< GeometryType, 1 > >
 CDune::IndexSet< Grid, IndexSet< Grid, HostIndexSet >, HostIndexSet::IndexType, HostIndexSet::Types >
 CDune::IndexSet< Grid, SPHierarchyIndexSet< Grid >, unsigned int, std::array< GeometryType, 1 > >
 CDune::IndexSet< Grid, SPIndexSet< Grid >, unsigned int, std::array< GeometryType, 1 > >
 CDune::IndexSet< GridImp, DefaultIndexSet< GridImp, IteratorImp >, unsigned int, std::vector< GeometryType > >
 CDune::IndexSet< GridImp, IdentityGridLeafIndexSet< GridImp >, std::remove_const< GridImp >::type::HostGridType::LeafGridView::IndexSet::IndexType, std::remove_const< GridImp >::type::HostGridType::LeafGridView::IndexSet::Types >
 CDune::IndexSet< GridImp, IdentityGridLevelIndexSet< GridImp >, std::remove_const< GridImp >::type::HostGridType::LevelGridView::IndexSet::IndexType, std::remove_const< GridImp >::type::HostGridType::LevelGridView::IndexSet::Types >
 CDune::IndexSet< GridImp, IndexSetImp >
 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::IntegerSequenceEntry< IntegerSequence, index >Get entry of std::integer_sequence
 CDune::IntegralRange< T >Dynamic integer range for use in range-based for loops
 CDune::InterfaceBuilderBase class of all classes representing a communication interface
 CDune::InterfaceInformationInformation describing an interface
 CDune::InterpolationInterfaceInterface for global-valued interpolation
 CDune::Intersection< GridImp, IntersectionImp >Intersection of a mesh entity of codimension 0 ("element") with a "neighboring" element or with the domain boundary
 CDune::YGridList< Coordinates >::IntersectionType describing an intersection with a neighboring processor
 CDune::Intersection< const Grid, SPIntersection< const Grid > >
 CDune::Intersection< Grid, IntersectionImpl >
 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::Functions::InvalidRangeDummy range class to be used if no proper type is available
 CDune::InverseOperator< X, Y >Abstract base class for all solvers
 CDune::InverseOperator< BlockVector< FieldVector< T, m >, std::allocator_traits< A >::template rebind_alloc< FieldVector< T, m > > >, BlockVector< FieldVector< T, n >, std::allocator_traits< A >::template rebind_alloc< FieldVector< T, n > > > >
 CDune::InverseOperator< Domain, Range >
 CDune::InverseOperator< Impl::SuperLUVectorChooser< M >::domain_type, Impl::SuperLUVectorChooser< M >::range_type >
 CDune::InverseOperator< Impl::UMFPackVectorChooser< M >::domain_type, Impl::UMFPackVectorChooser< M >::range_type >
 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::Functions::IsCallable< F >Helper class to check that F is callable
 CDune::IsCallable< D, R >Check if a type is callable with ()-operator and given arguments
 CDune::IsCallable< F(Args...), R >Check if a type is callable with ()-operator and given arguments
 CDune::Capabilities::isCartesian< Grid >Specialize with 'true' if the grid is a Cartesian grid. Cartesian grids satisfy the following properties:
 CDune::Capabilities::isCartesian< SPGrid< ct, dim, Ref, Comm > >Is the grid Cartesian?
 CDune::Capabilities::isCartesian< YaspGrid< dim, Coordinates > >YaspGrid is a Cartesian grid
 CDune::IsDofManagerTagging interface to indicate that class is of Type DofManager
 CDune::IsEmptyTypeList< T >Check if given type is an empty TypeList
 CDune::IsFieldVectorSizeCorrect< C, SIZE >TMP to check the size of a DenseVectors statically, if possible
 CDune::IsIndexable< T, I >Type trait to determine whether an instance of T has an operator[](I), i.e. whether it can be indexed with an index of type I
 CDune::IsIntegralConstant< T >Check if T is an std::integral_constant<I, i>
 CDune::IsInteroperable< T1, T2 >Checks whether two types are interoperable
 CDune::IsIterable< T, typename >Typetrait to check that a class has begin() and end() members
 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< ALUGrid< dim, dimworld, eltype, refinementtype, Comm > >ALUGrid has potentially nonconforming leaf grids (unless refinementtype is 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< SPGrid< ct, dim, Ref, Comm > >Is the leaf level of a grid always conform?
 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< ALUGrid< dim, dimworld, eltype, refinementtype, Comm > >ALUGrid has potentially nonconforming level grids
 CDune::Capabilities::isLevelwiseConforming< IdentityGrid< HostGrid > >Has conforming level grids when host grid has
 CDune::Capabilities::isLevelwiseConforming< OneDGrid >OneDGrid is levelwise conforming
 CDune::Capabilities::isLevelwiseConforming< SPGrid< ct, dim, Ref, Comm > >Are all levels of a grid always conform?
 CDune::Capabilities::isLevelwiseConforming< UGGrid< dim > >UGGrid is levelwise conforming
 CDune::Capabilities::isLevelwiseConforming< YaspGrid< dim, Coordinates > >YaspGrid is levelwise conforming
 CDune::Simd::VcImpl::IsMask< V, SFINAE >Specialized to true for Vc mask types
 CDune::IsMatrix< T >Test whether a type is an ISTL Matrix
 CDune::IsNumber< T >Whether this type acts as a scalar in the context of (hierarchically blocked) containers
 CDune::IsNumber< bigunsignedint< k > >Declare big unsigned int is a number
 CDune::TypeTree::IsTreePath< T >Check if type represents a tree path
 CDune::IsTuple< T >Check if T is a std::tuple<...>
 CDune::IsTupleOrDerived< T >Check if T derived from a std::tuple<...>
 CDune::IsType< T >Generator for predicates accepting one particular type
 CDune::IsTypeList< T >Check if given type is a TypeList
 CDune::IsTypeList< TypeList< T... > >Check if given type is a TypeList.
 CDune::IterativeSolver< X, Y >::Iteration< CountType >Class for controlling iterative methods
 CDune::CollectiveIterator< T, A >::iteratorIterator over the valid underlying iterators
 CDune::MatrixImp::DenseMatrixBase< 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::IteratorTransformationTagTag to enable iterator based transformations in TransformedRangeView
 CDune::MonomImp::JacobianAccess< Traits >Access output vector of evaluateJacobian()
 CDune::JoinTuples< Head, Tail >Join two std::tuple's
 CDune::LagrangeCubeLocalFiniteElement< D, R, dim, k >Lagrange finite element for cubes with arbitrary compile-time dimension and polynomial order
 CDune::LagrangeCubeLocalFiniteElement< Geometry::ctype, RF, Geometry::mydimension, 1 >
 CDune::Functions::LagrangePreBasis< GV, k, R >A pre-basis for a PQ-lagrange bases with given order
 CDune::Functions::LagrangePreBasis< GV, 1 >
 CDune::Functions::LagrangePreBasis< GV, 2 >
 CDune::LagrangePrismLocalFiniteElement< D, R, k >Lagrange finite element for 3d prisms with arbitrary compile-time polynomial order
 CDune::LagrangePyramidLocalFiniteElement< D, R, k >Lagrange finite element for 3d pyramids with compile-time polynomial order
 CDune::LagrangeSimplexLocalFiniteElement< D, R, d, k >Lagrange finite element for simplices with arbitrary compile-time dimension and polynomial order
 CDune::Simd::Overloads::LaneCount< class, class >Should be derived from a Dune::index_constant
 CDune::Simd::Overloads::LaneCount< V, std::enable_if_t< VcImpl::IsVector< V >::value > >Should be derived from an Dune::index_constant
 CDune::Functions::LastType< T >Get last entry of type list
 CDune::TypeTree::lazy_evaluate< F >Helper meta function to delay evaluation of F
 CDune::TypeTree::lazy_identity< F >Identity function
 CDune::LDL< Matrix >Use the LDL package to directly solve linear systems – empty default class
 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::TypeTree::LeafNodeBase class for leaf nodes in a dune-typetree
 CDune::TypeTree::LeafNodeTagTag designating a leaf node
 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, 1 >
 CDune::LinearMapping< cdim, 2 >
 CDune::LinearMapping< cdim, cdim >
 CDune::LinearMapping< cdim, dim >
 CDune::LinearOperator< X, Y >A linear operator
 CDune::LinearOperator< OP1::domain_type, OP1::range_type >
 CDune::LinearOperator< X, X >
 CDune::LocalBasisTraits< DF, n, D, RF, m, R, J >Type traits for LocalBasisVirtualInterface
 CDune::LocalBasisVirtualInterface< T >Virtual base class for a local basis
 CDune::LocalBasisVirtualInterface< LocalBasisTraits >
 CDune::LocalCoefficientsVirtualInterfaceVirtual base class for local coefficients
 CDune::Functions::LocalDerivativeTraits< EntitySet, DerivativeTraits >Derivative traits for local functions
 CDune::LocalFiniteElementFunctionBase< FE >Return a proper base class for functions to use with LocalInterpolation
 CDune::LocalFiniteElementTraits< LB, LC, LI >Traits helper struct
 CDune::LocalFiniteElementVariant< Implementations >Type erasure class for wrapping LocalFiniteElement classes
 CDune::LocalFiniteElementVariant< LagrangeSimplexLocalFiniteElement< D, R, 2, 2 >, LagrangeCubeLocalFiniteElement< D, R, 2, 2 > >
 CDune::LocalFiniteElementVariantCache< Base >A cache storing a compile time selection of local finite element implementations
 CDune::LocalFiniteElementVirtualInterface< T >Virtual base class for local finite elements with functions
 CDune::LocalFiniteElementVirtualInterface< Imp::Traits::LocalBasisType::Traits >
 CDune::Functions::DiscreteGlobalBasisFunctionDerivative< DGBF >::LocalFunctionLocal function evaluating the derivative in reference coordinates
 CDune::LocalGeometryTypeIndexCompute per-dimension indices for geometry types
 CDune::LocalIndexAn index present on the local process
 CDune::LocalInterpolationVirtualInterfaceBase< DomainType, RangeType >Virtual base class for a local interpolation
 CDune::LocalInterpolationVirtualInterfaceBase< typename LocalBasisTraits::DomainType, typename LocalBasisTraits::RangeType >
 CDune::LocalKeyDescribe position of one degree of freedom
 CDune::LocalL2Interpolation< B, Q, onb >A local L2 interpolation taking a test basis and a quadrature rule
 CDune::LocalL2InterpolationFactory< BasisFactory, onb >A factory class for the local l2 interpolations taking a basis factory
 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< GV::Grid, MultipleCodimMultipleGeomTypeMapper< G::LeafGridView >, GV::IndexSet::IndexType >
 CDune::Mapper< GV::Grid, MultipleCodimMultipleGeomTypeMapper< G::LevelGridView >, GV::IndexSet::IndexType >
 CDune::Mapper< GV::Grid, MultipleCodimMultipleGeomTypeMapper< GridView >, GV::IndexSet::IndexType >
 CDune::Mapper< GV::Grid, MultipleCodimMultipleGeomTypeMapper< GV >, 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::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
 CMatrixInfo< BCRSMatrix >Class template which yields information related to a square matrix like its spectral (i.e. 2-norm) condition number
 CDune::MatrixMarketImpl::MatrixValuesSetter< D, brows, bcols >Functor to the data values of the matrix
 CDune::TypeTree::max< result_type >Statically combine two values of type result_type by returning their maximum
 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::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::TypeTree::meta_functionMarker tag declaring a meta function
 CDune::MetaType< T >A type that refers to another type
 CDune::MimeticLocalFiniteElement< D, R, dim >
 CDune::TypeTree::min< result_type >Statically combine two values of type result_type by returning their minimum
 CDune::TypeTree::minus< result_type >Statically combine two values of type result_type using -
 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
 CDune::MonomialLocalBasis< D, R, d, p >Constant shape function
 CDune::MonomialLocalFiniteElement< D, R, d, p >Monomial basis for discontinuous Galerkin methods
 CMPIErrorMPI Error. Thrown when an mpi error occurs
 CDune::MPIFuture< R, S >Provides a future-like object for MPI communication. It contains the object that will be received and might contain also a sending object, which must be hold (keep alive) until the communication has been completed
 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< ctype, 0, 0 >
 CDune::MultiLinearGeometry< ctype, 1, 1 >
 CDune::MultiLinearGeometry< ctype, 2, 2 >
 CDune::MultiLinearGeometry< ctype, 3, 3 >
 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::TypeTree::multiply< result_type >Statically combine two values of type result_type using *
 CDune::MultiTypeBlockMatrix< FirstRow, Args >A Matrix class to support different block types
 CDune::MultiTypeBlockMatrix_Solver< I, crow, remain_row >Solver for MultiTypeBlockVector & MultiTypeBlockMatrix types
 CDune::MultiTypeBlockMatrix_Solver_Col< I, crow, ccol, remain_col >Part of solvers for MultiTypeBlockVector & MultiTypeBlockMatrix types
 CDune::MultiTypeBlockVector< Args >A Vector class to support different block types
 CDune::mutable_reference< R >Get the 'mutable' version of a reference to a const object
 CDune::Nedelec1stKindCubeLocalFiniteElement< D, R, dim, k >Nédélec elements of the first kind for cube elements
 CDune::Nedelec1stKindSimplexLocalFiniteElement< D, R, dim, k >Nédélec elements of the first kind for simplex elements
 CDune::NedelecL2Interpolation< dimension, F >An L2-based interpolation for Nedelec
 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::Std::negation< B >Forms the logical negation of the type traits B..
 CDune::TypeTree::NodeInterfaceInterface for nodes in a dune-typetree
 CDune::NonConformingFaceMapping< dim, dimworld, type, Comm >
 CDune::NonConformingFaceMapping< dim, dimworld, hexa, Comm >Non-conforming face mappings for hexahedra
 CDune::NonConformingFaceMapping< dim, dimworld, tetra, Comm >Non-conforming face mappings for tetrahedra
 CDune::Std::nonesuchType representing a lookup failure by std::detected_or and friends
 CDune::null_deleter< T >Implements the Deleter concept of shared_ptr without deleting anything
 CDune::NullPointerInitialiser< T >A helper template that initializes a std::tuple consisting of pointers to nullptr
 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::TypeTree::or_< result_type >Statically combine two values of type result_type using ||
 CDune::Functions::OverflowArray< BA, maxSize >A dynamically sized array-like class with overflow
 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::P0LocalBasis< D, R, d >Constant shape function
 CDune::P0LocalFiniteElement< D, R, d >The local p0 finite element on all types of reference elements
 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::ParameterizedObjectFactory< Signature, KeyT >A factory class for parameterized objects
 CDune::ParameterTreeHierarchical structure of string parameters
 CDune::ParameterTreeParserParsers to set up a ParameterTree from various input sources
 CDune::AlbertaLeafGridViewTraits< GridImp >::Codim< cd >::Partition< pit >Define types needed to iterate over entities of a given partition type
 CDune::AlbertaLevelGridViewTraits< GridImp >::Codim< cd >::Partition< pit >Define types needed to iterate over entities of a given partition type
 CDune::ALU3dGrid< dim, dimworld, elType, Comm >::Partition< pitype >Types for GridView
 CDune::ALU3dLeafGridViewTraits< GridImp, pitype >::Codim< cd >::Partition< pit >Define types needed to iterate over entities of a given partition type
 CDune::ALU3dLevelGridViewTraits< GridImp, pitype >::Codim< cd >::Partition< pit >Define types needed to iterate over entities of a given partition type
 CDune::DefaultLeafGridViewTraits< GridImp >::Codim< cd >::Partition< pit >Define types needed to iterate over entities of a given partition type
 CDune::DefaultLevelGridViewTraits< GridImp >::Codim< cd >::Partition< pit >Define types needed to iterate over entities of a given partition type
 CDune::Grid< dim, dimworld, ct, GridFamily >::Codim< cd >::Partition< pitype >A struct collecting all types depending on the partition iterator type
 CDune::GridTraits< dim, dimw, GridImp, GeometryImp, EntityImp, 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::GridView< ViewTraits >::Codim< cd >::Partition< pit >Define types needed to iterate over entities of a given partition type
 CDune::MacroGridViewTraits< GridImp, pitype >::Codim< cd >::Partition< pit >Define types needed to iterate over entities of a given partition type
 CDune::Yasp::Partitioning< d >Base class for the yaspgrid partitioning strategy
 CDune::PartitionSet< partitions >A set of PartitionType values
 CDune::MatrixMarketImpl::PatternDummyUtility class for marking the pattern type of the MatrixMarket matrices
 CDune::Functions::BasisFactory::Experimental::PeriodicIndexSetContainer storing identified indices for a periodic basis
 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< ALU3dGrid< dim, dimworld, elType, Comm >, G::HierarchicIndexSet, std::vector< T > >
 CDune::PersistentContainerVector< ALUGrid< dim, dimworld, eltype, refinementtype, Comm >, G::HierarchicIndexSet, std::vector< T > >
 CDune::PersistentContainerVector< G, G::HierarchicIndexSet, std::vector< T > >
 CDune::PersistentContainerVector< SPGrid< ct, dim, Ref, Comm >, SPGrid< ct, dim, Ref, Comm >::HierarchicIndexSet, std::vector< T > >
 CDune::PersistentContainerVector< YaspGrid< dim, CoordCont >, YaspPersistentContainerIndex< const YaspGrid< dim, CoordCont > >, std::vector< T > >
 CDune::TypeTree::plus< result_type >Statically combine two values of type result_type using +
 CDune::PointerPairDeletor< Tuple >Deletes all objects pointed to in a std::tuple of pointers
 CDune::Functions::PolymorphicSmallObject< Base, bufferSize >A wrapper providing small object optimization with polymorphic types
 CDune::Functions::PolymorphicType< Interface >Base class with polymorphic type boiler plate code
 CDune::Functions::PolymorphicType< TypeErasureWrapperInterface< Dune::Interface > >
 CDune::Functions::PolymorphicType< TypeErasureWrapperInterface< Interface > >
 CDune::Functions::Polynomial< K >A scalar polynomial implementation
 CDune::PolynomialBasis< Eval, CM, D, R >
 CDune::PolynomialBasis< Eval, SparseCoeffMatrix< typename Eval::Field, Eval::dimRange >, double, double >
 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 base and a compile-time integer exponent
 CDune::PowerBasis< Backend, dimR >Meta-basis turning a scalar basis into vector-valued basis
 CDune::PowerBasis< typename Backend::Traits::Basis, dimR >
 CDune::PowerFiniteElement< Backend, dimR >Meta-finite element turning a scalar finite element into vector-valued one
 CDune::PowerFiniteElementFactory< BackendFiniteElement, dimR >Factory for meta-finite elements turning scalar finite elements into vector-valued ones
 CDune::PowerInterpolation< Backend, BasisTraits >Meta-interpolation turning a scalar interpolation into vector-valued interpolation
 CDune::PowerInterpolation< typename Backend::Traits::Interpolation, typename Basis::Traits >
 CDune::PowerIteration_Algorithms< BCRSMatrix, BlockVector >Iterative eigenvalue algorithms based on power iteration
 CDune::TypeTree::PowerNode< T, k >Collect k instances of type T within a dune-typetree
 CDune::TypeTree::PowerNode< LagrangeNode< GV, 2 >, n >
 CDune::TypeTree::PowerNode< T, n >
 CDune::TypeTree::PowerNodeTagTag designating a power node
 CDune::Functions::PowerPreBasis< IMS, SPB, C >A pre-basis for power bases
 CDune::PQkLocalFiniteElementCache< D, R, dim, k >A cache that stores all available Pk/Qk like local finite elements for the given dimension and order
 CDune::PQkLocalFiniteElementFactory< D, R, dim, k >Factory to create any kind of Pk/Qk like element wrapped for the virtual interface
 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::PriorityTag< priority >Helper class for tagging priorities
 CDune::PriorityTag< 0 >Helper class for tagging priorities
 CDune::PriorityTag< 42 >
 CDune::Torus< Communication, d >::ProcListIterator
 CDune::PromotionTraits< T1, T2 >Compute type of the result of an arithmetic operation involving two different number types
 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::Simd::VcImpl::Proxy< V >A reference-like proxy for elements of random-access vectors
 CDune::TypeTree::ProxyNodeBase< Node, NodeTag >Tag-based dispatch to appropriate base class that provides necessary functionality
 CDune::TypeTree::ProxyNodeBase< Node, LeafNodeTag >ProxyNode base class for LeafNode
 CDune::TypeTree::ProxyNodeBase< Node, NodeTag< Node > >
 CDune::PseudoFuture< T >A wrapper-class for a object which is ready immediately
 CDune::PushBackTuple< Tuple, T >Helper template to append a type to a std::tuple
 CDune::PushFrontTuple< Tuple, T >Helper template to prepend a type to a std::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::value_type &, A::difference_type >
 CDune::RandomAccessIteratorFacade< ConstArrayListIterator< IndexPair< TG, TL >, N, std::allocator< Dune::IndexPair< TG, TL > > >, const A::value_type, A::value_type const &, A::difference_type >
 CDune::RandomAccessIteratorFacade< ConstArrayListIterator< T, N, A >, const A::value_type, A::value_type const &, 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< RealIterator< T, R >, T, R >
 CDune::RandomAccessIteratorFacade< RealRowIterator< T >, T >
 CDune::RannacherTurekLocalBasis< D, R, d >Rannacher-Turek shape functions
 CDune::RannacherTurekLocalCoefficients< d >Layout for Rannacher-Turek elements
 CDune::RannacherTurekLocalFiniteElement< D, R, d >Rannacher-Turek shape functions
 CDune::RannacherTurekLocalInterpolation< D, R, d >Please doc me
 CDune::Functions::RannacherTurekPreBasis< GV >Pre-basis for a Rannacher-Turek basis
 CDune::RaviartThomasCubeLocalFiniteElement< D, R, dim, order >Raviart-Thomas local finite elements for cubes
 CDune::RaviartThomasL2Interpolation< dimension, F >An L2-based interpolation for Raviart Thomas
 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::Simd::Overloads::RebindType< S, class, class >Should have a member type type
 CDune::Simd::Overloads::RebindType< bool, V, std::enable_if_t< VcImpl::IsVector< V >::value &&!VcImpl::IsMask< V >::value > >Should have a member type type
 CDune::Simd::Overloads::RebindType< S, M, std::enable_if_t< VcImpl::IsMask< M >::value &&VcImpl::IsVectorizable< S >::value &&!std::is_same< S, Scalar< typename M::Vector > >::value > >Should have a member type type
 CDune::Simd::Overloads::RebindType< S, V, std::enable_if_t< VcImpl::IsVector< V >::value &&!VcImpl::IsMask< V >::value &&VcImpl::IsVectorizable< S >::value &&!std::is_same< S, Scalar< V > >::value > >Should have a member type type
 CDune::Simd::Overloads::RebindType< S, V, std::enable_if_t< VcImpl::IsVector< V >::value &&!VcImpl::IsVectorizable< S >::value &&!std::is_same< S, bool >::value &&!std::is_same< S, Scalar< V > >::value > >Should have a member type type
 CDune::Simd::Overloads::RebindType< Scalar< typename M::Vector >, M, std::enable_if_t< VcImpl::IsMask< M >::value > >Should have a member type type
 CDune::Simd::Overloads::RebindType< Simd::Scalar< V >, V, std::enable_if_t< VcImpl::IsVector< V >::value > >Should have a member type 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::Geo::ReferenceElement< Implementation >This class provides access to geometric and topological properties of a reference element
 CDune::Geo::ReferenceElement< Geo::ReferenceElementImplementation< ctype, mydimension > >
 CDune::Geo::ReferenceElements< ctype_, dim >Class providing access to the singletons of the reference elements
 CDune::RefinedP0LocalBasis< D, R, dim >Uniformly refined constant shape functions on a unit simplex in R^dim
 CDune::RefinedP0LocalBasis< D, R, 1 >
 CDune::RefinedP0LocalBasis< D, R, 2 >
 CDune::RefinedP0LocalBasis< D, R, 3 >
 CDune::RefinedP0LocalFiniteElement< D, R, dim >Local finite element that is piecewise P0 on a once uniformly refined reference geometry
 CDune::RefinedP0LocalFiniteElement< D, R, 1 >Local finite element that is piecewise P0 on a once uniformly refined reference geometry
 CDune::RefinedP0LocalFiniteElement< D, R, 2 >Local finite element that is piecewise P0 on a once uniformly refined reference geometry
 CDune::RefinedP0LocalFiniteElement< D, R, 3 >Local finite element that is piecewise P0 on a once uniformly refined reference geometry
 CDune::RefinedP1LocalFiniteElement< D, R, dim >Piecewise linear continuous Lagrange functions on a uniformly refined simplex element
 CDune::RefinedSimplexLocalBasis< D, 1 >Base class for LocalBasis classes based on uniform refinement in 1D; provides numbering and local coordinates of subelements
 CDune::RefinedSimplexLocalBasis< D, 2 >Base class for LocalBasis classes based on uniform refinement in 2D; provides numbering and local coordinates of subelements
 CDune::RefinedSimplexLocalBasis< D, 3 >Base class for LocalBasis classes based on uniform refinement in 3D; provides numbering and local coordinates of subelements
 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::RefinementIntervalsHolds the number of refined intervals per axis needed for virtual and static refinement
 CDune::RefinementImp::HCube::RefinementSubEntityIteratorSpecial< dimension, CoordType, codimension >SubEntityIterator base class for hypercube refinement
 CDune::Concept::Refines< BaseConcepts >Base class for refined concepts
 CDune::Concept::Refines< BasisNode >
 CDune::Concept::Refines< Callable< Domain > >
 CDune::Concept::Refines< ConstVectorBackend< GlobalBasis > >
 CDune::Concept::Refines< Dune::Functions::Concept::DifferentiableFunction< Range(Domain), DerivativeTraits >, Dune::Functions::Concept::GridFunction< Range(Domain), EntitySet > >
 CDune::Concept::Refines< Dune::Functions::Concept::DifferentiableFunction< Range(Domain), DerivativeTraits >, Dune::Functions::Concept::LocalFunction< Range(Domain), LocalContext > >
 CDune::Concept::Refines< Dune::Functions::Concept::DifferentiableGridFunction< Range(Domain), GridViewEntitySet< GridView, 0 >, DerivativeTraits > >
 CDune::Concept::Refines< Dune::Functions::Concept::Function< Range(Domain)> >
 CDune::Concept::Refines< Dune::Functions::Concept::GridFunction< Range(Domain), GridViewEntitySet< GridView, 0 > > >
 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::Functions::ReservedDeque< T, n >A double-ended queue (deque) class with statically reserved memory
 CDune::ReservedVector< T, n >A Vector class with statically reserved memory
 CDune::ReservedVector< T, length >
 CDune::ReservedVector< YGridLevel, 32 >
 CDune::Functions::RotateTuple< T >Rotate type list by one, such that last entry is moved to first position
 CDune::ImplicitMatrixBuilder< M_ >::row_objectProxy row object for entry access
 CDune::Amg::RowSumFunctor using the row sum (infinity) norm to determine strong couplings
 CDune::RT02DLocalBasis< D, R >Lowest order Raviart-Thomas shape functions on the reference triangle
 CDune::RT02DLocalFiniteElement< D, R >Zero order Raviart-Thomas shape functions on triangles
 CDune::RT03DLocalBasis< D, R >Lowest order Raviart-Thomas shape functions on the reference tetrahedron
 CDune::RT03DLocalFiniteElement< D, R >Zero order Raviart-Thomas shape functions on tetrahedra
 CDune::RT0Cube2DLocalBasis< D, R >Lowest order Raviart-Thomas shape functions on the reference quadrilateral
 CDune::RT0Cube2DLocalFiniteElement< D, R >Zero order Raviart-Thomas shape functions on rectangles
 CDune::RT0Cube2DLocalInterpolation< LB >Lowest order Raviart-Thomas shape functions on the reference quadrilateral
 CDune::RT0Cube2DLocalInterpolation< Dune::RT0Cube2DLocalBasis< D, R > >
 CDune::RT0Cube3DLocalBasis< D, R >Lowest order Raviart-Thomas shape functions on the reference hexahedron
 CDune::RT0Cube3DLocalFiniteElement< D, R >Zero order Raviart-Thomas shape functions on cubes
 CDune::RT0Cube3DLocalInterpolation< LB >Lowest order Raviart-Thomas shape functions on the reference hexahedron
 CDune::RT0Cube3DLocalInterpolation< Dune::RT0Cube3DLocalBasis< D, R > >
 CDune::RT0PrismLocalBasis< D, R >First order Raviart-Thomas shape functions on the reference prism
 CDune::RT0PrismLocalFiniteElement< D, R >First order Raviart-Thomas shape functions on prisms
 CDune::RT0PrismLocalInterpolation< LB >First order Raviart-Thomas shape functions on the reference prism
 CDune::RT0PrismLocalInterpolation< Dune::RT0PrismLocalBasis< D, R > >
 CDune::RT0PyramidLocalBasis< D, R >First order Raviart-Thomas shape functions on the reference pyramid
 CDune::RT0PyramidLocalFiniteElement< D, R >First order Raviart-Thomas shape functions on pyramids
 CDune::RT0PyramidLocalInterpolation< LB >First order Raviart-Thomas shape functions on the reference hexahedron
 CDune::RT0PyramidLocalInterpolation< Dune::RT0PyramidLocalBasis< D, R > >
 CDune::RT12DLocalBasis< D, R >First order Raviart-Thomas shape functions on the reference triangle
 CDune::RT12DLocalCoefficientsLayout map for Raviart-Thomas-1 elements on the reference triangle
 CDune::RT12DLocalFiniteElement< D, R >First order Raviart-Thomas shape functions on triangles
 CDune::RT12DLocalInterpolation< LB >First order Raviart-Thomas shape functions on the reference quadrilateral
 CDune::RT12DLocalInterpolation< Dune::RT12DLocalBasis< D, R > >
 CDune::RT1Cube2DLocalBasis< D, R >First order Raviart-Thomas shape functions on the reference quadrilateral
 CDune::RT1Cube2DLocalFiniteElement< D, R >First order Raviart-Thomas shape functions on quadrilaterals
 CDune::RT1Cube2DLocalInterpolation< LB >First order Raviart-Thomas shape functions on the reference quadrilateral
 CDune::RT1Cube2DLocalInterpolation< Dune::RT1Cube2DLocalBasis< D, R > >
 CDune::RT1Cube3DLocalBasis< D, R >First order Raviart-Thomas shape functions on the reference hexahedron
 CDune::RT1Cube3DLocalFiniteElement< D, R >First order Raviart-Thomas shape functions on cubes
 CDune::RT1Cube3DLocalInterpolation< LB >First order Raviart-Thomas shape functions on the reference hexahedron
 CDune::RT1Cube3DLocalInterpolation< Dune::RT1Cube3DLocalBasis< D, R > >
 CDune::RT2Cube2DLocalBasis< D, R >Second order Raviart-Thomas shape functions on the reference quadrilateral
 CDune::RT2Cube2DLocalFiniteElement< D, R >Second order Raviart-Thomas shape functions on cubes
 CDune::RT2Cube2DLocalInterpolation< LB >Second order Raviart-Thomas shape functions on the reference triangle
 CDune::RT2Cube2DLocalInterpolation< Dune::RT2Cube2DLocalBasis< D, R > >
 CDune::RT3Cube2DLocalBasis< D, R >Second order Raviart-Thomas shape functions on the reference quadrilateral
 CDune::RT3Cube2DLocalFiniteElement< D, R >Second order Raviart-Thomas shape functions on cubes
 CDune::RT3Cube2DLocalInterpolation< LB >Second order Raviart-Thomas shape functions on the reference quadrilateral
 CDune::RT3Cube2DLocalInterpolation< Dune::RT3Cube2DLocalBasis< D, R > >
 CDune::RT4Cube2DLocalBasis< D, R >Second order Raviart-Thomas shape functions on the reference quadrilateral
 CDune::RT4Cube2DLocalFiniteElement< D, R >Second order Raviart-Thomas shape functions on cubes
 CDune::RT4Cube2DLocalInterpolation< LB >Second order Raviart-Thomas shape functions on the reference triangle
 CDune::RT4Cube2DLocalInterpolation< Dune::RT4Cube2DLocalBasis< D, R > >
 CDune::ScalarProduct< X >Base class for scalar product and norm computation
 CDune::Simd::Overloads::ScalarType< V, class >Should have a member type type
 CDune::Simd::Overloads::ScalarType< V, std::enable_if_t< VcImpl::IsVector< V >::value > >Should have a member type type
 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::SeqOverlappingSchwarzApplier< T >Helper template meta program for application of overlapping Schwarz
 CDune::SeqOverlappingSchwarzDomainSize< M >
 CDune::Functions::SignatureTag< Range(Domain), DerivativeTraitsT >Tag-class to encapsulate signature information
 CDune::Functions::SignatureTraits< Signature, isCallable >Helper class to deduce the signature of a callable
 CDune::SimdScalarTypeTraits< AlignedNumber< T, align > >Deduce the underlying scalar data type of an AlignedNumber
 CDune::TypeTree::SimpleFilterDefault simple filter that accepts any node and leaves its child structure unchanged
 CDune::TypeTree::SimpleFilterTagTag describing a simple filter that can only decide whether or not to include a single given child
 CDune::Singleton< T >An adapter to turn a class into a singleton
 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::Functions::SizeInfo< B >A class encapsulating size information
 CDune::SizeOf< T >Compute size of variadic type list
 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::SolverFactory< Operator >Factory to assembly solvers configured by a ParameterTree
 CDune::SolverHelper< ISTLLinearSolver, BCRSMatrix >Helper class for notifying a DUNE-ISTL linear solver about a change of the iteration matrix object in a unified way, i.e. independent from the solver's type (direct/iterative)
 CDune::SPAnisotropicRefinement< dim >User may choose freely along which axes the grid should be refined
 CDune::Amg::SparsityBuilder< M >Functor for building the sparsity pattern of the matrix using examineConnectivity
 CDune::SPBisectionRefinement< dim >Each element is split into 2 children
 CDune::SPDomain< ct, dim >Description of the computational domain
 CDune::SPEntitySeed< codim, Grd >Entity seed for SPGrid
 CDune::SPIntersection< Grid >
 CDune::SPIntersection< const Grid >
 CDune::SPIsotropicRefinement< dim >Each element is split into 2dim children
 CDune::SPMultiIndex< dim >Multiindex
 CDune::SPMultiIndex< dimension >
 CDune::SPQR< Matrix >Use the SPQR package to directly solve linear systems – empty default class
 CDune::SPTopology< dim >Description of the grid's topology
 CDune::SPTopology< dimension >
 CDune::StandardMathematicalConstants< T >Standard implementation of MathematicalConstants
 CDune::StandardMathematicalConstants< Field >
 CDune::StarCDReader< GridType >File reader for the Star-CD format
 CDune::TypeTree::StaticChildAccessors< ProxiedNode >Mixin class providing methods for child access with compile-time parameter
 CDune::TypeTree::StaticChildAccessors< Node >
 CDune::StaticIntegralRange< T, to, from >Static integer range for use in range-based for loops
 CDune::StaticPower< b, p >Calculates b^p at compile time
 CDune::StaticRefinement< topologyId, CoordType, coerceToId, dimension_ >Wrap each Refinement implementation to get a consistent interface
 CDune::TypeTree::StaticTraversalMixin base class for visitors that require a static TreePath during traversal
 CDune::StructuredGridFactory< GridType >Construct structured cube and simplex grids in unstructured grid managers
 CDune::StructuredGridFactory< AlbertaGrid< dim, dimworld > >Specialization of the generic StructuredGridFactory for AlbertaGrid
 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<EquidistantOffsetCoordinates>
 CDune::Functions::SubEntityDOFs< GridView >Range of DOFs associated to sub-entity
 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::Functions::SubspaceLocalView< RLV, PP >The restriction of a finite element basis to a single element
 CDune::Extensions::SuperEntityIterator< Grid, codim >Does a grid support superentity iterators of a codimension?
 CDune::Extensions::SuperEntityIterator< SPGrid< ct, dim, Ref, Comm >, codim >Does a grid support superentity iterators of a codimension?
 CDune::SuperLUMatrix< M >Utility class for converting an ISTL Matrix into a SuperLU Matrix
 CDune::SuperLUMatrix< Matrix >
 CDune::Capabilities::supportsCallbackAdaptation< SPGrid< ct, dim, Ref, Comm > >
 CDune::SurfaceNormalCalculatorA bilinear surface mapping
 CDune::SymmetricMultiplicativeSchwarzModeTag that tells the Schwarz method to be multiplicative and symmetric
 CDune::Functions::TaylorHoodPreBasis< GV, HI >Pre-basis for lowest order Taylor-Hood basis
 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
 CTestPartialHelper class to test the 'partial' method
 CDune::Capabilities::threadSafe< Grid >Specialize with 'true' if the grid implementation is thread safe. (default=false)
 CDune::Capabilities::threadSafe< ALUGrid< dim, dimworld, eltype, refinementtype, Comm > >ALUGrid is not generally thread safe (only grid iteration is)
 CDune::Capabilities::threadSafe< SPGrid< ct, dim, Ref, Comm > >Is a grid implementation thread safe?
 CDune::TimerA simple stop watch
 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::TopologySingletonFactory< MonomialBasisFactory< dim, SF > >
 CDune::Torus< Communication, d >
 CDune::Torus< Communication, dim >
 CDune::BasisInterface::TraitsTypes of domain and range
 CDune::EdgeS0_5Basis< Geometry, RF >::TraitsExport type traits for function signature
 CDune::FiniteElementInterface::TraitsTypes of component objects
 CDune::Function< Domain, Range >::TraitsTraits class containing raw types
 CDune::PowerBasis< Backend, dimR >::TraitsTypes of domain and range
 CDune::PowerFiniteElement< Backend, dimR >::TraitsTypes of component objects
 CDune::RefinementImp::Traits< topologyId, CoordType, coerceToId, dimension, Dummy >Mapping from geometryType, CoordType and coerceTo to a particular Refinement implementation
 CDune::Functions::Experimental::TransformedIndexPreBasis< RPB, T >A pre-basis transforming multi-indices
 CDune::TransformedRangeView< R, F, T >A range transforming the values of another range on-the-fly
 CDune::TypeTree::TransformTree< SourceTree, Transformation, Tag, recursive >Transform a TypeTree
 CDune::TransformTupleFunctor< TE, Args >
 CDune::TransposedMatMultMatResult< M1, M2 >Helper TMP to get the result type of a sparse matrix matrix multiplication ( \(C=A*B\))
 CDune::Functions::TreeData< T, ND, LO >Container allowing to attach data to each node of a tree
 CDune::TypeTree::TreeInfo< Tree, Tag >Struct for obtaining some basic structural information about a TypeTree
 CDune::Functions::TrigonometricFunction< K, sinFactor, cosFactor >A linear combination of trigonomic functions
 CDune::TrilinearMapping
 Cstd::tuple_element< i, Dune::MultiTypeBlockMatrix< Args... > >Make std::tuple_element work for MultiTypeBlockMatrix
 Cstd::tuple_element< i, Dune::MultiTypeBlockVector< Args... > >Make std::tuple_element work for MultiTypeBlockVector
 CDune::TupleVector< T >A class augmenting std::tuple by element access via operator[]
 CDune::TypeTree::TypeAccumulationPolicy< Functor, Reduction, StartType, ParentChildReduction, ReductionAlgorithm >
 CDune::Functions::TypeErasureBase< Interface, Implementation, bufferSize >Base class for type-erased interface wrapper
 CDune::Functions::TypeErasureBase< Imp::DifferentiableFunctionTraits< Range(Domain), DerivativeTraits, bufferSize >::Concept, Imp::DifferentiableFunctionTraits< Range(Domain), DerivativeTraits, bufferSize >::template Model >
 CDune::Functions::TypeErasureBase< Imp::GridFunctionTraits< Range(Domain), ES, DerivativeTraits, bufferSize >::Concept, Imp::GridFunctionTraits< Range(Domain), ES, DerivativeTraits, bufferSize >::template Model >
 CDune::Functions::TypeErasureBase< Imp::LocalFunctionTraits< Range(Domain), LocalContext, DerivativeTraits, bufferSize >::Concept, Imp::LocalFunctionTraits< Range(Domain), LocalContext, DerivativeTraits, bufferSize >::template Model >
 CDune::TypeListElement< i, TypeList< T... > >Get element of TypeList
 CDune::TypeListSize< TypeList< T... > >Get size of TypeList
 CDune::UncachedSelection< TS, TG, TL, N >An uncached selection of indices
 CDune::Unity< Field >A class representing the unit of a given Field
 CDune::TypeTree::SimpleFilter::validate< Node >Validates the combination of filter and node
 CDune::ValueTransformationTagTag to enable value based transformations in TransformedRangeView
 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::Capabilities::viewThreadSafe< ALUGrid< dim, dimworld, eltype, refinementtype, Comm > >ALUGrid is view thread safe (i.e. things that don't modify the grid)
 CDune::Capabilities::viewThreadSafe< SPGrid< ct, dim, Ref, Comm > >Is a grid implementation thread safe while not being modified?
 CDune::Capabilities::viewThreadSafe< YaspGrid< dim, Coordinates > >YaspGrid is viewThreadSafe
 CDune::VirtualRefinement< dimension, CoordType >VirtualRefinement base class
 CDune::TypeTree::VisitDirectChildren::VisitChild< Node1, Child1, Node2, Child2, TreePath >Template struct for determining whether or not to visit a given child
 CDune::TypeTree::VisitTree::VisitChild< Node1, Child1, Node2, Child2, TreePath >Template struct for determining whether or not to visit a given child
 CDune::TypeTree::VisitDirectChildrenMixin base class for visitors that only want to visit the direct children of a node
 CDune::TypeTree::VisitTreeMixin base class for visitors that want to visit the complete tree
 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::YaspEntitySeed< codim, GridImp >Describes the minimal information necessary to create a fully functional YaspEntity
 CDune::YaspHierarchicIterator< GridImp >YaspHierarchicIterator enables iteration over son entities of codim 0
 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::YaspLevelIterator< codim, pitype, GridImp >Iterates over entities of one grid level
 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 doesn't 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 doesn't hold any data, but an iterator range into a data array owned by YGridLevel
 CDune::Zero< Field >A class representing the zero of a given Field
Creative Commons License   |  Legal Statements / Impressum  |  Hosted by TU Dresden  |  generated with Hugo v0.111.3 (Jan 5, 23:30, 2025)