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