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