CDune::AdderSelector< T, X, S > | Template meta program for choosing how to add the correction |
CDune::AdderSelector< AdditiveSchwarzMode, X, S > | |
CDune::AdderSelector< MultiplicativeSchwarzMode, X, S > | |
CDune::AdderSelector< SymmetricMultiplicativeSchwarzMode, X, S > | |
CDune::OwnerOverlapCopyCommunication< GlobalIdType, LocalIdType >::AddGatherScatter< T > | |
CDune::AdditiveAdder< S, T > | |
CDune::AdditiveAdder< S, BlockVector< T, A > > | |
CDune::AdditiveSchwarzMode | Tag that the tells the Schwarz method to be additive |
CDune::Amg::Aggregate< G, S > | A class for temporarily storing the vertices of an aggregate in |
CDune::Amg::Aggregate< MatrixGraph, VertexSet > | |
CDune::Amg::AggregateRenumberer< G > | |
CDune::Amg::AggregatesGatherScatter< T, TI > | |
CDune::Amg::AggregatesMap< V > | Class providing information about the mapping of the vertices onto aggregates |
CDune::Amg::AggregatesMap< Vertex > | |
CDune::Amg::AggregatesPublisher< T, O, I > | |
CDune::Amg::AggregatesPublisher< T, O, OwnerOverlapCopyCommunication< T1, T2 > > | Utility class for publishing the aggregate number of the DOFs in the overlap to other processors and convert them to local indices |
CDune::Amg::AggregatesPublisher< T, O, SequentialInformation > | |
CDune::Amg::Aggregator< G > | Class for building the aggregates |
CDune::algmeta_bdsolve< I, relax > | |
CDune::algmeta_bdsolve< 0, norelax > | |
CDune::algmeta_bdsolve< 0, withrelax > | |
CDune::algmeta_btsolve< I, diag, relax > | |
CDune::algmeta_btsolve< 0, nodiag, norelax > | |
CDune::algmeta_btsolve< 0, nodiag, withrelax > | |
CDune::algmeta_btsolve< 0, withdiag, norelax > | |
CDune::algmeta_btsolve< 0, withdiag, withrelax > | |
CDune::algmeta_itsteps< I, M > | |
CDune::algmeta_itsteps< 0, M > | |
CDune::algmeta_itsteps< I, MultiTypeBlockMatrix< T1, MultiTypeMatrixArgs... > > | |
CDune::Amg::AlwaysOneNorm | |
CDune::AMGCreator | |
CDune::Amg::ApplyHelper< i > | |
CDune::Amg::ApplyHelper< 0 > | |
CDune::ArPackPlusPlus_Algorithms< BCRSMatrix, BlockVector > | Wrapper to use a range of ARPACK++ eigenvalue solvers |
►CDune::Imp::base_array_unmanaged< B, std::allocator< B > > | |
►CDune::Imp::block_vector_unmanaged< B, std::allocator< B > > | |
CDune::BlockVector< B, A > | A vector of blocks with memory management |
CDune::MatrixImp::DenseMatrixBase< B, A > | A Vector of blocks with different blocksizes |
CDune::VariableBlockVector< B, A > | A Vector of blocks with different blocksizes |
►CDune::Imp::base_array_unmanaged< T, A > | |
►CDune::Imp::block_vector_unmanaged< T, A > | |
CDune::BlockVector< T, A > | |
►CDune::Imp::base_array_unmanaged< T, std::allocator< T > > | |
►CDune::Imp::block_vector_unmanaged< T, std::allocator< T > > | |
CDune::MatrixImp::DenseMatrixBase< T, std::allocator< T > > | |
►CDune::Amg::BaseConnectivityConstructor | |
CDune::Amg::ConnectivityConstructor< G, T > | |
CDune::Amg::ConnectivityConstructor< G, SequentialInformation > | |
►CDune::Amg::BaseGalerkinProduct | |
CDune::Amg::GalerkinProduct< T > | |
CDune::Amg::GalerkinProduct< SequentialInformation > | |
CDune::BaseGetSuperLUType< T > | |
►CDune::BaseGetSuperLUType< double > | |
CDune::GetSuperLUType< double > | |
►CDune::BaseGetSuperLUType< float > | |
CDune::GetSuperLUType< float > | |
►CDune::BaseGetSuperLUType< std::complex< double > > | |
CDune::GetSuperLUType< std::complex< double > > | |
►CDune::BaseGetSuperLUType< std::complex< float > > | |
CDune::GetSuperLUType< std::complex< float > > | |
►CDune::ISTL::Impl::BCCSMatrix< BCRSMatrix< B, TA >::field_type, int > | |
CDune::SuperLUMatrix< BCRSMatrix< B, TA > > | Converter for BCRSMatrix to SuperLU Matrix |
►CDune::ISTL::Impl::BCCSMatrixInitializer< BCRSMatrix< B, A >, int > | |
CDune::SuperMatrixInitializer< BCRSMatrix< B, A > > | |
CDune::BCRSMatrix< B, A > | A sparse block matrix with compressed row storage |
►CDune::BCRSMatrix< B, std::allocator< B > > | |
CDune::BDMatrix< B, A > | A block-diagonal matrix |
CDune::BTDMatrix< B, A > | A block-tridiagonal matrix |
►CBidirectionalIteratorFacade | |
CDune::Amg::Hierarchy< T, A >::LevelIterator< C, T1 > | Iterator over the levels in the hierarchy |
CDune::BL< l > | Compile-time parameter for block recursion depth |
CDune::Amg::MatrixHierarchy< M, PI, A >::MatrixStats< Matrix, true >::calc | |
CDune::CheckIfDiagonalPresent< Matrix, blocklevel, l > | Check whether the a matrix has diagonal values on blocklevel recursion levels |
CDune::CheckIfDiagonalPresent< Matrix, 0, l > | |
CDune::CheckIfDiagonalPresent< MultiTypeBlockMatrix< T1, Args... >, blocklevel, l > | |
CDune::CommMatrixRow< M, I > | Utility class for comunicating the matrix entries |
CDune::CommMatrixRowSize< M, RI > | Utility class to communicate and set the row sizes of a redistributed matrix |
CDune::CommMatrixSparsityPattern< M, I > | Utility class to communicate and build the sparsity pattern of a redistributed matrix |
CDune::CommPolicy< Amg::GlobalAggregatesMap< T, TI > > | |
CDune::CommPolicy< CommMatrixRow< M, I > > | |
CDune::CommPolicy< CommMatrixSparsityPattern< M, I > > | |
CDune::CompressionStatistics< size_type > | Statistics about compression achieved in implicit mode |
CDune::Amg::BaseConnectivityConstructor::ConnectedBuilder< G, S, V > | Visitor for identifying connected aggregates during a breadthFirstSearch |
CDune::MatrixImp::DenseMatrixBase< B, A >::ConstIterator | ConstIterator class for sequential access |
CDune::Amg::ConstructionTraits< T > | Traits class for generically constructing non default constructable types |
CDune::Amg::ConstructionTraits< BlockPreconditioner< X, Y, C, T > > | |
CDune::Amg::ConstructionTraits< BlockVector< T, A > > | |
CDune::Amg::ConstructionTraits< MatrixAdapter< M, X, Y > > | |
CDune::Amg::ConstructionTraits< NonoverlappingBlockPreconditioner< C, T > > | |
CDune::Amg::ConstructionTraits< NonoverlappingSchwarzOperator< M, X, Y, C > > | |
CDune::Amg::ConstructionTraits< OverlappingSchwarzOperator< M, X, Y, C > > | |
CDune::Amg::ConstructionTraits< OwnerOverlapCopyCommunication< T1, T2 > > | |
CDune::Amg::ConstructionTraits< ParSSOR< M, X, Y, C > > | Policy for the construction of the ParSSOR smoother |
CDune::Amg::ConstructionTraits< Richardson< X, Y > > | Policy for the construction of the Richardson smoother |
CDune::Amg::ConstructionTraits< SeqILU< M, X, Y > > | Policy for the construction of the SeqILU smoother |
CDune::Amg::ConstructionTraits< SeqJac< M, X, Y, l > > | Policy for the construction of the SeqJac smoother |
CDune::Amg::ConstructionTraits< SeqOverlappingSchwarz< M, X, TM, TS, TA > > | |
CDune::Amg::ConstructionTraits< SeqSOR< M, X, Y, l > > | Policy for the construction of the SeqSOR smoother |
CDune::Amg::ConstructionTraits< SeqSSOR< M, X, Y, l > > | Policy for the construction of the SeqSSOR smoother |
CDune::Amg::ConstructionTraits< SequentialInformation > | |
CDune::OwnerOverlapCopyCommunication< GlobalIdType, LocalIdType >::CopyGatherScatter< T > | Gather/scatter callback for communcation |
CDune::BCRSMatrix< B, A >::CreateIterator | Iterator class for sequential creation of blocks |
CDune::VariableBlockVector< B, A >::CreateIterator | Iterator class for sequential creation of blocks |
CDune::ILU::CRS< B, Alloc > | Simple compressed row storage matrix class |
CDune::ILU::CRS< block_type, typename M::allocator_type > | |
►CDune::DefaultAllocatorTraits< T, typename > | |
CDune::AllocatorTraits< T > | |
CDune::DefaultAllocatorTraits< T, std::void_t< typename T::allocator_type > > | |
►CDune::Amg::DefaultConstructionArgs< T > | Construction Arguments for the default smoothers |
►CDune::Amg::ConstructionArgs< T > | |
CDune::Amg::DefaultParallelConstructionArgs< T, C > | |
CDune::Amg::DefaultConstructionArgs< Richardson< X, Y > > | |
►CDune::Amg::DefaultConstructionArgs< SeqILU< M, X, Y > > | |
CDune::Amg::ConstructionArgs< SeqILU< M, X, Y > > | |
►CDune::Amg::DefaultConstructionArgs< SeqOverlappingSchwarz< M, X, TM, TS, TA > > | |
CDune::Amg::ConstructionArgs< SeqOverlappingSchwarz< M, X, TM, TS, TA > > | |
►CDune::Amg::DefaultSmootherArgs< T > | The default class for the smoother arguments |
CDune::Amg::SeqOverlappingSchwarzSmootherArgs< T > | |
CDune::DefaultSVGMatrixOptions | Default options class to write SVG matrices |
CDune::DenseMatrixAssigner< DenseMatrix, ScaledIdentityMatrix< field, N > > | |
►CDune::Amg::DependencyParameters | Parameters needed to check whether a node depends on another |
►CDune::Amg::AggregationParameters | Parameters needed for the aggregation process |
►CDune::Amg::CoarseningParameters | Parameters for the complete coarsening process |
►CDune::Amg::Parameters | All parameters for AMG |
►CDune::Amg::Dependency< M, Norm > | |
►CDune::Amg::AggregationCriterion< Dependency< M, Norm > > | |
CDune::Amg::UnSymmetricCriterion< M, Norm > | Criterion suitable for unsymmetric matrices |
►CDune::Amg::SymmetricDependency< M, Norm > | |
►CDune::Amg::AggregationCriterion< SymmetricDependency< M, Norm > > | |
CDune::Amg::SymmetricCriterion< M, Norm > | Criterion taking advantage of symmetric matrices |
CDune::Amg::Dependency< M, N > | Dependency policy for symmetric matrices |
CDune::Amg::SymmetricDependency< M, N > | Dependency policy for symmetric matrices |
CDune::Amg::SymmetricMatrixDependency< M, N > | Dependency policy for symmetric matrices |
CDune::Amg::Diagonal< N > | Norm that uses only the [N][N] entry of the block to determine couplings |
►CDune::Amg::Diagonal< 0 > | |
CDune::Amg::FirstDiagonal | Norm that uses only the [0][0] entry of the block to determine couplings |
CDune::Amg::DirectSolverSelector< Matrix, Vector > | |
CDune::Amg::DirichletBoundarySetter< T > | |
CDune::Amg::DirichletBoundarySetter< SequentialInformation > | |
CDune::Amg::AggregatesMap< V >::DummyEdgeVisitor | A Dummy visitor that does nothing for each visited edge |
CDune::DynamicMatrixSubdomainSolver< M, X, Y > | Exact subdomain solver using Dune::DynamicMatrix<T>::solve |
CDune::DynamicMatrixSubdomainSolver< BCRSMatrix< K, Al >, X, Y > | |
CDune::Amg::SubGraph< G, T >::EdgeIndexMap | An index map for mapping the edges to indices |
CDune::Amg::MatrixGraph< M >::EdgeIteratorT< C > | Iterator over all edges starting from a vertex |
CDune::Amg::EdgeProperties | Class representing the properties of an ede in the matrix graph |
►CDune::Exception | |
CDune::MatrixMarketFormatError | |
CDune::exists< T > | |
►Cstd::false_type | |
CDune::AMGCreator::isValidBlockType< class > | |
CDune::LDLCreator::isValidBlock< F > | |
CDune::MatrixMarketImpl::is_complex< T > | |
CDune::SPQRCreator::isValidBlock< class > | |
CDune::SuperLUCreator::isValidBlock< class > | |
CDune::UMFPackCreator::isValidBlock< F, class > | |
CDune::FieldMatrix< K, n, m > | |
CDune::FieldTraits< BCRSMatrix< B, A > > | |
CDune::FieldTraits< BDMatrix< B, A > > | |
CDune::FieldTraits< BlockVector< B, A > > | |
CDune::FieldTraits< BTDMatrix< B, A > > | |
CDune::FieldTraits< Matrix< T, A > > | |
CDune::FieldTraits< MultiTypeBlockVector< Args... > > | |
CDune::FieldTraits< ScaledIdentityMatrix< K, n > > | |
►CDune::FMatrixError | |
CDune::MatrixBlockError | Error when performing an operation on a matrix block |
►CForwardIteratorFacade | |
CDune::Amg::SubGraph< G, T >::VertexIterator | The vertex iterator of the graph |
CDune::Amg::FrobeniusNorm | |
CDune::Amg::GaussSeidelPostsmoothDefect< level > | |
CDune::Amg::GaussSeidelPresmoothDefect< level > | |
CDune::GetSuperLUType< T > | |
CDune::Amg::GlobalAggregatesMap< T, TI > | |
CDune::Amg::GraphEdgePropertiesSelector< G > | Wrapper to access the internal vertex properties of a graph via operator[]() |
CDune::Amg::GraphVertexPropertiesSelector< G > | Wrapper to access the internal edge properties of a graph via operator[]() |
CDune::Amg::Hierarchy< T, A > | A hierarchy of containers (e.g. matrices or vectors) |
CDune::Amg::Hierarchy< Domain, A > | |
CDune::Amg::Hierarchy< Domain, std::allocator< X > > | |
CDune::Amg::Hierarchy< MatrixOperator, Allocator > | |
CDune::Amg::Hierarchy< ParallelInformation, Allocator > | |
CDune::Amg::Hierarchy< Range, A > | |
CDune::Amg::Hierarchy< Range, std::allocator< X > > | |
CDune::Amg::Hierarchy< Smoother, A > | |
CDune::Amg::Hierarchy< Smoother, std::allocator< X > > | |
►CDune::ILUSubdomainSolver< M, X, Y > | Base class encapsulating common algorithms of ILU0SubdomainSolver and ILUNSubdomainSolver |
CDune::ILU0SubdomainSolver< M, X, Y > | Exact subdomain solver using ILU(p) with appropriate p |
CDune::ILUNSubdomainSolver< M, X, Y > | |
CDune::SolverHelper< ISTLLinearSolver, BCRSMatrix >::Implementation< is_direct_solver, Dummy > | Implementation that works together with iterative ISTL solvers, e.g. Dune::CGSolver or Dune::BiCGSTABSolver |
CDune::SolverHelper< ISTLLinearSolver, BCRSMatrix >::Implementation< true, Dummy > | Implementation that works together with direct ISTL solvers, e.g. Dune::SuperLU or Dune::UMFPack |
CDune::ImplicitMatrixBuilder< M_ > | A wrapper for uniform access to the BCRSMatrix during and after the build stage in implicit build mode |
CDune::IndexInfoFromGrid< G, L > | Information about the index distribution |
CDune::Amg::IndicesCoarsener< T, E > | |
CDune::Amg::IndicesCoarsener< SequentialInformation, E > | Coarsen Indices in the sequential case |
►CInterface | |
CDune::RedistributeInterface | |
►CInvalidStateException | |
CDune::InvalidSolverCategory | |
CDune::InvalidSolverFactoryConfiguration | |
►CDune::InverseOperator< X, Y > | Abstract base class for all solvers |
CDune::IterativeSolver< X, Y > | Base class for all implementations of iterative solvers |
►CDune::InverseOperator< BlockVector< FieldVector< T, m >, std::allocator_traits< A >::template rebind_alloc< FieldVector< T, m > > >, BlockVector< FieldVector< T, n >, std::allocator_traits< A >::template rebind_alloc< FieldVector< T, n > > > > | |
CDune::LDL< BCRSMatrix< FieldMatrix< T, n, m >, A > > | The LDL direct sparse solver for matrices of type BCRSMatrix |
CDune::SPQR< BCRSMatrix< FieldMatrix< T, n, m >, A > > | The SPQR direct sparse solver for matrices of type BCRSMatrix |
CDune::InverseOperator< Domain, Range > | |
►CDune::InverseOperator< Impl::SuperLUVectorChooser< M >::domain_type, Impl::SuperLUVectorChooser< M >::range_type > | |
CDune::SuperLU< M > | SuperLu Solver |
►CDune::InverseOperator< Impl::UMFPackVectorChooser< M >::domain_type, Impl::UMFPackVectorChooser< M >::range_type > | |
CDune::UMFPack< M > | The UMFPack direct sparse solver |
►CDune::InverseOperator< X, X > | |
►CDune::IterativeSolver< X, X > | |
►CDune::RestartedGMResSolver< X, X > | |
CDune::RestartedFlexibleGMResSolver< X, Y, F > | Implements the Flexible Generalized Minimal Residual (FGMRes) method (right preconditioned) |
CDune::BiCGSTABSolver< X > | Bi-conjugate Gradient Stabilized (BiCG-STAB) |
CDune::CGSolver< X > | Conjugate gradient method |
CDune::GeneralizedPCGSolver< X > | Generalized preconditioned conjugate gradient solver |
CDune::GradientSolver< X > | Gradient method |
CDune::LoopSolver< X > | Preconditioned loop solver |
CDune::MINRESSolver< X > | Minimal Residual Method (MINRES) |
►CDune::RestartedFCGSolver< X > | Accelerated flexible conjugate gradient method |
CDune::CompleteFCGSolver< X > | Complete flexible conjugate gradient method |
CDune::RestartedGMResSolver< X, Y, F > | Implements the Generalized Minimal Residual (GMRes) method |
CDune::InverseOperatorResult | Statistics about the application of an inverse operator |
CDune::IsDirectSolver< Solver > | |
CDune::IsDirectSolver< LDL< BCRSMatrix< FieldMatrix< T, n, m >, A > > > | |
CDune::IsDirectSolver< SPQR< BCRSMatrix< T, A > > > | |
CDune::IsDirectSolver< SuperLU< BCRSMatrix< T, A > > > | |
CDune::IsDirectSolver< UMFPack< BCRSMatrix< FieldMatrix< T, n, m >, A > > > | |
CDune::IsMatrix< T > | Test whether a type is an ISTL Matrix |
CDune::IsMatrix< BCRSMatrix< T, A > > | |
CDune::IsMatrix< DenseMatrix< T > > | |
CDune::IterativeSolver< X, Y >::Iteration< CountType > | Class for controlling iterative methods |
CDune::MatrixImp::DenseMatrixBase< B, A >::Iterator | Iterator class for sequential access |
CDune::IteratorDirectionSelector< T1, T2, forward > | Helper template meta program for application of overlapping Schwarz |
CDune::IteratorDirectionSelector< T1, T2, false > | |
CDune::LDL< Matrix > | Use the LDL package to directly solve linear systems – empty default class |
CDune::LDLCreator | |
CDune::Amg::LevelTransferPolicy< FO, CO > | Abstract base class for transfer between levels and creation of the coarse level system |
CDune::Amg::LevelTransferPolicy< FO, typename CSP::Operator > | |
►CDune::Amg::LevelTransferPolicy< O, O > | |
CDune::Amg::AggregationLevelTransferPolicy< O, C > | A LeveTransferPolicy that used aggregation to construct the coarse level system |
►CDune::LinearOperator< X, Y > | A linear operator |
►CDune::AssembledLinearOperator< M, X, Y > | A linear operator exporting itself in matrix form |
CDune::MatrixAdapter< M, X, Y > | Adapter to turn a matrix into a linear operator |
CDune::NonoverlappingSchwarzOperator< M, X, Y, C > | A nonoverlapping operator with communication object |
CDune::OverlappingSchwarzOperator< M, X, Y, C > | An overlapping Schwarz operator |
CDune::LinearOperator< OP1::domain_type, OP1::range_type > | |
CDune::LinearOperator< X, X > | |
►CDune::MathError | |
►CDune::ISTLError | Derive error class from the base class in common |
►CDune::BCRSMatrixError | Error specific to BCRSMatrix |
CDune::ImplicitModeCompressionBufferExhausted | Thrown when the compression buffer used by the implicit BCRSMatrix construction is exhausted |
CDune::SolverAbort | Thrown when a solver aborts due to some problem |
CDune::MatMultMatResult< M1, M2 > | Helper TMP to get the result type of a sparse matrix matrix multiplication ( ) |
CDune::MatMultMatResult< BCRSMatrix< FieldMatrix< T, n, k >, A >, BCRSMatrix< FieldMatrix< T, k, m >, A1 > > | |
CDune::MatMultMatResult< FieldMatrix< T, n, k >, FieldMatrix< T, k, m > > | |
CDune::Matrix< T, A > | A generic dynamic dense matrix |
CDune::Amg::MatrixAdapterArgs< M, X, Y > | |
CDune::MatrixCopyRowSizeGatherScatter< M, I, RI > | |
CDune::MatrixDimension< M > | |
CDune::MatrixDimension< BCRSMatrix< B, TA > > | |
CDune::MatrixDimension< BCRSMatrix< FieldMatrix< B, n, m >, TA > > | |
CDune::MatrixDimension< DiagonalMatrix< K, n > > | |
CDune::MatrixDimension< Dune::DynamicMatrix< T > > | |
CDune::MatrixDimension< FieldMatrix< K, n, m > > | |
CDune::MatrixDimension< Matrix< B, TA > > | |
CDune::MatrixDimension< Matrix< FieldMatrix< K, n, m >, TA > > | |
CDune::MatrixDimension< ScaledIdentityMatrix< K, n > > | |
CDune::Amg::MatrixGraph< M > | The (undirected) graph of a matrix |
CDune::Amg::MatrixGraph< const M > | |
CDune::Amg::MatrixHierarchy< M, PI, A > | The hierarchies build by the coarsening process |
CDune::MatrixIndexSet | Stores the nonzero entries in a sparse matrix |
CDune::MatrixRowGatherScatter< M, I > | |
CDune::MatrixRowSizeGatherScatter< M, I, RI > | |
CDune::MatrixSparsityPatternGatherScatter< M, I > | |
CDune::MatrixMarketImpl::MatrixValuesSetter< D, brows, bcols > | Functor to the data values of the matrix |
CDune::MatrixMarketImpl::MatrixValuesSetter< PatternDummy, brows, bcols > | |
CDune::MatrixMarketImpl::mm_block_structure_header< M > | Metaprogram for writing the ISTL block structure header |
CDune::MatrixMarketImpl::mm_block_structure_header< BCRSMatrix< FieldMatrix< T, i, j >, A > > | |
CDune::MatrixMarketImpl::mm_block_structure_header< BCRSMatrix< T, A > > | |
CDune::MatrixMarketImpl::mm_block_structure_header< BlockVector< FieldVector< T, i >, A > > | |
CDune::MatrixMarketImpl::mm_block_structure_header< BlockVector< T, A > > | |
CDune::MatrixMarketImpl::mm_block_structure_header< FieldMatrix< T, i, j > > | |
CDune::MatrixMarketImpl::mm_block_structure_header< FieldVector< T, i > > | |
CDune::MatrixMarketImpl::mm_header_printer< M > | Meta program to write the correct Matrix Market header |
CDune::MatrixMarketImpl::mm_header_printer< BCRSMatrix< T, A > > | |
CDune::MatrixMarketImpl::mm_header_printer< BlockVector< B, A > > | |
CDune::MatrixMarketImpl::mm_header_printer< FieldMatrix< T, i, j > > | |
CDune::MatrixMarketImpl::mm_header_printer< FieldVector< T, j > > | |
CDune::MatrixMarketImpl::mm_multipliers< M > | |
CDune::MatrixMarketImpl::mm_multipliers< BCRSMatrix< B, A > > | |
CDune::MatrixMarketImpl::mm_multipliers< BCRSMatrix< FieldMatrix< B, i, j >, A > > | |
CDune::MatrixMarketImpl::mm_numeric_type< T > | Helper metaprogram to get the matrix market string representation of the numeric type |
CDune::MatrixMarketImpl::mm_numeric_type< double > | |
CDune::MatrixMarketImpl::mm_numeric_type< float > | |
CDune::MatrixMarketImpl::mm_numeric_type< int > | |
CDune::MatrixMarketImpl::mm_numeric_type< std::complex< double > > | |
CDune::MatrixMarketImpl::mm_numeric_type< std::complex< float > > | |
CDune::MatrixMarketImpl::MMHeader | |
CDune::MultiplicativeAdder< S, T > | |
CDune::MultiplicativeAdder< S, BlockVector< T, A > > | |
CDune::MultiplicativeSchwarzMode | Tag that tells the Schwarz method to be multiplicative |
CDune::MultiTypeBlockMatrix_Solver< I, crow, remain_row > | Solver for MultiTypeBlockVector & MultiTypeBlockMatrix types |
CDune::MultiTypeBlockMatrix_Solver< I, crow, 0 > | |
CDune::MultiTypeBlockMatrix_Solver_Col< I, crow, ccol, remain_col > | Part of solvers for MultiTypeBlockVector & MultiTypeBlockMatrix types |
CDune::MultiTypeBlockMatrix_Solver_Col< I, crow, ccol, 0 > | |
►CNotImplemented | |
CDune::UnsupportedType | |
CDune::MatrixMarketImpl::NumericWrapper< T > | Wrapper class of numeric values |
CDune::MatrixMarketImpl::NumericWrapper< PatternDummy > | |
CDune::Amg::OneStepAMGCoarseSolverPolicy< O, S, C > | A policy class for solving the coarse level system using one step of AMG |
CDune::OverlappingAssignerHelper< T, tag > | |
CDune::OverlappingAssignerHelper< DynamicMatrixSubdomainSolver< BCRSMatrix< K, Al >, X, Y >, false > | |
CDune::OverlappingAssignerHelper< S > | |
CDune::OverlappingAssignerHelper< S< BCRSMatrix< T, A > >, true > | |
►CDune::OverlappingAssignerILUBase< M, X, Y > | |
CDune::OverlappingAssignerHelper< ILU0SubdomainSolver< M, X, Y >, false > | |
CDune::OverlappingAssignerHelper< ILUNSubdomainSolver< M, X, Y >, false > | |
CDune::OverlappingSchwarzInitializer< I, S, D > | Initializer for SuperLU Matrices representing the subdomains |
CDune::Amg::OverlapVertex< T > | |
CDune::OwnerOverlapCopyAttributeSet | Attribute set for overlapping Schwarz |
CDune::OwnerOverlapCopyCommunication< GlobalIdType, LocalIdType > | A class setting up standard communication for a two-valued attribute set with owner/overlap/copy semantics |
CDune::Amg::OwnerOverlapCopyCommunicationArgs | |
CDune::Amg::ParallelIndicesCoarsener< T, E > | |
►CDune::Amg::ParallelIndicesCoarsener< OwnerOverlapCopyCommunication< G, L >, E > | |
CDune::Amg::IndicesCoarsener< OwnerOverlapCopyCommunication< G, L >, E > | Coarsen Indices in the parallel case |
CDune::Amg::ParallelOperatorArgs< M, C > | |
CDune::MatrixMarketImpl::PatternDummy | Utility class for marking the pattern type of the MatrixMarket matrices |
CDune::PointerCompare< T > | |
CDune::PowerIteration_Algorithms< BCRSMatrix, BlockVector > | Iterative eigenvalue algorithms based on power iteration |
►CDune::Preconditioner< X, Y > | Base class for matrix free definition of preconditioners |
CDune::BlockPreconditioner< X, Y, C, P > | Block parallel preconditioner |
CDune::ParSSOR< M, X, Y, C > | A parallel SSOR preconditioner |
CDune::Richardson< X, Y > | Richardson preconditioner |
CDune::SeqILDL< M, X, Y > | Sequential ILDL preconditioner |
CDune::SeqILU< M, X, Y, l > | Sequential ILU preconditioner |
CDune::SeqJac< M, X, Y, l > | The sequential jacobian preconditioner |
CDune::SeqSOR< M, X, Y, l > | Sequential SOR preconditioner |
CDune::SeqSSOR< M, X, Y, l > | Sequential SSOR preconditioner |
►CDune::Preconditioner< AMG::Domain, AMG::Range > | |
CDune::Amg::KAmgTwoGrid< Dune::Amg::AMG > | |
CDune::Amg::KAmgTwoGrid< AMG > | Two grid operator for AMG with Krylov cycle |
►CDune::Preconditioner< FO::domain_type, FO::range_type > | |
CDune::Amg::TwoLevelMethod< FO, CSP, S > | |
►CDune::Preconditioner< O::domain_type, O::range_type > | |
CDune::InverseOperator2Preconditioner< O, c > | Turns an InverseOperator into a Preconditioner |
►CDune::Preconditioner< P::domain_type, P::range_type > | |
CDune::NonoverlappingBlockPreconditioner< C, P > | Nonoverlapping parallel preconditioner |
►CDune::Preconditioner< X, X > | |
CDune::Amg::AMG< M, X, S, SequentialInformation, std::allocator< X > > | |
CDune::Amg::AMG< Operator, X, Smoother > | |
CDune::SeqOverlappingSchwarz< M, X, TM, TS, TA > | |
CDune::Amg::AMG< M, X, S, PI, A > | Parallel algebraic multigrid based on agglomeration |
CDune::Amg::FastAMG< M, X, PI, A > | A fast (sequential) algebraic multigrid based on agglomeration that saves memory bandwidth |
CDune::Amg::KAMG< M, X, S, PI, K, A > | Algebraic multigrid method using a Krylov-cycle |
CDune::SeqOverlappingSchwarz< M, X, TM, TD, TA > | Sequential overlapping Schwarz preconditioner |
CDune::Amg::PropertiesGraph< G, VP, EP, VM, EM > | Attaches properties to the edges and vertices of a graph |
CDune::Amg::PropertiesGraphCreator< M, PI > | |
CDune::Amg::PropertiesGraphCreator< M, SequentialInformation > | |
CDune::PropertyMapTypeSelector< Amg::VertexVisitedTag, Amg::PropertiesGraph< G, Amg::VertexProperties, EP, VM, EM > > | |
CDune::Amg::GlobalAggregatesMap< T, TI >::Proxy | |
CDune::QuerySpaceChooser< T > | |
►CRandomAccessIteratorFacade | |
CDune::Amg::SubGraph< G, T >::EdgeIterator | The edge iterator of the graph |
CDune::BCRSMatrix< B, A >::RealRowIterator< T > | Iterator access to matrix rows |
CDune::VariableBlockVector< B, A >::RealIterator< T, R > | Iterator class for sequential access |
►CRAPropertyMapHelper | |
CDune::Amg::PropertyGraphVertexPropertyMap< G, i > | |
CDune::Amg::RandomAccessBundledPropertyMap< C, K, i, T, R > | A property map that extracts one property out of a bundle using operator[]() |
CDune::RedistributeInformation< T > | |
CDune::RedistributeInformation< OwnerOverlapCopyCommunication< T, T1 > > | |
CDune::ImplicitMatrixBuilder< M_ >::row_object | Proxy row object for entry access |
CDune::Amg::RowSum | Functor using the row sum (infinity) norm to determine strong couplings |
►CDune::ScalarProduct< X > | Base class for scalar product and norm computation |
►CDune::ParallelScalarProduct< X, C > | Scalar product for overlapping Schwarz methods |
CDune::NonoverlappingSchwarzScalarProduct< X, C > | Nonoverlapping Scalar Product with communication object |
CDune::OverlappingSchwarzScalarProduct< X, C > | Scalar product for overlapping Schwarz methods |
CDune::SeqScalarProduct< X > | Default implementation for the scalar case |
CDune::ScaledIdentityMatrix< K, n > | A multiple of the identity matrix of static size |
CDune::SeqOverlappingSchwarzApplier< T > | Helper template meta program for application of overlapping Schwarz |
CDune::SeqOverlappingSchwarzApplier< SeqOverlappingSchwarz< M, X, SymmetricMultiplicativeSchwarzMode, TD, TA > > | |
CDune::SeqOverlappingSchwarzAssemblerHelper< T, tag > | |
CDune::SeqOverlappingSchwarzAssemblerHelper< DynamicMatrixSubdomainSolver< BCRSMatrix< K, Al >, X, Y >, false > | |
CDune::SeqOverlappingSchwarzAssemblerHelper< S< BCRSMatrix< T, A > >, true > | |
►CDune::SeqOverlappingSchwarzAssemblerILUBase< M, X, Y > | |
CDune::SeqOverlappingSchwarzAssemblerHelper< ILU0SubdomainSolver< M, X, Y >, false > | |
CDune::SeqOverlappingSchwarzAssemblerHelper< ILUNSubdomainSolver< M, X, Y >, false > | |
CDune::SeqOverlappingSchwarzDomainSize< M > | |
CDune::SeqOverlappingSchwarzDomainSize< BCRSMatrix< T, A > > | |
CDune::Amg::SequentialCommunicationArgs | |
CDune::Amg::SequentialInformation | |
CDune::Amg::SmootherApplier< T > | Helper class for applying the smoothers |
CDune::Amg::SmootherApplier< BlockPreconditioner< X, Y, C, SeqSOR< M, X, Y, l > > > | |
CDune::Amg::SmootherApplier< NonoverlappingBlockPreconditioner< C, SeqSOR< M, X, Y, l > > > | |
CDune::Amg::SmootherApplier< SeqOverlappingSchwarz< M, X, MultiplicativeSchwarzMode, MS, TA > > | |
CDune::Amg::SmootherApplier< SeqSOR< M, X, Y, l > > | |
►CDune::Amg::SmootherTraits< T > | Traits class for getting the attribute class of a smoother |
CDune::Amg::SmootherTraits< BlockPreconditioner< X, Y, C, T > > | |
CDune::Amg::SmootherTraits< NonoverlappingBlockPreconditioner< C, T > > | |
CDune::Amg::SmootherTraits< Richardson< X, Y > > | |
CDune::Amg::SmootherTraits< S > | |
CDune::Amg::SmootherTraits< SeqOverlappingSchwarz< M, X, TM, TS, TA > > | |
CDune::Amg::SmootherTraits< Smoother > | |
CDune::Amg::DirectSolverSelector< Matrix, Vector >::Solver< M, SolverType > | |
CDune::Amg::DirectSolverSelector< Matrix, Vector >::Solver< M, superlu > | |
CDune::SolverCategory | Categories for the solvers |
CDune::SolverFactory< Operator > | Factory to assembly solvers configured by a ParameterTree |
CDune::SolverHelper< ISTLLinearSolver, BCRSMatrix > | Helper class for notifying a DUNE-ISTL linear solver about a change of the iteration matrix object in a unified way, i.e. independent from the solver's type (direct/iterative) |
CDune::Amg::SparsityBuilder< M > | Functor for building the sparsity pattern of the matrix using examineConnectivity |
CDune::SPQR< Matrix > | Use the SPQR package to directly solve linear systems – empty default class |
CDune::SPQRCreator | |
CDune::StoresColumnCompressed< Solver > | |
CDune::StoresColumnCompressed< LDL< BCRSMatrix< FieldMatrix< T, n, m >, A > > > | |
CDune::StoresColumnCompressed< SPQR< BCRSMatrix< T, A > > > | |
CDune::StoresColumnCompressed< SuperLU< BCRSMatrix< T, A > > > | |
CDune::StoresColumnCompressed< UMFPack< BCRSMatrix< T, A > > > | |
CDune::Amg::SubGraph< G, T > | A subgraph of a graph |
CDune::Amg::SubGraph< Graph, T > | |
CDune::SuperLUCreator | |
CDune::SuperLUDenseMatChooser< T > | |
CDune::SuperLUMatrix< M > | Utility class for converting an ISTL Matrix into a SuperLU Matrix |
CDune::SuperLUMatrix< Matrix > | |
CDune::SuperLUQueryChooser< T > | |
CDune::SuperLUSolveChooser< T > | |
CDune::SuperMatrixCreateSparseChooser< T > | |
CDune::SuperMatrixInitializer< M > | |
CDune::SuperMatrixPrinter< T > | |
CDune::SymmetricMultiplicativeSchwarzMode | Tag that tells the Schwarz method to be multiplicative and symmetric |
►CT | |
CDune::Amg::AggregationCriterion< T > | Base class of all aggregation criterions |
CDune::Amg::CoarsenCriterion< T > | The criterion describing the stop criteria for the coarsening process |
CDune::Amg::CombinedFunctor< T > | |
CDune::MatrixMarketImpl::IndexData< T > | |
CDune::Amg::Transfer< V1, V2, T > | |
CDune::Amg::Transfer< V, V1, OwnerOverlapCopyCommunication< T1, T2 > > | |
CDune::Amg::Transfer< V, V1, SequentialInformation > | |
CDune::TransposedMatMultMatResult< M1, M2 > | Helper TMP to get the result type of a sparse matrix matrix multiplication ( ) |
CDune::TransposedMatMultMatResult< BCRSMatrix< FieldMatrix< T, k, n >, A >, BCRSMatrix< FieldMatrix< T, k, m >, A1 > > | |
CDune::TransposedMatMultMatResult< FieldMatrix< T, k, n >, FieldMatrix< T, k, m > > | |
►Cstd::true_type | |
CDune::AMGCreator::isValidBlockType< FieldMatrix< T, n, m > > | |
CDune::LDLCreator::isValidBlock< FieldVector< double, k > > | |
CDune::MatrixMarketImpl::is_complex< std::complex< T > > | |
CDune::SPQRCreator::isValidBlock< FieldVector< double, 1 > > | |
CDune::SuperLUCreator::isValidBlock< Dune::FieldVector< double, k > > | |
CDune::SuperLUCreator::isValidBlock< Dune::FieldVector< std::complex< double >, k > > | |
CDune::SuperLUCreator::isValidBlock< double > | |
CDune::SuperLUCreator::isValidBlock< std::complex< double > > | |
CDune::UMFPackCreator::isValidBlock< B, std::enable_if_t< std::is_same< typename FieldTraits< B >::real_type, double >::value > > | |
►Cstd::tuple | |
CDune::MultiTypeBlockMatrix< FirstRow, Args > | A Matrix class to support different block types |
CDune::MultiTypeBlockVector< Args > | A Vector class to support different block types |
Cstd::tuple_element< i, Dune::MultiTypeBlockMatrix< Args... > > | Make std::tuple_element work for MultiTypeBlockMatrix |
Cstd::tuple_element< i, Dune::MultiTypeBlockVector< Args... > > | Make std::tuple_element work for MultiTypeBlockVector |
►Cstd::conditional::type | |
CDune::Amg::PropertiesGraph< G, VP, EP, VM, EM >::EdgeIteratorT< C > | |
►Cstd::conditional::type | |
CDune::Amg::PropertiesGraph< G, VP, EP, VM, EM >::VertexIteratorT< C > | |
CDune::Amg::VertexPropertiesGraph< G, VP, VM >::VertexIteratorT< C > | |
CDune::UMFPackCreator | |
CDune::UMFPackMethodChooser< T > | |
CDune::UMFPackMethodChooser< double > | |
CDune::UMFPackMethodChooser< std::complex< double > > | |
CDune::Amg::MatrixGraph< M >::VertexIteratorT< C > | The vertex iterator type of the graph |
CDune::Amg::VertexProperties | Class representing a node in the matrix graph |
CDune::Amg::VertexPropertiesGraph< G, VP, VM > | Attaches properties to the vertices of a graph |
CDune::Amg::VertexVisitedTag | Tag idnetifying the visited property of a vertex |