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::AdditiveSchwarzMode | Tag 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::ADLTag | Tag 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::AdvancedFilter | Base class for advanced filters |
CDune::TypeTree::IndexFilter< indices > | Filter class for FilteredCompositeNode that selects the children with the given indices |
CDune::TypeTree::AdvancedFilterTag | Tag 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::AlignedNumberImpl::AlignedNumber< T, align > | Aligned wrappers for arithmetic types |
CDune::AllSet< TA > | A set containing everything |
CDune::AlwaysFalse< T > | Template which always yields a false value |
CDune::AlwaysTrue< T > | Template which always yields a true value |
CDune::AmiraMeshWriter< GridView > | Provides file writing facilities in the AmiraMesh format |
►CDune::AmiraMeshWriter< GridType::LeafGridView > | |
CDune::LeafAmiraMeshWriter< GridType > | Provides file writing facilities in the AmiraMesh format for leaf grids |
►CDune::AmiraMeshWriter< GridType::LevelGridView > | |
CDune::LevelAmiraMeshWriter< GridType > | Provides file writing facilities in the AmiraMesh format for level grids |
►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::AnalyticalCoordFunction< ct, dimD, dimR, Impl > | Derive an implementation of an analytical coordinate function from this class |
►CDune::AnalyticalCoordFunctionInterface< ctype, dimD, dimR, IdenticalCoordFunction< ctype, dim > > | |
CDune::AnalyticalCoordFunction< ctype, dim, dim, IdenticalCoordFunction< ctype, dim > > | |
►CDune::AnalyticalCoordFunctionInterface< double, dimD, dimR, DGFCoordFunction< dimD, dimR > > | |
CDune::AnalyticalCoordFunction< double, dimD, dimR, DGFCoordFunction< dimD, dimR > > | |
►CDune::AnalyticalCoordFunctionInterface< HostGrid::ctype, dimD, dimR, IdenticalCoordFunction< HostGrid::ctype, dim > > | |
CDune::AnalyticalCoordFunction< HostGrid::ctype, dim, dim, 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::PDELab::AnySpaceTag | |
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::Functions::FlatMultiIndex< size_type > | A multi-index class with only one level |
CDune::LoopSIMD< T, S, A > | |
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::PDELab::AssemblerInterface | The global assembler which performs the traversing of the integration parts |
CDune::AssociativePropertyMap< T > | An adapter to turn an unique associative container into a property map |
CDune::At< N > | Reverse element access |
CDune::PDELab::Backend::attached_container | Tag for requesting a vector or matrix container with a pre-attached underlying object |
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< T & > | Specialization to remove lvalue references |
CDune::AutonomousValueType< T && > | Specialization to remove rvalue references |
CDune::AutonomousValueType< const T > | Specialization to remove const qualifiers |
CDune::AutonomousValueType< volatile T > | Specialization to remove volatile qualifiers |
CDune::AutonomousValueType< volatile const T > | Specialization to remove both const and volatile qualifiers |
►CDune::AutonomousValueType< Simd::VcImpl::Proxy< V >::value_type > | |
CDune::AutonomousValueType< Simd::VcImpl::Proxy< V > > | Specialization of AutonomousValue for Vc proxies |
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::YaspGeometry< 0, cdim, GridImp > | Specialization for dim=0, this is a vertex |
►CDune::AxisAlignedCubeGeometry< GridImp::ctype, mydim, cdim > | |
CDune::YaspGeometry< mydim, cdim, GridImp > | The general version that handles all codimensions but 0 and dim |
►CDune::AxisAlignedCubeGeometry< GridImp::ctype, mydim, mydim > | |
CDune::YaspGeometry< mydim, mydim, GridImp > | Specialize for dim=dimworld, i.e. a volume element |
CDune::b64chunk | Struct representing the three byte text as well as the four 6 bit chunks |
►CDune::BackupRestoreFacility< Grid > | Facility for writing and reading grids |
CDune::BackupRestoreFacility< const Grid > | BackupRestoreFacility taking const Grid as type and deriving from the version with the const |
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::PDELab::interleaved_ordering::Base< DI, CI, Node > | Interface for merging index spaces |
CDune::Base64Stream | Class to base64 encode a stream of data |
CDune::PDELab::interleaved_ordering::Base< DI, CI, CompositeInterleavedOrdering< DI, CI, Children... > > | |
CDune::PDELab::interleaved_ordering::Base< DI, CI, PowerInterleavedOrdering< DI, CI, Child, k > > | |
►CDune::Imp::base_array_unmanaged< B, std::allocator< B > > | |
►CDune::Imp::block_vector_unmanaged< B, std::allocator< B > > | |
CDune::BlockVector< B, A > | A vector of blocks with memory management |
CDune::MatrixImp::DenseMatrixBase< B, A > | A Vector of blocks with different blocksizes |
CDune::VariableBlockVector< B, A > | A Vector of blocks with different blocksizes |
►CDune::Imp::base_array_unmanaged< double, std::allocator< double > > | |
►CDune::Imp::block_vector_unmanaged< double, std::allocator< double > > | |
CDune::MatrixImp::DenseMatrixBase< double, std::allocator< double > > | |
►CDune::Imp::base_array_unmanaged< T, A > | |
►CDune::Imp::block_vector_unmanaged< T, A > | |
CDune::BlockVector< T, A > | |
►CDune::Imp::base_array_unmanaged< T, std::allocator< T > > | |
►CDune::Imp::block_vector_unmanaged< T, std::allocator< T > > | |
CDune::MatrixImp::DenseMatrixBase< T, std::allocator< T > > | |
CDune::PDELab::BasicTypeFromDimensionAndTopologyId< dimension, topologyId > | Utility TMP for determining the BasicType of a geometry from its dimension and topology id |
►CDune::BasisInterface | Interface for global-valued shape functions |
CDune::ScalarLocalToGlobalBasisAdaptor< typename LocalFiniteElement::Traits::LocalBasisType, Geometry > | |
CDune::ScalarLocalToGlobalBasisAdaptor< LocalBasis, Geometry > | Convert a simple scalar local basis into a global basis |
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::SuperLUMatrix< BCRSMatrix< B, TA > > | Converter for BCRSMatrix to SuperLU Matrix |
►CDune::ISTL::Impl::BCCSMatrix< M::field_type, int > | |
CDune::ColCompMatrix< M, I > | A sparse matrix in compressed-column format |
CDune::PDELab::ISTL::tags::bcrs_matrix | Tag describing a BCRSMatrix |
CDune::BCRSMatrix< B, A > | A sparse block matrix with compressed row storage |
►CDune::BCRSMatrix< B, std::allocator< B > > | |
CDune::BDMatrix< B, A > | A block-diagonal matrix |
CDune::BTDMatrix< B, A > | A block-tridiagonal matrix |
CDune::PDELab::ISTL::BCRSMatrixBackend< EntriesPerRow > | Backend using (possibly nested) ISTL BCRSMatrices |
CDune::PDELab::ISTL::BCRSPattern< RowOrdering, ColOrdering > | Pattern builder for generic BCRS-like sparse matrices |
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::BrezziDouglasMariniCubeLocalFiniteElement< D, R, 2, 1 > | Brezzi-Douglas-Marini local finite elements for cubes with dimension 2 and order 1 |
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::BrezziDouglasMariniCubeLocalFiniteElement< D, R, 3, 1 > | Brezzi-Douglas-Marini local finite elements for cubes with dimension 3 and order 1 |
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::BrezziDouglasMariniSimplexLocalFiniteElement< D, R, 2, 1 > | Brezzi-Douglas-Marini local finite elements for simplices with dimension 2 and order 1 |
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::BrezziDouglasMariniCubeLocalFiniteElement< D, R, 2, 2 > | Brezzi-Douglas-Marini local finite elements for cubes with dimension 2 and order 2 |
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::BrezziDouglasMariniSimplexLocalFiniteElement< D, R, 2, 2 > | Brezzi-Douglas-Marini local finite elements for simplices with dimension 2 and order 2 |
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::ContainerWrapperIterator< CW, T, R > | Iterator class for sparse vector-like containers |
CDune::BidirectionalIteratorFacade< iterator, value_type > | |
►CDune::BidirectionalIteratorFacade< LevelIterator< C, T1 >, T1, T1 & > | |
CDune::Amg::Hierarchy< T, A >::LevelIterator< C, T1 > | Iterator over the levels in the hierarchy |
CDune::BidirectionalIteratorFacade< RealIterator< T >, T > | |
CDune::bigunsignedint< k > | Portable very large unsigned integers |
►CDune::BitSetVectorConstReference< block_size, Alloc > | A proxy class that acts as a const reference to a single bitset in a BitSetVector |
CDune::BitSetVectorReference< block_size, Alloc > | A proxy class that acts as a mutable reference to a single bitset in a BitSetVector |
CDune::BL< l > | Compile-time parameter for block recursion depth |
CDune::PDELab::ISTL::tags::block_vector | Tag describing a BlockVector |
CDune::PDELab::BlockSolverOptions | Options for IterativeBlockJacobiPreconditionerLocalOperator |
►CDune::PDELab::BoundaryGridFunctionInterface< T, Imp > | A BoundaryGridFunction allows evaluation on boundary intersections |
CDune::PDELab::BoundaryGridFunctionBase< T, Imp > | Leaf of a function tree |
►CDune::PDELab::BoundaryGridFunctionInterface< BoundaryGridFunctionTraits< GV, RF, 1, FieldVector< RF, 1 > >, ConstBoundaryGridFunction< GV, RF, 1 > > | |
►CDune::PDELab::BoundaryGridFunctionBase< BoundaryGridFunctionTraits< GV, RF, 1, FieldVector< RF, 1 > >, ConstBoundaryGridFunction< GV, RF, 1 > > | |
CDune::PDELab::ConstBoundaryGridFunction< GV, RF, dimR > | BoundaryGridFunction returning a constant value everywhere |
►CDune::PDELab::BoundaryGridFunctionInterface< BoundaryGridFunctionTraits< GV, RF, 1, FieldVector< RF, 1 > >, TwoArgsMemberFunctionToBoundaryGridFunctionAdaptor< Member, Class, GV, RF, 1 > > | |
►CDune::PDELab::BoundaryGridFunctionBase< BoundaryGridFunctionTraits< GV, RF, 1, FieldVector< RF, 1 > >, TwoArgsMemberFunctionToBoundaryGridFunctionAdaptor< Member, Class, GV, RF, 1 > > | |
CDune::PDELab::TwoArgsMemberFunctionToBoundaryGridFunctionAdaptor< Member, Class, GV, RF, dimR > | BoundaryGridFunction implemented by a member function of some class |
►CDune::PDELab::BoundaryGridFunctionInterface< BoundaryGridFunctionTraits< T::Traits::GridViewType, T::Traits::RangeFieldType, 1, Dune::FieldVector< T::Traits::RangeFieldType, 1 > >, BoundaryGridFunctionSelectComponentAdapter< T > > | |
CDune::PDELab::BoundaryGridFunctionSelectComponentAdapter< T > | Takes a BoundaryGridFunction and acts as a single component |
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::PDELab::BrezziDouglasMariniLocalFiniteElementMap< GV, D, R, k, basic_type > | |
CDune::BrezziDouglasMariniSimplexLocalFiniteElement< D, R, dim, order > | Brezzi-Douglas-Marini local finite element for simplices |
CDune::Functions::BSplineLocalBasis< GV, R, MI > | 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, MI > | |
CDune::Functions::BSplineLocalCoefficients< dim > | Attaches a shape function to an entity |
CDune::Functions::BSplineLocalFiniteElement< GV, R, MI > | LocalFiniteElement in the sense of dune-localfunctions, for the B-spline basis on tensor-product grids |
CDune::Functions::BSplineLocalFiniteElement< GV, double, MI > | |
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, MI > > | |
CDune::Functions::BSplineLocalInterpolation< dim, Dune::Functions::BSplineLocalBasis< GV, R, MI > > | |
CDune::Functions::BSplinePreBasis< GV, MI > | Pre-basis for B-spline basis |
CDune::BufferedCommunicator | A 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< IdentityGrid< HostGrid >, codim > | IdentityGrid can communicate when the host grid can communicate |
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 >::CellIterator | Iterator 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::PDELab::ordering::Chunked< OrderingTag > | |
CDune::Cloneable | An interface class for cloneable objects |
CDune::Amg::CoarsenCriterion< T > | The criterion describing the stop criteria for the coarsening process |
►CCoarseSpace< X > | Representation of a coarse space intended for two-level Schwarz preconditioners |
CDune::PDELab::SubdomainProjectedCoarseSpace< GFS, M, X, PIH > | This constructs a coarse space from a per-subdomain local basis |
CDune::AlbertaLeafGridView< GridImp >::Codim< cd > | Codim Structure |
CDune::AlbertaLevelGridView< GridImp >::Codim< cd > | Codim Structure |
CDune::Codim< codim > | Static tag representing a codimension |
CDune::DefaultLeafGridView< GridImp >::Codim< cd > | Codim Structure |
CDune::DefaultLevelGridView< GridImp >::Codim< cd > | Codim Structure |
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::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< codimension > | |
CDune::Codim< CodimInHostGrid > | |
CDune::Codim< dimension > | |
CDune::Codim< std::remove_const< Grid >::type::dimension - mydim > | |
►CDune::CoefficientsInterface | Interface for global-valued coefficients |
CDune::EdgeS0_5Coefficients< dim > | Coefficients for lowest order edge elements on simplices |
CDune::PowerCoefficients | Meta-coefficients turning a scalar coefficients into vector-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::PDELab::CombinedOperator< ApplyOp, Args > | A local operator to take combine different local operators |
►CDune::PDELab::CombinedOperator< InstationarySumLocalOperator< Args... >, Args... > | |
►CDune::PDELab::InstationarySumLocalOperator< Args... > | |
CDune::PDELab::InstationarySumLocalOperator< std::tuple< Args... > > | Deprecated specialization of |
CDune::PDELab::InstationarySumLocalOperator< Args > | A local operator to take the sum of other local operators |
►CDune::PDELab::CombinedOperator< WeightedSumLocalOperator< K, Args... >, Args... > | |
►CDune::PDELab::WeightedSumLocalOperator< K, Args... > | |
CDune::PDELab::WeightedSumLocalOperator< K, std::tuple< Args... > > | Deprecated specialization of |
CDune::PDELab::WeightedSumLocalOperator< K, Args > | A local operator to take the weighted sum of other local operators |
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< AddMatrixElementVectorDataHandle< GFS >, Matrix::field_type > | |
CDune::CommDataHandleIF< CommDataHandle< Grid, WrappedHandle >, WrappedHandle::DataType > | |
CDune::CommDataHandleIF< DataHandle, char > | |
►CDune::CommDataHandleIF< EntryAccumulator, ValueMPIData > | |
CDune::PDELab::NonOverlappingBorderDOFExchanger< GridOperator >::EntryAccumulator | A DataHandle class to exchange matrix entries |
►CDune::CommDataHandleIF< GFSDataHandle< GFS, V, DataGatherScatter< AddClearGatherScatter >, DOFDataCommunicationDescriptor< typename V::ElementType > >, CommunicationDescriptor::DataType > | |
CDune::PDELab::GFSDataHandle< GFS, V, DataGatherScatter< AddClearGatherScatter > > | |
►CDune::CommDataHandleIF< GFSDataHandle< GFS, V, DataGatherScatter< AddGatherScatter >, DOFDataCommunicationDescriptor< typename V::ElementType > >, CommunicationDescriptor::DataType > | |
CDune::PDELab::GFSDataHandle< GFS, V, DataGatherScatter< AddGatherScatter > > | |
►CDune::CommDataHandleIF< GFSDataHandle< GFS, V, DataGatherScatter< CopyGatherScatter >, DOFDataCommunicationDescriptor< typename V::ElementType > >, CommunicationDescriptor::DataType > | |
CDune::PDELab::GFSDataHandle< GFS, V, DataGatherScatter< CopyGatherScatter > > | |
►CDune::CommDataHandleIF< GFSDataHandle< GFS, V, DataGatherScatter< MaxGatherScatter >, DOFDataCommunicationDescriptor< typename V::ElementType > >, CommunicationDescriptor::DataType > | |
CDune::PDELab::GFSDataHandle< GFS, V, DataGatherScatter< MaxGatherScatter > > | |
►CDune::CommDataHandleIF< GFSDataHandle< GFS, V, DataGatherScatter< MinGatherScatter >, DOFDataCommunicationDescriptor< typename V::ElementType > >, CommunicationDescriptor::DataType > | |
CDune::PDELab::GFSDataHandle< GFS, V, DataGatherScatter< MinGatherScatter > > | |
►CDune::CommDataHandleIF< GFSDataHandle< GFS, V, DisjointPartitioningGatherScatter< V::ElementType >, EntityDataCommunicationDescriptor< V::ElementType > >, CommunicationDescriptor::DataType > | |
►CDune::PDELab::GFSDataHandle< GFS, V, DisjointPartitioningGatherScatter< V::ElementType >, EntityDataCommunicationDescriptor< V::ElementType > > | |
CDune::PDELab::DisjointPartitioningDataHandle< GFS, V > | GatherScatter data handle for creating a disjoint DOF partitioning |
►CDune::CommDataHandleIF< GFSDataHandle< GFS, V, GatherScatter, DOFDataCommunicationDescriptor< typename V::ElementType > >, CommunicationDescriptor::DataType > | |
CDune::PDELab::GFSDataHandle< GFS, V, GatherScatter, CommunicationDescriptor > | Implement a data handle with a grid function space |
►CDune::CommDataHandleIF< GFSDataHandle< GFS, V, GhostGatherScatter, EntityDataCommunicationDescriptor< bool > >, CommunicationDescriptor::DataType > | |
►CDune::PDELab::GFSDataHandle< GFS, V, GhostGatherScatter, EntityDataCommunicationDescriptor< bool > > | |
CDune::PDELab::GhostDataHandle< GFS, V > | Data handle for marking ghost DOFs |
►CDune::CommDataHandleIF< GFSDataHandle< GFS, V, MultiCommGatherScatter< GFS, RankIndex, V >, Dune::PDELab::DOFDataCommunicationDescriptor< V::ElementType, true > >, CommunicationDescriptor::DataType > | |
►CDune::PDELab::GFSDataHandle< GFS, V, MultiCommGatherScatter< GFS, RankIndex, V >, Dune::PDELab::DOFDataCommunicationDescriptor< V::ElementType, true > > | |
CDune::PDELab::MultiCommDataHandle< GFS, V, RankIndex > | Gather/scatter communication that passes a single function from each subdomain to all its neighbors. The functions are received individually without applying any further operations |
►CDune::CommDataHandleIF< GFSDataHandle< GFS, V, SharedDOFGatherScatter, EntityDataCommunicationDescriptor< bool > >, CommunicationDescriptor::DataType > | |
►CDune::PDELab::GFSDataHandle< GFS, V, SharedDOFGatherScatter, EntityDataCommunicationDescriptor< bool > > | |
CDune::PDELab::SharedDOFDataHandle< GFS, V > | Data handle for marking shared DOFs |
►CDune::CommDataHandleIF< GFSNeighborDataHandle< GFS, RankIndex >, RankIndex > | |
CDune::PDELab::GFSNeighborDataHandle< GFS, RankIndex > | Data handle for collecting set of neighboring MPI ranks |
CDune::CommDataHandleIF< IndexExchange, Index > | |
►CDune::CommDataHandleIF< LocalGlobalMapDataHandle< GFS >, int > | |
CDune::PDELab::LocalGlobalMapDataHandle< GFS > | |
CDune::CommDataHandleIF< MatrixExchangeDataHandle< GFS, M >, std::pair< GFS::Traits::GridView::Grid::Traits::GlobalIdSet::IdType, M::block_type > > | |
CDune::CommDataHandleIF< MinimumExchange< IS, V >, V::value_type > | |
►CDune::CommDataHandleIF< PatternExtender< Pattern >, PatternMPIData > | |
CDune::PDELab::NonOverlappingBorderDOFExchanger< GridOperator >::PatternExtender< Pattern > | A DataHandle class to exchange matrix sparsity patterns |
CDune::CommDataHandleIF< VectorExchange< GV, 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 |
Cstd::common_type< Dune::FieldVector< T, N >, Dune::FieldVector< R2, N > > | Specialization of common_type for two FieldVectors |
Cstd::common_type< Dune::FieldVector< T, N >, R2 > | Specialization of common_type for FieldVector and scalar |
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< T > | |
CDune::Communication< void * > | |
CDune::PDELab::CompositeGridFunctionSpaceBaseTag | Tag for the intermediate base class of the CompositeGridFunctionSpace |
CDune::PDELab::CompositeLocalFunctionSpaceTag | Tag denoting a CompositeLocalFunctionSpace |
CDune::TypeTree::CompositeNode< Children > | Base class for composite nodes based on variadic templates |
►CDune::TypeTree::CompositeNode< Children... > | |
CDune::PDELab::CompositeGridFunction< Children > | Composite functions |
CDune::PDELab::CompositeGridFunctionSpace< Backend, OrderingTag, Children > | Base class for tuples of grid function spaces base class that holds implementation of the methods this is the default version with lexicographic ordering |
CDune::PDELab::CompositeLexicographicOrdering< DI, CI, Children > | Interface for merging index spaces |
►CDune::TypeTree::CompositeNode< LeafOrdering > | |
CDune::PDELab::Experimental::GridFunctionSpace< DFBasis, VBE, CE >::Ordering | Root of the ordering tree |
►CDune::TypeTree::CompositeNode< LocalOrdering > | |
CDune::PDELab::GridViewOrdering< LocalOrdering > | Transforms a local ordering (entity-wise order) into a global ordering |
►CDune::PDELab::LeafOrderingBase< LocalOrdering > | Generic infrastructure for orderings for leaf spaces |
CDune::PDELab::LeafGridViewOrdering< LocalOrdering > | Gridview ordering for leaf spaces |
►CDune::TypeTree::CompositeNode< Ordering > | |
CDune::PDELab::ChunkedBlockOrdering< Ordering > | Ordering that permutes top-level ContainerIndex entries |
CDune::PDELab::PermutedOrdering< Ordering > | Ordering that permutes top-level ContainerIndex entries |
CDune::TypeTree::CompositeNode< T... > | |
CDune::TypeTree::CompositeNodeTag | Tag designating a composite node |
CDune::Functions::CompositePreBasis< MI, 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 >::ConstIterator | ConstIterator class for sequential access |
CDune::PDELab::CompositeGridFunctionSpace< Backend, OrderingTag, Children >::ConstraintsContainer< E > | Extract type for storing constraints |
CDune::PDELab::Experimental::GridFunctionSpace< DFBasis, VBE, CE >::ConstraintsContainer< E > | Extract type for storing constraints |
CDune::PDELab::GridFunctionSpace< ES, FEM, CE, B, O >::ConstraintsContainer< E > | Extract type for storing constraints |
CDune::PDELab::PowerGridFunctionSpace< T, k, Backend, OrderingTag >::ConstraintsContainer< E > | Extract type for storing constraints |
CDune::PDELab::VectorGridFunctionSpace< GV, FEM, k, Backend, LeafBackend, Constraints, OrderingTag, LeafOrderingTag >::ConstraintsContainer< E > | Extract type for storing constraints |
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::PDELab::ISTL::tags::container< T > | Extracts the container tag from T |
CDune::PDELab::ConvectionDiffusionBoundaryConditions | Class to define the boundary condition types |
CDune::PDELab::ConvectionDiffusionModelProblem< GV, RF > | Parameter class for solving the linear convection-diffusion equation |
CDune::PDELab::ConvectionDiffusionParameterTraits< GV, RF > | Traits class for convection diffusion parameters |
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 >::CreateIterator | Iterator class for sequential creation of blocks |
CDune::VariableBlockVector< B, A >::CreateIterator | Iterator class for sequential creation of blocks |
CDune::PDELab::CrossProduct< dimB_, dimC_ > | Calculate cross product |
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::DataArrayWriter | Base class for data array writers |
CDune::VTK::AppendedBase64DataArrayWriter | Streaming writer for data array tags, uses appended base64 format |
CDune::VTK::AppendedRawDataArrayWriter | Streaming writer for data array tags, uses appended raw format |
CDune::VTK::AsciiDataArrayWriter | Streaming writer for data array tags, uses ASCII inline format |
CDune::VTK::BinaryDataArrayWriter | Streaming writer for data array tags, uses binary inline format |
CDune::VTK::NakedBase64DataArrayWriter | Streaming writer for appended data array tags, uses base64 format |
CDune::VTK::NakedRawDataArrayWriter | Streaming writer for appended data arrays, uses raw format |
CDune::VTK::DataArrayWriterFactory | Factory for DataArrayWriters |
CDune::BCRSMatrix< B, A >::Deallocator | Class used by shared_ptr to deallocate memory using the proper allocator |
►CDune::DebugStreamState | Intermediate class to implement tie-operation of DebugStream |
CDune::DebugStream< thislevel, dlevel, alevel, activator > | Generic class to implement debug output streams |
CDune::PDELab::DefaultAssembler< GFSU, GFSV, CU, CV > | The assembler for standard DUNE grid |
CDune::PDELab::DefaultAssembler< CGGFS, GFS, CC, CC > | |
CDune::PDELab::DefaultAssembler< GFSU, GFSV, Dune::PDELab::EmptyTransformation, Dune::PDELab::EmptyTransformation > | |
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::DefaultHybridVisitor | Hybrid visitor interface and base class for TypeTree hybrid visitors |
CDune::PDELab::DefaultInteriorPenalty< RF > | Default implementation of the interior penalty factor |
CDune::PDELab::DefaultInteriorPenalty< typename V::Traits::RangeFieldType > | |
CDune::PDELab::DefaultLFSCacheTag | |
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::DefaultPairVisitor | Visitor interface and base class for visitors of pairs of TypeTrees |
CDune::TypeTree::DirectChildrenPairVisitor | Convenience base class for visiting the direct children of a node pair |
CDune::TypeTree::TreePairVisitor | Convenience base class for visiting an entire tree pair |
CDune::Amg::DefaultSmootherArgs< T > | The default class for the smoother arguments |
►CDune::PDELab::gfs::DefaultSubSpaceFeatures< GFS, TreePath, Tag > | Default features used by every subspace implementation |
CDune::PDELab::gfs::SubSpaceFeatureProvider< GFS, TreePath, Tag > | |
►CDune::PDELab::gfs::DefaultSubSpaceFeatures< GFS, TreePath, TypeTree::ImplementationTag< TypeTree::ChildForTreePath< GFS, TreePath > > > | |
►CDune::PDELab::gfs::SubSpaceFeatureProvider< GFS, TreePath, TypeTree::ImplementationTag< TypeTree::ChildForTreePath< GFS, TreePath > > > | |
CDune::PDELab::gfs::GridFunctionSubSpace< GFS, TreePath > | Non-nesting implementation of GridFunctionSubSpace |
►CDune::TypeTree::DefaultVisitor | Visitor interface and base class for TypeTree visitors |
CDune::TypeTree::DirectChildrenVisitor | Convenience base class for visiting the direct children of a node |
►CDune::TypeTree::TreeVisitor | Convenience base class for visiting the entire tree |
CDune::Functions::UniformNodeVisitor< CopyVisitor, leafOnly > | |
CDune::Functions::UniformNodeVisitor< DestroyVisitor, leafOnly > | |
CDune::Functions::UniformNodeVisitor< InitVisitor, leafOnly > | |
CDune::Functions::UniformNodeVisitor< SimpleNodeVisitorImp, leafOnly > | Mixin for visitors that should apply the same action on all nodes |
CDune::PDELab::PowerCompositeSetTimeVisitor< TT > | Visitor for Power- and CompositeGridFunctions calling the setTime() method on the leafs of the corresponding function trees |
CDune::DenseMatrix< MAT > | A dense n x m matrix |
►CDune::DenseMatrix< DynamicMatrix< K > > | |
CDune::DynamicMatrix< K > | Construct a matrix with a dynamic size |
►CDune::DenseMatrix< FieldMatrix< ctype, ROWS, COLS > > | |
CDune::FieldMatrix< ctype, coorddimension, mydimension > | |
CDune::FieldMatrix< ctype, mydimension, coorddimension > | |
CDune::FieldMatrix< ctype, numCorners, coorddimension > | |
►CDune::DenseMatrix< FieldMatrix< DF, ROWS, COLS > > | |
CDune::FieldMatrix< DF, dim, dim > | |
►CDune::DenseMatrix< FieldMatrix< K, ROWS, COLS > > | |
CDune::FieldMatrix< K, ROWS, COLS > | A dense n x m matrix |
►CDune::DenseMatrix< FieldMatrix< R, ROWS, COLS > > | |
CDune::FieldMatrix< R, 2, 3 > | |
CDune::FieldMatrix< R, 3, 4 > | |
CDune::FieldMatrix< R, 1, 2 > | |
CDune::FieldMatrix< R, 4, 5 > | |
►CDune::DenseMatrix< FieldMatrix< Real, ROWS, COLS > > | |
CDune::FieldMatrix< Real, dim, dimWorld > | |
CDune::FieldMatrix< Real, dimWorld, dim > | |
►CDune::DenseMatrix< FieldMatrix< RF, ROWS, COLS > > | |
CDune::FieldMatrix< RF, size, size > | |
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::DynamicVector< field_type > | |
►CDune::DenseVector< DynamicVector< K, std::allocator< K > > > | |
CDune::DynamicVector< K, Allocator > | Construct a vector with a dynamic size |
►CDune::DenseVector< FieldVector< ct, SIZE > > | |
CDune::FieldVector< ct, dim > | |
►CDune::DenseVector< FieldVector< ctype, SIZE > > | |
CDune::FieldVector< ctype, COLS > | |
CDune::FieldVector< ctype, dim > | |
CDune::FieldVector< ctype, coorddim > | |
CDune::FieldVector< ctype, coorddimension > | |
►CDune::DenseVector< FieldVector< D, SIZE > > | |
CDune::FieldVector< D, dim > | |
CDune::FieldVector< D, n > | |
►CDune::DenseVector< FieldVector< DF, SIZE > > | |
CDune::FieldVector< DF, COLS > | |
►CDune::DenseVector< FieldVector< double, SIZE > > | |
CDune::FieldVector< double, dw > | |
CDune::FieldVector< double, dimworld > | |
►CDune::DenseVector< FieldVector< F, SIZE > > | |
CDune::FieldVector< F, 1 > | |
CDune::FieldVector< F, d > | |
CDune::FieldVector< F, size > | |
►CDune::DenseVector< FieldVector< Field, SIZE > > | |
CDune::FieldVector< Field, dimension > | |
►CDune::DenseVector< FieldVector< int, SIZE > > | |
CDune::FieldVector< int, dimension > | |
►CDune::DenseVector< FieldVector< K, SIZE > > | |
CDune::FieldVector< K, sizeof...(Args)> | |
CDune::FieldVector< K, n > | |
CDune::FieldVector< K, COLS > | |
CDune::FieldVector< K, SIZE > | Vector space out of a tensor product of fields |
►CDune::DenseVector< FieldVector< R, SIZE > > | |
CDune::FieldVector< R, 3 > | |
CDune::FieldVector< R, COLS > | |
CDune::FieldVector< R, 4 > | |
CDune::FieldVector< R, 2 > | |
CDune::FieldVector< R, 5 > | |
►CDune::DenseVector< FieldVector< Real, SIZE > > | |
CDune::FieldVector< Real, COLS > | |
►CDune::DenseVector< FieldVector< RF, SIZE > > | |
CDune::FieldVector< RF, COLS > | |
►CDune::DenseVector< FieldVector< ScalarDeriv, SIZE > > | |
CDune::FieldVector< ScalarDeriv, dimR > | |
►CDune::DenseVector< FieldVector< ThisLFETensor, SIZE > > | |
CDune::FieldVector< ThisLFETensor, dimR > | |
CDune::DenseVector< ScalarVectorView< K > > | |
►CDune::Amg::DependencyParameters | Parameters needed to check whether a node depends on another |
►CDune::Amg::AggregationParameters | Parameters needed for the aggregation process |
►CDune::Amg::CoarseningParameters | Parameters for the complete coarsening process |
►CDune::Amg::Parameters | All parameters for AMG |
►CDune::Amg::Dependency< M, Norm > | |
►CDune::Amg::AggregationCriterion< Dependency< M, Norm > > | |
CDune::Amg::UnSymmetricCriterion< M, Norm > | Criterion suitable for unsymmetric matrices |
►CDune::Amg::SymmetricDependency< M, Norm > | |
►CDune::Amg::AggregationCriterion< SymmetricDependency< M, Norm > > | |
CDune::Amg::SymmetricCriterion< M, Norm > | Criterion taking advantage of symmetric matrices |
CDune::Amg::Dependency< M, N > | Dependency policy for symmetric matrices |
CDune::Amg::SymmetricDependency< M, N > | Dependency policy for symmetric matrices |
CDune::Amg::SymmetricMatrixDependency< M, N > | Dependency policy for symmetric matrices |
CDune::DGFBoundaryParameter | Contains types for additional features |
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 |
CDune::PDELab::vtk::DGFTreeCommonData< GFS, X, Pred > | Helper class for common data of a DGFTree |
CDune::DGFWriter< GV > | Write a GridView to a DGF file |
CDune::LegendreStuff::DGLegendreLocalBasis< D, R, k, d > | Lagrange shape functions of order k on the reference cube |
CDune::LegendreStuff::DGLegendreLocalBasis< Geometry::ctype, RF, k, d > | |
CDune::LegendreStuff::DGLegendreLocalInterpolation< D, R, k, d > | Determine degrees of freedom |
CDune::LegendreStuff::DGLegendreLocalInterpolation< Geometry::ctype, RF, k, d > | |
CDune::DGLocalCoefficients | A 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::Amg::FirstDiagonal | Norm that uses only the [0][0] entry of the block to determine couplings |
CDune::PDELab::lop::DiagonalJacobian | Decorator base class for local operators that have a diagonal jacobian matrix |
CDune::PDELab::DiagonalLocalMatrix< T, W > | A dense matrix for storing data associated with the degrees of freedom of a pair of LocalFunctionSpaces |
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::DiscreteCoordFunction< ct, dimR, Impl > | Derive an implementation of a discrete coordinate function from this class |
►CDune::DiscreteCoordFunctionInterface< CoordFunction::ctype, dimR, CachedCoordFunction< HostGrid, CoordFunction > > | |
CDune::DiscreteCoordFunction< CoordFunction::ctype, CoordFunction::dimRange, CachedCoordFunction< HostGrid, CoordFunction > > | |
CDune::Functions::DiscreteGlobalBasisFunction< B, V, NTRE, R > | A grid function induced by a global basis and a coefficient vector |
CDune::PDELab::DiscreteGridFunctionCurlTraits< GV, RangeFieldType, dimRangeOfBasis > | Helper class to calculate the Traits of DiscreteGridFunctionCurl |
CDune::PDELab::DiscreteGridViewFunction< GFS, V, diffOrder > | A discrete function defined over a GridFunctionSpace |
CDune::PDELab::DisjointPartitioningGatherScatter< RankIndex > | GatherScatter functor for creating a disjoint DOF partitioning |
CDune::PDELab::DisjointPartitioningGatherScatter< V::ElementType > | |
CDune::Std::disjunction< B > | Forms the logical disjunction of the type traits B.. |
CDune::PDELab::DOFDataCommunicationDescriptor< E, transmit_rank > | Communication descriptor for sending one item of type E per DOF |
CDune::PDELab::DOFDataCommunicationDescriptor< typename V::ElementType > | |
CDune::PDELab::DOFDataCommunicationDescriptor< V::ElementType, true > | |
CDune::PDELab::DOFIndex< T, tree_n, entity_n > | A multi-index representing a degree of freedom in a GridFunctionSpace |
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::PDELab::DummyDOFIndexIterator | Dummy iterator type over DOF indices |
CDune::Amg::AggregatesMap< V >::DummyEdgeVisitor | A Dummy visitor that does nothing for each visited edge |
►CDune::DuneBoundaryProjection< dimworld > | Interface class for vertex projection at the boundary |
CDune::BoundarySegmentWrapper< dim, dimworld > | |
CDune::DuneGridFormatParser | The DuneGridFormatParser class: reads a DGF file and stores build information in vector structures used by the MacroGrid class |
CDune::PDELab::ISTL::tags::dynamic_matrix | Tag describing a DynamicMatrix |
CDune::PDELab::ISTL::tags::dynamic_vector | Tag describing a DynamicVector |
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::DynamicPowerNodeTag | Tag designating a power node with runtime degree |
►CDune::TypeTree::DynamicTraversal | Mixin base class for visitors that only need a dynamic TreePath during traversal |
CDune::Functions::UniformNodeVisitor< CopyVisitor, leafOnly > | |
CDune::Functions::UniformNodeVisitor< DestroyVisitor, leafOnly > | |
CDune::Functions::UniformNodeVisitor< InitVisitor, leafOnly > | |
CDune::Functions::UniformNodeVisitor< SimpleNodeVisitorImp, leafOnly > | Mixin for visitors that should apply the same action on all nodes |
CDune::PDELab::PowerCompositeSetTimeVisitor< TT > | Visitor for Power- and CompositeGridFunctions calling the setTime() method on the leafs of the corresponding function trees |
CDune::Amg::SubGraph< G, T >::EdgeIndexMap | An index map for mapping the edges to indices |
CDune::Amg::MatrixGraph< M >::EdgeIteratorT< C > | Iterator over all edges starting from a vertex |
CDune::Amg::EdgeProperties | Class representing the properties of an ede in the matrix graph |
►CDune::EdgeS0_5Common< dim, DF > | Common base class for edge elements |
CDune::EdgeS0_5Coefficients< dim > | Coefficients for lowest order edge elements on simplices |
►CDune::EdgeS0_5Common< Geometry::mydimension, Geometry::ctype > | |
CDune::EdgeS0_5Basis< Geometry, RF > | Basis for order 0.5 (lowest order) edge elements on simplices |
►CDune::EdgeS0_5Common< Traits_::dimDomainLocal, Traits_::DomainField > | |
CDune::EdgeS0_5Interpolation< Geometry, typename Basis::Traits > | |
CDune::EdgeS0_5Interpolation< Geometry, Traits_ > | Interpolation for lowest order edge elements on simplices |
CDune::EdgeS0_5FiniteElement< Geometry, RF > | FiniteElement for lowest order edge elements on simplices |
CDune::PDELab::ElementGeometry< E > | Wrap element |
CDune::PDELab::ElementMapper< GV > | Class providing a consecutive index for codim 0 entities of a GridView |
CDune::Empty | Just an empty class |
CDune::EmptySet< TA > | An empty set |
CDune::EnableIfInterOperable< T1, T2, Type > | Enable typedef if two types are interoperable |
CDune::Simd::EndMark | Final element marker for RebindList |
►CDune::Entity< cd, dim, GridImp, EntityImp > | Wrapper class for entities |
CDune::MakeableInterfaceObject< Entity > | |
CDune::Entity< 0, dim, GridImp, EntityImp > | Template specialization of Dune::Entity for Elements (codim==0) |
►CDune::GeoGrid::EntityBase< codim, Grid, fake > | Actual implementation of the entity |
CDune::GeoGrid::Entity< codim, dim, Grid > | DUNE-conform 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::PDELab::EntityBlockedOrderingTag | Indicate blocking of the unknowns by grid entity |
CDune::PDELab::EntityDataCommunicationDescriptor< E, transmit_rank > | Communication descriptor for sending count items of type E per entity with attached DOFs |
CDune::PDELab::EntityDataCommunicationDescriptor< bool > | |
CDune::PDELab::EntityDataCommunicationDescriptor< V::ElementType > | |
►CDune::EntityDefaultImplementation< cd, dim, GridImp, EntityImp > | Default Implementations for EntityImp |
CDune::EntityDefaultImplementation< 0, dim, GridImp, EntityImp > | Default Implementations for EntityImp (Elements [cd=0]) |
►CDune::EntityDefaultImplementation< 0, dim, Grid, AlbertaGridEntity > | |
CDune::AlbertaGridEntity< 0, dim, Grid > | |
►CDune::EntityDefaultImplementation< 0, dim, GridImp, IdentityGridEntity > | |
CDune::IdentityGridEntity< 0, dim, GridImp > | Specialization for codim-0-entities |
CDune::EntityDefaultImplementation< 0, dim, GridImp, YaspEntity > | |
►CDune::EntityDefaultImplementation< codim, dim, Grid, AlbertaGridEntity > | |
CDune::AlbertaGridEntity< codim, dim, Grid > | |
►CDune::EntityDefaultImplementation< codim, dim, GridImp, IdentityGridEntity > | |
CDune::IdentityGridEntity< codim, dim, GridImp > | The implementation of entities in a IdentityGrid |
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::EntitySeed< GridImp, EntitySeedImp > | Store a reference to an entity with a minimal memory footprint |
CDune::Functions::Concept::EntitySet | Concept 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::QkStuff::EquidistantLagrangePolynomials< D, R, k > | Lagrange polynomials of degree k at equidistant points as a class |
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::exception | STL class |
►CDune::Exception | Base class for Dune-Exceptions |
CDune::GridError | Base class for exceptions in Dune grid modules |
CDune::HelpRequest | Exception thrown if the user wants to see help string |
►CDune::IOError | Default exception class for I/O errors |
CDune::CommPolicy< V >::CommunicationError | Error thrown if there was a problem with the communication |
CDune::DGFException | Exception class for IO errors in the DGF parser |
CDune::DebugStreamError | Standard exception for the debugstream |
►CDune::InvalidStateException | Default exception if a function was called while the object is not in a valid state for that function |
CDune::InvalidFutureException | This exception is thrown when ready() , wait() or get() is called on an invalid future. A future is valid until get() is called and if it is not default-constructed and it was not moved from |
CDune::InvalidIndexSetState | Exception indicating that the index set is not in the expected state |
►CDune::MathError | Default exception class for mathematical errors |
►CDune::FMatrixError | Error thrown if operations of a FieldMatrix fail |
CDune::MatrixBlockError | Error when performing an operation on a matrix block |
►CDune::ISTLError | Derive error class from the base class in common |
►CDune::BCRSMatrixError | Error specific to BCRSMatrix |
CDune::ImplicitModeCompressionBufferExhausted | Thrown when the compression buffer used by the implicit BCRSMatrix construction is exhausted |
CDune::SolverAbort | Thrown when a solver aborts due to some problem |
►CDune::NotImplemented | Default exception for dummy implementations |
CDune::QuadratureOrderOutOfRange | Exception thrown if a desired QuadratureRule is not available, because the requested order is to high |
►CDune::PDELab::Exception | Base class for all PDELab exceptions |
CDune::PDELab::ClockError | Exception thrown by clock functions |
►CDune::PDELab::FiniteElementMapError | General FiniteElementMap exception |
CDune::PDELab::InvalidGeometryType | FiniteElementMap exception raised when trying to obtain a finite element for an unsupported GeometryType |
CDune::PDELab::VariableElementSize | FiniteElementMap exception concerning the computation of the FiniteElementMap size |
►CDune::PDELab::GridFunctionSpaceError | GridFunctionSpace-related error |
CDune::PDELab::GridFunctionSpaceHierarchyError | |
CDune::PDELab::UninitializedGridFunctionSpaceError | Called a GridFunctionSpace method that requires initialization of the space |
►CDune::PDELab::OrderingError | Ordering-related error |
CDune::PDELab::ChunkedBlockOrderingSizeError | The block size of a ChunkedBlockOrdering does not divide the block count of the underlying ordering |
CDune::PDELab::OrderingStructureError | Error related to the logical structure of an Ordering |
CDune::PDELab::PermutedOrderingSizeError | A PermutedOrdering got a permutation vector of the wrong size |
►CDune::ParallelError | Default exception if an error in the parallel communication of the program occurred |
CDune::MPIGuardError | This exception is thrown if the MPIGuard detects an error on a remote process |
►CDune::RangeError | Default exception class for range errors |
CDune::ParameterTreeParserError | Report parser error while reading ParameterTree |
►CDune::SystemError | Default exception class for OS errors |
CDune::OutOfMemoryError | Default exception if memory allocation fails |
CDune::TypeTree::Exception | Base class for all TypeTree exceptions |
CDune::ExceptionHook | Base class to add a hook to the Dune::Exception |
CDune::PDELab::ExplicitOneStepMethod< T, IGOS, LS, TrlV, TstV, TC > | Do one step of an explicit time-stepping scheme |
CDune::Factorial< m > | Calculates the factorial of m at compile time |
CDune::Factorial< 0 > | End of recursion of factorial via specialization |
CDune::FakeMPIHelper | A fake mpi helper |
CDune::PDELab::FastDGAssembler< GFSU, GFSV, CU, CV, nonoverlapping_mode > | The fast DG assembler for standard DUNE grid |
CDune::PDELab::FastDGAssembler< GFSU, GFSV, Dune::PDELab::EmptyTransformation, Dune::PDELab::EmptyTransformation > | |
CDune::PDELab::FastDGGridOperator< GFSU, GFSV, LOP, MB, DF, RF, JF, CU, CV > | |
CDune::PDELab::Experimental::GridFunctionSpace< DFBasis, VBE, CE >::Traits::FEM | Rudimentary internal implementation of a FiniteElementMap |
►CDune::PDELab::ISTL::tags::field_matrix | Tag describing an arbitrary FieldMatrix |
CDune::PDELab::ISTL::tags::field_matrix_1_1 | Tag describing a FieldMatrix with row block size 1 and column block size 1 |
CDune::PDELab::ISTL::tags::field_matrix_1_m | Tag describing a FieldMatrix with row block size 1 and column block size > 1 |
CDune::PDELab::ISTL::tags::field_matrix_n_1 | Tag describing a FieldMatrix with row block size > 1 and column block size 1 |
CDune::PDELab::ISTL::tags::field_matrix_n_m | Tag describing a FieldMatrix with row block size > 1 and column block size > 1 |
►CDune::PDELab::ISTL::tags::field_matrix_1_any | Tag describing a FieldMatrix with row block size 1 and arbitrary column block size |
CDune::PDELab::ISTL::tags::field_matrix_1_1 | Tag describing a FieldMatrix with row block size 1 and column block size 1 |
CDune::PDELab::ISTL::tags::field_matrix_1_m | Tag describing a FieldMatrix with row block size 1 and column block size > 1 |
►CDune::PDELab::ISTL::tags::field_matrix_any_1 | Tag describing a FieldMatrix with arbitrary row block size and column block size 1 |
CDune::PDELab::ISTL::tags::field_matrix_1_1 | Tag describing a FieldMatrix with row block size 1 and column block size 1 |
CDune::PDELab::ISTL::tags::field_matrix_n_1 | Tag describing a FieldMatrix with row block size > 1 and column block size 1 |
►CDune::PDELab::ISTL::tags::field_matrix_any_m | Tag describing a FieldMatrix with arbitrary row block size and column block size > 1 |
CDune::PDELab::ISTL::tags::field_matrix_1_m | Tag describing a FieldMatrix with row block size 1 and column block size > 1 |
CDune::PDELab::ISTL::tags::field_matrix_n_m | Tag describing a FieldMatrix with row block size > 1 and column block size > 1 |
►CDune::PDELab::ISTL::tags::field_matrix_n_any | Tag describing a FieldMatrix with row block size > 1 and arbitrary column block size |
CDune::PDELab::ISTL::tags::field_matrix_n_1 | Tag describing a FieldMatrix with row block size > 1 and column block size 1 |
CDune::PDELab::ISTL::tags::field_matrix_n_m | Tag describing a FieldMatrix with row block size > 1 and column block size > 1 |
►CDune::PDELab::ISTL::tags::field_vector | Tag describing an arbitrary FieldVector |
CDune::PDELab::ISTL::tags::field_vector_1 | Tag describing a field vector with block size 1 |
CDune::PDELab::ISTL::tags::field_vector_n | Tag describing a field vector with block size > 1 |
CDune::VTK::FieldInfo | Descriptor 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::ScalarLocalToGlobalFiniteElementAdaptorFactory< LagrangeCubeLocalFiniteElement< Geometry::ctype, RF, Geometry::mydimension, 1 >, Geometry > | |
CDune::Q1FiniteElementFactory< Geometry, RF > | Factory for global-valued Q1 elements |
►CDune::ScalarLocalToGlobalFiniteElementAdaptorFactory< std::conditional< Geometry::mydimension==1, PkLocalFiniteElement< Geometry::ctype, RF, 1, 2 >, QkLocalFiniteElement< Geometry::ctype, RF, Geometry::mydimension, 2 > >::type, Geometry > | |
CDune::Q2FiniteElementFactory< Geometry, RF > | Factory for global-valued Q23D elements |
►CDune::ScalarLocalToGlobalFiniteElementAdaptorFactory< QkDGLagrangeLocalFiniteElement< Geometry::ctype, RF, k, Geometry::mydimension >, Geometry > | |
CDune::QkDGFiniteElementFactory< Geometry, RF, k > | Factory for global-valued QkDG elements |
►CDune::ScalarLocalToGlobalFiniteElementAdaptorFactory< QkDGGLLocalFiniteElement< Geometry::ctype, RF, k, Geometry::mydimension >, Geometry > | |
CDune::QkDGGLFiniteElementFactory< Geometry, RF, k > | Factory for global-valued QkDG elements |
►CDune::ScalarLocalToGlobalFiniteElementAdaptorFactory< QkDGLegendreLocalFiniteElement< Geometry::ctype, RF, k, Geometry::mydimension >, Geometry > | |
CDune::QkDGLegendreFiniteElementFactory< Geometry, RF, k > | Factory for global-valued DGLegendre elements |
CDune::EdgeS0_5FiniteElementFactory< Geometry, RF > | Factory for EdgeS0_5FiniteElement objects |
CDune::MonomialFiniteElementFactory< Geometry, RF, p > | Factory for global-valued MonomFiniteElement objects |
CDune::Pk1DFiniteElementFactory< Geometry, RF, k > | Factory for Pk1DFiniteElement objects |
CDune::Pk2DFiniteElementFactory< Geometry, RF, k > | Factory for Pk2DFiniteElement objects |
CDune::ScalarLocalToGlobalFiniteElementAdaptorFactory< LocalFiniteElement, Geometry > | Factory for ScalarLocalToGlobalFiniteElementAdaptor objects |
►CDune::FiniteElementInterface | Interface for global-valued finite elements |
CDune::Pk1DFiniteElement< Geometry, RF, k > | Langrange finite element of arbitrary order on triangles |
CDune::Pk2DFiniteElement< Geometry, RF, k > | Langrange finite element of arbitrary order on triangles |
CDune::ScalarLocalToGlobalFiniteElementAdaptor< LocalFiniteElement, Geometry > | Convert a simple scalar local finite element into a global finite element |
CDune::FiniteElementInterfaceSwitch< FiniteElement, Dummy > | Switch for uniform treatment of finite element with either the local or the global interface |
►CDune::PDELab::FiniteElementMapTraits< T > | Collect types exported by a finite element map |
CDune::PDELab::LocalFiniteElementMapTraits< T > | Collect types exported by a finite element map |
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::FirstTypeIndex< Tuple, T, start > | Find the first occurrence of a type in a std::tuple |
CDune::PDELab::FlatContainerAllocationTag | |
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::VTK::BoundaryIterator< GV > | Iterate over the GridViews boundary intersections |
CDune::ForwardIteratorFacade< const_iterator, const Matrix::row_type > | |
►CDune::ForwardIteratorFacade< CornerIterator, const Entity, EntityReference, int > | |
CDune::VTKWriter< GridView >::CornerIterator | Iterate over the elements' corners |
►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::VTK::CornerIterator< CellIterator > | Iterate over the corners of some cell range |
►CDune::ForwardIteratorFacade< iterator, const size_type > | |
CDune::PDELab::ISTL::BCRSPattern< RowOrdering, ColOrdering >::iterator | Iterator over all column indices for a given row, unique but in arbitrary order |
►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::VTK::PointIterator< CellIterator, IS > | Iterate over the points of some corner range |
►CDune::ForwardIteratorFacade< SLListConstIterator< T, A >, const T, const T &, std::size_t > | |
CDune::SLListConstIterator< T, A > | A constant iterator for the SLList |
►CDune::ForwardIteratorFacade< SLListIterator< RemoteIndex, Allocator >, RemoteIndex, RemoteIndex &, std::size_t > | |
CDune::SLListIterator< RemoteIndex, Allocator > | |
►CDune::ForwardIteratorFacade< SLListIterator< T, A >, T, T &, std::size_t > | |
CDune::SLListIterator< T, A > | A mutable iterator for the SLList |
►CDune::ForwardIteratorFacade< SLListModifyIterator< RemoteIndex, Allocator >, RemoteIndex, RemoteIndex &, std::size_t > | |
CDune::SLListModifyIterator< RemoteIndex, Allocator > | |
►CDune::ForwardIteratorFacade< SLListModifyIterator< T, A >, T, T &, std::size_t > | |
CDune::SLListModifyIterator< T, A > | A mutable iterator for the SLList |
►CDune::ForwardIteratorFacade< VertexIterator, const Entity, EntityReference, int > | |
CDune::VTKWriter< GridView >::VertexIterator | Iterate over the grid's vertices |
►CDune::ForwardIteratorFacade< VertexIterator, const VertexDescriptor > | |
CDune::Amg::SubGraph< G, T >::VertexIterator | The vertex iterator of the graph |
CDune::PDELab::FullBoundaryPattern | Sparsity pattern generator |
►CDune::PDELab::FullSkeletonPattern | Sparsity pattern generator |
CDune::PDELab::ConvectionDiffusionCCFV< TP > | |
CDune::PDELab::ConvectionDiffusionDG< T, FiniteElementMap > | |
CDune::PDELab::DGLinearAcousticsSpatialOperator< T, FEM > | |
CDune::PDELab::DGMaxwellSpatialOperator< T, FEM > | Spatial local operator for discontinuous Galerkin method for Maxwells Equations |
CDune::PDELab::DGNavierStokes< PRM > | A local operator for solving the Navier-Stokes equations using a DG discretization |
CDune::PDELab::DGNavierStokesVelVecFEM< PRM > | A local operator for solving the Navier-Stokes equations using a DG discretization and a vector-valued finite element map for the velocity grid function space |
CLOP_spatial_contaminant< Param, GFSF, ZF, GFSC, ZC, convection > | |
CLOP_spatial_flow< Param > | |
►CDune::PDELab::FullVolumePattern | Sparsity pattern generator |
►CDune::PDELab::BlockDiagonalLocalOperatorFullCoupling< impl::ScalarL2 > | |
CDune::PDELab::L2 | |
CDune::PDELab::BlockDiagonalLocalOperatorFullCoupling< ScalarLOP > | Block diagonal extension of scalar local operator |
CDune::PDELab::BlockSORPreconditionerLocalOperator< JacobianLOP, BlockOffDiagonalLOP, GridFunctionSpace > | Turn a matrix-free Jacobi-type local preconditioner to a SOR one |
CDune::PDELab::ConvectionDiffusionCCFV< TP > | |
CDune::PDELab::ConvectionDiffusionCCFVTemporalOperator< TP > | |
CDune::PDELab::ConvectionDiffusionDG< T, FiniteElementMap > | |
CDune::PDELab::ConvectionDiffusionFEM< T, FiniteElementMap > | |
CDune::PDELab::DGLinearAcousticsSpatialOperator< T, FEM > | |
CDune::PDELab::DGMaxwellSpatialOperator< T, FEM > | Spatial local operator for discontinuous Galerkin method for Maxwells Equations |
CDune::PDELab::DGNavierStokes< PRM > | A local operator for solving the Navier-Stokes equations using a DG discretization |
CDune::PDELab::DGNavierStokesVelVecFEM< PRM > | A local operator for solving the Navier-Stokes equations using a DG discretization and a vector-valued finite element map for the velocity grid function space |
CDune::PDELab::Electrodynamic_S< Mu > | Contruct matrix S for the Electrodynamic operator |
CDune::PDELab::Electrodynamic_T< Eps > | Construct matrix T for the Electrodynamic operator |
CDune::PDELab::IterativeBlockJacobiPreconditionerLocalOperator< BlockDiagonalLocalOperator, PointDiagonalLocalOperator, GridFunctionSpace, DomainField, IterativeSolver > | Local operator that can be used to create a fully matrix-free Jacobi preconditioner |
CDune::PDELab::LinearElasticity< T > | |
CDune::PDELab::NavierStokesMass< PRM > | A local operator for the mass term corresponding to the instationary part in the Navier-Stokes equations |
CDune::PDELab::NavierStokesVelVecMass< PRM > | A local operator for the mass term corresponding to the instationary part in the Navier-Stokes equations using a vector-valued Finite Element map for the velocity grid function space |
CDune::PDELab::NonLinearConvectionDiffusionFEM< T > | |
CDune::PDELab::TaylorHoodNavierStokes< P > | A local operator for the Navier-Stokes equations |
CDune::PDELab::TwoPhaseOnePointTemporalOperator< TP > | |
CLOP_spatial_contaminant< Param, GFSF, ZF, GFSC, ZC, convection > | |
CLOP_spatial_flow< Param > | |
CDune::Function< Domain, Range > | Base class template for function classes |
►CDune::Function< const Domain &, Range & > | |
CDune::VirtualFunction< Domain, Range > | |
►CDune::Function< const DomainType &, RangeType & > | |
CDune::VirtualFunction< DomainType, RangeType > | Virtual base class template for function classes |
CDune::Functions::FunctionFromCallable< Range(Domain), F, FunctionInterface > | Wrap a callable object as Dune::Function or Dune::VirtualFunction |
CDune::PDELab::FunctionInterface< T, Imp > | Function that maps x in DomainType to y in RangeType |
►CDune::PDELab::FunctionInterface< FunctionTraits< GF::Traits::GridViewType::ctype, GF::Traits::GridViewType::dimensionworld, Dune::FieldVector< GF::Traits::GridViewType::ctype, GF::Traits::GridViewType::dimensionworld >, GF::Traits::RangeFieldType, GF::Traits::dimRange, Dune::FieldVector< GF::Traits::RangeFieldType, GF::Traits::dimRange > >, GridFunctionToFunctionAdapter< GF > > | |
CDune::PDELab::GridFunctionToFunctionAdapter< GF > | Make a Function from a GridFunction |
►CDune::PDELab::FunctionInterface< FunctionTraits< T::Traits::DomainFieldType, T::Traits::dimDomain, T::Traits::DomainType, T::Traits::RangeFieldType, 1, Dune::FieldVector< T::Traits::RangeFieldType, 1 > >, SelectComponentAdapter< T > > | |
CDune::PDELab::SelectComponentAdapter< T > | Function maps x in DomainType to y in RangeType |
►CDune::PDELab::FunctionInterface< T::Traits, GlobalFunctionToLocalFunctionAdapter< T, E > > | |
CDune::PDELab::GlobalFunctionToLocalFunctionAdapter< T, E > | Make a Function in local coordinates from a Function in global coordinates |
►CDune::PDELab::FunctionInterface< T::Traits, GridFunctionToLocalFunctionAdapter< T > > | |
CDune::PDELab::GridFunctionToLocalFunctionAdapter< T > | Make a LocalFunction from a GridFunction using local coordinates |
CDune::PDELab::FunctionTraits< DF, n, D, RF, m, R > | |
►CDune::PDELab::FunctionTraits< GV::Grid::ctype, GV::dimension, Dune::FieldVector< GV::Grid::ctype, GV::dimension >, RangeFieldType, m, FieldVector< RangeFieldType, 1 > > | |
►CDune::PDELab::GridFunctionTraits< GV, RangeFieldType, 1, FieldVector< RangeFieldType, 1 > > | |
CDune::PDELab::DiscreteGridFunctionCurlTraits< GV, RangeFieldType, 2 > | Helper class to calculate the Traits of DiscreteGridFunctionCurl (2D) |
►CDune::PDELab::FunctionTraits< GV::Grid::ctype, GV::dimension, Dune::FieldVector< GV::Grid::ctype, GV::dimension >, RangeFieldType, m, FieldVector< RangeFieldType, 2 > > | |
►CDune::PDELab::GridFunctionTraits< GV, RangeFieldType, 2, FieldVector< RangeFieldType, 2 > > | |
CDune::PDELab::DiscreteGridFunctionCurlTraits< GV, RangeFieldType, 1 > | Helper class to calculate the Traits of DiscreteGridFunctionCurl (1D) |
►CDune::PDELab::FunctionTraits< GV::Grid::ctype, GV::dimension, Dune::FieldVector< GV::Grid::ctype, GV::dimension >, RangeFieldType, m, FieldVector< RangeFieldType, 3 > > | |
►CDune::PDELab::GridFunctionTraits< GV, RangeFieldType, 3, FieldVector< RangeFieldType, 3 > > | |
CDune::PDELab::DiscreteGridFunctionCurlTraits< GV, RangeFieldType, 3 > | Helper class to calculate the Traits of DiscreteGridFunctionCurl (3D) |
►CDune::PDELab::FunctionTraits< GV::Grid::ctype, GV::dimension, Dune::FieldVector< GV::Grid::ctype, GV::dimension >, RF, m, Dune::FieldVector< RF, m > > | |
►CDune::PDELab::GridFunctionTraits< GV, RF, m, Dune::FieldVector< RF, m > > | |
CDune::PDELab::AnalyticGridFunctionTraits< GV, RF, m > | Function signature for analytic functions on a grid |
►CDune::PDELab::FunctionTraits< GV::Grid::ctype, GV::dimension, Dune::FieldVector< GV::Grid::ctype, GV::dimension >, RF, m, R > | |
CDune::PDELab::GridFunctionTraits< GV, RF, m, R > | Traits class holding the function signature, same as in local function |
►CDune::PDELab::FunctionTraits< GV::Grid::ctype, GV::dimension-1, Dune::FieldVector< GV::Grid::ctype, GV::dimension-1 >, RF, m, R > | |
CDune::PDELab::BoundaryGridFunctionTraits< GV, RF, m, R > | Traits class holding function signature, same as in local function |
►CDune::VTKWriter< GridView >::VTKLocalFunction::FunctionWrapperBase | Base class for polymorphic container of underlying data set |
CDune::VTKWriter< GridView >::VTKLocalFunction::FunctionWrapper< F > | Type erasure implementation for functions conforming to the dune-functions LocalFunction interface |
CDune::VTKWriter< GridView >::VTKLocalFunction::GlobalFunctionWrapper< F > | Type erasure implementation for C++ functions, i.e., functions that can be evaluated in global coordinates |
CDune::VTKWriter< GridView >::VTKLocalFunction::VTKFunctionWrapper | Type erasure implementation for legacy VTKFunctions |
CDune::VTK::FunctionWriterBase< Cell_ > | Base class for function writers |
►CDune::VTK::FunctionWriterBase< Cell > | |
CDune::VTK::CoordinatesWriter< Cell > | Writer for the Coordinates array |
CDune::VTK::NonConformingConnectivityWriter< Cell > | Writer for the connectivity array in nonconforming mode |
CDune::VTK::OffsetsWriter< Cell > | Writer for the offsets array |
CDune::VTK::TypesWriter< Cell > | Writer for the types array |
►CDune::VTK::FunctionWriterBase< Func::Entity > | |
CDune::VTK::VTKFunctionWriter< Func > | Base class for function writers |
►CDune::VTK::FunctionWriterBase< Func::Traits::Cell > | |
CDune::VTK::SkeletonFunctionWriter< Func > | Function writer for skeleton functions |
►CDune::VTK::FunctionWriterBase< IteratorFactory::Cell > | |
CDune::VTK::ConformingConnectivityWriter< IteratorFactory > | Writer for the connectivity array in conforming mode |
CDune::Future< T > | Type-erasure for future-like objects. A future-like object is a object satisfying the interface of FutureBase |
CDune::Future< void > | |
CDune::QkStuff::GaussLobattoLagrangePolynomials< D, R, k > | Lagrange polynomials at Gauss-Lobatto points |
CDune::QkStuff::GaussLobattoLagrangePolynomials< double, double, k > | |
CDune::QkStuff::GaussLobattoLagrangePolynomials< Geometry::ctype, RF, k > | |
CDune::Gcd< a, b > | Calculator of the greatest common divisor |
CDune::GeneralVertexOrder< dim, Index_ > | Class providing information on the ordering of vertices |
CGenericEllipticProblem< GV, RF > | |
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::DGLocalFiniteElement< FE > | Takes the basis and interpolation factory from a given LocalFiniteElement (derived from GenericLocalFiniteElement) and replaces the coefficients with dg local keys, i.e., attaches all degrees of freedom to the codimension zero entity |
►CDune::GenericLocalFiniteElement< FE::BasisFactory, DGLocalCoefficientsFactory< FE::BasisFactory >, LocalL2InterpolationFactory< FE::BasisFactory, false > > | |
CDune::L2LocalFiniteElement< FE > | Takes the basis factory from a given LocalFiniteElement (derived from GenericLocalFiniteElement) and replaces the coefficients with dg local keys, i.e., attaches all degrees of freedom to the codimension zero entity and uses a l2 interpolation |
►CDune::GenericLocalFiniteElement< LagrangeBasisFactory< EquidistantPointSet, dimDomain, R, R >, LagrangeCoefficientsFactory< EquidistantPointSet, dimDomain, R >, LagrangeInterpolationFactory< EquidistantPointSet, dimDomain, R > > | |
►CDune::LagrangeLocalFiniteElement< EquidistantPointSet, 1, D, R > | |
CDune::Pk1dLocalFiniteElement< D, R > | Define the Pk Lagrange basis functions in 1d on the reference interval |
►CDune::GenericLocalFiniteElement< LagrangeBasisFactory< LP, dimDomain, R, R >, LagrangeCoefficientsFactory< LP, dimDomain, R >, LagrangeInterpolationFactory< LP, dimDomain, R > > | |
CDune::LagrangeLocalFiniteElement< LP, dimDomain, D, R, SF, CF > | Lagrange local finite elements for a given set of interpolation points |
►CDune::GenericLocalFiniteElement< OrthonormalBasisFactory< dimDomain, R, R >, DGLocalCoefficientsFactory< OrthonormalBasisFactory< dimDomain, R, R > >, LocalL2InterpolationFactory< OrthonormalBasisFactory< dimDomain, R, R >, true > > | |
CDune::OrthonormalLocalFiniteElement< dimDomain, D, R, SF, CF > | A class providing orthonormal basis functions |
►CDune::GenericLocalFiniteElement< RaviartThomasBasisFactory< dimDomain, R, R >, RaviartThomasCoefficientsFactory< dimDomain >, RaviartThomasL2InterpolationFactory< dimDomain, R > > | |
CDune::RaviartThomasSimplexLocalFiniteElement< dimDomain, D, R, SF, CF > | Raviart-Thomas local finite elements of arbitrary order for simplices of arbitrary dimension |
CDune::Geometry< mydim, cdim, GridImp, GeometryImp > | Wrapper class for geometries |
CDune::GeometryDefaultImplementation< mydim, cdim, GridImp, GeometryImp > | Default implementation for class Geometry |
CDune::GeometryDefaultImplementation< mydim, coorddim, GridImp, IdentityGridGeometry > | |
CDune::PDELab::GeometryFiniteElementMap< Factory > | Generic finite element map for global finite elements created with a geometry |
►CDune::PDELab::GeometryFiniteElementMap< MonomialFiniteElementFactory< Geometry, RF, p > > | |
CDune::PDELab::MonomFiniteElementMap< Geometry, RF, p > | Global-valued finite element map for Monom elements |
CDune::GeometryGrid< HostGrid, CoordFunction, Allocator > | Grid wrapper replacing the geometries |
CDune::GeometryType | Unique label for each type of entities that can occur in DUNE grids |
CDune::PDELab::GeometryVertexOrderFiniteElementMap< FEFactory, VOFactory > | Generic finite element map for global finite elements created with a geometry and a vertex ordering |
►CDune::PDELab::GeometryVertexOrderFiniteElementMap< EdgeS0_5FiniteElementFactory< Geometry, RF >, VertexOrderFactory > | |
CDune::PDELab::EdgeS0_5FiniteElementMap< Geometry, VertexOrderFactory, RF > | Global-valued finite element map for EdgeS0_5 elements |
CDune::PDELab::GhostGatherScatter | GatherScatter functor for marking ghost DOFs |
CGlobalBasisMoc< dim > | A Dummy global basis |
CDune::GlobalGeometryTypeIndex | Compute 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::GmshReaderOptions | Options 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::LeafGnuplotWriter< G > | GnuplotWriter on the leaf grid |
►CDune::GnuplotWriter< G::LevelGridView > | |
CDune::LevelGnuplotWriter< G > | GnuplotWriter on a given level grid |
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::GridDefaultImplementation< dim, dimworld, ct, GridFamily > | |
►CDune::Grid< dim, dimworld, Alberta::Real, AlbertaGridFamily< dim, Alberta::dimWorld > > | |
►CDune::GridDefaultImplementation< dim, Alberta::dimWorld, Alberta::Real, AlbertaGridFamily< dim, Alberta::dimWorld > > | |
CDune::AlbertaGrid< dim, dimworld > | [ provides Dune::Grid ] |
►CDune::Grid< dim, dimworld, Alberta::Real, AlbertaGridFamily< dim, dimworld > > | |
►CDune::GridDefaultImplementation< dim, dimworld, Alberta::Real, AlbertaGridFamily< dim, dimworld > > | |
CDune::AlbertaGrid< dim, dimworld > | |
►CDune::Grid< dim, dimworld, Coordinates::ctype, YaspGridFamily< dim, CoordCont > > | |
►CDune::GridDefaultImplementation< dim, dim, Coordinates::ctype, YaspGridFamily< dim, CoordCont > > | |
CDune::YaspGrid< dim, CoordCont > | |
►CDune::Grid< dim, dimworld, Coordinates::ctype, YaspGridFamily< dim, EquidistantCoordinates< double, dim > > > | |
►CDune::GridDefaultImplementation< dim, dim, Coordinates::ctype, YaspGridFamily< dim, EquidistantCoordinates< double, dim > > > | |
CDune::YaspGrid< dim, EquidistantCoordinates< double, dim > > | |
CDune::YaspGrid< dim, Coordinates > | [ provides Dune::Grid ] |
►CDune::Grid< dim, dimworld, double, UGGridFamily< dim > > | |
►CDune::GridDefaultImplementation< dim, dim, double, UGGridFamily< dim > > | |
CDune::UGGrid< dimworld > | |
CDune::UGGrid< dim > | Front-end for the grid manager of the finite element toolbox UG3 |
►CDune::Grid< dim, dimworld, HostGrid::ctype, IdentityGridFamily< HostGrid::dimension, HostGrid > > | |
►CDune::GridDefaultImplementation< HostGrid::dimension, HostGrid::dimensionworld, HostGrid::ctype, IdentityGridFamily< HostGrid::dimension, HostGrid > > | |
CDune::IdentityGrid< HostGrid > | Provides a meta grid that is identical to its host |
►CDune::Grid< dim, dimworld, OneDGridGeometry< 0, 1, OneDGrid >::ctype, OneDGridFamily > | |
►CDune::GridDefaultImplementation< 1, 1, OneDGridGeometry< 0, 1, OneDGrid >::ctype, OneDGridFamily > | |
CDune::OneDGrid | One-dimensional adaptive grid |
CDune::PDELab::GridAdaptor< Grid, GFSU, U, Projection > | Class for automatic adaptation of the grid |
►CDune::GridFactoryInterface< GridType > | Provide a generic factory class for unstructured grids |
CDune::GridFactory< GridType > | Provide a generic factory class for unstructured grids |
►CDune::GridFactoryInterface< AlbertaGrid< dim, dimworld > > | |
CDune::GridFactory< AlbertaGrid< dim, dimworld > > | Specialization of the generic GridFactory for AlbertaGrid |
►CDune::GridFactoryInterface< Grid > | |
CDune::GridFactory< Grid > | |
►CDune::GridFactoryInterface< UGGrid< dimworld > > | |
CDune::GridFactory< UGGrid< dimworld > > | Specialization of the generic GridFactory for UGGrid |
►CDune::PDELab::GridFunctionOutputParameters | Mixin base class for specifying output hints to I/O routines like VTK |
CDune::PDELab::Experimental::GridFunctionSpace< DFBasis, V, CE > | |
►CDune::PDELab::GridFunctionInterface< Dune::PDELab::GridFunctionTraits< PL::Traits::GridViewType, PL::Traits::RangeFieldType, PL::Traits::GridViewType::dimension, Dune::FieldVector< PL::Traits::RangeFieldType, PL::Traits::GridViewType::dimension > >, DarcyVelocityFromHeadCCFV< T, PL > > | |
►CDune::PDELab::GridFunctionBase< Dune::PDELab::GridFunctionTraits< PL::Traits::GridViewType, PL::Traits::RangeFieldType, PL::Traits::GridViewType::dimension, Dune::FieldVector< PL::Traits::RangeFieldType, PL::Traits::GridViewType::dimension > >, DarcyVelocityFromHeadCCFV< T, PL > > | |
CDarcyVelocityFromHeadCCFV< T, PL > | Provide velocity field for liquid phase |
►CDune::PDELab::GridFunctionInterface< Dune::PDELab::GridFunctionTraits< T::Traits::GridViewType, T::Traits::FiniteElementType::Traits::LocalBasisType ::Traits::RangeFieldType, T::Traits::FiniteElementType::Traits::LocalBasisType::Traits ::dimDomain, Dune::FieldVector< T::Traits::FiniteElementType::Traits ::LocalBasisType::Traits::RangeFieldType, T::Traits::FiniteElementType::Traits::LocalBasisType::Traits ::dimDomain > >, DarcyVelocityFromHeadFEM< P, T, X > > | |
►CDune::PDELab::GridFunctionBase< Dune::PDELab::GridFunctionTraits< T::Traits::GridViewType, T::Traits::FiniteElementType::Traits::LocalBasisType ::Traits::RangeFieldType, T::Traits::FiniteElementType::Traits::LocalBasisType::Traits ::dimDomain, Dune::FieldVector< T::Traits::FiniteElementType::Traits ::LocalBasisType::Traits::RangeFieldType, T::Traits::FiniteElementType::Traits::LocalBasisType::Traits ::dimDomain > >, DarcyVelocityFromHeadFEM< P, T, X > > | |
CDarcyVelocityFromHeadFEM< P, T, X > | Provide Darcy velocity as a vector-valued grid function |
►CDune::PDELab::GridFunctionInterface< Dune::PDELab::GridFunctionTraits< T::Traits::GridViewType, T::Traits::RangeFieldType, T::Traits::dimDomain, Dune::FieldVector< T::Traits::RangeFieldType, T::Traits::dimDomain > >, DiagonalPermeabilityAdapter< T > > | |
►CDune::PDELab::GridFunctionBase< Dune::PDELab::GridFunctionTraits< T::Traits::GridViewType, T::Traits::RangeFieldType, T::Traits::dimDomain, Dune::FieldVector< T::Traits::RangeFieldType, T::Traits::dimDomain > >, DiagonalPermeabilityAdapter< T > > | |
CDiagonalPermeabilityAdapter< T > | |
►CDune::PDELab::GridFunctionInterface< T, AnalyticGridFunctionBase< T, Imp > > | |
►CDune::PDELab::GridFunctionBase< T, AnalyticGridFunctionBase< T, Imp > > | |
CDune::PDELab::AnalyticGridFunctionBase< T, Imp > | Analytic grid function |
►CDune::PDELab::GridFunctionInterface< AnalyticGridFunctionTraits< GV, RF, 1 >, AnalyticGridFunctionBase< AnalyticGridFunctionTraits< GV, RF, 1 >, ConstGridFunction< GV, RF, 1 > > > | |
►CDune::PDELab::GridFunctionBase< AnalyticGridFunctionTraits< GV, RF, 1 >, AnalyticGridFunctionBase< AnalyticGridFunctionTraits< GV, RF, 1 >, ConstGridFunction< GV, RF, 1 > > > | |
►CDune::PDELab::AnalyticGridFunctionBase< AnalyticGridFunctionTraits< GV, RF, 1 >, ConstGridFunction< GV, RF, 1 > > | |
CDune::PDELab::ConstGridFunction< GV, RF, dimR > | GridFunction returning a constant value everywhere |
►CDune::PDELab::GridFunctionInterface< Dune::PDELab::GridFunctionTraits< T::Traits::GridViewType, T::Traits::RangeFieldType, 1, Dune::FieldVector< T::Traits::RangeFieldType, 1 > >, ConvectionDiffusionDirichletExtensionAdapter< T > > | |
►CDune::PDELab::GridFunctionBase< Dune::PDELab::GridFunctionTraits< T::Traits::GridViewType, T::Traits::RangeFieldType, 1, Dune::FieldVector< T::Traits::RangeFieldType, 1 > >, ConvectionDiffusionDirichletExtensionAdapter< T > > | |
CDune::PDELab::ConvectionDiffusionDirichletExtensionAdapter< T > | |
►CDune::PDELab::GridFunctionInterface< Dune::PDELab::GridFunctionTraits< T::Traits::GridViewType, T::Traits::RangeFieldType, T::Traits::GridViewType::dimension, Dune::FieldVector< T::Traits::RangeFieldType, T::Traits::GridViewType::dimension > >, ConvectionDiffusionExactGradientAdapter< T > > | |
►CDune::PDELab::GridFunctionBase< Dune::PDELab::GridFunctionTraits< T::Traits::GridViewType, T::Traits::RangeFieldType, T::Traits::GridViewType::dimension, Dune::FieldVector< T::Traits::RangeFieldType, T::Traits::GridViewType::dimension > >, ConvectionDiffusionExactGradientAdapter< T > > | |
CDune::PDELab::ConvectionDiffusionExactGradientAdapter< T > | |
►CDune::PDELab::GridFunctionInterface< Dune::PDELab::AnalyticGridFunctionTraits< T::Traits::GridViewType, T::Traits::RangeFieldType, T::Traits::GridViewType::dimension >, AnalyticGridFunctionBase< Dune::PDELab::AnalyticGridFunctionTraits< T::Traits::GridViewType, T::Traits::RangeFieldType, T::Traits::GridViewType::dimension >, ConvectionDiffusionVelocityExtensionAdapter< T > > > | |
►CDune::PDELab::GridFunctionBase< Dune::PDELab::AnalyticGridFunctionTraits< T::Traits::GridViewType, T::Traits::RangeFieldType, T::Traits::GridViewType::dimension >, AnalyticGridFunctionBase< Dune::PDELab::AnalyticGridFunctionTraits< T::Traits::GridViewType, T::Traits::RangeFieldType, T::Traits::GridViewType::dimension >, ConvectionDiffusionVelocityExtensionAdapter< T > > > | |
►CDune::PDELab::AnalyticGridFunctionBase< Dune::PDELab::AnalyticGridFunctionTraits< T::Traits::GridViewType, T::Traits::RangeFieldType, T::Traits::GridViewType::dimension >, ConvectionDiffusionVelocityExtensionAdapter< T > > | |
CDune::PDELab::ConvectionDiffusionVelocityExtensionAdapter< T > | |
►CDune::PDELab::GridFunctionInterface< Dune::PDELab::GridFunctionTraits< T1::Traits::GridViewType, T1::Traits::RangeFieldType, 1, Dune::FieldVector< T1::Traits::RangeFieldType, 1 > >, DifferenceAdapter< T1, T2 > > | |
►CDune::PDELab::GridFunctionBase< Dune::PDELab::GridFunctionTraits< T1::Traits::GridViewType, T1::Traits::RangeFieldType, 1, Dune::FieldVector< T1::Traits::RangeFieldType, 1 > >, DifferenceAdapter< T1, T2 > > | |
CDune::PDELab::DifferenceAdapter< T1, T2 > | Adapter returning f1(x)-f2(x) for two given grid functions |
►CDune::PDELab::GridFunctionInterface< Dune::PDELab::GridFunctionTraits< T1::Traits::GridViewType, T1::Traits::RangeFieldType, 1, Dune::FieldVector< T1::Traits::RangeFieldType, 1 > >, DifferenceSquaredAdapter< T1, T2 > > | |
►CDune::PDELab::GridFunctionBase< Dune::PDELab::GridFunctionTraits< T1::Traits::GridViewType, T1::Traits::RangeFieldType, 1, Dune::FieldVector< T1::Traits::RangeFieldType, 1 > >, DifferenceSquaredAdapter< T1, T2 > > | |
CDune::PDELab::DifferenceSquaredAdapter< T1, T2 > | Adapter returning ||f1(x)-f2(x)||^2 for two given grid functions |
►CDune::PDELab::GridFunctionInterface< Dune::PDELab::GridFunctionTraits< T::Traits::GridViewType, T::Traits::RangeFieldType, 1, Dune::FieldVector< T::Traits::RangeFieldType, 1 > >, DirichletBoundaryCondition_CD< T > > | |
►CDune::PDELab::GridFunctionBase< Dune::PDELab::GridFunctionTraits< T::Traits::GridViewType, T::Traits::RangeFieldType, 1, Dune::FieldVector< T::Traits::RangeFieldType, 1 > >, DirichletBoundaryCondition_CD< T > > | |
CDune::PDELab::DirichletBoundaryCondition_CD< T > | |
►CDune::PDELab::GridFunctionInterface< GridFunctionTraits< T::Traits::GridViewType, BasisInterfaceSwitch< FiniteElementInterfaceSwitch< T::Traits::FiniteElementType >::Basis >::RangeField, BasisInterfaceSwitch< FiniteElementInterfaceSwitch< T::Traits::FiniteElementType >::Basis >::dimRange, BasisInterfaceSwitch< FiniteElementInterfaceSwitch< T::Traits::FiniteElementType >::Basis >::Range >, DiscreteGridFunction< T, X > > | |
►CDune::PDELab::GridFunctionBase< GridFunctionTraits< T::Traits::GridViewType, BasisInterfaceSwitch< FiniteElementInterfaceSwitch< T::Traits::FiniteElementType >::Basis >::RangeField, BasisInterfaceSwitch< FiniteElementInterfaceSwitch< T::Traits::FiniteElementType >::Basis >::dimRange, BasisInterfaceSwitch< FiniteElementInterfaceSwitch< T::Traits::FiniteElementType >::Basis >::Range >, DiscreteGridFunction< T, X > > | |
CDune::PDELab::DiscreteGridFunction< T, X > | Convert a grid function space and a coefficient vector into a grid function |
►CDune::PDELab::GridFunctionInterface< GridFunctionTraits< T::Traits::GridViewType, JacobianToCurl< T::Traits::FiniteElementType::Traits::LocalBasisType::Traits::JacobianType >::CurlField, JacobianToCurl< T::Traits::FiniteElementType::Traits::LocalBasisType::Traits::JacobianType >::dimCurl, JacobianToCurl< T::Traits::FiniteElementType::Traits::LocalBasisType::Traits::JacobianType >::Curl >, DiscreteGridFunctionCurl< T, X > > | |
►CDune::PDELab::GridFunctionBase< GridFunctionTraits< T::Traits::GridViewType, JacobianToCurl< T::Traits::FiniteElementType::Traits::LocalBasisType::Traits::JacobianType >::CurlField, JacobianToCurl< T::Traits::FiniteElementType::Traits::LocalBasisType::Traits::JacobianType >::dimCurl, JacobianToCurl< T::Traits::FiniteElementType::Traits::LocalBasisType::Traits::JacobianType >::Curl >, DiscreteGridFunctionCurl< T, X > > | |
CDune::PDELab::DiscreteGridFunctionCurl< T, X > | Convert a grid function space and a coefficient vector into a grid function of the curl |
►CDune::PDELab::GridFunctionInterface< DiscreteGridFunctionCurlTraits< T::Traits::GridViewType, T::Traits::FiniteElementType::Traits::LocalBasisType::Traits::RangeFieldType, T::Traits::FiniteElementType::Traits::LocalBasisType::Traits::dimRange >, DiscreteGridFunctionGlobalCurl< T, X > > | |
►CDune::PDELab::GridFunctionBase< DiscreteGridFunctionCurlTraits< T::Traits::GridViewType, T::Traits::FiniteElementType::Traits::LocalBasisType::Traits::RangeFieldType, T::Traits::FiniteElementType::Traits::LocalBasisType::Traits::dimRange >, DiscreteGridFunctionGlobalCurl< T, X > > | |
CDune::PDELab::DiscreteGridFunctionGlobalCurl< T, X > | Convert a single component function space with experimental global finite elements into a grid function representing the curl |
►CDune::PDELab::GridFunctionInterface< GridFunctionTraits< T::Traits::GridViewType, T::Traits::FiniteElementType::Traits::LocalBasisType ::Traits::RangeFieldType, T::Traits::FiniteElementType::Traits::LocalBasisType::Traits ::dimDomain, FieldVector< T::Traits::FiniteElementType::Traits ::LocalBasisType::Traits::RangeFieldType, T::Traits::FiniteElementType::Traits::LocalBasisType::Traits ::dimDomain > >, DiscreteGridFunctionGradient< T, X > > | |
►CDune::PDELab::GridFunctionBase< GridFunctionTraits< T::Traits::GridViewType, T::Traits::FiniteElementType::Traits::LocalBasisType ::Traits::RangeFieldType, T::Traits::FiniteElementType::Traits::LocalBasisType::Traits ::dimDomain, FieldVector< T::Traits::FiniteElementType::Traits ::LocalBasisType::Traits::RangeFieldType, T::Traits::FiniteElementType::Traits::LocalBasisType::Traits ::dimDomain > >, DiscreteGridFunctionGradient< T, X > > | |
CDune::PDELab::DiscreteGridFunctionGradient< T, X > | Convert a single component function space with a grid function representing the gradient |
►CDune::PDELab::GridFunctionInterface< GridFunctionTraits< T::Traits::GridViewType, T::Traits::FiniteElementType::Traits::LocalBasisType::Traits::RangeFieldType, T::Traits::FiniteElementType::Traits::LocalBasisType::Traits::dimRange, T::Traits::FiniteElementType::Traits::LocalBasisType::Traits::RangeType >, DiscreteGridFunctionPiola< T, X > > | |
►CDune::PDELab::GridFunctionBase< GridFunctionTraits< T::Traits::GridViewType, T::Traits::FiniteElementType::Traits::LocalBasisType::Traits::RangeFieldType, T::Traits::FiniteElementType::Traits::LocalBasisType::Traits::dimRange, T::Traits::FiniteElementType::Traits::LocalBasisType::Traits::RangeType >, DiscreteGridFunctionPiola< T, X > > | |
CDune::PDELab::DiscreteGridFunctionPiola< T, X > | DiscreteGridFunction with Piola transformation |
►CDune::PDELab::GridFunctionInterface< GF1::Traits, DivisionGridFunctionAdapter< GF1, GF2 > > | |
►CDune::PDELab::GridFunctionBase< GF1::Traits, DivisionGridFunctionAdapter< GF1, GF2 > > | |
CDune::PDELab::DivisionGridFunctionAdapter< GF1, GF2 > | Substract two GridFunctions |
►CDune::PDELab::GridFunctionInterface< GridFunctionTraits< G, T::Traits::RangeFieldType, T::Traits::dimRange, T::Traits::RangeType >, FunctionToGridFunctionAdapter< G, T > > | |
►CDune::PDELab::GridFunctionBase< GridFunctionTraits< G, T::Traits::RangeFieldType, T::Traits::dimRange, T::Traits::RangeType >, FunctionToGridFunctionAdapter< G, T > > | |
CDune::PDELab::FunctionToGridFunctionAdapter< G, T > | Make a GridFunction from a Function |
►CDune::PDELab::GridFunctionInterface< Dune::PDELab::GridFunctionTraits< GV, RF, n, Dune::FieldVector< RF, n > >, GlobalCallableToGridFunctionAdapter< GV, RF, n, F > > | |
►CDune::PDELab::GridFunctionBase< Dune::PDELab::GridFunctionTraits< GV, RF, n, Dune::FieldVector< RF, n > >, GlobalCallableToGridFunctionAdapter< GV, RF, n, F > > | |
CDune::PDELab::GlobalCallableToGridFunctionAdapter< GV, RF, n, F > | Adapter for callables f(x) expecting a global coordinate x |
►CDune::PDELab::GridFunctionInterface< Dune::PDELab::GridFunctionTraits< GV, RF, n, Dune::FieldVector< RF, n > >, GlobalCallableToInstationaryGridFunctionAdapter< GV, RF, n, F, P > > | |
►CDune::PDELab::GridFunctionBase< Dune::PDELab::GridFunctionTraits< GV, RF, n, Dune::FieldVector< RF, n > >, GlobalCallableToInstationaryGridFunctionAdapter< GV, RF, n, F, P > > | |
CDune::PDELab::GlobalCallableToInstationaryGridFunctionAdapter< GV, RF, n, F, P > | Return a PDELab GridFunction (with setTime method) defined by a parameter class and a callable f(x) global coordinates x |
►CDune::PDELab::GridFunctionInterface< Imp::Traits, GridFunctionBaseAdapter< Imp > > | |
►CDune::PDELab::GridFunctionBase< Imp::Traits, GridFunctionBaseAdapter< Imp > > | |
CDune::PDELab::GridFunctionBaseAdapter< Imp > | Turn an ordinary GridFunction into a GridFunctionTree leaf |
►CDune::PDELab::GridFunctionInterface< GF::Traits, InverseGridFunctionAdapter< GF > > | |
►CDune::PDELab::GridFunctionBase< GF::Traits, InverseGridFunctionAdapter< GF > > | |
CDune::PDELab::InverseGridFunctionAdapter< GF > | Take inverse of a GridFunction |
►CDune::PDELab::GridFunctionInterface< Dune::PDELab::GridFunctionTraits< T::Traits::GridViewType, T::Traits::RangeFieldType, T::Traits::dimDomain+1, Dune::FieldVector< T::Traits::RangeFieldType, T::Traits::dimDomain+1 > >, LinearAcousticsInitialValueAdapter< T > > | |
CDune::PDELab::GridFunctionBase< Dune::PDELab::GridFunctionTraits< T::Traits::GridViewType, T::Traits::RangeFieldType, T::Traits::dimDomain+1, Dune::FieldVector< T::Traits::RangeFieldType, T::Traits::dimDomain+1 > >, LinearAcousticsInitialValueAdapter< T > > | |
►CDune::PDELab::GridFunctionInterface< Dune::PDELab::GridFunctionTraits< T::Traits::GridViewType, T::Traits::RangeFieldType, T::Traits::dimRange, T::Traits::RangeType >, LinearElasticityDirichletExtensionAdapter< T > > | |
►CDune::PDELab::GridFunctionBase< Dune::PDELab::GridFunctionTraits< T::Traits::GridViewType, T::Traits::RangeFieldType, T::Traits::dimRange, T::Traits::RangeType >, LinearElasticityDirichletExtensionAdapter< T > > | |
CDune::PDELab::LinearElasticityDirichletExtensionAdapter< T > | |
►CDune::PDELab::GridFunctionInterface< Dune::PDELab::GridFunctionTraits< GV, RF, n, Dune::FieldVector< RF, n > >, LocalCallableToGridFunctionAdapter< GV, RF, n, F > > | |
►CDune::PDELab::GridFunctionBase< Dune::PDELab::GridFunctionTraits< GV, RF, n, Dune::FieldVector< RF, n > >, LocalCallableToGridFunctionAdapter< GV, RF, n, F > > | |
CDune::PDELab::LocalCallableToGridFunctionAdapter< GV, RF, n, F > | Adapter for callables f(e,x) expecting an entity e and a global coordinate x |
►CDune::PDELab::GridFunctionInterface< Dune::PDELab::GridFunctionTraits< GV, RF, n, Dune::FieldVector< RF, n > >, LocalCallableToInstationaryGridFunctionAdapter< GV, RF, n, F, P > > | |
►CDune::PDELab::GridFunctionBase< Dune::PDELab::GridFunctionTraits< GV, RF, n, Dune::FieldVector< RF, n > >, LocalCallableToInstationaryGridFunctionAdapter< GV, RF, n, F, P > > | |
CDune::PDELab::LocalCallableToInstationaryGridFunctionAdapter< GV, RF, n, F, P > | Return a PDELab GridFunction (with setTime method) defined by a parameter class and a callable f(e,x) that expects an entity e and local coordinates x |
►CDune::PDELab::GridFunctionInterface< Dune::PDELab::GridFunctionTraits< T::Traits::GridViewType, T::Traits::RangeFieldType, T::Traits::dimDomain *2, Dune::FieldVector< T::Traits::RangeFieldType, T::Traits::dimDomain *2 > >, MaxwellInitialValueAdapter< T > > | |
CDune::PDELab::GridFunctionBase< Dune::PDELab::GridFunctionTraits< T::Traits::GridViewType, T::Traits::RangeFieldType, T::Traits::dimDomain *2, Dune::FieldVector< T::Traits::RangeFieldType, T::Traits::dimDomain *2 > >, MaxwellInitialValueAdapter< T > > | |
►CDune::PDELab::GridFunctionInterface< GridFunctionTraits< GV, RF, 1, FieldVector< RF, 1 > >, MemberFunctionToGridFunctionAdaptor< Member, Class, GV, RF, 1 > > | |
►CDune::PDELab::GridFunctionBase< GridFunctionTraits< GV, RF, 1, FieldVector< RF, 1 > >, MemberFunctionToGridFunctionAdaptor< Member, Class, GV, RF, 1 > > | |
CDune::PDELab::MemberFunctionToGridFunctionAdaptor< Member, Class, GV, RF, dimR > | GridFunction implemented by a member function of some class |
►CDune::PDELab::GridFunctionInterface< GF1::Traits, MinusGridFunctionAdapter< GF1, GF2 > > | |
►CDune::PDELab::GridFunctionBase< GF1::Traits, MinusGridFunctionAdapter< GF1, GF2 > > | |
CDune::PDELab::MinusGridFunctionAdapter< GF1, GF2 > | Substract two GridFunctions |
►CDune::PDELab::GridFunctionInterface< Dune::PDELab::GridFunctionTraits< T::Traits::GridViewType, T::Traits::RangeFieldType, 1, Dune::FieldVector< T::Traits::RangeFieldType, 1 > >, NormalFluxGridFunctionAdapter< T > > | |
CDune::PDELab::GridFunctionBase< Dune::PDELab::GridFunctionTraits< T::Traits::GridViewType, T::Traits::RangeFieldType, 1, Dune::FieldVector< T::Traits::RangeFieldType, 1 > >, NormalFluxGridFunctionAdapter< T > > | |
►CDune::PDELab::GridFunctionInterface< T, PiolaBackwardAdapter< T > > | |
CDune::PDELab::GridFunctionBase< T::Traits, PiolaBackwardAdapter< T > > | |
►CDune::PDELab::GridFunctionInterface< F0::Traits, PointwiseGridFunctionAdapter< Engine, F0, Functions... > > | |
►CDune::PDELab::GridFunctionBase< F0::Traits, PointwiseGridFunctionAdapter< Engine, F0, Functions... > > | |
CDune::PDELab::PointwiseGridFunctionAdapter< Engine, F0, Functions > | |
►CDune::PDELab::GridFunctionInterface< GridFunctionTraits< GF1::Traits::GridViewType, GF1::Traits::RangeFieldType, 1, FieldVector< GF1::Traits::RangeFieldType, 1 > >, ProductGridFunctionAdapter< GF1, GF2 > > | |
►CDune::PDELab::GridFunctionBase< GridFunctionTraits< GF1::Traits::GridViewType, GF1::Traits::RangeFieldType, 1, FieldVector< GF1::Traits::RangeFieldType, 1 > >, ProductGridFunctionAdapter< GF1, GF2 > > | |
CDune::PDELab::ProductGridFunctionAdapter< GF1, GF2, class > | Product of two GridFunctions |
►CDune::PDELab::GridFunctionInterface< GridFunctionTraits< GF1::Traits::GridViewType, GF1::Traits::RangeFieldType, 1, FieldVector< GF1::Traits::RangeFieldType, 1 > >, ProductGridFunctionAdapter< GF2, GF1 > > | |
►CDune::PDELab::GridFunctionBase< GridFunctionTraits< GF1::Traits::GridViewType, GF1::Traits::RangeFieldType, 1, FieldVector< GF1::Traits::RangeFieldType, 1 > >, ProductGridFunctionAdapter< GF2, GF1 > > | |
►CDune::PDELab::ProductGridFunctionAdapter< GF2, GF1 > | |
CDune::PDELab::ProductGridFunctionAdapter< GF1, GF2, typename std::enable_if< GF1::Traits::dimRange !=1 &&GF2::Traits::dimRange==1 >::type > | Product of two GridFunctions |
►CDune::PDELab::GridFunctionInterface< GF2::Traits, ProductGridFunctionAdapter< GF1, GF2 > > | |
►CDune::PDELab::GridFunctionBase< GF2::Traits, ProductGridFunctionAdapter< GF1, GF2 > > | |
CDune::PDELab::ProductGridFunctionAdapter< GF1, GF2, typename std::enable_if< GF1::Traits::dimRange==1 &&GF2::Traits::dimRange !=1 >::type > | Product of two GridFunctions |
►CDune::PDELab::GridFunctionInterface< GF::Traits, ScalarScaledGridFunctionAdapter< GF > > | |
►CDune::PDELab::GridFunctionBase< GF::Traits, ScalarScaledGridFunctionAdapter< GF > > | |
CDune::PDELab::ScalarScaledGridFunctionAdapter< GF > | Scale a GridFunction by a constant |
►CDune::PDELab::GridFunctionInterface< GridFunctionTraits< GF::Traits::GridViewType, GF::Traits::RangeFieldType, 1, FieldVector< GF::Traits::RangeFieldType, 1 > >, SelectComponentGridFunctionAdapter< GF, 1 > > | |
►CDune::PDELab::GridFunctionBase< GridFunctionTraits< GF::Traits::GridViewType, GF::Traits::RangeFieldType, 1, FieldVector< GF::Traits::RangeFieldType, 1 > >, SelectComponentGridFunctionAdapter< GF, 1 > > | |
CDune::PDELab::SelectComponentGridFunctionAdapter< GF, dimR > | Select certain component(s) of a gridfunction |
►CDune::PDELab::GridFunctionInterface< GridFunctionTraits< GF::Traits::GridViewType, GF::Traits::RangeFieldType, 1, FieldVector< GF::Traits::RangeFieldType, 1 > >, SqrGridFunctionAdapter< GF > > | |
►CDune::PDELab::GridFunctionBase< GridFunctionTraits< GF::Traits::GridViewType, GF::Traits::RangeFieldType, 1, FieldVector< GF::Traits::RangeFieldType, 1 > >, SqrGridFunctionAdapter< GF > > | |
CDune::PDELab::SqrGridFunctionAdapter< GF > | Take square of a GridFunction |
►CDune::PDELab::GridFunctionInterface< GF::Traits, SqrtGridFunctionAdapter< GF > > | |
►CDune::PDELab::GridFunctionBase< GF::Traits, SqrtGridFunctionAdapter< GF > > | |
CDune::PDELab::SqrtGridFunctionAdapter< GF > | Take sqrt of a GridFunction |
►CDune::PDELab::GridFunctionInterface< GridFunctionTraits< GV, RF, 1, FieldVector< RF, 1 > >, TwoArgsMemberFunctionToGridFunctionAdaptor< Member, Class, GV, RF, 1 > > | |
►CDune::PDELab::GridFunctionBase< GridFunctionTraits< GV, RF, 1, FieldVector< RF, 1 > >, TwoArgsMemberFunctionToGridFunctionAdaptor< Member, Class, GV, RF, 1 > > | |
CDune::PDELab::TwoArgsMemberFunctionToGridFunctionAdaptor< Member, Class, GV, RF, dimR > | GridFunction implemented by a member function of some class |
►CDune::PDELab::GridFunctionInterface< GridFunctionTraits< FS::GV, FS::NT, 1, FieldVector< FS::NT, 1 > >, UserFunction< FS, Functor > > | |
CDune::PDELab::GridFunctionBase< GridFunctionTraits< FS::GV, FS::NT, 1, FieldVector< FS::NT, 1 > >, UserFunction< FS, Functor > > | |
►CDune::PDELab::GridFunctionInterface< Dune::PDELab::GridFunctionTraits< PL::Traits::GridViewType, PL::Traits::RangeFieldType, PL::Traits::GridViewType::dimension, Dune::FieldVector< PL::Traits::RangeFieldType, PL::Traits::GridViewType::dimension > >, V_g< TP, PL, PG > > | |
►CDune::PDELab::GridFunctionBase< Dune::PDELab::GridFunctionTraits< PL::Traits::GridViewType, PL::Traits::RangeFieldType, PL::Traits::GridViewType::dimension, Dune::FieldVector< PL::Traits::RangeFieldType, PL::Traits::GridViewType::dimension > >, V_g< TP, PL, PG > > | |
CDune::PDELab::V_g< TP, PL, PG > | Provide velocity field for gas phase |
►CDune::PDELab::GridFunctionInterface< Dune::PDELab::GridFunctionTraits< PL::Traits::GridViewType, PL::Traits::RangeFieldType, PL::Traits::GridViewType::dimension, Dune::FieldVector< PL::Traits::RangeFieldType, PL::Traits::GridViewType::dimension > >, V_l< TP, PL, PG > > | |
►CDune::PDELab::GridFunctionBase< Dune::PDELab::GridFunctionTraits< PL::Traits::GridViewType, PL::Traits::RangeFieldType, PL::Traits::GridViewType::dimension, Dune::FieldVector< PL::Traits::RangeFieldType, PL::Traits::GridViewType::dimension > >, V_l< TP, PL, PG > > | |
CDune::PDELab::V_l< TP, PL, PG > | Provide velocity field for liquid phase |
►CDune::PDELab::GridFunctionInterface< GridFunctionTraits< T::Traits::GridViewType, T::template Child< 0 >::Type::Traits::FiniteElementType ::Traits::LocalBasisType::Traits::RangeFieldType, TypeTree::StaticDegree< T >::value, Dune::FieldVector< T::template Child< 0 >::Type::Traits::FiniteElementType ::Traits::LocalBasisType::Traits::RangeFieldType, TypeTree::StaticDegree< T >::value > >, VectorDiscreteGridFunction< T, X > > | |
►CDune::PDELab::GridFunctionBase< GridFunctionTraits< T::Traits::GridViewType, T::template Child< 0 >::Type::Traits::FiniteElementType ::Traits::LocalBasisType::Traits::RangeFieldType, TypeTree::StaticDegree< T >::value, Dune::FieldVector< T::template Child< 0 >::Type::Traits::FiniteElementType ::Traits::LocalBasisType::Traits::RangeFieldType, TypeTree::StaticDegree< T >::value > >, VectorDiscreteGridFunction< T, X > > | |
CDune::PDELab::VectorDiscreteGridFunction< T, X, dimR > | DiscreteGridFunction for vector-valued functions |
►CDune::PDELab::GridFunctionInterface< Dune::PDELab::GridFunctionTraits< T::Traits::GridViewType, T::template Child< 0 >::Type::Traits::FiniteElementType::Traits::LocalBasisType::Traits::RangeFieldType, T::template Child< 0 >::Type::Traits::FiniteElementType::Traits::LocalBasisType::Traits::dimRange, T::template Child< 0 >::Type::Traits::FiniteElementType::Traits::LocalBasisType::Traits::RangeType >, VectorDiscreteGridFunctionDiv< T, X > > | |
►CDune::PDELab::GridFunctionBase< Dune::PDELab::GridFunctionTraits< T::Traits::GridViewType, T::template Child< 0 >::Type::Traits::FiniteElementType::Traits::LocalBasisType::Traits::RangeFieldType, T::template Child< 0 >::Type::Traits::FiniteElementType::Traits::LocalBasisType::Traits::dimRange, T::template Child< 0 >::Type::Traits::FiniteElementType::Traits::LocalBasisType::Traits::RangeType >, VectorDiscreteGridFunctionDiv< T, X > > | |
CDune::PDELab::VectorDiscreteGridFunctionCurl< T, X, 2 > | Compute curl of vector-valued functions (2D) |
CDune::PDELab::VectorDiscreteGridFunctionDiv< T, X > | Compute divergence of vector-valued functions |
►CDune::PDELab::GridFunctionInterface< Dune::PDELab::GridFunctionTraits< T::Traits::GridViewType, T::template Child< 0 >::Type::Traits::FiniteElementType::Traits::LocalBasisType::Traits::RangeFieldType, TypeTree::StaticDegree< T >::value, Dune::FieldVector< T::template Child< 0 >::Type::Traits::FiniteElementType ::Traits::LocalBasisType::Traits::RangeFieldType, TypeTree::StaticDegree< T >::value > >, VectorDiscreteGridFunctionCurl< T, X > > | |
►CDune::PDELab::GridFunctionBase< Dune::PDELab::GridFunctionTraits< T::Traits::GridViewType, T::template Child< 0 >::Type::Traits::FiniteElementType::Traits::LocalBasisType::Traits::RangeFieldType, TypeTree::StaticDegree< T >::value, Dune::FieldVector< T::template Child< 0 >::Type::Traits::FiniteElementType ::Traits::LocalBasisType::Traits::RangeFieldType, TypeTree::StaticDegree< T >::value > >, VectorDiscreteGridFunctionCurl< T, X > > | |
CDune::PDELab::VectorDiscreteGridFunctionCurl< T, X, 3 > | Compute curl of vector-valued functions (3D) |
►CDune::PDELab::GridFunctionInterface< GridFunctionTraits< T::Traits::GridViewType, T::template Child< 0 >::Type::Traits::FiniteElementType::Traits::LocalBasisType::Traits::RangeFieldType, TypeTree::StaticDegree< T >::value, Dune::FieldMatrix< T::template Child< 0 >::Type::Traits::FiniteElementType::Traits::LocalBasisType::Traits::RangeFieldType, TypeTree::StaticDegree< T >::value, T::template Child< 0 >::Type::Traits::FiniteElementType::Traits::LocalBasisType::Traits::dimDomain > >, VectorDiscreteGridFunctionGradient< T, X > > | |
►CDune::PDELab::GridFunctionBase< GridFunctionTraits< T::Traits::GridViewType, T::template Child< 0 >::Type::Traits::FiniteElementType::Traits::LocalBasisType::Traits::RangeFieldType, TypeTree::StaticDegree< T >::value, Dune::FieldMatrix< T::template Child< 0 >::Type::Traits::FiniteElementType::Traits::LocalBasisType::Traits::RangeFieldType, TypeTree::StaticDegree< T >::value, T::template Child< 0 >::Type::Traits::FiniteElementType::Traits::LocalBasisType::Traits::dimDomain > >, VectorDiscreteGridFunctionGradient< T, X > > | |
CDune::PDELab::VectorDiscreteGridFunctionGradient< T, X > | Equivalent of DiscreteGridFunctionGradient for vector-valued functions |
►CDune::PDELab::GridFunctionInterface< GridFunctionTraits< LFS::Traits::GridView, BasisInterfaceSwitch< FiniteElementInterfaceSwitch< LFS::Traits::FiniteElement >::Basis >::RangeField, BasisInterfaceSwitch< FiniteElementInterfaceSwitch< LFS::Traits::FiniteElement >::Basis >::dimRange, BasisInterfaceSwitch< FiniteElementInterfaceSwitch< LFS::Traits::FiniteElement >::Basis >::Range >, DGFTreeLeafFunction< LFS, Data > > | |
CDune::PDELab::GridFunctionBase< GridFunctionTraits< LFS::Traits::GridView, BasisInterfaceSwitch< FiniteElementInterfaceSwitch< LFS::Traits::FiniteElement >::Basis >::RangeField, BasisInterfaceSwitch< FiniteElementInterfaceSwitch< LFS::Traits::FiniteElement >::Basis >::dimRange, BasisInterfaceSwitch< FiniteElementInterfaceSwitch< LFS::Traits::FiniteElement >::Basis >::Range >, DGFTreeLeafFunction< LFS, Data > > | |
►CDune::PDELab::GridFunctionInterface< GridFunctionTraits< LFS::Traits::GridView, BasisInterfaceSwitch< FiniteElementInterfaceSwitch< LFS::ChildType::Traits::FiniteElement >::Basis >::RangeField, TypeTree::StaticDegree< LFS >::value, Dune::FieldVector< BasisInterfaceSwitch< FiniteElementInterfaceSwitch< LFS::ChildType::Traits::FiniteElement >::Basis >::RangeField, TypeTree::StaticDegree< LFS >::value > >, DGFTreeVectorFunction< LFS, Data > > | |
CDune::PDELab::GridFunctionBase< GridFunctionTraits< LFS::Traits::GridView, BasisInterfaceSwitch< FiniteElementInterfaceSwitch< LFS::ChildType::Traits::FiniteElement >::Basis >::RangeField, TypeTree::StaticDegree< LFS >::value, Dune::FieldVector< BasisInterfaceSwitch< FiniteElementInterfaceSwitch< LFS::ChildType::Traits::FiniteElement >::Basis >::RangeField, TypeTree::StaticDegree< LFS >::value > >, DGFTreeVectorFunction< LFS, Data > > | |
►CDune::PDELab::GridFunctionInterface< Dune::PDELab::GridFunctionTraits< T::Traits::GridViewType, T::Traits::RangeFieldType, 1, Dune::FieldVector< T::Traits::RangeFieldType, 1 > >, PermeabilityAdapter< T > > | |
►CDune::PDELab::GridFunctionBase< Dune::PDELab::GridFunctionTraits< T::Traits::GridViewType, T::Traits::RangeFieldType, 1, Dune::FieldVector< T::Traits::RangeFieldType, 1 > >, PermeabilityAdapter< T > > | |
CPermeabilityAdapter< T > | |
CDune::PDELab::GridFunctionSpace< impl::EntitySet< GV >, FEM, NoConstraints, LeafBackend, DefaultLeafOrderingTag > | |
CDune::PDELab::Experimental::GridFunctionSpace< DFBasis, VBE, CE > | A pdelab grid function space implemented by a dune-functions function space basis |
►CDune::PDELab::GridFunctionInterface< T, Imp > | GridFunction maps x in DomainType to y in RangeType |
CDune::PDELab::GridFunctionBase< T, Imp > | Leaf of a function tree |
CDune::PDELab::GridFunctionSpace< ES, FEM, CE, B, O > | A grid function space |
CDune::PDELab::VectorGridFunctionSpace< GV, FEM, k, Backend, LeafBackend, Constraints, OrderingTag, LeafOrderingTag > | Tensorproduct space representing a vector valued function space |
CDune::PDELab::GridFunctionProbe< GF > | Evaluate a GridFunction at a certain global coordinate |
CDune::PDELab::GridFunctionSpaceTraits< G, L, C, B, O > | Collect types exported by a leaf grid function space |
CDune::PDELab::gfs::GridFunctionSubSpaceOutputParameters< T, Enable > | Mixin class which inherits from GridFunctionOutputParameters iff T inherits from GridFunctionOutputParameters |
►CDune::PDELab::gfs::GridFunctionSubSpaceOutputParameters< TypeTree::ChildForTreePath< GFS, TreePath > > | |
CDune::PDELab::gfs::GridFunctionSubSpace< GFS, TreePath > | Non-nesting implementation of GridFunctionSubSpace |
CDune::PDELab::GridOperator< GFSU, GFSV, LOP, MB, DF, RF, JF, CU, CV > | Standard grid operator implementation |
CDune::PDELab::GridOperator< CGGFS, GFS, CGTODGLOP, MBE, field_type, field_type, field_type, CC, CC > | |
CDune::PDELab::GridOperatorInterface< GFSU, GFSV, MB, DF, RF, JF > | The grid operator represents an operator mapping which corresponds to the (possibly nonlinear) algebraic problem resulting from the discretization of a PDE |
CDune::PDELab::GridOperatorTraits< GFSU, GFSV, MB, DF, RF, JF, CU, CV, A, LA > | Traits class for the grid operator |
►CDune::dgf::GridParameterBlock | Common Grid parameters |
CDune::dgf::YaspGridParameterBlock | Grid parameters for YaspGrid |
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::GridViewInfoGTCompare | Comparison object to sort GeometryType by majorly dimension |
CDune::Capabilities::hasBackupRestoreFacilities< Grid > | Specialize with 'true' if implementation provides backup and restore facilities. (default=false) |
CDune::Capabilities::hasBackupRestoreFacilities< AlbertaGrid< dim, dimworld > > | AlbertaGrid has backup and restore facilities |
CDune::Capabilities::hasEntity< Grid, codim > | Specialize with 'true' for all codims that a grid implements entities for. (default=false) |
CDune::Capabilities::hasEntity< AlbertaGrid< dim, dimworld >, codim > | AlbertaGrid has entities for all codimensions |
CDune::Capabilities::hasEntity< IdentityGrid< HostGrid >, codim > | Has entities for some codimensions as host grid |
CDune::Capabilities::hasEntity< OneDGrid, cdim > | OneDGrid has entities for all codimension |
CDune::Capabilities::hasEntity< 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::HasNaN< T > | Whether this type has a value of NaN |
CDune::Capabilities::hasSingleGeometryType< Grid > | Specialize with 'true' for if the codimension 0 entity of the grid has only one possible geometry type. In this case the topologyId of this geometry type has also to be specified. (default=false, topologyId=undefined) |
CDune::MultiLinearGeometryTraits< ct >::hasSingleGeometryType< dim > | Will there be only one geometry type for a dimension? |
CDune::Capabilities::hasSingleGeometryType< AlbertaGrid< dim, dimworld > > | AlbertaGrid has only one geometry type for codim 0 entities |
CDune::Capabilities::hasSingleGeometryType< OneDGrid > | OneDGrid has only one geometry type for codim 0 entities |
CDune::Capabilities::hasSingleGeometryType< YaspGrid< dim, Coordinates > > | YaspGrid has only one geometry type for codim 0 entities |
CDune::Functions::HierarchicalLagrangePreBasis< GV, k, MI, 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::PDELab::HierarchicContainerAllocationTag | |
CDune::Functions::HierarchicNodeToRangeMap | A 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::HierarchicSearch< typename GF::Traits::GridViewType::Grid, typename GF::Traits::GridViewType::IndexSet > | |
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::identity | A 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::IdentityMap | A 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::AlbertaGridIdSet< dim, Alberta::dimWorld > | |
CDune::AlbertaGridIdSet< dim, dimworld > | Hierarchic index set of AlbertaGrid |
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::YaspGlobalIdSet< const Dune::YaspGrid< dim, CoordCont > > | |
►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::YaspGlobalIdSet< const Dune::YaspGrid< dim, EquidistantCoordinates< double, dim > > > | |
CDune::IdSet< Grid, IdSet< Grid, HostIdSet >, HostIdSet::IdType > | |
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::YaspGlobalIdSet< GridImp > | Persistent, globally unique Ids |
►CDune::ILUSubdomainSolver< M, X, Y > | Base class encapsulating common algorithms of ILU0SubdomainSolver and ILUNSubdomainSolver |
CDune::ILU0SubdomainSolver< M, X, Y > | Exact subdomain solver using ILU(p) with appropriate p |
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::ImplementationDefined | Dummy 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::Indent | Utility class for handling nested indentation in output |
CDune::IndexInfoFromGrid< G, L > | Information about the index distribution |
►CDune::Functions::BasisFactory::IndexMergingStrategy | Base class for index merging strategies to simplify detection |
CDune::Functions::BasisFactory::BlockedInterleaved | Interleaved merging of direct children with blocking (i.e. creating blocks at the leaves containing one leaf per child each) |
CDune::Functions::BasisFactory::BlockedLexicographic | Lexicographic merging of direct children with blocking (i.e. creating one block per direct child) |
CDune::Functions::BasisFactory::FlatInterleaved | Interleaved merging of direct children without blocking |
CDune::Functions::BasisFactory::FlatLexicographic | Lexicographic merging of direct children without blocking |
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< 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::IdentityGridLevelIndexSet< const Dune::IdentityGrid< HostGrid > > | |
►CDune::IndexSet< const Dune::YaspGrid< dim, CoordCont >, YaspIndexSet< const Dune::YaspGrid< dim, CoordCont >, isLeafIndexSet >, unsigned int > | |
CDune::YaspIndexSet< const Dune::YaspGrid< dim, CoordCont >, false > | |
CDune::YaspIndexSet< const Dune::YaspGrid< dim, CoordCont >, true > | |
►CDune::IndexSet< const Dune::YaspGrid< dim, EquidistantCoordinates< double, dim > >, YaspIndexSet< const Dune::YaspGrid< dim, EquidistantCoordinates< double, dim > >, isLeafIndexSet >, unsigned int > | |
CDune::YaspIndexSet< const Dune::YaspGrid< dim, EquidistantCoordinates< double, dim > >, false > | |
CDune::YaspIndexSet< const Dune::YaspGrid< dim, EquidistantCoordinates< double, dim > >, true > | |
CDune::IndexSet< Grid, IndexSet< Grid, HostIndexSet >, HostIndexSet::IndexType, HostIndexSet::Types > | |
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::IdentityGridLevelIndexSet< GridImp > | |
►CDune::IndexSet< GridImp, IndexSetImp > | |
CDune::IndexSetDefaultImplementation< GridImp, IndexSetImp > | Provide default implementation of method if IndexSet |
►CDune::IndexSet< GridImp, YaspIndexSet< GridImp, isLeafIndexSet >, unsigned int > | |
CDune::YaspIndexSet< GridImp, isLeafIndexSet > | Implementation of Level- and LeafIndexSets for YaspGrid |
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::PDELab::InstationaryFunctionDefaults | Default class for additional methods in instationary functions |
CDune::PDELab::ConstGridFunction< GV, RF, dimR > | GridFunction returning a constant value everywhere |
CDune::PDELab::InstationaryLocalOperatorDefaultMethods< R > | Default class for additional methods in instationary local operators |
►CDune::PDELab::InstationaryLocalOperatorDefaultMethods< double > | |
CDune::PDELab::ConvectionDiffusionTemporalResidualEstimator< T > | |
CDune::PDELab::ConvectionDiffusionTemporalResidualEstimator1< T > | |
CDune::PDELab::NonLinearConvectionDiffusionFEM< T > | |
CLOP_spatial_contaminant< Param, GFSF, ZF, GFSC, ZC, convection > | |
CLOP_spatial_flow< Param > | |
►CDune::PDELab::InstationaryLocalOperatorDefaultMethods< P::Traits::RangeField > | |
CDune::PDELab::TaylorHoodNavierStokes< P > | A local operator for the Navier-Stokes equations |
►CDune::PDELab::InstationaryLocalOperatorDefaultMethods< PRM::Traits::RangeField > | |
CDune::PDELab::DGNavierStokes< PRM > | A local operator for solving the Navier-Stokes equations using a DG discretization |
CDune::PDELab::DGNavierStokesVelVecFEM< PRM > | A local operator for solving the Navier-Stokes equations using a DG discretization and a vector-valued finite element map for the velocity grid function space |
CDune::PDELab::NavierStokesMass< PRM > | A local operator for the mass term corresponding to the instationary part in the Navier-Stokes equations |
CDune::PDELab::NavierStokesVelVecMass< PRM > | A local operator for the mass term corresponding to the instationary part in the Navier-Stokes equations using a vector-valued Finite Element map for the velocity grid function space |
►CDune::PDELab::InstationaryLocalOperatorDefaultMethods< T::Traits::DomainType > | |
CDune::PDELab::LinearElasticity< T > | |
►CDune::PDELab::InstationaryLocalOperatorDefaultMethods< T::Traits::RangeFieldType > | |
CDune::PDELab::ConvectionDiffusionDG< T, FiniteElementMap > | |
CDune::PDELab::ConvectionDiffusionFEM< T, FiniteElementMap > | |
CDune::PDELab::DGLinearAcousticsSpatialOperator< T, FEM > | |
CDune::PDELab::DGLinearAcousticsTemporalOperator< T, FEM > | |
CDune::PDELab::DGMaxwellSpatialOperator< T, FEM > | Spatial local operator for discontinuous Galerkin method for Maxwells Equations |
CDune::PDELab::DGMaxwellTemporalOperator< T, FEM > | |
►CDune::PDELab::InstationaryLocalOperatorDefaultMethods< Time > | |
CDune::PDELab::ZeroLocalOperator< Time > | Do-nothing local operator |
►CDune::PDELab::InstationaryLocalOperatorDefaultMethods< TP::Traits::RangeFieldType > | |
CDune::PDELab::ConvectionDiffusionCCFV< TP > | |
CDune::PDELab::ConvectionDiffusionCCFVTemporalOperator< TP > | |
CDune::PDELab::TwoPhaseOnePointTemporalOperator< TP > | |
CDune::IntegerSequenceEntry< IntegerSequence, index > | Get entry of std::integer_sequence |
CDune::IntegralRange< T > | Dynamic integer range for use in range-based for loops |
►CDune::InterfaceBuilder | Base class of all classes representing a communication interface |
CDune::Interface | Communication interface between remote and local indices |
CDune::InterfaceInformation | Information describing an interface |
CDune::PDELab::InterleavedOrderingTag | Indicate interleaved ordering of the unknowns of non-leaf grid function spaces according to a given blocking pattern |
►CDune::InterpolationInterface | Interface for global-valued interpolation |
CDune::LocalToGlobalInterpolationAdaptor< LocalInterpolation, typename Basis::Traits > | |
CDune::LocalToGlobalInterpolationAdaptor< typename LocalFiniteElement::Traits::LocalInterpolationType, typename Basis::Traits > | |
CDune::LocalToGlobalInterpolationAdaptor< LocalInterpolation, Traits_ > | Convert a local interpolation into a global 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 >::Intersection | Type describing an intersection with a neighboring processor |
CDune::Intersection< GridImp, AlbertaGridLeafIntersection< GridImp > > | |
CDune::IntersectionDefaultNormalVectors< GridImp, IntersectionImp > | Default Implementations of integrationOuterNormal and unitOuterNormal for IntersectionImp |
CDune::PDELab::IntersectionGeometry< I > | Wrap intersection |
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::Functions::InvalidRange | Dummy range class to be used if no proper type is available |
►CDune::InverseOperator< X, Y > | Abstract base class for all solvers |
CDune::IterativeSolver< X, Y > | Base class for all implementations of iterative 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::LDL< BCRSMatrix< FieldMatrix< T, n, m >, A > > | The LDL direct sparse solver for matrices of type BCRSMatrix |
CDune::SPQR< BCRSMatrix< FieldMatrix< T, n, m >, A > > | The SPQR direct sparse solver for matrices of type BCRSMatrix |
CDune::InverseOperator< Domain, Range > | |
►CDune::InverseOperator< Impl::SuperLUVectorChooser< ISTLM >::domain_type, Impl::SuperLUVectorChooser< ISTLM >::range_type > | |
CDune::SuperLU< ISTLM > | |
►CDune::InverseOperator< Impl::SuperLUVectorChooser< M >::domain_type, Impl::SuperLUVectorChooser< M >::range_type > | |
CDune::SuperLU< M > | SuperLu Solver |
►CDune::InverseOperator< Impl::UMFPackVectorChooser< ISTLM >::domain_type, Impl::UMFPackVectorChooser< ISTLM >::range_type > | |
CDune::UMFPack< ISTLM > | |
►CDune::InverseOperator< Impl::UMFPackVectorChooser< M >::domain_type, Impl::UMFPackVectorChooser< M >::range_type > | |
CDune::UMFPack< M > | The UMFPack direct sparse solver |
►CDune::InverseOperator< X, X > | |
►CDune::IterativeSolver< X, X > | |
►CDune::RestartedGMResSolver< X, X > | |
CDune::RestartedFlexibleGMResSolver< X, Y, F > | Implements the Flexible Generalized Minimal Residual (FGMRes) method (right preconditioned) |
CDune::BiCGSTABSolver< X > | Bi-conjugate Gradient Stabilized (BiCG-STAB) |
CDune::CGSolver< X > | Conjugate gradient method |
CDune::GeneralizedPCGSolver< X > | Generalized preconditioned conjugate gradient solver |
CDune::GradientSolver< X > | Gradient method |
CDune::LoopSolver< X > | Preconditioned loop solver |
CDune::MINRESSolver< X > | Minimal Residual Method (MINRES) |
►CDune::RestartedFCGSolver< X > | Accelerated flexible conjugate gradient method |
CDune::CompleteFCGSolver< X > | Complete flexible conjugate gradient method |
CDune::RestartedGMResSolver< X, Y, F > | Implements the Generalized Minimal Residual (GMRes) method |
CDune::InverseOperatorResult | Statistics about the application of an inverse operator |
CDune::ios_base_all_saver | Utility class for storing and resetting stream attributes |
CDune::Std::is_callable< D, R > | Traits class to check if function is callable |
CDune::Std::is_callable< F(Args...), R > | Traits class to check if function is callable |
CDune::Std::is_invocable< F, Args > | Traits class to check if function is invocable |
CDune::Std::is_invocable_r< R, F, Args > | Traits class to check if function is invocable and the return type is compatible |
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< YaspGrid< dim, Coordinates > > | YaspGrid is a Cartesian grid |
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< IdentityGrid< HostGrid > > | Has conforming leaf grids when host grid has |
CDune::Capabilities::isLeafwiseConforming< OneDGrid > | OneDGrid is leafwise conforming |
CDune::Capabilities::isLeafwiseConforming< UGGrid< dim > > | UGGrid may not be leafwise conforming |
CDune::Capabilities::isLeafwiseConforming< YaspGrid< dim, Coordinates > > | YaspGrid is leafwise conforming |
CDune::Capabilities::isLevelwiseConforming< Grid > | Specialize with 'true' if implementation guarantees conforming level grids. (default=false) |
CDune::Capabilities::isLevelwiseConforming< AlbertaGrid< dim, dimworld > > | AlbertaGrid is not levelwise conforming (since it uses bisection) |
CDune::Capabilities::isLevelwiseConforming< IdentityGrid< HostGrid > > | Has conforming level grids when host grid has |
CDune::Capabilities::isLevelwiseConforming< OneDGrid > | OneDGrid is levelwise conforming |
CDune::Capabilities::isLevelwiseConforming< 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::Simd::VcImpl::IsVector< V, SFINAE > | Specialized to true for Vc vector and 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::PDELab::ISTLAMGStatistics | Class providing some statistics of the AMG solver |
CDune::PDELab::ISTLBackend_BCGS_AMG_ILU0< GO, s > | Overlapping parallel BiCGStab solver preconditioned with AMG smoothed by ILU0 |
CDune::PDELab::ISTLBackend_BCGS_AMG_SSOR< GO, s > | Overlapping parallel BiCGStab solver preconditioned with AMG smoothed by SSOR |
CDune::PDELab::ISTLBackend_CG_AMG_SSOR< GO, s > | Overlapping parallel conjugate gradient solver preconditioned with AMG smoothed by SSOR |
CDune::PDELab::ISTLBackend_NOVLP_BASE_PREC< GO, Preconditioner, Solver > | Utility base class for preconditioned novlp backends |
►CDune::PDELab::ISTLBackend_NOVLP_BASE_PREC< GO, Dune::SeqSSOR, Dune::BiCGSTABSolver > | |
CDune::PDELab::ISTLBackend_NOVLP_BCGS_SSORk< GO > | Nonoverlapping parallel BiCGSTAB solver preconditioned by block SSOR |
►CDune::PDELab::ISTLBackend_NOVLP_BASE_PREC< GO, Dune::SeqSSOR, Dune::CGSolver > | |
CDune::PDELab::ISTLBackend_NOVLP_CG_SSORk< GO > | Nonoverlapping parallel CG solver preconditioned by block SSOR |
CDune::PDELab::ISTLBackend_NOVLP_BCGS_AMG_SSOR< GO, s > | Nonoverlapping parallel BiCGStab solver preconditioned with AMG smoothed by SSOR |
CDune::PDELab::ISTLBackend_NOVLP_BCGS_Jacobi< GFS > | Nonoverlapping parallel BiCGStab solver with Jacobi preconditioner |
CDune::PDELab::ISTLBackend_NOVLP_BCGS_NOPREC< GFS > | Nonoverlapping parallel BiCGStab solver without preconditioner |
CDune::PDELab::ISTLBackend_NOVLP_CG_AMG_SSOR< GO, s > | Nonoverlapping parallel CG solver preconditioned with AMG smoothed by SSOR |
CDune::PDELab::ISTLBackend_NOVLP_CG_Jacobi< GFS > | Nonoverlapping parallel CG solver with Jacobi preconditioner |
CDune::PDELab::ISTLBackend_NOVLP_CG_NOPREC< GFS > | Nonoverlapping parallel CG solver without preconditioner |
CDune::PDELab::ISTLBackend_NOVLP_ExplicitDiagonal< GFS > | Solver to be used for explicit time-steppers with (block-)diagonal mass matrix |
CDune::PDELab::ISTLBackend_NOVLP_LS_AMG_SSOR< GO, s > | Nonoverlapping parallel LoopSolver preconditioned with AMG smoothed by SSOR |
CDune::PDELab::ISTLBackend_OVLP_AMG_4_DG< DGGO, DGCC, CGGFS, CGCC, TransferLOP, DGPrec, Solver, s > | |
CDune::PDELab::ISTLBackend_OVLP_BCGS_ILU0< GFS, CC > | Overlapping parallel BiCGStab solver with ILU0 preconditioner |
CDune::PDELab::ISTLBackend_OVLP_BCGS_ILUn< GFS, CC > | Overlapping parallel BiCGStab solver with ILU0 preconditioner |
CDune::PDELab::ISTLBackend_OVLP_BCGS_SSORk< GFS, CC > | Overlapping parallel BiCGStab solver with SSOR preconditioner |
CDune::PDELab::ISTLBackend_OVLP_BCGS_SuperLU< GFS, CC > | Overlapping parallel BiCGStab solver with SuperLU preconditioner |
CDune::PDELab::ISTLBackend_OVLP_CG_SSORk< GFS, CC > | Overlapping parallel CGS solver with SSOR preconditioner |
CDune::PDELab::ISTLBackend_OVLP_CG_SuperLU< GFS, CC > | Overlapping parallel CG solver with SuperLU preconditioner |
CDune::PDELab::ISTLBackend_OVLP_CG_UMFPack< GFS, CC > | Overlapping parallel CG solver with UMFPack preconditioner |
CDune::PDELab::ISTLBackend_OVLP_ExplicitDiagonal< GFS > | Solver to be used for explicit time-steppers with (block-)diagonal mass matrix |
CDune::PDELab::ISTLBackend_OVLP_GMRES_ILU0< GFS, CC > | Overlapping parallel restarted GMRes solver with ILU0 preconditioner |
CDune::PDELab::ISTLBackend_SEQ_AMG_4_DG< DGGO, CGGFS, TransferLOP, DGPrec, Solver > | |
CDune::PDELab::ISTLBackend_SEQ_BCGS_AMG_SOR< GO > | Sequential BiCGSTAB solver preconditioned with AMG smoothed by SOR |
CDune::PDELab::ISTLBackend_SEQ_BCGS_AMG_SSOR< GO > | Sequential BiCGStab solver preconditioned with AMG smoothed by SSOR |
CDune::PDELab::ISTLBackend_SEQ_BCGS_ILU0 | Backend for sequential BiCGSTAB solver with ILU0 preconditioner |
CDune::PDELab::ISTLBackend_SEQ_BCGS_ILUn | Sequential BiCGStab solver with ILU0 preconditioner |
CDune::PDELab::ISTLBackend_SEQ_BCGS_Jac | Backend for sequential BiCGSTAB solver with Jacobi preconditioner |
CDune::PDELab::ISTLBackend_SEQ_BCGS_Richardson | Backend for sequential BiCGSTAB solver with Richardson precondition (equivalent to no preconditioner for Richards with parameter=1.0) |
CDune::PDELab::ISTLBackend_SEQ_BCGS_SSOR | Backend for sequential BiCGSTAB solver with SSOR preconditioner |
CDune::PDELab::ISTLBackend_SEQ_CG_AMG_SSOR< GO > | Sequential conjugate gradient solver preconditioned with AMG smoothed by SSOR |
CDune::PDELab::ISTLBackend_SEQ_CG_ILU0 | Backend for sequential conjugate gradient solver with ILU0 preconditioner |
CDune::PDELab::ISTLBackend_SEQ_CG_ILUn | Sequential congute gradient solver with ILU0 preconditioner |
CDune::PDELab::ISTLBackend_SEQ_CG_Jac | Backend for conjugate gradient solver with Jacobi preconditioner |
CDune::PDELab::ISTLBackend_SEQ_CG_SSOR | Backend for sequential conjugate gradient solver with SSOR preconditioner |
CDune::PDELab::ISTLBackend_SEQ_ExplicitDiagonal | Solver to be used for explicit time-steppers with (block-)diagonal mass matrix |
CDune::PDELab::ISTLBackend_SEQ_GMRES_ILU0 | Linear solver backend for Restarted GMRes preconditioned with ILU(0) |
CDune::PDELab::ISTLBackend_SEQ_LOOP_Jac | Backend for sequential loop solver with Jacobi preconditioner |
CDune::PDELab::ISTLBackend_SEQ_LS_AMG_SOR< GO > | Sequential Loop solver preconditioned with AMG smoothed by SOR |
CDune::PDELab::ISTLBackend_SEQ_LS_AMG_SSOR< GO > | Sequential Loop solver preconditioned with AMG smoothed by SSOR |
CDune::PDELab::ISTLBackend_SEQ_MatrixFree_Base< GO, PrecGO, Solver > | Sequential matrix-free solver backend |
CDune::PDELab::ISTLBackend_SEQ_MINRES_SSOR | Backend using a MINRes solver preconditioned by SSOR |
CDune::PDELab::ISTLBackend_SEQ_SuperLU | Solver backend using SuperLU as a direct solver |
CDune::PDELab::ISTLBackend_SEQ_UMFPack | Solver backend using UMFPack as a direct solver |
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 >::iterator | Iterator over the valid underlying iterators |
CDune::MatrixImp::DenseMatrixBase< B, A >::Iterator | Iterator class for sequential access |
CDune::YGrid< Coordinates >::Iterator | Iterator 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::IteratorTransformationTag | Tag to enable iterator based transformations in TransformedRangeView |
CDune::MonomImp::JacobianAccess< Traits > | Access output vector of evaluateJacobian() |
CDune::PDELab::JacobianBasedAlphaBoundary< Imp > | Implement alpha_boundary() based on jacobian_boundary() |
CDune::PDELab::JacobianBasedAlphaSkeleton< Imp > | Implement alpha_skeleton() based on jacobian_skeleton() |
CDune::PDELab::JacobianBasedAlphaVolume< Imp > | Implement alpha_volume() based on jacobian_volume() |
►CDune::PDELab::JacobianBasedAlphaVolume< Electrodynamic_S< Mu > > | |
CDune::PDELab::Electrodynamic_S< Mu > | Contruct matrix S for the Electrodynamic operator |
►CDune::PDELab::JacobianBasedAlphaVolume< Electrodynamic_T< Eps > > | |
CDune::PDELab::Electrodynamic_T< Eps > | Construct matrix T for the Electrodynamic operator |
CDune::PDELab::JacobianToCurl< Jacobian, dimR, dimD > | Extract the curl of a function from the jacobian of that function |
CDune::PDELab::JacobianToCurl< Jacobian, 1, 2 > | Extract the curl of a 1D-valued function in 2D from the jacobian of that function |
CDune::PDELab::JacobianToCurl< Jacobian, 2, 2 > | Extract the curl of a 2D-valued function in 2D from the jacobian of that function |
CDune::PDELab::JacobianToCurl< Jacobian, 3, 3 > | Extract the curl of a 3D-valued function in 3D from the jacobian of that function |
CDune::JoinTuples< Head, Tail > | Join two std::tuple's |
CDune::PDELab::L2Projection< GFS, U > | |
CDune::LagrangeCubeLocalFiniteElement< D, R, dim, k > | Lagrange finite element for cubes with arbitrary compile-time dimension and polynomial order |
CDune::LagrangeCubeLocalFiniteElement< D, R, GV::dimension, k > | |
CDune::LagrangeCubeLocalFiniteElement< Geometry::ctype, RF, Geometry::mydimension, 1 > | |
CDune::Functions::LagrangePreBasis< GV, k, MI, R > | A pre-basis for a PQ-lagrange bases with given order |
CDune::Functions::LagrangePreBasis< GV, 1, PQMultiIndex > | |
CDune::Functions::LagrangePreBasis< GV, 2, PQMultiIndex > | |
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::LagrangeSimplexLocalFiniteElement< D, R, 1, k > | |
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::Lcm< m, n > | Calculate the least common multiple of two numbers |
CDune::LDL< Matrix > | Use the LDL package to directly solve linear systems – empty default class |
CDune::PDELab::LeafLocalFunctionSpaceTag | Tag denoting a LeafLocalFunctionSpace |
►CDune::TypeTree::LeafNode | Base class for leaf nodes in a dune-typetree |
CDune::PDELab::BoundaryGridFunctionBase< BoundaryGridFunctionTraits< GV, RF, 1, FieldVector< RF, 1 > >, ConstBoundaryGridFunction< GV, RF, 1 > > | |
CDune::PDELab::BoundaryGridFunctionBase< BoundaryGridFunctionTraits< GV, RF, 1, FieldVector< RF, 1 > >, TwoArgsMemberFunctionToBoundaryGridFunctionAdaptor< Member, Class, GV, RF, 1 > > | |
CDune::PDELab::Experimental::GridFunctionSpace< DFBasis, V, CE > | |
CDune::PDELab::GridFunctionBase< Dune::PDELab::GridFunctionTraits< PL::Traits::GridViewType, PL::Traits::RangeFieldType, PL::Traits::GridViewType::dimension, Dune::FieldVector< PL::Traits::RangeFieldType, PL::Traits::GridViewType::dimension > >, DarcyVelocityFromHeadCCFV< T, PL > > | |
CDune::PDELab::GridFunctionBase< Dune::PDELab::GridFunctionTraits< T::Traits::GridViewType, T::Traits::FiniteElementType::Traits::LocalBasisType ::Traits::RangeFieldType, T::Traits::FiniteElementType::Traits::LocalBasisType::Traits ::dimDomain, Dune::FieldVector< T::Traits::FiniteElementType::Traits ::LocalBasisType::Traits::RangeFieldType, T::Traits::FiniteElementType::Traits::LocalBasisType::Traits ::dimDomain > >, DarcyVelocityFromHeadFEM< P, T, X > > | |
CDune::PDELab::GridFunctionBase< Dune::PDELab::GridFunctionTraits< T::Traits::GridViewType, T::Traits::RangeFieldType, T::Traits::dimDomain, Dune::FieldVector< T::Traits::RangeFieldType, T::Traits::dimDomain > >, DiagonalPermeabilityAdapter< T > > | |
CDune::PDELab::GridFunctionBase< T, AnalyticGridFunctionBase< T, Imp > > | |
CDune::PDELab::GridFunctionBase< AnalyticGridFunctionTraits< GV, RF, 1 >, AnalyticGridFunctionBase< AnalyticGridFunctionTraits< GV, RF, 1 >, ConstGridFunction< GV, RF, 1 > > > | |
CDune::PDELab::GridFunctionBase< Dune::PDELab::GridFunctionTraits< T::Traits::GridViewType, T::Traits::RangeFieldType, 1, Dune::FieldVector< T::Traits::RangeFieldType, 1 > >, ConvectionDiffusionDirichletExtensionAdapter< T > > | |
CDune::PDELab::GridFunctionBase< Dune::PDELab::GridFunctionTraits< T::Traits::GridViewType, T::Traits::RangeFieldType, T::Traits::GridViewType::dimension, Dune::FieldVector< T::Traits::RangeFieldType, T::Traits::GridViewType::dimension > >, ConvectionDiffusionExactGradientAdapter< T > > | |
CDune::PDELab::GridFunctionBase< Dune::PDELab::AnalyticGridFunctionTraits< T::Traits::GridViewType, T::Traits::RangeFieldType, T::Traits::GridViewType::dimension >, AnalyticGridFunctionBase< Dune::PDELab::AnalyticGridFunctionTraits< T::Traits::GridViewType, T::Traits::RangeFieldType, T::Traits::GridViewType::dimension >, ConvectionDiffusionVelocityExtensionAdapter< T > > > | |
CDune::PDELab::GridFunctionBase< Dune::PDELab::GridFunctionTraits< T1::Traits::GridViewType, T1::Traits::RangeFieldType, 1, Dune::FieldVector< T1::Traits::RangeFieldType, 1 > >, DifferenceAdapter< T1, T2 > > | |
CDune::PDELab::GridFunctionBase< Dune::PDELab::GridFunctionTraits< T1::Traits::GridViewType, T1::Traits::RangeFieldType, 1, Dune::FieldVector< T1::Traits::RangeFieldType, 1 > >, DifferenceSquaredAdapter< T1, T2 > > | |
CDune::PDELab::GridFunctionBase< Dune::PDELab::GridFunctionTraits< T::Traits::GridViewType, T::Traits::RangeFieldType, 1, Dune::FieldVector< T::Traits::RangeFieldType, 1 > >, DirichletBoundaryCondition_CD< T > > | |
CDune::PDELab::GridFunctionBase< GridFunctionTraits< T::Traits::GridViewType, BasisInterfaceSwitch< FiniteElementInterfaceSwitch< T::Traits::FiniteElementType >::Basis >::RangeField, BasisInterfaceSwitch< FiniteElementInterfaceSwitch< T::Traits::FiniteElementType >::Basis >::dimRange, BasisInterfaceSwitch< FiniteElementInterfaceSwitch< T::Traits::FiniteElementType >::Basis >::Range >, DiscreteGridFunction< T, X > > | |
CDune::PDELab::GridFunctionBase< GridFunctionTraits< T::Traits::GridViewType, JacobianToCurl< T::Traits::FiniteElementType::Traits::LocalBasisType::Traits::JacobianType >::CurlField, JacobianToCurl< T::Traits::FiniteElementType::Traits::LocalBasisType::Traits::JacobianType >::dimCurl, JacobianToCurl< T::Traits::FiniteElementType::Traits::LocalBasisType::Traits::JacobianType >::Curl >, DiscreteGridFunctionCurl< T, X > > | |
CDune::PDELab::GridFunctionBase< DiscreteGridFunctionCurlTraits< T::Traits::GridViewType, T::Traits::FiniteElementType::Traits::LocalBasisType::Traits::RangeFieldType, T::Traits::FiniteElementType::Traits::LocalBasisType::Traits::dimRange >, DiscreteGridFunctionGlobalCurl< T, X > > | |
CDune::PDELab::GridFunctionBase< GridFunctionTraits< T::Traits::GridViewType, T::Traits::FiniteElementType::Traits::LocalBasisType ::Traits::RangeFieldType, T::Traits::FiniteElementType::Traits::LocalBasisType::Traits ::dimDomain, FieldVector< T::Traits::FiniteElementType::Traits ::LocalBasisType::Traits::RangeFieldType, T::Traits::FiniteElementType::Traits::LocalBasisType::Traits ::dimDomain > >, DiscreteGridFunctionGradient< T, X > > | |
CDune::PDELab::GridFunctionBase< GridFunctionTraits< T::Traits::GridViewType, T::Traits::FiniteElementType::Traits::LocalBasisType::Traits::RangeFieldType, T::Traits::FiniteElementType::Traits::LocalBasisType::Traits::dimRange, T::Traits::FiniteElementType::Traits::LocalBasisType::Traits::RangeType >, DiscreteGridFunctionPiola< T, X > > | |
CDune::PDELab::GridFunctionBase< GF1::Traits, DivisionGridFunctionAdapter< GF1, GF2 > > | |
CDune::PDELab::GridFunctionBase< GridFunctionTraits< G, T::Traits::RangeFieldType, T::Traits::dimRange, T::Traits::RangeType >, FunctionToGridFunctionAdapter< G, T > > | |
CDune::PDELab::GridFunctionBase< Dune::PDELab::GridFunctionTraits< GV, RF, n, Dune::FieldVector< RF, n > >, GlobalCallableToGridFunctionAdapter< GV, RF, n, F > > | |
CDune::PDELab::GridFunctionBase< Dune::PDELab::GridFunctionTraits< GV, RF, n, Dune::FieldVector< RF, n > >, GlobalCallableToInstationaryGridFunctionAdapter< GV, RF, n, F, P > > | |
CDune::PDELab::GridFunctionBase< Imp::Traits, GridFunctionBaseAdapter< Imp > > | |
CDune::PDELab::GridFunctionBase< GF::Traits, InverseGridFunctionAdapter< GF > > | |
CDune::PDELab::GridFunctionBase< Dune::PDELab::GridFunctionTraits< T::Traits::GridViewType, T::Traits::RangeFieldType, T::Traits::dimDomain+1, Dune::FieldVector< T::Traits::RangeFieldType, T::Traits::dimDomain+1 > >, LinearAcousticsInitialValueAdapter< T > > | |
CDune::PDELab::GridFunctionBase< Dune::PDELab::GridFunctionTraits< T::Traits::GridViewType, T::Traits::RangeFieldType, T::Traits::dimRange, T::Traits::RangeType >, LinearElasticityDirichletExtensionAdapter< T > > | |
CDune::PDELab::GridFunctionBase< Dune::PDELab::GridFunctionTraits< GV, RF, n, Dune::FieldVector< RF, n > >, LocalCallableToGridFunctionAdapter< GV, RF, n, F > > | |
CDune::PDELab::GridFunctionBase< Dune::PDELab::GridFunctionTraits< GV, RF, n, Dune::FieldVector< RF, n > >, LocalCallableToInstationaryGridFunctionAdapter< GV, RF, n, F, P > > | |
CDune::PDELab::GridFunctionBase< Dune::PDELab::GridFunctionTraits< T::Traits::GridViewType, T::Traits::RangeFieldType, T::Traits::dimDomain *2, Dune::FieldVector< T::Traits::RangeFieldType, T::Traits::dimDomain *2 > >, MaxwellInitialValueAdapter< T > > | |
CDune::PDELab::GridFunctionBase< GridFunctionTraits< GV, RF, 1, FieldVector< RF, 1 > >, MemberFunctionToGridFunctionAdaptor< Member, Class, GV, RF, 1 > > | |
CDune::PDELab::GridFunctionBase< GF1::Traits, MinusGridFunctionAdapter< GF1, GF2 > > | |
CDune::PDELab::GridFunctionBase< Dune::PDELab::GridFunctionTraits< T::Traits::GridViewType, T::Traits::RangeFieldType, 1, Dune::FieldVector< T::Traits::RangeFieldType, 1 > >, NormalFluxGridFunctionAdapter< T > > | |
CDune::PDELab::GridFunctionBase< T::Traits, PiolaBackwardAdapter< T > > | |
CDune::PDELab::GridFunctionBase< F0::Traits, PointwiseGridFunctionAdapter< Engine, F0, Functions... > > | |
CDune::PDELab::GridFunctionBase< GridFunctionTraits< GF1::Traits::GridViewType, GF1::Traits::RangeFieldType, 1, FieldVector< GF1::Traits::RangeFieldType, 1 > >, ProductGridFunctionAdapter< GF1, GF2 > > | |
CDune::PDELab::GridFunctionBase< GridFunctionTraits< GF1::Traits::GridViewType, GF1::Traits::RangeFieldType, 1, FieldVector< GF1::Traits::RangeFieldType, 1 > >, ProductGridFunctionAdapter< GF2, GF1 > > | |
CDune::PDELab::GridFunctionBase< GF2::Traits, ProductGridFunctionAdapter< GF1, GF2 > > | |
CDune::PDELab::GridFunctionBase< GF::Traits, ScalarScaledGridFunctionAdapter< GF > > | |
CDune::PDELab::GridFunctionBase< GridFunctionTraits< GF::Traits::GridViewType, GF::Traits::RangeFieldType, 1, FieldVector< GF::Traits::RangeFieldType, 1 > >, SelectComponentGridFunctionAdapter< GF, 1 > > | |
CDune::PDELab::GridFunctionBase< GridFunctionTraits< GF::Traits::GridViewType, GF::Traits::RangeFieldType, 1, FieldVector< GF::Traits::RangeFieldType, 1 > >, SqrGridFunctionAdapter< GF > > | |
CDune::PDELab::GridFunctionBase< GF::Traits, SqrtGridFunctionAdapter< GF > > | |
CDune::PDELab::GridFunctionBase< GridFunctionTraits< GV, RF, 1, FieldVector< RF, 1 > >, TwoArgsMemberFunctionToGridFunctionAdaptor< Member, Class, GV, RF, 1 > > | |
CDune::PDELab::GridFunctionBase< GridFunctionTraits< FS::GV, FS::NT, 1, FieldVector< FS::NT, 1 > >, UserFunction< FS, Functor > > | |
CDune::PDELab::GridFunctionBase< Dune::PDELab::GridFunctionTraits< PL::Traits::GridViewType, PL::Traits::RangeFieldType, PL::Traits::GridViewType::dimension, Dune::FieldVector< PL::Traits::RangeFieldType, PL::Traits::GridViewType::dimension > >, V_g< TP, PL, PG > > | |
CDune::PDELab::GridFunctionBase< Dune::PDELab::GridFunctionTraits< PL::Traits::GridViewType, PL::Traits::RangeFieldType, PL::Traits::GridViewType::dimension, Dune::FieldVector< PL::Traits::RangeFieldType, PL::Traits::GridViewType::dimension > >, V_l< TP, PL, PG > > | |
CDune::PDELab::GridFunctionBase< GridFunctionTraits< T::Traits::GridViewType, T::template Child< 0 >::Type::Traits::FiniteElementType ::Traits::LocalBasisType::Traits::RangeFieldType, TypeTree::StaticDegree< T >::value, Dune::FieldVector< T::template Child< 0 >::Type::Traits::FiniteElementType ::Traits::LocalBasisType::Traits::RangeFieldType, TypeTree::StaticDegree< T >::value > >, VectorDiscreteGridFunction< T, X > > | |
CDune::PDELab::GridFunctionBase< Dune::PDELab::GridFunctionTraits< T::Traits::GridViewType, T::template Child< 0 >::Type::Traits::FiniteElementType::Traits::LocalBasisType::Traits::RangeFieldType, T::template Child< 0 >::Type::Traits::FiniteElementType::Traits::LocalBasisType::Traits::dimRange, T::template Child< 0 >::Type::Traits::FiniteElementType::Traits::LocalBasisType::Traits::RangeType >, VectorDiscreteGridFunctionDiv< T, X > > | |
CDune::PDELab::GridFunctionBase< Dune::PDELab::GridFunctionTraits< T::Traits::GridViewType, T::template Child< 0 >::Type::Traits::FiniteElementType::Traits::LocalBasisType::Traits::RangeFieldType, TypeTree::StaticDegree< T >::value, Dune::FieldVector< T::template Child< 0 >::Type::Traits::FiniteElementType ::Traits::LocalBasisType::Traits::RangeFieldType, TypeTree::StaticDegree< T >::value > >, VectorDiscreteGridFunctionCurl< T, X > > | |
CDune::PDELab::GridFunctionBase< GridFunctionTraits< T::Traits::GridViewType, T::template Child< 0 >::Type::Traits::FiniteElementType::Traits::LocalBasisType::Traits::RangeFieldType, TypeTree::StaticDegree< T >::value, Dune::FieldMatrix< T::template Child< 0 >::Type::Traits::FiniteElementType::Traits::LocalBasisType::Traits::RangeFieldType, TypeTree::StaticDegree< T >::value, T::template Child< 0 >::Type::Traits::FiniteElementType::Traits::LocalBasisType::Traits::dimDomain > >, VectorDiscreteGridFunctionGradient< T, X > > | |
CDune::PDELab::GridFunctionBase< GridFunctionTraits< LFS::Traits::GridView, BasisInterfaceSwitch< FiniteElementInterfaceSwitch< LFS::Traits::FiniteElement >::Basis >::RangeField, BasisInterfaceSwitch< FiniteElementInterfaceSwitch< LFS::Traits::FiniteElement >::Basis >::dimRange, BasisInterfaceSwitch< FiniteElementInterfaceSwitch< LFS::Traits::FiniteElement >::Basis >::Range >, DGFTreeLeafFunction< LFS, Data > > | |
CDune::PDELab::GridFunctionBase< GridFunctionTraits< LFS::Traits::GridView, BasisInterfaceSwitch< FiniteElementInterfaceSwitch< LFS::ChildType::Traits::FiniteElement >::Basis >::RangeField, TypeTree::StaticDegree< LFS >::value, Dune::FieldVector< BasisInterfaceSwitch< FiniteElementInterfaceSwitch< LFS::ChildType::Traits::FiniteElement >::Basis >::RangeField, TypeTree::StaticDegree< LFS >::value > >, DGFTreeVectorFunction< LFS, Data > > | |
CDune::PDELab::GridFunctionBase< Dune::PDELab::GridFunctionTraits< T::Traits::GridViewType, T::Traits::RangeFieldType, 1, Dune::FieldVector< T::Traits::RangeFieldType, 1 > >, PermeabilityAdapter< T > > | |
CDune::PDELab::GridFunctionSpace< impl::EntitySet< GV >, FEM, NoConstraints, LeafBackend, DefaultLeafOrderingTag > | |
CDune::PDELab::BoundaryGridFunctionBase< T, Imp > | Leaf of a function tree |
►CDune::PDELab::ConformingDirichletConstraints | Dirichlet Constraints construction |
CDune::PDELab::HangingNodesDirichletConstraints< Grid, HangingNodesConstraintsAssemblerType, BoundaryFunction > | Hanging Node constraints construction |
CDune::PDELab::NonoverlappingConformingDirichletConstraints< GV > | Extend conforming constraints class by processor boundary |
CDune::PDELab::OverlappingConformingDirichletConstraints | Extend conforming constraints class by processor boundary |
►CDune::PDELab::DirichletConstraintsParameters | |
CDune::PDELab::BCTypeParam_CD< T > | |
CDune::PDELab::ConvectionDiffusionBoundaryConditionAdapter< T > | |
CDune::PDELab::GlobalCallableToBoundaryConditionAdapter< F > | Adapter for boundary cond from a callable taking global coordinates |
CDune::PDELab::LinearElasticityParameterInterface< T, Imp > | Base class for linear elasticity parameter class |
CDune::PDELab::LocalCallableToBoundaryConditionAdapter< F > | Adapter for boundary cond from a callable taking an entity and local coordinates |
CDune::PDELab::StokesPressureDirichletConstraints< PRM > | |
CDune::PDELab::StokesVelocityDirichletConstraints< PRM > | |
CDune::PDELab::DirichletFromFluxConstraintsAdapter< FluxConstraintsParameters > | |
CDune::PDELab::Experimental::GridFunctionSpace< DFBasis, VBE, CE > | A pdelab grid function space implemented by a dune-functions function space basis |
CDune::PDELab::Experimental::GridFunctionSpace< DFBasis, VBE, CE >::LeafOrdering | The actual Ordering object of the grid function space |
►CDune::PDELab::FluxConstraintsParameters | |
CDune::PDELab::ConvectionDiffusionBoundaryConditionAdapter< T > | |
CDune::PDELab::LocalCallableToBoundaryConditionAdapter< F > | Adapter for boundary cond from a callable taking an entity and local coordinates |
CDune::PDELab::FluxFromDirichletConstraintsAdapter< DirichletConstraintsParameters > | |
CDune::PDELab::GridFunctionBase< T, Imp > | Leaf of a function tree |
CDune::PDELab::GridFunctionSpace< ES, FEM, CE, B, O > | A grid function space |
CDune::PDELab::InteriorNodeConstraints | Constraints all DOFs associated with interior vertices This allows to implement surface FEM using standard first order FEM |
CDune::PDELab::LeafLocalFunctionSpaceNode< GFS, DOFIndex > | Single component local function space |
CDune::PDELab::NoConstraintsParameters | |
CDune::PDELab::NoDirichletConstraintsParameters | |
CDune::PDELab::NoFluxConstraintsParameters | |
CDune::PDELab::P0ParallelConstraints | Parallel P0 constraints for overlapping grids |
CDune::PDELab::P0ParallelGhostConstraints | Parallel P0 constraints for nonoverlapping grids with ghosts |
CDune::PDELab::RT0Constraints | Neumann Constraints construction, as needed for RT0 |
CDune::TypeTree::LeafNodeTag | Tag designating a leaf node |
CDune::PDELab::LeafOrderingTag< Params > | Tag indicating a standard ordering for a leaf GridfunctionSpace |
►CDune::PDELab::gfs::LeafSubSpaceFeatures< GFS, TreePath, Tag > | Additional features used by leaf subspaces |
CDune::PDELab::gfs::SubSpaceFeatureProvider< GFS, TreePath, Tag > | |
►CDune::PDELab::gfs::LeafSubSpaceFeatures< GFS, TreePath, TypeTree::ImplementationTag< TypeTree::ChildForTreePath< GFS, TreePath > > > | |
CDune::PDELab::gfs::SubSpaceFeatureProvider< GFS, TreePath, TypeTree::ImplementationTag< TypeTree::ChildForTreePath< GFS, TreePath > > > | |
CDune::LegendreStuff::LegendrePolynomials1d< D, R, k > | The 1d Legendre Polynomials (k=0,1 are specialized below) |
CDune::LegendreStuff::LegendrePolynomials1d< Geometry::ctype, RF, k > | |
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::Amg::AggregationLevelTransferPolicy< O, C > | A LeveTransferPolicy that used aggregation to construct the coarse level system |
CDune::PDELab::LexicographicOrderingTag | Indicate lexicographic ordering of the unknowns of non-leaf grid function spaces |
CDune::PDELab::LinearAcousticsEigenvectors< 1 > | Provide matrix which contains rowwise the eigenvectors of linear acoustics problem |
CDune::PDELab::LinearAcousticsEigenvectors< 2 > | Provide matrix which contains rowwise the eigenvectors of linear acoustics problem |
CDune::PDELab::LinearAcousticsEigenvectors< 3 > | Provide matrix which contains rowwise the eigenvectors of linear acoustics problem |
CDune::PDELab::LinearAcousticsParameterTraits< GV, RF > | Traits class for linear acoustics parameters |
CDune::PDELab::LinearElasticityParameterTraits< GV, RF > | Traits class for linear elasticity parameters |
►CDune::LinearOperator< X, Y > | A linear operator |
►CDune::AssembledLinearOperator< M, X, Y > | A linear operator exporting itself in matrix form |
CDune::MatrixAdapter< M, X, Y > | Adapter to turn a matrix into a linear operator |
CDune::NonoverlappingSchwarzOperator< M, X, Y, C > | A nonoverlapping operator with communication object |
CDune::OverlappingSchwarzOperator< M, X, Y, C > | An overlapping Schwarz operator |
CDune::PDELab::NonoverlappingOperator< GFS, M, X, Y > | Operator for the non-overlapping parallel case |
CDune::PDELab::OnTheFlyOperator< X, Y, GO > | |
CDune::LinearOperator< OP1::domain_type, OP1::range_type > | |
►CDune::LinearOperator< V, W > | |
CDune::PDELab::OnTheFlyOperator< V, W, GO > | |
►CDune::LinearOperator< W, W > | |
CDune::PDELab::impl::BlockDiagonalOperator< BlockDiagonalLocalOperator, W, XView, EG, LFSU, LFSV > | Create ISTL operator that applies a local block diagonal |
CDune::LinearOperator< X, X > | |
CDune::PDELab::LinearSolverHasIsMatrixFree< LS, std::void_t< decltype(std::declval< LS >().isMatrixFree)> > | SFINAE check if a linear solver backend has a isMatrixFree method |
CDune::PDELab::LineSearchInterface< Domain > | Abstract base class describing the line search interface |
►CDune::PDELab::LineSearchInterface< Solver::Domain > | |
CDune::PDELab::LineSearchHackbuschReusken< Solver > | Hackbusch-Reusken line search |
CDune::PDELab::LineSearchNone< Solver > | Class for simply updating the solution without line search |
CDune::PDELab::LocalAssemblerBase< B, CU, CV > | Base class for local assembler |
►CDune::PDELab::LocalAssemblerBase< B, CU, CV > | |
CDune::PDELab::LocalAssemblerInterface< B, CU, CV > | The local assembler which provides the engines that drive the global assembler |
►CDune::PDELab::LocalAssemblerBase< GO::Traits::MatrixBackend, GO::Traits::TrialGridFunctionSpaceConstraints, GO::Traits::TestGridFunctionSpaceConstraints > | |
CDune::PDELab::DefaultLocalAssembler< GridOperator, LOP, GFSU::Traits::EntitySet::Partitions::partitionIterator()==InteriorBorder_Partition > | |
CDune::PDELab::DefaultLocalAssembler< GridOperator, CGTODGLOP, GFSU::Traits::EntitySet::Partitions::partitionIterator()==InteriorBorder_Partition > | |
CDune::PDELab::FastDGLocalAssembler< FastDGGridOperator, LOP, GFSU::Traits::EntitySet::Partitions::partitionIterator()==InteriorBorder_Partition > | |
CDune::PDELab::OneStepLocalAssembler< OneStepGridOperator, LocalAssemblerDT0, LocalAssemblerDT1 > | |
CDune::PDELab::DefaultLocalAssembler< GO, LOP, nonoverlapping_mode > | The local assembler for DUNE grids |
CDune::PDELab::FastDGLocalAssembler< GO, LOP, nonoverlapping_mode > | The local assembler for DUNE grids |
CDune::PDELab::OneStepLocalAssembler< GO, LA0, LA1 > | The local assembler for one step methods |
CDune::PDELab::LocalAssemblerEngine | The local assembler engine which handles the integration parts as provided by the global assemblers |
►CDune::PDELab::LocalAssemblerEngineBase | Base class for LocalAssemblerEngine implementations to avoid boilerplate code |
CDune::PDELab::DefaultLocalJacobianApplyAssemblerEngine< DefaultLocalAssembler > | |
CDune::PDELab::DefaultLocalJacobianAssemblerEngine< DefaultLocalAssembler > | |
CDune::PDELab::DefaultLocalPatternAssemblerEngine< DefaultLocalAssembler > | |
CDune::PDELab::DefaultLocalResidualAssemblerEngine< DefaultLocalAssembler > | |
CDune::PDELab::FastDGLocalJacobianApplyAssemblerEngine< FastDGLocalAssembler > | |
CDune::PDELab::FastDGLocalJacobianAssemblerEngine< FastDGLocalAssembler > | |
CDune::PDELab::FastDGLocalPatternAssemblerEngine< FastDGLocalAssembler > | |
CDune::PDELab::FastDGLocalResidualAssemblerEngine< FastDGLocalAssembler > | |
CDune::PDELab::OneStepExplicitLocalJacobianResidualAssemblerEngine< OneStepLocalAssembler > | |
CDune::PDELab::DefaultLocalJacobianApplyAssemblerEngine< LA > | The local assembler engine for DUNE grids which assembles the local application of the Jacobian |
CDune::PDELab::DefaultLocalJacobianAssemblerEngine< LA > | The local assembler engine for DUNE grids which assembles the jacobian matrix |
CDune::PDELab::DefaultLocalPatternAssemblerEngine< LA > | The local assembler engine for DUNE grids which creates the matrix pattern |
CDune::PDELab::DefaultLocalResidualAssemblerEngine< LA > | The local assembler engine for DUNE grids which assembles the residual vector |
CDune::PDELab::FastDGLocalJacobianApplyAssemblerEngine< LA > | The fast DG local assembler engine for DUNE grids which assembles the local application of the Jacobian |
CDune::PDELab::FastDGLocalJacobianAssemblerEngine< LA > | The fast DG local assembler engine for DUNE grids which assembles the jacobian matrix |
CDune::PDELab::FastDGLocalPatternAssemblerEngine< LA > | The fast DG local assembler engine for DUNE grids which creates the matrix pattern |
CDune::PDELab::FastDGLocalResidualAssemblerEngine< LA > | The fast DG local assembler engine for DUNE grids which assembles the residual vector |
CDune::PDELab::OneStepExplicitLocalJacobianResidualAssemblerEngine< OSLA > | The local assembler engine for DUNE grids which assembles the residual vector |
CDune::PDELab::LocalAssemblerTraits< GO > | |
CDune::PDELab::LocalBasisCache< LocalBasisType > | Store values of basis functions and gradients in a cache |
CDune::LocalBasisTraits< DF, n, D, RF, m, R, J > | Type traits for LocalBasisVirtualInterface |
►CDune::LocalBasisVirtualInterface< T > | Virtual base class for a local basis |
CDune::LocalBasisVirtualImp< T, Imp > | Class for wrapping a basis using the virtual interface |
►CDune::LocalBasisVirtualInterface< LocalBasisTraits > | |
CDune::LocalBasisVirtualImp< LocalBasisTraits, typename Imp::Traits::LocalBasisType > | |
►CDune::LocalCoefficientsVirtualInterface | Virtual base class for local coefficients |
CDune::LocalCoefficientsVirtualImp< typename Imp::Traits::LocalCoefficientsType > | |
►CDune::LocalCoefficientsVirtualImp< Imp > | Class for wrapping local coefficients using the virtual interface |
CDune::RefinedP0LocalCoefficients< 1 > | |
CDune::RefinedP0LocalCoefficients< 2 > | |
CDune::RefinedP0LocalCoefficients< 3 > | |
CDune::BDFMCubeLocalCoefficients< D, R, dim, order > | Layout map for Brezzi-Douglas-Fortin-Marini elements on cubes |
CDune::BDM1Cube2DLocalCoefficients | Layout map for Brezzi-Douglas-Marini-1 elements on quadrilaterals |
CDune::BDM1Cube3DLocalCoefficients | Layout map for Brezzi-Douglas-Marini-1 elements on hexahedra |
CDune::BDM1Simplex2DLocalCoefficients | Layout map for Brezzi-Douglas-Marini-1 elements on triangles |
CDune::BDM2Cube2DLocalCoefficients | Layout map for Brezzi-Douglas-Marini-2 elements on quadrilaterals |
CDune::BDM2Simplex2DLocalCoefficients | Layout map for Brezzi-Douglas-Marini-2 elements on triangles |
CDune::DualP1LocalCoefficients< dim > | Local coefficients for dual simplex P1 elements |
CDune::DualQ1LocalCoefficients< dim > | Layout map for dual Q1 elements |
CDune::LegendreStuff::DGLegendreLocalCoefficients< k, d > | Layout map for Q1 elements |
CDune::MimeticLocalCoefficients | ! |
CDune::MonomialLocalCoefficients< static_size > | Layout map for monomial finite elements |
CDune::P0LocalCoefficients | Layout map for P0 elements |
CDune::QkStuff::QkDGLocalCoefficients< k, d > | Layout map for Q1 elements |
CDune::RT02DLocalCoefficients | Layout map for RT0 elements |
CDune::RT03DLocalCoefficients | Layout map for RT0 elements |
CDune::RT0Cube2DLocalCoefficients | Layout map for RT0 elements on quadrilaterals |
CDune::RT0Cube3DLocalCoefficients | Layout map for RT0 elements on quadrilaterals |
CDune::RT1Cube2DLocalCoefficients | Layout map for Raviart-Thomas-1 elements on quadrilaterals |
CDune::RT1Cube3DLocalCoefficients | Layout map for Raviart-Thomas-1 elements on quadrilaterals |
CDune::RT2Cube2DLocalCoefficients | Layout map for Raviart-Thomas-2 elements on quadrilaterals |
CDune::RT3Cube2DLocalCoefficients | Layout map for Raviart-Thomas-3 elements on quadrilaterals |
CDune::RT4Cube2DLocalCoefficients | Layout map for Raviart-Thomas-4 elements on quadrilaterals |
CDune::RefinedP0LocalCoefficients< k > | Layout map for RefinedP0 elements |
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::PDELab::LocalFiniteElementMapInterface< T, Imp > | Interface for a finite element map |
CDune::PDELab::LocalFiniteElementMapInterface< Dune::PDELab::LocalFiniteElementMapTraits< MimeticLocalFiniteElement< D, R, dim > >, MimeticLocalFiniteElementMap< IIS, D, R, dim > > | |
►CDune::PDELab::LocalFiniteElementMapInterface< LocalFiniteElementMapTraits< Dune::BDM1Cube2DLocalFiniteElement< D, R > >, BDM1Cube2DLocalFiniteElementMap< GV, D, R > > | |
CDune::PDELab::BDM1Cube2DLocalFiniteElementMap< GV, D, R > | |
►CDune::PDELab::LocalFiniteElementMapInterface< LocalFiniteElementMapTraits< Dune::BDM1Simplex2DLocalFiniteElement< D, R > >, BDM1Simplex2DLocalFiniteElementMap< GV, D, R > > | |
CDune::PDELab::BDM1Simplex2DLocalFiniteElementMap< GV, D, R > | |
►CDune::PDELab::LocalFiniteElementMapInterface< LocalFiniteElementMapTraits< Dune::LagrangeSimplexLocalFiniteElement< D, R, 1, k > >, SimpleLocalFiniteElementMap< Dune::LagrangeSimplexLocalFiniteElement< D, R, 1, k >, dim_ > > | |
CDune::PDELab::SimpleLocalFiniteElementMap< Dune::LagrangeSimplexLocalFiniteElement< D, R, 1, k >, 1 > | |
CDune::PDELab::LocalFiniteElementMapInterface< LocalFiniteElementMapTraits< Dune::LagrangeSimplexLocalFiniteElement< D, R, 2, k > >, PkLocalFiniteElementMapBase< GV, D, R, k, 2 > > | |
CDune::PDELab::LocalFiniteElementMapInterface< LocalFiniteElementMapTraits< Dune::LagrangeSimplexLocalFiniteElement< D, R, 3, k > >, PkLocalFiniteElementMapBase< GV, D, R, k, 3 > > | |
►CDune::PDELab::LocalFiniteElementMapInterface< LocalFiniteElementMapTraits< Dune::MonomialLocalFiniteElement< D, R, d, p > >, SimpleLocalFiniteElementMap< Dune::MonomialLocalFiniteElement< D, R, d, p >, dim_ > > | |
►CDune::PDELab::SimpleLocalFiniteElementMap< Dune::MonomialLocalFiniteElement< D, R, d, p >, d > | |
CDune::PDELab::MonomLocalFiniteElementMap< D, R, d, p > | |
►CDune::PDELab::LocalFiniteElementMapInterface< LocalFiniteElementMapTraits< Dune::OPBLocalFiniteElement< D, R, k, d, bt, R, basisType > >, SimpleLocalFiniteElementMap< Dune::OPBLocalFiniteElement< D, R, k, d, bt, R, basisType >, dim_ > > | |
►CDune::PDELab::SimpleLocalFiniteElementMap< Dune::OPBLocalFiniteElement< D, R, k, d, bt, R, basisType >, d > | |
►CDune::PDELab::OPBLocalFiniteElementMap< D, R, k, d, Dune::GeometryType::cube, R, Dune::PB::BasisType::Qk > | |
CDune::PDELab::QkDGLocalFiniteElementMap< D, R, k, d, QkDGBasisPolynomial::l2orthonormal > | Qk discontinuous Galerkin FiniteElementMap based on an L2 orthonormal polynomials |
►CDune::PDELab::LocalFiniteElementMapInterface< LocalFiniteElementMapTraits< Dune::OPBLocalFiniteElement< D, R, k, d, bt, R, PB::BasisType::Pk > >, SimpleLocalFiniteElementMap< Dune::OPBLocalFiniteElement< D, R, k, d, bt, R, PB::BasisType::Pk >, dim_ > > | |
►CDune::PDELab::SimpleLocalFiniteElementMap< Dune::OPBLocalFiniteElement< D, R, k, d, bt, R, PB::BasisType::Pk >, d > | |
CDune::PDELab::OPBLocalFiniteElementMap< D, R, k, d, bt, ComputationFieldType, basisType > | |
►CDune::PDELab::LocalFiniteElementMapInterface< LocalFiniteElementMapTraits< Dune::P0LocalFiniteElement< D, R, d > >, SimpleLocalFiniteElementMap< Dune::P0LocalFiniteElement< D, R, d >, dim_ > > | |
►CDune::PDELab::SimpleLocalFiniteElementMap< Dune::P0LocalFiniteElement< D, R, d >, d > | |
CDune::PDELab::P0LocalFiniteElementMap< D, R, d > | |
►CDune::PDELab::LocalFiniteElementMapInterface< LocalFiniteElementMapTraits< Dune::QkDGGLLocalFiniteElement< D, R, k, d > >, SimpleLocalFiniteElementMap< Dune::QkDGGLLocalFiniteElement< D, R, k, d >, dim_ > > | |
►CDune::PDELab::SimpleLocalFiniteElementMap< Dune::QkDGGLLocalFiniteElement< D, R, k, d >, d > | |
CDune::PDELab::QkDGLocalFiniteElementMap< D, R, k, d, QkDGBasisPolynomial::lobatto > | Qk discontinuous Galerkin FiniteElementMap based on Legendre polynomials at Gauss-Lobatto points |
►CDune::PDELab::LocalFiniteElementMapInterface< LocalFiniteElementMapTraits< Dune::QkDGLagrangeLocalFiniteElement< D, R, k, d > >, SimpleLocalFiniteElementMap< Dune::QkDGLagrangeLocalFiniteElement< D, R, k, d >, dim_ > > | |
►CDune::PDELab::SimpleLocalFiniteElementMap< Dune::QkDGLagrangeLocalFiniteElement< D, R, k, d >, d > | |
CDune::PDELab::QkDGLocalFiniteElementMap< D, R, k, d, QkDGBasisPolynomial::lagrange > | Qk discontinuous Galerkin FiniteElementMap based on Lagrange polynomials |
►CDune::PDELab::LocalFiniteElementMapInterface< LocalFiniteElementMapTraits< Dune::QkDGLegendreLocalFiniteElement< D, R, k, d > >, SimpleLocalFiniteElementMap< Dune::QkDGLegendreLocalFiniteElement< D, R, k, d >, dim_ > > | |
►CDune::PDELab::SimpleLocalFiniteElementMap< Dune::QkDGLegendreLocalFiniteElement< D, R, k, d >, d > | |
CDune::PDELab::QkDGLocalFiniteElementMap< D, R, k, d, QkDGBasisPolynomial::legendre > | Qk discontinuous Galerkin FiniteElementMap based on Legendre polynomials |
►CDune::PDELab::LocalFiniteElementMapInterface< LocalFiniteElementMapTraits< Dune::QkLocalFiniteElement< D, R, GV::dimension, k > >, SimpleLocalFiniteElementMap< Dune::QkLocalFiniteElement< D, R, GV::dimension, k >, dim_ > > | |
►CDune::PDELab::SimpleLocalFiniteElementMap< Dune::QkLocalFiniteElement< D, R, GV::dimension, k >, GV::dimension > | |
CDune::PDELab::QkLocalFiniteElementMap< GV, D, R, k > | |
►CDune::PDELab::LocalFiniteElementMapInterface< LocalFiniteElementMapTraits< Dune::RT02DLocalFiniteElement< D, R > >, RT0Simplex2DLocalFiniteElementMap< GV, D, R > > | |
►CDune::PDELab::RTLocalFiniteElementMap< GV, Dune::RT02DLocalFiniteElement< D, R >, RT0Simplex2DLocalFiniteElementMap< GV, D, R >, 8 > | |
CDune::PDELab::RT0Simplex2DLocalFiniteElementMap< GV, D, R > | |
►CDune::PDELab::LocalFiniteElementMapInterface< LocalFiniteElementMapTraits< Dune::RT03DLocalFiniteElement< D, R > >, RT0Simplex3DLocalFiniteElementMap< GV, D, R > > | |
►CDune::PDELab::RTLocalFiniteElementMap< GV, Dune::RT03DLocalFiniteElement< D, R >, RT0Simplex3DLocalFiniteElementMap< GV, D, R >, 16 > | |
CDune::PDELab::RT0Simplex3DLocalFiniteElementMap< GV, D, R > | |
►CDune::PDELab::LocalFiniteElementMapInterface< LocalFiniteElementMapTraits< Dune::RT0Cube2DLocalFiniteElement< D, R > >, RT0Cube2DLocalFiniteElementMap< GV, D, R > > | |
►CDune::PDELab::RTLocalFiniteElementMap< GV, Dune::RT0Cube2DLocalFiniteElement< D, R >, RT0Cube2DLocalFiniteElementMap< GV, D, R >, 16 > | |
CDune::PDELab::RT0Cube2DLocalFiniteElementMap< GV, D, R > | |
►CDune::PDELab::LocalFiniteElementMapInterface< LocalFiniteElementMapTraits< Dune::RT0Cube3DLocalFiniteElement< D, R > >, RT0Cube3DLocalFiniteElementMap< GV, D, R > > | |
►CDune::PDELab::RTLocalFiniteElementMap< GV, Dune::RT0Cube3DLocalFiniteElement< D, R >, RT0Cube3DLocalFiniteElementMap< GV, D, R >, 64 > | |
CDune::PDELab::RT0Cube3DLocalFiniteElementMap< GV, D, R > | |
►CDune::PDELab::LocalFiniteElementMapInterface< LocalFiniteElementMapTraits< Dune::RT12DLocalFiniteElement< D, R > >, RT1Simplex2DLocalFiniteElementMap< GV, D, R > > | |
►CDune::PDELab::RTLocalFiniteElementMap< GV, Dune::RT12DLocalFiniteElement< D, R >, RT1Simplex2DLocalFiniteElementMap< GV, D, R >, 8 > | |
CDune::PDELab::RT1Simplex2DLocalFiniteElementMap< GV, D, R > | |
►CDune::PDELab::LocalFiniteElementMapInterface< LocalFiniteElementMapTraits< Dune::RT1Cube2DLocalFiniteElement< D, R > >, RT1Cube2DLocalFiniteElementMap< GV, D, R > > | |
►CDune::PDELab::RTLocalFiniteElementMap< GV, Dune::RT1Cube2DLocalFiniteElement< D, R >, RT1Cube2DLocalFiniteElementMap< GV, D, R >, 16 > | |
CDune::PDELab::RT1Cube2DLocalFiniteElementMap< GV, D, R > | |
►CDune::PDELab::LocalFiniteElementMapInterface< LocalFiniteElementMapTraits< Dune::RT1Cube3DLocalFiniteElement< D, R > >, RT1Cube3DLocalFiniteElementMap< GV, D, R > > | |
►CDune::PDELab::RTLocalFiniteElementMap< GV, Dune::RT1Cube3DLocalFiniteElement< D, R >, RT1Cube3DLocalFiniteElementMap< GV, D, R >, 64 > | |
CDune::PDELab::RT1Cube3DLocalFiniteElementMap< GV, D, R > | |
►CDune::PDELab::LocalFiniteElementMapInterface< LocalFiniteElementMapTraits< Dune::RT2Cube2DLocalFiniteElement< D, R > >, RT2Cube2DLocalFiniteElementMap< GV, D, R > > | |
►CDune::PDELab::RTLocalFiniteElementMap< GV, Dune::RT2Cube2DLocalFiniteElement< D, R >, RT2Cube2DLocalFiniteElementMap< GV, D, R >, 16 > | |
CDune::PDELab::RT2Cube2DLocalFiniteElementMap< GV, D, R > | |
►CDune::PDELab::LocalFiniteElementMapInterface< LocalFiniteElementMapTraits< FE >, Imp > | |
CDune::PDELab::EdgeS0LocalFiniteElementMap< GV, FE, Imp > | Implementation for finite elements requiring oriented edges |
CDune::PDELab::RTLocalFiniteElementMap< GV, FE, Imp, Variants > | |
►CDune::PDELab::LocalFiniteElementMapInterface< LocalFiniteElementMapTraits< Imp >, SimpleLocalFiniteElementMap< Imp, dim_ > > | |
CDune::PDELab::SimpleLocalFiniteElementMap< Imp, dim_ > | Simple implementation where all entities have the same finite element |
►CDune::PDELab::LocalFiniteElementMapInterface< LocalFiniteElementMapTraits< LagrangeLocalFiniteElement< EquidistantPointSet, 1, D, R > >, SimpleLocalFiniteElementMap< LagrangeLocalFiniteElement< EquidistantPointSet, 1, D, R >, dim_ > > | |
►CDune::PDELab::SimpleLocalFiniteElementMap< LagrangeLocalFiniteElement< EquidistantPointSet, 1, D, R >, 1 > | |
CDune::PDELab::Pk1dLocalFiniteElementMap< D, R > | FiniteElementMap for the Pk basis in 1d |
►CDune::PDELab::LocalFiniteElementMapInterface< LocalFiniteElementMapTraits< RannacherTurekLocalFiniteElement< D, R, d > >, SimpleLocalFiniteElementMap< RannacherTurekLocalFiniteElement< D, R, d >, dim_ > > | |
►CDune::PDELab::SimpleLocalFiniteElementMap< RannacherTurekLocalFiniteElement< D, R, d >, d > | |
CDune::PDELab::RannacherTurekLocalFiniteElementMap< D, R, d > | |
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::LocalFiniteElementVirtualImp< Imp > | Class for wrapping a finite element using the virtual interface |
CDune::PDELab::LocalFunctionSpace< GFS, TAG > | Create a local function space from a global function space |
CDune::PDELab::LocalFunctionSpace< CGGFS, TrialSpaceTag > | |
CDune::PDELab::LocalFunctionSpace< GFS > | |
CDune::PDELab::LocalFunctionSpace< GFS, TestSpaceTag > | |
CDune::PDELab::LocalFunctionSpace< GFSC > | |
CDune::PDELab::LocalFunctionSpace< GFSF > | |
CDune::PDELab::LocalFunctionSpace< GFSU > | |
CDune::PDELab::LocalFunctionSpace< GFSU, TrialSpaceTag > | |
CDune::PDELab::LocalFunctionSpace< GFSV, TestSpaceTag > | |
CDune::PDELab::LocalFunctionSpace< GridFunctionSpace > | |
CDune::PDELab::LocalFunctionSpaceBaseTraits< GFS, DI > | Traits mapping global function space information to local function space |
►CDune::PDELab::LocalFunctionSpaceBaseTraits< GFS, DOFIndex > | |
►CDune::PDELab::GridViewLocalFunctionSpaceBaseTraits< GFS, DOFIndex > | Traits for local function space on a gridview |
►CDune::PDELab::PowerCompositeLocalFunctionSpaceTraits< GFS, DOFIndex, N > | Traits for multi component local function space |
CDune::PDELab::LeafLocalFunctionSpaceTraits< GFS, DOFIndex, N > | Traits for single component local function space |
CDune::LocalGeometryTypeIndex | Compute per-dimension indices for geometry types |
CDune::LocalIndex | An index present on the local process |
►CDune::LocalInterpolationVirtualInterfaceBase< DomainType, RangeType > | Virtual base class for a local interpolation |
►CDune::LocalInterpolationVirtualInterface< DomainType, RangeType > | Virtual base class for a local interpolation |
CDune::LocalInterpolationVirtualImp< DomainType, RangeType, Imp > | Class for wrapping a local interpolation using the virtual interface |
►CDune::LocalInterpolationVirtualInterfaceBase< typename LocalBasisTraits::DomainType, typename LocalBasisTraits::RangeType > | |
►CDune::LocalInterpolationVirtualInterface< typename LocalBasisTraits::DomainType, typename LocalBasisTraits::RangeType > | |
CDune::LocalInterpolationVirtualImp< typename LocalBasisTraits::DomainType, typename LocalBasisTraits::RangeType, typename Imp::Traits::LocalInterpolationType > | |
CDune::LocalKey | Describe 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::PDELab::LocalMatrix< T, W > | A dense matrix for storing data associated with the degrees of freedom of a pair of LocalFunctionSpaces |
CDune::PDELab::LocalMatrix< R > | |
►CDune::PDELab::LocalOperatorDefaultFlags | Default flags for all local operators |
CDune::PDELab::BlockDiagonalLocalOperatorFullCoupling< impl::ScalarL2 > | |
CDune::PDELab::BlockDiagonalLocalOperatorFullCoupling< ScalarLOP > | Block diagonal extension of scalar local operator |
CDune::PDELab::BlockDiagonalLocalOperatorWrapper< LocalOperator > | A local operator that accumulates the block diagonal |
CDune::PDELab::BlockOffDiagonalLocalOperatorWrapper< LocalOperator > | A local operator that accumulates the off block diagonal |
CDune::PDELab::BlockSORPreconditionerLocalOperator< JacobianLOP, BlockOffDiagonalLOP, GridFunctionSpace > | Turn a matrix-free Jacobi-type local preconditioner to a SOR one |
CDune::PDELab::ConvectionDiffusionCCFV< TP > | |
CDune::PDELab::ConvectionDiffusionCCFVTemporalOperator< TP > | |
CDune::PDELab::ConvectionDiffusionDG< T, FiniteElementMap > | |
CDune::PDELab::ConvectionDiffusionDG_ErrorIndicator< T > | Local operator for residual-based error estimation |
CDune::PDELab::ConvectionDiffusionFEM< T, FiniteElementMap > | |
CDune::PDELab::ConvectionDiffusionFEMResidualEstimator< T > | |
CDune::PDELab::ConvectionDiffusionTemporalResidualEstimator< T > | |
CDune::PDELab::ConvectionDiffusionTemporalResidualEstimator1< T > | |
CDune::PDELab::DGLinearAcousticsSpatialOperator< T, FEM > | |
CDune::PDELab::DGLinearAcousticsTemporalOperator< T, FEM > | |
CDune::PDELab::DGMaxwellSpatialOperator< T, FEM > | Spatial local operator for discontinuous Galerkin method for Maxwells Equations |
CDune::PDELab::DGMaxwellTemporalOperator< T, FEM > | |
CDune::PDELab::DGNavierStokes< PRM > | A local operator for solving the Navier-Stokes equations using a DG discretization |
CDune::PDELab::DGNavierStokesVelVecFEM< PRM > | A local operator for solving the Navier-Stokes equations using a DG discretization and a vector-valued finite element map for the velocity grid function space |
CDune::PDELab::Electrodynamic_S< Mu > | Contruct matrix S for the Electrodynamic operator |
CDune::PDELab::Electrodynamic_T< Eps > | Construct matrix T for the Electrodynamic operator |
CDune::PDELab::IterativeBlockJacobiPreconditionerLocalOperator< BlockDiagonalLocalOperator, PointDiagonalLocalOperator, GridFunctionSpace, DomainField, IterativeSolver > | Local operator that can be used to create a fully matrix-free Jacobi preconditioner |
CDune::PDELab::L2VolumeFunctional< F > | A local operator that tests a function against a test function space defined on the entire grid |
CDune::PDELab::LinearElasticity< T > | |
CDune::PDELab::LocalOperatorInterface | Class to document the stationary local operator interface |
CDune::PDELab::NavierStokesMass< PRM > | A local operator for the mass term corresponding to the instationary part in the Navier-Stokes equations |
CDune::PDELab::NavierStokesVelVecMass< PRM > | A local operator for the mass term corresponding to the instationary part in the Navier-Stokes equations using a vector-valued Finite Element map for the velocity grid function space |
CDune::PDELab::NonLinearConvectionDiffusionFEM< T > | |
CDune::PDELab::PointDiagonalLocalOperatorWrapper< LocalOperator > | A local operator that accumulates the point diagonal |
CDune::PDELab::TaylorHoodNavierStokes< P > | A local operator for the Navier-Stokes equations |
CDune::PDELab::TwoPhaseOnePointTemporalOperator< TP > | |
CDune::PDELab::ZeroLocalOperator< Time > | Do-nothing local operator |
CLOP_spatial_contaminant< Param, GFSF, ZF, GFSC, ZC, convection > | |
CLOP_spatial_flow< Param > | |
CDune::PDELab::LocalOperatorOvlpRegion< LocalOperatorBase, GFS > | Wrapper for LocalOperators restricting their action to areas overlapping with other subdomains Any entity not covered by multiple subdomains will be ignored by not evaluating the underlying LocalOperator. This wrapper can be used to generate the overlap matrix needed for the GenEO coarse space |
CDune::PDELab::LocalOrderingBase< ES, DI, CI > | Entity-wise orderings |
CDune::PDELab::LocalOrderingBase< ChildOrdering::Traits::EntitySet, ChildOrdering::Traits::DOFIndex, ChildOrdering::Traits::ContainerIndex > | |
CDune::PDELab::LocalOrderingBase< first_type< Children... >::type::Traits::EntitySet, first_type< Children... >::type::Traits::DOFIndex, first_type< Children... >::type::Traits::ContainerIndex > | |
CDune::PDELab::LocalTag | Insert standard boilerplate into log messages |
CDune::PDELab::LocalVector< T, LFSFlavorTag, W > | A container for storing data associated with the degrees of freedom of a LocalFunctionSpace |
CDune::PDELab::LocalVector< DomainElement, LocalTrialSpaceTag > | |
CDune::PDELab::LocalVector< RangeElement, LocalTestSpaceTag > | |
CDune::PDELab::LocalVector< ResidualElement, LocalTestSpaceTag > | |
CDune::PDELab::LocalVector< SolutionElement, LocalTrialSpaceTag > | |
CDune::PDELab::LocalVector< typename X::ElementType > | |
CDune::PDELab::LocalVector< value_type > | |
►CDune::PDELab::LogtagFormatterBase | Virtual base class for logger formatters |
CDune::PDELab::GeneralLogtagFormatter< FormatFunc > | A log tag formatter that wraps a unary formatting function or functor |
CDune::lru< Key, Tp, Traits > | LRU Cache Container |
CDune::MakeableInterfaceObject< InterfaceType > | |
►CDune::MallocAllocator< T > | Allocators implementation which simply calls malloc/free |
CDune::AlignedAllocator< T, Alignment > | Allocators which guarantee alignment of the memory |
►Cstd::map< K, T > | STL class |
CDune::GridViewInfo< ctype > | Structure to hold information about a certain GridView |
CDune::Mapper< G, MapperImp, IndexType > | Mapper interface |
►CDune::Mapper< GV::Grid, MultipleCodimMultipleGeomTypeMapper< G::LeafGridView >, GV::IndexSet::IndexType > | |
►CDune::MultipleCodimMultipleGeomTypeMapper< G::LeafGridView > | |
CDune::LeafMultipleCodimMultipleGeomTypeMapper< G > | Multiple codim and multiple geometry type mapper for leaf entities |
►CDune::Mapper< GV::Grid, MultipleCodimMultipleGeomTypeMapper< G::LevelGridView >, GV::IndexSet::IndexType > | |
►CDune::MultipleCodimMultipleGeomTypeMapper< G::LevelGridView > | |
CDune::LevelMultipleCodimMultipleGeomTypeMapper< G > | Multiple codim and multiple geometry type mapper for entities of one level |
►CDune::Mapper< GV::Grid, MultipleCodimMultipleGeomTypeMapper< GridView >, GV::IndexSet::IndexType > | |
CDune::MultipleCodimMultipleGeomTypeMapper< GridView > | |
►CDune::Mapper< GV::Grid, MultipleCodimMultipleGeomTypeMapper< GV >, GV::IndexSet::IndexType > | |
CDune::MultipleCodimMultipleGeomTypeMapper< GV > | Implementation class for a multiple codim and multiple geometry type mapper |
►CDune::Mapper< GV::Grid, SingleCodimSingleGeomTypeMapper< G::LeafGridView, c >, GV::IndexSet::IndexType > | |
►CDune::SingleCodimSingleGeomTypeMapper< G::LeafGridView, c > | |
CDune::LeafSingleCodimSingleGeomTypeMapper< G, c > | Single codim and single geometry type mapper for leaf entities |
►CDune::Mapper< GV::Grid, SingleCodimSingleGeomTypeMapper< G::LevelGridView, c >, GV::IndexSet::IndexType > | |
►CDune::SingleCodimSingleGeomTypeMapper< G::LevelGridView, c > | |
CDune::LevelSingleCodimSingleGeomTypeMapper< G, c > | Single codim and single geometry type mapper for entities of one level |
►CDune::Mapper< GV::Grid, SingleCodimSingleGeomTypeMapper< GridView, c >, GV::IndexSet::IndexType > | |
CDune::SingleCodimSingleGeomTypeMapper< GridView, 0 > | |
►CDune::Mapper< GV::Grid, SingleCodimSingleGeomTypeMapper< GV, c >, GV::IndexSet::IndexType > | |
CDune::SingleCodimSingleGeomTypeMapper< GV, c > | Implementation class for a single codim and single geometry type mapper |
CDune::MatMultMatResult< M1, M2 > | Helper TMP to get the result type of a sparse matrix matrix multiplication ( \(C=A*B\)) |
CDune::MatMultMatResult< PTADG, P > | |
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::MatrixIndexSet | Stores 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 |
CDune::PDELab::MaxwellEigenvectors< 3 > | Provide matrix which contains column-wise the eigenvectors of maxwell problem |
CDune::PDELab::MaxwellParameterTraits< GV, RF > | Traits class for convection diffusion parameters |
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::PDELab::MergeMode | Index merging algorithm for global orderings |
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_function | Marker 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::PB::MonomialEvaluate< F, d > | Compute \( \prod_{i=0}^{d-1} x_i^{a_i} \) |
CDune::PB::MonomialIntegrator< ComputationFieldType, bt, d > | Integrate monomials over the reference element |
CDune::PB::MonomialIntegrator< ComputationFieldType, Dune::GeometryType::cube, d > | Integrate monomials over the cube in any d |
CDune::PB::MonomialIntegrator< ComputationFieldType, Dune::GeometryType::simplex, 1 > | Integrate monomials over the unit interval considered as a simplex |
CDune::PB::MonomialIntegrator< ComputationFieldType, Dune::GeometryType::simplex, 2 > | Integrate monomials over the triangle |
CDune::PB::MonomialIntegrator< ComputationFieldType, Dune::GeometryType::simplex, 3 > | Integrate monomials over the tetrahedron |
CDune::MonomialLocalBasis< D, R, d, p > | Constant shape function |
CDune::MonomialLocalFiniteElement< D, R, d, p > | Monomial basis for discontinuous Galerkin methods |
CMPIError | MPI 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::MPIGuard | Detects a thrown exception and communicates to all other processes |
CDune::MPIHelper | A 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::PDELab::MultiCommGatherScatter< GFS, RankIndex, V > | Gather/scatter communication that passes a single function from each subdomain to all its neighbors |
CDune::MultiLinearGeometry< ct, mydim, cdim, Traits > | Generic geometry implementation based on corner coordinates |
►CDune::MultiLinearGeometry< ct, mydim, cdim, MultiLinearGeometryTraits< ct > > | |
CDune::CachedMultiLinearGeometry< ct, mydim, cdim, Traits > | Implement a MultiLinearGeometry with additional caching |
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::MultiplicativeSchwarzMode | Tag 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::PDELab::NavierStokesDefaultParameters< GV, RF, F, B, V, J, navier, tensor > | |
►CDune::PDELab::NavierStokesDefaultParameters< GV, RF, F, B, V, J, false, false > | |
CDune::PDELab::DGNavierStokesParameters< GV, RF, F, B, V, J, navier, full_tensor, IP > | Parameter class for local operator DGNavierStokes |
CDune::PDELab::NavierStokesParameterTraits< GV, RF > | |
CDune::PDELab::NavierStokesVelocityFunctionAdapter< PRM > | |
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::PDELab::ISTL::NestedPattern< RowOrdering, ColOrdering, SubPattern_ > | Pattern builder for nested hierarchies of generic BCRS-like sparse matrices |
CDune::PDELab::ISTL::nesting_depth< T > | TMP for figuring out the depth up to which ISTL containers are nested |
CDune::PDELab::NewtonMethod< GridOperator_, LinearSolver_ > | Newton solver for solving non-linear problems |
CDune::TypeTree::apply_to_tuple_policy::no_pass_index | Do not pass the index of the current tuple to the functor |
CDune::PDELab::NoConstOrderingSize< v > | Mixin indicating whether a leaf GridFunctionSpace should never assume a const ordering size |
CDune::TypeTree::NodeInterface | Interface for nodes in a dune-typetree |
CDune::Std::nonesuch | Type representing a lookup failure by std::detected_or and friends |
CDune::PDELab::NonLinearConvectionDiffusionParameterInterface< T, Imp > | Base class for parameter class |
CDune::PDELab::NonLinearConvectionDiffusionParameterTraits< GV, RF > | Traits class for two phase parameter class |
CDune::PDELab::NonOverlappingBorderDOFExchanger< GridOperator > | Helper class for adding up matrix entries on border |
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::PDELab::NumericalJacobianBoundary< Imp > | Implement jacobian_boundary() based on alpha_boundary() |
►CDune::PDELab::NumericalJacobianBoundary< ConvectionDiffusionFEM< T, FiniteElementMap > > | |
CDune::PDELab::ConvectionDiffusionFEM< T, FiniteElementMap > | |
►CDune::PDELab::NumericalJacobianBoundary< DGLinearAcousticsSpatialOperator< T, FEM > > | |
CDune::PDELab::DGLinearAcousticsSpatialOperator< T, FEM > | |
►CDune::PDELab::NumericalJacobianBoundary< DGMaxwellSpatialOperator< T, FEM > > | |
CDune::PDELab::DGMaxwellSpatialOperator< T, FEM > | Spatial local operator for discontinuous Galerkin method for Maxwells Equations |
►CDune::PDELab::NumericalJacobianBoundary< LOP_spatial_contaminant< Param, GFSF, ZF, GFSC, ZC, convection > > | |
CLOP_spatial_contaminant< Param, GFSF, ZF, GFSC, ZC, convection > | |
►CDune::PDELab::NumericalJacobianBoundary< LOP_spatial_flow< Param > > | |
CLOP_spatial_flow< Param > | |
►CDune::PDELab::NumericalJacobianBoundary< NonLinearConvectionDiffusionFEM< T > > | |
CDune::PDELab::NonLinearConvectionDiffusionFEM< T > | |
CDune::PDELab::NumericalJacobianBoundary< TwoPhaseTwoPointFluxOperator< TP > > | |
CDune::PDELab::NumericalJacobianSkeleton< Imp > | Implement jacobian_skeleton() based on alpha_skeleton() |
►CDune::PDELab::NumericalJacobianSkeleton< DGLinearAcousticsSpatialOperator< T, FEM > > | |
CDune::PDELab::DGLinearAcousticsSpatialOperator< T, FEM > | |
►CDune::PDELab::NumericalJacobianSkeleton< DGMaxwellSpatialOperator< T, FEM > > | |
CDune::PDELab::DGMaxwellSpatialOperator< T, FEM > | Spatial local operator for discontinuous Galerkin method for Maxwells Equations |
►CDune::PDELab::NumericalJacobianSkeleton< LOP_spatial_contaminant< Param, GFSF, ZF, GFSC, ZC, convection > > | |
CLOP_spatial_contaminant< Param, GFSF, ZF, GFSC, ZC, convection > | |
►CDune::PDELab::NumericalJacobianSkeleton< LOP_spatial_flow< Param > > | |
CLOP_spatial_flow< Param > | |
CDune::PDELab::NumericalJacobianSkeleton< TwoPhaseTwoPointFluxOperator< TP > > | |
CDune::PDELab::NumericalJacobianVolume< Imp > | Implement jacobian_volume() based on alpha_volume() |
►CDune::PDELab::NumericalJacobianVolume< ConvectionDiffusionFEM< T, FiniteElementMap > > | |
CDune::PDELab::ConvectionDiffusionFEM< T, FiniteElementMap > | |
►CDune::PDELab::NumericalJacobianVolume< DGLinearAcousticsSpatialOperator< T, FEM > > | |
CDune::PDELab::DGLinearAcousticsSpatialOperator< T, FEM > | |
►CDune::PDELab::NumericalJacobianVolume< DGMaxwellSpatialOperator< T, FEM > > | |
CDune::PDELab::DGMaxwellSpatialOperator< T, FEM > | Spatial local operator for discontinuous Galerkin method for Maxwells Equations |
CDune::PDELab::NumericalJacobianVolume< DiffusionMixed< PARAM > > | |
►CDune::PDELab::NumericalJacobianVolume< LOP_spatial_contaminant< Param, GFSF, ZF, GFSC, ZC, convection > > | |
CLOP_spatial_contaminant< Param, GFSF, ZF, GFSC, ZC, convection > | |
►CDune::PDELab::NumericalJacobianVolume< LOP_spatial_flow< Param > > | |
CLOP_spatial_flow< Param > | |
CDune::PDELab::NumericalJacobianVolume< LOP_time_contaminant< Param, GFSF, ZF, convection > > | |
CDune::PDELab::NumericalJacobianVolume< LOP_time_flow< Param > > | |
►CDune::PDELab::NumericalJacobianVolume< NonLinearConvectionDiffusionFEM< T > > | |
CDune::PDELab::NonLinearConvectionDiffusionFEM< T > | |
►CDune::PDELab::NumericalJacobianVolume< TwoPhaseOnePointTemporalOperator< TP > > | |
CDune::PDELab::TwoPhaseOnePointTemporalOperator< TP > | |
CDune::PDELab::NumericalJacobianVolumePostSkeleton< Imp > | |
►CDune::PDELab::NumericalNonlinearJacobianApplyBoundary< Imp > | Implements nonlinear version of jacobian_apply_boundary() based on alpha_boundary() |
CDune::PDELab::NumericalJacobianApplyBoundary< Imp > | Implements linear and nonlinear versions of jacobian_apply_boundary() based on alpha_boundary() |
►CDune::PDELab::NumericalNonlinearJacobianApplyBoundary< ConvectionDiffusionCCFV< TP > > | |
►CDune::PDELab::NumericalJacobianApplyBoundary< ConvectionDiffusionCCFV< TP > > | |
CDune::PDELab::ConvectionDiffusionCCFV< TP > | |
►CDune::PDELab::NumericalNonlinearJacobianApplyBoundary< ConvectionDiffusionFEM< T, FiniteElementMap > > | |
►CDune::PDELab::NumericalJacobianApplyBoundary< ConvectionDiffusionFEM< T, FiniteElementMap > > | |
CDune::PDELab::ConvectionDiffusionFEM< T, FiniteElementMap > | |
►CDune::PDELab::NumericalNonlinearJacobianApplyBoundary< DGLinearAcousticsSpatialOperator< T, FEM > > | |
►CDune::PDELab::NumericalJacobianApplyBoundary< DGLinearAcousticsSpatialOperator< T, FEM > > | |
CDune::PDELab::DGLinearAcousticsSpatialOperator< T, FEM > | |
►CDune::PDELab::NumericalNonlinearJacobianApplyBoundary< DGMaxwellSpatialOperator< T, FEM > > | |
►CDune::PDELab::NumericalJacobianApplyBoundary< DGMaxwellSpatialOperator< T, FEM > > | |
CDune::PDELab::DGMaxwellSpatialOperator< T, FEM > | Spatial local operator for discontinuous Galerkin method for Maxwells Equations |
►CDune::PDELab::NumericalNonlinearJacobianApplyBoundary< NonLinearConvectionDiffusionFEM< T > > | |
►CDune::PDELab::NumericalJacobianApplyBoundary< NonLinearConvectionDiffusionFEM< T > > | |
CDune::PDELab::NonLinearConvectionDiffusionFEM< T > | |
►CDune::PDELab::NumericalNonlinearJacobianApplyBoundary< TwoPhaseTwoPointFluxOperator< TP > > | |
CDune::PDELab::NumericalJacobianApplyBoundary< TwoPhaseTwoPointFluxOperator< TP > > | |
►CDune::PDELab::NumericalNonlinearJacobianApplySkeleton< Imp > | Implements nonlinear version of jacobian_apply_skeleton() based on alpha_skeleton() |
CDune::PDELab::NumericalJacobianApplySkeleton< Imp > | Implements linear and nonlinear versions of jacobian_apply_skeleton() based on alpha_skeleton() |
►CDune::PDELab::NumericalNonlinearJacobianApplySkeleton< DGLinearAcousticsSpatialOperator< T, FEM > > | |
►CDune::PDELab::NumericalJacobianApplySkeleton< DGLinearAcousticsSpatialOperator< T, FEM > > | |
CDune::PDELab::DGLinearAcousticsSpatialOperator< T, FEM > | |
►CDune::PDELab::NumericalNonlinearJacobianApplySkeleton< DGMaxwellSpatialOperator< T, FEM > > | |
►CDune::PDELab::NumericalJacobianApplySkeleton< DGMaxwellSpatialOperator< T, FEM > > | |
CDune::PDELab::DGMaxwellSpatialOperator< T, FEM > | Spatial local operator for discontinuous Galerkin method for Maxwells Equations |
►CDune::PDELab::NumericalNonlinearJacobianApplySkeleton< TwoPhaseTwoPointFluxOperator< TP > > | |
CDune::PDELab::NumericalJacobianApplySkeleton< TwoPhaseTwoPointFluxOperator< TP > > | |
►CDune::PDELab::NumericalNonlinearJacobianApplyVolume< Imp > | Implements nonlinear version of jacobian_apply_volume() based on alpha_volume() |
CDune::PDELab::NumericalJacobianApplyVolume< Imp > | Implements linear and nonlinear versions of jacobian_apply_volume() based on alpha_volume() |
►CDune::PDELab::NumericalNonlinearJacobianApplyVolume< ConvectionDiffusionFEM< T, FiniteElementMap > > | |
►CDune::PDELab::NumericalJacobianApplyVolume< ConvectionDiffusionFEM< T, FiniteElementMap > > | |
CDune::PDELab::ConvectionDiffusionFEM< T, FiniteElementMap > | |
►CDune::PDELab::NumericalNonlinearJacobianApplyVolume< DGLinearAcousticsSpatialOperator< T, FEM > > | |
►CDune::PDELab::NumericalJacobianApplyVolume< DGLinearAcousticsSpatialOperator< T, FEM > > | |
CDune::PDELab::DGLinearAcousticsSpatialOperator< T, FEM > | |
►CDune::PDELab::NumericalNonlinearJacobianApplyVolume< DGLinearAcousticsTemporalOperator< T, FEM > > | |
►CDune::PDELab::NumericalJacobianApplyVolume< DGLinearAcousticsTemporalOperator< T, FEM > > | |
CDune::PDELab::DGLinearAcousticsTemporalOperator< T, FEM > | |
►CDune::PDELab::NumericalNonlinearJacobianApplyVolume< DGMaxwellSpatialOperator< T, FEM > > | |
►CDune::PDELab::NumericalJacobianApplyVolume< DGMaxwellSpatialOperator< T, FEM > > | |
CDune::PDELab::DGMaxwellSpatialOperator< T, FEM > | Spatial local operator for discontinuous Galerkin method for Maxwells Equations |
►CDune::PDELab::NumericalNonlinearJacobianApplyVolume< DGMaxwellTemporalOperator< T, FEM > > | |
►CDune::PDELab::NumericalJacobianApplyVolume< DGMaxwellTemporalOperator< T, FEM > > | |
CDune::PDELab::DGMaxwellTemporalOperator< T, FEM > | |
►CDune::PDELab::NumericalNonlinearJacobianApplyVolume< DiffusionMixed< PARAM > > | |
CDune::PDELab::NumericalJacobianApplyVolume< DiffusionMixed< PARAM > > | |
►CDune::PDELab::NumericalNonlinearJacobianApplyVolume< EmptyLop > | |
CDune::PDELab::NumericalJacobianApplyVolume< EmptyLop > | |
►CDune::PDELab::NumericalNonlinearJacobianApplyVolume< NonLinearConvectionDiffusionFEM< T > > | |
►CDune::PDELab::NumericalJacobianApplyVolume< NonLinearConvectionDiffusionFEM< T > > | |
CDune::PDELab::NonLinearConvectionDiffusionFEM< T > | |
►CDune::PDELab::NumericalNonlinearJacobianApplyVolume< TwoPhaseOnePointTemporalOperator< TP > > | |
►CDune::PDELab::NumericalJacobianApplyVolume< TwoPhaseOnePointTemporalOperator< TP > > | |
CDune::PDELab::TwoPhaseOnePointTemporalOperator< TP > | |
►CDune::PDELab::NumericalNonlinearJacobianApplyVolumePostSkeleton< Imp > | |
CDune::PDELab::NumericalJacobianApplyVolumePostSkeleton< Imp > | |
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::PDELab::OneStepLocalAssemblerEngineBase< OSLA, LAE0, LAE1 > | The local assembler engine for UDG sub triangulations which assembles the residual vector |
►CDune::PDELab::OneStepLocalAssemblerEngineBase< OneStepLocalAssembler, OSLA::LocalAssemblerDT0::LocalJacobianApplyAssemblerEngine, OSLA::LocalAssemblerDT1::LocalJacobianApplyAssemblerEngine > | |
CDune::PDELab::OneStepLocalJacobianApplyAssemblerEngine< OneStepLocalAssembler > | |
►CDune::PDELab::OneStepLocalAssemblerEngineBase< OneStepLocalAssembler, OSLA::LocalAssemblerDT0::LocalJacobianAssemblerEngine, OSLA::LocalAssemblerDT1::LocalJacobianAssemblerEngine > | |
CDune::PDELab::OneStepLocalJacobianAssemblerEngine< OneStepLocalAssembler > | |
►CDune::PDELab::OneStepLocalAssemblerEngineBase< OneStepLocalAssembler, OSLA::LocalAssemblerDT0::LocalPatternAssemblerEngine, OSLA::LocalAssemblerDT1::LocalPatternAssemblerEngine > | |
CDune::PDELab::OneStepLocalPatternAssemblerEngine< OneStepLocalAssembler > | |
►CDune::PDELab::OneStepLocalAssemblerEngineBase< OneStepLocalAssembler, OSLA::LocalAssemblerDT0::LocalResidualAssemblerEngine, OSLA::LocalAssemblerDT1::LocalResidualAssemblerEngine > | |
CDune::PDELab::OneStepLocalPreStageAssemblerEngine< OneStepLocalAssembler > | |
CDune::PDELab::OneStepLocalResidualAssemblerEngine< OneStepLocalAssembler > | |
►CDune::PDELab::OneStepLocalAssemblerEngineBase< OSLA, OSLA::LocalAssemblerDT0::LocalJacobianApplyAssemblerEngine, OSLA::LocalAssemblerDT1::LocalJacobianApplyAssemblerEngine > | |
CDune::PDELab::OneStepLocalJacobianApplyAssemblerEngine< OSLA > | The local assembler engine for one-step methods which applies the jacobian without explicitly assembling it |
►CDune::PDELab::OneStepLocalAssemblerEngineBase< OSLA, OSLA::LocalAssemblerDT0::LocalJacobianAssemblerEngine, OSLA::LocalAssemblerDT1::LocalJacobianAssemblerEngine > | |
CDune::PDELab::OneStepLocalJacobianAssemblerEngine< OSLA > | The local assembler engine for one step methods which assembles the residual vector |
►CDune::PDELab::OneStepLocalAssemblerEngineBase< OSLA, OSLA::LocalAssemblerDT0::LocalPatternAssemblerEngine, OSLA::LocalAssemblerDT1::LocalPatternAssemblerEngine > | |
CDune::PDELab::OneStepLocalPatternAssemblerEngine< OSLA > | The local assembler engine for OneStep sub triangulations which creates the matrix pattern |
►CDune::PDELab::OneStepLocalAssemblerEngineBase< OSLA, OSLA::LocalAssemblerDT0::LocalResidualAssemblerEngine, OSLA::LocalAssemblerDT1::LocalResidualAssemblerEngine > | |
CDune::PDELab::OneStepLocalPreStageAssemblerEngine< OSLA > | The local assembler engine for one step methods which assembles the constant part of the residual vector |
CDune::PDELab::OneStepLocalResidualAssemblerEngine< OSLA > | The local assembler engine for one step methods which assembles the residual vector |
CDune::PDELab::OneStepMethod< T, IGOS, PDESOLVER, TrlV, TstV > | Do one step of a time-stepping scheme |
CDune::TypeTree::or_< result_type > | Statically combine two values of type result_type using || |
CDune::PB::OrthonormalPolynomialBasis< FieldType, k, d, bt, ComputationFieldType, basisType > | Integrate monomials over the reference element |
CDune::PB::OrthonormalPolynomialBasis< R, k, d, bt, Dune::PB::DefaultComputationalFieldType, basisType > | |
CDune::PB::OrthonormalPolynomialBasis< R, k, d, bt, Dune::PB::DefaultComputationalFieldType, PB::BasisType::Pk > | |
CDune::PB::OrthonormalPolynomialBasis< R, k, d, bt, R, basisType > | |
CDune::PDELab::GridFunctionOutputParameters::Output | Namespace for output-related data types and enums |
CDune::OverlappingSchwarzInitializer< I, S, D > | Initializer for SuperLU Matrices representing the subdomains |
CDune::PDELab::OverPenalizedInteriorPenalty< RF > | Implementation of overpenalized interior penalty |
CDune::OwnerOverlapCopyAttributeSet | Attribute 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 |
CParameters< Number, LType > | |
CDune::ParameterTree | Hierarchical structure of string parameters |
CDune::ParameterTreeParser | Parsers 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::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::PDELab::PartitionSelector< p0, p1, p2, p3, p4 > | Helper for building the bitmask describing the grid partitions contained in a GFS |
CDune::PartitionSet< partitions > | A set of PartitionType values |
CDune::PDELab::PartitionViewEntitySet< GV, P > | Partition view (or entity set) of a grid view |
CDune::PDELab::PartitionViewEntitySet< GV > | |
CDune::TypeTree::apply_to_tuple_policy::pass_index | Pass the index of the current tuple to the functor as its first argument in a std::integral_constant |
CDune::MatrixMarketImpl::PatternDummy | Utility class for marking the pattern type of the MatrixMarket matrices |
CDune::PDELab::ISTL::PatternStatistics< T > | Statistics about the pattern of a BCRSMatrix |
CDune::Functions::BasisFactory::Experimental::PeriodicIndexSet | Container storing identified indices for a periodic basis |
CDune::PDELab::ordering::Permuted< OrderingTag > | Permute the ordering created from the passed-in tag based on a simple lookup table |
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::PersistentContainer< G, T > | A class for storing data during an adaptation cycle |
►CDune::PersistentContainerMap< Grid, G::LocalIdSet, std::map< G::LocalIdSet::IdType, T > > | |
►CDune::PersistentContainer< Grid, T > | |
CDune::PersistentContainer< const Grid, T > | Refer PersistentContainer<const Grid> to the implementation of the mutable grid |
►CDune::PersistentContainerMap< HostGrid, G::LocalIdSet, std::map< G::LocalIdSet::IdType, Coordinate > > | |
CDune::PersistentContainer< HostGrid, Coordinate > | |
►CDune::PersistentContainerMap< HostGrid, G::LocalIdSet, std::map< G::LocalIdSet::IdType, RangeVector > > | |
CDune::PersistentContainer< HostGrid, RangeVector > | |
►CDune::PersistentContainerMap< HostGrid, G::LocalIdSet, std::map< G::LocalIdSet::IdType, T > > | |
CDune::PersistentContainer< HostGrid, T > | |
CDune::PersistentContainerVector< G, IndexSet, Vector > | Vector-based implementation of the PersistentContainer |
CDune::PersistentContainerVector< AlbertaGrid< dim, dimworld >, AlbertaGrid< dim, dimworld >::HierarchicIndexSet, std::vector< T > > | |
►CDune::PersistentContainerVector< YaspGrid< dim, CoordCont >, YaspPersistentContainerIndex< const YaspGrid< dim, CoordCont > >, std::vector< T > > | |
CDune::PersistentContainer< YaspGrid< dim, CoordCont >, T > | Specialization of the PersistentContainer for YaspGrid |
CDune::PDELab::PkQkLocalFiniteElementMap< D, R, d, maxP > | FiniteElementMap which provides PkQkLocalFiniteElement instances, depending on the geometry type |
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::PDELab::PointwiseAdapterEngine | Interface of a pointwise adapter engine |
CDune::PDELab::PointwiseScaleAdapterEngine< S > | Scale the output value |
CDune::PDELab::PointwiseSumAdapterEngine | Sum all terms |
CDune::PDELab::PolymorphicBufferWrapper< Buffer > | Wrapper for message buffers of grid DataHandles that allows for sending different types of data |
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::PolynomialBasisWithMatrix< Eval, CM, D, R > | |
CDune::Pool< T, s > | A memory pool of objects |
CDune::Pool< T, size > | |
CDune::PoolAllocator< T, s > | An allocator managing a pool of objects for reuse |
CDune::Power< p > | Compute power for a run-time mantissa and a compile-time integer exponent |
CDune::PowerBasis< Backend, dimR > | Meta-basis turning a scalar basis into vector-valued basis |
CDune::PowerBasis< typename Backend::Traits::Basis, dimR > | |
CDune::PDELab::PowerCompositeGridFunctionSpaceBase< GridFunctionSpace, GV, B, O, k > | Mixin class providing common functionality of PowerGridFunctionSpace and CompositeGridFunctionSpace |
►CDune::PDELab::PowerCompositeGridFunctionSpaceBase< CompositeGridFunctionSpace< Backend, OrderingTag, Children... >, TypeTree::Child< TypeTree::CompositeNode< Children... >, 0 >::Traits::EntitySet, Backend, OrderingTag, sizeof...(Children) > | |
CDune::PDELab::CompositeGridFunctionSpace< Backend, OrderingTag, Children > | Base class for tuples of grid function spaces base class that holds implementation of the methods this is the default version with lexicographic ordering |
►CDune::PDELab::PowerCompositeGridFunctionSpaceBase< PowerGridFunctionSpace< T, k, Backend, LexicographicOrderingTag >, T::Traits::EntitySet, Backend, LexicographicOrderingTag, k > | |
CDune::PDELab::PowerGridFunctionSpace< T, k, Backend, OrderingTag > | Base class for tuples of grid function spaces product of identical grid function spaces base class that holds implementation of the methods |
►CDune::PDELab::PowerCompositeGridFunctionSpaceBase< VectorGridFunctionSpace< GV, FEM, k, Backend, LeafBackend, NoConstraints, LexicographicOrderingTag, DefaultLeafOrderingTag >, impl::EntitySet< GV >, Backend, LexicographicOrderingTag, k > | |
CDune::PDELab::VectorGridFunctionSpace< GV, FEM, k, Backend, LeafBackend, Constraints, OrderingTag, LeafOrderingTag > | Tensorproduct space representing a vector valued function space |
CDune::PDELab::PowerCompositeGridFunctionSpaceTraits< G, B, O, k > | Trait class for the multi component grid function spaces |
►CDune::PDELab::PowerCompositeGridFunctionTraits< GV > | GV The type of the grid view the function lives on |
CDune::PDELab::GridFunctionTraits< GV, RF, m, Dune::FieldVector< RF, m > > | |
CDune::PDELab::GridFunctionTraits< GV, RangeFieldType, 2, FieldVector< RangeFieldType, 2 > > | |
CDune::PDELab::GridFunctionTraits< GV, RangeFieldType, 1, FieldVector< RangeFieldType, 1 > > | |
CDune::PDELab::GridFunctionTraits< GV, RangeFieldType, 3, FieldVector< RangeFieldType, 3 > > | |
CDune::PDELab::GridFunctionTraits< GV, RF, m, R > | Traits class holding the function signature, same as in local function |
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::PDELab::PowerFiniteElementMap< BackendFEM, dimR > | FiniteElementMap for PowerFiniteElements |
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::PDELab::PowerLocalFunctionSpaceTag | Tag denoting a PowerLocalFunctionSpace |
►CDune::TypeTree::PowerNode< T, k > | Collect k instances of type T within a dune-typetree |
CDune::PDELab::PowerGridFunction< T, k > | Product of identical functions |
CDune::PDELab::PowerGridFunctionSpace< T, k, Backend, OrderingTag > | Base class for tuples of grid function spaces product of identical grid function spaces base class that holds implementation of the methods |
CDune::TypeTree::PowerNode< Child, k > | |
CDune::TypeTree::PowerNode< ChildLFS, k > | |
CDune::TypeTree::PowerNode< ChildOrdering, k > | |
CDune::TypeTree::PowerNode< F, k > | |
►CDune::TypeTree::PowerNode< GridFunctionSpace< impl::EntitySet< GV >, FEM, NoConstraints, LeafBackend, DefaultLeafOrderingTag >, k > | |
CDune::PDELab::VectorGridFunctionSpace< GV, FEM, k, Backend, LeafBackend, Constraints, OrderingTag, LeafOrderingTag > | Tensorproduct space representing a vector valued function space |
CDune::TypeTree::PowerNode< LagrangeNode< GV, 2 >, n > | |
CDune::TypeTree::PowerNode< T, n > | |
CDune::TypeTree::PowerNodeTag | Tag designating a power node |
CDune::Functions::PowerPreBasis< MI, 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::BlockPreconditioner< X, Y, C, P > | Block parallel preconditioner |
CDune::PDELab::NonoverlappingJacobi< A, X, Y > | Parallel non-overlapping Jacobi preconditioner |
CDune::ParSSOR< M, X, Y, C > | A parallel SSOR preconditioner |
CDune::Richardson< X, Y > | Richardson preconditioner |
CDune::SeqILDL< M, X, Y > | Sequential ILDL preconditioner |
CDune::SeqILU< M, X, Y, l > | Sequential ILU preconditioner |
CDune::SeqJac< M, X, Y, l > | The sequential jacobian preconditioner |
CDune::SeqSOR< M, X, Y, l > | Sequential SOR preconditioner |
CDune::SeqSSOR< M, X, Y, l > | Sequential SSOR preconditioner |
►CDune::Preconditioner< AMG::Domain, AMG::Range > | |
CDune::Amg::KAmgTwoGrid< Dune::Amg::AMG > | |
CDune::Amg::KAmgTwoGrid< AMG > | Two grid operator for AMG with Krylov cycle |
►CDune::Preconditioner< DGPrec::domain_type, DGPrec::range_type > | |
CDune::PDELab::SeqDGAMGPrec< DGMatrix, DGPrec, CGPrec, P > | |
►CDune::Preconditioner< Dune::PDELab::Backend::Vector< DGGFS, DGPrec::domain_type::field_type >, Dune::PDELab::Backend::Vector< DGGFS, DGPrec::range_type::field_type > > | |
CDune::PDELab::OvlpDGAMGPrec< DGGFS, DGMatrix, DGPrec, DGCC, CGGFS, CGPrec, CGCC, P, DGHelper, Comm > | |
CDune::Preconditioner< Dune::PDELab::Backend::Vector< GFS, P::domain_type::field_type >, Dune::PDELab::Backend::Vector< GFS, P::range_type::field_type > > | |
►CDune::Preconditioner< FO::domain_type, FO::range_type > | |
CDune::Amg::TwoLevelMethod< FO, CSP, S > | |
►CDune::Preconditioner< O::domain_type, O::range_type > | |
CDune::InverseOperator2Preconditioner< O, c > | Turns an InverseOperator into a Preconditioner |
►CDune::Preconditioner< P::domain_type, P::range_type > | |
CDune::NonoverlappingBlockPreconditioner< C, P > | Nonoverlapping parallel preconditioner |
►CDune::Preconditioner< PrecGO::Traits::Domain, PrecGO::Traits::Range > | |
CDune::PDELab::GridOperatorPreconditioner< PrecGO > | Turn a grid operator that represents a preconditioner into an ISTL preconditioner |
►CDune::Preconditioner< X, X > | |
CDune::Amg::AMG< M, X, S, SequentialInformation, std::allocator< X > > | |
CDune::Amg::AMG< Operator, X, Smoother > | |
CDune::SeqOverlappingSchwarz< M, X, TM, TS, TA > | |
CDune::Amg::AMG< M, X, S, PI, A > | Parallel algebraic multigrid based on agglomeration |
CDune::Amg::FastAMG< M, X, PI, A > | A fast (sequential) algebraic multigrid based on agglomeration that saves memory bandwidth |
CDune::Amg::KAMG< M, X, S, PI, K, A > | Algebraic multigrid method using a Krylov-cycle |
CDune::SeqOverlappingSchwarz< M, X, TM, TD, TA > | Sequential overlapping Schwarz preconditioner |
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::Functions::HasStaticSize< T > | Check if type is a statically sized container |
CDune::Functions::StaticSize< T > | Obtain size of statically sized container |
CDune::Torus< CollectiveCommunication, 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< const TypeTree::ChildForTreePath< BaseOrdering_, TreePath >, NodeTag< const TypeTree::ChildForTreePath< BaseOrdering_, TreePath > > > | |
►CDune::TypeTree::ProxyNode< const TypeTree::ChildForTreePath< BaseOrdering_, TreePath > > | |
CDune::PDELab::SubOrdering< BaseOrdering_, TreePath > | A view on a subtree of a multi-component ordering |
►CDune::TypeTree::ProxyNodeBase< const TypeTree::ChildForTreePath< GFS, TreePath >, NodeTag< const TypeTree::ChildForTreePath< GFS, TreePath > > > | |
►CDune::TypeTree::ProxyNode< const TypeTree::ChildForTreePath< GFS, TreePath > > | |
CDune::PDELab::gfs::GridFunctionSubSpace< GFS, TreePath > | Non-nesting implementation of GridFunctionSubSpace |
►CDune::TypeTree::ProxyNodeBase< const TypeTree::ChildForTreePath< typename GFS::Ordering, typename find_ordering_treepath_for_sub_gfs< typename GFS::Ordering, GFS, TreePath >::type >, NodeTag< const TypeTree::ChildForTreePath< typename GFS::Ordering, typename find_ordering_treepath_for_sub_gfs< typename GFS::Ordering, GFS, TreePath >::type > > > | |
►CDune::TypeTree::ProxyNode< const TypeTree::ChildForTreePath< typename GFS::Ordering, typename find_ordering_treepath_for_sub_gfs< typename GFS::Ordering, GFS, TreePath >::type > > | |
CDune::PDELab::SubOrdering< typename GFS::Ordering, typename find_ordering_treepath_for_sub_gfs< typename GFS::Ordering, GFS, TreePath >::type > | |
CDune::TypeTree::ProxyNodeBase< Node, LeafNodeTag > | ProxyNode base class for LeafNode |
►CDune::TypeTree::ProxyNodeBase< Node, NodeTag< Node > > | |
CDune::TypeTree::ProxyNode< Node > | Base class for nodes acting as a proxy for an existing 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::PVTUWriter | Dump a .vtu/.vtp files contents to a stream |
CDune::QkDGGLLocalFiniteElement< D, R, k, d > | |
CDune::QkDGGLLocalFiniteElement< Geometry::ctype, RF, k, Geometry::mydimension > | |
CDune::QkDGLagrangeLocalFiniteElement< D, R, k, d > | |
CDune::QkDGLagrangeLocalFiniteElement< Geometry::ctype, RF, k, Geometry::mydimension > | |
CDune::QkDGLegendreLocalFiniteElement< D, R, k, d > | |
CDune::QkDGLegendreLocalFiniteElement< Geometry::ctype, RF, k, Geometry::mydimension > | |
CDune::QkStuff::QkGLLocalBasis< D, R, k, d > | Lagrange shape functions of order k on the reference cube |
CDune::QkStuff::QkGLLocalBasis< Geometry::ctype, RF, k, d > | |
CDune::QkStuff::QkGLLocalInterpolation< k, d, LB > | |
CDune::QkStuff::QkGLLocalInterpolation< 0, d, LB > | |
CDune::QkStuff::QkGLLocalInterpolation< k, d, LocalBasis > | |
CDune::QkStuff::QkLocalBasis< D, R, k, d > | Lagrange shape functions of order k on the reference cube |
CDune::QkStuff::QkLocalBasis< Geometry::ctype, RF, k, d > | |
CDune::QkStuff::QkLocalInterpolation< k, d, LB > | |
CDune::QkStuff::QkLocalInterpolation< 0, d, LB > | |
CDune::QkStuff::QkLocalInterpolation< k, d, LocalBasis > | |
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::PDELab::QuadratureRuleWrapper< QR > | Wrapper for Dune::QuadratureRule with value semantics |
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::ArrayListIterator< T, N, A > | A random access iterator for the Dune::ArrayList class |
CDune::ParallelIndexSet< TG, TL, N >::iterator | The iterator over the pairs |
►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::ConstArrayListIterator< IndexPair< TG, TL >, N, std::allocator< Dune::IndexPair< TG, TL > > > | |
►CDune::RandomAccessIteratorFacade< ConstArrayListIterator< T, N, A >, const A::value_type, A::value_type const &, A::difference_type > | |
CDune::ConstArrayListIterator< T, N, A > | A constant random access iterator for the Dune::ArrayList class |
►CDune::RandomAccessIteratorFacade< DenseIterator< C, T, T & >, T, T &, std::ptrdiff_t > | |
CDune::DenseIterator< C, T, R > | Generic iterator class for dense vector and matrix implementations |
CDune::RandomAccessIteratorFacade< DOFIndexViewIterator< DOFIterator >, const std::iterator_traits< DOFIterator >::value_type::View, const std::iterator_traits< DOFIterator >::value_type::View > | |
CDune::RandomAccessIteratorFacade< DOFIndexViewIterator< Iterator >, const std::iterator_traits< Iterator >::value_type::View, const std::iterator_traits< Iterator >::value_type::View > | |
►CDune::RandomAccessIteratorFacade< EdgeIterator, const EdgeDescriptor > | |
CDune::Amg::SubGraph< G, T >::EdgeIterator | The edge iterator of the graph |
►CDune::RandomAccessIteratorFacade< GenericIterator< C, T, T &, std::ptrdiff_t, RandomAccessIteratorFacade >, T, T &, std::ptrdiff_t > | |
CDune::GenericIterator< C, T, R, D, IteratorFacade > | Generic class for stl-conforming iterators for container classes with operator[] |
►CDune::RandomAccessIteratorFacade< iterator, const Index_ > | |
CDune::GeneralVertexOrder< dim, Index_ >::iterator | Iterate over the vertex indices of some sub-entity |
CDune::RandomAccessIteratorFacade< RealIterator< T >, T > | |
►CDune::RandomAccessIteratorFacade< RealIterator< T, R >, T, R > | |
CDune::VariableBlockVector< B, A >::RealIterator< T, R > | Iterator class for sequential access |
►CDune::RandomAccessIteratorFacade< RealRowIterator< T >, T > | |
CDune::BCRSMatrix< B, A >::RealRowIterator< T > | Iterator access to matrix rows |
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, MI > | Pre-basis for a Rannacher-Turek basis |
CDune::RaviartThomasCubeLocalFiniteElement< D, R, dim, order > | Raviart-Thomas local finite elements for cubes |
CDune::RaviartThomasCubeLocalFiniteElement< DF, RF, dim, 0 > | |
CDune::RaviartThomasL2Interpolation< dimension, F > | An L2-based interpolation for Raviart Thomas |
CDune::PDELab::RaviartThomasLocalFiniteElementMap< GV, D, R, k, basic_type > | Raviart-Thomas elements of order k |
CDune::RawStream | Write out data in binary |
►CDune::ReadablePropertyMapTag | Tag for the category of readable property maps |
►CDune::ReadWritePropertyMapTag | Tag for the category of readable and writable property maps |
CDune::LvaluePropertyMapTag | Tag for the category of lvalue 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::RefinedP1LocalBasis< D, R, 1 > | Uniformly refined linear Lagrange shape functions in 1D |
►CDune::RefinedSimplexLocalBasis< D, 2 > | Base class for LocalBasis classes based on uniform refinement in 2D; provides numbering and local coordinates of subelements |
CDune::RefinedP1LocalBasis< D, R, 2 > | Uniformly refined linear Lagrange shape functions on the triangle |
►CDune::RefinedSimplexLocalBasis< D, 3 > | Base class for LocalBasis classes based on uniform refinement in 3D; provides numbering and local coordinates of subelements |
CDune::RefinedP1LocalBasis< D, R, 3 > | Uniformly refined linear Lagrange shape functions on the 3D-simplex (tetrahedron) |
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::RefinementIntervals | Holds 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::Functions::Concept::Function< Range(Domain)> | Concept for a function mapping Domain to Range |
CDune::Concept::Refines< ConstVectorBackend< GlobalBasis > > | |
►CDune::Concept::Refines< Dune::Functions::Concept::DifferentiableFunction< Range(Domain), DerivativeTraits >, Dune::Functions::Concept::GridFunction< Range(Domain), EntitySet > > | |
CDune::Functions::Concept::DifferentiableGridFunction< Range(Domain), EntitySet, DerivativeTraits > | Concept for a differentiable grid function mapping Domain to Range |
►CDune::Concept::Refines< Dune::Functions::Concept::DifferentiableFunction< Range(Domain), DerivativeTraits >, Dune::Functions::Concept::LocalFunction< Range(Domain), LocalContext > > | |
CDune::Functions::Concept::DifferentiableLocalFunction< Range(Domain), LocalContext, DerivativeTraits > | Concept for a differentiable local function mapping Domain to Range |
►CDune::Concept::Refines< Dune::Functions::Concept::DifferentiableGridFunction< Range(Domain), GridViewEntitySet< GridView, 0 >, DerivativeTraits > > | |
CDune::Functions::Concept::DifferentiableGridViewFunction< Range(Domain), GridView, DerivativeTraits > | Concept for a differentiable grid view function mapping Domain to Range |
►CDune::Concept::Refines< Dune::Functions::Concept::Function< Range(Domain)> > | |
CDune::Functions::Concept::DifferentiableFunction< Range(Domain), DerivativeTraits > | Concept for a differentiable function mapping Domain to Range |
CDune::Functions::Concept::GridFunction< Range(Domain), EntitySet > | Concept for a grid function mapping Domain to Range |
CDune::Functions::Concept::LocalFunction< Range(Domain), LocalContext > | Concept for a local function mapping Domain to Range |
►CDune::Concept::Refines< Dune::Functions::Concept::GridFunction< Range(Domain), GridViewEntitySet< GridView, 0 > > > | |
CDune::Functions::Concept::GridViewFunction< Range(Domain), GridView > | Concept for a grid view function mapping Domain to Range |
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::PDELab::MultiIndex< T, max_depth > | |
CDune::PDELab::MultiIndex< T, tree_n > | |
CDune::PDELab::MultiIndex< T, n > | A class for representing multi-indices |
►CDune::ReservedVector< d, n > | |
CDune::PDELab::MultiIndex< d > | |
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_object | Proxy row object for entry access |
CDune::Amg::RowSum | Functor 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::RaviartThomasCubeLocalFiniteElement< D, R, 2, 0 > | Raviart-Thomas local finite elements for cubes with dimension 2 and order 0 |
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::RaviartThomasCubeLocalFiniteElement< D, R, 3, 0 > | Raviart-Thomas local finite elements for cubes with dimension 3 and order 0 |
CDune::RT0Cube3DLocalInterpolation< LB > | Lowest order Raviart-Thomas shape functions on the reference hexahedron |
CDune::RT0Cube3DLocalInterpolation< Dune::RT0Cube3DLocalBasis< D, R > > | |
CDune::RT12DLocalBasis< D, R > | First order Raviart-Thomas shape functions on the reference triangle |
CDune::RT12DLocalCoefficients | Layout 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::RaviartThomasCubeLocalFiniteElement< D, R, 2, 1 > | Raviart-Thomas local finite elements for cubes with dimension 2 and order 1 |
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::RaviartThomasCubeLocalFiniteElement< D, R, 3, 1 > | Raviart-Thomas local finite elements for cubes with dimension 3 and order 1 |
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::RaviartThomasCubeLocalFiniteElement< D, R, 2, 2 > | Raviart-Thomas local finite elements for cubes with dimension 2 and order 2 |
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::RaviartThomasCubeLocalFiniteElement< D, R, 2, 3 > | Raviart-Thomas local finite elements for cubes with dimension 2 and order 3 |
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::RaviartThomasCubeLocalFiniteElement< D, R, 2, 4 > | Raviart-Thomas local finite elements for cubes with dimension 2 and order 4 |
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::ParallelScalarProduct< X, C > | Scalar product for overlapping Schwarz methods |
CDune::NonoverlappingSchwarzScalarProduct< X, C > | Nonoverlapping Scalar Product with communication object |
CDune::OverlappingSchwarzScalarProduct< X, C > | Scalar product for overlapping Schwarz methods |
CDune::SeqScalarProduct< X > | Default implementation for the scalar case |
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::PDELab::ScaledLocalOperator< Backend, Factor, Time > | A local operator that scales the result of another local operator |
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::PDELab::FastDGGridOperator< GFSU, GFSV, LOP, MB, DF, RF, JF, CU, CV >::SetupGridOperator< GridOperatorTuple > | |
CDune::PDELab::GridOperator< GFSU, GFSV, LOP, MB, DF, RF, JF, CU, CV >::SetupGridOperator< GridOperatorTuple > | |
CDune::PDELab::SharedDOFGatherScatter | GatherScatter functor for marking shared DOFs |
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::SimpleFilter | Default simple filter that accepts any node and leaves its child structure unchanged |
CDune::TypeTree::SimpleFilterTag | Tag describing a simple filter that can only decide whether or not to include a single given child |
CDune::PDELab::SimpleLFSCacheTag | |
CDune::PDELab::SingleCodimMapper | |
CDune::PDELab::SingleDerivativeComputationHelper< Mat, RF, size > | Helper class to compute a single derivative of scalar basis functions |
CDune::PDELab::SingleDerivativeComputationHelper< Dune::DiagonalMatrix< RF, size >, RF, size > | Template specialization for Dune::DiagonalMatrix |
CDune::PDELab::SingleDerivativeComputationHelper< Dune::FieldMatrix< RF, size, size >, RF, size > | Template specialization for Dune::FieldMatrix |
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::SizeOne | Flag for marking indexed data structures where data at each index is of the same size |
CDune::PDELab::SizeProviderAdapter< Size, ContainerIndex_, OriginOrder > | Adapter to create a size provider from an ordering |
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::SolverCategory | Categories 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::PDELab::SolverStatistics< T > | Class for collecting statistics over several invocations |
CDune::PDELab::SolverStatistics< int > | |
CDune::Amg::SparsityBuilder< M > | Functor for building the sparsity pattern of the matrix using examineConnectivity |
CDune::PDELab::SparsityLink | Entry in sparsity pattern |
CDune::SPQR< Matrix > | Use the SPQR package to directly solve linear systems – empty default class |
CDune::StandardMathematicalConstants< T > | Standard implementation of MathematicalConstants |
►CDune::StandardMathematicalConstants< Field > | |
CDune::MathematicalConstants< Field > | Provides commonly used mathematical constants |
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::DynamicChildAccessors< ProxiedNode > | Mixin class providing methods for child access with run-time parameter |
►CDune::TypeTree::StaticChildAccessors< Node > | |
►CDune::TypeTree::DynamicChildAccessors< Node > | |
CDune::TypeTree::ProxyNodeBase< Node, PowerNodeTag > | ProxyNode base class for PowerNode |
CDune::TypeTree::ProxyNodeBase< Node, CompositeNodeTag > | ProxyNode base class for CompositeNode |
CDune::StaticIntegralRange< T, to, from > | Static integer range for use in range-based for loops |
CDune::StaticPower< m, p > | Calculates m^p at compile time |
CDune::StaticRefinement< topologyId, CoordType, coerceToId, dimension_ > | Wrap each Refinement implementation to get a consistent interface |
CDune::TypeTree::StaticTraversal | Mixin base class for visitors that require a static TreePath during traversal |
CDune::PDELab::StationaryLinearProblemSolver< GO, LS, V > | Solve linear problems using a residual formulation |
CDune::PDELab::StatisticsResult< T > | Statistics result structure |
CDune::PDELab::StokesBoundaryCondition | |
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::PDELab::SubdomainBasis< X > | This represents a general per-subdomain basis |
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::SuperLUMatrix< M > | Utility class for converting an ISTL Matrix into a SuperLU Matrix |
CDune::SuperLUMatrix< Matrix > | |
CDune::SymmetricMultiplicativeSchwarzMode | Tag that tells the Schwarz method to be multiplicative and symmetric |
CDune::Functions::TaylorHoodPreBasis< GV, MI, 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 |
CTestPartial | Helper class to test the 'partial' method |
CDune::PDELab::TestSpaceTag | |
CDune::Capabilities::threadSafe< Grid > | Specialize with 'true' if the grid implementation is thread safe. (default=false) |
►CDune::PDELab::TimeControllerInterface< R > | Controller interface for adaptive time stepping |
CDune::PDELab::CFLTimeController< R, IGOS > | Limit time step to maximum dt * CFL number |
CDune::PDELab::SimpleTimeController< R > | Default time controller; just returns given dt |
CDune::PDELab::TimeControllerInterface< T > | |
CDune::Timer | A simple stop watch |
CDune::PDELab::TimeSpec | Struct to store temporal values |
►CDune::PDELab::TimeSteppingParameterInterface< R > | Base parameter class for time stepping scheme parameters |
CDune::PDELab::Alexander2Parameter< R > | Parameters to turn the OneStepMethod into an Alexander scheme |
CDune::PDELab::Alexander3Parameter< R > | Parameters to turn the OneStepMethod into an Alexander3 scheme |
CDune::PDELab::FractionalStepParameter< R > | Parameters to turn the OneStepMethod into a fractional step theta scheme |
CDune::PDELab::HeunParameter< R > | Parameters to turn the ExplicitOneStepMethod into a Heun scheme |
►CDune::PDELab::OneStepThetaParameter< R > | Parameters to turn the OneStepMethod into an one step theta method |
CDune::PDELab::ExplicitEulerParameter< R > | Parameters to turn the ExplicitOneStepMethod into an explicit Euler method |
CDune::PDELab::ImplicitEulerParameter< R > | Parameters to turn the OneStepMethod into an implicit Euler method |
CDune::PDELab::RK4Parameter< R > | Parameters to turn the ExplicitOneStepMethod into a classical fourth order Runge-Kutta method |
CDune::PDELab::Shu3Parameter< R > | Parameters to turn the ExplicitOneStepMethod into a third order strong stability preserving (SSP) scheme |
CDune::PDELab::TimeSteppingParameterInterface< T > | |
CDune::Std::to_false_type< T > | Template mapping a type to std::false_type |
CDune::Std::to_true_type< T > | Template mapping a type to std::true_type |
CDune::TopologyFactory< Traits > | Provide a factory over the generic topologies |
CDune::TopologySingletonFactory< Factory > | A wrapper for a TopologyFactory providing singleton storage. Same usage as TopologyFactory but with empty release method an internal storage |
CDune::TopologySingletonFactory< MonomialBasisFactory< dim, SF > > | |
CDune::Torus< CollectiveCommunication, d > | |
CDune::Torus< Dune::Communication, dim > | |
►CDune::BasisInterface::Traits | Types of domain and range |
CDune::LocalToGlobalBasisAdaptorTraits< LocalBasisTraits, dimDomainGlobal_ > | Traits class for local-to-global basis adaptors |
CDune::EdgeS0_5Basis< Geometry, RF >::Traits | Export type traits for function signature |
CDune::FiniteElementInterface::Traits | Types of component objects |
CDune::Function< Domain, Range >::Traits | Traits class containing raw types |
CDune::PDELab::Experimental::GridFunctionSpace< DFBasis, VBE, CE >::Traits | Export Traits class |
CDune::PDELab::replay_visitor< GFS, DOFVector, CountVector >::coarse_function< FiniteElement >::Traits | Traits class containing decayed types |
CDune::PowerBasis< Backend, dimR >::Traits | Types of domain and range |
CDune::PowerFiniteElement< Backend, dimR >::Traits | Types 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< MI, 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::PDELab::TrialSpaceTag | |
CDune::Functions::TrigonometricFunction< K, sinFactor, cosFactor > | A linear combination of trigonomic functions |
CDune::TupleVector< T > | A class augmenting std::tuple by element access via operator[] |
CDune::PDELab::TwoPhaseParameterInterface< T, Imp > | Base class for parameter class |
CDune::PDELab::TwoPhaseParameterTraits< GV, RF > | Traits class for two phase parameter class |
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::DifferentiableFunction< Range(Domain), DerivativeTraits, bufferSize > | Class storing differentiable functions using type erasure |
►CDune::Functions::TypeErasureBase< Imp::GridFunctionTraits< Range(Domain), ES, DerivativeTraits, bufferSize >::Concept, Imp::GridFunctionTraits< Range(Domain), ES, DerivativeTraits, bufferSize >::template Model > | |
CDune::Functions::GridFunction< Range(Domain), ES, DerivativeTraits, bufferSize > | Wrapper class for functions defined on a Grid |
►CDune::Functions::TypeErasureBase< Imp::LocalFunctionTraits< Range(Domain), LocalContext, DerivativeTraits, bufferSize >::Concept, Imp::LocalFunctionTraits< Range(Domain), LocalContext, DerivativeTraits, bufferSize >::template Model > | |
CDune::Functions::LocalFunction< Range(Domain), LocalContext, DerivativeTraits, bufferSize > | Class storing local functions using type erasure |
CDune::TypeListElement< i, TypeList< T... > > | Get element of TypeList |
CDune::TypeListSize< TypeList< T... > > | Get size of TypeList |
CDune::PDELab::Backend::unattached_container | Tag for requesting a vector or matrix container without a pre-attached underlying object |
CDune::UncachedSelection< TS, TG, TL, N > | An uncached selection of indices |
CDune::Unity< Field > | A class representing the unit of a given Field |
►Cstd::unordered_map< K, T > | STL class |
CDune::PDELab::ConstraintsTransformation< char, char, char > | |
CDune::PDELab::ConstraintsTransformation< DI, CI, F > | Class holding transformation for constrained spaces |
CDune::TypeTree::SimpleFilter::validate< Node > | Validates the combination of filter and node |
CDune::ValueTransformationTag | Tag to enable value based transformations in TransformedRangeView |
CDune::PDELab::NavierStokesDGImp::VariableBoundarySlipSwitch< PRM, Dummy > | Compile-time switch for the boundary slip factor |
CDune::PDELab::VariableMonomLocalFiniteElementMap< M, D, R, d, maxP > | |
CDune::PDELab::VariableOPBLocalFiniteElementMap< M, D, R, d, ComputationFieldType, maxP, bt > | |
CDune::PDELab::VariableQkDGLocalFiniteElementMap< M, D, R, d, maxP > | |
CDune::VariableSize | Flag 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::BitSetVector< block_size, Allocator > | A dynamic array of blocks of booleans |
CDune::PDELab::LocalSparsityPattern | Layout description for a sparse linear operator |
CDune::QuadratureRule< ct, dim > | Abstract base class for quadrature rules |
CDune::PDELab::ISTL::vector_backend_tag | Tag describing an ISTL BlockVector backend |
CDune::PDELab::VectorBasisInterfaceSwitch< Basis, typename std::enable_if< Dune::AlwaysTrue< std::integral_constant< std::size_t, Basis::Traits::dimDomain > >::value >::type > | Switch for uniform treatment of local and global basis classes |
CDune::PDELab::VectorDiscreteGridFunctionCurl< T, X, dimR > | Compute curl of vector-valued functions |
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::VertexProperties | Class representing a node in the matrix graph |
CDune::Amg::VertexPropertiesGraph< G, VP, VM > | Attaches properties to the vertices of a graph |
CDune::Amg::VertexVisitedTag | Tag idnetifying the visited property of a vertex |
CDune::Capabilities::viewThreadSafe< Grid > | Specialize with 'true' if the grid implementation is thread safe, while it is not modified. (default=false) |
CDune::VirtualRefinement< dimension, CoordType > | VirtualRefinement base class |
CDune::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::VisitDirectChildren | Mixin base class for visitors that only want to visit the direct children of a node |
CDune::TypeTree::DirectChildrenPairVisitor | Convenience base class for visiting the direct children of a node pair |
CDune::TypeTree::DirectChildrenVisitor | Convenience base class for visiting the direct children of a node |
►CDune::TypeTree::VisitTree | Mixin base class for visitors that want to visit the complete tree |
CDune::TypeTree::TreePairVisitor | Convenience base class for visiting an entire tree pair |
CDune::TypeTree::TreeVisitor | Convenience base class for visiting the entire tree |
CDune::VTKFunction< GridView > | A base class for grid functions with any return type and dimension |
►CDune::VTKFunction< G > | |
CDune::PDELab::VTKFiniteElementMapAdapter< G, FEM > | |
►CDune::VTKFunction< GV > | |
CDune::P0VTKFunction< GV, V > | Take a vector and interpret it as cell data for the VTKWriter |
CDune::P1VTKFunction< GV, V > | Take a vector and interpret it as point data for the VTKWriter |
►CDune::VTKFunction< T::Traits::GridViewType > | |
CDune::PDELab::VTKGridFunctionAdapter< T > | Wrap a GridFunction so it can be used with the VTKWriter from dune-grid |
CDune::VTKWriter< GridView >::VTKLocalFunction | Type 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::VTKSequenceWriter< GridView > | Writer for the ouput of grid functions in the vtk format |
►CDune::VTKWriter< GridView > | Writer for the ouput of grid functions in the vtk format |
CDune::SubsamplingVTKWriter< GridView > | Writer for the output of subsampled grid functions in the vtk format |
CDune::VTKWriter< Dune::GridView > | |
CDune::VTK::VTUWriter | Dump a .vtu/.vtp files contents to a stream |
CDune::PDELab::WeightedMatrixAccumulationView< C > | An accumulate-only view on a local matrix that automatically takes into account an accumulation weight |
CDune::PDELab::WeightedVectorAccumulationView< C > | An accumulate-only view on a local vector that automatically takes into account an accumulation weight |
CDune::PDELab::WithLogtag | Temporarily use a different log tag format function |
►CDune::WritablePropertyMapTag | Tag for the category of writable property maps |
CDune::ReadWritePropertyMapTag | Tag for the category of readable and 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::PersistentContainer< YaspGrid< dim, CoordCont >, T > | Specialization of the PersistentContainer for YaspGrid |
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::YLoadBalance< d > | Base class for the yaspgrid partitioning strategy The name might be irritating. It will probably change to YaspPartitionerBase in a 3.0 release |
CDune::YLoadBalanceDefault< d > | Implement the default load balance strategy of yaspgrid |
CDune::YLoadBalancePowerD< d > | Implement yaspgrid load balance strategy for P=x^{dim} processors |
CDune::YaspFixedSizePartitioner< d > | Implement partitioner that gets a fixed partitioning from an array If the given partitioning doesn't match the number of processors, the grid should be distributed to, an exception is thrown |
CDune::YLoadBalance< dim > | |
CDune::Zero< Field > | A class representing the zero of a given Field |