►NDune | |
►NAmg | |
CAggregate | A class for temporarily storing the vertices of an aggregate in |
CAggregateRenumberer | |
CAggregatesGatherScatter | |
►CAggregatesMap | Class providing information about the mapping of the vertices onto aggregates |
CDummyEdgeVisitor | A Dummy visitor that does nothing for each visited edge |
CAggregatesPublisher | |
CAggregatesPublisher< 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 |
CAggregatesPublisher< T, O, SequentialInformation > | |
CAggregationCriterion | Base class of all aggregation criterions |
CAggregationLevelTransferPolicy | A LeveTransferPolicy that used aggregation to construct the coarse level system |
CAggregationParameters | Parameters needed for the aggregation process |
CAggregator | Class for building the aggregates |
CAlwaysOneNorm | |
CAMG | Parallel algebraic multigrid based on agglomeration |
CApplyHelper | |
CApplyHelper< 0 > | |
►CBaseConnectivityConstructor | |
CConnectedBuilder | Visitor for identifying connected aggregates during a breadthFirstSearch |
CBaseGalerkinProduct | |
CCoarsenCriterion | The criterion describing the stop criteria for the coarsening process |
CCoarseningParameters | Parameters for the complete coarsening process |
CCombinedFunctor | |
CConnectivityConstructor | |
CConnectivityConstructor< G, SequentialInformation > | |
CConstructionArgs | |
CConstructionArgs< SeqILU< M, X, Y > > | |
CConstructionArgs< SeqOverlappingSchwarz< M, X, TM, TS, TA > > | |
CConstructionTraits | Traits class for generically constructing non default constructable types |
CConstructionTraits< BlockPreconditioner< X, Y, C, T > > | |
CConstructionTraits< BlockVector< T, A > > | |
CConstructionTraits< MatrixAdapter< M, X, Y > > | |
CConstructionTraits< NonoverlappingBlockPreconditioner< C, T > > | |
CConstructionTraits< NonoverlappingSchwarzOperator< M, X, Y, C > > | |
CConstructionTraits< OverlappingSchwarzOperator< M, X, Y, C > > | |
CConstructionTraits< OwnerOverlapCopyCommunication< T1, T2 > > | |
CConstructionTraits< ParSSOR< M, X, Y, C > > | Policy for the construction of the ParSSOR smoother |
CConstructionTraits< Richardson< X, Y > > | Policy for the construction of the Richardson smoother |
CConstructionTraits< SeqILU< M, X, Y > > | Policy for the construction of the SeqILU smoother |
CConstructionTraits< SeqJac< M, X, Y, l > > | Policy for the construction of the SeqJac smoother |
CConstructionTraits< SeqOverlappingSchwarz< M, X, TM, TS, TA > > | |
CConstructionTraits< SeqSOR< M, X, Y, l > > | Policy for the construction of the SeqSOR smoother |
CConstructionTraits< SeqSSOR< M, X, Y, l > > | Policy for the construction of the SeqSSOR smoother |
CConstructionTraits< SequentialInformation > | |
CDefaultConstructionArgs | Construction Arguments for the default smoothers |
CDefaultConstructionArgs< Richardson< X, Y > > | |
CDefaultParallelConstructionArgs | |
CDefaultSmootherArgs | The default class for the smoother arguments |
CDependency | Dependency policy for symmetric matrices |
CDependencyParameters | Parameters needed to check whether a node depends on another |
CDiagonal | Norm that uses only the [N][N] entry of the block to determine couplings |
►CDirectSolverSelector | |
CSolver | |
CSolver< M, superlu > | |
CDirichletBoundarySetter | |
CDirichletBoundarySetter< SequentialInformation > | |
CEdgeProperties | Class representing the properties of an ede in the matrix graph |
CFastAMG | A fast (sequential) algebraic multigrid based on agglomeration that saves memory bandwidth |
CFirstDiagonal | Norm that uses only the [0][0] entry of the block to determine couplings |
CFrobeniusNorm | |
CGalerkinProduct | |
CGalerkinProduct< SequentialInformation > | |
CGaussSeidelPostsmoothDefect | |
CGaussSeidelPresmoothDefect | |
►CGlobalAggregatesMap | |
CProxy | |
CGraphEdgePropertiesSelector | Wrapper to access the internal vertex properties of a graph via operator[]() |
CGraphVertexPropertiesSelector | Wrapper to access the internal edge properties of a graph via operator[]() |
►CHierarchy | A hierarchy of containers (e.g. matrices or vectors) |
CLevelIterator | Iterator over the levels in the hierarchy |
CIndicesCoarsener | |
CIndicesCoarsener< OwnerOverlapCopyCommunication< G, L >, E > | Coarsen Indices in the parallel case |
CIndicesCoarsener< SequentialInformation, E > | Coarsen Indices in the sequential case |
CKAMG | Algebraic multigrid method using a Krylov-cycle |
CKAmgTwoGrid | Two grid operator for AMG with Krylov cycle |
CLevelTransferPolicy | Abstract base class for transfer between levels and creation of the coarse level system |
CMatrixAdapterArgs | |
►CMatrixGraph | The (undirected) graph of a matrix |
CEdgeIteratorT | Iterator over all edges starting from a vertex |
CVertexIteratorT | The vertex iterator type of the graph |
CMatrixHierarchy | The hierarchies build by the coarsening process |
COneStepAMGCoarseSolverPolicy | A policy class for solving the coarse level system using one step of AMG |
COverlapVertex | |
COwnerOverlapCopyCommunicationArgs | |
CParallelIndicesCoarsener | |
CParallelOperatorArgs | |
CParameters | All parameters for AMG |
►CPropertiesGraph | Attaches properties to the edges and vertices of a graph |
CEdgeIteratorT | |
CVertexIteratorT | |
CPropertiesGraphCreator | |
CPropertiesGraphCreator< M, SequentialInformation > | |
CPropertyGraphVertexPropertyMap | |
CRandomAccessBundledPropertyMap | A property map that extracts one property out of a bundle using operator[]() |
CRowSum | Functor using the row sum (infinity) norm to determine strong couplings |
CSeqOverlappingSchwarzSmootherArgs | |
CSequentialCommunicationArgs | |
CSequentialInformation | |
CSmootherApplier | Helper class for applying the smoothers |
CSmootherApplier< BlockPreconditioner< X, Y, C, SeqSOR< M, X, Y, l > > > | |
CSmootherApplier< NonoverlappingBlockPreconditioner< C, SeqSOR< M, X, Y, l > > > | |
CSmootherApplier< SeqOverlappingSchwarz< M, X, MultiplicativeSchwarzMode, MS, TA > > | |
CSmootherApplier< SeqSOR< M, X, Y, l > > | |
CSmootherTraits | Traits class for getting the attribute class of a smoother |
CSmootherTraits< BlockPreconditioner< X, Y, C, T > > | |
CSmootherTraits< NonoverlappingBlockPreconditioner< C, T > > | |
CSmootherTraits< Richardson< X, Y > > | |
CSmootherTraits< SeqOverlappingSchwarz< M, X, TM, TS, TA > > | |
CSparsityBuilder | Functor for building the sparsity pattern of the matrix using examineConnectivity |
►CSubGraph | A subgraph of a graph |
CEdgeIndexMap | An index map for mapping the edges to indices |
CEdgeIterator | The edge iterator of the graph |
CVertexIterator | The vertex iterator of the graph |
CSymmetricCriterion | Criterion taking advantage of symmetric matrices |
CSymmetricDependency | Dependency policy for symmetric matrices |
CSymmetricMatrixDependency | Dependency policy for symmetric matrices |
CTransfer | |
CTransfer< V, V1, OwnerOverlapCopyCommunication< T1, T2 > > | |
CTransfer< V, V1, SequentialInformation > | |
CTwoLevelMethod | |
CUnSymmetricCriterion | Criterion suitable for unsymmetric matrices |
CVertexProperties | Class representing a node in the matrix graph |
►CVertexPropertiesGraph | Attaches properties to the vertices of a graph |
CVertexIteratorT | |
CVertexVisitedTag | Tag idnetifying the visited property of a vertex |
►NILU | |
CCRS | Simple compressed row storage matrix class |
►NMatrixImp | |
►CDenseMatrixBase | A Vector of blocks with different blocksizes |
CConstIterator | ConstIterator class for sequential access |
CIterator | Iterator class for sequential access |
►NMatrixMarketImpl | |
CIndexData | |
Cis_complex | |
Cis_complex< std::complex< T > > | |
CMatrixValuesSetter | Functor to the data values of the matrix |
CMatrixValuesSetter< PatternDummy, brows, bcols > | |
Cmm_block_structure_header | Metaprogram for writing the ISTL block structure header |
Cmm_block_structure_header< BCRSMatrix< FieldMatrix< T, i, j >, A > > | |
Cmm_block_structure_header< BCRSMatrix< T, A > > | |
Cmm_block_structure_header< BlockVector< FieldVector< T, i >, A > > | |
Cmm_block_structure_header< BlockVector< T, A > > | |
Cmm_block_structure_header< FieldMatrix< T, i, j > > | |
Cmm_block_structure_header< FieldVector< T, i > > | |
Cmm_header_printer | Meta program to write the correct Matrix Market header |
Cmm_header_printer< BCRSMatrix< T, A > > | |
Cmm_header_printer< BlockVector< B, A > > | |
Cmm_header_printer< FieldMatrix< T, i, j > > | |
Cmm_header_printer< FieldVector< T, j > > | |
Cmm_multipliers | |
Cmm_multipliers< BCRSMatrix< B, A > > | |
Cmm_multipliers< BCRSMatrix< FieldMatrix< B, i, j >, A > > | |
Cmm_numeric_type | Helper metaprogram to get the matrix market string representation of the numeric type |
Cmm_numeric_type< double > | |
Cmm_numeric_type< float > | |
Cmm_numeric_type< int > | |
Cmm_numeric_type< std::complex< double > > | |
Cmm_numeric_type< std::complex< float > > | |
CMMHeader | |
CNumericWrapper | Wrapper class of numeric values |
CNumericWrapper< PatternDummy > | |
CPatternDummy | Utility class for marking the pattern type of the MatrixMarket matrices |
CAdderSelector | Template meta program for choosing how to add the correction |
CAdderSelector< AdditiveSchwarzMode, X, S > | |
CAdderSelector< MultiplicativeSchwarzMode, X, S > | |
CAdderSelector< SymmetricMultiplicativeSchwarzMode, X, S > | |
CAdditiveAdder | |
CAdditiveAdder< S, BlockVector< T, A > > | |
CAdditiveSchwarzMode | Tag that the tells the Schwarz method to be additive |
Calgmeta_bdsolve | |
Calgmeta_bdsolve< 0, norelax > | |
Calgmeta_bdsolve< 0, withrelax > | |
Calgmeta_btsolve | |
Calgmeta_btsolve< 0, nodiag, norelax > | |
Calgmeta_btsolve< 0, nodiag, withrelax > | |
Calgmeta_btsolve< 0, withdiag, norelax > | |
Calgmeta_btsolve< 0, withdiag, withrelax > | |
Calgmeta_itsteps | |
Calgmeta_itsteps< 0, M > | |
Calgmeta_itsteps< I, MultiTypeBlockMatrix< T1, MultiTypeMatrixArgs... > > | |
CAllocatorTraits | |
►CAMGCreator | |
CisValidBlockType | |
CisValidBlockType< FieldMatrix< T, n, m > > | |
CArPackPlusPlus_Algorithms | Wrapper to use a range of ARPACK++ eigenvalue solvers |
CAssembledLinearOperator | A linear operator exporting itself in matrix form |
CBaseGetSuperLUType | |
►CBCRSMatrix | A sparse block matrix with compressed row storage |
CCreateIterator | Iterator class for sequential creation of blocks |
CRealRowIterator | Iterator access to matrix rows |
CBCRSMatrixError | Error specific to BCRSMatrix |
CBDMatrix | A block-diagonal matrix |
CBiCGSTABSolver | Bi-conjugate Gradient Stabilized (BiCG-STAB) |
CBL | Compile-time parameter for block recursion depth |
CBlockPreconditioner | Block parallel preconditioner |
CBlockVector | A vector of blocks with memory management |
CBTDMatrix | A block-tridiagonal matrix |
CCGSolver | Conjugate gradient method |
CCheckIfDiagonalPresent | Check whether the a matrix has diagonal values on blocklevel recursion levels |
CCheckIfDiagonalPresent< Matrix, 0, l > | |
CCheckIfDiagonalPresent< MultiTypeBlockMatrix< T1, Args... >, blocklevel, l > | |
CCommMatrixRow | Utility class for comunicating the matrix entries |
CCommMatrixRowSize | Utility class to communicate and set the row sizes of a redistributed matrix |
CCommMatrixSparsityPattern | Utility class to communicate and build the sparsity pattern of a redistributed matrix |
CCommPolicy< Amg::GlobalAggregatesMap< T, TI > > | |
CCommPolicy< CommMatrixRow< M, I > > | |
CCommPolicy< CommMatrixSparsityPattern< M, I > > | |
CCompleteFCGSolver | Complete flexible conjugate gradient method |
CCompressionStatistics | Statistics about compression achieved in implicit mode |
CDefaultAllocatorTraits | |
CDefaultAllocatorTraits< T, std::void_t< typename T::allocator_type > > | |
CDefaultSVGMatrixOptions | Default options class to write SVG matrices |
CDenseMatrixAssigner< DenseMatrix, ScaledIdentityMatrix< field, N > > | |
CDynamicMatrixSubdomainSolver | Exact subdomain solver using Dune::DynamicMatrix<T>::solve |
CDynamicMatrixSubdomainSolver< BCRSMatrix< K, Al >, X, Y > | |
Cexists | |
CFieldMatrix | |
CFieldTraits< BCRSMatrix< B, A > > | |
CFieldTraits< BDMatrix< B, A > > | |
CFieldTraits< BlockVector< B, A > > | |
CFieldTraits< BTDMatrix< B, A > > | |
CFieldTraits< Matrix< T, A > > | |
CFieldTraits< MultiTypeBlockVector< Args... > > | |
CFieldTraits< ScaledIdentityMatrix< K, n > > | |
CGeneralizedPCGSolver | Generalized preconditioned conjugate gradient solver |
CGetSuperLUType | |
CGetSuperLUType< double > | |
CGetSuperLUType< float > | |
CGetSuperLUType< std::complex< double > > | |
CGetSuperLUType< std::complex< float > > | |
CGradientSolver | Gradient method |
CILU0SubdomainSolver | Exact subdomain solver using ILU(p) with appropriate p |
CILUNSubdomainSolver | |
CILUSubdomainSolver | Base class encapsulating common algorithms of ILU0SubdomainSolver and ILUNSubdomainSolver |
►CImplicitMatrixBuilder | A wrapper for uniform access to the BCRSMatrix during and after the build stage in implicit build mode |
Crow_object | Proxy row object for entry access |
CImplicitModeCompressionBufferExhausted | Thrown when the compression buffer used by the implicit BCRSMatrix construction is exhausted |
CIndexInfoFromGrid | Information about the index distribution |
CInvalidSolverCategory | |
CInvalidSolverFactoryConfiguration | |
CInverseOperator | Abstract base class for all solvers |
CInverseOperator2Preconditioner | Turns an InverseOperator into a Preconditioner |
CInverseOperatorResult | Statistics about the application of an inverse operator |
CIsDirectSolver | |
CIsDirectSolver< LDL< BCRSMatrix< FieldMatrix< T, n, m >, A > > > | |
CIsDirectSolver< SPQR< BCRSMatrix< T, A > > > | |
CIsDirectSolver< SuperLU< BCRSMatrix< T, A > > > | |
CIsDirectSolver< UMFPack< BCRSMatrix< FieldMatrix< T, n, m >, A > > > | |
CIsMatrix | Test whether a type is an ISTL Matrix |
CIsMatrix< BCRSMatrix< T, A > > | |
CIsMatrix< DenseMatrix< T > > | |
CISTLError | Derive error class from the base class in common |
►CIterativeSolver | Base class for all implementations of iterative solvers |
CIteration | Class for controlling iterative methods |
CIteratorDirectionSelector | Helper template meta program for application of overlapping Schwarz |
CIteratorDirectionSelector< T1, T2, false > | |
CLDL | Use the LDL package to directly solve linear systems – empty default class |
CLDL< BCRSMatrix< FieldMatrix< T, n, m >, A > > | The LDL direct sparse solver for matrices of type BCRSMatrix |
►CLDLCreator | |
CisValidBlock | |
CisValidBlock< FieldVector< double, k > > | |
CLinearOperator | A linear operator |
CLoopSolver | Preconditioned loop solver |
CMatMultMatResult | Helper TMP to get the result type of a sparse matrix matrix multiplication ( ) |
CMatMultMatResult< BCRSMatrix< FieldMatrix< T, n, k >, A >, BCRSMatrix< FieldMatrix< T, k, m >, A1 > > | |
CMatMultMatResult< FieldMatrix< T, n, k >, FieldMatrix< T, k, m > > | |
CMatrix | A generic dynamic dense matrix |
CMatrixAdapter | Adapter to turn a matrix into a linear operator |
CMatrixBlockError | Error when performing an operation on a matrix block |
CMatrixCopyRowSizeGatherScatter | |
CMatrixDimension | |
CMatrixDimension< BCRSMatrix< B, TA > > | |
CMatrixDimension< BCRSMatrix< FieldMatrix< B, n, m >, TA > > | |
CMatrixDimension< DiagonalMatrix< K, n > > | |
CMatrixDimension< Dune::DynamicMatrix< T > > | |
CMatrixDimension< FieldMatrix< K, n, m > > | |
CMatrixDimension< Matrix< B, TA > > | |
CMatrixDimension< Matrix< FieldMatrix< K, n, m >, TA > > | |
CMatrixDimension< ScaledIdentityMatrix< K, n > > | |
CMatrixIndexSet | Stores the nonzero entries in a sparse matrix |
CMatrixMarketFormatError | |
CMatrixRowGatherScatter | |
CMatrixRowSizeGatherScatter | |
CMatrixSparsityPatternGatherScatter | |
CMINRESSolver | Minimal Residual Method (MINRES) |
CMultiplicativeAdder | |
CMultiplicativeAdder< S, BlockVector< T, A > > | |
CMultiplicativeSchwarzMode | Tag that tells the Schwarz method to be multiplicative |
CMultiTypeBlockMatrix | A Matrix class to support different block types |
CMultiTypeBlockMatrix_Solver | Solver for MultiTypeBlockVector & MultiTypeBlockMatrix types |
CMultiTypeBlockMatrix_Solver< I, crow, 0 > | |
CMultiTypeBlockMatrix_Solver_Col | Part of solvers for MultiTypeBlockVector & MultiTypeBlockMatrix types |
CMultiTypeBlockMatrix_Solver_Col< I, crow, ccol, 0 > | |
CMultiTypeBlockVector | A Vector class to support different block types |
CNonoverlappingBlockPreconditioner | Nonoverlapping parallel preconditioner |
CNonoverlappingSchwarzOperator | A nonoverlapping operator with communication object |
CNonoverlappingSchwarzScalarProduct | Nonoverlapping Scalar Product with communication object |
COverlappingAssignerHelper | |
COverlappingAssignerHelper< DynamicMatrixSubdomainSolver< BCRSMatrix< K, Al >, X, Y >, false > | |
COverlappingAssignerHelper< ILU0SubdomainSolver< M, X, Y >, false > | |
COverlappingAssignerHelper< ILUNSubdomainSolver< M, X, Y >, false > | |
COverlappingAssignerHelper< S< BCRSMatrix< T, A > >, true > | |
COverlappingAssignerILUBase | |
COverlappingSchwarzInitializer | Initializer for SuperLU Matrices representing the subdomains |
COverlappingSchwarzOperator | An overlapping Schwarz operator |
COverlappingSchwarzScalarProduct | Scalar product for overlapping Schwarz methods |
COwnerOverlapCopyAttributeSet | Attribute set for overlapping Schwarz |
►COwnerOverlapCopyCommunication | A class setting up standard communication for a two-valued attribute set with owner/overlap/copy semantics |
CAddGatherScatter | |
CCopyGatherScatter | Gather/scatter callback for communcation |
CParallelScalarProduct | Scalar product for overlapping Schwarz methods |
CParSSOR | A parallel SSOR preconditioner |
CPointerCompare | |
CPowerIteration_Algorithms | Iterative eigenvalue algorithms based on power iteration |
CPreconditioner | Base class for matrix free definition of preconditioners |
CPropertyMapTypeSelector< Amg::VertexVisitedTag, Amg::PropertiesGraph< G, Amg::VertexProperties, EP, VM, EM > > | |
CQuerySpaceChooser | |
CRedistributeInformation | |
CRedistributeInformation< OwnerOverlapCopyCommunication< T, T1 > > | |
CRedistributeInterface | |
CRestartedFCGSolver | Accelerated flexible conjugate gradient method |
CRestartedFlexibleGMResSolver | Implements the Flexible Generalized Minimal Residual (FGMRes) method (right preconditioned) |
CRestartedGMResSolver | Implements the Generalized Minimal Residual (GMRes) method |
CRichardson | Richardson preconditioner |
CScalarProduct | Base class for scalar product and norm computation |
CScaledIdentityMatrix | A multiple of the identity matrix of static size |
CSeqILDL | Sequential ILDL preconditioner |
CSeqILU | Sequential ILU preconditioner |
CSeqJac | The sequential jacobian preconditioner |
CSeqOverlappingSchwarz | Sequential overlapping Schwarz preconditioner |
CSeqOverlappingSchwarzApplier | Helper template meta program for application of overlapping Schwarz |
CSeqOverlappingSchwarzApplier< SeqOverlappingSchwarz< M, X, SymmetricMultiplicativeSchwarzMode, TD, TA > > | |
CSeqOverlappingSchwarzAssemblerHelper | |
CSeqOverlappingSchwarzAssemblerHelper< DynamicMatrixSubdomainSolver< BCRSMatrix< K, Al >, X, Y >, false > | |
CSeqOverlappingSchwarzAssemblerHelper< ILU0SubdomainSolver< M, X, Y >, false > | |
CSeqOverlappingSchwarzAssemblerHelper< ILUNSubdomainSolver< M, X, Y >, false > | |
CSeqOverlappingSchwarzAssemblerHelper< S< BCRSMatrix< T, A > >, true > | |
CSeqOverlappingSchwarzAssemblerILUBase | |
CSeqOverlappingSchwarzDomainSize | |
CSeqOverlappingSchwarzDomainSize< BCRSMatrix< T, A > > | |
CSeqScalarProduct | Default implementation for the scalar case |
CSeqSOR | Sequential SOR preconditioner |
CSeqSSOR | Sequential SSOR preconditioner |
CSolverAbort | Thrown when a solver aborts due to some problem |
CSolverCategory | Categories for the solvers |
CSolverFactory | Factory to assembly solvers configured by a ParameterTree |
►CSolverHelper | 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) |
CImplementation | Implementation that works together with iterative ISTL solvers, e.g. Dune::CGSolver or Dune::BiCGSTABSolver |
CImplementation< true, Dummy > | Implementation that works together with direct ISTL solvers, e.g. Dune::SuperLU or Dune::UMFPack |
CSPQR | Use the SPQR package to directly solve linear systems – empty default class |
CSPQR< BCRSMatrix< FieldMatrix< T, n, m >, A > > | The SPQR direct sparse solver for matrices of type BCRSMatrix |
►CSPQRCreator | |
CisValidBlock | |
CisValidBlock< FieldVector< double, 1 > > | |
CStoresColumnCompressed | |
CStoresColumnCompressed< LDL< BCRSMatrix< FieldMatrix< T, n, m >, A > > > | |
CStoresColumnCompressed< SPQR< BCRSMatrix< T, A > > > | |
CStoresColumnCompressed< SuperLU< BCRSMatrix< T, A > > > | |
CStoresColumnCompressed< UMFPack< BCRSMatrix< T, A > > > | |
CSuperLU | SuperLu Solver |
►CSuperLUCreator | |
CisValidBlock | |
CisValidBlock< double > | |
CisValidBlock< Dune::FieldVector< double, k > > | |
CisValidBlock< Dune::FieldVector< std::complex< double >, k > > | |
CisValidBlock< std::complex< double > > | |
CSuperLUDenseMatChooser | |
CSuperLUMatrix | Utility class for converting an ISTL Matrix into a SuperLU Matrix |
CSuperLUMatrix< BCRSMatrix< B, TA > > | Converter for BCRSMatrix to SuperLU Matrix |
CSuperLUQueryChooser | |
CSuperLUSolveChooser | |
CSuperMatrixCreateSparseChooser | |
CSuperMatrixInitializer | |
CSuperMatrixInitializer< BCRSMatrix< B, A > > | |
CSuperMatrixPrinter | |
CSymmetricMultiplicativeSchwarzMode | Tag that tells the Schwarz method to be multiplicative and symmetric |
CTransposedMatMultMatResult | Helper TMP to get the result type of a sparse matrix matrix multiplication ( ) |
CTransposedMatMultMatResult< BCRSMatrix< FieldMatrix< T, k, n >, A >, BCRSMatrix< FieldMatrix< T, k, m >, A1 > > | |
CTransposedMatMultMatResult< FieldMatrix< T, k, n >, FieldMatrix< T, k, m > > | |
CUMFPack | The UMFPack direct sparse solver |
►CUMFPackCreator | |
CisValidBlock | |
CisValidBlock< B, std::enable_if_t< std::is_same< typename FieldTraits< B >::real_type, double >::value > > | |
CUMFPackMethodChooser | |
CUMFPackMethodChooser< double > | |
CUMFPackMethodChooser< std::complex< double > > | |
CUnsupportedType | |
►CVariableBlockVector | A Vector of blocks with different blocksizes |
CCreateIterator | Iterator class for sequential creation of blocks |
CRealIterator | Iterator class for sequential access |
►Nstd | STL namespace |
Ctuple_element< i, Dune::MultiTypeBlockMatrix< Args... > > | Make std::tuple_element work for MultiTypeBlockMatrix |
Ctuple_element< i, Dune::MultiTypeBlockVector< Args... > > | Make std::tuple_element work for MultiTypeBlockVector |