C Dune::AdderSelector< T, X, S > Template meta program for choosing how to add the correction
C Dune::AdderSelector< AdditiveSchwarzMode, X, S >
C Dune::AdderSelector< MultiplicativeSchwarzMode, X, S >
C Dune::AdderSelector< SymmetricMultiplicativeSchwarzMode, X, S >
C Dune::OwnerOverlapCopyCommunication< GlobalIdType, LocalIdType >::AddGatherScatter< T >
C Dune::AdditiveAdder< S, T >
C Dune::AdditiveAdder< S, BlockVector< FieldVector< T, n >, A > >
C Dune::AdditiveSchwarzMode Tag that the tells the schwarz method to be additive
C Dune::Amg::Aggregate< G, S > A class for temporarily storing the vertices of an aggregate in
C Dune::Amg::Aggregate< MatrixGraph, VertexSet >
C Dune::Amg::AggregateRenumberer< G >
C Dune::Amg::AggregatesGatherScatter< T, TI >
C Dune::Amg::AggregatesMap< V > Class providing information about the mapping of the vertices onto aggregates
C Dune::Amg::AggregatesMap< Vertex >
C Dune::Amg::AggregatesPublisher< T, O, I >
C Dune::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
C Dune::Amg::AggregatesPublisher< T, O, SequentialInformation >
C Dune::Amg::Aggregator< G > Class for building the aggregates
C Dune::algmeta_bdsolve< I, relax >
C Dune::algmeta_bdsolve< 0, norelax >
C Dune::algmeta_bdsolve< 0, withrelax >
C Dune::algmeta_btsolve< I, diag, relax >
C Dune::algmeta_btsolve< 0, nodiag, norelax >
C Dune::algmeta_btsolve< 0, nodiag, withrelax >
C Dune::algmeta_btsolve< 0, withdiag, norelax >
C Dune::algmeta_btsolve< 0, withdiag, withrelax >
C Dune::algmeta_itsteps< I, M >
C Dune::algmeta_itsteps< 0, M >
C Dune::algmeta_itsteps< I, MultiTypeBlockMatrix< T1, MultiTypeMatrixArgs... > >
C Dune::Amg::AlwaysOneNorm
C Dune::Amg::ApplyHelper< i >
C Dune::Amg::ApplyHelper< 0 >
► C Dune::base_array_unmanaged< B, A > A simple array container for objects of type B
C Dune::block_vector_unmanaged< B, std::allocator< B > >
C Dune::block_vector_unmanaged< FieldVector< T, n >, A >
C Dune::block_vector_unmanaged< T, std::allocator< T > >
C Dune::base_array< B, A > This container extends base_array_unmanaged by memory management with the usual copy semantics providing the full range of copy constructor, destructor and assignment operators
C Dune::base_array_window< B, A > Extend base_array_unmanaged by functions to manipulate
► C Dune::block_vector_unmanaged< B, A > An unmanaged vector of blocks
C Dune::BlockVector< FieldVector< T, n >, A >
C Dune::MatrixImp::DenseMatrixBase< T, std::allocator< T > >
C Dune::BlockVector< B, A > A vector of blocks with memory management
C Dune::BlockVectorWindow< B, A >
C Dune::MatrixImp::DenseMatrixBase< B, A > A Vector of blocks with different blocksizes
C Dune::VariableBlockVector< B, A > A Vector of blocks with different blocksizes
► C Dune::base_array_unmanaged< B, A >
► C Dune::block_vector_unmanaged< B, A >
C Dune::BlockVectorWindow< B, A >
C Dune::base_array_unmanaged< B, std::allocator< B > >
C Dune::base_array_unmanaged< FieldVector< T, n >, A >
C Dune::base_array_unmanaged< T, std::allocator< T > >
► C Dune::Amg::BaseConnectivityConstructor
C Dune::Amg::ConnectivityConstructor< G, T >
C Dune::Amg::ConnectivityConstructor< G, SequentialInformation >
► C Dune::Amg::BaseGalerkinProduct
C Dune::Amg::GalerkinProduct< T >
C Dune::Amg::GalerkinProduct< SequentialInformation >
C Dune::BaseGetSuperLUType< T >
► C Dune::BaseGetSuperLUType< double >
C Dune::GetSuperLUType< double >
► C Dune::BaseGetSuperLUType< float >
C Dune::GetSuperLUType< float >
► C Dune::BaseGetSuperLUType< std::complex< double > >
C Dune::GetSuperLUType< std::complex< double > >
► C Dune::BaseGetSuperLUType< std::complex< float > >
C Dune::GetSuperLUType< std::complex< float > >
► C Dune::BCRSMatrix< B, A > A sparse block matrix with compressed row storage
C Dune::BDMatrix< B, A > A block-diagonal matrix
C Dune::BTDMatrix< B, A > A block-tridiagonal matrix
C Dune::BCRSMatrix< B, std::allocator< B > >
► C BidirectionalIteratorFacade
C Dune::Amg::Hierarchy< T, A >::LevelIterator< C, T1 > Iterator over the levels in the hierarchy
C Dune::compressed_base_array_unmanaged< B, A >::RealIterator< T > Iterator class for sequential access
C Dune::BL< l > Compile-time parameter for block recursion depth
C Dune::Amg::MatrixHierarchy< M, PI, A >::MatrixStats< Matrix, true >::calc
C Dune::CheckIfDiagonalPresent< Matrix, blocklevel, l > Check whether the a matrix has diagonal values on blocklevel recursion levels
C Dune::CheckIfDiagonalPresent< Matrix, 0, l >
C Dune::CheckIfDiagonalPresent< MultiTypeBlockMatrix< T1, Args... >, blocklevel, l >
C Dune::ColCompMatrix< M > Utility class for converting an ISTL Matrix into a column-compressed matrix
► C Dune::ColCompMatrix< BCRSMatrix< FieldMatrix< B, n, m >, TA > > Converter for BCRSMatrix to column-compressed Matrix . specialization for BCRSMatrix
C Dune::SuperLUMatrix< BCRSMatrix< FieldMatrix< B, n, m >, TA > > Converter for BCRSMatrix to SuperLU Matrix
C Dune::ColCompMatrix< Matrix >
C Dune::ColCompMatrixInitializer< M > Inititializer for the ColCompMatrix as needed by OverlappingSchwarz
► C Dune::ColCompMatrixInitializer< BCRSMatrix< FieldMatrix< T, n, m >, A > >
C Dune::SuperMatrixInitializer< BCRSMatrix< FieldMatrix< T, n, m >, A > >
C Dune::CommMatrixRow< M, I > Utility class for comunicating the matrix entries
C Dune::CommMatrixRowSize< M, RI > Utility class to communicate and set the row sizes of a redistributed matrix
C Dune::CommMatrixSparsityPattern< M, I > Utility class to communicate and build the sparsity pattern of a redistributed matrix
C Dune::CommPolicy< Amg::GlobalAggregatesMap< T, TI > >
C Dune::CommPolicy< CommMatrixRow< M, I > >
C Dune::CommPolicy< CommMatrixSparsityPattern< M, I > >
► C Dune::compressed_base_array_unmanaged< B, A > A simple array container with non-consecutive index set
C Dune::compressed_block_vector_unmanaged< B, std::allocator< B > >
► C Dune::compressed_block_vector_unmanaged< B, A >
C Dune::CompressedBlockVectorWindow< B, A >
► C Dune::compressed_base_array_unmanaged< B, A >
► C Dune::compressed_block_vector_unmanaged< B, A >
C Dune::CompressedBlockVectorWindow< B, A >
C Dune::compressed_base_array_unmanaged< B, std::allocator< B > >
C Dune::CompressionStatistics< size_type > Statistics about compression achieved in implicit mode
C Dune::Amg::BaseConnectivityConstructor::ConnectedBuilder< G, S, V > Visitor for identifying connected aggregates during a breadthFirstSearch
C Dune::MatrixImp::DenseMatrixBase< B, A >::ConstIterator ConstIterator class for sequential access
C Dune::Amg::ConstructionTraits< T > Traits class for generically constructing non default constructable types
C Dune::Amg::ConstructionTraits< BlockPreconditioner< X, Y, C, T > >
C Dune::Amg::ConstructionTraits< BlockVector< T, A > >
C Dune::Amg::ConstructionTraits< MatrixAdapter< M, X, Y > >
C Dune::Amg::ConstructionTraits< NonoverlappingBlockPreconditioner< C, T > >
C Dune::Amg::ConstructionTraits< NonoverlappingSchwarzOperator< M, X, Y, C > >
C Dune::Amg::ConstructionTraits< OverlappingSchwarzOperator< M, X, Y, C > >
C Dune::Amg::ConstructionTraits< OwnerOverlapCopyCommunication< T1, T2 > >
C Dune::Amg::ConstructionTraits< ParSSOR< M, X, Y, C > > Policy for the construction of the ParSSOR smoother
C Dune::Amg::ConstructionTraits< SeqILU0< M, X, Y > > Policy for the construction of the SeqILUn smoother
C Dune::Amg::ConstructionTraits< SeqILUn< M, X, Y > > Policy for the construction of the SeqJac smoother
C Dune::Amg::ConstructionTraits< SeqJac< M, X, Y, l > > Policy for the construction of the SeqJac smoother
C Dune::Amg::ConstructionTraits< SeqOverlappingSchwarz< M, X, TM, TS, TA > >
C Dune::Amg::ConstructionTraits< SeqSOR< M, X, Y, l > > Policy for the construction of the SeqSOR smoother
C Dune::Amg::ConstructionTraits< SeqSSOR< M, X, Y, l > > Policy for the construction of the SeqSSOR smoother
C Dune::Amg::ConstructionTraits< SequentialInformation >
C Dune::OwnerOverlapCopyCommunication< GlobalIdType, LocalIdType >::CopyGatherScatter< T > Gather/scatter callback for communcation
C Dune::BCRSMatrix< B, A >::CreateIterator Iterator class for sequential creation of blocks
C Dune::VariableBlockVector< B, A >::CreateIterator Iterator class for sequential creation of blocks
C Dune::BCRSMatrix< B, A >::Deallocator Class used by shared_ptr to deallocate memory using the proper allocator
► C Dune::Amg::DefaultConstructionArgs< T > Construction Arguments for the default smoothers
► C Dune::Amg::ConstructionArgs< T >
C Dune::Amg::DefaultParallelConstructionArgs< T, C >
► C Dune::Amg::DefaultConstructionArgs< SeqILUn< M, X, Y > >
C Dune::Amg::ConstructionArgs< SeqILUn< M, X, Y > >
► C Dune::Amg::DefaultConstructionArgs< SeqOverlappingSchwarz< M, X, TM, TS, TA > >
C Dune::Amg::ConstructionArgs< SeqOverlappingSchwarz< M, X, TM, TS, TA > >
► C Dune::Amg::DefaultSmootherArgs< T > The default class for the smoother arguments
C Dune::Amg::SeqOverlappingSchwarzSmootherArgs< T >
C Dune::DenseMatrixAssigner< DenseMatrix, ScaledIdentityMatrix< field, N > >
► C Dune::Amg::DependencyParameters Parameters needed to check whether a node depends on another
► C Dune::Amg::AggregationParameters Parameters needed for the aggregation process,
► C Dune::Amg::CoarseningParameters Parameters for the complete coarsening process
► C Dune::Amg::Parameters All parameters for AMG
► C Dune::Amg::Dependency< M, Norm >
► C Dune::Amg::AggregationCriterion< Dependency< M, Norm > >
C Dune::Amg::UnSymmetricCriterion< M, Norm > Criterion suited for unsymmetric matrices
► C Dune::Amg::SymmetricDependency< M, Norm >
► C Dune::Amg::AggregationCriterion< SymmetricDependency< M, Norm > >
C Dune::Amg::SymmetricCriterion< M, Norm > Criterion taking advantage of symmetric matrices
C Dune::Amg::Dependency< M, N > Dependency policy for symmetric matrices
C Dune::Amg::SymmetricDependency< M, N > Dependency policy for symmetric matrices
C Dune::Amg::SymmetricMatrixDependency< M, N > Dependency policy for symmetric matrices
C Dune::Amg::Diagonal< N > Norm that uses only the [N][N] entry of the block to determine couplings
► C Dune::Amg::Diagonal< 0 >
C Dune::Amg::FirstDiagonal Norm that uses only the [0][0] entry of the block to determine couplings
C Dune::Amg::DirichletBoundarySetter< T >
C Dune::Amg::DirichletBoundarySetter< SequentialInformation >
C Dune::Amg::AggregatesMap< V >::DummyEdgeVisitor A Dummy visitor that does nothing for each visited edge
C Dune::DynamicMatrixSubdomainSolver< M, X, Y > Exact subdomain solver using Dune::DynamicMatrix<T>::solve
C Dune::DynamicMatrixSubdomainSolver< BCRSMatrix< FieldMatrix< K, n, n >, Al >, X, Y >
C Dune::Amg::SubGraph< G, T >::EdgeIndexMap An index map for mapping the edges to indices
C Dune::Amg::MatrixGraph< M >::EdgeIteratorT< C > Iterator over all edges starting from a vertex
C Dune::Amg::EdgeProperties Class representing the properties of an ede in the matrix graph
► C Dune::Exception
C Dune::MatrixMarketFormatError
C Dune::FieldMatrix< K, n, m >
C Dune::FieldTraits< BlockVector< B, A > >
C Dune::FieldTraits< MultiTypeBlockVector< Arg0, Args... > >
► C Dune::FMatrixError
C Dune::MatrixBlockError
► C ForwardIteratorFacade
C Dune::Amg::SubGraph< G, T >::VertexIterator The vertex iterator of the graph
C Dune::MatrixRowSubset< M, S >::const_iterator The matrix row iterator type
C Dune::Amg::FrobeniusNorm
C Dune::Amg::GaussSeidelPostsmoothDefect< level >
C Dune::Amg::GaussSeidelPresmoothDefect< level >
C Dune::GetSuperLUType< T >
C Dune::Amg::GlobalAggregatesMap< T, TI >
C Dune::Amg::GraphEdgePropertiesSelector< G > Wrapper to access the internal vertex properties of a graph via operator[]()
C Dune::Amg::GraphVertexPropertiesSelector< G > Wrapper to access the internal edge properties of a graph via operator[]()
C Dune::Amg::Hierarchy< T, A > A hierarchy of coantainers (e.g. matrices or vectors)
C Dune::Amg::Hierarchy< Domain, A >
C Dune::Amg::Hierarchy< Domain, std::allocator< X > >
C Dune::Amg::Hierarchy< MatrixOperator, Allocator >
C Dune::Amg::Hierarchy< ParallelInformation, Allocator >
C Dune::Amg::Hierarchy< Range, A >
C Dune::Amg::Hierarchy< Range, std::allocator< X > >
C Dune::Amg::Hierarchy< Smoother, A >
C Dune::Amg::Hierarchy< Smoother, std::allocator< X > >
► C Dune::ILUSubdomainSolver< M, X, Y > Base class encapsulating common algorithms of ILU0SubdomainSolver and ILUNSubdomainSolver
C Dune::ILU0SubdomainSolver< M, X, Y > Exact subdomain solver using ILU(p) with appropriate p
C Dune::ILUNSubdomainSolver< M, X, Y >
C Dune::SolverHelper< ISTLLinearSolver, BCRSMatrix >::Implementation< is_direct_solver, Dummy > Implementation that works together with iterative ISTL solvers, e.g. Dune::CGSolver or Dune::BiCGSTABSolver
C Dune::SolverHelper< ISTLLinearSolver, BCRSMatrix >::Implementation< true, Dummy > Implementation that works together with direct ISTL solvers, e.g. Dune::SuperLU or Dune::UMFPack
C Dune::ImplicitMatrixBuilder< M_ > A wrapper for uniform access to the BCRSMatrix during and after the build stage in implicit build mode
C Dune::IndexInfoFromGrid< G, L > Information about the index distribution
C Dune::Amg::IndicesCoarsener< T, E >
C Dune::Amg::IndicesCoarsener< SequentialInformation, E > Coarsen Indices in the sequential case
► C Interface
C Dune::RedistributeInterface
► C Dune::InverseOperator< X, Y > Abstract base class for all solvers
C Dune::RestartedGMResSolver< X, Y, F > Implements the Generalized Minimal Residual (GMRes) method
► C Dune::InverseOperator< BlockVector< FieldVector< T, m >, A::template rebind< FieldVector< T, m > >::other >, BlockVector< FieldVector< T, n >, A::template rebind< FieldVector< T, n > >::other > >
C Dune::LDL< BCRSMatrix< FieldMatrix< T, n, m >, A > > The LDL direct sparse solver for matrices of type BCRSMatrix
C Dune::SPQR< BCRSMatrix< FieldMatrix< T, n, m >, A > > The SPQR direct sparse solver for matrices of type BCRSMatrix
C Dune::SuperLU< BCRSMatrix< FieldMatrix< T, n, m >, A > > SuperLu Solver
C Dune::UMFPack< BCRSMatrix< FieldMatrix< T, n, m >, A > > The UMFPack direct sparse solver for matrices of type BCRSMatrix
C Dune::InverseOperator< Domain, Range >
► C Dune::InverseOperator< X, X >
C Dune::BiCGSTABSolver< X > Bi-conjugate Gradient Stabilized (BiCG-STAB)
C Dune::CGSolver< X > Conjugate gradient method
C Dune::GeneralizedPCGSolver< X > Generalized preconditioned conjugate gradient solver
C Dune::GradientSolver< X > Gradient method
C Dune::LoopSolver< X > Preconditioned loop solver
C Dune::MINRESSolver< X > Minimal Residual Method (MINRES)
C Dune::InverseOperatorResult Statistics about the application of an inverse operator
C Dune::IsDirectSolver< Solver >
C Dune::IsDirectSolver< LDL< BCRSMatrix< FieldMatrix< T, n, m >, A > > >
C Dune::IsDirectSolver< SPQR< BCRSMatrix< FieldMatrix< T, n, m >, A > > >
C Dune::IsDirectSolver< SuperLU< BCRSMatrix< FieldMatrix< T, n, m >, A > > >
C Dune::IsDirectSolver< UMFPack< BCRSMatrix< FieldMatrix< T, n, m >, A > > >
C Dune::IsMatrix< T > Test whether a type is an ISTL Matrix
C Dune::IsMatrix< BCRSMatrix< T, A > >
C Dune::IsMatrix< DenseMatrix< T > >
C Dune::MatrixImp::DenseMatrixBase< B, A >::Iterator Iterator class for sequential access
C Dune::IteratorDirectionSelector< T1, T2, forward > Helper template meta program for application of overlapping schwarz
C Dune::IteratorDirectionSelector< T1, T2, false >
C Dune::LDL< Matrix > Use the LDL package to directly solve linear systems – empty default class
C Dune::Amg::LevelTransferPolicy< FO, CO > Abstract base class for transfer between levels and creation of the coarse level system
C Dune::Amg::LevelTransferPolicy< FO, typename CSP::Operator >
► C Dune::Amg::LevelTransferPolicy< O, O >
C Dune::Amg::AggregationLevelTransferPolicy< O, C > A LeveTransferPolicy that used aggregation to construct the coarse level system
► C Dune::LinearOperator< X, Y > A linear operator
► C Dune::AssembledLinearOperator< M, X, Y > A linear operator exporting itself in matrix form
C Dune::MatrixAdapter< M, X, Y > Adapter to turn a matrix into a linear operator
C Dune::NonoverlappingSchwarzOperator< M, X, Y, C > A nonoverlapping operator with communication object
C Dune::OverlappingSchwarzOperator< M, X, Y, C > An overlapping schwarz operator
C Dune::ScalingLinearOperator< X, Y > A linear operator scaling vectors by a scalar value. The scalar value can be changed as it is given in a form decomposed into an immutable and a mutable part
► C Dune::LinearOperator< OP1::domain_type, OP1::range_type >
C Dune::LinearOperatorSum< MatrixOperator, ScalingOperator >
C Dune::LinearOperatorSum< OP1, OP2 > A linear operator representing the sum of two linear operators
C Dune::LinearOperator< X, X >
► C Dune::MathError
► C Dune::ISTLError Derive error class from the base class in common
► C Dune::BCRSMatrixError Error specific to BCRSMatrix
C Dune::ImplicitModeOverflowExhausted The overflow error used during implicit BCRSMatrix construction was exhausted
C Dune::SolverAbort Thrown when a solver aborts due to some problem
C Dune::MatMultMatResult< M1, M2 > Helper TMP to get the result type of a sparse matrix matrix multiplication ( )
C Dune::MatMultMatResult< BCRSMatrix< FieldMatrix< T, n, k >, A >, BCRSMatrix< FieldMatrix< T, k, m >, A1 > >
C Dune::MatMultMatResult< FieldMatrix< T, n, k >, FieldMatrix< T, k, m > >
C Dune::Matrix< T, A > A generic dynamic dense matrix
C Dune::Amg::MatrixAdapterArgs< M, X, Y >
C Dune::MatrixCopyRowSizeGatherScatter< M, I, RI >
C Dune::MatrixDimension< M >
C Dune::MatrixDimension< BCRSMatrix< B, TA > >
C Dune::MatrixDimension< BCRSMatrix< FieldMatrix< B, n, m >, TA > >
C Dune::MatrixDimension< DiagonalMatrix< K, n > >
C Dune::MatrixDimension< Dune::DynamicMatrix< T > >
C Dune::MatrixDimension< FieldMatrix< K, n, m > >
C Dune::MatrixDimension< Matrix< FieldMatrix< K, n, m >, TA > >
C Dune::MatrixDimension< ScaledIdentityMatrix< K, n > >
C Dune::Amg::MatrixGraph< M > The (undirected) graph of a matrix
C Dune::Amg::MatrixGraph< const M >
C Dune::Amg::MatrixHierarchy< M, PI, A > The hierarchies build by the coarsening process
C Dune::MatrixIndexSet Stores the nonzero entries in a sparse matrix
C Dune::MatrixRowGatherScatter< M, I >
C Dune::MatrixRowSet< M > Provides access to an iterator over all matrix rows
C Dune::MatrixRowSizeGatherScatter< M, I, RI >
C Dune::MatrixRowSubset< M, S > Provides access to an iterator over an arbitrary subset of matrix rows
C Dune::MatrixSparsityPatternGatherScatter< M, I >
C Dune::MatrixMarketImpl::MatrixValuesSetter< D, brows, bcols > Functor to the data values of the matrix
C Dune::MatrixMarketImpl::MatrixValuesSetter< PatternDummy, brows, bcols >
C Dune::MatrixMarketImpl::mm_block_structure_header< M > Metaprogram for writing the ISTL block structure header
C Dune::MatrixMarketImpl::mm_block_structure_header< BCRSMatrix< FieldMatrix< T, i, j >, A > >
C Dune::MatrixMarketImpl::mm_block_structure_header< BlockVector< FieldVector< T, i >, A > >
C Dune::MatrixMarketImpl::mm_block_structure_header< FieldMatrix< T, i, j > >
C Dune::MatrixMarketImpl::mm_block_structure_header< FieldVector< T, i > >
C Dune::MatrixMarketImpl::mm_header_printer< M > Meta program to write the correct Matrix Market header
C Dune::MatrixMarketImpl::mm_header_printer< BCRSMatrix< FieldMatrix< T, i, j >, A > >
C Dune::MatrixMarketImpl::mm_header_printer< BlockVector< B, A > >
C Dune::MatrixMarketImpl::mm_header_printer< FieldMatrix< T, i, j > >
C Dune::MatrixMarketImpl::mm_header_printer< FieldVector< T, j > >
C Dune::mm_multipliers< M >
C Dune::mm_multipliers< BCRSMatrix< FieldMatrix< B, i, j >, A > >
C Dune::MatrixMarketImpl::mm_numeric_type< T > Helper metaprogram to get the matrix market string representation of the numeric type
C Dune::MatrixMarketImpl::mm_numeric_type< double >
C Dune::MatrixMarketImpl::mm_numeric_type< float >
C Dune::MatrixMarketImpl::mm_numeric_type< int >
C Dune::MatrixMarketImpl::mm_numeric_type< std::complex< double > >
C Dune::MatrixMarketImpl::mm_numeric_type< std::complex< float > >
C Dune::MatrixMarketImpl::MMHeader
C Dune::MultiplicativeAdder< S, T >
C Dune::MultiplicativeAdder< S, BlockVector< FieldVector< T, n >, A > >
C Dune::MultiplicativeSchwarzMode Tag that tells the Schwarz method to be multiplicative
C Dune::MultiTypeBlockMatrix_Solver< I, crow, remain_row > Solver for MultiTypeBlockVector & MultiTypeBlockMatrix types
C Dune::MultiTypeBlockMatrix_Solver< I, crow, 0 >
C Dune::MultiTypeBlockMatrix_Solver_Col< I, crow, ccol, remain_col > Part of solvers for MultiTypeBlockVector & MultiTypeBlockMatrix types
C Dune::MultiTypeBlockMatrix_Solver_Col< I, crow, ccol, 0 >
C Dune::Amg::NonoverlappingOperatorArgs< M, C >
C Dune::MatrixMarketImpl::NumericWrapper< T > Wrapper class of numeric values
C Dune::MatrixMarketImpl::NumericWrapper< PatternDummy >
C Dune::Amg::OneStepAMGCoarseSolverPolicy< O, S, C > A policy class for solving the coarse level system using one step of AMG
C Dune::OverlappingAssignerHelper< T, tag >
C Dune::OverlappingAssignerHelper< DynamicMatrixSubdomainSolver< BCRSMatrix< FieldMatrix< K, n, n >, Al >, X, Y >, false >
C Dune::OverlappingAssignerHelper< S >
C Dune::OverlappingAssignerHelper< S< BCRSMatrix< FieldMatrix< T, n, m >, A > >, true >
► C Dune::OverlappingAssignerILUBase< M, X, Y >
C Dune::OverlappingAssignerHelper< ILU0SubdomainSolver< M, X, Y >, false >
C Dune::OverlappingAssignerHelper< ILUNSubdomainSolver< M, X, Y >, false >
C Dune::OverlappingSchwarzInitializer< I, S, D > Initializer for SuperLU Matrices representing the subdomains
C Dune::Amg::OverlappingSchwarzOperatorArgs< M, C >
C Dune::Amg::OverlapVertex< T >
C Dune::OwnerOverlapCopyAttributeSet Attribute set for overlapping schwarz
C Dune::OwnerOverlapCopyCommunication< GlobalIdType, LocalIdType > A class setting up standard communication for a two-valued attribute set with owner/overlap/copy semantics
C Dune::Amg::OwnerOverlapCopyCommunicationArgs
C Dune::Amg::ParallelIndicesCoarsener< T, E >
► C Dune::Amg::ParallelIndicesCoarsener< OwnerOverlapCopyCommunication< G, L >, E >
C Dune::Amg::IndicesCoarsener< OwnerOverlapCopyCommunication< G, L >, E > Coarsen Indices in the parallel case
C Dune::MatrixMarketImpl::PatternDummy Utility class for marking the pattern type of the MatrixMarket matrices
C Dune::PointerCompare< T >
C Dune::PowerIteration_Algorithms< BCRSMatrix, BlockVector > A class template for performing some iterative eigenvalue algorithms based on power iteration
► C Dune::Preconditioner< X, Y > Base class for matrix free definition of preconditioners
C Dune::BlockPreconditioner< X, Y, C, T > Block parallel preconditioner
C Dune::ParSSOR< M, X, Y, C > A parallel SSOR preconditioner
C Dune::Richardson< X, Y > Richardson preconditioner
C Dune::SeqGS< M, X, Y, l > Sequential Gauss Seidel preconditioner
C Dune::SeqILU0< M, X, Y, l > Sequential ILU0 preconditioner
C Dune::SeqILUn< M, X, Y, l > Sequential ILU(n) preconditioner
C Dune::SeqJac< M, X, Y, l > The sequential jacobian preconditioner
C Dune::SeqSOR< M, X, Y, l > Sequential SOR preconditioner
C Dune::SeqSSOR< M, X, Y, l > Sequential SSOR preconditioner
► C Dune::Preconditioner< AMG::Domain, AMG::Range >
C Dune::Amg::KAmgTwoGrid< Dune::Amg::AMG >
C Dune::Amg::KAmgTwoGrid< AMG > Two grid operator for AMG with Krylov cycle
► C Dune::Preconditioner< FO::domain_type, FO::range_type >
C Dune::Amg::TwoLevelMethod< FO, CSP, S >
► C Dune::Preconditioner< O::domain_type, O::range_type >
C Dune::InverseOperator2Preconditioner< O, c > Turns an InverseOperator into a Preconditioner
► C Dune::Preconditioner< P::domain_type, P::range_type >
C Dune::NonoverlappingBlockPreconditioner< C, P > Nonoverlapping parallel preconditioner
► C Dune::Preconditioner< X, X >
C Dune::Amg::AMG< M, X, S, SequentialInformation, std::allocator< X > >
C Dune::Amg::AMG< Operator, X, Smoother >
C Dune::SeqOverlappingSchwarz< M, X, TM, TS, TA >
C Dune::Amg::AMG< M, X, S, PI, A > Parallel algebraic multigrid based on agglomeration
C Dune::Amg::FastAMG< M, X, PI, A > A fast (sequential) algebraic multigrid based on agglomeration that saves memory bandwidth
C Dune::Amg::KAMG< M, X, S, PI, K, A > Algebraic multigrid method using a Krylov-cycle
C Dune::SeqOverlappingSchwarz< M, X, TM, TD, TA > Sequential overlapping Schwarz preconditioner
C Dune::Amg::PropertiesGraph< G, VP, EP, VM, EM > Attaches properties to the edges and vertices of a graph
C Dune::Amg::PropertiesGraphCreator< M, cat >
C Dune::Amg::PropertiesGraphCreator< M, SolverCategory::nonoverlapping >
C Dune::Amg::PropertiesGraphCreator< M, SolverCategory::overlapping >
C Dune::Amg::PropertiesGraphCreator< M, SolverCategory::sequential >
C Dune::PropertyMapTypeSelector< Amg::VertexVisitedTag, Amg::PropertiesGraph< G, Amg::VertexProperties, EP, VM, EM > >
C Dune::Amg::GlobalAggregatesMap< T, TI >::Proxy
C Dune::QuerySpaceChooser< T >
C Dune::QuerySpaceChooser< float >
► C RandomAccessIteratorFacade
C Dune::Amg::SubGraph< G, T >::EdgeIterator The edge iterator of the graph
C Dune::BCRSMatrix< B, A >::RealRowIterator< T > Iterator access to matrix rows
C Dune::VariableBlockVector< B, A >::RealIterator< T, R > Iterator class for sequential access
C Dune::base_array_unmanaged< B, A >::RealIterator< T > Iterator implementation class
► C RAPropertyMapHelper
C Dune::Amg::PropertyGraphVertexPropertyMap< G, i >
C Dune::Amg::RandomAccessBundledPropertyMap< C, K, i, T, R > A property map that extracts one property out of a bundle using operator[]()
C Dune::RedistributeInformation< T >
C Dune::RedistributeInformation< OwnerOverlapCopyCommunication< T, T1 > >
C Dune::ImplicitMatrixBuilder< M_ >::row_object Proxy row object for entry access
C Dune::Amg::RowSum Functor using the row sum (infinity) norm to determine strong couplings
► C Dune::ScalarProduct< X > Base class for scalar product and norm computation
C Dune::NonoverlappingSchwarzScalarProduct< X, C > Nonoverlapping Scalar Product with communication object
C Dune::OverlappingSchwarzScalarProduct< X, C > Scalar product for overlapping schwarz methods
C Dune::SeqScalarProduct< X > Default implementation for the scalar case
C Dune::ScalarProductChooser< X, C, c > Choose the approriate scalar product for a solver category
C Dune::ScalarProductChooser< X, C, SolverCategory::nonoverlapping >
C Dune::ScalarProductChooser< X, C, SolverCategory::overlapping >
C Dune::ScalarProductChooser< X, C, SolverCategory::sequential >
C Dune::ScaledIdentityMatrix< K, n > A multiple of the identity matrix of static size
C Dune::SeqOverlappingSchwarzApplier< T > Helper template meta program for application of overlapping schwarz
C Dune::SeqOverlappingSchwarzApplier< SeqOverlappingSchwarz< M, X, SymmetricMultiplicativeSchwarzMode, TD, TA > >
C Dune::SeqOverlappingSchwarzAssemblerHelper< T, tag >
C Dune::SeqOverlappingSchwarzAssemblerHelper< DynamicMatrixSubdomainSolver< BCRSMatrix< FieldMatrix< K, n, n >, Al >, X, Y >, false >
C Dune::SeqOverlappingSchwarzAssemblerHelper< S< BCRSMatrix< FieldMatrix< T, m, n >, A > >, true >
► C Dune::SeqOverlappingSchwarzAssemblerILUBase< M, X, Y >
C Dune::SeqOverlappingSchwarzAssemblerHelper< ILU0SubdomainSolver< M, X, Y >, false >
C Dune::SeqOverlappingSchwarzAssemblerHelper< ILUNSubdomainSolver< M, X, Y >, false >
C Dune::SeqOverlappingSchwarzDomainSize< M >
C Dune::SeqOverlappingSchwarzDomainSize< BCRSMatrix< FieldMatrix< T, n, m >, A > >
C Dune::Amg::SequentialCommunicationArgs
C Dune::Amg::SequentialInformation
C Dune::Amg::SmootherApplier< T > Helper class for applying the smoothers
C Dune::Amg::SmootherApplier< BlockPreconditioner< X, Y, C, SeqSOR< M, X, Y, l > > >
C Dune::Amg::SmootherApplier< NonoverlappingBlockPreconditioner< C, SeqSOR< M, X, Y, l > > >
C Dune::Amg::SmootherApplier< SeqOverlappingSchwarz< M, X, MultiplicativeSchwarzMode, MS, TA > >
C Dune::Amg::SmootherApplier< SeqSOR< M, X, Y, l > >
C Dune::Amg::SmootherTraits< T > Traits class for getting the attribute class of a smoother
C Dune::Amg::SmootherTraits< BlockPreconditioner< X, Y, C, T > >
C Dune::Amg::SmootherTraits< NonoverlappingBlockPreconditioner< C, T > >
C Dune::Amg::SmootherTraits< S >
C Dune::Amg::SmootherTraits< SeqOverlappingSchwarz< M, X, TM, TS, TA > >
C Dune::Amg::SmootherTraits< Smoother >
C Dune::SolverCategory Categories for the solvers
C Dune::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)
C Dune::Amg::SparsityBuilder< M > Functor for building the sparsity pattern of the matrix using examineConnectivity
C Dune::SPQR< Matrix > Use the SPQR package to directly solve linear systems – empty default class
C Dune::StoresColumnCompressed< Solver >
C Dune::StoresColumnCompressed< LDL< BCRSMatrix< FieldMatrix< T, n, m >, A > > >
C Dune::StoresColumnCompressed< SPQR< BCRSMatrix< FieldMatrix< T, n, m >, A > > >
C Dune::StoresColumnCompressed< SuperLU< BCRSMatrix< FieldMatrix< T, n, m >, A > > >
C Dune::StoresColumnCompressed< UMFPack< BCRSMatrix< FieldMatrix< T, n, m >, A > > >
C Dune::Amg::SubGraph< G, T > A subgraph of a graph
C Dune::Amg::SubGraph< Graph, T >
C Dune::SuperLU< Matrix >
C Dune::SuperLUDenseMatChooser< T >
C Dune::SuperLUDenseMatChooser< float >
C Dune::SuperLUMatrix< M > Utility class for converting an ISTL Matrix into a SuperLU Matrix
C Dune::SuperLUMatrix< Matrix >
C Dune::SuperLUQueryChooser< T >
C Dune::SuperLUSolveChooser< T >
C Dune::SuperLUSolveChooser< float >
C Dune::SuperMatrixCreateSparseChooser< T >
C Dune::SuperMatrixCreateSparseChooser< float >
C Dune::SuperMatrixInitializer< M >
C Dune::SuperMatrixPrinter< T >
C Dune::SuperMatrixPrinter< float >
C Dune::SymmetricMultiplicativeSchwarzMode Tag that tells the Schwarz method to be multiplicative and symmetric
► C T
C Dune::Amg::AggregationCriterion< T > Base class of all aggregation criterions
C Dune::Amg::CoarsenCriterion< T > The criterion describing the stop criteria for the coarsening process
C Dune::Amg::CombinedFunctor< T >
C Dune::MatrixMarketImpl::IndexData< T >
C Timer
C Dune::Amg::Transfer< V1, V2, T >
C Dune::Amg::Transfer< V, V1, OwnerOverlapCopyCommunication< T1, T2 > >
C Dune::Amg::Transfer< V, V1, SequentialInformation >
C Dune::TransposedMatMultMatResult< M1, M2 > Helper TMP to get the result type of a sparse matrix matrix multiplication ( )
C Dune::TransposedMatMultMatResult< BCRSMatrix< FieldMatrix< T, k, n >, A >, BCRSMatrix< FieldMatrix< T, k, m >, A1 > >
C Dune::TransposedMatMultMatResult< FieldMatrix< T, k, n >, FieldMatrix< T, k, m > >
► C std::tuple
C Dune::MultiTypeBlockMatrix< FirstRow, Args > A Matrix class to support different block types
C Dune::MultiTypeBlockVector< Args > A Vector class to support different block types
► C std::conditional::type
C Dune::Amg::PropertiesGraph< G, VP, EP, VM, EM >::EdgeIteratorT< C >
► C std::conditional::type
C Dune::Amg::PropertiesGraph< G, VP, EP, VM, EM >::VertexIteratorT< C >
C Dune::Amg::VertexPropertiesGraph< G, VP, VM >::VertexIteratorT< C >
C Dune::UMFPack< Matrix > Use the UMFPack package to directly solve linear systems – empty default class
C Dune::UMFPackMethodChooser< T >
C Dune::UMFPackMethodChooser< double >
C Dune::UMFPackMethodChooser< std::complex< double > >
C Dune::Amg::MatrixGraph< M >::VertexIteratorT< C > The vertex iterator type of the graph
C Dune::Amg::VertexProperties Class representing a node in the matrix graph
C Dune::Amg::VertexPropertiesGraph< G, VP, VM > Attaches properties to the vertices of a graph
C Dune::Amg::VertexVisitedTag Tag idnetifying the visited property of a vertex