► 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< SeqILU< M, X, Y > >
C ConstructionArgs< SeqOverlappingSchwarz< M, X, TM, TS, TA > >
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< Richardson< X, Y > > Policy for the construction of the Richardson smoother
C ConstructionTraits< SeqILU< M, X, Y > > Policy for the construction of the SeqILU 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 DefaultConstructionArgs< Richardson< X, Y > >
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 DirectSolverSelector
C Solver
C Solver< M, superlu >
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 containers (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 OneStepAMGCoarseSolverPolicy A policy class for solving the coarse level system using one step of AMG
C OverlapVertex
C OwnerOverlapCopyCommunicationArgs
C ParallelIndicesCoarsener
C ParallelOperatorArgs
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, SequentialInformation >
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< Richardson< X, Y > >
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 suitable 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 ILU
C CRS Simple compressed row storage matrix class
► 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 is_complex
C is_complex< std::complex< T > >
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< BCRSMatrix< T, A > >
C mm_block_structure_header< BlockVector< FieldVector< T, i >, A > >
C mm_block_structure_header< BlockVector< T, 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< T, 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_multipliers
C mm_multipliers< BCRSMatrix< B, A > >
C mm_multipliers< BCRSMatrix< FieldMatrix< B, i, j >, A > >
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< T, 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 AllocatorTraits
► C AMGCreator
C isValidBlockType
C isValidBlockType< FieldMatrix< T, n, m > >
C ArPackPlusPlus_Algorithms Wrapper to use a range of ARPACK++ eigenvalue solvers
C AssembledLinearOperator A linear operator exporting itself in matrix form
C BaseGetSuperLUType
► C BCRSMatrix A sparse block matrix with compressed row storage
C CreateIterator Iterator class for sequential creation of blocks
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 BlockPreconditioner Block parallel preconditioner
C BlockVector A vector of blocks with memory management
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 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 CompleteFCGSolver Complete flexible conjugate gradient method
C CompressionStatistics Statistics about compression achieved in implicit mode
C DefaultAllocatorTraits
C DefaultAllocatorTraits< T, std::void_t< typename T::allocator_type > >
C DefaultSVGMatrixOptions Default options class to write SVG matrices
C DenseMatrixAssigner< DenseMatrix, ScaledIdentityMatrix< field, N > >
C DynamicMatrixSubdomainSolver Exact subdomain solver using Dune::DynamicMatrix<T>::solve
C DynamicMatrixSubdomainSolver< BCRSMatrix< K, Al >, X, Y >
C exists
C FieldMatrix
C FieldTraits< BCRSMatrix< B, A > >
C FieldTraits< BDMatrix< B, A > >
C FieldTraits< BlockVector< B, A > >
C FieldTraits< BTDMatrix< B, A > >
C FieldTraits< Matrix< T, A > >
C FieldTraits< MultiTypeBlockVector< Args... > >
C FieldTraits< ScaledIdentityMatrix< K, n > >
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 ImplicitModeCompressionBufferExhausted Thrown when the compression buffer used by the implicit BCRSMatrix construction is exhausted
C IndexInfoFromGrid Information about the index distribution
C InvalidSolverCategory
C InvalidSolverFactoryConfiguration
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< T, A > > >
C IsDirectSolver< SuperLU< BCRSMatrix< T, 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 IterativeSolver Base class for all implementations of iterative solvers
C Iteration Class for controlling iterative methods
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 LDLCreator
C isValidBlock
C isValidBlock< FieldVector< double, k > >
C LinearOperator A linear operator
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 Error when performing an operation on a matrix block
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< B, TA > >
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 MatrixRowSizeGatherScatter
C MatrixSparsityPatternGatherScatter
C MINRESSolver Minimal Residual Method (MINRES)
C MultiplicativeAdder
C MultiplicativeAdder< S, BlockVector< T, 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< K, Al >, X, Y >, false >
C OverlappingAssignerHelper< ILU0SubdomainSolver< M, X, Y >, false >
C OverlappingAssignerHelper< ILUNSubdomainSolver< M, X, Y >, false >
C OverlappingAssignerHelper< S< BCRSMatrix< T, 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 ParallelScalarProduct Scalar product for overlapping Schwarz methods
C ParSSOR A parallel SSOR preconditioner
C PointerCompare
C PowerIteration_Algorithms 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 RedistributeInformation
C RedistributeInformation< OwnerOverlapCopyCommunication< T, T1 > >
C RedistributeInterface
C RestartedFCGSolver Accelerated flexible conjugate gradient method
C RestartedFlexibleGMResSolver Implements the Flexible Generalized Minimal Residual (FGMRes) method (right preconditioned)
C RestartedGMResSolver Implements the Generalized Minimal Residual (GMRes) method
C Richardson Richardson preconditioner
C ScalarProduct Base class for scalar product and norm computation
C ScaledIdentityMatrix A multiple of the identity matrix of static size
C SeqILDL Sequential ILDL preconditioner
C SeqILU Sequential ILU 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< K, Al >, X, Y >, false >
C SeqOverlappingSchwarzAssemblerHelper< ILU0SubdomainSolver< M, X, Y >, false >
C SeqOverlappingSchwarzAssemblerHelper< ILUNSubdomainSolver< M, X, Y >, false >
C SeqOverlappingSchwarzAssemblerHelper< S< BCRSMatrix< T, A > >, true >
C SeqOverlappingSchwarzAssemblerILUBase
C SeqOverlappingSchwarzDomainSize
C SeqOverlappingSchwarzDomainSize< BCRSMatrix< T, 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 SolverFactory Factory to assembly solvers configured by a ParameterTree
► 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 SPQRCreator
C isValidBlock
C isValidBlock< FieldVector< double, 1 > >
C StoresColumnCompressed
C StoresColumnCompressed< LDL< BCRSMatrix< FieldMatrix< T, n, m >, A > > >
C StoresColumnCompressed< SPQR< BCRSMatrix< T, A > > >
C StoresColumnCompressed< SuperLU< BCRSMatrix< T, A > > >
C StoresColumnCompressed< UMFPack< BCRSMatrix< T, A > > >
C SuperLU SuperLu Solver
► C SuperLUCreator
C isValidBlock
C isValidBlock< double >
C isValidBlock< Dune::FieldVector< double, k > >
C isValidBlock< Dune::FieldVector< std::complex< double >, k > >
C isValidBlock< std::complex< double > >
C SuperLUDenseMatChooser
C SuperLUMatrix Utility class for converting an ISTL Matrix into a SuperLU Matrix
C SuperLUMatrix< BCRSMatrix< B, TA > > Converter for BCRSMatrix to SuperLU Matrix
C SuperLUQueryChooser
C SuperLUSolveChooser
C SuperMatrixCreateSparseChooser
C SuperMatrixInitializer
C SuperMatrixInitializer< BCRSMatrix< B, A > >
C SuperMatrixPrinter
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 The UMFPack direct sparse solver
► C UMFPackCreator
C isValidBlock
C isValidBlock< B, std::enable_if_t< std::is_same< typename FieldTraits< B >::real_type, double >::value > >
C UMFPackMethodChooser
C UMFPackMethodChooser< double, std::false_type >
C UMFPackMethodChooser< double, std::true_type >
C UMFPackMethodChooser< std::complex< double >, std::false_type >
C UMFPackMethodChooser< std::complex< double >, std::true_type >
C UnsupportedType
► 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
► N std STL namespace
C tuple_element< i, Dune::MultiTypeBlockMatrix< Args... > > Make std::tuple_element work for MultiTypeBlockMatrix
C tuple_element< i, Dune::MultiTypeBlockVector< Args... > > Make std::tuple_element work for MultiTypeBlockVector