Class List

Here are the classes, structs, unions and interfaces with brief descriptions:
Dune::AdditiveSchwarzModeTag 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::AggregatesMap< V >Class providing information about the mapping of the vertices onto aggregates
Dune::Amg::AggregatesMap< V >::DummyEdgeVisitorA Dummy visitor that does nothing for each visited edge
Dune::Amg::AggregationCriterion< T >Base class of all aggregation criterions
Dune::Amg::Aggregator< G >Class for building the aggregates
Dune::Amg::AMG< M, X, S, PI, A >Parallel algebraic multigrid based on agglomeration
Dune::AssembledLinearOperator< M, X, Y >A linear operator exporting itself in matrix form
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_unmanaged< B, A >A simple array container for objects of type B
Dune::base_array_unmanaged< B, A >::RealIterator< T >Iterator implementation class
Dune::base_array_window< B, A >Extend base_array_unmanaged by functions to manipulate
Dune::Amg::BaseConnectivityConstructor::ConnectedBuilder< G, S, V >Visitor for identifying connected aggregates during a breadthFirstSearch
Dune::BCRSMatrix< B, A >A sparse block matrix with compressed row storage
Dune::BCRSMatrix< B, A >::CreateIteratorIterator class for sequential creation of blocks
Dune::BCRSMatrix< B, A >::RealRowIterator< T >Iterator access to matrix rows
Dune::BDMatrix< B, A >A block-diagonal matrix
Dune::BiCGSTABSolver< X >Bi-conjugate Gradient Stabilized (BiCG-STAB)
Dune::BL< l >Compile-time parameter for block recursion depth
Dune::block_vector_unmanaged< B, A >An unmanaged vector of blocks
Dune::BlockPreconditioner< X, Y, C, T >Block parallel preconditioner
Dune::BlockVector< B, A >A vector of blocks with memory management
Dune::BlockVectorWindow< B, A >
Dune::BufferedCommunicator< T >A communicator that uses buffers to gather and scatter the data to be send or received
Dune::CGSolver< X >Conjugate gradient method
Dune::CheckIfDiagonalPresent< blocklevel, l >Check whether the a matrix has diagonal values on blocklevel recursion levels
Dune::Amg::CoarsenCriterion< T >The criterion describing the stop criteria for the coarsening process
Dune::CollectiveIterator< T >A collective iterator for moving over the remote indices for all processes collectively
Dune::CollectiveIterator< T >::iteratorIterator over the valid underlying iterators
Dune::CommPolicy< V >Default policy used for communicating an indexed type
Dune::CommPolicy< V >::CommunicationErrorError thrown if there was a problem with the communication
Dune::CommPolicy< V >::CopyGatherScatter< T >GatherScatter default implementation that just copies data
Dune::compressed_base_array_unmanaged< B, A >A simple array container with non-consecutive index set
Dune::compressed_base_array_unmanaged< B, A >::RealIterator< T >Iterator class for sequential access
Dune::compressed_block_vector_unmanaged< B, A >
Dune::CompressedBlockVectorWindow< B, A >
Dune::Amg::ConstructionTraits< T >Traits class for generically constructing non default constructable types
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< 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::DefaultConstructionArgs< T >Construction Arguments for the default smoothers
Dune::Amg::DefaultSmootherArgs< T >The default class for the smoother arguments
Dune::Amg::Dependency< M, N >Dependency policy for symmetric matrices
Dune::Amg::DependencyParametersParamters needed to check whether a node depends on another
Dune::DiagonalMatrix< K, n >A diagonal matrix of static size
Dune::Amg::EdgePropertiesClass representing the properties of an ede in the matrix graph
Dune::Amg::FirstDiagonalNorm that uses only the [0][0] entry of the block to determine couplings
Dune::GlobalLookupIndexSet< I >Decorates an index set with the possibility to find a global index that is mapped to a specific local
Dune::GradientSolver< X >Gradient method
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< T, A >::LevelIterator< C, T1 >Iterator over the levels in the hierarchy
Dune::IndexInfoFromGrid< G, L >Information about the index distribution
Dune::IndexPair< TG, TL >A pair consisting of a global and local index
Dune::Amg::IndicesCoarsener< SequentialInformation, E >Coarsen Indices in the sequential case
Dune::IndicesSyncer< T >Class for recomputing missing indices of a distributed index set
Dune::Interface< T >Communication interface between remote and local indices
Dune::InterfaceBuilder< T >Base class of all classes representing a communication interface
Dune::InterfaceInformationInformation describing an interface
Dune::InvalidIndexSetStateException indicating that the index set is not in the expected state
Dune::InverseOperator< X, Y >Abstract base class for all solvers
Dune::InverseOperatorResultStatistics about the application of an inverse operator
Dune::ISTLAllocatorDefault allocator for ISTL
Dune::ISTLErrorDerive error class from the base class in common
Dune::LinearOperator< X, Y >A linear operator
Dune::LocalIndexAn index present on the local process
Dune::LoopSolver< X >Preconditioned loop solver
Dune::Matrix< T, A >A generic dynamic matrix
Dune::MatrixAdapter< M, X, Y >Adapter to turn a matrix into a linear operator
Dune::Amg::MatrixGraph< M >The (undirected) graph of a matrix
Dune::Amg::MatrixGraph< M >::EdgeIteratorT< C >Iterator over all edges starting from a vertex
Dune::Amg::MatrixGraph< M >::VertexIteratorT< C >The vertex iterator type of the graph
Dune::Amg::MatrixHierarchy< M, PI, A >The hierarchies build by the coarsening process
Dune::MatrixIndexSetStores the nonzero entries in a sparse matrix
Dune::MINRESSolver< X >Minimal Residual Method (MINRES)
Dune::MPITraits< T >A traits class describing the mapping of types onto MPI_Datatypes
Dune::MPITraits< IndexPair< TG, ParallelLocalIndex< TA > > >
Dune::MPITraits< ParallelLocalIndex< T > >
Dune::MultiplicativeSchwarzModeTag that tells the Schwarz method to be multiplicative
Dune::OverlappingSchwarzInitializer< I, S >Initializer for SuperLU Matrices representing the subdomains
Dune::OverlappingSchwarzOperator< M, X, Y, C >An overlapping schwarz operator
Dune::OverlappingSchwarzScalarProduct< X, C >Scalar product for overlapping schwarz methods
Dune::OwnerOverlapCopyAttributeSetAttribute 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::OwnerOverlapCopyCommunication< GlobalIdType, LocalIdType >::CopyGatherScatter< T >Gather/scatter callback for communcation
Dune::ParallelIndexSet< TG, TL, N >Manager class for the mapping between local indices and globally unique indices
Dune::ParallelIndexSet< TG, TL, N >::iteratorThe iterator over the pairs
Dune::ParallelLocalIndex< T >An index present on the local process with an additional attribute flag
Dune::Amg::ParallelMatrix< M, IS, X, Y >Matrix together with information about the distribution between the processes
Dune::ParSSOR< M, X, Y, C >A parallel SSOR preconditioner
Dune::Preconditioner< X, Y >Base class for matrix free definition of preconditioners
Dune::Amg::PropertiesGraph< G, VP, EP, VM, EM >Attaches properties to the edges and vertices of a graph
Dune::Amg::RandomAccessBundledPropertyMap< C, K, i, T, R >A property map that extracts one property out of a bundle using operator[]()
Dune::RemoteIndex< T1, T2 >Information about an index residing on another processor
Dune::RemoteIndexListModifier< T, mode >Modifier for adding and/or deleting remote indices from the remote index list
Dune::RemoteIndices< T >The indices present on remote processes
Dune::RestartedGMResSolver< X, Y, F >Implements the Generalized Minimal Residual (GMRes) method
Dune::Richardson< X, Y >Richardson preconditioner
Dune::Amg::RowSumFunctor using the row sum (infinity) norm to determine strong couplings
Dune::ScalarProduct< X >Base class for scalar product and norm computation
Dune::ScalarProductChooser< X, C, c >Choose the approriate scalar product for a solver category
Dune::ScaledIdentityMatrix< K, n >A multiple of the identity matrix of static size
Dune::SeqGS< M, X, Y, l >Sequential Gauss Seidel preconditioner
Dune::SeqILU0< M, X, Y >Sequential ILU0 preconditioner
Dune::SeqILUn< M, X, Y >Sequential ILU(n) preconditioner
Dune::SeqJac< M, X, Y, l >The sequential jacobian preconditioner
Dune::SeqOverlappingSchwarz< M, X, TM, TA >Sequential overlapping Schwarz preconditioner
Dune::SeqOverlappingSchwarzDomainSize< M >
Dune::SeqPardiso< M, X, Y >The sequential Pardiso preconditioner
Dune::SeqScalarProduct< X >Default implementation for the scalar case
Dune::SeqSOR< M, X, Y, l >Sequential SOR preconditioner
Dune::SeqSSOR< M, X, Y, l >Sequential SSOR preconditioner
Dune::SizeOneFlag for marking indexed data structures where data at each index is of the same size
Dune::Amg::SmootherApplier< T >Helper class for applying the smoothers
Dune::Amg::SmootherTraits< T >Traits class for getting the attribute class of a smoother
Dune::SolverCategoryCategories for the solvers
Dune::Amg::SparsityBuilder< M, V >Functor for building the sparsity pattern of the matrix using examineConnectivity
Dune::Amg::SubGraph< G, T >A subgraph of a graph
Dune::Amg::SubGraph< G, T >::EdgeIndexMapAn index map for mapping the edges to indices
Dune::Amg::SubGraph< G, T >::EdgeIteratorThe edge iterator of the graph
Dune::Amg::SubGraph< G, T >::VertexIteratorThe vertex iterator of the graph
Dune::SuperLU< BCRSMatrix< FieldMatrix< T, n, m >, A > >SuperLu Solver
Dune::SuperLUMatrix< M >Utility class for converting an ISTL Matrix into a SsuperLU Matrix
Dune::SuperLUMatrix< BCRSMatrix< FieldMatrix< B, n, m >, TA > >Coverte for BCRSMatrix to SuperLU Matrix
Dune::Amg::SymmetricCriterion< M, Norm >Criterion taking advantage of symmetric matrices
Dune::Amg::SymmetricDependency< M, N >Dependency policy for symmetric matrices
Dune::Amg::UnSymmetricCriterion< M, Norm >Criterion suited for unsymmetric matrices
Dune::VariableBlockVector< B, A >A Vector of blocks with different blocksizes
Dune::VariableBlockVector< B, A >::ConstIteratorConstIterator class for sequential access
Dune::VariableBlockVector< B, A >::CreateIteratorIterator class for sequential creation of blocks
Dune::VariableBlockVector< B, A >::IteratorIterator class for sequential access
Dune::VariableSizeFlag for marking indexed data structures where the data at each index may be a variable multiple of another type
Dune::Amg::VertexPropertiesClass representing a node in the matrix graph
Dune::Amg::VertexPropertiesGraph< G, VP, VM >Attaches properties to the vertices of a graph
Dune::Amg::VertexVisitedTagTag idnetifying the visited property of a vertex

Generated on Sun Nov 15 22:29:39 2009 for dune-istl by  doxygen 1.5.6