► N Hpro
► N BLAS
C Matrix Standard dense matrix in basic linear algebra, i.e. BLAS/LAPACK
C TransposeView Provide transposed view of a matrix
C AdjoinView Provide adjoint view, e.g. conjugate transposed of a given matrix
C MatrixView Provide generic view to a matrix, e.g. transposed or adjoint
C MatrixBase Defines basic interface for matrices
C MemBlock Defines a reference countable memory block
C Range Indexset with modified ctors
C Vector Standard vector in basic linear algebra, i.e. BLAS/LAPACK
► N DAG
C LocalGraph
C Node Represents a node in a DAG
C fac_options_t Options for matrix factorisations
C inv_options_t Options for matrix inversion
C TFrobeniusNorm Computes Frobenius norm ‖·‖_F of a matrix
C TSpectralNorm Computes spectral norm ‖·‖₂ of matrix (or linear operator)
C TInfinityNorm Computes infinity norm ‖·‖_∞ of a matrix
C TRowMatrixNorm Computes norm for each row of a matrix
C TColumnMatrixNorm Computes norm for each column of the matrix
C solve_option_t Options for how to solve with given matrix
C eval_option_t Options for how to evaluate given matrix
C TCoarsen Implements coarsening, e.g. agglomeration of blocked matrices into dense or low-rank matrices if the later use less memory
C TLowRankApx Base class for all low rank approximation techniques
C TZeroLRApx Approximate all low-rank blocks by zero, e.g. for nearfield only
C TDenseLRApx Computes dense matrix block without approximation
C TSVDLRApx Uses exact SVD to compute low rank approximation (WARNING: O(n³) complexity)
C TRandSVDLRApx Uses randomized SVD to compute low rank approximation (WARNING: O(n²) complexity)
C TRRQRLRApx Uses rank-revealing QR to compute low rank approximation
C TACA Defines interface for all ACA algorithms and implements classical ACA
C TACAPlus Implements ACA+, which corrects some of the deficits of the original ACA algorithm
C TACAFull ACA with full pivot search (complexity: O(n²))
► C THCA Uses hybrid cross approximation (HCA) for computing low rank approximation
C stat_t
C TGeneratorFn Class defining kernel generator function used by HCA
C TPermHCAGeneratorFn Base class for HCA generator functions using row/column permutations
C TMatrix Base class for all matrices, defining basic properties, e.g. underlying block index and processor set
C TByteStream Implements a stream of bytes for storage purposes
C is_complex_type
C is_single_prec
C real_type
C promote_type
C value_type
C TTruncAcc Defines accuracy for truncation of low rank blocks
C TBlockTruncAcc Truncation accuracy defined blockwise for block index sets
C TTypeInfo Provides basic interface and methods for RTTI
C TBilinearForm Base class for all bilinear forms
C TBEMBF Base class for BEM bilinear forms with ansatz and test space
C TBFCoeffFn Provide matrix coefficients defined by bilinear forms
C TExpBF Bilinear form for expontential kernel
C TExpGenFn Kernel generator function for Exp Kernel
C THelmholtzSLPBF Bilinear form for Helmholtz single layer potential
C THelmholtzDLPBF Bilinear form for Helmholtz double layer potential
C THelmholtzSLPGenFn Kernel generator function for Helmholtz SLP
C THelmholtzDLPGenFn Kernel generator function for Helmholtz DLP
C TLaplaceSLPBF Bilinear form for Laplace single layer potential
C TLaplaceDLPBF Bilinear form for Laplace double layer potential
C TLaplaceSLPGenFn Kernel generator function for Laplace SLP
C TLaplaceDLPGenFn Kernel generator function for Laplace DLP
C TMassBF Bilinear form for mass matrix
C TMaxwellEFIEMassBF Bilinear form for Maxwell EFIE mass matrix
C TMaxwellMFIEMassBF Bilinear form for Maxwell MFIE mass matrix
C tripair_quad_rule_t Holds quadrature rule with points and weights for two triangles
C TQuadBEMBF Base class for all quadrature based bilinear forms
C TInvarBasisQuadBEMBF Class for quadrature based bilinear forms with invariant basis functions
C tri_quad_rule_t
► C TQuadHCAGenFn Base class for HCA generator functions using quadrature
C stat_t
C TInvarBasisQuadHCAGenFn Class for BEM HCA generator functions with invariant basis functions
C TAdmCondition Defines basic interface for admissibility conditions
C TOffDiagAdmCond Everything except diagonal is admissible
C TAlgAdmCond Base class for algebraic admissibility conditions
C TStdAlgAdmCond Standard admissibility condition based on matrix graph criteria
C TAlgCTBuilder Base class for cluster tree construction algorithms based on graph partitioning with graph defined by a sparse matrix
► C TAlgNDCTBuilder Enhances algebraic clustering by nested dissection
C TOptClusterSize Controls optimal cluster size per tree level
C TPartAlgCTBuilder Enhances algebraic clustering by allowing the user to define the first level of index partitioning, e.g. define which index belongs to which son cluster
C TAlgPartStrat Base class for partitioning strategies for algebraic clustering
C TBFSAlgPartStrat Graph partitioning using BFS algorithm and FM optimisation
C TMLAlgPartStrat Multi level graph partitioning
C TMETISAlgPartStrat Graph partitioning using METIS
C TScotchAlgPartStrat Graph partitioning using Scotch
C TChacoAlgPartStrat Graph partitioning using CHACO
C TMongooseAlgPartStrat Graph partitioning using Mongoose
C TBCBuilder Recursively build block cluster tree with supplied admissibility condition
C TBlockCluster Representing a node in a block cluster tree as product of two clusters
C TBlockClusterTree Represents a block cluster tree
► C TGeomCTBuilder Base class for all cluster tree constructors based on geometry data
C data_t Datatype for internal argument transfer
C TOptClusterSize Controls optimal cluster size per tree level
C TBSPCTBuilder Base class for all cluster tree constructors based on BSP
C TBSPNDCTBuilder Combines binary space partitioning with nested dissection based on connectivity defined by a sparse matrix
C TGeomPartCTBuilder Enhances other geometrical ct builders by allowing the user to define the first level of index partitioning by a given vector
C TGeomGroupCTBuilder Enhances geometrical ct builder by allowing to group indices, e.g. the groups are clustered and later expanded, ensuring that all indices in a group are in the same cluster NOTE: bounding boxes per index are not yet supported (bb_min/bb_max)
C TBSPPartStrat Base class for partitioning strategies for geometrical BSP clustering
C TGeomBSPPartStrat Partition according to geometrical volume of index sets
C TCardBSPPartStrat Partition according to cardinality of index sets
C TPCABSPPartStrat Partition according to principle component analysis
C TNDBSPPartStrat Special partition strategy to optimized nested dissection clustering
C TAutoBSPPartStrat Automatic choice of best partitioning strategy
C TCluster Represents a node in a cluster tree with an arbitrary number of sons
C TUniformVector Class for a uniform vector, e.g. represented as with cluster basis and coefficients
C TClusterBasis Class representing a nested cluster basis
C TDenseClusterBasisBuilder Class for constructing cluster bases using dense matrices
C THClusterBasisBuilder Class for constructing cluster bases using H-matrices
C TClusterTree Represents a cluster tree with permutation of index sets
C TCoordinate Stores coordinate information for indices
► C TDiGraph Class for directed graph represented by adjacency matrix in sparse format (assuming sparse graph!)
C TIterator Iterator to predecessor/successor lists
C TFVS Uses a heuristic algorithm to compute feedback vertex set of a directed graph represented by a sparse matrix
C TStdGeomAdmCond Standard admissibility for FEM/BEM applications normal : adm iff min( diam(τ), diam(σ) ) ≤ η·dist(τ,σ) use_max: adm iff max( diam(τ), diam(σ) ) ≤ η·dist(τ,σ)
C TWeakStdGeomAdmCond Combination of standard and weak admissibility
C THiLoFreqGeomAdmCond Admissibility for high and low frequency regimes
C TParabolicGeomAdmCond Parabolic admissibility for high frequency regimes
C TGeomCluster Extend standard cluster by bounding box
► C TGraph Class for a undirected graph stored as adjacency matrix in CRS representation
C TAdjNodes
C TAdjNodesWeights
C TNodes
C TEWGraph Represents undirected graph with edge weights
C TIndexSet Represents an indexset with contigously numbered indices, defined by the first and last index in the set
C TBlockIndexSet Represents a product of two indexsets
► C TNodeSet Represents a set of nodes by an array
C iterator STL iterator for TNodeSet
C TPermutation Describes permutation of index sets
C TClusterBasisVis Base class for cluster basis visualisation
C TPSClusterBasisVis Cluster basis visualisation in PostScript format
C TClusterVis Base class for cluster tree visualisation
C TBlockClusterVis Base class for block cluster tree visualisation
C T2DClusterVis Base class for cluster tree visualisation in 2D
C TPSClusterVis Class for cluster tree visualisation in PostScript format
C TPDFClusterVis Class for cluster tree visualisation in PDF format
C T2DBlockClusterVis Base class for block cluster tree visualisation in 2D
C TPSBlockClusterVis Class for block cluster tree visualisation in PostScript format
C TPDFBlockClusterVis Class for block cluster tree visualisation in PDF format
C TVTKBlockClusterVis Class for block cluster tree visualisation in VTK
C TGVClusterVis Cluster tree visualisation in GraphViz format
C TGVBlockClusterVis Block cluster tree visualisation in GraphViz format
C TCoordIO Base class for coordinate I/O defining interface
C TAutoCoordIO Class for coordinate I/O with file format detection
C TSAMGCoordIO Class for coordinate I/O in SAMG format
C TMatlabCoordIO Class for coordinate I/O in Matlab format
C THproCoordIO Class for coordinate I/O in HLIB format
C TMMCoordIO Class for coordinate I/O in MatrixMarket format
C TPLTMGCoordIO Class for coordinate I/O in PLTMG format
C TGMSHCoordIO Class for coordinate I/O in GMSH format
C TPSCoordVis Coordinate visualisation in PostScript format
C TVTKCoordVis Coordinate visualisation in VTK format
C TGridIO Base class for reading grids
C TAutoGridIO Class for grid I/O with file format detection
C THLibGridIO Class for grid I/O in HLIB format
C TPlyGridIO Class for grid I/O in Ply format
C TSurfMeshGridIO Class for grid I/O in Surface Mesh format
C TGMSHGridIO Class for grid I/O in GMSH format
C T2DGridVis Base class for 2D grid visualisation (by projection)
C TPSGridVis Class for grid visualisation in PostScript format
C TPDFGridVis Class for grid visualisation in PDF format
C TVTKGridVis Class for grid visualisation in VTK format
C TAutoMatrixIO Class for matrix I/O with automatic file format detection
C TOctaveMatrixIO Class for matrix I/O in octave format
C TSAMGMatrixIO Class for matrix I/O in SAMG format
C TMatlabMatrixIO Class for matrix I/O in Matlab format
C THproMatrixIO Class for matrix I/O in HLIB format
C TPLTMGMatrixIO Class for matrix I/O in PLTMG format
C THBMatrixIO Class for matrix I/O in Harwell-Boeing and Rutherford-Boeing format
C TMMMatrixIO Class for matrix I/O in MatrixMarket format
C THDF5MatrixIO Class for matrix I/O in HDF5 format
C TMatrixVisBase Implements 2D based matrix visualisation
C TPSMatrixVis Class for matrix visualisation in PostScript format
C TPDFMatrixVis Class for matrix visualisation in PDF format
C TAutoVectorIO Class for vector I/O with automatic file format detection
C TSAMGVectorIO Class for vector I/O in SAMG format
C TMatlabVectorIO Class for vector I/O in Matlab format
C THproVectorIO Class for vector I/O in HLIB format
C THBVectorIO Class for vector I/O in Harwell-Boeing and Rutherford-Boeing format
C TMMVectorIO Class for vector I/O in MatrixMarket format
C TBlockMatrix Class for a n×m block matrix of TMatrix sub matrices
C TCoeffFn Base class for returning coefficient for a given indexpair (i,j) in internal ordering
C TPermCoeffFn Eval coefficient function with reordered indices, e.g. change internal to external ordering
C TCBCoeffFn Eval real valued matrix coefficients with call-back function
C TDenseMatrix Represent a dense matrix
C TFacInvMatrix Baseclass for representing the inverse of factorised matrices
C TLUInvMatrix Represents the inverse of a LU factored matrix
C TLDUInvMatrix Represents the inverse of a LDU factored matrix
C TLDLInvMatrix Represents the inverse of a LDL factored matrix
C TLLInvMatrix Represents the inverse of a Cholesky factored matrix
C TGhostMatrix The class acts as a place holder for non-local matrix blocks to access logical information, e.g. size, processor number, but can not perform any computations
C TH2Matrix Class for an H²-matrix, which extends block matrices with additional functionality, e.g. permutations and uniform vectors
C THMatrix Class for an H-matrix, which extends block matrices with additional functionality, e.g. permutations
C TJacobi Implements Jacobi preconditioner
C TLinearOperator Base class for all linear operators mapping vectors to vectors
C TMatBuilder Base class for building matrices implementing basic management and parallel construction
C TSparseMatBuilder Creates H-matrices out of sparse matrices
► C TDenseMatBuilder Creates matrices by computing low rank approximations of dense sub matrices, e.g. via ACA or SVD
C stat_t Statistical data of computations
C TH2MatBuilder Base class for H² matrix builders providing leaf bulding function with corresponding cluster bases
C TIdMatBuilder Construct identity matrix for given block cluster trees
C TZeroMatBuilder Construct empty matrix for given block cluster trees
C TSparseBlockMatrix Represents a n×m block matrix with only a small number of non-null sub matrices stored in an efficient way
C TMatrixHierarchy Represents a level-wise hierarchy of matrices
C TMatrixProduct Represents product α₁A₁ · α₂A₂ · α₃A₃... of matrices (linear ops)
C TMatrixSum Represents sum α₁A₁ + α₂A₂ + α₃A₃... of matrices (linear ops)
C TNearfieldMulVec Implements matrix-vector multiplication with nearfield part of H-matrix
C TPermMatrix
C TRkMatrix Represents low rank matrices in factored form:
C TSOR Implements SOR preconditioner for sparse matrices
C TGaussSeidel Implements Gauss-Seidel preconditioner
C TSparseMatrix Class for a sparse matrix stored in compressed row storage format
C TUniformMatrix Represents low rank matrices as uniform matrix: , where and are cluster bases and holds the corresponding coefficients
C TUpdateAccumulator Handles updates for a single matrix block by accumulating direct updates and recursive (pending) updates
C TZeroMatrix Class for a null matrix with only zero coefficients
C TMaternCovCoeffFn Matern covariance coefficient function
C TTimer Timer class
C TCPUTimer Timer class measuring CPU time
C TThreadCPUTimer Timer class measuring CPU time of current thread
C TWallTimer Timer class measuring wall clock time
► C TDistrBC Base class for all block cluster distribution methods
C TCostFunc Cost function for block clusters in load balancing
C TBlockDistrBC Class for block-wise block cluster tree distribution
C TSFCDistrBC Class for distributing block cluster trees using space filling curves
C TNDDistrBC Class for block cluster tree distribution for nested dissection
C TMutex Wraps default mutices
C TLockable Base class for all mutex equipped classes
C TScopedLock Provides automatic lock and unlock for mutices
C TProcSet Describes a processor set of continuously numbered processors
C TAutoSolver Implements an iterative solver automatically choosing appropriate algorithm based on matrix criteria
C TBiCGStab Implements BiCG-Stab iteration
C TCG Implements conjugate gradient iteration
C TCGS Implements squared conjugate gradient iteration
C TGMRES Implements GMRES iteration with restart
C TLinearIteration Implements linear iteration
C TMINRES Implements the MINRES iteration
C TTFQMR Implements transpose free quasi minimal residual iteration
C TBlockVector Class for a blocked, scalar vector
C TScalarVector Class for a scalar vector
C TUniformBlockVector Class for a uniform block vector, e.g. of uniform sub blocks
C TVector Base class for all vectors defining basic interface
C acc_u
C hpro_
C TGridVis Base class for grid visualisation
C THLibClusterBasisIO Cluster basis I/O in HLIBpro file format
C TLDL Computes LDL factorisation or
C TLDU Computes LDU factorisation
C TLL Computes Cholesky factorisation or
C TLU Computes LU factorisation
C TMBLRBSPCTBuilder Implement MBLR clustering