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