Cacc_u | |
CTGeomCTBuilder::data_t | Datatype for internal argument transfer |
Ceval_option_t | Options for how to evaluate given matrix |
Cfac_options_t | Options for matrix factorisations |
Chpro_ | |
Cinv_options_t | Options for matrix inversion |
Cis_complex_type< T > | |
Cis_single_prec< T > | |
CTNodeSet::iterator | STL iterator for TNodeSet |
►Clock_guard< T > | STL class |
CTScopedLock | Provides automatic lock and unlock for mutices |
►CMatrixBase< T_derived > | Defines basic interface for matrices |
CMatrix< value_t > | |
►CMatrixBase< AdjoinView< T_matrix > > | |
CAdjoinView< T_matrix > | Provide adjoint view, e.g. conjugate transposed of a given matrix |
►CMatrixBase< Matrix< T_value > > | |
CMatrix< T_value > | Standard dense matrix in basic linear algebra, i.e. BLAS/LAPACK |
►CMatrixBase< MatrixView< T_matrix > > | |
CMatrixView< T_matrix > | Provide generic view to a matrix, e.g. transposed or adjoint |
►CMatrixBase< TransposeView< T_matrix > > | |
CTransposeView< T_matrix > | Provide transposed view of a matrix |
►CMemBlock< T_value > | Defines a reference countable memory block |
CMatrix< value_t > | |
CVector< value_t > | |
CMatrix< T_value > | Standard dense matrix in basic linear algebra, i.e. BLAS/LAPACK |
CVector< T_value > | Standard vector in basic linear algebra, i.e. BLAS/LAPACK |
►Cmutex | STL class |
CTMutex | Wraps default mutices |
CNode | Represents a node in a DAG |
Cpromote_type< T1, T2 > | |
Creal_type< T > | |
Csolve_option_t | Options for how to solve with given matrix |
CTDenseMatBuilder< T_value >::stat_t | Statistical data of computations |
CTHCA< T_value >::stat_t | |
CTQuadHCAGenFn< T_ansatzsp, T_testsp, T_value >::stat_t | |
►CT2DGridVis | Base class for 2D grid visualisation (by projection) |
CTPDFGridVis | Class for grid visualisation in PDF format |
CTPSGridVis | Class for grid visualisation in PostScript format |
CTGraph::TAdjNodes | |
CTGraph::TAdjNodesWeights | |
►CTAdmCondition | Defines basic interface for admissibility conditions |
►CTAlgAdmCond | Base class for algebraic admissibility conditions |
CTStdAlgAdmCond | Standard admissibility condition based on matrix graph criteria |
CTHiLoFreqGeomAdmCond | Admissibility for high and low frequency regimes |
CTOffDiagAdmCond | Everything except diagonal is admissible |
CTParabolicGeomAdmCond | Parabolic admissibility for high frequency regimes |
►CTStdGeomAdmCond | Standard admissibility for FEM/BEM applications normal : adm iff min( diam(τ), diam(σ) ) ≤ η·dist(τ,σ) use_max: adm iff max( diam(τ), diam(σ) ) ≤ η·dist(τ,σ) |
CTWeakStdGeomAdmCond | Combination of standard and weak admissibility |
►CTAlgCTBuilder | Base class for cluster tree construction algorithms based on graph partitioning with graph defined by a sparse matrix |
CTAlgNDCTBuilder | Enhances algebraic clustering by nested dissection |
CTPartAlgCTBuilder | 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 |
►CTAlgPartStrat | Base class for partitioning strategies for algebraic clustering |
CTBFSAlgPartStrat | Graph partitioning using BFS algorithm and FM optimisation |
CTChacoAlgPartStrat | Graph partitioning using CHACO |
CTMETISAlgPartStrat | Graph partitioning using METIS |
CTMLAlgPartStrat | Multi level graph partitioning |
CTMongooseAlgPartStrat | Graph partitioning using Mongoose |
CTScotchAlgPartStrat | Graph partitioning using Scotch |
CTAutoMatrixIO | Class for matrix I/O with automatic file format detection |
CTAutoSolver | Implements an iterative solver automatically choosing appropriate algorithm based on matrix criteria |
CTAutoVectorIO | Class for vector I/O with automatic file format detection |
CTBCBuilder | Recursively build block cluster tree with supplied admissibility condition |
CTBiCGStab | Implements BiCG-Stab iteration |
►CTBilinearForm< T_val > | Base class for all bilinear forms |
►CTBEMBF< T_ansatzsp, T_testsp, std::complex< double > > | |
CTQuadBEMBF< T_ansatzsp, T_testsp, std::complex< double > > | |
CTMaxwellEFIEMassBF< T_ansatzsp, T_testsp > | Bilinear form for Maxwell EFIE mass matrix |
CTMaxwellMFIEMassBF< T_ansatzsp, T_testsp > | Bilinear form for Maxwell MFIE mass matrix |
►CTBEMBF< T_ansatzsp, T_testsp, T_value > | |
CTMassBF< T_ansatzsp, T_testsp, T_value > | Bilinear form for mass matrix |
►CTQuadBEMBF< T_ansatzsp, T_testsp, T_value > | Base class for all quadrature based bilinear forms |
►CTInvarBasisQuadBEMBF< T_ansatzsp, T_testsp, T_value > | |
CTExpBF< T_ansatzsp, T_testsp, T_value > | Bilinear form for expontential kernel |
CTHelmholtzDLPBF< T_ansatzsp, T_testsp, T_value > | Bilinear form for Helmholtz double layer potential |
CTHelmholtzSLPBF< T_ansatzsp, T_testsp, T_value > | Bilinear form for Helmholtz single layer potential |
►CTInvarBasisQuadBEMBF< T_ansatzsp, T_testsp, double > | |
CTLaplaceDLPBF< T_ansatzsp, T_testsp, T_value > | Bilinear form for Laplace double layer potential |
CTLaplaceSLPBF< T_ansatzsp, T_testsp, T_value > | Bilinear form for Laplace single layer potential |
►CTBEMBF< T_ansatzsp, T_testsp, T_val > | Base class for BEM bilinear forms with ansatz and test space |
►CTQuadBEMBF< T_ansatzsp, T_testsp, T_val > | |
CTInvarBasisQuadBEMBF< T_ansatzsp, T_testsp, T_val > | Class for quadrature based bilinear forms with invariant basis functions |
CTBlockCluster | Representing a node in a block cluster tree as product of two clusters |
CTBlockClusterTree | Represents a block cluster tree |
►CTBlockClusterVis | Base class for block cluster tree visualisation |
►CT2DBlockClusterVis | Base class for block cluster tree visualisation in 2D |
CTPDFBlockClusterVis | Class for block cluster tree visualisation in PDF format |
CTPSBlockClusterVis | Class for block cluster tree visualisation in PostScript format |
CTGVBlockClusterVis | Block cluster tree visualisation in GraphViz format |
CTVTKBlockClusterVis | Class for block cluster tree visualisation in VTK |
CTBlockIndexSet | Represents a product of two indexsets |
►CTBSPPartStrat | Base class for partitioning strategies for geometrical BSP clustering |
CTAutoBSPPartStrat | Automatic choice of best partitioning strategy |
CTCardBSPPartStrat | Partition according to cardinality of index sets |
CTGeomBSPPartStrat | Partition according to geometrical volume of index sets |
CTNDBSPPartStrat< value_t > | Special partition strategy to optimized nested dissection clustering |
CTPCABSPPartStrat | Partition according to principle component analysis |
CTByteStream | Implements a stream of bytes for storage purposes |
CTCG | Implements conjugate gradient iteration |
CTCGS | Implements squared conjugate gradient iteration |
►CTClusterBasisVis< T > | Base class for cluster basis visualisation |
CTPSClusterBasisVis< T > | Cluster basis visualisation in PostScript format |
CTClusterTree | Represents a cluster tree with permutation of index sets |
►CTClusterVis | Base class for cluster tree visualisation |
►CT2DClusterVis | Base class for cluster tree visualisation in 2D |
CTPDFClusterVis | Class for cluster tree visualisation in PDF format |
CTPSClusterVis | Class for cluster tree visualisation in PostScript format |
CTGVClusterVis | Cluster tree visualisation in GraphViz format |
CTCoarsen | Implements coarsening, e.g. agglomeration of blocked matrices into dense or low-rank matrices if the later use less memory |
►CTCoeffFn< T > | Base class for returning coefficient for a given indexpair (i,j) in internal ordering |
CTCBCoeffFn< T > | Eval real valued matrix coefficients with call-back function |
CTPermCoeffFn< T > | Eval coefficient function with reordered indices, e.g. change internal to external ordering |
►CTCoeffFn< double > | |
CTMaternCovCoeffFn< T_point > | Matern covariance coefficient function |
►CTCoeffFn< T_bf::value_t > | |
CTBFCoeffFn< T_bf > | Provide matrix coefficients defined by bilinear forms |
CTCoeffFn< value_t > | |
CTColumnMatrixNorm | Computes norm for each column of the matrix |
CTCoordinate | Stores coordinate information for indices |
►CTCoordIO | Base class for coordinate I/O defining interface |
CTAutoCoordIO | Class for coordinate I/O with file format detection |
CTGMSHCoordIO | Class for coordinate I/O in GMSH format |
CTHproCoordIO | Class for coordinate I/O in HLIB format |
CTMMCoordIO | Class for coordinate I/O in MatrixMarket format |
CTMatlabCoordIO | Class for coordinate I/O in Matlab format |
CTPLTMGCoordIO | Class for coordinate I/O in PLTMG format |
CTSAMGCoordIO | Class for coordinate I/O in SAMG format |
CTDistrBC::TCostFunc | Cost function for block clusters in load balancing |
CTDenseClusterBasisBuilder< T > | Class for constructing cluster bases using dense matrices |
CTDiGraph | Class for directed graph represented by adjacency matrix in sparse format (assuming sparse graph!) |
►CTDistrBC | Base class for all block cluster distribution methods |
CTBlockDistrBC | Class for block-wise block cluster tree distribution |
CTNDDistrBC | Class for block cluster tree distribution for nested dissection |
CTSFCDistrBC | Class for distributing block cluster trees using space filling curves |
CTFrobeniusNorm | Computes Frobenius norm ‖·‖_F of a matrix |
CTFVS | Uses a heuristic algorithm to compute feedback vertex set of a directed graph represented by a sparse matrix |
►CTHCA< T_value >::TGeneratorFn | Class defining kernel generator function used by HCA |
►CTPermHCAGeneratorFn< T_value > | Base class for HCA generator functions using row/column permutations |
►CTQuadHCAGenFn< T_ansatzsp, T_testsp, T_value > | Base class for HCA generator functions using quadrature |
►CTInvarBasisQuadHCAGenFn< T_ansatzsp, T_testsp, double > | |
CTLaplaceDLPGenFn< T_ansatzsp, T_testsp, T_value > | Kernel generator function for Laplace DLP |
CTLaplaceSLPGenFn< T_ansatzsp, T_testsp, T_value > | Kernel generator function for Laplace SLP |
►CTInvarBasisQuadHCAGenFn< T_ansatzsp, T_testsp, T_value > | Class for BEM HCA generator functions with invariant basis functions |
CTExpGenFn< T_ansatzsp, T_testsp, T_value > | Kernel generator function for Exp Kernel |
CTHelmholtzDLPGenFn< T_ansatzsp, T_testsp, T_value > | Kernel generator function for Helmholtz DLP |
CTHelmholtzSLPGenFn< T_ansatzsp, T_testsp, T_value > | Kernel generator function for Helmholtz SLP |
►CTGeomCTBuilder | Base class for all cluster tree constructors based on geometry data |
►CTBSPCTBuilder | Base class for all cluster tree constructors based on BSP |
CTBSPNDCTBuilder | Combines binary space partitioning with nested dissection based on connectivity defined by a sparse matrix |
CTGeomGroupCTBuilder | 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) |
CTGeomPartCTBuilder | Enhances other geometrical ct builders by allowing the user to define the first level of index partitioning by a given vector |
CTGMRES | Implements GMRES iteration with restart |
►CTGraph | Class for a undirected graph stored as adjacency matrix in CRS representation |
CTEWGraph | Represents undirected graph with edge weights |
►CTGridIO | Base class for reading grids |
CTAutoGridIO | Class for grid I/O with file format detection |
CTGMSHGridIO | Class for grid I/O in GMSH format |
CTHLibGridIO | Class for grid I/O in HLIB format |
CTPlyGridIO | Class for grid I/O in Ply format |
CTSurfMeshGridIO | Class for grid I/O in Surface Mesh format |
CTGridVis | Base class for grid visualisation |
CTHBMatrixIO | Class for matrix I/O in Harwell-Boeing and Rutherford-Boeing format |
CTHBVectorIO | Class for vector I/O in Harwell-Boeing and Rutherford-Boeing format |
CTHClusterBasisBuilder< T > | Class for constructing cluster bases using H-matrices |
CTHDF5MatrixIO | Class for matrix I/O in HDF5 format |
CTHLibClusterBasisIO | Cluster basis I/O in HLIBpro file format |
CTHproMatrixIO | Class for matrix I/O in HLIB format |
CTHproVectorIO | Class for vector I/O in HLIB format |
►CTIndexSet | Represents an indexset with contigously numbered indices, defined by the first and last index in the set |
CTClusterBasis< value_t > | |
CRange | Indexset with modified ctors |
►CTCluster | Represents a node in a cluster tree with an arbitrary number of sons |
CTGeomCluster | Extend standard cluster by bounding box |
CTClusterBasis< T_value > | Class representing a nested cluster basis |
CTInfinityNorm | Computes infinity norm ‖·‖_∞ of a matrix |
CTDiGraph::TIterator | Iterator to predecessor/successor lists |
CTLDL | Computes LDL factorisation \( A = LDL^T \) or \( A = LDL^H \) |
CTLDU | Computes LDU factorisation \( A = LDU \) |
CTLinearIteration | Implements linear iteration \(x_{i+1} = x_k + N (A x_i - b)\) |
CTLL | Computes Cholesky factorisation \( A = LL^T \) or \( A=LL^H \) |
►CTLockable | Base class for all mutex equipped classes |
►CTMatrix< T_value > | Base class for all matrices, defining basic properties, e.g. underlying block index and processor set |
CTSparseMatrix< value_t > | |
►CTBlockMatrix< T_value > | Class for a n×m block matrix of TMatrix sub matrices |
CTHMatrix< value_t > | |
CTH2Matrix< T_value > | Class for an H²-matrix, which extends block matrices with additional functionality, e.g. permutations and uniform vectors |
CTHMatrix< T_value > | Class for an H-matrix, which extends block matrices with additional functionality, e.g. permutations |
CTDenseMatrix< T_value > | Represent a dense matrix |
CTGhostMatrix< T_value > | 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 |
CTRkMatrix< T_value > | Represents low rank matrices in factored form: \( M = A B^H \) |
CTSparseMatrix< T_value > | Class for a sparse matrix stored in compressed row storage format |
CTUniformMatrix< T_value > | Represents low rank matrices as uniform matrix: \(M = V S W^H\), where \(V\) and \(W\) are cluster bases and \(S\) holds the corresponding coefficients |
CTZeroMatrix< T_value > | Class for a null matrix with only zero coefficients |
CTUpdateAccumulator< value_t > | Handles updates for a single matrix block by accumulating direct updates and recursive (pending) updates |
►CTLowRankApx< T_value > | Base class for all low rank approximation techniques |
►CTACA< T_value > | Defines interface for all ACA algorithms and implements classical ACA |
CTACAFull< T_value > | ACA with full pivot search (complexity: O(n²)) |
CTACAPlus< T_value > | Implements ACA+, which corrects some of the deficits of the original ACA algorithm |
CTDenseLRApx< T_value > | Computes dense matrix block without approximation |
CTHCA< T_value > | Uses hybrid cross approximation (HCA) for computing low rank approximation |
CTRRQRLRApx< T_value > | Uses rank-revealing QR to compute low rank approximation |
CTRandSVDLRApx< T_value > | Uses randomized SVD to compute low rank approximation (WARNING: O(n²) complexity) |
CTSVDLRApx< T_value > | Uses exact SVD to compute low rank approximation (WARNING: O(n³) complexity) |
CTZeroLRApx< T_value > | Approximate all low-rank blocks by zero, e.g. for nearfield only |
CTLowRankApx< value_t > | |
CTLU | Computes LU factorisation \( A = LU \) |
►CTMatBuilder< value_t > | Base class for building matrices implementing basic management and parallel construction |
CTIdMatBuilder< value_t > | Construct identity matrix for given block cluster trees |
CTSparseMatBuilder< value_t, sparse_value_t > | Creates H-matrices out of sparse matrices |
CTZeroMatBuilder< value_t > | Construct empty matrix for given block cluster trees |
►CTMatBuilder< T_value > | |
CTDenseMatBuilder< T_value > | Creates matrices by computing low rank approximations of dense sub matrices, e.g. via ACA or SVD |
CTH2MatBuilder< T_value > | Base class for H² matrix builders providing leaf bulding function with corresponding cluster bases |
CTMatlabMatrixIO | Class for matrix I/O in Matlab format |
CTMatlabVectorIO | Class for vector I/O in Matlab format |
CTMatrixHierarchy< value_t > | Represents a level-wise hierarchy of matrices |
►CTMatrixVisBase | Implements 2D based matrix visualisation |
CTPDFMatrixVis | Class for matrix visualisation in PDF format |
CTPSMatrixVis | Class for matrix visualisation in PostScript format |
CTMBLRBSPCTBuilder | Implement MBLR clustering |
CTMINRES | Implements the MINRES iteration |
CTMMMatrixIO | Class for matrix I/O in MatrixMarket format |
CTMMVectorIO | Class for vector I/O in MatrixMarket format |
CTGraph::TNodes | |
CTNodeSet | Represents a set of nodes by an array |
CTOctaveMatrixIO | Class for matrix I/O in octave format |
CTAlgNDCTBuilder::TOptClusterSize | Controls optimal cluster size per tree level |
CTGeomCTBuilder::TOptClusterSize | Controls optimal cluster size per tree level |
CTPLTMGMatrixIO | Class for matrix I/O in PLTMG format |
CTProcSet | Describes a processor set of continuously numbered processors |
CTPSCoordVis | Coordinate visualisation in PostScript format |
Ctri_quad_rule_t< value_t > | |
Ctri_quad_rule_t< real_t > | |
CTGrid::triangle_t | |
Ctripair_quad_rule_t< value_t > | Holds quadrature rule with points and weights for two triangles |
CTRowMatrixNorm | Computes norm for each row of a matrix |
CTSAMGMatrixIO | Class for matrix I/O in SAMG format |
CTSAMGVectorIO | Class for vector I/O in SAMG format |
CTSparseBlockMatrix< value_t > | Represents a n×m block matrix with only a small number of non-null sub matrices stored in an efficient way |
CTSpectralNorm | Computes spectral norm ‖·‖₂ of matrix (or linear operator) |
CTTFQMR | Implements transpose free quasi minimal residual iteration |
►CTTimer | Timer class |
CTCPUTimer | Timer class measuring CPU time |
CTThreadCPUTimer | Timer class measuring CPU time of current thread |
CTWallTimer | Timer class measuring wall clock time |
►CTTruncAcc | Defines accuracy for truncation of low rank blocks |
CTBlockTruncAcc | Truncation accuracy defined blockwise for block index sets |
►CTTypeInfo | Provides basic interface and methods for RTTI |
CTClusterBasis< value_t > | |
►CTVector< value_t > | |
CTScalarVector< value_t > | |
CTUniformVector< value_t > | |
CTCluster | Represents a node in a cluster tree with an arbitrary number of sons |
CTClusterBasis< T_value > | Class representing a nested cluster basis |
►CTLinearOperator< T_value > | Base class for all linear operators mapping vectors to vectors |
►CTFacInvMatrix< T_value > | Baseclass for representing the inverse of factorised matrices |
CTLDLInvMatrix< T_value > | Represents the inverse of a LDL factored matrix |
CTLDUInvMatrix< T_value > | Represents the inverse of a LDU factored matrix |
CTLLInvMatrix< T_value > | Represents the inverse of a Cholesky factored matrix |
CTLUInvMatrix< T_value > | Represents the inverse of a LU factored matrix |
CTGaussSeidel< T_value > | Implements Gauss-Seidel preconditioner |
CTJacobi< T_value > | Implements Jacobi preconditioner |
CTMatrix< T_value > | Base class for all matrices, defining basic properties, e.g. underlying block index and processor set |
CTMatrixProduct< T_value > | Represents product α₁A₁ · α₂A₂ · α₃A₃... of matrices (linear ops) |
CTMatrixSum< T_value > | Represents sum α₁A₁ + α₂A₂ + α₃A₃... of matrices (linear ops) |
CTNearfieldMulVec< T_value > | Implements matrix-vector multiplication with nearfield part of H-matrix |
CTPermMatrix< T_value > | |
CTSOR< T_value > | Implements SOR preconditioner for sparse matrices |
►CTVector< T_value > | Base class for all vectors defining basic interface |
CTBlockVector< T_value > | Class for a blocked, scalar vector |
CTScalarVector< T_value > | Class for a scalar vector |
►CTUniformVector< T_value > | Class for a uniform vector, e.g. represented as \(x = V s\) with cluster basis \(V\) and coefficients \(s\) |
CTUniformBlockVector< T_value > | Class for a uniform block vector, e.g. of uniform sub blocks |
CTVTKCoordVis | Coordinate visualisation in VTK format |
CTVTKGridVis | Class for grid visualisation in VTK format |
Cvalue_type< T > | |
►Cvector< T > | STL class |
CTPermutation | Describes permutation of index sets |
►Cvector< Node * > | |
CLocalGraph | |