Classes | |
class | AnasaziParam |
Parameters for Anasazi package. More... | |
class | ArpackSolver |
Driver for ARPARK solvers. More... | |
class | Array |
Multi-dimensional Array. More... | |
class | Array3D |
3D array. More... | |
class | Array4D |
4D array. More... | |
class | ArrayColComplexSparse |
class | ArrayColSparse |
class | ArrayColSymComplexSparse |
class | ArrayColSymSparse |
class | ArrayRowComplexSparse |
class | ArrayRowSparse |
class | ArrayRowSymComplexSparse |
class | ArrayRowSymSparse |
class | ArrowCol |
class | BandedCol |
class | CallocAlloc |
class | class_SeldonConjTrans |
class | class_SeldonLeft |
class | class_SeldonNonUnit |
class | class_SeldonNoTrans |
class | class_SeldonRight |
class | class_SeldonTrans |
class | class_SeldonUnit |
class | ClassComplexType |
workaround class to retrieve double type from complex<double> More... | |
class | ClassComplexType< complex< T > > |
workaround class to retrieve double type from complex<double> More... | |
class | ColComplexSparse |
class | ColHerm |
class | ColHermPacked |
class | Collection |
class | ColLoTriang |
class | ColLoTriangPacked |
class | ColMajor |
class | ColMajorCollection |
class | ColSparse |
class | ColSym |
class | ColSymComplexSparse |
class | ColSymPacked |
class | ColSymPackedCollection |
class | ColSymSparse |
class | ColUpTriang |
class | ColUpTriangPacked |
class | ColUpTriangPackedCollection |
class | DenseEigenProblem |
computation of a few eigenvalues for dense matrices More... | |
class | DenseSparseCollection |
class | DistributedCholeskySolver |
class | DistributedMatrix |
matrix distributed over all the processors More... | |
class | DistributedMatrix_Base |
Base class for distributed matrix over all the processors. More... | |
class | DistributedMatrixIntegerArray |
class storing arrays needed for a distributed matrix More... | |
class | DistributedVector |
class storing a vector distributed over all the processors More... | |
class | EigenProblem_Base |
Base class to solve an eigenvalue problem. More... | |
class | EigenvalueComparisonClass |
base class for setting comparison between eigenvalues More... | |
class | Error |
class | FeastParam |
parameters for Feast package More... | |
class | FloatDouble |
class | General |
class | GeneralEigenProblem |
class for solving a general eigenproblem with parameter T (double or complex) More... | |
class | GeneralEigenProblem_Base |
Base class to solve a general eigenvalue problem (linear or not) More... | |
class | Hermitian |
class | HeterogeneousMatrixCollection |
Matrix class made of an heterogeneous collection of matrices. More... | |
class | HyprePreconditioner |
class interfacing Hypre with Seldon (as a preconditioner) More... | |
class | IlutPreconditioning |
class | IOError |
class | Iteration |
Class containing parameters for an iterative resolution. More... | |
class | LapackError |
class | LapackInfo |
class | MallocAlloc |
class | MallocObject |
class | Matrix |
class | Matrix< FloatDouble, General, DenseSparseCollection, Allocator< double > > |
Heterogeneous matrix collection class. More... | |
class | Matrix< T, General, ArrowCol, Allocator > |
arrow matrix stored by columns More... | |
class | Matrix< T, General, BandedCol, Allocator > |
banded matrix stored by columns (Lapack format) More... | |
class | Matrix< T, Prop, ArrayColComplexSparse, Allocator > |
Column-major sparse-matrix class. More... | |
class | Matrix< T, Prop, ArrayColSparse, Allocator > |
Column-major sparse-matrix class. More... | |
class | Matrix< T, Prop, ArrayColSymComplexSparse, Allocator > |
Column-major symmetric sparse-matrix class. More... | |
class | Matrix< T, Prop, ArrayColSymSparse, Allocator > |
Column-major symmetric sparse-matrix class. More... | |
class | Matrix< T, Prop, ArrayRowComplexSparse, Allocator > |
Row-major sparse-matrix class. More... | |
class | Matrix< T, Prop, ArrayRowSparse, Allocator > |
Row-major sparse-matrix class. More... | |
class | Matrix< T, Prop, ArrayRowSymComplexSparse, Allocator > |
Row-major symmetric sparse-matrix class. More... | |
class | Matrix< T, Prop, ArrayRowSymSparse, Allocator > |
Row-major symmetric sparse-matrix class. More... | |
class | Matrix< T, Prop, ColComplexSparse, Allocator > |
Column-major sparse-matrix class. More... | |
class | Matrix< T, Prop, ColHerm, Allocator > |
Column-major hermitian full-matrix class. More... | |
class | Matrix< T, Prop, ColHermPacked, Allocator > |
Column-major hermitian packed matrix class. More... | |
class | Matrix< T, Prop, ColLoTriang, Allocator > |
Column-major lower-triangular full-matrix class. More... | |
class | Matrix< T, Prop, ColLoTriangPacked, Allocator > |
Column-major lower-triangular packed matrix class. More... | |
class | Matrix< T, Prop, ColMajor, Allocator > |
Column-major full-matrix class. More... | |
class | Matrix< T, Prop, ColMajorCollection, Allocator > |
Column-major matrix collection class. More... | |
class | Matrix< T, Prop, ColSparse, Allocator > |
Column-major sparse-matrix class. More... | |
class | Matrix< T, Prop, ColSym, Allocator > |
Column-major symmetric full-matrix class. More... | |
class | Matrix< T, Prop, ColSymComplexSparse, Allocator > |
Column-major complex sparse-matrix class. More... | |
class | Matrix< T, Prop, ColSymPacked, Allocator > |
Column-major symmetric packed matrix class. More... | |
class | Matrix< T, Prop, ColSymPackedCollection, Allocator > |
Symetric column-major matrix collection class. More... | |
class | Matrix< T, Prop, ColSymSparse, Allocator > |
Column-major sparse-matrix class. More... | |
class | Matrix< T, Prop, ColUpTriang, Allocator > |
Column-major upper-triangular full-matrix class. More... | |
class | Matrix< T, Prop, ColUpTriangPacked, Allocator > |
Column-major upper-triangular packed matrix class. More... | |
class | Matrix< T, Prop, PETScMPIAIJ, Allocator > |
class | Matrix< T, Prop, PETScMPIDense, Allocator > |
class | Matrix< T, Prop, PETScSeqDense, Allocator > |
class | Matrix< T, Prop, RowComplexSparse, Allocator > |
Row-major sparse-matrix class. More... | |
class | Matrix< T, Prop, RowHerm, Allocator > |
Row-major hermitian full-matrix class. More... | |
class | Matrix< T, Prop, RowHermPacked, Allocator > |
Row-major hermitian packed matrix class. More... | |
class | Matrix< T, Prop, RowLoTriang, Allocator > |
Row-major lower-triangular full-matrix class. More... | |
class | Matrix< T, Prop, RowLoTriangPacked, Allocator > |
Row-major lower-triangular packed matrix class. More... | |
class | Matrix< T, Prop, RowMajor, Allocator > |
Row-major full-matrix class. More... | |
class | Matrix< T, Prop, RowMajorCollection, Allocator > |
Row-major matrix collection class. More... | |
class | Matrix< T, Prop, RowSparse, Allocator > |
Row-major sparse-matrix class. More... | |
class | Matrix< T, Prop, RowSym, Allocator > |
Row-major symmetric full-matrix class. More... | |
class | Matrix< T, Prop, RowSymComplexSparse, Allocator > |
Row-major complex sparse-matrix class. More... | |
class | Matrix< T, Prop, RowSymPacked, Allocator > |
Row-major symmetric packed matrix class. More... | |
class | Matrix< T, Prop, RowSymPackedCollection, Allocator > |
Symetric row-major matrix collection class. More... | |
class | Matrix< T, Prop, RowSymSparse, Allocator > |
Row-major sparse-matrix class. More... | |
class | Matrix< T, Prop, RowUpTriang, Allocator > |
Row-major upper-triangular full-matrix class. More... | |
class | Matrix< T, Prop, RowUpTriangPacked, Allocator > |
Row-major upper-triangular packed matrix class. More... | |
class | Matrix< T, Prop, SubStorage< M >, Allocator > |
Sub-matrix class. More... | |
class | Matrix_ArrayComplexSparse |
Sparse Array-matrix class. More... | |
class | Matrix_ArraySparse |
Sparse Array-matrix class. More... | |
class | Matrix_Arrow |
base class for arrow matrix (banded matrix + dense columns/rows) More... | |
class | Matrix_Band |
base class for a banded-matrix More... | |
class | Matrix_Base |
Base class for all matrices. More... | |
class | Matrix_ComplexSparse |
Complex sparse-matrix class. More... | |
class | Matrix_Hermitian |
Hermitian matrix stored in a full matrix. More... | |
class | Matrix_HermPacked |
Hermitian packed matrix class. More... | |
class | Matrix_Pointers |
Full matrix class. More... | |
class | Matrix_Sparse |
Sparse-matrix class. More... | |
class | Matrix_SymComplexSparse |
Symmetric complex sparse-matrix class. More... | |
class | Matrix_Symmetric |
Symmetric matrix stored in a full matrix. More... | |
class | Matrix_SymPacked |
Symmetric packed matrix class. More... | |
class | Matrix_SymSparse |
Symmetric sparse-matrix class. More... | |
class | Matrix_TriangPacked |
Triangular packed matrix class. More... | |
class | Matrix_Triangular |
Triangular matrix stored in a full matrix. More... | |
class | MatrixCholmod |
Object containing Cholesky factorization. More... | |
class | MatrixCollection |
Matrix class made of a collection of matrices. More... | |
class | MatrixFreeEigenProblem |
computation of a few eigenvalues with only matrix-vector product More... | |
class | MatrixMumps |
object used to solve linear system by calling mumps subroutines More... | |
class | MatrixPardiso |
class | MatrixPastix |
class | MatrixSuperLU |
empty matrix More... | |
class | MatrixSuperLU< complex< double > > |
class interfacing SuperLU functions in complex double precision More... | |
class | MatrixSuperLU< double > |
class interfacing SuperLU functions in double precision More... | |
class | MatrixSuperLU_Base |
class interfacing SuperLU functions More... | |
class | MatrixUmfPack |
empty class More... | |
class | MatrixUmfPack< complex< double > > |
class to solve linear system in complex double precision with UmfPack More... | |
class | MatrixUmfPack< double > |
class to solve linear system in double precision with UmfPack More... | |
class | MatrixUmfPack_Base |
< base class to solve linear system by using UmfPack More... | |
class | MatrixWsmp |
struct | MySlepcOperator |
class | NaNAlloc |
struct | NepSlepcOperator |
class for matshell operator for NEP solver More... | |
struct | NepSlepcPreconditioning |
class for preconditioning for NEP solver More... | |
class | NewAlloc |
class | NLoptSolver |
NLopt optimization. More... | |
class | NoMemory |
class | PetscMatrix |
Matrix class based on PETSc matrix. More... | |
class | PETScMPIAIJ |
class | PETScMPIDense |
class | PETScPar |
class | PETScSeq |
class | PETScSeqDense |
class | PETScVector |
PETSc vector class. More... | |
class | PolynomialDenseEigenProblem |
implementation of polynomial eigenvalue solver for dense problem More... | |
class | PolynomialEigenProblem |
matrix-free implementation of polynomial eigenvalue solver More... | |
class | PolynomialEigenProblem_Base |
Base class for polynomial eigenvalue solver. More... | |
class | PolynomialSparseEigenProblem |
implementation of sparse polynomial eigenvalue solver More... | |
class | Preconditioner_Base |
Base class for preconditioners. More... | |
class | RowComplexSparse |
class | RowHerm |
class | RowHermPacked |
class | RowLoTriang |
class | RowLoTriangPacked |
class | RowMajor |
class | RowMajorCollection |
class | RowSparse |
class | RowSym |
class | RowSymComplexSparse |
class | RowSymPacked |
class | RowSymPackedCollection |
class | RowSymSparse |
class | RowUpTriang |
class | RowUpTriangPacked |
class | RowUpTriangPackedCollection |
class | SeldonConjugate |
class | SeldonDefaultAllocator |
Selection of default allocator depending on storage and value type. More... | |
class | SeldonDefaultAllocator< ArrayColComplexSparse, complex< double > > |
class | SeldonDefaultAllocator< ArrayColComplexSparse, complex< float > > |
class | SeldonDefaultAllocator< ArrayColComplexSparse, complex< long double > > |
class | SeldonDefaultAllocator< ArrayColComplexSparse, T > |
for complex sparse matrix, the allocator involves real numbers More... | |
class | SeldonDefaultAllocator< ArrayColSymComplexSparse, complex< double > > |
class | SeldonDefaultAllocator< ArrayColSymComplexSparse, complex< float > > |
class | SeldonDefaultAllocator< ArrayColSymComplexSparse, complex< long double > > |
class | SeldonDefaultAllocator< ArrayColSymComplexSparse, T > |
for complex sparse matrix, the allocator involves real numbers More... | |
class | SeldonDefaultAllocator< ArrayRowComplexSparse, complex< double > > |
class | SeldonDefaultAllocator< ArrayRowComplexSparse, complex< float > > |
class | SeldonDefaultAllocator< ArrayRowComplexSparse, complex< long double > > |
class | SeldonDefaultAllocator< ArrayRowComplexSparse, T > |
for complex sparse matrix, the allocator involves real numbers More... | |
class | SeldonDefaultAllocator< ArrayRowSymComplexSparse, complex< double > > |
class | SeldonDefaultAllocator< ArrayRowSymComplexSparse, complex< float > > |
class | SeldonDefaultAllocator< ArrayRowSymComplexSparse, complex< long double > > |
class | SeldonDefaultAllocator< ArrayRowSymComplexSparse, T > |
for complex sparse matrix, the allocator involves real numbers More... | |
class | SeldonDefaultAllocator< ColComplexSparse, complex< double > > |
class | SeldonDefaultAllocator< ColComplexSparse, complex< float > > |
class | SeldonDefaultAllocator< ColComplexSparse, complex< long double > > |
class | SeldonDefaultAllocator< ColComplexSparse, T > |
for complex sparse matrix, the allocator involves real numbers More... | |
class | SeldonDefaultAllocator< ColSymComplexSparse, complex< double > > |
class | SeldonDefaultAllocator< ColSymComplexSparse, complex< float > > |
class | SeldonDefaultAllocator< ColSymComplexSparse, complex< long double > > |
class | SeldonDefaultAllocator< ColSymComplexSparse, T > |
for complex sparse matrix, the allocator involves real numbers More... | |
class | SeldonDefaultAllocator< RowComplexSparse, complex< double > > |
class | SeldonDefaultAllocator< RowComplexSparse, complex< float > > |
class | SeldonDefaultAllocator< RowComplexSparse, complex< long double > > |
class | SeldonDefaultAllocator< RowComplexSparse, T > |
for complex sparse matrix, the allocator involves real numbers More... | |
class | SeldonDefaultAllocator< RowSymComplexSparse, complex< double > > |
class | SeldonDefaultAllocator< RowSymComplexSparse, complex< float > > |
class | SeldonDefaultAllocator< RowSymComplexSparse, complex< long double > > |
class | SeldonDefaultAllocator< RowSymComplexSparse, T > |
for complex sparse matrix, the allocator involves real numbers More... | |
class | SeldonDefaultAllocator< Storage, bool > |
class | SeldonDefaultAllocator< Storage, char > |
class | SeldonDefaultAllocator< Storage, complex< double > > |
class | SeldonDefaultAllocator< Storage, complex< float > > |
class | SeldonDefaultAllocator< Storage, complex< long double > > |
class | SeldonDefaultAllocator< Storage, double > |
class | SeldonDefaultAllocator< Storage, float > |
class | SeldonDefaultAllocator< Storage, int > |
class | SeldonDefaultAllocator< Storage, long > |
class | SeldonDefaultAllocator< Storage, long double > |
class | SeldonDefaultAllocator< Storage, long long > |
class | SeldonDefaultAllocator< Storage, unsigned > |
class | SeldonDefaultAllocator< Storage, unsigned long > |
class | SeldonDefaultAllocator< Storage, unsigned long long > |
class | SeldonDiag |
class | SeldonNorm |
class | SeldonSide |
class | SeldonTranspose |
class | SeldonUplo |
class | SlepcParam |
Parameters for Slepc package. More... | |
class | SlepcParamPep |
Parameters for Slepc package. More... | |
class | SolverDivergenceError |
class | SolverMaximumIterationError |
class | SorPreconditioner |
class | SparseCholeskySolver |
Class grouping different Cholesky solvers. More... | |
class | SparseDirectSolver |
Class grouping different direct solvers. More... | |
class | SparseDistributedSolver |
general class for direct solver More... | |
class | SparseEigenProblem |
computation of a few eigenvalues for sparse matrices More... | |
class | SparseMatrixOrdering |
Basic class grouping different ordering strategies. More... | |
class | SparseSeldonSolver |
Default solver in Seldon. More... | |
class | Str |
This class helps formatting C++ strings on the fly. More... | |
class | SubMatrix |
Sub-matrix class. More... | |
class | SubMatrix_Base |
Sub-matrix base class. More... | |
class | SubStorage |
class | Symmetric |
class | TinyMatrix |
empty class overloaded for general and symmetric matrices More... | |
class | TinyMatrix< T, General, m, n > |
Class storing small matrices whose number of rows and columns is known at compilation time. More... | |
class | TinyMatrix< T, Symmetric, m, m > |
class storing tiny small matrices More... | |
class | TinyMatrixDifference |
Difference between two expressions. More... | |
class | TinyMatrixDivision |
Division between two expressions (elementwise) More... | |
class | TinyMatrixDoubleLoop |
class for double loop in matrix functions More... | |
class | TinyMatrixDoubleLoop< p, 0 > |
class for terminating double loops More... | |
class | TinyMatrixExpression |
Expression between vectors. More... | |
class | TinyMatrixLoop |
class for simple loops for matrix operations More... | |
class | TinyMatrixLoop< 0 > |
class terminating simple loops for matrix operations More... | |
class | TinyMatrixNode |
class | TinyMatrixNode< General, m, n, p > |
class used to obtain (i,j) from data[p] More... | |
class | TinyMatrixNode< Symmetric, m, m, 0 > |
class | TinyMatrixNode< Symmetric, m, m, p > |
class used to obtain (i,j) from data[p] More... | |
class | TinyMatrixOpposite |
Opposite of a matrix. More... | |
class | TinyMatrixProduct |
Product between two expressions (elementwise) More... | |
class | TinyMatrixScalDiff |
Subtraction between a scalar and a matrix. More... | |
class | TinyMatrixScalDiv |
Division between a scalar and a matrix. More... | |
class | TinyMatrixScaled |
Multiplication between a scalar and a matrix. More... | |
class | TinyMatrixScalSum |
Addition between a scalar and a matrix. More... | |
class | TinyMatrixSum |
Sum between two expressions. More... | |
class | TinyMatrixTranspose |
Transpose of a matrix. More... | |
class | TinyMatrixTripleLoop |
class for triple loop in matrix functions More... | |
class | TinyMatrixTripleLoop< p, q, 0 > |
class terminating triple loop in matrix functions More... | |
class | TinyVector |
vector with real/complex components More... | |
class | TinyVector< int, m_ > |
vector with integer components More... | |
class | TinyVector_Base |
Class storing a tiny vector whose size is known at compilation time. More... | |
class | TinyVectorDifference |
Difference between two expressions. More... | |
class | TinyVectorDivision |
Division between two expressions (elementwise) More... | |
class | TinyVectorExpression |
Expression between vectors. More... | |
class | TinyVectorLoop |
class used for unrolling loops for operators/functions of TinyVector More... | |
class | TinyVectorLoop< 0 > |
Class used to terminate the loop. More... | |
class | TinyVectorOpposite |
Opposite of a vector. More... | |
class | TinyVectorProduct |
Product between two expressions (elementwise) More... | |
class | TinyVectorScalDiff |
Subtraction between a scalar and a vector. More... | |
class | TinyVectorScalDiv |
Division between a scalar and a vector. More... | |
class | TinyVectorScaled |
Multiplication between a scalar and a vector. More... | |
class | TinyVectorScalSum |
Addition between a scalar and a vector. More... | |
class | TinyVectorSum |
Sum between two expressions. More... | |
class | TypeEigenvalueSolver |
list of availables eigenvalue solvers More... | |
class | TypeMumps |
class | TypeMumps< complex< double > > |
class containing MUMPS data structure More... | |
class | TypeMumps< double > |
class containing MUMPS data structure More... | |
class | Undefined |
class | VectFull |
class | Vector |
class | Vector2 |
Vector of vectors. More... | |
class | Vector3 |
Vector of vectors of vectors. More... | |
class | Vector< FloatDouble, DenseSparseCollection, Allocator< T > > |
Structure for distributed vectors. More... | |
class | Vector< T, Collection, Allocator > |
Structure for distributed vectors. More... | |
class | Vector< T, PETScPar, Allocator > |
class | Vector< T, PETScSeq, Allocator > |
class | Vector< T, VectFull, Allocator > |
Full vector class. More... | |
class | Vector< T, VectSparse, Allocator > |
Sparse vector class. More... | |
class | Vector_Base |
Base structure for all vectors. More... | |
class | VectorDifference |
Difference between two expressions. More... | |
class | VectorDivision |
Division between two expressions (elementwise) More... | |
class | VectorExpression |
Expression between vectors. More... | |
class | VectorOpposite |
Opposite of a vector. More... | |
class | VectorProduct |
Product between two expressions (elementwise) More... | |
class | VectorScalDiff |
Subtraction between a scalar and a vector. More... | |
class | VectorScalDiv |
Division between a scalar and a vector. More... | |
class | VectorScaled |
Multiplication between a scalar and a vector. More... | |
class | VectorScalSum |
Addition between a scalar and a vector. More... | |
class | VectorSum |
Sum between two expressions. More... | |
class | VectSparse |
class | VirtualEigenProblem |
base class for eigenvalue problems More... | |
class | VirtualMatrix |
Abstract base class for all matrices. More... | |
class | VirtualSparseDirectSolver |
Base class for an interface with a direct solver. More... | |
class | WrongArgument |
class | WrongCol |
class | WrongDim |
class | WrongIndex |
class | WrongRow |
Typedefs | |
typedef double | Real_wp |
typedef std::complex< double > | Complex_wp |
typedef Array3D< int > | IArr3D |
typedef Vector< int, VectFull > | IVect |
typedef Vector< float, VectFull > | SVect |
typedef Vector< double, VectFull > | DVect |
typedef Vector< complex< float >, VectFull > | CVect |
typedef Vector< complex< double >, VectFull > | ZVect |
typedef Matrix< int, General, ColMajor > | IGCMat |
typedef Matrix< float, General, ColMajor > | SGCMat |
typedef Matrix< double, General, ColMajor > | DGCMat |
typedef Matrix< complex< float >, General, ColMajor > | CGCMat |
typedef Matrix< complex< double >, General, ColMajor > | ZGCMat |
typedef Matrix< int, General, RowMajor > | IGRMat |
typedef Matrix< float, General, RowMajor > | SGRMat |
typedef Matrix< double, General, RowMajor > | DGRMat |
typedef Matrix< complex< float >, General, RowMajor > | CGRMat |
typedef Matrix< complex< double >, General, RowMajor > | ZGRMat |
typedef Matrix< int, General, RowSparse > | IGRSMat |
typedef Matrix< float, General, RowSparse > | SGRSMat |
typedef Matrix< double, General, RowSparse > | DGRSMat |
typedef Matrix< complex< float >, General, RowSparse > | CGRSMat |
typedef Matrix< complex< double >, General, RowSparse > | ZGRSMat |
typedef Matrix< int, General, ColSparse > | IGCSMat |
typedef Matrix< float, General, ColSparse > | SGCSMat |
typedef Matrix< double, General, ColSparse > | DGCSMat |
typedef Matrix< complex< float >, General, ColSparse > | CGCSMat |
typedef Matrix< complex< double >, General, ColSparse > | ZGCSMat |
Functions | |
template<class T , int N, class Allocator > | |
ostream & | operator<< (ostream &out, const Array< T, N, Allocator > &A) |
operator<< overloaded for a 3D array. More... | |
template<class T , class Allocator > | |
ostream & | operator<< (ostream &out, const Array3D< T, Allocator > &A) |
operator<< overloaded for a 3D array. More... | |
template<class T0 , class T , class Allocator > | |
void | MltScalar (const T0 &alpha, Array3D< T, Allocator > &A) |
Multiplication of all elements of a 3D array by a scalar. More... | |
template<class T , class Allocator > | |
ostream & | operator<< (ostream &out, const Array4D< T, Allocator > &A) |
operator<< overloaded for a 4D array. More... | |
template<class T0 , class Prop0 , class Storage0 , class Allocator0 > | |
void | SolveLU (const Matrix< T0, Prop0, Storage0, Allocator0 > &A, const Vector< int > &pivot, Vector< complex< T0 > > &x) |
template<class T0 , class Storage0 , class Allocator0 > | |
void | SolveLU (const SeldonTranspose &trans, const Matrix< T0, General, Storage0, Allocator0 > &A, const Vector< int > &pivot, Vector< complex< T0 > > &x) |
template<class T0 , class Storage0 , class Allocator0 > | |
void | SolveLU (const SeldonTranspose &trans, const Matrix< T0, Symmetric, Storage0, Allocator0 > &A, const Vector< int > &pivot, Vector< complex< T0 > > &x) |
template<class T , class Allocator > | |
void | Mlt (const T &alpha, Array3D< T, Allocator > &A) |
template<class T , class Allocator > | |
void | Mlt (const T &alpha, Array3D< complex< T >, Allocator > &A) |
template<class T , class T0 , class Storage , class Allocator > | |
void | Mlt (const T &alpha, Vector< T0, Storage, Allocator > &A) |
template<class T , class Storage , class Allocator > | |
void | Mlt (const T &alpha, Vector< complex< T >, Storage, Allocator > &A) |
template<class T , class Storage1 , class Allocator1 , class Storage2 , class Allocator2 > | |
void | Add (const T &alpha, const Vector< T, Storage1, Allocator1 > &X, Vector< T, Storage2, Allocator2 > &Y) |
template<class T , class Storage1 , class Allocator1 , class Storage2 , class Allocator2 > | |
void | Add (const T &alpha, const Vector< complex< T >, Storage1, Allocator1 > &X, Vector< complex< T >, Storage2, Allocator2 > &Y) |
template<class T , class Storage1 , class Allocator1 , class Storage2 , class Allocator2 > | |
void | Add (const T &alpha, const Vector< T, Storage1, Allocator1 > &X, const T &beta, Vector< T, Storage2, Allocator2 > &Y) |
template<class T , class Storage1 , class Allocator1 , class Storage2 , class Allocator2 > | |
void | Copy (const Vector< T, Storage1, Allocator1 > &X, Vector< T, Storage2, Allocator2 > &Y) |
template<class T , class Storage1 , class Allocator1 , class Storage2 , class Allocator2 > | |
T | DotProd (const Vector< T, Storage1, Allocator1 > &X, const Vector< T, Storage2, Allocator2 > &Y) |
template<class T , class Storage1 , class Allocator1 , class Storage2 , class Allocator2 > | |
T | DotProdConj (const Vector< T, Storage1, Allocator1 > &X, const Vector< T, Storage2, Allocator2 > &Y) |
template<class T , class Storage1 , class Allocator1 , class Storage2 , class Allocator2 > | |
complex< T > | DotProdConj (const Vector< complex< T >, Storage1, Allocator1 > &X, const Vector< complex< T >, Storage2, Allocator2 > &Y) |
template<class T , class Storage1 , class Allocator1 , class Storage2 , class Allocator2 > | |
complex< T > | DotProdConj (const Vector< complex< T >, Storage1, Allocator1 > &X, const Vector< T, Storage2, Allocator2 > &Y) |
template<class T , class Storage1 , class Allocator1 , class Storage2 , class Allocator2 > | |
complex< T > | DotProdConj (const Vector< T, Storage1, Allocator1 > &X, const Vector< complex< T >, Storage2, Allocator2 > &Y) |
template<class T , class E > | |
ClassComplexType< T >::Treal | Norm1 (const VectorExpression< T, E > &X) |
returns 1-norm of an expression with vectors | |
template<class T , class E > | |
ClassComplexType< T >::Treal | Norm2 (const VectorExpression< T, E > &X) |
returns 2-norm of an expression with vectors | |
template<class T0 , class Prop0 , class Storage0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 > | |
void | Mlt (const Matrix< T0, Prop0, Storage0, Allocator0 > &M, const Vector< T1, Storage1, Allocator1 > &X, Vector< T2, Storage2, Allocator2 > &Y) |
template<class T , class Prop0 , class Storage0 , class Allocator0 , class Storage1 , class Allocator1 , class Storage2 , class Allocator2 > | |
void | Mlt (const Matrix< complex< T >, Prop0, Storage0, Allocator0 > &M, const Vector< T, Storage1, Allocator1 > &X, Vector< T, Storage2, Allocator2 > &Y) |
template<class T , class Prop0 , class Storage0 , class Allocator0 , class Storage1 , class Allocator1 , class Storage2 , class Allocator2 > | |
void | Mlt (const Matrix< T, Prop0, Storage0, Allocator0 > &M, const Vector< complex< T >, Storage1, Allocator1 > &X, Vector< complex< T >, Storage2, Allocator2 > &Y) |
template<class T0 , class T1 , class Prop1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 , class Storage3 , class Allocator3 > | |
void | Mlt (const T0 &alpha, const Matrix< T1, Prop1, Storage1, Allocator1 > &M, const Vector< T2, Storage2, Allocator2 > &X, Vector< T3, Storage3, Allocator3 > &Y) |
template<class T , class Prop1 , class Storage1 , class Allocator1 , class Storage2 , class Allocator2 , class Storage3 , class Allocator3 > | |
void | Mlt (const complex< T > &alpha, const Matrix< T, Prop1, Storage1, Allocator1 > &M, const Vector< complex< T >, Storage2, Allocator2 > &X, Vector< complex< T >, Storage3, Allocator3 > &Y) |
template<class T , class Prop1 , class Storage1 , class Allocator1 , class Storage2 , class Allocator2 , class Storage3 , class Allocator3 > | |
void | Mlt (const T &alpha, const Matrix< complex< T >, Prop1, Storage1, Allocator1 > &M, const Vector< T, Storage2, Allocator2 > &X, Vector< T, Storage3, Allocator3 > &Y) |
template<class T , class T1 , class Prop1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 , class T4 , class Storage4 , class Allocator4 > | |
void | MltAdd (const T &alpha, const Matrix< T1, Prop1, Storage1, Allocator1 > &M, const Vector< T2, Storage2, Allocator2 > &X, const T3 &beta, Vector< T4, Storage4, Allocator4 > &Y) |
template<class T , class Prop1 , class Storage1 , class Allocator1 , class Storage2 , class Allocator2 , class Storage4 , class Allocator4 > | |
void | MltAdd (const T &alpha, const Matrix< complex< T >, Prop1, Storage1, Allocator1 > &M, const Vector< complex< T >, Storage2, Allocator2 > &X, const T &beta, Vector< complex< T >, Storage4, Allocator4 > &Y) |
template<class T , class Prop1 , class Storage1 , class Allocator1 , class Storage2 , class Allocator2 , class Storage4 , class Allocator4 > | |
void | MltAdd (const T &alpha, const Matrix< T, Prop1, Storage1, Allocator1 > &M, const Vector< complex< T >, Storage2, Allocator2 > &X, const T &beta, Vector< complex< T >, Storage4, Allocator4 > &Y) |
template<class T , class Prop1 , class Storage1 , class Allocator1 , class Storage2 , class Allocator2 , class Storage4 , class Allocator4 > | |
void | MltAdd (const T &alpha, const Matrix< complex< T >, Prop1, Storage1, Allocator1 > &M, const Vector< T, Storage2, Allocator2 > &X, const T &beta, Vector< T, Storage4, Allocator4 > &Y) |
template<class T , class Prop1 , class Storage1 , class Allocator1 , class Storage2 , class Allocator2 , class Storage4 , class Allocator4 > | |
void | MltAdd (const complex< T > &alpha, const Matrix< T, Prop1, Storage1, Allocator1 > &M, const Vector< complex< T >, Storage2, Allocator2 > &X, const complex< T > &beta, Vector< complex< T >, Storage4, Allocator4 > &Y) |
template<class T , class Prop0 , class Storage0 , class Allocator0 , class Storage1 , class Allocator1 , class Storage2 , class Allocator2 > | |
void | SOR (const Matrix< T, Prop0, Storage0, Allocator0 > &M, Vector< T, Storage2, Allocator2 > &Y, const Vector< T, Storage1, Allocator1 > &X, const typename ClassComplexType< T >::Treal &omega, int iter, int type_ssor=2) |
template<class T , class Prop0 , class Storage0 , class Allocator0 , class Storage1 , class Allocator1 , class Storage2 , class Allocator2 > | |
void | SOR (const SeldonTranspose &, const Matrix< T, Prop0, Storage0, Allocator0 > &M, Vector< T, Storage2, Allocator2 > &Y, const Vector< T, Storage1, Allocator1 > &X, const typename ClassComplexType< T >::Treal &omega, int iter, int type_ssor=3) |
template<class T , class Prop0 , class Storage0 , class Allocator0 , class Storage1 , class Allocator1 , class Storage2 , class Allocator2 > | |
void | SOR (const Matrix< T, Prop0, Storage0, Allocator0 > &M, Vector< complex< T >, Storage2, Allocator2 > &Y, const Vector< complex< T >, Storage1, Allocator1 > &X, const typename ClassComplexType< T >::Treal &omega, int iter, int type_ssor=2) |
template<class T , class Prop0 , class Storage0 , class Allocator0 , class Storage1 , class Allocator1 , class Storage2 , class Allocator2 > | |
void | SOR (const SeldonTranspose &, const Matrix< T, Prop0, Storage0, Allocator0 > &M, Vector< complex< T >, Storage2, Allocator2 > &Y, const Vector< complex< T >, Storage1, Allocator1 > &X, const typename ClassComplexType< T >::Treal &omega, int iter, int type_ssor=3) |
template<class T , class Prop0 , class Storage0 , class Allocator0 , class Storage1 , class Allocator1 , class Storage2 , class Allocator2 > | |
void | SOR (const Matrix< complex< T >, Prop0, Storage0, Allocator0 > &M, Vector< T, Storage2, Allocator2 > &Y, const Vector< T, Storage1, Allocator1 > &X, const typename ClassComplexType< T >::Treal &omega, int iter, int type_ssor=2) |
template<class T , class Prop0 , class Storage0 , class Allocator0 , class Storage1 , class Allocator1 , class Storage2 , class Allocator2 > | |
void | SOR (const SeldonTranspose &, const Matrix< complex< T >, Prop0, Storage0, Allocator0 > &M, Vector< T, Storage2, Allocator2 > &Y, const Vector< T, Storage1, Allocator1 > &X, const typename ClassComplexType< T >::Treal &omega, int iter, int type_ssor=3) |
template<class T , class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const SeldonUplo &Uplo, const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< T, Prop0, RowSparse, Allocator0 > &A, const Vector< T, VectFull, Allocator1 > &X, Vector< T, VectFull, Allocator1 > &Y) |
template<class T , class Prop0 , class Storage0 , class Allocator0 , class Storage1 , class Allocator1 > | |
void | SolveLU (const Matrix< T, Prop0, Storage0, Allocator0 > &M, Vector< T, Storage1, Allocator1 > &Y) |
template<class T , class Prop0 , class Storage0 , class Allocator0 , class Storage1 , class Allocator1 > | |
void | SolveLU (const Matrix< complex< T >, Prop0, Storage0, Allocator0 > &M, Vector< T, Storage1, Allocator1 > &Y) |
template<class T , class Prop0 , class Storage0 , class Allocator0 , class Storage1 , class Allocator1 > | |
void | SolveLU (const Matrix< T, Prop0, Storage0, Allocator0 > &M, Vector< complex< T >, Storage1, Allocator1 > &Y) |
template<class T , class Prop0 , class Storage0 , class Allocator0 , class Storage1 , class Allocator1 > | |
void | SolveLU (const SeldonTranspose &transA, const Matrix< T, Prop0, Storage0, Allocator0 > &M, Vector< T, Storage1, Allocator1 > &Y) |
template<class T , class Prop0 , class Storage0 , class Allocator0 , class Storage1 , class Allocator1 > | |
void | SolveLU (const SeldonTranspose &transA, const Matrix< complex< T >, Prop0, Storage0, Allocator0 > &M, Vector< T, Storage1, Allocator1 > &Y) |
template<class T , class Prop0 , class Storage0 , class Allocator0 , class Storage1 , class Allocator1 > | |
void | SolveLU (const SeldonTranspose &transA, const Matrix< T, Prop0, Storage0, Allocator0 > &M, Vector< complex< T >, Storage1, Allocator1 > &Y) |
template<class T0 , class Prop0 , class Storage0 , class Allocator0 > | |
void | SolveLU (const Matrix< T0, Prop0, Storage0, Allocator0 > &A, const Vector< int > &pivot, Vector< T0 > &x) |
template<class T0 , class Prop0 , class Storage0 , class Allocator0 > | |
void | SolveLU (const Matrix< complex< T0 >, Prop0, Storage0, Allocator0 > &A, const Vector< int > &pivot, Vector< T0 > &x) |
template<class T0 , class Storage0 , class Allocator0 > | |
void | SolveLU (const SeldonTranspose &trans, const Matrix< T0, General, Storage0, Allocator0 > &A, const Vector< int > &pivot, Vector< T0 > &x) |
template<class T0 , class Storage0 , class Allocator0 > | |
void | SolveLU (const SeldonTranspose &trans, const Matrix< complex< T0 >, General, Storage0, Allocator0 > &A, const Vector< int > &pivot, Vector< T0 > &x) |
template<class T0 , class Storage0 , class Allocator0 > | |
void | SolveLU (const SeldonTranspose &trans, const Matrix< T0, Symmetric, Storage0, Allocator0 > &A, const Vector< int > &pivot, Vector< T0 > &x) |
template<class T0 , class Storage0 , class Allocator0 > | |
void | SolveLU (const SeldonTranspose &trans, const Matrix< complex< T0 >, Symmetric, Storage0, Allocator0 > &A, const Vector< int > &pivot, Vector< T0 > &x) |
template<class T , class Prop , class Storage , class Allocator > | |
void | Mlt (const T &alpha, Matrix< T, Prop, Storage, Allocator > &A) |
template<class T , class Prop , class Storage , class Allocator > | |
void | Mlt (const T &alpha, Matrix< complex< T >, Prop, Storage, Allocator > &A) |
template<class T , class Prop1 , class Storage1 , class Allocator1 , class Prop2 , class Storage2 , class Allocator2 , class Prop3 , class Storage3 , class Allocator3 > | |
void | Mlt (const T &alpha, const Matrix< T, Prop1, Storage1, Allocator1 > &A, const Matrix< T, Prop2, Storage2, Allocator2 > &B, Matrix< T, Prop3, Storage3, Allocator3 > &C) |
template<class T , class Prop0 , class Storage0 , class Allocator0 , class Prop1 , class Storage1 , class Allocator1 , class Prop2 , class Storage2 , class Allocator2 > | |
void | Mlt (const Matrix< T, Prop0, Storage0, Allocator0 > &A, const Matrix< T, Prop1, Storage1, Allocator1 > &B, Matrix< T, Prop2, Storage2, Allocator2 > &C) |
template<class T , class Prop1 , class Storage1 , class Allocator1 , class Prop2 , class Storage2 , class Allocator2 , class Prop3 , class Storage3 , class Allocator3 > | |
void | MltAdd (const T &alpha, const Matrix< T, Prop1, Storage1, Allocator1 > &A, const Matrix< T, Prop2, Storage2, Allocator2 > &B, const T &beta, Matrix< T, Prop3, Storage3, Allocator3 > &C) |
template<class T , class Prop1 , class Storage1 , class Allocator1 , class Prop2 , class Storage2 , class Allocator2 , class Prop3 , class Storage3 , class Allocator3 > | |
void | MltAdd (const T &alpha, const SeldonTranspose &transA, const Matrix< T, Prop1, Storage1, Allocator1 > &A, const SeldonTranspose &transB, const Matrix< T, Prop2, Storage2, Allocator2 > &B, const T &beta, Matrix< T, Prop3, Storage3, Allocator3 > &C) |
template<class T , class Prop1 , class Storage1 , class Allocator1 , class Prop2 , class Storage2 , class Allocator2 > | |
void | Add (const T &alpha, const Matrix< T, Prop1, Storage1, Allocator1 > &A, Matrix< T, Prop2, Storage2, Allocator2 > &B) |
template<class T , class Prop1 , class Storage1 , class Allocator1 , class Prop2 , class Storage2 , class Allocator2 > | |
void | Add (const complex< T > &alpha, const Matrix< T, Prop1, Storage1, Allocator1 > &A, Matrix< complex< T >, Prop2, Storage2, Allocator2 > &B) |
template<class T , class Prop1 , class Storage1 , class Allocator1 , class Prop2 , class Storage2 , class Allocator2 > | |
void | Add (const T &alpha, const Matrix< complex< T >, Prop1, Storage1, Allocator1 > &A, Matrix< complex< T >, Prop2, Storage2, Allocator2 > &B) |
template<class T , class Prop1 , class Storage1 , class Allocator1 , class Prop2 , class Storage2 , class Allocator2 > | |
void | Add (const T &alpha, const Matrix< complex< T >, Prop1, Storage1, Allocator1 > &A, Matrix< T, Prop2, Storage2, Allocator2 > &B) |
template<class T , class Prop1 , class Storage1 , class Allocator1 , class Prop2 , class Storage2 , class Allocator2 > | |
void | Copy (const Matrix< T, Prop1, Storage1, Allocator1 > &A, Matrix< T, Prop2, Storage2, Allocator2 > &B) |
template<class T , class Prop1 , class Storage1 , class Allocator1 , class Prop2 , class Storage2 , class Allocator2 > | |
void | Copy (const Matrix< complex< T >, Prop1, Storage1, Allocator1 > &A, Matrix< T, Prop2, Storage2, Allocator2 > &B) |
template<class T , class Prop1 , class Storage1 , class Allocator1 , class Prop2 , class Storage2 , class Allocator2 > | |
void | Copy (const Matrix< T, Prop1, Storage1, Allocator1 > &A, Matrix< complex< T >, Prop2, Storage2, Allocator2 > &B) |
template<class T , class Prop , class Storage , class Allocator > | |
bool | IsSymmetricMatrix (const Matrix< T, Prop, Storage, Allocator > &A) |
returns true if the matrix is symmetric | |
template<class T , class Storage , class Allocator > | |
bool | IsSymmetricMatrix (const Matrix< T, Symmetric, Storage, Allocator > &A) |
returns true if the matrix is symmetric | |
template<class T , class Prop , class Storage , class Allocator > | |
bool | IsComplexMatrix (const Matrix< T, Prop, Storage, Allocator > &A) |
returns true if the matrix is complex | |
template<class T , class Prop , class Storage , class Allocator > | |
bool | IsComplexMatrix (const Matrix< complex< T >, Prop, Storage, Allocator > &A) |
returns true if the matrix is complex | |
template<class T , class Prop1 , class Storage1 , class Allocator1 , class Storage2 , class Allocator2 , class Storage3 , class Allocator3 > | |
void | Mlt (const SeldonTranspose &Trans, const Matrix< T, Prop1, Storage1, Allocator1 > &M, const Vector< T, Storage2, Allocator2 > &X, Vector< T, Storage3, Allocator3 > &Y) |
template<class T , class Prop1 , class Storage1 , class Allocator1 , class Storage2 , class Allocator2 , class Storage3 , class Allocator3 > | |
void | Mlt (const SeldonTranspose &Trans, const Matrix< complex< T >, Prop1, Storage1, Allocator1 > &M, const Vector< T, Storage2, Allocator2 > &X, Vector< T, Storage3, Allocator3 > &Y) |
template<class T , class Prop1 , class Storage1 , class Allocator1 , class Storage2 , class Allocator2 , class Storage3 , class Allocator3 > | |
void | Mlt (const SeldonTranspose &Trans, const Matrix< T, Prop1, Storage1, Allocator1 > &M, const Vector< complex< T >, Storage2, Allocator2 > &X, Vector< complex< T >, Storage3, Allocator3 > &Y) |
template<class T , class Prop1 , class Storage1 , class Allocator1 , class Storage2 , class Allocator2 , class Storage4 , class Allocator4 > | |
void | MltAdd (const T &alpha, const SeldonTranspose &Trans, const Matrix< T, Prop1, Storage1, Allocator1 > &M, const Vector< T, Storage2, Allocator2 > &X, const T &beta, Vector< T, Storage4, Allocator4 > &Y) |
template<class T , class Prop1 , class Storage1 , class Allocator1 , class Storage2 , class Allocator2 , class Storage4 , class Allocator4 > | |
void | MltAdd (const T &alpha, const SeldonTranspose &Trans, const Matrix< complex< T >, Prop1, Storage1, Allocator1 > &M, const Vector< complex< T >, Storage2, Allocator2 > &X, const T &beta, Vector< complex< T >, Storage4, Allocator4 > &Y) |
template<class T , class Prop1 , class Storage1 , class Allocator1 , class Storage2 , class Allocator2 , class Storage4 , class Allocator4 > | |
void | MltAdd (const T &alpha, const SeldonTranspose &Trans, const Matrix< T, Prop1, Storage1, Allocator1 > &M, const Vector< complex< T >, Storage2, Allocator2 > &X, const T &beta, Vector< complex< T >, Storage4, Allocator4 > &Y) |
template<class T , class Prop1 , class Storage1 , class Allocator1 , class Storage2 , class Allocator2 , class Storage4 , class Allocator4 > | |
void | MltAdd (const T &alpha, const SeldonTranspose &Trans, const Matrix< complex< T >, Prop1, Storage1, Allocator1 > &M, const Vector< T, Storage2, Allocator2 > &X, const T &beta, Vector< T, Storage4, Allocator4 > &Y) |
template<class T , class Prop1 , class Storage1 , class Allocator1 , class Storage2 , class Allocator2 , class Storage4 , class Allocator4 > | |
void | MltAdd (const complex< T > &alpha, const SeldonTranspose &Trans, const Matrix< T, Prop1, Storage1, Allocator1 > &M, const Vector< complex< T >, Storage2, Allocator2 > &X, const complex< T > &beta, Vector< complex< T >, Storage4, Allocator4 > &Y) |
template<class T0 , class T1 , class Prop1 , class Storage1 , class Allocator1 > | |
void | MltScalar (const T0 &alpha, Matrix< T1, Prop1, Storage1, Allocator1 > &A) throw () |
Multiplies a matrix by a scalar. More... | |
template<class T0 , class T1 , class Prop1 , class Allocator1 > | |
void | MltScalar (const T0 &alpha, Matrix< T1, Prop1, ColMajorCollection, Allocator1 > &A) |
Multiplies a matrix by a scalar. More... | |
template<class T0 , class T1 , class Prop1 , class Allocator1 > | |
void | MltScalar (const T0 &alpha, Matrix< T1, Prop1, RowMajorCollection, Allocator1 > &A) |
Multiplies a matrix by a scalar. More... | |
template<class T0 , class Allocator > | |
void | MltScalar (const T0 &alpha, Matrix< FloatDouble, General, DenseSparseCollection, Allocator > &A) |
Multiplies a FloatDouble collection by a scalar. More... | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 , class T2 , class Prop2 , class Allocator2 > | |
void | MltMatrix (const Matrix< T0, Prop0, RowSparse, Allocator0 > &A, const Matrix< T1, Prop1, RowSparse, Allocator1 > &B, Matrix< T2, Prop2, RowSparse, Allocator2 > &C) |
Multiplies two row-major sparse matrices in Harwell-Boeing format. More... | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 , class T2 , class Prop2 , class Allocator2 > | |
void | MltMatrix (const Matrix< T0, Prop0, RowMajor, Allocator0 > &A, const Matrix< T1, Prop1, RowSparse, Allocator1 > &B, Matrix< T2, Prop2, RowMajor, Allocator2 > &C) |
Multiplies two row-major sparse matrices in Harwell-Boeing format. More... | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 , class T2 , class Prop2 , class Allocator2 > | |
void | MltMatrix (const class_SeldonNoTrans &, const Matrix< T0, Prop0, RowMajor, Allocator0 > &A, const class_SeldonTrans &, const Matrix< T1, Prop1, RowSparse, Allocator1 > &B, Matrix< T2, Prop2, RowMajor, Allocator2 > &C) |
Multiplies two row-major sparse matrices in Harwell-Boeing format. More... | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 , class T2 , class Prop2 , class Allocator2 > | |
void | MltMatrix (const class_SeldonNoTrans &, const Matrix< T0, Prop0, RowSparse, Allocator0 > &A, const class_SeldonTrans &, const Matrix< T1, Prop1, RowSparse, Allocator1 > &B, Matrix< T2, Prop2, RowSparse, Allocator2 > &C) |
Multiplies two row-major sparse matrices in Harwell-Boeing format. More... | |
template<class T0 , class T1 , class Prop1 , class Storage1 , class Allocator1 , class T2 , class Prop2 , class Storage2 , class Allocator2 , class T3 , class T4 , class Prop4 , class Storage4 , class Allocator4 > | |
void | MltAddMatrix (const T0 &alpha, const Matrix< T1, Prop1, Storage1, Allocator1 > &A, const Matrix< T2, Prop2, Storage2, Allocator2 > &B, const T3 &beta, Matrix< T4, Prop4, Storage4, Allocator4 > &C) |
Multiplies two matrices, and adds the result to a third matrix. More... | |
template<class T0 , class T1 , class Prop1 , class Storage1 , class Allocator1 , class T2 , class Prop2 , class Storage2 , class Allocator2 , class T3 , class T4 , class Prop4 , class Storage4 , class Allocator4 > | |
void | MltAddMatrix (const T0 &alpha, const SeldonTranspose &TransA, const Matrix< T1, Prop1, Storage1, Allocator1 > &A, const SeldonTranspose &TransB, const Matrix< T2, Prop2, Storage2, Allocator2 > &B, const T3 &beta, Matrix< T4, Prop4, Storage4, Allocator4 > &C) |
Multiplies two matrices, and adds the result to a third matrix. More... | |
template<class T0 , class T1 , class Prop1 , class Allocator1 , class T2 , class Allocator2 , class T3 , class T4 , class Prop4 , class Allocator4 > | |
void | MltAddMatrix (const T0 &alpha, const Matrix< T1, Prop1, PETScMPIDense, Allocator1 > &A, const Matrix< T2, General, RowMajor, Allocator2 > &B, const T3 &beta, Matrix< T4, Prop4, PETScMPIDense, Allocator4 > &C) |
Multiplies two matrices, and adds the result to a third matrix. More... | |
template<class T0 , class T1 , class Prop1 , class Allocator1 , class T2 , class Prop2 , class Allocator2 , class T3 , class T4 , class Prop4 , class Allocator4 > | |
void | MltAddMatrix (const T0 &alpha, const Matrix< T1, Prop1, RowMajorCollection, Allocator1 > &A, const Matrix< T2, Prop2, RowMajorCollection, Allocator2 > &B, const T3 &beta, Matrix< T4, Prop4, RowMajorCollection, Allocator4 > &C) |
Multiplies two matrices, and adds the result to a third matrix. More... | |
template<class T0 , class T1 , class Prop1 , class Allocator1 , class T2 , class Prop2 , class Allocator2 , class T3 , class T4 , class Prop4 , class Allocator4 > | |
void | MltAddMatrix (const T0 &alpha, const Matrix< T1, Prop1, ColMajorCollection, Allocator1 > &A, const Matrix< T2, Prop2, ColMajorCollection, Allocator2 > &B, const T3 &beta, Matrix< T4, Prop4, ColMajorCollection, Allocator4 > &C) |
Multiplies two matrices, and adds the result to a third matrix. More... | |
template<class T0 , class T1 , class Allocator1 , class T2 , class Allocator2 , class T3 , class T4 , class Allocator4 > | |
void | MltAddMatrix (const T0 &alpha, const Matrix< T1, General, RowMajor, Allocator1 > &A, const Matrix< T2, General, RowMajor, Allocator2 > &B, const T3 &beta, Matrix< T4, General, RowSparse, Allocator4 > &C) |
template<class T0 , class T1 , class Allocator1 , class T2 , class Allocator2 , class T3 , class T4 , class Allocator4 > | |
void | MltAddMatrix (const T0 &alpha, const Matrix< T1, General, RowMajor, Allocator1 > &A, const Matrix< T2, General, RowSparse, Allocator2 > &B, const T3 &beta, Matrix< T4, General, RowSparse, Allocator4 > &C) |
template<class T0 , class T1 , class Allocator1 , class T2 , class Allocator2 , class T3 , class T4 , class Allocator4 > | |
void | MltAddMatrix (const T0 &alpha, const Matrix< T1, General, RowSparse, Allocator1 > &A, const Matrix< T2, General, RowMajor, Allocator2 > &B, const T3 &beta, Matrix< T4, General, RowSparse, Allocator4 > &C) |
template<class T0 , class Allocator1 , class Allocator2 , class Allocator3 , class T4 , class Prop4 , class Storage4 , class Allocator4 > | |
void | MltAdd_heterogeneous (const T0 &alpha, const Matrix< FloatDouble, General, DenseSparseCollection, Allocator1 > &A, const Matrix< FloatDouble, General, DenseSparseCollection, Allocator2 > &B, Matrix< FloatDouble, General, DenseSparseCollection, Allocator3 > &C, Matrix< T4, Prop4, Storage4, Allocator4 > &mc, int i, int j) |
template<class T0 , class T1 , class Prop1 , class Storage1 , class Allocator1 , class Allocator2 , class Allocator3 , class T4 , class Prop4 , class Storage4 , class Allocator4 > | |
void | MltAdd_heterogeneous2 (const T0 &alpha, const Matrix< T1, Prop1, Storage1, Allocator1 > &ma, const Matrix< FloatDouble, General, DenseSparseCollection, Allocator2 > &B, Matrix< FloatDouble, General, DenseSparseCollection, Allocator3 > &C, Matrix< T4, Prop4, Storage4, Allocator4 > &mc, int j, int k) |
template<class T0 , class Allocator1 , class Allocator2 , class T3 , class Allocator4 > | |
void | MltAddMatrix (const T0 &alpha, const Matrix< FloatDouble, General, DenseSparseCollection, Allocator1 > &A, const Matrix< FloatDouble, General, DenseSparseCollection, Allocator2 > &B, const T3 &beta, Matrix< FloatDouble, General, DenseSparseCollection, Allocator4 > &C) |
Multiplies a FloatDouble collection by a scalar. More... | |
template<class T0 , class T1 , class Prop1 , class Allocator1 , class T2 , class Prop2 , class Allocator2 , class T3 , class T4 , class Prop4 , class Allocator4 > | |
void | MltAddMatrix (const T0 &alpha, const Matrix< T1, Prop1, RowSparse, Allocator1 > &A, const Matrix< T2, Prop2, RowSparse, Allocator2 > &B, const T3 &beta, Matrix< T4, Prop4, RowSparse, Allocator4 > &C) |
Multiplies two row-major sparse matrices and adds the result to a third. More... | |
template<class T0 , class T1 , class Prop1 , class Allocator1 , class T2 , class Prop2 , class Allocator2 , class T3 , class T4 , class Prop4 , class Allocator4 > | |
void | MltAddMatrix (const T0 &alpha, const SeldonTranspose &TransA, const Matrix< T1, Prop1, RowSparse, Allocator1 > &A, const SeldonTranspose &TransB, const Matrix< T2, Prop2, RowSparse, Allocator2 > &B, const T3 &beta, Matrix< T4, Prop4, RowSparse, Allocator4 > &C) |
Multiplies two row-major sparse matrices and adds the result to a third. More... | |
template<class T0 , class T1 , class Prop1 , class Allocator1 , class T4 , class T2 , class Prop2 , class Storage2 , class Allocator2 , class T3 , class Prop3 , class Storage3 , class Allocator3 > | |
void | MltAddMatrix (const T0 &alpha, const Matrix< T1, Prop1, RowSparse, Allocator1 > &A, const Matrix< T2, Prop2, Storage2, Allocator2 > &B, const T4 &beta, Matrix< T3, Prop3, Storage3, Allocator3 > &C) |
Multiplies a RowSparse matrix with a dense matrix. | |
template<class T0 , class T1 , class Prop1 , class Allocator1 , class T4 , class T2 , class Prop2 , class Storage2 , class Allocator2 , class T3 , class Prop3 , class Storage3 , class Allocator3 > | |
void | MltAddMatrix (const T0 &alpha, const SeldonTranspose &TransA, const Matrix< T1, Prop1, RowSparse, Allocator1 > &A, const SeldonTranspose &TransB, const Matrix< T2, Prop2, Storage2, Allocator2 > &B, const T4 &beta, Matrix< T3, Prop3, Storage3, Allocator3 > &C) |
Multiplies a RowSparse matrix with a dense matrix | |
template<class T0 , class T1 , class Prop1 , class Allocator1 , class T2 , class Prop2 , class Allocator2 , class T3 , class T4 , class Prop4 , class Allocator4 > | |
void | MltAddMatrix (const T0 &alpha, const SeldonTranspose &TransA, const Matrix< T1, Prop1, RowMajor, Allocator1 > &A, const SeldonTranspose &TransB, const Matrix< T2, Prop2, RowSparse, Allocator2 > &B, const T3 &beta, Matrix< T4, Prop4, RowMajor, Allocator4 > &C) |
Multiplies a row-major matrix with a row-major sparse matrix and adds it to a third. More... | |
template<class T0 , class T1 , class Prop1 , class Storage1 , class Allocator1 , class T2 , class Prop2 , class Storage2 , class Allocator2 > | |
void | AddMatrix (const T0 &alpha, const Matrix< T1, Prop1, Storage1, Allocator1 > &A, Matrix< T2, Prop2, Storage2, Allocator2 > &B) |
Adds two matrices. More... | |
template<class T0 , class T1 , class Prop1 , class Allocator1 , class T2 , class Prop2 , class Allocator2 > | |
void | AddMatrix (const T0 &alpha, const Matrix< T1, Prop1, RowMajorCollection, Allocator1 > &A, Matrix< T2, Prop2, RowMajorCollection, Allocator2 > &B) |
Adds two matrices. More... | |
template<class T0 , class T1 , class Prop1 , class Allocator1 , class T2 , class Prop2 , class Allocator2 > | |
void | AddMatrix (const T0 &alpha, const Matrix< T1, Prop1, ColMajorCollection, Allocator1 > &A, Matrix< T2, Prop2, ColMajorCollection, Allocator2 > &B) |
Adds two matrices. More... | |
template<class T0 , class T1 , class Prop1 , class Storage1 , class Allocator1 , class Allocator2 > | |
void | Add_heterogeneous (const T0 &alpha, const Matrix< T1, Prop1, Storage1, Allocator1 > &ma, Matrix< FloatDouble, General, DenseSparseCollection, Allocator2 > &B, int i, int j) |
template<class T0 , class Allocator1 , class Allocator2 > | |
void | AddMatrix (const T0 &alpha, const Matrix< FloatDouble, General, DenseSparseCollection, Allocator1 > &A, Matrix< FloatDouble, General, DenseSparseCollection, Allocator2 > &B) |
Multiplies a FloatDouble collection by a scalar. More... | |
template<class T0 , class T1 , class Prop1 , class Allocator1 , class T2 , class Prop2 , class Allocator2 > | |
void | AddMatrix (const T0 &alpha, const Matrix< T1, Prop1, RowMajor, Allocator1 > &A, Matrix< T2, Prop2, RowSparse, Allocator2 > &B) |
template<class T0 , class T1 , class Prop1 , class Allocator1 , class T2 , class Prop2 , class Allocator2 > | |
void | AddMatrix (const T0 &alpha, const Matrix< T1, Prop1, ColMajor, Allocator1 > &A, Matrix< T2, Prop2, RowSparse, Allocator2 > &B) |
template<class T0 , class T1 , class Prop1 , class Allocator1 , class T2 , class Prop2 , class Storage , class Allocator2 > | |
void | Add_csr (const T0 &alpha, const Matrix< T1, Prop1, Storage, Allocator1 > &A, Matrix< T2, Prop2, Storage, Allocator2 > &B, int p) |
template<class T0 , class T1 , class Prop1 , class Allocator1 , class T2 , class Prop2 , class Allocator2 > | |
void | AddMatrix (const T0 &alpha, const Matrix< T1, Prop1, RowSparse, Allocator1 > &A, Matrix< T2, Prop2, RowSparse, Allocator2 > &B) |
Adds two matrices. More... | |
template<class T0 , class T1 , class Prop1 , class Allocator1 , class T2 , class Prop2 , class Allocator2 > | |
void | AddMatrix (const T0 &alpha, const Matrix< T1, Prop1, ColSparse, Allocator1 > &A, Matrix< T2, Prop2, ColSparse, Allocator2 > &B) |
Adds two matrices. More... | |
template<class T0 , class T1 , class Prop1 , class Allocator1 , class T2 , class Prop2 , class Allocator2 > | |
void | AddMatrix (const T0 &alpha, const Matrix< T1, Prop1, RowSymSparse, Allocator1 > &A, Matrix< T2, Prop2, RowSymSparse, Allocator2 > &B) |
Adds two matrices. More... | |
template<class T0 , class T1 , class Prop1 , class Allocator1 , class T2 , class Prop2 , class Allocator2 > | |
void | AddMatrix (const T0 &alpha, const Matrix< T1, Prop1, ColSymSparse, Allocator1 > &A, Matrix< T2, Prop2, ColSymSparse, Allocator2 > &B) |
Adds two matrices. More... | |
template<class T0 , class Prop0 , class Storage0 , class Allocator0 > | |
void | GetLU (Matrix< T0, Prop0, Storage0, Allocator0 > &A) |
Returns the LU factorization of a matrix. More... | |
template<class T0 , class Prop0 , class Storage0 , class Allocator0 , class T1 , class Prop1 , class Storage1 , class Allocator1 , class T2 , class Prop2 , class Storage2 , class Allocator2 > | |
void | CheckDim (const Matrix< T0, Prop0, Storage0, Allocator0 > &A, const Matrix< T1, Prop1, Storage1, Allocator1 > &B, const Matrix< T2, Prop2, Storage2, Allocator2 > &C, string function) |
Checks the compatibility of the dimensions. More... | |
template<class T0 , class Prop0 , class Storage0 , class Allocator0 , class T1 , class Prop1 , class Storage1 , class Allocator1 , class T2 , class Prop2 , class Storage2 , class Allocator2 > | |
void | CheckDim (const SeldonSide &side, const Matrix< T0, Prop0, Storage0, Allocator0 > &A, const Matrix< T1, Prop1, Storage1, Allocator1 > &B, const Matrix< T2, Prop2, Storage2, Allocator2 > &C, string function) |
Checks the compatibility of the dimensions. More... | |
template<class T0 , class Prop0 , class Storage0 , class Allocator0 , class T1 , class Prop1 , class Storage1 , class Allocator1 > | |
void | CheckDim (const SeldonTranspose &TransA, const Matrix< T0, Prop0, Storage0, Allocator0 > &A, const SeldonTranspose &TransB, const Matrix< T1, Prop1, Storage1, Allocator1 > &B, string function) |
Checks the compatibility of the dimensions. More... | |
template<class T0 , class Prop0 , class Storage0 , class Allocator0 , class T1 , class Prop1 , class Storage1 , class Allocator1 , class T2 , class Prop2 , class Storage2 , class Allocator2 > | |
void | CheckDim (const SeldonTranspose &TransA, const Matrix< T0, Prop0, Storage0, Allocator0 > &A, const SeldonTranspose &TransB, const Matrix< T1, Prop1, Storage1, Allocator1 > &B, const Matrix< T2, Prop2, Storage2, Allocator2 > &C, string function) |
Checks the compatibility of the dimensions. More... | |
template<class T0 , class Prop0 , class Storage0 , class Allocator0 , class T1 , class Prop1 , class Storage1 , class Allocator1 > | |
void | CheckDim (const Matrix< T0, Prop0, Storage0, Allocator0 > &A, const Matrix< T1, Prop1, Storage1, Allocator1 > &B, string function) |
Checks the compatibility of the dimensions. More... | |
template<class T0 , class Prop0 , class Storage0 , class Allocator0 , class T1 , class Prop1 , class Storage1 , class Allocator1 > | |
void | CheckDim (const SeldonSide &side, const Matrix< T0, Prop0, Storage0, Allocator0 > &A, const Matrix< T1, Prop1, Storage1, Allocator1 > &B, string function) |
Checks the compatibility of the dimensions. More... | |
template<class T , class Prop , class Storage , class Allocator > | |
ClassComplexType< T >::Treal | MaxAbs (const Matrix< T, Prop, Storage, Allocator > &A) |
Returns the maximum (in absolute value) of a matrix. More... | |
template<class T , class Prop , class Storage , class Allocator > | |
ClassComplexType< T >::Treal | Norm1 (const Matrix< T, Prop, Storage, Allocator > &A) |
Returns the 1-norm of a matrix. More... | |
template<class T , class Prop , class Storage , class Allocator > | |
ClassComplexType< T >::Treal | NormInf (const Matrix< T, Prop, Storage, Allocator > &A) |
Returns the infinity-norm of a matrix. More... | |
template<class T , class Prop , class Allocator > | |
ClassComplexType< T >::Treal | MaxAbs (const Matrix< T, Prop, RowSparse, Allocator > &A) |
Returns the maximum (in absolute value) of a matrix. More... | |
template<class T , class Prop , class Allocator > | |
ClassComplexType< T >::Treal | Norm1 (const Matrix< T, Prop, RowSparse, Allocator > &A) |
Returns the 1-norm of a matrix. More... | |
template<class T , class Prop , class Allocator > | |
ClassComplexType< T >::Treal | NormInf (const Matrix< T, Prop, RowSparse, Allocator > &A) |
Returns the infinity-norm of a matrix. More... | |
template<class T , class Prop , class Allocator > | |
ClassComplexType< T >::Treal | MaxAbs (const Matrix< T, Prop, ColSparse, Allocator > &A) |
Returns the maximum (in absolute value) of a matrix. More... | |
template<class T , class Prop , class Allocator > | |
ClassComplexType< T >::Treal | Norm1 (const Matrix< T, Prop, ColSparse, Allocator > &A) |
Returns the 1-norm of a matrix. More... | |
template<class T , class Prop , class Allocator > | |
ClassComplexType< T >::Treal | NormInf (const Matrix< T, Prop, ColSparse, Allocator > &A) |
Returns the infinity-norm of a matrix. More... | |
template<class T , class Prop , class Allocator > | |
ClassComplexType< T >::Treal | MaxAbs (const Matrix< T, Prop, RowSymSparse, Allocator > &A) |
Returns the maximum (in absolute value) of a matrix. More... | |
template<class T , class Prop , class Allocator > | |
ClassComplexType< T >::Treal | Norm1 (const Matrix< T, Prop, RowSymSparse, Allocator > &A) |
Returns the 1-norm of a matrix. More... | |
template<class T , class Prop , class Allocator > | |
ClassComplexType< T >::Treal | NormInf (const Matrix< T, Prop, RowSymSparse, Allocator > &A) |
Returns the infinity-norm of a matrix. More... | |
template<class T , class Prop , class Allocator > | |
ClassComplexType< T >::Treal | MaxAbs (const Matrix< T, Prop, ColSymSparse, Allocator > &A) |
Returns the maximum (in absolute value) of a matrix. More... | |
template<class T , class Prop , class Allocator > | |
ClassComplexType< T >::Treal | Norm1 (const Matrix< T, Prop, ColSymSparse, Allocator > &A) |
Returns the 1-norm of a matrix. More... | |
template<class T , class Prop , class Allocator > | |
ClassComplexType< T >::Treal | NormInf (const Matrix< T, Prop, ColSymSparse, Allocator > &A) |
Returns the infinity-norm of a matrix. More... | |
template<class T , class Prop , class Storage , class Allocator > | |
void | Transpose (Matrix< T, Prop, Storage, Allocator > &A) |
Matrix transposition. | |
template<class T , class Prop , class Storage , class Allocator > | |
void | Transpose (const Matrix< T, Prop, Storage, Allocator > &A, Matrix< T, Prop, Storage, Allocator > &B) |
Matrix transposition. | |
template<class T , class Storage , class Allocator > | |
void | Transpose (Matrix< T, Symmetric, Storage, Allocator > &A) |
Matrix transposition. | |
template<class T , class Storage , class Allocator > | |
void | Transpose (Matrix< T, Hermitian, Storage, Allocator > &A) |
Matrix transposition. | |
template<class T , class Storage , class Allocator > | |
void | Transpose (const Matrix< T, Symmetric, Storage, Allocator > &A, Matrix< T, Symmetric, Storage, Allocator > &B) |
Matrix transposition. | |
template<class T , class Storage , class Allocator > | |
void | Transpose (const Matrix< T, Hermitian, Storage, Allocator > &A, Matrix< T, Hermitian, Storage, Allocator > &B) |
Matrix transposition. | |
template<class T , class Allocator > | |
void | Transpose (const Matrix< T, General, RowSparse, Allocator > &A, Matrix< T, General, RowSparse, Allocator > &B) |
Matrix transposition. | |
template<class T , class Allocator > | |
void | Transpose (Matrix< T, General, RowSparse, Allocator > &A) |
Matrix transposition. | |
template<class T , class Allocator > | |
void | Transpose (const Matrix< T, General, ColSparse, Allocator > &A, Matrix< T, General, ColSparse, Allocator > &B) |
Matrix transposition. | |
template<class T , class Allocator > | |
void | Transpose (Matrix< T, General, ColSparse, Allocator > &A) |
Matrix transposition. | |
template<class T , class Prop , class Storage , class Allocator > | |
void | Conjugate (Matrix< T, Prop, Storage, Allocator > &A) |
A is replaced by its conjugate. | |
template<class T , class Prop , class Storage , class Allocator > | |
void | TransposeConj (const Matrix< T, Prop, Storage, Allocator > &A, Matrix< T, Prop, Storage, Allocator > &B) |
Matrix transposition and conjugation. | |
template<class T , class Prop , class Storage , class Allocator > | |
void | TransposeConj (Matrix< T, Prop, Storage, Allocator > &A) |
Matrix transposition and conjugation. | |
template<class T1 , class Prop1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T4 , class Storage4 , class Allocator4 > | |
void | MltVector (const Matrix< T1, Prop1, RowSparse, Allocator1 > &M, const Vector< T2, Storage2, Allocator2 > &X, Vector< T4, Storage4, Allocator4 > &Y) |
template<class T1 , class Prop1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T4 , class Storage4 , class Allocator4 > | |
void | MltVector (const Matrix< T1, Prop1, ColSparse, Allocator1 > &M, const Vector< T2, Storage2, Allocator2 > &X, Vector< T4, Storage4, Allocator4 > &Y) |
template<class T1 , class Prop1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T4 , class Storage4 , class Allocator4 > | |
void | MltVector (const Matrix< T1, Prop1, RowSymSparse, Allocator1 > &M, const Vector< T2, Storage2, Allocator2 > &X, Vector< T4, Storage4, Allocator4 > &Y) |
template<class T1 , class Prop1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T4 , class Storage4 , class Allocator4 > | |
void | MltVector (const Matrix< T1, Prop1, ColSymSparse, Allocator1 > &M, const Vector< T2, Storage2, Allocator2 > &X, Vector< T4, Storage4, Allocator4 > &Y) |
template<class T1 , class Prop1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T4 , class Storage4 , class Allocator4 > | |
void | MltVector (const SeldonTranspose &Trans, const Matrix< T1, Prop1, RowSparse, Allocator1 > &M, const Vector< T2, Storage2, Allocator2 > &X, Vector< T4, Storage4, Allocator4 > &Y) |
template<class T1 , class Prop1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T4 , class Storage4 , class Allocator4 > | |
void | MltVector (const SeldonTranspose &Trans, const Matrix< T1, Prop1, ColSparse, Allocator1 > &M, const Vector< T2, Storage2, Allocator2 > &X, Vector< T4, Storage4, Allocator4 > &Y) |
template<class T1 , class Prop1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T4 , class Storage4 , class Allocator4 > | |
void | MltVector (const SeldonTranspose &Trans, const Matrix< T1, Prop1, RowSymSparse, Allocator1 > &M, const Vector< T2, Storage2, Allocator2 > &X, Vector< T4, Storage4, Allocator4 > &Y) |
template<class T1 , class Prop1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T4 , class Storage4 , class Allocator4 > | |
void | MltVector (const SeldonTranspose &Trans, const Matrix< T1, Prop1, ColSymSparse, Allocator1 > &M, const Vector< T2, Storage2, Allocator2 > &X, Vector< T4, Storage4, Allocator4 > &Y) |
template<class T1 , class Prop1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T4 , class Storage4 , class Allocator4 > | |
void | MltVector (const Matrix< T1, Prop1, Storage1, Allocator1 > &M, const Vector< T2, Storage2, Allocator2 > &X, Vector< T4, Storage4, Allocator4 > &Y) |
template<class T1 , class Prop1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T4 , class Storage4 , class Allocator4 > | |
void | MltVector (const SeldonTranspose &Trans, const Matrix< T1, Prop1, Storage1, Allocator1 > &M, const Vector< T2, Storage2, Allocator2 > &X, Vector< T4, Storage4, Allocator4 > &Y) |
template<class T0 , class T1 , class Prop1 , class Allocator1 , class T2 , class Allocator2 , class T3 , class T4 , class Allocator4 > | |
void | MltAddVector (const T0 &alpha, const Matrix< T1, Prop1, PETScMPIAIJ, Allocator1 > &M, const Vector< T2, PETScSeq, Allocator2 > &X, const T3 &beta, Vector< T4, PETScSeq, Allocator4 > &Y) |
template<class T0 , class T1 , class Prop1 , class Allocator1 , class T2 , class Allocator2 , class T3 , class T4 , class Allocator4 > | |
void | MltAddVector (const T0 &alpha, const Matrix< T1, Prop1, PETScMPIAIJ, Allocator1 > &M, const Vector< T2, PETScPar, Allocator2 > &X, const T3 &beta, Vector< T4, PETScPar, Allocator4 > &Y) |
template<class T0 , class T1 , class Prop1 , class Allocator1 , class T2 , class Allocator2 , class T3 , class T4 , class Allocator4 > | |
void | MltAddVector (const T0 &alpha, const Matrix< T1, Prop1, PETScMPIAIJ, Allocator1 > &M, const Vector< T2, VectFull, Allocator2 > &X, const T3 &beta, Vector< T4, PETScSeq, Allocator4 > &Y) |
template<class T0 , class T1 , class Prop1 , class Allocator1 , class T2 , class Allocator2 , class T3 , class T4 , class Allocator4 > | |
void | MltAddVector (const T0 &alpha, const Matrix< T1, Prop1, PETScMPIAIJ, Allocator1 > &M, const Vector< T2, VectFull, Allocator2 > &X, const T3 &beta, Vector< T4, PETScPar, Allocator4 > &Y) |
template<class T0 , class T1 , class Prop1 , class Allocator1 , class T2 , class Allocator2 , class T3 , class T4 , class Allocator4 > | |
void | MltAddVector (const T0 &alpha, const Matrix< T1, Prop1, PETScMPIDense, Allocator1 > &M, const Vector< T2, VectFull, Allocator2 > &X, const T3 &beta, Vector< T4, PETScPar, Allocator4 > &Y) |
template<class T0 , class T1 , class Prop1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 , class T4 , class Storage4 , class Allocator4 > | |
void | MltAddVector (const T0 &alpha, const Matrix< T1, Prop1, RowSparse, Allocator1 > &M, const Vector< T2, Storage2, Allocator2 > &X, const T3 &beta, Vector< T4, Storage4, Allocator4 > &Y) |
template<class T0 , class T1 , class Prop1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 , class T4 , class Allocator4 > | |
void | MltAddVector (const T0 &alpha, const Matrix< T1, Prop1, RowSparse, Allocator1 > &M, const Vector< T2, Storage2, Allocator2 > &X, const T3 &beta, Vector< T4, Collection, Allocator4 > &Y) |
template<class T0 , class T1 , class Prop1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 , class T4 , class Storage4 , class Allocator4 > | |
void | MltAddVector (const T0 &alpha, const Matrix< T1, Prop1, ColSparse, Allocator1 > &M, const Vector< T2, Storage2, Allocator2 > &X, const T3 &beta, Vector< T4, Storage4, Allocator4 > &Y) |
template<class T0 , class T1 , class Prop1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 , class T4 , class Storage4 , class Allocator4 > | |
void | MltAddVector (const T0 &alpha, const Matrix< T1, Prop1, RowSymSparse, Allocator1 > &M, const Vector< T2, Storage2, Allocator2 > &X, const T3 &beta, Vector< T4, Storage4, Allocator4 > &Y) |
template<class T0 , class T1 , class Prop1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 , class T4 , class Storage4 , class Allocator4 > | |
void | MltAddVector (const T0 &alpha, const Matrix< T1, Prop1, ColSymSparse, Allocator1 > &M, const Vector< T2, Storage2, Allocator2 > &X, const T3 &beta, Vector< T4, Storage4, Allocator4 > &Y) |
template<class T0 , class T1 , class Prop1 , class Allocator1 , class T2 , class Allocator2 , class T3 , class T4 , class Allocator4 > | |
void | MltAddVector (const T0 &alpha, const Matrix< T1, Prop1, RowSymSparse, Allocator1 > &M, const Vector< T2, Collection, Allocator2 > &X, const T3 &beta, Vector< T4, Collection, Allocator4 > &Y) |
template<class T0 , class T1 , class Prop1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 , class T4 , class Allocator4 > | |
void | MltAddVector (const T0 &alpha, const Matrix< T1, Prop1, RowSymSparse, Allocator1 > &M, const Vector< T2, Storage2, Allocator2 > &X, const T3 &beta, Vector< T4, Collection, Allocator4 > &Y) |
template<class T0 , class T1 , class Prop1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 , class T4 , class Storage4 , class Allocator4 > | |
void | MltAddVector (const T0 &alpha, const SeldonTranspose &Trans, const Matrix< T1, Prop1, RowSparse, Allocator1 > &M, const Vector< T2, Storage2, Allocator2 > &X, const T3 &beta, Vector< T4, Storage4, Allocator4 > &Y) |
template<class T0 , class T1 , class Prop1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 , class T4 , class Storage4 , class Allocator4 > | |
void | MltAddVector (const T0 &alpha, const SeldonTranspose &Trans, const Matrix< T1, Prop1, ColSparse, Allocator1 > &M, const Vector< T2, Storage2, Allocator2 > &X, const T3 &beta, Vector< T4, Storage4, Allocator4 > &Y) |
template<class T0 , class T1 , class Prop1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 , class T4 , class Storage4 , class Allocator4 > | |
void | MltAddVector (const T0 &alpha, const SeldonTranspose &Trans, const Matrix< T1, Prop1, RowSymSparse, Allocator1 > &M, const Vector< T2, Storage2, Allocator2 > &X, const T3 &beta, Vector< T4, Storage4, Allocator4 > &Y) |
template<class T0 , class T1 , class Prop1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 , class T4 , class Storage4 , class Allocator4 > | |
void | MltAddVector (const T0 &alpha, const SeldonTranspose &Trans, const Matrix< T1, Prop1, ColSymSparse, Allocator1 > &M, const Vector< T2, Storage2, Allocator2 > &X, const T3 &beta, Vector< T4, Storage4, Allocator4 > &Y) |
template<class T0 , class T1 , class Prop1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 , class T4 , class Storage4 , class Allocator4 > | |
void | MltAddVector (const T0 &alpha, const Matrix< T1, Prop1, Storage1, Allocator1 > &M, const Vector< T2, Storage2, Allocator2 > &X, const T3 &beta, Vector< T4, Storage4, Allocator4 > &Y) |
Performs the multiplication of a matrix with a vector, and adds the result to another vector. More... | |
template<class T0 , class T1 , class Prop1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 , class T4 , class Allocator4 > | |
void | MltAddVector (const T0 &alpha, const Matrix< T1, Prop1, Storage1, Allocator1 > &M, const Vector< T2, Storage2, Allocator2 > &X, const T3 &beta, Vector< T4, Collection, Allocator4 > &Y) |
Performs the multiplication of a matrix with a vector, and adds the result to another vector. More... | |
template<class T0 , class T1 , class Prop1 , class Allocator1 , class T2 , class Allocator2 , class T3 , class T4 , class Allocator4 > | |
void | MltAddVector (const T0 &alpha, const Matrix< T1, Prop1, RowMajorCollection, Allocator1 > &M, const Vector< T2, Collection, Allocator2 > &X, const T3 &beta, Vector< T4, Collection, Allocator4 > &Y) |
Performs the multiplication of a matrix collection with a vector collection, and adds the result to another vector. More... | |
template<class T0 , class T1 , class Prop1 , class Allocator1 , class T2 , class Allocator2 , class T3 , class T4 , class Allocator4 > | |
void | MltAddVector (const T0 &alpha, const Matrix< T1, Prop1, ColMajorCollection, Allocator1 > &M, const Vector< T2, Collection, Allocator2 > &X, const T3 &beta, Vector< T4, Collection, Allocator4 > &Y) |
Performs the multiplication of a matrix collection with a vector collection, and adds the result to another vector. More... | |
template<class T0 , class T1 , class Prop1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 , class T4 , class Storage4 , class Allocator4 > | |
void | MltAddVector (const T0 &alpha, const SeldonTranspose &Trans, const Matrix< T1, Prop1, Storage1, Allocator1 > &M, const Vector< T2, Storage2, Allocator2 > &X, const T3 &beta, Vector< T4, Storage4, Allocator4 > &Y) |
Performs the multiplication of a matrix (possibly transposed) with a vector, and adds the result to another vector. More... | |
template<class T0 , class Prop0 , class Storage0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 > | |
void | Gauss (Matrix< T0, Prop0, Storage0, Allocator0 > &M, Vector< T1, Storage1, Allocator1 > &X) |
Solves M*Y = X with Gauss method. More... | |
template<class T0 , class Prop0 , class Storage0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 > | |
void | GaussSeidel (const Matrix< T0, Prop0, Storage0, Allocator0 > &M, Vector< T2, Storage2, Allocator2 > &Y, const Vector< T1, Storage1, Allocator1 > &X, int iter, int type_algo) |
Solve M*Y = X with Gauss-Seidel method. More... | |
template<class T0 , class Prop0 , class Storage0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 > | |
void | SorVector (const Matrix< T0, Prop0, Storage0, Allocator0 > &M, Vector< T2, Storage2, Allocator2 > &Y, const Vector< T1, Storage1, Allocator1 > &X, const T3 &omega, int iter, int type_ssor) |
Solve M Y = X with S.O.R. method. More... | |
template<class T0 , class Prop0 , class Storage0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 > | |
void | SorVector (const SeldonTranspose &transM, const Matrix< T0, Prop0, Storage0, Allocator0 > &M, Vector< T2, Storage2, Allocator2 > &Y, const Vector< T1, Storage1, Allocator1 > &X, const T3 &omega, int iter, int type_ssor) |
Solve M^T Y = X with S.O.R. method. More... | |
template<class T0 , class Prop0 , class Storage0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 > | |
void | SolveLuVector (const Matrix< T0, Prop0, Storage0, Allocator0 > &M, Vector< T1, Storage1, Allocator1 > &Y) |
Solves a linear system whose matrix has been LU-factorized. More... | |
template<class T0 , class Prop0 , class Storage0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 > | |
void | GetAndSolveLU (Matrix< T0, Prop0, Storage0, Allocator0 > &M, Vector< T1, Storage1, Allocator1 > &Y) |
Solves a linear system using LU factorization. More... | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Allocator1 > | |
void | SolveTriangular (const SeldonUplo &Uplo, const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< T0, Prop0, RowSparse, Allocator0 > &A, const Vector< T1, VectFull, Allocator1 > &X, Vector< T1, VectFull, Allocator1 > &Y) |
solves by triangular upper part or lower part of A | |
template<class T0 , class Prop0 , class Storage0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 > | |
void | CheckDim (const Matrix< T0, Prop0, Storage0, Allocator0 > &M, const Vector< T1, Storage1, Allocator1 > &X, const Vector< T2, Storage2, Allocator2 > &Y, string function) |
Checks the compatibility of the dimensions. More... | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Allocator1 , class T2 , class Allocator2 > | |
void | CheckDim (const Matrix< T0, Prop0, RowMajorCollection, Allocator0 > &M, const Vector< T1, Collection, Allocator1 > &X, const Vector< T2, Collection, Allocator2 > &Y, string function) |
Checks the compatibility of the dimensions. More... | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Allocator1 , class T2 , class Allocator2 > | |
void | CheckDim (const Matrix< T0, Prop0, ColMajorCollection, Allocator0 > &M, const Vector< T1, Collection, Allocator1 > &X, const Vector< T2, Collection, Allocator2 > &Y, string function) |
Checks the compatibility of the dimensions. More... | |
template<class T0 , class Prop0 , class Storage0 , class Allocator0 , class T1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 > | |
void | CheckDim (const Matrix< T0, Prop0, Storage0, Allocator0 > &M, const Vector< T1, Collection, Allocator1 > &X, const Vector< T2, Storage2, Allocator2 > &Y, string function) |
Checks the compatibility of the dimensions. More... | |
template<class T0 , class Prop0 , class Storage0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 > | |
void | CheckDim (const SeldonTranspose &trans, const Matrix< T0, Prop0, Storage0, Allocator0 > &M, const Vector< T1, Storage1, Allocator1 > &X, const Vector< T2, Storage2, Allocator2 > &Y, string function, string op) |
Checks the compatibility of the dimensions. More... | |
template<class T0 , class Prop0 , class Storage0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 > | |
void | CheckDim (const Matrix< T0, Prop0, Storage0, Allocator0 > &M, const Vector< T1, Storage1, Allocator1 > &X, string function, string op) |
Checks the compatibility of the dimensions. More... | |
template<class T0 , class T1 , class Storage1 , class Allocator1 > | |
void | MltScalar (const T0 &alpha, Vector< T1, Storage1, Allocator1 > &X) throw () |
Multiplication of a vector by a scalar. | |
template<class T0 , class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 > | |
void | AddVector (const T0 &alpha, const Vector< T1, Storage1, Allocator1 > &X, Vector< T2, Storage2, Allocator2 > &Y) |
Adds two vectors Y = Y + alpha X. | |
template<class T0 , class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 > | |
void | AddVector (const T0 &alpha, const Vector< T1, Storage1, Allocator1 > &X, const T0 &beta, Vector< T2, Storage2, Allocator2 > &Y) |
Adds two vectors Y = beta Y + alpha X. | |
template<class T0 , class T1 , class Allocator1 , class T2 , class Allocator2 > | |
void | AddVector (const T0 alpha, const Vector< T1, PETScSeq, Allocator1 > &X, Vector< T2, PETScSeq, Allocator2 > &Y) |
Adds two vectors Y = Y + alpha X. | |
template<class T0 , class T1 , class Allocator1 , class T2 , class Allocator2 > | |
void | AddVector (const T0 alpha, const Vector< T1, PETScPar, Allocator1 > &X, Vector< T2, PETScPar, Allocator2 > &Y) |
template<class T0 , class T1 , class Allocator1 , class T2 , class Allocator2 > | |
void | AddVector (const T0 &alpha, const Vector< T1, VectSparse, Allocator1 > &X, Vector< T2, VectSparse, Allocator2 > &Y) |
Adds two vectors Y = Y + alpha X. | |
template<class T0 , class T1 , class Allocator1 , class T2 , class Allocator2 > | |
void | AddVector (const T0 &alpha, const Vector< T1, VectSparse, Allocator1 > &X, Vector< T2, VectFull, Allocator2 > &Y) |
Adds two vectors Y = Y + alpha X. | |
template<class T0 , class T1 , class Allocator1 , class T2 , class Allocator2 > | |
void | AddVector (const T0 &alpha, const Vector< T1, Collection, Allocator1 > &X, Vector< T2, Collection, Allocator2 > &Y) |
Adds two vectors Y = Y + alpha X. | |
template<class T0 , class T1 , template< class U1 > class Allocator1, class T2 , template< class U2 > class Allocator2> | |
void | AddVector (const T0 &alpha, const Vector< FloatDouble, DenseSparseCollection, Allocator1< T1 > > &X, Vector< FloatDouble, DenseSparseCollection, Allocator2< T2 > > &Y) |
template<class T0 , class T1 , template< class U1 > class Allocator1, class T2 , class Storage2 , class Allocator2 > | |
void | AddVector (const T0 &alpha, const Vector< FloatDouble, DenseSparseCollection, Allocator1< T1 > > &X, Vector< T2, Storage2, Allocator2 > &Y) |
Adds two vectors Y = Y + alpha X. | |
template<class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 > | |
void | CopyVector (const Vector< T1, Storage1, Allocator1 > &X, Vector< T2, Storage2, Allocator2 > &Y) |
Y = X. | |
template<class T1 , class Allocator1 , class T2 , class Allocator2 > | |
void | CopyVector (const Vector< T1, Collection, Allocator1 > &X, Vector< T2, VectFull, Allocator2 > &Y) |
Y = X. | |
template<class T , class Alloc1 , class Alloc2 > | |
void | CopyVector (const Vector< T, PETScPar, Alloc1 > &A, Vector< T, VectFull, Alloc2 > &B) |
template<class T , class Alloc1 , class Alloc2 > | |
void | CopyVector (const Vector< T, VectFull, Alloc1 > &A, Vector< T, PETScPar, Alloc2 > &B) |
template<class T , class Storage , class Allocator > | |
void | Swap (Vector< T, Storage, Allocator > &X, Vector< T, Storage, Allocator > &Y) |
Swaps X and Y without copying all elements. | |
template<class T , class Allocator > | |
void | Swap (Vector< T, VectSparse, Allocator > &X, Vector< T, VectSparse, Allocator > &Y) |
Swaps X and Y without copying all elements. | |
template<class T > | |
void | SwapPointer (Vector< T > &X, Vector< T > &Y) |
Swaps X and Y with pointers. | |
template<class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 > | |
T1 | DotProdVector (const Vector< T1, Storage1, Allocator1 > &X, const Vector< T2, Storage2, Allocator2 > &Y) |
Scalar product between two vectors. | |
template<class T1 , class Allocator1 , class T2 , class Allocator2 > | |
T1::value_type | DotProdVector (const Vector< T1, Collection, Allocator1 > &X, const Vector< T2, Collection, Allocator2 > &Y) |
Scalar product between two vector collections. | |
template<class T1 , template< class U1 > class Allocator1, class T2 , template< class U2 > class Allocator2> | |
double | DotProdVector (const Vector< FloatDouble, DenseSparseCollection, Allocator1< T1 > > &X, const Vector< FloatDouble, DenseSparseCollection, Allocator2< T2 > > &Y) |
Scalar product between two vector collections. | |
template<class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 > | |
T1 | DotProdConjVector (const Vector< T1, Storage1, Allocator1 > &X, const Vector< T2, Storage2, Allocator2 > &Y) |
Scalar product between two vectors conj(X).Y . | |
template<class T1 , class Allocator1 , class T2 , class Allocator2 > | |
T1 | DotProdVector (const Vector< T1, VectSparse, Allocator1 > &X, const Vector< T2, VectSparse, Allocator2 > &Y) |
Scalar product between two sparse vectors. | |
template<class T1 , class Allocator1 , class T2 , class Allocator2 > | |
T1 | DotProdVector (const Vector< T1, VectSparse, Allocator1 > &X, const Vector< T2, VectFull, Allocator2 > &Y) |
Scalar product between a sparse vector and a dense vector. | |
template<class T1 , class Allocator1 , class T2 , class Allocator2 > | |
T1 | DotProdVector (const Vector< T1, VectFull, Allocator1 > &X, const Vector< T2, VectSparse, Allocator2 > &Y) |
Scalar product between a sparse vector and a dense vector. | |
template<class T1 , class Allocator1 , class T2 , class Allocator2 > | |
T1 | DotProdConjVector (const Vector< T1, VectSparse, Allocator1 > &X, const Vector< T2, VectSparse, Allocator2 > &Y) |
Scalar product between two sparse vectors conj(X).Y. | |
template<class T1 , class Allocator1 , class T2 , class Allocator2 > | |
T1 | DotProdConjVector (const Vector< T1, VectSparse, Allocator1 > &X, const Vector< T2, VectFull, Allocator2 > &Y) |
Scalar product between a sparse vector and dense one conj(X).Y. | |
template<class T1 , class Storage1 , class Allocator1 > | |
ClassComplexType< T1 >::Treal | Norm1 (const Vector< T1, Storage1, Allocator1 > &X) |
returns 1-norm of X More... | |
template<class T1 , class Allocator1 > | |
ClassComplexType< T1 >::Treal | Norm1 (const Vector< T1, VectSparse, Allocator1 > &X) |
returns 1-norm of X More... | |
template<class T1 , class Storage1 , class Allocator1 > | |
T1 | Norm2 (const Vector< T1, Storage1, Allocator1 > &X) |
returns 2-norm of X | |
template<class T1 , class Storage1 , class Allocator1 > | |
T1 | Norm2 (const Vector< complex< T1 >, Storage1, Allocator1 > &X) |
returns 2-norm of X | |
template<class T1 , class Allocator1 > | |
T1 | Norm2 (const Vector< T1, VectSparse, Allocator1 > &X) |
returns 2-norm of X | |
template<class T1 , class Allocator1 > | |
T1 | Norm2 (const Vector< complex< T1 >, VectSparse, Allocator1 > &X) |
returns 2-norm of X | |
template<class T , class Storage , class Allocator > | |
long | GetMaxAbsIndex (const Vector< T, Storage, Allocator > &X) |
returns index for which X(i) is maximal | |
template<class T > | |
void | GenRot (T &a_in, T &b_in, T &c_, T &s_) |
Computation of rotation between two points. | |
template<class T > | |
void | GenRot (complex< T > &a_in, complex< T > &b_in, T &c_, complex< T > &s_) |
Computation of rotation between two points. | |
template<class T > | |
void | ApplyRot (T &x, T &y, const T &c_, const T &s_) |
Rotation of a point in 2-D. | |
template<class T > | |
void | ApplyRot (complex< T > &x, complex< T > &y, const T &c_, const complex< T > &s_) |
Rotation of a complex point in 2-D. | |
template<class T , class Allocator1 , class Allocator2 > | |
void | ApplyRot (Vector< T, VectFull, Allocator1 > &X, Vector< T, VectFull, Allocator2 > &Y, const T &c, const T &s) |
Rotation of a vector of points in 2-D. | |
template<class T , class Allocator1 , class Allocator2 > | |
void | ApplyRot (Vector< T, VectSparse, Allocator1 > &X, Vector< T, VectFull, Allocator2 > &Y, const T &c, const T &s) |
Rotation of a vector of points in 2-D. | |
template<class T0 , class Storage0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 > | |
void | CheckDim (const Vector< T0, Storage0, Allocator0 > &X, const Vector< T1, Storage1, Allocator1 > &Y, string function, string op) |
Checks the compatibility of the dimensions. More... | |
template<class T0 , class Allocator0 , class T1 , class Allocator1 > | |
void | CheckDim (const Vector< T0, VectSparse, Allocator0 > &X, const Vector< T1, VectSparse, Allocator1 > &Y, string function, string op) |
Checks the compatibility of the dimensions. More... | |
template<class T0 , class Allocator0 , class T1 , class Allocator1 > | |
void | CheckDim (const Vector< T0, Collection, Allocator0 > &X, const Vector< T1, Collection, Allocator1 > &Y, string function, string op) |
Checks the compatibility of the dimensions. More... | |
template<class T0 , class Allocator0 , class Allocator00 , class T1 , class Allocator1 , class Allocator11 > | |
void | CheckDim (const Vector< Vector< T0, VectSparse, Allocator0 >, Collection, Allocator00 > &X, const Vector< Vector< T1, VectSparse, Allocator1 >, Collection, Allocator11 > &Y, string function, string op) |
Checks the compatibility of the dimensions. More... | |
template<class T0 , class Allocator0 , class T1 , class Allocator1 > | |
void | CheckDim (const Vector< T0, VectFull, Allocator0 > &X, Vector< T1, Collection, Allocator1 > &Y, string function, string op) |
Checks the compatibility of the dimensions. More... | |
template<class T0 , template< class U0 > class Allocator0, class T1 , template< class U1 > class Allocator1> | |
void | CheckDim (const Vector< FloatDouble, DenseSparseCollection, Allocator0< T0 > > &X, const Vector< FloatDouble, DenseSparseCollection, Allocator1< T1 > > &Y, string function, string op) |
Checks the compatibility of the dimensions. More... | |
template<class T , class Allocator1 , class Allocator2 > | |
void | GatherSparseEntry (const Vector< T, VectFull, Allocator1 > &Y, Vector< T, VectSparse, Allocator2 > &X) |
template<class T , class Allocator1 , class Allocator2 > | |
void | GatherSparseEntryZero (Vector< T, VectFull, Allocator1 > &Y, Vector< T, VectSparse, Allocator2 > &X) |
template<class T , class Allocator1 , class Allocator2 > | |
void | ScatterSparseEntry (const Vector< T, VectSparse, Allocator1 > &X, Vector< T, VectFull, Allocator2 > &Y) |
template<class T , class Prop , class Allocator > | |
void | Conjugate (Vector< T, Prop, Allocator > &X) |
Sets a vector to its conjugate. | |
template<class T , class Allocator > | |
void | Conjugate (Vector< T, VectSparse, Allocator > &X) |
Sets a vector to its conjugate. | |
void | GenRot (float &a, float &b, float &c, float &d) |
void | GenRot (double &a, double &b, double &c, double &d) |
void | GenModifRot (float &d1, float &d2, float &x1, const float &y1, float *param) |
void | GenModifRot (double &d1, double &d2, double &x1, const double &y1, double *param) |
template<class Allocator > | |
void | ApplyRot (Vector< float, VectFull, Allocator > &X, Vector< float, VectFull, Allocator > &Y, const float &c, const float &s) |
template<class Allocator > | |
void | ApplyRot (Vector< double, VectFull, Allocator > &X, Vector< double, VectFull, Allocator > &Y, const double &c, const double &s) |
template<class Allocator > | |
void | ApplyModifRot (Vector< float, VectFull, Allocator > &X, Vector< float, VectFull, Allocator > &Y, const float *param) |
template<class Allocator > | |
void | ApplyModifRot (Vector< double, VectFull, Allocator > &X, Vector< double, VectFull, Allocator > &Y, const double *param) |
template<class Allocator > | |
void | Swap (Vector< float, VectFull, Allocator > &X, Vector< float, VectFull, Allocator > &Y) |
template<class Allocator > | |
void | Swap (Vector< double, VectFull, Allocator > &X, Vector< double, VectFull, Allocator > &Y) |
template<class Allocator > | |
void | Swap (Vector< complex< float >, VectFull, Allocator > &X, Vector< complex< float >, VectFull, Allocator > &Y) |
template<class Allocator > | |
void | Swap (Vector< complex< double >, VectFull, Allocator > &X, Vector< complex< double >, VectFull, Allocator > &Y) |
template<class Allocator > | |
void | MltScalar (const float &alpha, Vector< float, VectFull, Allocator > &X) |
template<class Allocator > | |
void | MltScalar (const double &alpha, Vector< double, VectFull, Allocator > &X) |
template<class Allocator > | |
void | MltScalar (const float &alpha, Vector< complex< float >, VectFull, Allocator > &X) |
template<class Allocator > | |
void | MltScalar (const double &alpha, Vector< complex< double >, VectFull, Allocator > &X) |
template<class Allocator > | |
void | MltScalar (const complex< float > &alpha, Vector< complex< float >, VectFull, Allocator > &X) |
template<class Allocator > | |
void | MltScalar (const complex< double > &alpha, Vector< complex< double >, VectFull, Allocator > &X) |
template<class Allocator0 , class Allocator1 > | |
void | CopyVector (const Vector< float, VectFull, Allocator0 > &X, Vector< float, VectFull, Allocator1 > &Y) |
template<class Allocator0 , class Allocator1 > | |
void | CopyVector (const Vector< double, VectFull, Allocator0 > &X, Vector< double, VectFull, Allocator1 > &Y) |
template<class Allocator0 , class Allocator1 > | |
void | CopyVector (const Vector< complex< float >, VectFull, Allocator0 > &X, Vector< complex< float >, VectFull, Allocator1 > &Y) |
template<class Allocator0 , class Allocator1 > | |
void | CopyVector (const Vector< complex< double >, VectFull, Allocator0 > &X, Vector< complex< double >, VectFull, Allocator1 > &Y) |
template<class Allocator0 , class Allocator1 > | |
void | AddVector (const float &alpha, const Vector< float, VectFull, Allocator0 > &X, Vector< float, VectFull, Allocator1 > &Y) |
template<class Allocator0 , class Allocator1 > | |
void | AddVector (const double &alpha, const Vector< double, VectFull, Allocator0 > &X, Vector< double, VectFull, Allocator1 > &Y) |
template<class Allocator0 , class Allocator1 > | |
void | AddVector (const complex< float > &alpha, const Vector< complex< float >, VectFull, Allocator0 > &X, Vector< complex< float >, VectFull, Allocator1 > &Y) |
template<class Allocator0 , class Allocator1 > | |
void | AddVector (const complex< double > &alpha, const Vector< complex< double >, VectFull, Allocator0 > &X, Vector< complex< double >, VectFull, Allocator1 > &Y) |
template<class Allocator0 , class Allocator1 > | |
float | DotProdVector (const Vector< float, VectFull, Allocator0 > &X, const Vector< float, VectFull, Allocator1 > &Y) |
template<class Allocator0 , class Allocator1 > | |
double | DotProdVector (const Vector< double, VectFull, Allocator0 > &X, const Vector< double, VectFull, Allocator1 > &Y) |
template<class Allocator0 , class Allocator1 > | |
complex< float > | DotProdVector (const Vector< complex< float >, VectFull, Allocator0 > &X, const Vector< complex< float >, VectFull, Allocator1 > &Y) |
template<class Allocator0 , class Allocator1 > | |
complex< double > | DotProdVector (const Vector< complex< double >, VectFull, Allocator0 > &X, const Vector< complex< double >, VectFull, Allocator1 > &Y) |
template<class Allocator0 , class Allocator1 > | |
float | ScaledDotProd (const float &alpha, const Vector< float, VectFull, Allocator0 > &X, const Vector< float, VectFull, Allocator1 > &Y) |
template<class Allocator0 , class Allocator1 > | |
complex< float > | DotProdConjVector (const Vector< complex< float >, VectFull, Allocator0 > &X, const Vector< complex< float >, VectFull, Allocator1 > &Y) |
template<class Allocator0 , class Allocator1 > | |
complex< double > | DotProdConjVector (const Vector< complex< double >, VectFull, Allocator0 > &X, const Vector< complex< double >, VectFull, Allocator1 > &Y) |
template<class Allocator > | |
float | Norm1 (const Vector< float, VectFull, Allocator > &X) |
template<class Allocator > | |
double | Norm1 (const Vector< double, VectFull, Allocator > &X) |
template<class Allocator > | |
float | Norm1 (const Vector< complex< float >, VectFull, Allocator > &X) |
template<class Allocator > | |
double | Norm1 (const Vector< complex< double >, VectFull, Allocator > &X) |
template<class Allocator > | |
float | Norm2 (const Vector< float, VectFull, Allocator > &X) |
template<class Allocator > | |
double | Norm2 (const Vector< double, VectFull, Allocator > &X) |
template<class Allocator > | |
float | Norm2 (const Vector< complex< float >, VectFull, Allocator > &X) |
template<class Allocator > | |
double | Norm2 (const Vector< complex< double >, VectFull, Allocator > &X) |
template<class Allocator > | |
size_t | GetMaxAbsIndex (const Vector< float, VectFull, Allocator > &X) |
template<class Allocator > | |
size_t | GetMaxAbsIndex (const Vector< double, VectFull, Allocator > &X) |
template<class Allocator > | |
size_t | GetMaxAbsIndex (const Vector< complex< float >, VectFull, Allocator > &X) |
template<class Allocator > | |
size_t | GetMaxAbsIndex (const Vector< complex< double >, VectFull, Allocator > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const Matrix< float, Prop0, ColUpTriang, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const Matrix< double, Prop0, ColUpTriang, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const Matrix< complex< float >, Prop0, ColUpTriang, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const Matrix< complex< double >, Prop0, ColUpTriang, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< float, Prop0, ColUpTriang, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< double, Prop0, ColUpTriang, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< float >, Prop0, ColUpTriang, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< double >, Prop0, ColUpTriang, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const Matrix< float, Prop0, ColLoTriang, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const Matrix< double, Prop0, ColLoTriang, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const Matrix< complex< float >, Prop0, ColLoTriang, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const Matrix< complex< double >, Prop0, ColLoTriang, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< float, Prop0, ColLoTriang, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< double, Prop0, ColLoTriang, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< float >, Prop0, ColLoTriang, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< double >, Prop0, ColLoTriang, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const Matrix< float, Prop0, RowUpTriang, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const Matrix< double, Prop0, RowUpTriang, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const Matrix< complex< float >, Prop0, RowUpTriang, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const Matrix< complex< double >, Prop0, RowUpTriang, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< float, Prop0, RowUpTriang, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< double, Prop0, RowUpTriang, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< float >, Prop0, RowUpTriang, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< double >, Prop0, RowUpTriang, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const Matrix< float, Prop0, RowLoTriang, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const Matrix< double, Prop0, RowLoTriang, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const Matrix< complex< float >, Prop0, RowLoTriang, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const Matrix< complex< double >, Prop0, RowLoTriang, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< float, Prop0, RowLoTriang, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< double, Prop0, RowLoTriang, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< float >, Prop0, RowLoTriang, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< double >, Prop0, RowLoTriang, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const Matrix< float, Prop0, ColUpTriangPacked, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const Matrix< double, Prop0, ColUpTriangPacked, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const Matrix< complex< float >, Prop0, ColUpTriangPacked, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const Matrix< complex< double >, Prop0, ColUpTriangPacked, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< float, Prop0, ColUpTriangPacked, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< double, Prop0, ColUpTriangPacked, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< float >, Prop0, ColUpTriangPacked, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< double >, Prop0, ColUpTriangPacked, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const Matrix< float, Prop0, ColLoTriangPacked, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const Matrix< double, Prop0, ColLoTriangPacked, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const Matrix< complex< float >, Prop0, ColLoTriangPacked, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const Matrix< complex< double >, Prop0, ColLoTriangPacked, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< float, Prop0, ColLoTriangPacked, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< double, Prop0, ColLoTriangPacked, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< float >, Prop0, ColLoTriangPacked, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< double >, Prop0, ColLoTriangPacked, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const Matrix< float, Prop0, RowUpTriangPacked, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const Matrix< double, Prop0, RowUpTriangPacked, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const Matrix< complex< float >, Prop0, RowUpTriangPacked, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const Matrix< complex< double >, Prop0, RowUpTriangPacked, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< float, Prop0, RowUpTriangPacked, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< double, Prop0, RowUpTriangPacked, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< float >, Prop0, RowUpTriangPacked, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< double >, Prop0, RowUpTriangPacked, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const Matrix< float, Prop0, RowLoTriangPacked, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const Matrix< double, Prop0, RowLoTriangPacked, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const Matrix< complex< float >, Prop0, RowLoTriangPacked, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const Matrix< complex< double >, Prop0, RowLoTriangPacked, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< float, Prop0, RowLoTriangPacked, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< double, Prop0, RowLoTriangPacked, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< float >, Prop0, RowLoTriangPacked, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Mlt (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< double >, Prop0, RowLoTriangPacked, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltAddVector (const float &alpha, const Matrix< float, Prop0, ColMajor, Allocator0 > &A, const Vector< float, VectFull, Allocator1 > &X, const float &beta, Vector< float, VectFull, Allocator2 > &Y) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltAddVector (const double &alpha, const Matrix< double, Prop0, ColMajor, Allocator0 > &A, const Vector< double, VectFull, Allocator1 > &X, const double &beta, Vector< double, VectFull, Allocator2 > &Y) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltAddVector (const complex< float > &alpha, const Matrix< complex< float >, Prop0, ColMajor, Allocator0 > &A, const Vector< complex< float >, VectFull, Allocator1 > &X, const complex< float > &beta, Vector< complex< float >, VectFull, Allocator2 > &Y) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltAddVector (const complex< double > &alpha, const Matrix< complex< double >, Prop0, ColMajor, Allocator0 > &A, const Vector< complex< double >, VectFull, Allocator1 > &X, const complex< double > &beta, Vector< complex< double >, VectFull, Allocator2 > &Y) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltAddVector (const float &alpha, const SeldonTranspose &TransA, const Matrix< float, Prop0, ColMajor, Allocator0 > &A, const Vector< float, VectFull, Allocator1 > &X, const float &beta, Vector< float, VectFull, Allocator2 > &Y) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltAddVector (const double &alpha, const SeldonTranspose &TransA, const Matrix< double, Prop0, ColMajor, Allocator0 > &A, const Vector< double, VectFull, Allocator1 > &X, const double &beta, Vector< double, VectFull, Allocator2 > &Y) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltAddVector (const complex< float > &alpha, const SeldonTranspose &TransA, const Matrix< complex< float >, Prop0, ColMajor, Allocator0 > &A, const Vector< complex< float >, VectFull, Allocator1 > &X, const complex< float > &beta, Vector< complex< float >, VectFull, Allocator2 > &Y) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltAddVector (const complex< double > &alpha, const SeldonTranspose &TransA, const Matrix< complex< double >, Prop0, ColMajor, Allocator0 > &A, const Vector< complex< double >, VectFull, Allocator1 > &X, const complex< double > &beta, Vector< complex< double >, VectFull, Allocator2 > &Y) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltAddVector (const float &alpha, const Matrix< float, Prop0, RowMajor, Allocator0 > &A, const Vector< float, VectFull, Allocator1 > &X, const float &beta, Vector< float, VectFull, Allocator2 > &Y) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltAddVector (const double &alpha, const Matrix< double, Prop0, RowMajor, Allocator0 > &A, const Vector< double, VectFull, Allocator1 > &X, const double &beta, Vector< double, VectFull, Allocator2 > &Y) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltAddVector (const complex< float > &alpha, const Matrix< complex< float >, Prop0, RowMajor, Allocator0 > &A, const Vector< complex< float >, VectFull, Allocator1 > &X, const complex< float > &beta, Vector< complex< float >, VectFull, Allocator2 > &Y) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltAddVector (const complex< double > &alpha, const Matrix< complex< double >, Prop0, RowMajor, Allocator0 > &A, const Vector< complex< double >, VectFull, Allocator1 > &X, const complex< double > &beta, Vector< complex< double >, VectFull, Allocator2 > &Y) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltAddVector (const float &alpha, const SeldonTranspose &TransA, const Matrix< float, Prop0, RowMajor, Allocator0 > &A, const Vector< float, VectFull, Allocator1 > &X, const float &beta, Vector< float, VectFull, Allocator2 > &Y) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltAddVector (const double &alpha, const SeldonTranspose &TransA, const Matrix< double, Prop0, RowMajor, Allocator0 > &A, const Vector< double, VectFull, Allocator1 > &X, const double &beta, Vector< double, VectFull, Allocator2 > &Y) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltAddVector (const complex< float > &alpha, const SeldonTranspose &TransA, const Matrix< complex< float >, Prop0, RowMajor, Allocator0 > &A, const Vector< complex< float >, VectFull, Allocator1 > &X, const complex< float > &beta, Vector< complex< float >, VectFull, Allocator2 > &Y) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltAddVector (const complex< double > &alpha, const SeldonTranspose &TransA, const Matrix< complex< double >, Prop0, RowMajor, Allocator0 > &A, const Vector< complex< double >, VectFull, Allocator1 > &X, const complex< double > &beta, Vector< complex< double >, VectFull, Allocator2 > &Y) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltAddVector (const complex< float > &alpha, const Matrix< complex< float >, Prop0, ColHerm, Allocator0 > &A, const Vector< complex< float >, VectFull, Allocator1 > &X, const complex< float > &beta, Vector< complex< float >, VectFull, Allocator2 > &Y) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltAddVector (const complex< double > &alpha, const Matrix< complex< double >, Prop0, ColHerm, Allocator0 > &A, const Vector< complex< double >, VectFull, Allocator1 > &X, const complex< double > &beta, Vector< complex< double >, VectFull, Allocator2 > &Y) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltAdd (const complex< float > &alpha, const SeldonUplo &Uplo, const Matrix< complex< float >, Prop0, ColHerm, Allocator0 > &A, const Vector< complex< float >, VectFull, Allocator1 > &X, const complex< float > &beta, Vector< complex< float >, VectFull, Allocator2 > &Y) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltAdd (const complex< double > &alpha, const SeldonUplo &Uplo, const Matrix< complex< double >, Prop0, ColHerm, Allocator0 > &A, const Vector< complex< double >, VectFull, Allocator1 > &X, const complex< double > &beta, Vector< complex< double >, VectFull, Allocator2 > &Y) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltAddVector (const complex< float > &alpha, const Matrix< complex< float >, Prop0, RowHerm, Allocator0 > &A, const Vector< complex< float >, VectFull, Allocator1 > &X, const complex< float > &beta, Vector< complex< float >, VectFull, Allocator2 > &Y) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltAddVector (const complex< double > &alpha, const Matrix< complex< double >, Prop0, RowHerm, Allocator0 > &A, const Vector< complex< double >, VectFull, Allocator1 > &X, const complex< double > &beta, Vector< complex< double >, VectFull, Allocator2 > &Y) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltAdd (const complex< float > &alpha, const SeldonUplo &Uplo, const Matrix< complex< float >, Prop0, RowHerm, Allocator0 > &A, const Vector< complex< float >, VectFull, Allocator1 > &X, const complex< float > &beta, Vector< complex< float >, VectFull, Allocator2 > &Y) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltAdd (const complex< double > &alpha, const SeldonUplo &Uplo, const Matrix< complex< double >, Prop0, RowHerm, Allocator0 > &A, const Vector< complex< double >, VectFull, Allocator1 > &X, const complex< double > &beta, Vector< complex< double >, VectFull, Allocator2 > &Y) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltAddVector (const complex< float > &alpha, const Matrix< complex< float >, Prop0, ColHermPacked, Allocator0 > &A, const Vector< complex< float >, VectFull, Allocator1 > &X, const complex< float > &beta, Vector< complex< float >, VectFull, Allocator2 > &Y) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltAddVector (const complex< double > &alpha, const Matrix< complex< double >, Prop0, ColHermPacked, Allocator0 > &A, const Vector< complex< double >, VectFull, Allocator1 > &X, const complex< double > &beta, Vector< complex< double >, VectFull, Allocator2 > &Y) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltAdd (const complex< float > &alpha, const SeldonUplo &Uplo, const Matrix< complex< float >, Prop0, ColHermPacked, Allocator0 > &A, const Vector< complex< float >, VectFull, Allocator1 > &X, const complex< float > &beta, Vector< complex< float >, VectFull, Allocator2 > &Y) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltAdd (const complex< double > &alpha, const SeldonUplo &Uplo, const Matrix< complex< double >, Prop0, ColHermPacked, Allocator0 > &A, const Vector< complex< double >, VectFull, Allocator1 > &X, const complex< double > &beta, Vector< complex< double >, VectFull, Allocator2 > &Y) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltAddVector (const complex< float > &alpha, const Matrix< complex< float >, Prop0, RowHermPacked, Allocator0 > &A, const Vector< complex< float >, VectFull, Allocator1 > &X, const complex< float > &beta, Vector< complex< float >, VectFull, Allocator2 > &Y) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltAddVector (const complex< double > &alpha, const Matrix< complex< double >, Prop0, RowHermPacked, Allocator0 > &A, const Vector< complex< double >, VectFull, Allocator1 > &X, const complex< double > &beta, Vector< complex< double >, VectFull, Allocator2 > &Y) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltAdd (const complex< float > &alpha, const SeldonUplo &Uplo, const Matrix< complex< float >, Prop0, RowHermPacked, Allocator0 > &A, const Vector< complex< float >, VectFull, Allocator1 > &X, const complex< float > &beta, Vector< complex< float >, VectFull, Allocator2 > &Y) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltAdd (const complex< double > &alpha, const SeldonUplo &Uplo, const Matrix< complex< double >, Prop0, RowHermPacked, Allocator0 > &A, const Vector< complex< double >, VectFull, Allocator1 > &X, const complex< double > &beta, Vector< complex< double >, VectFull, Allocator2 > &Y) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltAddVector (const float &alpha, const Matrix< float, Prop0, ColSym, Allocator0 > &A, const Vector< float, VectFull, Allocator1 > &X, const float &beta, Vector< float, VectFull, Allocator2 > &Y) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltAddVector (const double &alpha, const Matrix< double, Prop0, ColSym, Allocator0 > &A, const Vector< double, VectFull, Allocator1 > &X, const double &beta, Vector< double, VectFull, Allocator2 > &Y) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltAdd (const float &alpha, const SeldonUplo &Uplo, const Matrix< float, Prop0, ColSym, Allocator0 > &A, const Vector< float, VectFull, Allocator1 > &X, const float &beta, Vector< float, VectFull, Allocator2 > &Y) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltAdd (const double &alpha, const SeldonUplo &Uplo, const Matrix< double, Prop0, ColSym, Allocator0 > &A, const Vector< double, VectFull, Allocator1 > &X, const double &beta, Vector< double, VectFull, Allocator2 > &Y) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltAddVector (const float &alpha, const Matrix< float, Prop0, RowSym, Allocator0 > &A, const Vector< float, VectFull, Allocator1 > &X, const float &beta, Vector< float, VectFull, Allocator2 > &Y) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltAddVector (const double &alpha, const Matrix< double, Prop0, RowSym, Allocator0 > &A, const Vector< double, VectFull, Allocator1 > &X, const double &beta, Vector< double, VectFull, Allocator2 > &Y) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltAdd (const float &alpha, const SeldonUplo &Uplo, const Matrix< float, Prop0, RowSym, Allocator0 > &A, const Vector< float, VectFull, Allocator1 > &X, const float &beta, Vector< float, VectFull, Allocator2 > &Y) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltAdd (const double &alpha, const SeldonUplo &Uplo, const Matrix< double, Prop0, RowSym, Allocator0 > &A, const Vector< double, VectFull, Allocator1 > &X, const double &beta, Vector< double, VectFull, Allocator2 > &Y) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltAddVector (const float &alpha, const Matrix< float, Prop0, ColSymPacked, Allocator0 > &A, const Vector< float, VectFull, Allocator1 > &X, const float &beta, Vector< float, VectFull, Allocator2 > &Y) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltAddVector (const double &alpha, const Matrix< double, Prop0, ColSymPacked, Allocator0 > &A, const Vector< double, VectFull, Allocator1 > &X, const double &beta, Vector< double, VectFull, Allocator2 > &Y) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltAdd (const float &alpha, const SeldonUplo &Uplo, const Matrix< float, Prop0, ColSymPacked, Allocator0 > &A, const Vector< float, VectFull, Allocator1 > &X, const float &beta, Vector< float, VectFull, Allocator2 > &Y) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltAdd (const double &alpha, const SeldonUplo &Uplo, const Matrix< double, Prop0, ColSymPacked, Allocator0 > &A, const Vector< double, VectFull, Allocator1 > &X, const double &beta, Vector< double, VectFull, Allocator2 > &Y) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltAddVector (const float &alpha, const Matrix< float, Prop0, RowSymPacked, Allocator0 > &A, const Vector< float, VectFull, Allocator1 > &X, const float &beta, Vector< float, VectFull, Allocator2 > &Y) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltAddVector (const double &alpha, const Matrix< double, Prop0, RowSymPacked, Allocator0 > &A, const Vector< double, VectFull, Allocator1 > &X, const double &beta, Vector< double, VectFull, Allocator2 > &Y) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltAdd (const float &alpha, const SeldonUplo &Uplo, const Matrix< float, Prop0, RowSymPacked, Allocator0 > &A, const Vector< float, VectFull, Allocator1 > &X, const float &beta, Vector< float, VectFull, Allocator2 > &Y) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltAdd (const double &alpha, const SeldonUplo &Uplo, const Matrix< double, Prop0, RowSymPacked, Allocator0 > &A, const Vector< double, VectFull, Allocator1 > &X, const double &beta, Vector< double, VectFull, Allocator2 > &Y) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | Rank1Update (const float &alpha, const Vector< float, VectFull, Allocator1 > &X, const Vector< float, VectFull, Allocator2 > &Y, Matrix< float, Prop0, ColMajor, Allocator0 > &A) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | Rank1Update (const double &alpha, const Vector< double, VectFull, Allocator1 > &X, const Vector< double, VectFull, Allocator2 > &Y, Matrix< double, Prop0, ColMajor, Allocator0 > &A) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | Rank1Update (const complex< float > &alpha, const Vector< complex< float >, VectFull, Allocator1 > &X, const Vector< complex< float >, VectFull, Allocator2 > &Y, Matrix< complex< float >, Prop0, ColMajor, Allocator0 > &A) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | Rank1Update (const complex< double > &alpha, const Vector< complex< double >, VectFull, Allocator1 > &X, const Vector< complex< double >, VectFull, Allocator2 > &Y, Matrix< complex< double >, Prop0, ColMajor, Allocator0 > &A) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | Rank1Update (const complex< float > &alpha, const Vector< complex< float >, VectFull, Allocator1 > &X, const SeldonConjugate &ConjY, const Vector< complex< float >, VectFull, Allocator2 > &Y, Matrix< complex< float >, Prop0, ColMajor, Allocator0 > &A) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | Rank1Update (const complex< double > &alpha, const Vector< complex< double >, VectFull, Allocator1 > &X, const SeldonConjugate &ConjY, const Vector< complex< double >, VectFull, Allocator2 > &Y, Matrix< complex< double >, Prop0, ColMajor, Allocator0 > &A) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | Rank1Update (const float &alpha, const Vector< float, VectFull, Allocator1 > &X, const Vector< float, VectFull, Allocator2 > &Y, Matrix< float, Prop0, RowMajor, Allocator0 > &A) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | Rank1Update (const double &alpha, const Vector< double, VectFull, Allocator1 > &X, const Vector< double, VectFull, Allocator2 > &Y, Matrix< double, Prop0, RowMajor, Allocator0 > &A) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | Rank1Update (const complex< float > &alpha, const Vector< complex< float >, VectFull, Allocator1 > &X, const Vector< complex< float >, VectFull, Allocator2 > &Y, Matrix< complex< float >, Prop0, RowMajor, Allocator0 > &A) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | Rank1Update (const complex< double > &alpha, const Vector< complex< double >, VectFull, Allocator1 > &X, const Vector< complex< double >, VectFull, Allocator2 > &Y, Matrix< complex< double >, Prop0, RowMajor, Allocator0 > &A) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | Rank1Update (const complex< float > &alpha, const Vector< complex< float >, VectFull, Allocator1 > &X, const SeldonConjugate &ConjY, const Vector< complex< float >, VectFull, Allocator2 > &Y, Matrix< complex< float >, Prop0, RowMajor, Allocator0 > &A) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | Rank1Update (const complex< double > &alpha, const Vector< complex< double >, VectFull, Allocator1 > &X, const SeldonConjugate &ConjY, const Vector< complex< double >, VectFull, Allocator2 > &Y, Matrix< complex< double >, Prop0, RowMajor, Allocator0 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 > | |
void | Rank1Update (const float &alpha, const Vector< float, VectFull, Allocator0 > &X, Matrix< float, Prop1, ColSymPacked, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 > | |
void | Rank1Update (const double &alpha, const Vector< double, VectFull, Allocator0 > &X, Matrix< double, Prop1, ColSymPacked, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 > | |
void | Rank1Update (const float &alpha, const Vector< float, VectFull, Allocator0 > &X, Matrix< float, Prop1, ColSym, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 > | |
void | Rank1Update (const double &alpha, const Vector< double, VectFull, Allocator0 > &X, Matrix< double, Prop1, ColSym, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 > | |
void | Rank1Update (const float &alpha, const Vector< complex< float >, VectFull, Allocator0 > &X, Matrix< complex< float >, Prop1, ColHermPacked, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 > | |
void | Rank1Update (const double &alpha, const Vector< complex< double >, VectFull, Allocator0 > &X, Matrix< complex< double >, Prop1, ColHermPacked, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 > | |
void | Rank1Update (const float &alpha, const Vector< complex< float >, VectFull, Allocator0 > &X, Matrix< complex< float >, Prop1, ColHerm, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 > | |
void | Rank1Update (const double &alpha, const Vector< complex< double >, VectFull, Allocator0 > &X, Matrix< complex< double >, Prop1, ColHerm, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 > | |
void | Rank1Update (const float &alpha, const Vector< float, VectFull, Allocator0 > &X, const SeldonUplo &Uplo, Matrix< float, Prop1, ColSymPacked, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 > | |
void | Rank1Update (const double &alpha, const Vector< double, VectFull, Allocator0 > &X, const SeldonUplo &Uplo, Matrix< double, Prop1, ColSymPacked, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 > | |
void | Rank1Update (const float &alpha, const Vector< float, VectFull, Allocator0 > &X, const SeldonUplo &Uplo, Matrix< float, Prop1, ColSym, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 > | |
void | Rank1Update (const double &alpha, const Vector< double, VectFull, Allocator0 > &X, const SeldonUplo &Uplo, Matrix< double, Prop1, ColSym, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 > | |
void | Rank1Update (const float &alpha, const Vector< complex< float >, VectFull, Allocator0 > &X, const SeldonUplo &Uplo, Matrix< complex< float >, Prop1, ColHermPacked, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 > | |
void | Rank1Update (const double &alpha, const Vector< complex< double >, VectFull, Allocator0 > &X, const SeldonUplo &Uplo, Matrix< complex< double >, Prop1, ColHermPacked, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 > | |
void | Rank1Update (const float &alpha, const Vector< complex< float >, VectFull, Allocator0 > &X, const SeldonUplo &Uplo, Matrix< complex< float >, Prop1, ColHerm, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 > | |
void | Rank1Update (const double &alpha, const Vector< complex< double >, VectFull, Allocator0 > &X, const SeldonUplo &Uplo, Matrix< complex< double >, Prop1, ColHerm, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 > | |
void | Rank1Update (const float &alpha, const Vector< float, VectFull, Allocator0 > &X, Matrix< float, Prop1, RowSymPacked, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 > | |
void | Rank1Update (const double &alpha, const Vector< double, VectFull, Allocator0 > &X, Matrix< double, Prop1, RowSymPacked, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 > | |
void | Rank1Update (const float &alpha, const Vector< float, VectFull, Allocator0 > &X, Matrix< float, Prop1, RowSym, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 > | |
void | Rank1Update (const double &alpha, const Vector< double, VectFull, Allocator0 > &X, Matrix< double, Prop1, RowSym, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 > | |
void | Rank1Update (const float &alpha, const Vector< complex< float >, VectFull, Allocator0 > &X, Matrix< complex< float >, Prop1, RowHermPacked, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 > | |
void | Rank1Update (const double &alpha, const Vector< complex< double >, VectFull, Allocator0 > &X, Matrix< complex< double >, Prop1, RowHermPacked, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 > | |
void | Rank1Update (const float &alpha, const Vector< complex< float >, VectFull, Allocator0 > &X, Matrix< complex< float >, Prop1, RowHerm, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 > | |
void | Rank1Update (const double &alpha, const Vector< complex< double >, VectFull, Allocator0 > &X, Matrix< complex< double >, Prop1, RowHerm, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 > | |
void | Rank1Update (const float &alpha, const Vector< float, VectFull, Allocator0 > &X, const SeldonUplo &Uplo, Matrix< float, Prop1, RowSymPacked, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 > | |
void | Rank1Update (const double &alpha, const Vector< double, VectFull, Allocator0 > &X, const SeldonUplo &Uplo, Matrix< double, Prop1, RowSymPacked, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 > | |
void | Rank1Update (const float &alpha, const Vector< float, VectFull, Allocator0 > &X, const SeldonUplo &Uplo, Matrix< float, Prop1, RowSym, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 > | |
void | Rank1Update (const double &alpha, const Vector< double, VectFull, Allocator0 > &X, const SeldonUplo &Uplo, Matrix< double, Prop1, RowSym, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 > | |
void | Rank1Update (const float &alpha, const Vector< complex< float >, VectFull, Allocator0 > &X, const SeldonUplo &Uplo, Matrix< complex< float >, Prop1, RowHermPacked, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 > | |
void | Rank1Update (const double &alpha, const Vector< complex< double >, VectFull, Allocator0 > &X, const SeldonUplo &Uplo, Matrix< complex< double >, Prop1, RowHermPacked, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 > | |
void | Rank1Update (const float &alpha, const Vector< complex< float >, VectFull, Allocator0 > &X, const SeldonUplo &Uplo, Matrix< complex< float >, Prop1, RowHerm, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 > | |
void | Rank1Update (const double &alpha, const Vector< complex< double >, VectFull, Allocator0 > &X, const SeldonUplo &Uplo, Matrix< complex< double >, Prop1, RowHerm, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 , class Allocator2 > | |
void | Rank2Update (const float &alpha, const Vector< float, VectFull, Allocator0 > &X, const Vector< float, VectFull, Allocator2 > &Y, Matrix< float, Prop1, ColSymPacked, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 , class Allocator2 > | |
void | Rank2Update (const double &alpha, const Vector< double, VectFull, Allocator0 > &X, const Vector< double, VectFull, Allocator2 > &Y, Matrix< double, Prop1, ColSymPacked, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 , class Allocator2 > | |
void | Rank2Update (const float &alpha, const Vector< float, VectFull, Allocator0 > &X, const Vector< float, VectFull, Allocator2 > &Y, Matrix< float, Prop1, ColSym, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 , class Allocator2 > | |
void | Rank2Update (const double &alpha, const Vector< double, VectFull, Allocator0 > &X, const Vector< double, VectFull, Allocator2 > &Y, Matrix< double, Prop1, ColSym, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 , class Allocator2 > | |
void | Rank2Update (const complex< float > &alpha, const Vector< complex< float >, VectFull, Allocator0 > &X, const Vector< complex< float >, VectFull, Allocator2 > &Y, Matrix< complex< float >, Prop1, ColHermPacked, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 , class Allocator2 > | |
void | Rank2Update (const complex< double > &alpha, const Vector< complex< double >, VectFull, Allocator0 > &X, const Vector< complex< double >, VectFull, Allocator2 > &Y, Matrix< complex< double >, Prop1, ColHermPacked, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 , class Allocator2 > | |
void | Rank2Update (const complex< float > &alpha, const Vector< complex< float >, VectFull, Allocator0 > &X, const Vector< complex< float >, VectFull, Allocator2 > &Y, Matrix< complex< float >, Prop1, ColHerm, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 , class Allocator2 > | |
void | Rank2Update (const complex< double > &alpha, const Vector< complex< double >, VectFull, Allocator0 > &X, const Vector< complex< double >, VectFull, Allocator2 > &Y, Matrix< complex< double >, Prop1, ColHerm, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 , class Allocator2 > | |
void | Rank2Update (const float &alpha, const Vector< float, VectFull, Allocator0 > &X, const Vector< float, VectFull, Allocator2 > &Y, const SeldonUplo &Uplo, Matrix< float, Prop1, ColSymPacked, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 , class Allocator2 > | |
void | Rank2Update (const double &alpha, const Vector< double, VectFull, Allocator0 > &X, const Vector< double, VectFull, Allocator2 > &Y, const SeldonUplo &Uplo, Matrix< double, Prop1, ColSymPacked, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 , class Allocator2 > | |
void | Rank2Update (const float &alpha, const Vector< float, VectFull, Allocator0 > &X, const Vector< float, VectFull, Allocator2 > &Y, const SeldonUplo &Uplo, Matrix< float, Prop1, ColSym, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 , class Allocator2 > | |
void | Rank2Update (const double &alpha, const Vector< double, VectFull, Allocator0 > &X, const Vector< double, VectFull, Allocator2 > &Y, const SeldonUplo &Uplo, Matrix< double, Prop1, ColSym, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 , class Allocator2 > | |
void | Rank2Update (const complex< float > &alpha, const Vector< complex< float >, VectFull, Allocator0 > &X, const Vector< complex< float >, VectFull, Allocator2 > &Y, const SeldonUplo &Uplo, Matrix< complex< float >, Prop1, ColHermPacked, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 , class Allocator2 > | |
void | Rank2Update (const complex< double > &alpha, const Vector< complex< double >, VectFull, Allocator0 > &X, const Vector< complex< double >, VectFull, Allocator2 > &Y, const SeldonUplo &Uplo, Matrix< complex< double >, Prop1, ColHermPacked, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 , class Allocator2 > | |
void | Rank2Update (const complex< float > &alpha, const Vector< complex< float >, VectFull, Allocator0 > &X, const Vector< complex< float >, VectFull, Allocator2 > &Y, const SeldonUplo &Uplo, Matrix< complex< float >, Prop1, ColHerm, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 , class Allocator2 > | |
void | Rank2Update (const complex< double > &alpha, const Vector< complex< double >, VectFull, Allocator0 > &X, const Vector< complex< double >, VectFull, Allocator2 > &Y, const SeldonUplo &Uplo, Matrix< complex< double >, Prop1, ColHerm, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 , class Allocator2 > | |
void | Rank2Update (const float &alpha, const Vector< float, VectFull, Allocator0 > &X, const Vector< float, VectFull, Allocator2 > &Y, Matrix< float, Prop1, RowSymPacked, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 , class Allocator2 > | |
void | Rank2Update (const double &alpha, const Vector< double, VectFull, Allocator0 > &X, const Vector< double, VectFull, Allocator2 > &Y, Matrix< double, Prop1, RowSymPacked, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 , class Allocator2 > | |
void | Rank2Update (const float &alpha, const Vector< float, VectFull, Allocator0 > &X, const Vector< float, VectFull, Allocator2 > &Y, Matrix< float, Prop1, RowSym, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 , class Allocator2 > | |
void | Rank2Update (const double &alpha, const Vector< double, VectFull, Allocator0 > &X, const Vector< double, VectFull, Allocator2 > &Y, Matrix< double, Prop1, RowSym, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 , class Allocator2 > | |
void | Rank2Update (const complex< float > &alpha, const Vector< complex< float >, VectFull, Allocator0 > &X, const Vector< complex< float >, VectFull, Allocator2 > &Y, Matrix< complex< float >, Prop1, RowHermPacked, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 , class Allocator2 > | |
void | Rank2Update (const complex< double > &alpha, const Vector< complex< double >, VectFull, Allocator0 > &X, const Vector< complex< double >, VectFull, Allocator2 > &Y, Matrix< complex< double >, Prop1, RowHermPacked, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 , class Allocator2 > | |
void | Rank2Update (const complex< float > &alpha, const Vector< complex< float >, VectFull, Allocator0 > &X, const Vector< complex< float >, VectFull, Allocator2 > &Y, Matrix< complex< float >, Prop1, RowHerm, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 , class Allocator2 > | |
void | Rank2Update (const complex< double > &alpha, const Vector< complex< double >, VectFull, Allocator0 > &X, const Vector< complex< double >, VectFull, Allocator2 > &Y, Matrix< complex< double >, Prop1, RowHerm, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 , class Allocator2 > | |
void | Rank2Update (const float &alpha, const Vector< float, VectFull, Allocator0 > &X, const Vector< float, VectFull, Allocator2 > &Y, const SeldonUplo &Uplo, Matrix< float, Prop1, RowSymPacked, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 , class Allocator2 > | |
void | Rank2Update (const double &alpha, const Vector< double, VectFull, Allocator0 > &X, const Vector< double, VectFull, Allocator2 > &Y, const SeldonUplo &Uplo, Matrix< double, Prop1, RowSymPacked, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 , class Allocator2 > | |
void | Rank2Update (const float &alpha, const Vector< float, VectFull, Allocator0 > &X, const Vector< float, VectFull, Allocator2 > &Y, const SeldonUplo &Uplo, Matrix< float, Prop1, RowSym, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 , class Allocator2 > | |
void | Rank2Update (const double &alpha, const Vector< double, VectFull, Allocator0 > &X, const Vector< double, VectFull, Allocator2 > &Y, const SeldonUplo &Uplo, Matrix< double, Prop1, RowSym, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 , class Allocator2 > | |
void | Rank2Update (const complex< float > &alpha, const Vector< complex< float >, VectFull, Allocator0 > &X, const Vector< complex< float >, VectFull, Allocator2 > &Y, const SeldonUplo &Uplo, Matrix< complex< float >, Prop1, RowHermPacked, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 , class Allocator2 > | |
void | Rank2Update (const complex< double > &alpha, const Vector< complex< double >, VectFull, Allocator0 > &X, const Vector< complex< double >, VectFull, Allocator2 > &Y, const SeldonUplo &Uplo, Matrix< complex< double >, Prop1, RowHermPacked, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 , class Allocator2 > | |
void | Rank2Update (const complex< float > &alpha, const Vector< complex< float >, VectFull, Allocator0 > &X, const Vector< complex< float >, VectFull, Allocator2 > &Y, const SeldonUplo &Uplo, Matrix< complex< float >, Prop1, RowHerm, Allocator1 > &A) |
template<class Allocator0 , class Prop1 , class Allocator1 , class Allocator2 > | |
void | Rank2Update (const complex< double > &alpha, const Vector< complex< double >, VectFull, Allocator0 > &X, const Vector< complex< double >, VectFull, Allocator2 > &Y, const SeldonUplo &Uplo, Matrix< complex< double >, Prop1, RowHerm, Allocator1 > &A) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const Matrix< float, Prop0, ColUpTriang, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const Matrix< double, Prop0, ColUpTriang, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const Matrix< complex< float >, Prop0, ColUpTriang, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const Matrix< complex< double >, Prop0, ColUpTriang, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< float, Prop0, ColUpTriang, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< double, Prop0, ColUpTriang, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< float >, Prop0, ColUpTriang, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< double >, Prop0, ColUpTriang, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const Matrix< float, Prop0, ColLoTriang, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const Matrix< double, Prop0, ColLoTriang, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const Matrix< complex< float >, Prop0, ColLoTriang, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const Matrix< complex< double >, Prop0, ColLoTriang, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< float, Prop0, ColLoTriang, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< double, Prop0, ColLoTriang, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< float >, Prop0, ColLoTriang, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< double >, Prop0, ColLoTriang, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const Matrix< float, Prop0, RowUpTriang, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const Matrix< double, Prop0, RowUpTriang, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const Matrix< complex< float >, Prop0, RowUpTriang, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const Matrix< complex< double >, Prop0, RowUpTriang, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< float, Prop0, RowUpTriang, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< double, Prop0, RowUpTriang, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< float >, Prop0, RowUpTriang, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< double >, Prop0, RowUpTriang, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const Matrix< float, Prop0, RowLoTriang, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const Matrix< double, Prop0, RowLoTriang, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const Matrix< complex< float >, Prop0, RowLoTriang, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const Matrix< complex< double >, Prop0, RowLoTriang, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< float, Prop0, RowLoTriang, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< double, Prop0, RowLoTriang, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< float >, Prop0, RowLoTriang, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< double >, Prop0, RowLoTriang, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const Matrix< float, Prop0, ColUpTriangPacked, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const Matrix< double, Prop0, ColUpTriangPacked, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const Matrix< complex< float >, Prop0, ColUpTriangPacked, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const Matrix< complex< double >, Prop0, ColUpTriangPacked, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< float, Prop0, ColUpTriangPacked, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< double, Prop0, ColUpTriangPacked, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< float >, Prop0, ColUpTriangPacked, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< double >, Prop0, ColUpTriangPacked, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const Matrix< float, Prop0, ColLoTriangPacked, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const Matrix< double, Prop0, ColLoTriangPacked, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const Matrix< complex< float >, Prop0, ColLoTriangPacked, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const Matrix< complex< double >, Prop0, ColLoTriangPacked, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< float, Prop0, ColLoTriangPacked, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< double, Prop0, ColLoTriangPacked, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< float >, Prop0, ColLoTriangPacked, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< double >, Prop0, ColLoTriangPacked, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const Matrix< float, Prop0, RowUpTriangPacked, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const Matrix< double, Prop0, RowUpTriangPacked, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const Matrix< complex< float >, Prop0, RowUpTriangPacked, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const Matrix< complex< double >, Prop0, RowUpTriangPacked, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< float, Prop0, RowUpTriangPacked, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< double, Prop0, RowUpTriangPacked, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< float >, Prop0, RowUpTriangPacked, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< double >, Prop0, RowUpTriangPacked, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const Matrix< float, Prop0, RowLoTriangPacked, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const Matrix< double, Prop0, RowLoTriangPacked, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const Matrix< complex< float >, Prop0, RowLoTriangPacked, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const Matrix< complex< double >, Prop0, RowLoTriangPacked, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< float, Prop0, RowLoTriangPacked, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< double, Prop0, RowLoTriangPacked, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< float >, Prop0, RowLoTriangPacked, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< double >, Prop0, RowLoTriangPacked, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator1 > &X) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 , class Prop2 , class Allocator2 > | |
void | MltAddMatrix (const float &alpha, const Matrix< float, Prop0, ColMajor, Allocator0 > &A, const Matrix< float, Prop1, ColMajor, Allocator1 > &B, const float &beta, Matrix< float, Prop2, ColMajor, Allocator2 > &C) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 , class Prop2 , class Allocator2 > | |
void | MltAddMatrix (const double &alpha, const Matrix< double, Prop0, ColMajor, Allocator0 > &A, const Matrix< double, Prop1, ColMajor, Allocator1 > &B, const double &beta, Matrix< double, Prop2, ColMajor, Allocator2 > &C) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 , class Prop2 , class Allocator2 > | |
void | MltAddMatrix (const complex< float > &alpha, const Matrix< complex< float >, Prop0, ColMajor, Allocator0 > &A, const Matrix< complex< float >, Prop1, ColMajor, Allocator1 > &B, const complex< float > &beta, Matrix< complex< float >, Prop2, ColMajor, Allocator2 > &C) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 , class Prop2 , class Allocator2 > | |
void | MltAddMatrix (const complex< double > &alpha, const Matrix< complex< double >, Prop0, ColMajor, Allocator0 > &A, const Matrix< complex< double >, Prop1, ColMajor, Allocator1 > &B, const complex< double > &beta, Matrix< complex< double >, Prop2, ColMajor, Allocator2 > &C) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 , class Prop2 , class Allocator2 > | |
void | MltAddMatrix (const float &alpha, const SeldonTranspose &TransA, const Matrix< float, Prop0, ColMajor, Allocator0 > &A, const SeldonTranspose &TransB, const Matrix< float, Prop1, ColMajor, Allocator1 > &B, const float &beta, Matrix< float, Prop2, ColMajor, Allocator2 > &C) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 , class Prop2 , class Allocator2 > | |
void | MltAddMatrix (const double &alpha, const SeldonTranspose &TransA, const Matrix< double, Prop0, ColMajor, Allocator0 > &A, const SeldonTranspose &TransB, const Matrix< double, Prop1, ColMajor, Allocator1 > &B, const double &beta, Matrix< double, Prop2, ColMajor, Allocator2 > &C) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 , class Prop2 , class Allocator2 > | |
void | MltAddMatrix (const complex< float > &alpha, const SeldonTranspose &TransA, const Matrix< complex< float >, Prop0, ColMajor, Allocator0 > &A, const SeldonTranspose &TransB, const Matrix< complex< float >, Prop1, ColMajor, Allocator1 > &B, const complex< float > &beta, Matrix< complex< float >, Prop2, ColMajor, Allocator2 > &C) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 , class Prop2 , class Allocator2 > | |
void | MltAddMatrix (const complex< double > &alpha, const SeldonTranspose &TransA, const Matrix< complex< double >, Prop0, ColMajor, Allocator0 > &A, const SeldonTranspose &TransB, const Matrix< complex< double >, Prop1, ColMajor, Allocator1 > &B, const complex< double > &beta, Matrix< complex< double >, Prop2, ColMajor, Allocator2 > &C) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 , class Prop2 , class Allocator2 > | |
void | MltAddMatrix (const float &alpha, const Matrix< float, Prop0, RowMajor, Allocator0 > &A, const Matrix< float, Prop1, RowMajor, Allocator1 > &B, const float &beta, Matrix< float, Prop2, RowMajor, Allocator2 > &C) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 , class Prop2 , class Allocator2 > | |
void | MltAddMatrix (const double &alpha, const Matrix< double, Prop0, RowMajor, Allocator0 > &A, const Matrix< double, Prop1, RowMajor, Allocator1 > &B, const double &beta, Matrix< double, Prop2, RowMajor, Allocator2 > &C) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 , class Prop2 , class Allocator2 > | |
void | MltAddMatrix (const complex< float > &alpha, const Matrix< complex< float >, Prop0, RowMajor, Allocator0 > &A, const Matrix< complex< float >, Prop1, RowMajor, Allocator1 > &B, const complex< float > &beta, Matrix< complex< float >, Prop2, RowMajor, Allocator2 > &C) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 , class Prop2 , class Allocator2 > | |
void | MltAddMatrix (const complex< double > &alpha, const Matrix< complex< double >, Prop0, RowMajor, Allocator0 > &A, const Matrix< complex< double >, Prop1, RowMajor, Allocator1 > &B, const complex< double > &beta, Matrix< complex< double >, Prop2, RowMajor, Allocator2 > &C) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 , class Prop2 , class Allocator2 > | |
void | MltAddMatrix (const float &alpha, const SeldonTranspose &TransA, const Matrix< float, Prop0, RowMajor, Allocator0 > &A, const SeldonTranspose &TransB, const Matrix< float, Prop1, RowMajor, Allocator1 > &B, const float &beta, Matrix< float, Prop2, RowMajor, Allocator2 > &C) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 , class Prop2 , class Allocator2 > | |
void | MltAddMatrix (const double &alpha, const SeldonTranspose &TransA, const Matrix< double, Prop0, RowMajor, Allocator0 > &A, const SeldonTranspose &TransB, const Matrix< double, Prop1, RowMajor, Allocator1 > &B, const double &beta, Matrix< double, Prop2, RowMajor, Allocator2 > &C) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 , class Prop2 , class Allocator2 > | |
void | MltAddMatrix (const complex< float > &alpha, const SeldonTranspose &TransA, const Matrix< complex< float >, Prop0, RowMajor, Allocator0 > &A, const SeldonTranspose &TransB, const Matrix< complex< float >, Prop1, RowMajor, Allocator1 > &B, const complex< float > &beta, Matrix< complex< float >, Prop2, RowMajor, Allocator2 > &C) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 , class Prop2 , class Allocator2 > | |
void | MltAddMatrix (const complex< double > &alpha, const SeldonTranspose &TransA, const Matrix< complex< double >, Prop0, RowMajor, Allocator0 > &A, const SeldonTranspose &TransB, const Matrix< complex< double >, Prop1, RowMajor, Allocator1 > &B, const complex< double > &beta, Matrix< complex< double >, Prop2, RowMajor, Allocator2 > &C) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 , class Prop2 , class Allocator2 > | |
void | MltAdd (const SeldonSide &Side, const float &alpha, const Matrix< float, Prop0, ColSym, Allocator0 > &A, const Matrix< float, Prop1, ColMajor, Allocator1 > &B, const float &beta, Matrix< float, Prop2, ColMajor, Allocator2 > &C) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 , class Prop2 , class Allocator2 > | |
void | MltAdd (const SeldonSide &Side, const double &alpha, const Matrix< double, Prop0, ColSym, Allocator0 > &A, const Matrix< double, Prop1, ColMajor, Allocator1 > &B, const double &beta, Matrix< double, Prop2, ColMajor, Allocator2 > &C) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 , class Prop2 , class Allocator2 > | |
void | MltAdd (const SeldonSide &Side, const complex< float > &alpha, const Matrix< complex< float >, Prop0, ColSym, Allocator0 > &A, const Matrix< complex< float >, Prop1, ColMajor, Allocator1 > &B, const complex< float > &beta, Matrix< complex< float >, Prop2, ColMajor, Allocator2 > &C) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 , class Prop2 , class Allocator2 > | |
void | MltAdd (const SeldonSide &Side, const complex< double > &alpha, const Matrix< complex< double >, Prop0, ColSym, Allocator0 > &A, const Matrix< complex< double >, Prop1, ColMajor, Allocator1 > &B, const complex< double > &beta, Matrix< complex< double >, Prop2, ColMajor, Allocator2 > &C) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 , class Prop2 , class Allocator2 > | |
void | MltAdd (const SeldonSide &Side, const float &alpha, const SeldonUplo &Uplo, const Matrix< float, Prop0, ColSym, Allocator0 > &A, const Matrix< float, Prop1, ColMajor, Allocator1 > &B, const float &beta, Matrix< float, Prop2, ColMajor, Allocator2 > &C) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 , class Prop2 , class Allocator2 > | |
void | MltAdd (const SeldonSide &Side, const double &alpha, const SeldonUplo &Uplo, const Matrix< double, Prop0, ColSym, Allocator0 > &A, const Matrix< double, Prop1, ColMajor, Allocator1 > &B, const double &beta, Matrix< double, Prop2, ColMajor, Allocator2 > &C) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 , class Prop2 , class Allocator2 > | |
void | MltAdd (const SeldonSide &Side, const complex< float > &alpha, const SeldonUplo &Uplo, const Matrix< complex< float >, Prop0, ColSym, Allocator0 > &A, const Matrix< complex< float >, Prop1, ColMajor, Allocator1 > &B, const complex< float > &beta, Matrix< complex< float >, Prop2, ColMajor, Allocator2 > &C) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 , class Prop2 , class Allocator2 > | |
void | MltAdd (const SeldonSide &Side, const complex< double > &alpha, const SeldonUplo &Uplo, const Matrix< complex< double >, Prop0, ColSym, Allocator0 > &A, const Matrix< complex< double >, Prop1, ColMajor, Allocator1 > &B, const complex< double > &beta, Matrix< complex< double >, Prop2, ColMajor, Allocator2 > &C) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 , class Prop2 , class Allocator2 > | |
void | MltAdd (const SeldonSide &Side, const float &alpha, const Matrix< float, Prop0, RowSym, Allocator0 > &A, const Matrix< float, Prop1, RowMajor, Allocator1 > &B, const float &beta, Matrix< float, Prop2, RowMajor, Allocator2 > &C) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 , class Prop2 , class Allocator2 > | |
void | MltAdd (const SeldonSide &Side, const double &alpha, const Matrix< double, Prop0, RowSym, Allocator0 > &A, const Matrix< double, Prop1, RowMajor, Allocator1 > &B, const double &beta, Matrix< double, Prop2, RowMajor, Allocator2 > &C) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 , class Prop2 , class Allocator2 > | |
void | MltAdd (const SeldonSide &Side, const complex< float > &alpha, const Matrix< complex< float >, Prop0, RowSym, Allocator0 > &A, const Matrix< complex< float >, Prop1, RowMajor, Allocator1 > &B, const complex< float > &beta, Matrix< complex< float >, Prop2, RowMajor, Allocator2 > &C) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 , class Prop2 , class Allocator2 > | |
void | MltAdd (const SeldonSide &Side, const complex< double > &alpha, const Matrix< complex< double >, Prop0, RowSym, Allocator0 > &A, const Matrix< complex< double >, Prop1, RowMajor, Allocator1 > &B, const complex< double > &beta, Matrix< complex< double >, Prop2, RowMajor, Allocator2 > &C) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 , class Prop2 , class Allocator2 > | |
void | MltAdd (const SeldonSide &Side, const float &alpha, const SeldonUplo &Uplo, const Matrix< float, Prop0, RowSym, Allocator0 > &A, const Matrix< float, Prop1, RowMajor, Allocator1 > &B, const float &beta, Matrix< float, Prop2, RowMajor, Allocator2 > &C) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 , class Prop2 , class Allocator2 > | |
void | MltAdd (const SeldonSide &Side, const double &alpha, const SeldonUplo &Uplo, const Matrix< double, Prop0, RowSym, Allocator0 > &A, const Matrix< double, Prop1, RowMajor, Allocator1 > &B, const double &beta, Matrix< double, Prop2, RowMajor, Allocator2 > &C) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 , class Prop2 , class Allocator2 > | |
void | MltAdd (const SeldonSide &Side, const complex< float > &alpha, const SeldonUplo &Uplo, const Matrix< complex< float >, Prop0, RowSym, Allocator0 > &A, const Matrix< complex< float >, Prop1, RowMajor, Allocator1 > &B, const complex< float > &beta, Matrix< complex< float >, Prop2, RowMajor, Allocator2 > &C) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 , class Prop2 , class Allocator2 > | |
void | MltAdd (const SeldonSide &Side, const complex< double > &alpha, const SeldonUplo &Uplo, const Matrix< complex< double >, Prop0, RowSym, Allocator0 > &A, const Matrix< complex< double >, Prop1, RowMajor, Allocator1 > &B, const complex< double > &beta, Matrix< complex< double >, Prop2, RowMajor, Allocator2 > &C) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 , class Prop2 , class Allocator2 > | |
void | MltAdd (const SeldonSide &Side, const complex< float > &alpha, const Matrix< complex< float >, Prop0, ColHerm, Allocator0 > &A, const Matrix< complex< float >, Prop1, ColMajor, Allocator1 > &B, const complex< float > &beta, Matrix< complex< float >, Prop2, ColMajor, Allocator2 > &C) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 , class Prop2 , class Allocator2 > | |
void | MltAdd (const SeldonSide &Side, const complex< double > &alpha, const Matrix< complex< double >, Prop0, ColHerm, Allocator0 > &A, const Matrix< complex< double >, Prop1, ColMajor, Allocator1 > &B, const complex< double > &beta, Matrix< complex< double >, Prop2, ColMajor, Allocator2 > &C) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 , class Prop2 , class Allocator2 > | |
void | MltAdd (const SeldonSide &Side, const complex< float > &alpha, const SeldonUplo &Uplo, const Matrix< complex< float >, Prop0, ColHerm, Allocator0 > &A, const Matrix< complex< float >, Prop1, ColMajor, Allocator1 > &B, const complex< float > &beta, Matrix< complex< float >, Prop2, ColMajor, Allocator2 > &C) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 , class Prop2 , class Allocator2 > | |
void | MltAdd (const SeldonSide &Side, const complex< double > &alpha, const SeldonUplo &Uplo, const Matrix< complex< double >, Prop0, ColHerm, Allocator0 > &A, const Matrix< complex< double >, Prop1, ColMajor, Allocator1 > &B, const complex< double > &beta, Matrix< complex< double >, Prop2, ColMajor, Allocator2 > &C) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 , class Prop2 , class Allocator2 > | |
void | MltAdd (const SeldonSide &Side, const complex< float > &alpha, const Matrix< complex< float >, Prop0, RowHerm, Allocator0 > &A, const Matrix< complex< float >, Prop1, RowMajor, Allocator1 > &B, const complex< float > &beta, Matrix< complex< float >, Prop2, RowMajor, Allocator2 > &C) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 , class Prop2 , class Allocator2 > | |
void | MltAdd (const SeldonSide &Side, const complex< double > &alpha, const Matrix< complex< double >, Prop0, RowHerm, Allocator0 > &A, const Matrix< complex< double >, Prop1, RowMajor, Allocator1 > &B, const complex< double > &beta, Matrix< complex< double >, Prop2, RowMajor, Allocator2 > &C) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 , class Prop2 , class Allocator2 > | |
void | MltAdd (const SeldonSide &Side, const complex< float > &alpha, const SeldonUplo &Uplo, const Matrix< complex< float >, Prop0, RowHerm, Allocator0 > &A, const Matrix< complex< float >, Prop1, RowMajor, Allocator1 > &B, const complex< float > &beta, Matrix< complex< float >, Prop2, RowMajor, Allocator2 > &C) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 , class Prop2 , class Allocator2 > | |
void | MltAdd (const SeldonSide &Side, const complex< double > &alpha, const SeldonUplo &Uplo, const Matrix< complex< double >, Prop0, RowHerm, Allocator0 > &A, const Matrix< complex< double >, Prop1, RowMajor, Allocator1 > &B, const complex< double > &beta, Matrix< complex< double >, Prop2, RowMajor, Allocator2 > &C) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Mlt (const SeldonSide &Side, const float &alpha, const Matrix< float, Prop0, ColUpTriang, Allocator0 > &A, Matrix< float, Prop1, ColMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Mlt (const SeldonSide &Side, const double &alpha, const Matrix< double, Prop0, ColUpTriang, Allocator0 > &A, Matrix< double, Prop1, ColMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Mlt (const SeldonSide &Side, const complex< float > &alpha, const Matrix< complex< float >, Prop0, ColUpTriang, Allocator0 > &A, Matrix< complex< float >, Prop1, ColMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Mlt (const SeldonSide &Side, const complex< double > &alpha, const Matrix< complex< double >, Prop0, ColUpTriang, Allocator0 > &A, Matrix< complex< double >, Prop1, ColMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Mlt (const SeldonSide &Side, const float &alpha, const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< float, Prop0, ColUpTriang, Allocator0 > &A, Matrix< float, Prop1, ColMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Mlt (const SeldonSide &Side, const double &alpha, const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< double, Prop0, ColUpTriang, Allocator0 > &A, Matrix< double, Prop1, ColMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Mlt (const SeldonSide &Side, const complex< float > &alpha, const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< float >, Prop0, ColUpTriang, Allocator0 > &A, Matrix< complex< float >, Prop1, ColMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Mlt (const SeldonSide &Side, const complex< double > &alpha, const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< double >, Prop0, ColUpTriang, Allocator0 > &A, Matrix< complex< double >, Prop1, ColMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Mlt (const SeldonSide &Side, const float &alpha, const Matrix< float, Prop0, ColLoTriang, Allocator0 > &A, Matrix< float, Prop1, ColMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Mlt (const SeldonSide &Side, const double &alpha, const Matrix< double, Prop0, ColLoTriang, Allocator0 > &A, Matrix< double, Prop1, ColMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Mlt (const SeldonSide &Side, const complex< float > &alpha, const Matrix< complex< float >, Prop0, ColLoTriang, Allocator0 > &A, Matrix< complex< float >, Prop1, ColMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Mlt (const SeldonSide &Side, const complex< double > &alpha, const Matrix< complex< double >, Prop0, ColLoTriang, Allocator0 > &A, Matrix< complex< double >, Prop1, ColMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Mlt (const SeldonSide &Side, const float &alpha, const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< float, Prop0, ColLoTriang, Allocator0 > &A, Matrix< float, Prop1, ColMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Mlt (const SeldonSide &Side, const double &alpha, const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< double, Prop0, ColLoTriang, Allocator0 > &A, Matrix< double, Prop1, ColMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Mlt (const SeldonSide &Side, const complex< float > &alpha, const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< float >, Prop0, ColLoTriang, Allocator0 > &A, Matrix< complex< float >, Prop1, ColMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Mlt (const SeldonSide &Side, const complex< double > &alpha, const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< double >, Prop0, ColLoTriang, Allocator0 > &A, Matrix< complex< double >, Prop1, ColMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Mlt (const SeldonSide &Side, const float &alpha, const Matrix< float, Prop0, RowUpTriang, Allocator0 > &A, Matrix< float, Prop1, RowMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Mlt (const SeldonSide &Side, const double &alpha, const Matrix< double, Prop0, RowUpTriang, Allocator0 > &A, Matrix< double, Prop1, RowMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Mlt (const SeldonSide &Side, const complex< float > &alpha, const Matrix< complex< float >, Prop0, RowUpTriang, Allocator0 > &A, Matrix< complex< float >, Prop1, RowMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Mlt (const SeldonSide &Side, const complex< double > &alpha, const Matrix< complex< double >, Prop0, RowUpTriang, Allocator0 > &A, Matrix< complex< double >, Prop1, RowMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Mlt (const SeldonSide &Side, const float &alpha, const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< float, Prop0, RowUpTriang, Allocator0 > &A, Matrix< float, Prop1, RowMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Mlt (const SeldonSide &Side, const double &alpha, const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< double, Prop0, RowUpTriang, Allocator0 > &A, Matrix< double, Prop1, RowMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Mlt (const SeldonSide &Side, const complex< float > &alpha, const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< float >, Prop0, RowUpTriang, Allocator0 > &A, Matrix< complex< float >, Prop1, RowMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Mlt (const SeldonSide &Side, const complex< double > &alpha, const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< double >, Prop0, RowUpTriang, Allocator0 > &A, Matrix< complex< double >, Prop1, RowMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Mlt (const SeldonSide &Side, const float &alpha, const Matrix< float, Prop0, RowLoTriang, Allocator0 > &A, Matrix< float, Prop1, RowMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Mlt (const SeldonSide &Side, const double &alpha, const Matrix< double, Prop0, RowLoTriang, Allocator0 > &A, Matrix< double, Prop1, RowMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Mlt (const SeldonSide &Side, const complex< float > &alpha, const Matrix< complex< float >, Prop0, RowLoTriang, Allocator0 > &A, Matrix< complex< float >, Prop1, RowMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Mlt (const SeldonSide &Side, const complex< double > &alpha, const Matrix< complex< double >, Prop0, RowLoTriang, Allocator0 > &A, Matrix< complex< double >, Prop1, RowMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Mlt (const SeldonSide &Side, const float &alpha, const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< float, Prop0, RowLoTriang, Allocator0 > &A, Matrix< float, Prop1, RowMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Mlt (const SeldonSide &Side, const double &alpha, const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< double, Prop0, RowLoTriang, Allocator0 > &A, Matrix< double, Prop1, RowMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Mlt (const SeldonSide &Side, const complex< float > &alpha, const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< float >, Prop0, RowLoTriang, Allocator0 > &A, Matrix< complex< float >, Prop1, RowMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Mlt (const SeldonSide &Side, const complex< double > &alpha, const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< double >, Prop0, RowLoTriang, Allocator0 > &A, Matrix< complex< double >, Prop1, RowMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Solve (const SeldonSide &Side, const float &alpha, const Matrix< float, Prop0, ColUpTriang, Allocator0 > &A, Matrix< float, Prop1, ColMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Solve (const SeldonSide &Side, const double &alpha, const Matrix< double, Prop0, ColUpTriang, Allocator0 > &A, Matrix< double, Prop1, ColMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Solve (const SeldonSide &Side, const complex< float > &alpha, const Matrix< complex< float >, Prop0, ColUpTriang, Allocator0 > &A, Matrix< complex< float >, Prop1, ColMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Solve (const SeldonSide &Side, const complex< double > &alpha, const Matrix< complex< double >, Prop0, ColUpTriang, Allocator0 > &A, Matrix< complex< double >, Prop1, ColMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Solve (const SeldonSide &Side, const float &alpha, const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< float, Prop0, ColUpTriang, Allocator0 > &A, Matrix< float, Prop1, ColMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Solve (const SeldonSide &Side, const double &alpha, const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< double, Prop0, ColUpTriang, Allocator0 > &A, Matrix< double, Prop1, ColMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Solve (const SeldonSide &Side, const complex< float > &alpha, const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< float >, Prop0, ColUpTriang, Allocator0 > &A, Matrix< complex< float >, Prop1, ColMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Solve (const SeldonSide &Side, const complex< double > &alpha, const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< double >, Prop0, ColUpTriang, Allocator0 > &A, Matrix< complex< double >, Prop1, ColMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Solve (const SeldonSide &Side, const float &alpha, const Matrix< float, Prop0, ColLoTriang, Allocator0 > &A, Matrix< float, Prop1, ColMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Solve (const SeldonSide &Side, const double &alpha, const Matrix< double, Prop0, ColLoTriang, Allocator0 > &A, Matrix< double, Prop1, ColMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Solve (const SeldonSide &Side, const complex< float > &alpha, const Matrix< complex< float >, Prop0, ColLoTriang, Allocator0 > &A, Matrix< complex< float >, Prop1, ColMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Solve (const SeldonSide &Side, const complex< double > &alpha, const Matrix< complex< double >, Prop0, ColLoTriang, Allocator0 > &A, Matrix< complex< double >, Prop1, ColMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Solve (const SeldonSide &Side, const float &alpha, const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< float, Prop0, ColLoTriang, Allocator0 > &A, Matrix< float, Prop1, ColMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Solve (const SeldonSide &Side, const double &alpha, const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< double, Prop0, ColLoTriang, Allocator0 > &A, Matrix< double, Prop1, ColMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Solve (const SeldonSide &Side, const complex< float > &alpha, const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< float >, Prop0, ColLoTriang, Allocator0 > &A, Matrix< complex< float >, Prop1, ColMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Solve (const SeldonSide &Side, const complex< double > &alpha, const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< double >, Prop0, ColLoTriang, Allocator0 > &A, Matrix< complex< double >, Prop1, ColMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Solve (const SeldonSide &Side, const float &alpha, const Matrix< float, Prop0, RowUpTriang, Allocator0 > &A, Matrix< float, Prop1, RowMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Solve (const SeldonSide &Side, const double &alpha, const Matrix< double, Prop0, RowUpTriang, Allocator0 > &A, Matrix< double, Prop1, RowMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Solve (const SeldonSide &Side, const complex< float > &alpha, const Matrix< complex< float >, Prop0, RowUpTriang, Allocator0 > &A, Matrix< complex< float >, Prop1, RowMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Solve (const SeldonSide &Side, const complex< double > &alpha, const Matrix< complex< double >, Prop0, RowUpTriang, Allocator0 > &A, Matrix< complex< double >, Prop1, RowMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Solve (const SeldonSide &Side, const float &alpha, const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< float, Prop0, RowUpTriang, Allocator0 > &A, Matrix< float, Prop1, RowMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Solve (const SeldonSide &Side, const double &alpha, const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< double, Prop0, RowUpTriang, Allocator0 > &A, Matrix< double, Prop1, RowMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Solve (const SeldonSide &Side, const complex< float > &alpha, const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< float >, Prop0, RowUpTriang, Allocator0 > &A, Matrix< complex< float >, Prop1, RowMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Solve (const SeldonSide &Side, const complex< double > &alpha, const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< double >, Prop0, RowUpTriang, Allocator0 > &A, Matrix< complex< double >, Prop1, RowMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Solve (const SeldonSide &Side, const float &alpha, const Matrix< float, Prop0, RowLoTriang, Allocator0 > &A, Matrix< float, Prop1, RowMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Solve (const SeldonSide &Side, const double &alpha, const Matrix< double, Prop0, RowLoTriang, Allocator0 > &A, Matrix< double, Prop1, RowMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Solve (const SeldonSide &Side, const complex< float > &alpha, const Matrix< complex< float >, Prop0, RowLoTriang, Allocator0 > &A, Matrix< complex< float >, Prop1, RowMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Solve (const SeldonSide &Side, const complex< double > &alpha, const Matrix< complex< double >, Prop0, RowLoTriang, Allocator0 > &A, Matrix< complex< double >, Prop1, RowMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Solve (const SeldonSide &Side, const float &alpha, const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< float, Prop0, RowLoTriang, Allocator0 > &A, Matrix< float, Prop1, RowMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Solve (const SeldonSide &Side, const double &alpha, const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< double, Prop0, RowLoTriang, Allocator0 > &A, Matrix< double, Prop1, RowMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Solve (const SeldonSide &Side, const complex< float > &alpha, const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< float >, Prop0, RowLoTriang, Allocator0 > &A, Matrix< complex< float >, Prop1, RowMajor, Allocator1 > &B) |
template<class Prop0 , class Allocator0 , class Prop1 , class Allocator1 > | |
void | Solve (const SeldonSide &Side, const complex< double > &alpha, const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< double >, Prop0, RowLoTriang, Allocator0 > &A, Matrix< complex< double >, Prop1, RowMajor, Allocator1 > &B) |
template<class T , class Prop , class Storage , class Allocator > | |
void | GetCholesky (Matrix< T, Prop, Storage, Allocator > &A, MatrixCholmod &mat_chol, bool keep_matrix) |
template<class T , class Allocator > | |
void | SolveCholesky (const SeldonTranspose &TransA, MatrixCholmod &mat_chol, Vector< T, VectFull, Allocator > &x) |
template<class T , class Allocator > | |
void | MltCholesky (const SeldonTranspose &TransA, MatrixCholmod &mat_chol, Vector< T, VectFull, Allocator > &x) |
template<class MatrixSparse , class T > | |
void | GetLU (MatrixSparse &A, MatrixMumps< T > &mat_lu, bool keep_matrix, T &x) |
Factorization of a matrix of same type T as for the Mumps object | |
template<class MatrixSparse , class T > | |
void | GetLU (MatrixSparse &A, MatrixMumps< T > &mat_lu, bool keep_matrix, complex< T > &x) |
Factorization of a complex matrix with a real Mumps object. | |
template<class MatrixSparse , class T > | |
void | GetLU (MatrixSparse &A, MatrixMumps< complex< T > > &mat_lu, bool keep_matrix, T &x) |
Factorization of a real matrix with a complex Mumps object. | |
template<class T0 , class Prop , class Storage , class Allocator , class T > | |
void | GetLU (Matrix< T0, Prop, Storage, Allocator > &A, MatrixMumps< T > &mat_lu, bool keep_matrix) |
Factorization of a general matrix with Mumps. | |
template<class T , class Storage , class Allocator , class MatrixFull > | |
void | GetSchurMatrix (Matrix< T, Symmetric, Storage, Allocator > &A, MatrixMumps< T > &mat_lu, const IVect &num, MatrixFull &schur_matrix, bool keep_matrix) |
computes Schur complement of a symmetric matrix | |
template<class T , class Storage , class Allocator , class MatrixFull > | |
void | GetSchurMatrix (Matrix< T, General, Storage, Allocator > &A, MatrixMumps< T > &mat_lu, const IVect &num, MatrixFull &schur_matrix, bool keep_matrix) |
computes Schur complement of an unsymmetric matrix | |
template<class T , class Allocator > | |
void | SolveLU (MatrixMumps< T > &mat_lu, Vector< T, VectFull, Allocator > &x) |
LU resolution with a vector whose type is the same as for Mumps object. | |
template<class T , class Allocator > | |
void | SolveLU (const SeldonTranspose &TransA, MatrixMumps< T > &mat_lu, Vector< T, VectFull, Allocator > &x) |
LU resolution with a vector whose type is the same as for Mumps object Solves transpose system A^T x = b or A x = b depending on TransA. | |
template<class Allocator > | |
void | SolveLU (MatrixMumps< double > &mat_lu, Vector< complex< double >, VectFull, Allocator > &x) |
Solves A x = b, where A is real and x is complex. | |
template<class Allocator > | |
void | SolveLU (const SeldonTranspose &TransA, MatrixMumps< double > &mat_lu, Vector< complex< double >, VectFull, Allocator > &x) |
Solves A x = b or A^T x = b, where A is real and x is complex. | |
template<class Allocator > | |
void | SolveLU (MatrixMumps< complex< double > > &mat_lu, Vector< double, VectFull, Allocator > &x) |
Solves A x = b, where A is complex and x is real => Forbidden. | |
template<class Allocator > | |
void | SolveLU (const SeldonTranspose &TransA, MatrixMumps< complex< double > > &mat_lu, Vector< double, VectFull, Allocator > &x) |
Solves A x = b or A^T x = b, where A is complex and x is real => Forbidden | |
template<class T , class Prop , class Allocator > | |
void | SolveLU (MatrixMumps< T > &mat_lu, Matrix< T, Prop, ColMajor, Allocator > &x) |
LU resolution with a matrix whose type is the same as for Mumps object. | |
template<class T , class Allocator , class Prop > | |
void | SolveLU (const SeldonTranspose &TransA, MatrixMumps< T > &mat_lu, Matrix< T, Prop, ColMajor, Allocator > &x) |
LU resolution with a matrix whose type is the same as for Mumps object Solves transpose system A^T x = b or A x = b depending on TransA. | |
template<class Prop , class Allocator > | |
void | SolveLU (MatrixMumps< double > &mat_lu, Matrix< complex< double >, Prop, ColMajor, Allocator > &x) |
template<class Prop , class Allocator > | |
void | SolveLU (const SeldonTranspose &TransA, MatrixMumps< double > &mat_lu, Matrix< complex< double >, Prop, ColMajor, Allocator > &x) |
template<class Prop , class Allocator > | |
void | SolveLU (MatrixMumps< complex< double > > &mat_lu, Matrix< double, Prop, ColMajor, Allocator > &x) |
template<class Prop , class Allocator > | |
void | SolveLU (const SeldonTranspose &TransA, MatrixMumps< complex< double > > &mat_lu, Matrix< double, Prop, ColMajor, Allocator > &x) |
template<class MatrixSparse , class T > | |
void | GetLU (MatrixSparse &A, MatrixPardiso< T > &mat_lu, bool keep_matrix, T &x) |
Factorization of a matrix of same type T as for the Pardiso object. | |
template<class MatrixSparse , class T > | |
void | GetLU (MatrixSparse &A, MatrixPardiso< T > &mat_lu, bool keep_matrix, complex< T > &x) |
Factorization of a complex matrix with a real Pardiso object. | |
template<class MatrixSparse , class T > | |
void | GetLU (MatrixSparse &A, MatrixPardiso< complex< T > > &mat_lu, bool keep_matrix, T &x) |
Factorization of a real matrix with a complex Pardiso object. | |
template<class T0 , class Prop , class Storage , class Allocator , class T > | |
void | GetLU (Matrix< T0, Prop, Storage, Allocator > &A, MatrixPardiso< T > &mat_lu, bool keep_matrix) |
Factorization of a general matrix with Pardiso. | |
template<class T , class Allocator > | |
void | SolveLU (MatrixPardiso< T > &mat_lu, Vector< T, VectFull, Allocator > &x) |
LU resolution with a vector whose type is the same as for Pardiso object. | |
template<class T , class Allocator > | |
void | SolveLU (const SeldonTranspose &TransA, MatrixPardiso< T > &mat_lu, Vector< T, VectFull, Allocator > &x) |
LU resolution with a vector whose type is the same as for Pardiso object Solves transpose system A^T x = b or A x = b depending on TransA. | |
template<class T , class Prop , class Allocator > | |
void | SolveLU (MatrixPardiso< T > &mat_lu, Matrix< T, Prop, ColMajor, Allocator > &x) |
LU resolution with a matrix whose type is the same as for Pardiso object. | |
template<class T , class Allocator , class Prop > | |
void | SolveLU (const SeldonTranspose &TransA, MatrixPardiso< T > &mat_lu, Matrix< T, Prop, ColMajor, Allocator > &x) |
LU resolution with a matrix whose type is the same as for Pardiso object Solves transpose system A^T x = b or A x = b depending on TransA. | |
template<class Allocator > | |
void | SolveLU (MatrixPardiso< double > &mat_lu, Vector< complex< double >, VectFull, Allocator > &x) |
Solves A x = b, where A is real and x is complex. | |
template<class Allocator > | |
void | SolveLU (const SeldonTranspose &TransA, MatrixPardiso< double > &mat_lu, Vector< complex< double >, VectFull, Allocator > &x) |
Solves A x = b or A^T x = b, where A is real and x is complex. | |
template<class Allocator > | |
void | SolveLU (MatrixPardiso< complex< double > > &mat_lu, Vector< double, VectFull, Allocator > &x) |
Solves A x = b, where A is complex and x is real => Forbidden | |
template<class Allocator > | |
void | SolveLU (const SeldonTranspose &TransA, MatrixPardiso< complex< double > > &mat_lu, Vector< double, VectFull, Allocator > &x) |
Solves A x = b or A^T x = b, where A is complex and x is real => Forbidden | |
template<class MatrixSparse , class T > | |
void | GetLU (MatrixSparse &A, MatrixPastix< T > &mat_lu, bool keep_matrix, T &x) |
Factorization of a matrix of same type T as the Pastix object. | |
template<class MatrixSparse , class T > | |
void | GetLU (MatrixSparse &A, MatrixPastix< T > &mat_lu, bool keep_matrix, complex< T > &x) |
Factorization of a complex matrix with a real Pastix object. | |
template<class MatrixSparse , class T > | |
void | GetLU (MatrixSparse &A, MatrixPastix< complex< T > > &mat_lu, bool keep_matrix, T &x) |
Factorization of a real matrix with a complex Pastix object. | |
template<class T0 , class Prop , class Storage , class Allocator , class T > | |
void | GetLU (Matrix< T0, Prop, Storage, Allocator > &A, MatrixPastix< T > &mat_lu, bool keep_matrix) |
Factorization of a general matrix with Pastix. | |
template<class T , class Allocator > | |
void | SolveLU (MatrixPastix< T > &mat_lu, Vector< T, VectFull, Allocator > &x) |
LU resolution with a vector whose type is the same as Pastix object. | |
template<class T , class Allocator > | |
void | SolveLU (const SeldonTranspose &TransA, MatrixPastix< T > &mat_lu, Vector< T, VectFull, Allocator > &x) |
LU resolution with a vector whose type is the same as Pastix object Solves transpose system A^T x = b or A x = b depending on TransA. | |
template<class T , class Prop , class Allocator > | |
void | SolveLU (MatrixPastix< T > &mat_lu, Matrix< T, Prop, ColMajor, Allocator > &x) |
LU resolution with a matrix whose type is the same as Pastix object. | |
template<class T , class Prop , class Allocator > | |
void | SolveLU (const SeldonTranspose &TransA, MatrixPastix< T > &mat_lu, Matrix< T, Prop, ColMajor, Allocator > &x) |
LU resolution with a matrix whose type is the same as UmfPack object Solves transpose system A^T x = b or A x = b depending on TransA. | |
template<class Allocator > | |
void | SolveLU (MatrixPastix< double > &mat_lu, Vector< complex< double >, VectFull, Allocator > &x) |
Solves A x = b, where A is real and x is complex. | |
template<class Allocator > | |
void | SolveLU (const SeldonTranspose &TransA, MatrixPastix< double > &mat_lu, Vector< complex< double >, VectFull, Allocator > &x) |
Solves A x = b or A^T x = b, where A is real and x is complex. | |
template<class Allocator > | |
void | SolveLU (MatrixPastix< complex< double > > &mat_lu, Vector< double, VectFull, Allocator > &x) |
Solves A x = b, where A is complex and x is real => Forbidden. | |
template<class Allocator > | |
void | SolveLU (const SeldonTranspose &TransA, MatrixPastix< complex< double > > &mat_lu, Vector< double, VectFull, Allocator > &x) |
Solves A x = b or A^T x = b, where A is complex and x is real => Forbidden | |
template<class T , class Prop , class Storage , class Allocator > | |
void | GetCholesky (Matrix< T, Prop, Storage, Allocator > &A, MatrixPastix< T > &mat_chol, bool keep_matrix) |
template<class T , class Allocator > | |
void | SolveCholesky (const SeldonTranspose &TransA, MatrixPastix< T > &mat_chol, Vector< T, VectFull, Allocator > &x) |
template<class T , class Allocator > | |
void | MltCholesky (const SeldonTranspose &TransA, MatrixPastix< T > &mat_chol, Vector< T, VectFull, Allocator > &x) |
template<class T > | |
void | SolveLU (const SeldonTranspose &transA, SparseDirectSolver< T > &mat_lu, Vector< T > &x) |
template<class T > | |
void | SolveLU (const SeldonTranspose &transA, SparseDirectSolver< complex< T > > &mat_lu, Vector< T > &x) |
template<class T > | |
void | SolveLU (const SeldonTranspose &transA, SparseDirectSolver< T > &mat_lu, Vector< complex< T > > &x) |
template<class T > | |
void | SolveLU (const SeldonTranspose &transA, SparseDirectSolver< T > &mat_lu, Matrix< T, General, ColMajor > &x) |
template<class T > | |
void | SolveLU (const SeldonTranspose &transA, SparseDirectSolver< complex< T > > &mat_lu, Matrix< T, General, ColMajor > &x) |
template<class T > | |
void | SolveLU (const SeldonTranspose &transA, SparseDirectSolver< T > &mat_lu, Matrix< complex< T >, General, ColMajor > &x) |
template<class T0 , class Prop , class Storage , class Allocator , class T > | |
void | GetLU (Matrix< T0, Prop, Storage, Allocator > &A, SparseDirectSolver< T > &mat_lu, bool keep_matrix) |
factorizes a matrix A with SparseDirectSolver class | |
template<class T0 , class Prop0 , class Storage0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 > | |
void | SparseSolve (Matrix< T0, Prop0, Storage0, Allocator0 > &M, Vector< T1, Storage1, Allocator1 > &Y) |
Solves a sparse linear system using LU factorization. More... | |
template<class T , class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetAndSolveLU (Matrix< T, Prop0, ColSparse, Allocator0 > &M, Vector< T, VectFull, Allocator1 > &Y) |
template<class T , class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetAndSolveLU (Matrix< T, Prop0, RowSparse, Allocator0 > &M, Vector< T, VectFull, Allocator1 > &Y) |
template<class T , class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetAndSolveLU (Matrix< T, Prop0, ArrayRowSparse, Allocator0 > &M, Vector< T, VectFull, Allocator1 > &Y) |
template<class T , class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetAndSolveLU (Matrix< T, Prop0, ColSymSparse, Allocator0 > &M, Vector< T, VectFull, Allocator1 > &Y) |
template<class T , class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetAndSolveLU (Matrix< T, Prop0, RowSymSparse, Allocator0 > &M, Vector< T, VectFull, Allocator1 > &Y) |
template<class T , class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetAndSolveLU (Matrix< T, Prop0, ArrayRowSymSparse, Allocator0 > &M, Vector< T, VectFull, Allocator1 > &Y) |
void | SetComplexOne (superlu::doublecomplex &one) |
template<class T > | |
void | LUextract (superlu::SuperMatrix *L, superlu::SuperMatrix *U, T *Lval, int *Lrow, long *Lcol, T *Uval, int *Urow, long *Ucol, int *snnzL, int *snnzU) |
template<class MatrixSparse , class T > | |
void | GetLU (MatrixSparse &A, MatrixSuperLU< T > &mat_lu, bool keep_matrix, T &x) |
Factorization of a matrix of same type T as for the SuperLU object. | |
template<class MatrixSparse , class T > | |
void | GetLU (MatrixSparse &A, MatrixSuperLU< T > &mat_lu, bool keep_matrix, complex< T > &x) |
Factorization of a complex matrix with a real SuperLU object. | |
template<class MatrixSparse , class T > | |
void | GetLU (MatrixSparse &A, MatrixSuperLU< complex< T > > &mat_lu, bool keep_matrix, T &x) |
Factorization of a real matrix with a complex SuperLU object. | |
template<class T0 , class Prop , class Storage , class Allocator , class T > | |
void | GetLU (Matrix< T0, Prop, Storage, Allocator > &A, MatrixSuperLU< T > &mat_lu, bool keep_matrix) |
Factorization of a general matrix with SuperLU. | |
template<class T , class Allocator > | |
void | SolveLU (MatrixSuperLU< T > &mat_lu, Vector< T, VectFull, Allocator > &x) |
LU resolution with a vector whose type is the same as for SuperLU object. | |
template<class T , class Allocator > | |
void | SolveLU (const SeldonTranspose &TransA, MatrixSuperLU< T > &mat_lu, Vector< T, VectFull, Allocator > &x) |
LU resolution with a vector whose type is the same as for SuperLU object Solves transpose system A^T x = b or A x = b depending on TransA. | |
template<class T , class Prop , class Allocator > | |
void | SolveLU (MatrixSuperLU< T > &mat_lu, Matrix< T, Prop, ColMajor, Allocator > &x) |
LU resolution with a matrix whose type is the same as for SuperLU object. | |
template<class T , class Prop , class Allocator > | |
void | SolveLU (const SeldonTranspose &TransA, MatrixSuperLU< T > &mat_lu, Matrix< T, Prop, ColMajor, Allocator > &x) |
LU resolution with a matrix whose type is the same as for SuperLU object Solves transpose system A^T x = b or A x = b depending on TransA. | |
template<class Allocator > | |
void | SolveLU (MatrixSuperLU< double > &mat_lu, Vector< complex< double >, VectFull, Allocator > &x) |
Solves A x = b, where A is real and x is complex. | |
template<class Allocator > | |
void | SolveLU (const SeldonTranspose &TransA, MatrixSuperLU< double > &mat_lu, Vector< complex< double >, VectFull, Allocator > &x) |
Solves A x = b or A^T x = b, where A is real and x is complex. | |
template<class Allocator > | |
void | SolveLU (MatrixSuperLU< complex< double > > &mat_lu, Vector< double, VectFull, Allocator > &x) |
Solves A x = b, where A is complex and x is real => Forbidden. | |
template<class Allocator > | |
void | SolveLU (const SeldonTranspose &TransA, MatrixSuperLU< complex< double > > &mat_lu, Vector< double, VectFull, Allocator > &x) |
Solves A x = b or A^T x = b, where A is complex and x is real => Forbidden | |
template<class MatrixSparse , class T > | |
void | GetLU (MatrixSparse &A, MatrixUmfPack< T > &mat_lu, bool keep_matrix, T &x) |
Factorization of a matrix of same type T as for the UmfPack object. | |
template<class MatrixSparse , class T > | |
void | GetLU (MatrixSparse &A, MatrixUmfPack< T > &mat_lu, bool keep_matrix, complex< T > &x) |
Factorization of a complex matrix with a real UmfPack object. | |
template<class MatrixSparse , class T > | |
void | GetLU (MatrixSparse &A, MatrixUmfPack< complex< T > > &mat_lu, bool keep_matrix, T &x) |
Factorization of a real matrix with a complex UmfPack object. | |
template<class T0 , class Prop , class Storage , class Allocator , class T > | |
void | GetLU (Matrix< T0, Prop, Storage, Allocator > &A, MatrixUmfPack< T > &mat_lu, bool keep_matrix) |
Factorization of a general matrix with UmfPack. | |
template<class T , class Allocator > | |
void | SolveLU (MatrixUmfPack< T > &mat_lu, Vector< T, VectFull, Allocator > &x) |
LU resolution with a vector whose type is the same as for UmfPack object. | |
template<class T , class Allocator > | |
void | SolveLU (const SeldonTranspose &TransA, MatrixUmfPack< T > &mat_lu, Vector< T, VectFull, Allocator > &x) |
LU resolution with a vector whose type is the same as for UmfPack object Solves transpose system A^T x = b or A x = b depending on TransA. | |
template<class T , class Prop , class Allocator > | |
void | SolveLU (MatrixUmfPack< T > &mat_lu, Matrix< T, Prop, ColMajor, Allocator > &x) |
LU resolution with a matrix whose type is the same as for UmfPack object. | |
template<class T , class Prop , class Allocator > | |
void | SolveLU (const SeldonTranspose &TransA, MatrixUmfPack< T > &mat_lu, Matrix< T, Prop, ColMajor, Allocator > &x) |
LU resolution with a matrix whose type is the same as for UmfPack object Solves transpose system A^T x = b or A x = b depending on TransA. | |
template<class Allocator > | |
void | SolveLU (MatrixUmfPack< double > &mat_lu, Vector< complex< double >, VectFull, Allocator > &x) |
Solves A x = b, where A is real and x is complex. | |
template<class Allocator > | |
void | SolveLU (const SeldonTranspose &TransA, MatrixUmfPack< double > &mat_lu, Vector< complex< double >, VectFull, Allocator > &x) |
Solves A x = b or A^T x = b, where A is real and x is complex. | |
template<class Allocator > | |
void | SolveLU (MatrixUmfPack< complex< double > > &mat_lu, Vector< double, VectFull, Allocator > &x) |
Solves A x = b, where A is complex and x is real => Forbidden. | |
template<class Allocator > | |
void | SolveLU (const SeldonTranspose &TransA, MatrixUmfPack< complex< double > > &mat_lu, Vector< double, VectFull, Allocator > &x) |
Solves A x = b or A^T x = b, where A is complex and x is real => Forbidden | |
template<class T , class Prop , class Storage , class Allocator > | |
void | GetLU (Matrix< T, Prop, Storage, Allocator > &A, MatrixWsmp< T > &mat_lu, bool keep_matrix) |
Factorization of a sparse matrix with Wsmp. | |
template<class T , class Allocator > | |
void | SolveLU (MatrixWsmp< T > &mat_lu, Vector< T, VectFull, Allocator > &x) |
LU solution with a vector whose type is the same as for Wsmp object. | |
template<class T , class Allocator > | |
void | SolveLU (const SeldonTranspose &TransA, MatrixWsmp< T > &mat_lu, Vector< T, VectFull, Allocator > &x) |
LU solution with a vector whose type is the same as for Wsmp object Solves transpose system A^T x = b or A x = b depending on TransA. | |
template<class T , class Prop , class Allocator > | |
void | SolveLU (MatrixWsmp< T > &mat_lu, Matrix< T, Prop, ColMajor, Allocator > &x) |
LU solution with a matrix whose type is the same as for Wsmp object. | |
template<class T , class Prop , class Allocator > | |
void | SolveLU (const SeldonTranspose &TransA, MatrixWsmp< T > &mat_lu, Matrix< T, Prop, ColMajor, Allocator > &x) |
LU solution with a matrix whose type is the same as for Wsmp object Solves transpose system A^T x = b or A x = b depending on TransA. | |
template<class Allocator > | |
void | SolveLU (MatrixWsmp< double > &mat_lu, Vector< complex< double >, VectFull, Allocator > &x) |
Solves A x = b, where A is real and x is complex. | |
template<class Allocator > | |
void | SolveLU (const SeldonTranspose &TransA, MatrixWsmp< double > &mat_lu, Vector< complex< double >, VectFull, Allocator > &x) |
Solves A x = b or A^T x = b, where A is real and x is complex. | |
template<class Allocator > | |
void | SolveLU (MatrixWsmp< complex< double > > &mat_lu, Vector< double, VectFull, Allocator > &x) |
Solves A x = b, where A is complex and x is real => Forbidden. | |
template<class Allocator > | |
void | SolveLU (const SeldonTranspose &TransA, MatrixWsmp< complex< double > > &mat_lu, Vector< double, VectFull, Allocator > &x) |
Solves A x = b or A^T x = b, where A is complex and x is real => Forbidden | |
template<class T > | |
void | SetComplexEigenvalue (const T &x, const T &y, T &z, T &zimag) |
real case, z = x, zimag = y | |
template<class T > | |
void | SetComplexEigenvalue (const T &x, const T &y, complex< T > &z, complex< T > &zimag) |
real case, z = (x, y), zimag = 0 | |
template<class EigenProblem , class T , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | FindEigenvaluesAnasazi (EigenProblem &var, Vector< T, VectFull, Allocator1 > &eigen_values, Vector< T, VectFull, Allocator2 > &lambda_imag, Matrix< T, General, ColMajor, Allocator3 > &eigen_vectors) |
computation of eigenvalues and related eigenvectors More... | |
template<class EigenProblem , class T , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | FindEigenvaluesArpack (EigenProblem &var, Vector< T, VectFull, Allocator1 > &eigen_values, Vector< T, VectFull, Allocator2 > &lambda_imag, Matrix< T, General, ColMajor, Allocator3 > &eigen_vectors) |
computation of eigenvalues and related eigenvectors More... | |
template<class T , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 , class Alloc5 > | |
void | CallArpack (int comm, int &ido, char &bmat, int &n, string &which, int &nev, T &tol, Vector< T, VectFull, Allocator1 > &resid, int &ncv, Matrix< T, General, ColMajor, Allocator2 > &v, int &ldv, Vector< int > &iparam, Vector< int > &ipntr, int sym, Vector< T, VectFull, Allocator3 > &workd, Vector< T, VectFull, Allocator4 > &workl, int &lworkl, Vector< T, VectFull, Alloc5 > &rwork, int &info) |
calling arpack routine | |
template<class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 , class Alloc5 > | |
void | CallArpack (int comm, int &ido, char &bmat, int &n, string &which, int &nev, double &tol, Vector< complex< double >, VectFull, Allocator1 > &resid, int &ncv, Matrix< complex< double >, General, ColMajor, Allocator2 > &v, int &ldv, Vector< int > &iparam, Vector< int > &ipntr, int sym, Vector< complex< double >, VectFull, Allocator3 > &workd, Vector< complex< double >, VectFull, Allocator4 > &workl, int &lworkl, Vector< double, VectFull, Alloc5 > &rwork, int &info) |
calling arpack routine | |
template<class T , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 , class Allocator5 , class Allocator6 , class Allocator7 , class Alloc8 > | |
void | CallArpack (int comm, int &rvec, char &howmny, Vector< int > &selec, Vector< T, VectFull, Allocator1 > &lambda, Vector< T, VectFull, Allocator2 > &lambda_i, Matrix< T, General, ColMajor, Allocator3 > &eigen_vec, int &ldz, T &shiftr, T &shifti, char &bmat, int &n, string &which, int &nev, T &tol, Vector< T, VectFull, Allocator4 > &resid, int &ncv, Matrix< T, General, ColMajor, Allocator5 > &v, int &ldv, Vector< int > &iparam, Vector< int > &ipntr, int sym, Vector< T, VectFull, Allocator6 > &workd, Vector< T, VectFull, Allocator7 > &workl, int &lworkl, Vector< T, VectFull, Alloc8 > &rwork, int &info) |
calling Arpack routine | |
template<class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 , class Allocator5 , class Allocator6 , class Allocator7 , class Alloc8 > | |
void | CallArpack (int comm, int &rvec, char &howmny, Vector< int > &selec, Vector< complex< double >, VectFull, Allocator1 > &lambda, Vector< complex< double >, VectFull, Allocator2 > &lambda_i, Matrix< complex< double >, General, ColMajor, Allocator3 > &eigen_vectors, int &ldz, complex< double > &shiftr, complex< double > &shifti, char &bmat, int &n, string &which, int &nev, double &tol, Vector< complex< double >, VectFull, Allocator4 > &resid, int &ncv, Matrix< complex< double >, General, ColMajor, Allocator5 > &v, int &ldv, Vector< int > &iparam, Vector< int > &ipntr, int sym, Vector< complex< double >, VectFull, Allocator6 > &workd, Vector< complex< double >, VectFull, Allocator7 > &workl, int &lworkl, Vector< double, VectFull, Alloc8 > &rwork, int &info) |
calling arpack routine | |
void | saupd (ARPACK_INTEGER &ido, char bmat, ARPACK_INTEGER n, char *which, ARPACK_INTEGER nev, ARPACK_DOUBLEREAL &tol, ARPACK_DOUBLEREAL *resid, ARPACK_INTEGER ncv, ARPACK_DOUBLEREAL *V, ARPACK_INTEGER ldv, ARPACK_INTEGER *iparam, ARPACK_INTEGER *ipntr, ARPACK_DOUBLEREAL *workd, ARPACK_DOUBLEREAL *workl, ARPACK_INTEGER lworkl, ARPACK_INTEGER &info) |
Symmetric problems in double precision. | |
void | saupd (ARPACK_INTEGER &ido, char bmat, ARPACK_INTEGER n, char *which, ARPACK_INTEGER nev, ARPACK_REAL &tol, ARPACK_REAL *resid, ARPACK_INTEGER ncv, ARPACK_REAL *V, ARPACK_INTEGER ldv, ARPACK_INTEGER *iparam, ARPACK_INTEGER *ipntr, ARPACK_REAL *workd, ARPACK_REAL *workl, ARPACK_INTEGER lworkl, ARPACK_INTEGER &info) |
Symmetric problems in single precision. | |
void | seupd (ARPACK_LOGICAL rvec, char HowMny, ARPACK_LOGICAL *select, ARPACK_DOUBLEREAL *d, ARPACK_DOUBLEREAL *Z, ARPACK_INTEGER ldz, ARPACK_DOUBLEREAL sigma, char bmat, ARPACK_INTEGER n, char *which, ARPACK_INTEGER nev, ARPACK_DOUBLEREAL tol, ARPACK_DOUBLEREAL *resid, ARPACK_INTEGER ncv, ARPACK_DOUBLEREAL *V, ARPACK_INTEGER ldv, ARPACK_INTEGER *iparam, ARPACK_INTEGER *ipntr, ARPACK_DOUBLEREAL *workd, ARPACK_DOUBLEREAL *workl, ARPACK_INTEGER lworkl, ARPACK_INTEGER &info) |
Postprocessing for symmetric problems in double precision. | |
void | seupd (ARPACK_LOGICAL rvec, char HowMny, ARPACK_LOGICAL *select, ARPACK_REAL *d, ARPACK_REAL *Z, ARPACK_INTEGER ldz, ARPACK_REAL sigma, char bmat, ARPACK_INTEGER n, char *which, ARPACK_INTEGER nev, ARPACK_REAL tol, ARPACK_REAL *resid, ARPACK_INTEGER ncv, ARPACK_REAL *V, ARPACK_INTEGER ldv, ARPACK_INTEGER *iparam, ARPACK_INTEGER *ipntr, ARPACK_REAL *workd, ARPACK_REAL *workl, ARPACK_INTEGER lworkl, ARPACK_INTEGER &info) |
Postprocessing for symmetric problems in single precision. | |
void | naupd (ARPACK_INTEGER &ido, char bmat, ARPACK_INTEGER n, char *which, ARPACK_INTEGER nev, ARPACK_DOUBLEREAL &tol, ARPACK_DOUBLEREAL *resid, ARPACK_INTEGER ncv, ARPACK_DOUBLEREAL *V, ARPACK_INTEGER ldv, ARPACK_INTEGER *iparam, ARPACK_INTEGER *ipntr, ARPACK_DOUBLEREAL *workd, ARPACK_DOUBLEREAL *workl, ARPACK_INTEGER lworkl, ARPACK_INTEGER &info) |
Non-symmetric problems in double precision. | |
void | naupd (ARPACK_INTEGER &ido, char bmat, ARPACK_INTEGER n, char *which, ARPACK_INTEGER nev, ARPACK_REAL &tol, ARPACK_REAL *resid, ARPACK_INTEGER ncv, ARPACK_REAL *V, ARPACK_INTEGER ldv, ARPACK_INTEGER *iparam, ARPACK_INTEGER *ipntr, ARPACK_REAL *workd, ARPACK_REAL *workl, ARPACK_INTEGER lworkl, ARPACK_INTEGER &info) |
Non-symmetric problems in single precision. | |
void | neupd (ARPACK_LOGICAL rvec, char HowMny, ARPACK_LOGICAL *select, ARPACK_DOUBLEREAL *dr, ARPACK_DOUBLEREAL *di, ARPACK_DOUBLEREAL *Z, ARPACK_INTEGER ldz, ARPACK_DOUBLEREAL sigmar, ARPACK_DOUBLEREAL sigmai, ARPACK_DOUBLEREAL *workv, char bmat, ARPACK_INTEGER n, char *which, ARPACK_INTEGER nev, ARPACK_DOUBLEREAL tol, ARPACK_DOUBLEREAL *resid, ARPACK_INTEGER ncv, ARPACK_DOUBLEREAL *V, ARPACK_INTEGER ldv, ARPACK_INTEGER *iparam, ARPACK_INTEGER *ipntr, ARPACK_DOUBLEREAL *workd, ARPACK_DOUBLEREAL *workl, ARPACK_INTEGER lworkl, ARPACK_INTEGER &info) |
Postprocessing for non-symmetric problems in double precision. | |
void | neupd (ARPACK_LOGICAL rvec, char HowMny, ARPACK_LOGICAL *select, ARPACK_REAL *dr, ARPACK_REAL *di, ARPACK_REAL *Z, ARPACK_INTEGER ldz, ARPACK_REAL sigmar, ARPACK_REAL sigmai, ARPACK_REAL *workv, char bmat, ARPACK_INTEGER n, char *which, ARPACK_INTEGER nev, ARPACK_REAL tol, ARPACK_REAL *resid, ARPACK_INTEGER ncv, ARPACK_REAL *V, ARPACK_INTEGER ldv, ARPACK_INTEGER *iparam, ARPACK_INTEGER *ipntr, ARPACK_REAL *workd, ARPACK_REAL *workl, ARPACK_INTEGER lworkl, ARPACK_INTEGER &info) |
Postprocessing for non-symmetric problems in single precision. | |
template<class EigenPb , class Vector1 , class Matrix1 , class T0 > | |
void | ApplyScalingEigenvec (EigenPb &var, Vector1 &eigen_values, Vector1 &lambda_imag, Matrix1 &eigen_vectors, const T0 &shiftr, const T0 &shifti) |
modification of eigenvectors to take into account scaling by mass matrix More... | |
template<class EigenPb , class Vector1 , class Matrix1 , class T0 > | |
void | ApplyScalingEigenvec (EigenPb &var, Vector1 &eigen_values, Vector1 &lambda_imag, Matrix1 &eigen_vectors, const complex< T0 > &shiftr, const complex< T0 > &shifti) |
modification of eigenvectors to take into account scaling by mass matrix More... | |
template<class T , class Storage1 , class Storage2 , class Alloc1 , class Alloc2 > | |
void | SortEigenvalues (Vector< T > &lambda_r, Vector< T > &lambda_i, Matrix< T, General, Storage1, Alloc1 > &eigen_old, Matrix< T, General, Storage2, Alloc2 > &eigen_new, int type_spectrum, int type_sort, const T &shift_r, const T &shift_i) |
sorting eigenvalues | |
template<class T , class Storage1 , class Storage2 , class Alloc1 , class Alloc2 > | |
void | SortEigenvalues (Vector< complex< T > > &lambda_r, Vector< complex< T > > &lambda_i, Matrix< complex< T >, General, Storage1, Alloc1 > &eigen_old, Matrix< complex< T >, General, Storage2, Alloc2 > &eigen_new, int type_spectrum, int type_sort, const complex< T > &shift_r, const complex< T > &shift_i) |
sorting eigenvalues | |
template<class EigenPb , class Vector1 , class Vector2 , class T , class Prop , class Storage , class Alloc3 > | |
void | GetEigenvaluesEigenvectors (EigenPb &var_eig, Vector1 &lambda, Vector2 &lambda_imag, Matrix< T, Prop, Storage, Alloc3 > &eigen_vec) |
template<class EigenProblem , class T , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | FindEigenvaluesFeast (EigenProblem &var, Vector< T, VectFull, Allocator1 > &eigen_values, Vector< T, VectFull, Allocator2 > &lambda_imag, Matrix< T, General, ColMajor, Allocator3 > &eigen_vectors) |
void | CallFeast (int &ijob, int n, bool herm, bool sym, complex< double > &ze, Matrix< double, General, ColMajor > &work, Matrix< complex< double >, General, ColMajor > &workc, Vector< double > &aq, Vector< double > &bq, Matrix< complex< double >, General, ColMajor > &zwork, Vector< complex< double > > &zaq, Vector< complex< double > > &zbq, IVect &fpm, double &epsout, int &loop, double emin, double emax, complex< double > Emid, double r, int m0, Vector< double > &lambda, Matrix< double, General, ColMajor > &eigen_vectors, Vector< complex< double > > &lambda_cplx, Matrix< complex< double >, General, ColMajor > &eigen_vec_cplx, int &m, Vector< double > &res, int &info) |
void | CallFeast (int &ijob, int n, bool herm, bool sym, complex< double > &ze, Matrix< complex< double >, General, ColMajor > &work, Matrix< complex< double >, General, ColMajor > &workc, Vector< complex< double > > &aq, Vector< complex< double > > &bq, Matrix< complex< double >, General, ColMajor > &zwork, Vector< complex< double > > &zaq, Vector< complex< double > > &zbq, IVect &fpm, double &epsout, int &loop, double emin, double emax, complex< double > Emid, double r, int m0, Vector< double > &lambda, Matrix< complex< double >, General, ColMajor > &eigen_vectors, Vector< complex< double > > &lambda_cplx, Matrix< complex< double >, General, ColMajor > &eigen_vec_cplx, int &m, Vector< double > &res, int &info) |
void | CallFeastP (int &ijob, int p, int n, bool sym, complex< double > &ze, Matrix< complex< double >, General, ColMajor > &zwork, Matrix< complex< double >, General, ColMajor > &workc, Vector< complex< double > > &zaq, Vector< complex< double > > &zbq, IVect &fpm, double &epsout, int &loop, complex< double > Emid, double r, int m0, Vector< complex< double > > &lambda_cplx, Matrix< complex< double >, General, ColMajor > &eigen_vec_cplx, int &m, Vector< double > &res, int &info) |
template<class EigenProblem , class T , class Allocator1 , class Allocator2 , class Al3 > | |
void | FindEigenvaluesFeast (EigenProblem &var, Vector< T, VectFull, Allocator1 > &eigen_values, Vector< T, VectFull, Allocator2 > &lambda_imag, Matrix< T, General, ColMajor, Al3 > &eigen_vectors) |
template<class T , class Prop , class Storage > | |
void | GetEigenvaluesEigenvectors (PolynomialEigenProblem_Base< T > &var_eig, Vector< T > &lambda, Vector< T > &lambda_imag, Matrix< T, Prop, Storage > &eigen_vec, int type_solver) |
void | SetParametersSlepc (const SlepcParam ¶m, EPS &eps) |
void | CopyPointerPetsc (const Vec &x, Vector< PetscScalar > &y) |
filling the vector y from pointer contained in x (Petsc vector) | |
void | AllocatePetscVector (const MPI_Comm &comm, Vec &Vr, int n, int nglob, Vector< PetscScalar > &Vr_vec) |
PetscErrorCode | MatMult_Matrix (Mat mat, Vec x, Vec y) |
matrix-vector product y = mat x (mat : stiffness operator) | |
PetscErrorCode | MatMult_MassMatrix (Mat mat, Vec x, Vec y) |
matrix-vector product y = mat x (mat : mass operator) | |
PetscErrorCode | MatMultTranspose_Matrix (Mat A, Vec x, Vec y) |
matrix-vector product with transpose, y = mat^T x | |
PetscErrorCode | MatGetDiagonal_Matrix (Mat A, Vec d) |
retrieves diagonal of A, d = diag(A) | |
template<class T > | |
bool | PutEigenpairLapackForm (int num, int nev, T &Lr, T &Li, Vector< T > &Vr, Vector< T > &Vi, T &Lr_next, T &Li_next, Vector< T > &Vr_next, Vector< T > &Vi_next, Vector< T > &eigen_values, Vector< T > &lambda_imag, Matrix< T, General, ColMajor > &eigen_vectors) |
template<class T > | |
bool | PutEigenpairLapackForm (int num, int nev, complex< T > &Lr, complex< T > &Li, Vector< complex< T > > &Vr, Vector< complex< T > > &Vi, complex< T > &Lr_next, complex< T > &Li_next, Vector< complex< T > > &Vr_next, Vector< complex< T > > &Vi_next, Vector< complex< T > > &eigen_values, Vector< complex< T > > &lambda_imag, Matrix< complex< T >, General, ColMajor > &eigen_vectors) |
void | FindEigenvaluesSlepc_ (EigenProblem_Base< PetscScalar > &var, Vector< PetscScalar > &eigen_values, Vector< PetscScalar > &lambda_imag, Matrix< PetscScalar, General, ColMajor > &eigen_vectors) |
void | ApplySpectralTransform (double shift, Vector< double > &eigen_values, Vector< double > &lambda_imag) |
void | ApplySpectralTransform (complex< double > shift, Vector< complex< double > > &eigen_values, Vector< complex< double > > &lambda_imag) |
void | SetParametersSlepc (const SlepcParamPep ¶m, PEP &pep) |
PetscErrorCode | MatMult_PepOperator (Mat mat, Vec x, Vec y) |
matrix-vector product y = op x | |
PetscErrorCode | MatMult_PepOperatorTrans (Mat mat, Vec x, Vec y) |
matrix-vector product y = op^T x | |
PetscErrorCode | MatSolve_PepOperator (Mat mat, Vec x, Vec y) |
solving op y = x | |
PetscErrorCode | MatSolveTrans_PepOperator (Mat mat, Vec x, Vec y) |
solving op y = x | |
void | FindEigenvaluesSlepc_ (PolynomialEigenProblem_Base< PetscScalar > &var, Vector< PetscScalar > &eigen_values, Vector< PetscScalar > &lambda_imag, Matrix< PetscScalar, General, ColMajor > &eigen_vectors) |
functions to compute eigenvalues with PEP solver of Slepc | |
void | UpdatePrecond_Nep (PC pc, bool first_construct) |
preconditioning is updated | |
PetscErrorCode | ConstructPreconditioning_NepOperator (PC pc) |
PetscErrorCode | UpdatePreconditioning_NepOperator (PC pc, KSP ksp, Vec b, Vec x) |
PetscErrorCode | ApplyPreconditioning_NepOperator (PC pc, Vec x, Vec y) |
PetscErrorCode | SetSingularities_NepOperator (NEP nep, PetscInt *maxnp, PetscScalar *xi, void *ctx) |
void | SetParametersSlepc (const SlepcParamNep ¶m, NEP &nep, NonLinearEigenProblem_Base< PetscScalar > &var, NepSlepcPreconditioning &prec) |
PetscErrorCode | FormFunctionNEP (NEP nep, PetscScalar lambda, Mat A, Mat B, void *ctx) |
PetscErrorCode | FormJacobianNEP (NEP nep, PetscScalar lambda, Mat A, void *ctx) |
void | ConvertToPetsc (DistributedMatrix< PetscScalar, General, ArrayRowSparse > &A, Mat Ap) |
PetscErrorCode | FormFunctionExpNEP (NEP nep, PetscScalar lambda, Mat Ap, Mat Bp, void *ctx) |
PetscErrorCode | FormJacobianExpNEP (NEP nep, PetscScalar lambda, Mat Ap, void *ctx) |
PetscErrorCode | MatMult_NepOperator (Mat mat, Vec x, Vec y) |
matrix-vector product y = op x | |
PetscErrorCode | MatMultTrans_NepOperator (Mat mat, Vec x, Vec y) |
matrix-vector product y = op^T x | |
PetscErrorCode | MatDuplicate_NepOperator (Mat A, MatDuplicateOption op, Mat *B) |
void | FindEigenvaluesSlepc_ (NonLinearEigenProblem_Base< PetscScalar > &var, Vector< PetscScalar > &eigen_values, Vector< PetscScalar > &lambda_imag, Matrix< PetscScalar, General, ColMajor > &eigen_vectors) |
functions to compute eigenvalues with NEP solver of Slepc | |
template<class EigenProblem , class T , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | FindEigenvaluesSlepc (EigenProblem &var, Vector< T, VectFull, Allocator1 > &eigen_values, Vector< T, VectFull, Allocator2 > &lambda_imag, Matrix< T, General, ColMajor, Allocator3 > &eigen_vectors) |
void | FindEigenvaluesSlepc_ (EigenProblem_Base< Petsc_Scalar > &var, Vector< Petsc_Scalar > &eigen_values, Vector< Petsc_Scalar > &lambda_imag, Matrix< Petsc_Scalar, General, ColMajor > &eigen_vectors) |
void | FindEigenvaluesSlepc_ (PolynomialEigenProblem_Base< Petsc_Scalar > &var, Vector< Petsc_Scalar > &eigen_values, Vector< Petsc_Scalar > &lambda_imag, Matrix< Petsc_Scalar, General, ColMajor > &eigen_vectors) |
template<class T0 , class Prop , class Storage > | |
void | ApplyScalingEigenvec (EigenProblem_Base< T0 > &var, Vector< T0 > &eigen_values, Vector< T0 > &lambda_imag, Matrix< T0, Prop, Storage > &eigen_vectors, const T0 &shiftr, const T0 &shifti) |
modification of eigenvectors to take into account scaling by mass matrix More... | |
template<class T0 , class Prop , class Storage > | |
void | ApplyScalingEigenvec (EigenProblem_Base< complex< T0 > > &var, Vector< complex< T0 > > &eigen_values, Vector< complex< T0 > > &lambda_imag, Matrix< complex< T0 >, Prop, Storage > &eigen_vectors, const complex< T0 > &shiftr, const complex< T0 > &shifti) |
modification of eigenvectors to take into account scaling by mass matrix More... | |
template<class T , class Storage1 , class Storage2 > | |
void | SortEigenvalues (Vector< T > &lambda_r, Vector< T > &lambda_i, Matrix< T, General, Storage1 > &eigen_old, Matrix< T, General, Storage2 > &eigen_new, int type_spectrum, int type_sort, const T &shift_r, const T &shift_i) |
sorting eigenvalues | |
template<class T , class Storage1 , class Storage2 > | |
void | SortEigenvalues (Vector< complex< T > > &lambda_r, Vector< complex< T > > &lambda_i, Matrix< complex< T >, General, Storage1 > &eigen_old, Matrix< complex< T >, General, Storage2 > &eigen_new, int type_spectrum, int type_sort, const complex< T > &shift_r, const complex< T > &shift_i) |
sorting eigenvalues | |
template<class T , class Prop , class Storage > | |
void | GetEigenvaluesEigenvectors (EigenProblem_Base< T > &var_eig, Vector< T > &lambda, Vector< T > &lambda_imag, Matrix< T, Prop, Storage > &eigen_vec, int type_solver) |
template<class T0 , class T1 > | |
void | to_complex_eigen (const T0 &x, T1 &y) |
template<class T0 , class T1 > | |
void | to_complex_eigen (const complex< T0 > &x, T1 &y) |
template<class T0 , class T1 > | |
void | to_complex_eigen (const T0 &x, complex< T1 > &y) |
template<class T0 , class T1 > | |
void | to_complex_eigen (const complex< T0 > &x, complex< T1 > &y) |
template<class Prop , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | GetEigenvalues (Matrix< float, Prop, RowMajor, Allocator1 > &A, Vector< float, VectFull, Allocator2 > &wr, Vector< float, VectFull, Allocator3 > &wi, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | GetEigenvaluesEigenvectors (Matrix< float, Prop, RowMajor, Allocator1 > &A, Vector< float, VectFull, Allocator2 > &wr, Vector< float, VectFull, Allocator3 > &wi, Matrix< float, General, RowMajor, Allocator4 > &zr, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 > | |
void | GetEigenvalues (Matrix< complex< float >, Prop, RowMajor, Allocator1 > &A, Vector< complex< float >, VectFull, Allocator2 > &w, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | GetEigenvaluesEigenvectors (Matrix< complex< float >, Prop, RowMajor, Allocator1 > &A, Vector< complex< float >, VectFull, Allocator2 > &w, Matrix< complex< float >, General, RowMajor, Allocator3 > &z, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | GetEigenvalues (Matrix< double, Prop, RowMajor, Allocator1 > &A, Vector< double, VectFull, Allocator2 > &wr, Vector< double, VectFull, Allocator3 > &wi, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | GetEigenvaluesEigenvectors (Matrix< double, Prop, RowMajor, Allocator1 > &A, Vector< double, VectFull, Allocator2 > &wr, Vector< double, VectFull, Allocator3 > &wi, Matrix< double, General, RowMajor, Allocator4 > &zr, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 > | |
void | GetEigenvalues (Matrix< complex< double >, Prop, RowMajor, Allocator1 > &A, Vector< complex< double >, VectFull, Allocator2 > &w, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | GetEigenvaluesEigenvectors (Matrix< complex< double >, Prop, RowMajor, Allocator1 > &A, Vector< complex< double >, VectFull, Allocator2 > &w, Matrix< complex< double >, General, RowMajor, Allocator3 > &z, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | GetEigenvalues (Matrix< float, Prop, ColMajor, Allocator1 > &A, Vector< float, VectFull, Allocator2 > &wr, Vector< float, VectFull, Allocator3 > &wi, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | GetEigenvaluesEigenvectors (Matrix< float, Prop, ColMajor, Allocator1 > &A, Vector< float, VectFull, Allocator2 > &wr, Vector< float, VectFull, Allocator3 > &wi, Matrix< float, General, ColMajor, Allocator4 > &zr, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 > | |
void | GetEigenvalues (Matrix< complex< float >, Prop, ColMajor, Allocator1 > &A, Vector< complex< float >, VectFull, Allocator2 > &w, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | GetEigenvaluesEigenvectors (Matrix< complex< float >, Prop, ColMajor, Allocator1 > &A, Vector< complex< float >, VectFull, Allocator2 > &w, Matrix< complex< float >, General, ColMajor, Allocator3 > &z, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | GetEigenvalues (Matrix< double, Prop, ColMajor, Allocator1 > &A, Vector< double, VectFull, Allocator2 > &wr, Vector< double, VectFull, Allocator3 > &wi, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | GetEigenvaluesEigenvectors (Matrix< double, Prop, ColMajor, Allocator1 > &A, Vector< double, VectFull, Allocator2 > &wr, Vector< double, VectFull, Allocator3 > &wi, Matrix< double, General, ColMajor, Allocator4 > &zr, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 > | |
void | GetEigenvalues (Matrix< complex< double >, Prop, ColMajor, Allocator1 > &A, Vector< complex< double >, VectFull, Allocator2 > &w, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | GetEigenvaluesEigenvectors (Matrix< complex< double >, Prop, ColMajor, Allocator1 > &A, Vector< complex< double >, VectFull, Allocator2 > &w, Matrix< complex< double >, General, ColMajor, Allocator3 > &z, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 > | |
void | GetEigenvalues (Matrix< float, Prop, RowSym, Allocator1 > &A, Vector< float, VectFull, Allocator2 > &w, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | GetEigenvaluesEigenvectors (Matrix< float, Prop, RowSym, Allocator1 > &A, Vector< float, VectFull, Allocator2 > &w, Matrix< float, General, RowMajor, Allocator3 > &z, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 > | |
void | GetEigenvalues (Matrix< complex< float >, Prop, RowSym, Allocator1 > &A, Vector< complex< float >, VectFull, Allocator2 > &w, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | GetEigenvaluesEigenvectors (Matrix< complex< float >, Prop, RowSym, Allocator1 > &A, Vector< complex< float >, VectFull, Allocator2 > &w, Matrix< complex< float >, General, RowMajor, Allocator3 > &z, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 > | |
void | GetEigenvalues (Matrix< double, Prop, RowSym, Allocator1 > &A, Vector< double, VectFull, Allocator2 > &w, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | GetEigenvaluesEigenvectors (Matrix< double, Prop, RowSym, Allocator1 > &A, Vector< double, VectFull, Allocator2 > &w, Matrix< double, General, RowMajor, Allocator3 > &z, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 > | |
void | GetEigenvalues (Matrix< complex< double >, Prop, RowSym, Allocator1 > &A, Vector< complex< double >, VectFull, Allocator2 > &w, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | GetEigenvaluesEigenvectors (Matrix< complex< double >, Prop, RowSym, Allocator1 > &A, Vector< complex< double >, VectFull, Allocator2 > &w, Matrix< complex< double >, General, RowMajor, Allocator3 > &z, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 > | |
void | GetEigenvalues (Matrix< float, Prop, ColSym, Allocator1 > &A, Vector< float, VectFull, Allocator2 > &w, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | GetEigenvaluesEigenvectors (Matrix< float, Prop, ColSym, Allocator1 > &A, Vector< float, VectFull, Allocator2 > &w, Matrix< float, General, ColMajor, Allocator3 > &z, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 > | |
void | GetEigenvalues (Matrix< complex< float >, Prop, ColSym, Allocator1 > &A, Vector< complex< float >, VectFull, Allocator2 > &w, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | GetEigenvaluesEigenvectors (Matrix< complex< float >, Prop, ColSym, Allocator1 > &A, Vector< complex< float >, VectFull, Allocator2 > &w, Matrix< complex< float >, General, ColMajor, Allocator3 > &z, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 > | |
void | GetEigenvalues (Matrix< double, Prop, ColSym, Allocator1 > &A, Vector< double, VectFull, Allocator2 > &w, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | GetEigenvaluesEigenvectors (Matrix< double, Prop, ColSym, Allocator1 > &A, Vector< double, VectFull, Allocator2 > &w, Matrix< double, General, ColMajor, Allocator3 > &z, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 > | |
void | GetEigenvalues (Matrix< complex< double >, Prop, ColSym, Allocator1 > &A, Vector< complex< double >, VectFull, Allocator2 > &w, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | GetEigenvaluesEigenvectors (Matrix< complex< double >, Prop, ColSym, Allocator1 > &A, Vector< complex< double >, VectFull, Allocator2 > &w, Matrix< complex< double >, General, ColMajor, Allocator3 > &z, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 > | |
void | GetEigenvalues (Matrix< complex< float >, Prop, RowHerm, Allocator1 > &A, Vector< float, VectFull, Allocator2 > &w, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | GetEigenvaluesEigenvectors (Matrix< complex< float >, Prop, RowHerm, Allocator1 > &A, Vector< float, VectFull, Allocator2 > &w, Matrix< complex< float >, General, RowMajor, Allocator3 > &z, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 > | |
void | GetEigenvalues (Matrix< complex< double >, Prop, RowHerm, Allocator1 > &A, Vector< double, VectFull, Allocator2 > &w, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | GetEigenvaluesEigenvectors (Matrix< complex< double >, Prop, RowHerm, Allocator1 > &A, Vector< double, VectFull, Allocator2 > &w, Matrix< complex< double >, General, RowMajor, Allocator3 > &z, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 > | |
void | GetEigenvalues (Matrix< complex< float >, Prop, ColHerm, Allocator1 > &A, Vector< float, VectFull, Allocator2 > &w, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | GetEigenvaluesEigenvectors (Matrix< complex< float >, Prop, ColHerm, Allocator1 > &A, Vector< float, VectFull, Allocator2 > &w, Matrix< complex< float >, General, ColMajor, Allocator3 > &z, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 > | |
void | GetEigenvalues (Matrix< complex< double >, Prop, ColHerm, Allocator1 > &A, Vector< double, VectFull, Allocator2 > &w, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | GetEigenvaluesEigenvectors (Matrix< complex< double >, Prop, ColHerm, Allocator1 > &A, Vector< double, VectFull, Allocator2 > &w, Matrix< complex< double >, General, ColMajor, Allocator3 > &z, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 > | |
void | GetEigenvalues (Matrix< float, Prop, RowSymPacked, Allocator1 > &A, Vector< float, VectFull, Allocator2 > &w, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | GetEigenvaluesEigenvectors (Matrix< float, Prop, RowSymPacked, Allocator1 > &A, Vector< float, VectFull, Allocator2 > &w, Matrix< float, General, RowMajor, Allocator3 > &z, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 > | |
void | GetEigenvalues (Matrix< complex< float >, Prop, RowSymPacked, Allocator1 > &A, Vector< complex< float >, VectFull, Allocator2 > &w, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | GetEigenvaluesEigenvectors (Matrix< complex< float >, Prop, RowSymPacked, Allocator1 > &A, Vector< complex< float >, VectFull, Allocator2 > &w, Matrix< complex< float >, General, RowMajor, Allocator3 > &z, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 > | |
void | GetEigenvalues (Matrix< double, Prop, RowSymPacked, Allocator1 > &A, Vector< double, VectFull, Allocator2 > &w, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | GetEigenvaluesEigenvectors (Matrix< double, Prop, RowSymPacked, Allocator1 > &A, Vector< double, VectFull, Allocator2 > &w, Matrix< double, General, RowMajor, Allocator3 > &z, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 > | |
void | GetEigenvalues (Matrix< complex< double >, Prop, RowSymPacked, Allocator1 > &A, Vector< complex< double >, VectFull, Allocator2 > &w, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | GetEigenvaluesEigenvectors (Matrix< complex< double >, Prop, RowSymPacked, Allocator1 > &A, Vector< complex< double >, VectFull, Allocator2 > &w, Matrix< complex< double >, General, RowMajor, Allocator3 > &z, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 > | |
void | GetEigenvalues (Matrix< float, Prop, ColSymPacked, Allocator1 > &A, Vector< float, VectFull, Allocator2 > &w, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | GetEigenvaluesEigenvectors (Matrix< float, Prop, ColSymPacked, Allocator1 > &A, Vector< float, VectFull, Allocator2 > &w, Matrix< float, General, ColMajor, Allocator3 > &z, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 > | |
void | GetEigenvalues (Matrix< complex< float >, Prop, ColSymPacked, Allocator1 > &A, Vector< complex< float >, VectFull, Allocator2 > &w, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | GetEigenvaluesEigenvectors (Matrix< complex< float >, Prop, ColSymPacked, Allocator1 > &A, Vector< complex< float >, VectFull, Allocator2 > &w, Matrix< complex< float >, General, ColMajor, Allocator3 > &z, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 > | |
void | GetEigenvalues (Matrix< double, Prop, ColSymPacked, Allocator1 > &A, Vector< double, VectFull, Allocator2 > &w, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | GetEigenvaluesEigenvectors (Matrix< double, Prop, ColSymPacked, Allocator1 > &A, Vector< double, VectFull, Allocator2 > &w, Matrix< double, General, ColMajor, Allocator3 > &z, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 > | |
void | GetEigenvalues (Matrix< complex< double >, Prop, ColSymPacked, Allocator1 > &A, Vector< complex< double >, VectFull, Allocator2 > &w, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | GetEigenvaluesEigenvectors (Matrix< complex< double >, Prop, ColSymPacked, Allocator1 > &A, Vector< complex< double >, VectFull, Allocator2 > &w, Matrix< complex< double >, General, ColMajor, Allocator3 > &z, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 > | |
void | GetEigenvalues (Matrix< complex< float >, Prop, RowHermPacked, Allocator1 > &A, Vector< float, VectFull, Allocator2 > &w, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | GetEigenvaluesEigenvectors (Matrix< complex< float >, Prop, RowHermPacked, Allocator1 > &A, Vector< float, VectFull, Allocator2 > &w, Matrix< complex< float >, General, RowMajor, Allocator3 > &z, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 > | |
void | GetEigenvalues (Matrix< complex< double >, Prop, RowHermPacked, Allocator1 > &A, Vector< double, VectFull, Allocator2 > &w, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | GetEigenvaluesEigenvectors (Matrix< complex< double >, Prop, RowHermPacked, Allocator1 > &A, Vector< double, VectFull, Allocator2 > &w, Matrix< complex< double >, General, RowMajor, Allocator3 > &z, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 > | |
void | GetEigenvalues (Matrix< complex< float >, Prop, ColHermPacked, Allocator1 > &A, Vector< float, VectFull, Allocator2 > &w, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | GetEigenvaluesEigenvectors (Matrix< complex< float >, Prop, ColHermPacked, Allocator1 > &A, Vector< float, VectFull, Allocator2 > &w, Matrix< complex< float >, General, ColMajor, Allocator3 > &z, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 > | |
void | GetEigenvalues (Matrix< complex< double >, Prop, ColHermPacked, Allocator1 > &A, Vector< double, VectFull, Allocator2 > &w, LapackInfo &info) |
template<class Prop , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | GetEigenvaluesEigenvectors (Matrix< complex< double >, Prop, ColHermPacked, Allocator1 > &A, Vector< double, VectFull, Allocator2 > &w, Matrix< complex< double >, General, ColMajor, Allocator3 > &z, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | GetEigenvalues (Matrix< float, Prop1, RowSym, Allocator1 > &A, Matrix< float, Prop2, RowSym, Allocator2 > &B, Vector< float, VectFull, Allocator3 > &w, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | GetEigenvaluesEigenvectors (Matrix< float, Prop1, RowSym, Allocator1 > &A, Matrix< float, Prop2, RowSym, Allocator2 > &B, Vector< float, VectFull, Allocator3 > &w, Matrix< float, General, RowMajor, Allocator4 > &z, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Allocator1 , class Allocator2 , class Allocator4 , class Allocator5 > | |
void | GetEigenvalues (Matrix< complex< float >, Prop1, RowSym, Allocator1 > &A, Matrix< complex< float >, Prop2, RowSym, Allocator2 > &B, Vector< complex< float >, VectFull, Allocator4 > &alpha, Vector< complex< float >, VectFull, Allocator5 > &beta, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Prop3 , class Allocator1 , class Allocator2 , class Allocator4 , class Allocator5 , class Allocator6 > | |
void | GetEigenvaluesEigenvectors (Matrix< complex< float >, Prop1, RowSym, Allocator1 > &A, Matrix< complex< float >, Prop2, RowSym, Allocator2 > &B, Vector< complex< float >, VectFull, Allocator4 > &alpha, Vector< complex< float >, VectFull, Allocator5 > &beta, Matrix< complex< float >, Prop3, RowMajor, Allocator6 > &V, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | GetEigenvalues (Matrix< double, Prop1, RowSym, Allocator1 > &A, Matrix< double, Prop2, RowSym, Allocator2 > &B, Vector< double, VectFull, Allocator3 > &w, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | GetEigenvaluesEigenvectors (Matrix< double, Prop1, RowSym, Allocator1 > &A, Matrix< double, Prop2, RowSym, Allocator2 > &B, Vector< double, VectFull, Allocator3 > &w, Matrix< double, General, RowMajor, Allocator4 > &z, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Allocator1 , class Allocator2 , class Allocator4 , class Allocator5 > | |
void | GetEigenvalues (Matrix< complex< double >, Prop1, RowSym, Allocator1 > &A, Matrix< complex< double >, Prop2, RowSym, Allocator2 > &B, Vector< complex< double >, VectFull, Allocator4 > &alpha, Vector< complex< double >, VectFull, Allocator5 > &beta, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Prop3 , class Allocator1 , class Allocator2 , class Allocator4 , class Allocator5 , class Allocator6 > | |
void | GetEigenvaluesEigenvectors (Matrix< complex< double >, Prop1, RowSym, Allocator1 > &A, Matrix< complex< double >, Prop2, RowSym, Allocator2 > &B, Vector< complex< double >, VectFull, Allocator4 > &alpha, Vector< complex< double >, VectFull, Allocator5 > &beta, Matrix< complex< double >, Prop3, RowMajor, Allocator6 > &V, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | GetEigenvalues (Matrix< float, Prop1, ColSym, Allocator1 > &A, Matrix< float, Prop2, ColSym, Allocator2 > &B, Vector< float, VectFull, Allocator3 > &w, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | GetEigenvaluesEigenvectors (Matrix< float, Prop1, ColSym, Allocator1 > &A, Matrix< float, Prop2, ColSym, Allocator2 > &B, Vector< float, VectFull, Allocator3 > &w, Matrix< float, General, ColMajor, Allocator4 > &z, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Allocator1 , class Allocator2 , class Allocator4 , class Allocator5 > | |
void | GetEigenvalues (Matrix< complex< float >, Prop1, ColSym, Allocator1 > &A, Matrix< complex< float >, Prop2, ColSym, Allocator2 > &B, Vector< complex< float >, VectFull, Allocator4 > &alpha, Vector< complex< float >, VectFull, Allocator5 > &beta, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Prop3 , class Alloc1 , class Alloc2 , class Alloc4 , class Alloc5 , class Alloc6 > | |
void | GetEigenvaluesEigenvectors (Matrix< complex< float >, Prop1, ColSym, Alloc1 > &A, Matrix< complex< float >, Prop2, ColSym, Alloc2 > &B, Vector< complex< float >, VectFull, Alloc4 > &alpha, Vector< complex< float >, VectFull, Alloc5 > &beta, Matrix< complex< float >, Prop3, ColMajor, Alloc6 > &V, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | GetEigenvalues (Matrix< double, Prop1, ColSym, Allocator1 > &A, Matrix< double, Prop2, ColSym, Allocator2 > &B, Vector< double, VectFull, Allocator3 > &w, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | GetEigenvaluesEigenvectors (Matrix< double, Prop1, ColSym, Allocator1 > &A, Matrix< double, Prop2, ColSym, Allocator2 > &B, Vector< double, VectFull, Allocator3 > &w, Matrix< double, General, ColMajor, Allocator4 > &z, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Allocator1 , class Allocator2 , class Allocator4 , class Allocator5 > | |
void | GetEigenvalues (Matrix< complex< double >, Prop1, ColSym, Allocator1 > &A, Matrix< complex< double >, Prop2, ColSym, Allocator2 > &B, Vector< complex< double >, VectFull, Allocator4 > &alpha, Vector< complex< double >, VectFull, Allocator5 > &beta, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Prop3 , class Alloc1 , class Alloc2 , class Alloc4 , class Alloc5 , class Alloc6 > | |
void | GetEigenvaluesEigenvectors (Matrix< complex< double >, Prop1, ColSym, Alloc1 > &A, Matrix< complex< double >, Prop2, ColSym, Alloc2 > &B, Vector< complex< double >, VectFull, Alloc4 > &alpha, Vector< complex< double >, VectFull, Alloc5 > &beta, Matrix< complex< double >, Prop3, ColMajor, Alloc6 > &V, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | GetEigenvalues (Matrix< complex< float >, Prop1, RowHerm, Allocator1 > &A, Matrix< complex< float >, Prop2, RowHerm, Allocator2 > &B, Vector< float, VectFull, Allocator3 > &w, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | GetEigenvaluesEigenvectors (Matrix< complex< float >, Prop1, RowHerm, Allocator1 > &A, Matrix< complex< float >, Prop2, RowHerm, Allocator2 > &B, Vector< float, VectFull, Allocator3 > &w, Matrix< complex< float >, General, RowMajor, Allocator4 > &z, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | GetEigenvalues (Matrix< complex< double >, Prop1, RowHerm, Allocator1 > &A, Matrix< complex< double >, Prop2, RowHerm, Allocator2 > &B, Vector< double, VectFull, Allocator3 > &w, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | GetEigenvaluesEigenvectors (Matrix< complex< double >, Prop1, RowHerm, Allocator1 > &A, Matrix< complex< double >, Prop2, RowHerm, Allocator2 > &B, Vector< double, VectFull, Allocator3 > &w, Matrix< complex< double >, General, RowMajor, Allocator4 > &z, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | GetEigenvalues (Matrix< complex< float >, Prop1, ColHerm, Allocator1 > &A, Matrix< complex< float >, Prop2, ColHerm, Allocator2 > &B, Vector< float, VectFull, Allocator3 > &w, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | GetEigenvaluesEigenvectors (Matrix< complex< float >, Prop1, ColHerm, Allocator1 > &A, Matrix< complex< float >, Prop2, ColHerm, Allocator2 > &B, Vector< float, VectFull, Allocator3 > &w, Matrix< complex< float >, General, ColMajor, Allocator4 > &z, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | GetEigenvalues (Matrix< complex< double >, Prop1, ColHerm, Allocator1 > &A, Matrix< complex< double >, Prop2, ColHerm, Allocator2 > &B, Vector< double, VectFull, Allocator3 > &w, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | GetEigenvaluesEigenvectors (Matrix< complex< double >, Prop1, ColHerm, Allocator1 > &A, Matrix< complex< double >, Prop2, ColHerm, Allocator2 > &B, Vector< double, VectFull, Allocator3 > &w, Matrix< complex< double >, General, ColMajor, Allocator4 > &z, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | GetEigenvalues (Matrix< float, Prop1, RowSymPacked, Allocator1 > &A, Matrix< float, Prop2, RowSymPacked, Allocator2 > &B, Vector< float, VectFull, Allocator3 > &w, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | GetEigenvaluesEigenvectors (Matrix< float, Prop1, RowSymPacked, Allocator1 > &A, Matrix< float, Prop2, RowSymPacked, Allocator2 > &B, Vector< float, VectFull, Allocator3 > &w, Matrix< float, General, RowMajor, Allocator4 > &z, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | GetEigenvalues (Matrix< complex< float >, Prop1, RowSymPacked, Allocator1 > &A, Matrix< complex< float >, Prop2, RowSymPacked, Allocator2 > &B, Vector< complex< float >, VectFull, Allocator3 > &alpha, Vector< complex< float >, VectFull, Allocator4 > &beta, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 , class Allocator5 > | |
void | GetEigenvaluesEigenvectors (Matrix< complex< float >, Prop1, RowSymPacked, Allocator1 > &A, Matrix< complex< float >, Prop2, RowSymPacked, Allocator2 > &B, Vector< complex< float >, VectFull, Allocator3 > &alpha, Vector< complex< float >, VectFull, Allocator4 > &beta, Matrix< complex< float >, General, RowMajor, Allocator5 > &z, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | GetEigenvalues (Matrix< double, Prop1, RowSymPacked, Allocator1 > &A, Matrix< double, Prop2, RowSymPacked, Allocator2 > &B, Vector< double, VectFull, Allocator3 > &w, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | GetEigenvaluesEigenvectors (Matrix< double, Prop1, RowSymPacked, Allocator1 > &A, Matrix< double, Prop2, RowSymPacked, Allocator2 > &B, Vector< double, VectFull, Allocator3 > &w, Matrix< double, General, RowMajor, Allocator4 > &z, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | GetEigenvalues (Matrix< complex< double >, Prop1, RowSymPacked, Allocator1 > &A, Matrix< complex< double >, Prop2, RowSymPacked, Allocator2 > &B, Vector< complex< double >, VectFull, Allocator3 > &alpha, Vector< complex< double >, VectFull, Allocator4 > &beta, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 , class Allocator5 > | |
void | GetEigenvaluesEigenvectors (Matrix< complex< double >, Prop1, RowSymPacked, Allocator1 > &A, Matrix< complex< double >, Prop2, RowSymPacked, Allocator2 > &B, Vector< complex< double >, VectFull, Allocator3 > &alpha, Vector< complex< double >, VectFull, Allocator4 > &beta, Matrix< complex< double >, General, RowMajor, Allocator5 > &z, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | GetEigenvalues (Matrix< float, Prop1, ColSymPacked, Allocator1 > &A, Matrix< float, Prop2, ColSymPacked, Allocator2 > &B, Vector< float, VectFull, Allocator3 > &w, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | GetEigenvaluesEigenvectors (Matrix< float, Prop1, ColSymPacked, Allocator1 > &A, Matrix< float, Prop2, ColSymPacked, Allocator2 > &B, Vector< float, VectFull, Allocator3 > &w, Matrix< float, General, ColMajor, Allocator4 > &z, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | GetEigenvalues (Matrix< complex< float >, Prop1, ColSymPacked, Allocator1 > &A, Matrix< complex< float >, Prop2, ColSymPacked, Allocator2 > &B, Vector< complex< float >, VectFull, Allocator3 > &alpha, Vector< complex< float >, VectFull, Allocator4 > &beta, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 , class Allocator5 > | |
void | GetEigenvaluesEigenvectors (Matrix< complex< float >, Prop1, ColSymPacked, Allocator1 > &A, Matrix< complex< float >, Prop2, ColSymPacked, Allocator2 > &B, Vector< complex< float >, VectFull, Allocator3 > &alpha, Vector< complex< float >, VectFull, Allocator4 > &beta, Matrix< complex< float >, General, ColMajor, Allocator5 > &z, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | GetEigenvalues (Matrix< double, Prop1, ColSymPacked, Allocator1 > &A, Matrix< double, Prop2, ColSymPacked, Allocator2 > &B, Vector< double, VectFull, Allocator3 > &w, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | GetEigenvaluesEigenvectors (Matrix< double, Prop1, ColSymPacked, Allocator1 > &A, Matrix< double, Prop2, ColSymPacked, Allocator2 > &B, Vector< double, VectFull, Allocator3 > &w, Matrix< double, General, ColMajor, Allocator4 > &z, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | GetEigenvalues (Matrix< complex< double >, Prop1, ColSymPacked, Allocator1 > &A, Matrix< complex< double >, Prop2, ColSymPacked, Allocator2 > &B, Vector< complex< double >, VectFull, Allocator3 > &alpha, Vector< complex< double >, VectFull, Allocator4 > &beta, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 , class Allocator5 > | |
void | GetEigenvaluesEigenvectors (Matrix< complex< double >, Prop1, ColSymPacked, Allocator1 > &A, Matrix< complex< double >, Prop2, ColSymPacked, Allocator2 > &B, Vector< complex< double >, VectFull, Allocator3 > &alpha, Vector< complex< double >, VectFull, Allocator4 > &beta, Matrix< complex< double >, General, ColMajor, Allocator5 > &z, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | GetEigenvalues (Matrix< complex< float >, Prop1, RowHermPacked, Allocator1 > &A, Matrix< complex< float >, Prop2, RowHermPacked, Allocator2 > &B, Vector< float, VectFull, Allocator3 > &w, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | GetEigenvaluesEigenvectors (Matrix< complex< float >, Prop1, RowHermPacked, Allocator1 > &A, Matrix< complex< float >, Prop2, RowHermPacked, Allocator2 > &B, Vector< float, VectFull, Allocator3 > &w, Matrix< complex< float >, General, RowMajor, Allocator4 > &z, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | GetEigenvalues (Matrix< complex< double >, Prop1, RowHermPacked, Allocator1 > &A, Matrix< complex< double >, Prop2, RowHermPacked, Allocator2 > &B, Vector< double, VectFull, Allocator3 > &w, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | GetEigenvaluesEigenvectors (Matrix< complex< double >, Prop1, RowHermPacked, Allocator1 > &A, Matrix< complex< double >, Prop2, RowHermPacked, Allocator2 > &B, Vector< double, VectFull, Allocator3 > &w, Matrix< complex< double >, General, RowMajor, Allocator4 > &z, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | GetEigenvalues (Matrix< complex< float >, Prop1, ColHermPacked, Allocator1 > &A, Matrix< complex< float >, Prop2, ColHermPacked, Allocator2 > &B, Vector< float, VectFull, Allocator3 > &w, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | GetEigenvaluesEigenvectors (Matrix< complex< float >, Prop1, ColHermPacked, Allocator1 > &A, Matrix< complex< float >, Prop2, ColHermPacked, Allocator2 > &B, Vector< float, VectFull, Allocator3 > &w, Matrix< complex< float >, General, ColMajor, Allocator4 > &z, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | GetEigenvalues (Matrix< complex< double >, Prop1, ColHermPacked, Allocator1 > &A, Matrix< complex< double >, Prop2, ColHermPacked, Allocator2 > &B, Vector< double, VectFull, Allocator3 > &w, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | GetEigenvaluesEigenvectors (Matrix< complex< double >, Prop1, ColHermPacked, Allocator1 > &A, Matrix< complex< double >, Prop2, ColHermPacked, Allocator2 > &B, Vector< double, VectFull, Allocator3 > &w, Matrix< complex< double >, General, ColMajor, Allocator4 > &z, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 , class Allocator5 > | |
void | GetEigenvalues (Matrix< float, Prop1, RowMajor, Allocator1 > &A, Matrix< float, Prop2, RowMajor, Allocator2 > &B, Vector< float, VectFull, Allocator3 > &alpha_real, Vector< float, VectFull, Allocator4 > &alpha_imag, Vector< float, VectFull, Allocator5 > &beta, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Prop3 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 , class Allocator5 , class Allocator6 > | |
void | GetEigenvaluesEigenvectors (Matrix< float, Prop1, RowMajor, Allocator1 > &A, Matrix< float, Prop2, RowMajor, Allocator2 > &B, Vector< float, VectFull, Allocator3 > &alpha_real, Vector< float, VectFull, Allocator4 > &alpha_imag, Vector< float, VectFull, Allocator5 > &beta, Matrix< float, Prop3, RowMajor, Allocator6 > &V, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Allocator1 , class Allocator2 , class Allocator4 , class Allocator5 > | |
void | GetEigenvalues (Matrix< complex< float >, Prop1, RowMajor, Allocator1 > &A, Matrix< complex< float >, Prop2, RowMajor, Allocator2 > &B, Vector< complex< float >, VectFull, Allocator4 > &alpha, Vector< complex< float >, VectFull, Allocator5 > &beta, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Prop3 , class Allocator1 , class Allocator2 , class Allocator4 , class Allocator5 , class Allocator6 > | |
void | GetEigenvaluesEigenvectors (Matrix< complex< float >, Prop1, RowMajor, Allocator1 > &A, Matrix< complex< float >, Prop2, RowMajor, Allocator2 > &B, Vector< complex< float >, VectFull, Allocator4 > &alpha, Vector< complex< float >, VectFull, Allocator5 > &beta, Matrix< complex< float >, Prop3, RowMajor, Allocator6 > &V, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 , class Allocator5 > | |
void | GetEigenvalues (Matrix< double, Prop1, RowMajor, Allocator1 > &A, Matrix< double, Prop2, RowMajor, Allocator2 > &B, Vector< double, VectFull, Allocator3 > &alpha_real, Vector< double, VectFull, Allocator4 > &alpha_imag, Vector< double, VectFull, Allocator5 > &beta, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Prop3 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 , class Allocator5 , class Allocator6 > | |
void | GetEigenvaluesEigenvectors (Matrix< double, Prop1, RowMajor, Allocator1 > &A, Matrix< double, Prop2, RowMajor, Allocator2 > &B, Vector< double, VectFull, Allocator3 > &alpha_real, Vector< double, VectFull, Allocator4 > &alpha_imag, Vector< double, VectFull, Allocator5 > &beta, Matrix< double, Prop3, RowMajor, Allocator6 > &V, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Allocator1 , class Allocator2 , class Allocator4 , class Allocator5 > | |
void | GetEigenvalues (Matrix< complex< double >, Prop1, RowMajor, Allocator1 > &A, Matrix< complex< double >, Prop2, RowMajor, Allocator2 > &B, Vector< complex< double >, VectFull, Allocator4 > &alpha, Vector< complex< double >, VectFull, Allocator5 > &beta, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Prop3 , class Allocator1 , class Allocator2 , class Allocator4 , class Allocator5 , class Allocator6 > | |
void | GetEigenvaluesEigenvectors (Matrix< complex< double >, Prop1, RowMajor, Allocator1 > &A, Matrix< complex< double >, Prop2, RowMajor, Allocator2 > &B, Vector< complex< double >, VectFull, Allocator4 > &alpha, Vector< complex< double >, VectFull, Allocator5 > &beta, Matrix< complex< double >, Prop3, RowMajor, Allocator6 > &V, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 , class Allocator5 > | |
void | GetEigenvalues (Matrix< float, Prop1, ColMajor, Allocator1 > &A, Matrix< float, Prop2, ColMajor, Allocator2 > &B, Vector< float, VectFull, Allocator3 > &alpha_real, Vector< float, VectFull, Allocator4 > &alpha_imag, Vector< float, VectFull, Allocator5 > &beta, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Prop3 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 , class Allocator5 , class Allocator6 > | |
void | GetEigenvaluesEigenvectors (Matrix< float, Prop1, ColMajor, Allocator1 > &A, Matrix< float, Prop2, ColMajor, Allocator2 > &B, Vector< float, VectFull, Allocator3 > &alpha_real, Vector< float, VectFull, Allocator4 > &alpha_imag, Vector< float, VectFull, Allocator5 > &beta, Matrix< float, Prop3, ColMajor, Allocator6 > &V, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Allocator1 , class Allocator2 , class Allocator4 , class Allocator5 > | |
void | GetEigenvalues (Matrix< complex< float >, Prop1, ColMajor, Allocator1 > &A, Matrix< complex< float >, Prop2, ColMajor, Allocator2 > &B, Vector< complex< float >, VectFull, Allocator4 > &alpha, Vector< complex< float >, VectFull, Allocator5 > &beta, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Prop3 , class Allocator1 , class Allocator2 , class Allocator4 , class Allocator5 , class Allocator6 > | |
void | GetEigenvaluesEigenvectors (Matrix< complex< float >, Prop1, ColMajor, Allocator1 > &A, Matrix< complex< float >, Prop2, ColMajor, Allocator2 > &B, Vector< complex< float >, VectFull, Allocator4 > &alpha, Vector< complex< float >, VectFull, Allocator5 > &beta, Matrix< complex< float >, Prop3, ColMajor, Allocator6 > &V, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 , class Allocator5 > | |
void | GetEigenvalues (Matrix< double, Prop1, ColMajor, Allocator1 > &A, Matrix< double, Prop2, ColMajor, Allocator2 > &B, Vector< double, VectFull, Allocator3 > &alpha_real, Vector< double, VectFull, Allocator4 > &alpha_imag, Vector< double, VectFull, Allocator5 > &beta, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Prop3 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 , class Allocator5 , class Allocator6 > | |
void | GetEigenvaluesEigenvectors (Matrix< double, Prop1, ColMajor, Allocator1 > &A, Matrix< double, Prop2, ColMajor, Allocator2 > &B, Vector< double, VectFull, Allocator3 > &alpha_real, Vector< double, VectFull, Allocator4 > &alpha_imag, Vector< double, VectFull, Allocator5 > &beta, Matrix< double, Prop3, ColMajor, Allocator6 > &V, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Allocator1 , class Allocator2 , class Allocator4 , class Allocator5 > | |
void | GetEigenvalues (Matrix< complex< double >, Prop1, ColMajor, Allocator1 > &A, Matrix< complex< double >, Prop2, ColMajor, Allocator2 > &B, Vector< complex< double >, VectFull, Allocator4 > &alpha, Vector< complex< double >, VectFull, Allocator5 > &beta, LapackInfo &info) |
template<class Prop1 , class Prop2 , class Prop3 , class Allocator1 , class Allocator2 , class Allocator4 , class Allocator5 , class Allocator6 > | |
void | GetEigenvaluesEigenvectors (Matrix< complex< double >, Prop1, ColMajor, Allocator1 > &A, Matrix< complex< double >, Prop2, ColMajor, Allocator2 > &B, Vector< complex< double >, VectFull, Allocator4 > &alpha, Vector< complex< double >, VectFull, Allocator5 > &beta, Matrix< complex< double >, Prop3, ColMajor, Allocator6 > &V, LapackInfo &info) |
template<class Prop1 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | GetSVD (Matrix< float, Prop1, RowMajor, Allocator1 > &A, Vector< float, VectFull, Allocator4 > &lambda, Matrix< float, General, RowMajor, Allocator2 > &u, Matrix< float, General, RowMajor, Allocator3 > &v, LapackInfo &info) |
template<class Prop1 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | GetSVD (Matrix< complex< float >, Prop1, RowMajor, Allocator1 > &A, Vector< float, VectFull, Allocator4 > &lambda, Matrix< complex< float >, General, RowMajor, Allocator2 > &u, Matrix< complex< float >, General, RowMajor, Allocator3 > &v, LapackInfo &info) |
template<class Prop1 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | GetSVD (Matrix< double, Prop1, RowMajor, Allocator1 > &A, Vector< double, VectFull, Allocator4 > &lambda, Matrix< double, General, RowMajor, Allocator2 > &u, Matrix< double, General, RowMajor, Allocator3 > &v, LapackInfo &info) |
template<class Prop1 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | GetSVD (Matrix< complex< double >, Prop1, RowMajor, Allocator1 > &A, Vector< double, VectFull, Allocator4 > &lambda, Matrix< complex< double >, General, RowMajor, Allocator2 > &u, Matrix< complex< double >, General, RowMajor, Allocator3 > &v, LapackInfo &info) |
template<class Prop1 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | GetSVD (Matrix< float, Prop1, ColMajor, Allocator1 > &A, Vector< float, VectFull, Allocator4 > &lambda, Matrix< float, General, ColMajor, Allocator2 > &u, Matrix< float, General, ColMajor, Allocator3 > &v, LapackInfo &info) |
template<class Prop1 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | GetSVD (Matrix< complex< float >, Prop1, ColMajor, Allocator1 > &A, Vector< float, VectFull, Allocator4 > &lambda, Matrix< complex< float >, General, ColMajor, Allocator2 > &u, Matrix< complex< float >, General, ColMajor, Allocator3 > &v, LapackInfo &info) |
template<class Prop1 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | GetSVD (Matrix< double, Prop1, ColMajor, Allocator1 > &A, Vector< double, VectFull, Allocator4 > &lambda, Matrix< double, General, ColMajor, Allocator2 > &u, Matrix< double, General, ColMajor, Allocator3 > &v, LapackInfo &info) |
template<class Prop1 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | GetSVD (Matrix< complex< double >, Prop1, ColMajor, Allocator1 > &A, Vector< double, VectFull, Allocator4 > &sigma, Matrix< complex< double >, General, ColMajor, Allocator2 > &u, Matrix< complex< double >, General, ColMajor, Allocator3 > &v, LapackInfo &info) |
template<class T , class Prop , class Storage , class Allocator > | |
void | GetPseudoInverse (Matrix< T, Prop, Storage, Allocator > &A, const T &epsilon, LapackInfo &info) |
template<class T , class Prop , class Storage , class Allocator > | |
void | GetPseudoInverse (Matrix< complex< T >, Prop, Storage, Allocator > &A, const T &epsilon, LapackInfo &info) |
template<class Alloc > | |
void | GetHessenberg (Matrix< complex< double >, General, ColMajor, Alloc > &A, Matrix< complex< double >, General, ColMajor, Alloc > &Q, LapackInfo &info) |
Reduces A to their Hessenberg form. More... | |
template<class Alloc > | |
void | GetHessenberg (Matrix< complex< double >, General, ColMajor, Alloc > &A, Matrix< complex< double >, General, ColMajor, Alloc > &B, Matrix< complex< double >, General, ColMajor, Alloc > &Q, Matrix< complex< double >, General, ColMajor, Alloc > &Z, LapackInfo &info) |
Reduces A and B to their Hessenberg form. More... | |
template<class Alloc > | |
void | GetQZ (Matrix< complex< double >, General, ColMajor, Alloc > &A, Matrix< complex< double >, General, ColMajor, Alloc > &B, Matrix< complex< double >, General, ColMajor, Alloc > &Q, Matrix< complex< double >, General, ColMajor, Alloc > &Z, LapackInfo &info) |
Reduces A and B to quasi-triangular matrices. More... | |
template<class Alloc > | |
void | GetHessenberg (Matrix< complex< double >, General, RowMajor, Alloc > &A, Matrix< complex< double >, General, RowMajor, Alloc > &Q, LapackInfo &info) |
template<class Alloc > | |
void | GetHessenberg (Matrix< complex< double >, General, RowMajor, Alloc > &A, Matrix< complex< double >, General, RowMajor, Alloc > &B, Matrix< complex< double >, General, RowMajor, Alloc > &Q, Matrix< complex< double >, General, RowMajor, Alloc > &Z, LapackInfo &info) |
template<class Alloc > | |
void | GetQZ (Matrix< complex< double >, General, RowMajor, Alloc > &A, Matrix< complex< double >, General, RowMajor, Alloc > &B, Matrix< complex< double >, General, RowMajor, Alloc > &Q, Matrix< complex< double >, General, RowMajor, Alloc > &Z, LapackInfo &info) |
template<class T , class Prop , class Storage , class Allocator , class Vector1 > | |
void | SolveHessenberg (Matrix< T, Prop, Storage, Allocator > &A, Vector1 &B) |
Gaussian elimination to solve A X = B with A an Hessenberg matrix. | |
template<class T , class Prop , class Storage , class Allocator , class Vector1 > | |
void | SolveHessenbergTwo (Matrix< T, Prop, Storage, Allocator > &A, Vector1 &B) |
Gaussian elimination to solve A X = B with A matrix so that a_ij = 0 for i > j+2. | |
template<class Prop , class Storage , class Allocator > | |
void | SolveSylvester (Matrix< complex< double >, Prop, Storage, Allocator > &A, Matrix< complex< double >, Prop, Storage, Allocator > &B, Matrix< complex< double >, Prop, Storage, Allocator > &C, Matrix< complex< double >, Prop, Storage, Allocator > &D, Matrix< complex< double >, Prop, Storage, Allocator > &E) |
Solves A X B^H + C X D^H = E, E is overwritten with result X. A, B, C and D are modified. | |
template<class Alloc > | |
void | GetHessenberg (Matrix< double, General, ColMajor, Alloc > &A, Matrix< double, General, ColMajor, Alloc > &Q, LapackInfo &info) |
template<class Alloc > | |
void | GetHessenberg (Matrix< double, General, ColMajor, Alloc > &A, Matrix< double, General, ColMajor, Alloc > &B, Matrix< double, General, ColMajor, Alloc > &Q, Matrix< double, General, ColMajor, Alloc > &Z, LapackInfo &info) |
Reduces A and B to their Hessenberg form. More... | |
template<class Alloc > | |
void | GetQZ (Matrix< double, General, ColMajor, Alloc > &A, Matrix< double, General, ColMajor, Alloc > &B, Matrix< double, General, ColMajor, Alloc > &Q, Matrix< double, General, ColMajor, Alloc > &Z, LapackInfo &info) |
Reduces A and B to quasi-triangular matrices. More... | |
template<class Alloc > | |
void | GetHessenberg (Matrix< double, General, RowMajor, Alloc > &A, Matrix< double, General, RowMajor, Alloc > &Q, LapackInfo &info) |
template<class Alloc > | |
void | GetHessenberg (Matrix< double, General, RowMajor, Alloc > &A, Matrix< double, General, RowMajor, Alloc > &B, Matrix< double, General, RowMajor, Alloc > &Q, Matrix< double, General, RowMajor, Alloc > &Z, LapackInfo &info) |
template<class Alloc > | |
void | GetQZ (Matrix< double, General, RowMajor, Alloc > &A, Matrix< double, General, RowMajor, Alloc > &B, Matrix< double, General, RowMajor, Alloc > &Q, Matrix< double, General, RowMajor > &Z, LapackInfo &info) |
template<class Prop , class Storage , class Allocator > | |
void | SolveSylvester (Matrix< double, Prop, Storage, Allocator > &A, Matrix< double, Prop, Storage, Allocator > &B, Matrix< double, Prop, Storage, Allocator > &C, Matrix< double, Prop, Storage, Allocator > &D, Matrix< double, Prop, Storage, Allocator > &E) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetQR (Matrix< float, Prop0, ColMajor, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &tau, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetQR (Matrix< double, Prop0, ColMajor, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &tau, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetQR (Matrix< complex< float >, Prop0, ColMajor, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator1 > &tau, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetQR (Matrix< complex< double >, Prop0, ColMajor, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator1 > &tau, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetQR (Matrix< float, Prop0, RowMajor, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &tau, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetQR (Matrix< double, Prop0, RowMajor, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &tau, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetQR (Matrix< complex< float >, Prop0, RowMajor, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator1 > &tau, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetQR (Matrix< complex< double >, Prop0, RowMajor, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator1 > &tau, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetQR_Pivot (Matrix< double, Prop0, ColMajor, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &tau, Vector< int > &ipivot, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetQ_FromQR (Matrix< float, Prop0, ColMajor, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &tau, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetQ_FromQR (Matrix< complex< float >, Prop0, ColMajor, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator1 > &tau, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetQ_FromQR (Matrix< double, Prop0, ColMajor, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &tau, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetQ_FromQR (Matrix< complex< double >, Prop0, ColMajor, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator1 > &tau, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetQ_FromLQ (Matrix< float, Prop0, ColMajor, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &tau, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetQ_FromLQ (Matrix< complex< float >, Prop0, ColMajor, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator1 > &tau, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetQ_FromLQ (Matrix< double, Prop0, ColMajor, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &tau, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetQ_FromLQ (Matrix< complex< double >, Prop0, ColMajor, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator1 > &tau, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetQ_FromQR (Matrix< float, Prop0, RowMajor, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &tau, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetQ_FromQR (Matrix< complex< float >, Prop0, RowMajor, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator1 > &tau, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetQ_FromQR (Matrix< double, Prop0, RowMajor, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &tau, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetQ_FromQR (Matrix< complex< double >, Prop0, RowMajor, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator1 > &tau, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetQ_FromLQ (Matrix< float, Prop0, RowMajor, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &tau, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetQ_FromLQ (Matrix< complex< float >, Prop0, RowMajor, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator1 > &tau, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetQ_FromLQ (Matrix< double, Prop0, RowMajor, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &tau, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetQ_FromLQ (Matrix< complex< double >, Prop0, RowMajor, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator1 > &tau, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetLQ (Matrix< float, Prop0, ColMajor, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &tau, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetLQ (Matrix< double, Prop0, ColMajor, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &tau, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetLQ (Matrix< complex< float >, Prop0, ColMajor, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator1 > &tau, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetLQ (Matrix< complex< double >, Prop0, ColMajor, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator1 > &tau, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetLQ (Matrix< float, Prop0, RowMajor, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &tau, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetLQ (Matrix< double, Prop0, RowMajor, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &tau, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetLQ (Matrix< complex< float >, Prop0, RowMajor, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator1 > &tau, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetLQ (Matrix< complex< double >, Prop0, RowMajor, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator1 > &tau, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltQ_FromQR (const SeldonTranspose &trans, const Matrix< float, Prop0, ColMajor, Allocator0 > &A, const Vector< float, VectFull, Allocator1 > &tau, Vector< float, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltQ_FromQR (const SeldonTranspose &trans, const Matrix< complex< float >, Prop0, ColMajor, Allocator0 > &A, const Vector< complex< float >, VectFull, Allocator1 > &tau, Vector< complex< float >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltQ_FromQR (const SeldonTranspose &trans, const Matrix< double, Prop0, ColMajor, Allocator0 > &A, const Vector< double, VectFull, Allocator1 > &tau, Vector< double, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltQ_FromQR (const SeldonTranspose &trans, const Matrix< complex< double >, Prop0, ColMajor, Allocator0 > &A, const Vector< complex< double >, VectFull, Allocator1 > &tau, Vector< complex< double >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltQ_FromQR (const SeldonSide &side, const SeldonTranspose &trans, const Matrix< float, Prop0, ColMajor, Allocator0 > &A, const Vector< float, VectFull, Allocator1 > &tau, Matrix< float, Prop0, ColMajor, Allocator2 > &C, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltQ_FromQR (const SeldonSide &side, const SeldonTranspose &trans, const Matrix< complex< float >, Prop0, ColMajor, Allocator0 > &A, const Vector< complex< float >, VectFull, Allocator1 > &tau, Matrix< complex< float >, Prop0, ColMajor, Allocator2 > &C, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltQ_FromQR (const SeldonSide &side, const SeldonTranspose &trans, const Matrix< double, Prop0, ColMajor, Allocator0 > &A, const Vector< double, VectFull, Allocator1 > &tau, Matrix< double, Prop0, ColMajor, Allocator2 > &C, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltQ_FromQR (const SeldonSide &side, const SeldonTranspose &trans, const Matrix< complex< double >, Prop0, ColMajor, Allocator0 > &A, const Vector< complex< double >, VectFull, Allocator1 > &tau, Matrix< complex< double >, Prop0, ColMajor, Allocator2 > &C, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltQ_FromLQ (const SeldonTranspose &trans, const Matrix< float, Prop0, ColMajor, Allocator0 > &A, const Vector< float, VectFull, Allocator1 > &tau, Vector< float, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltQ_FromLQ (const SeldonTranspose &trans, const Matrix< complex< float >, Prop0, ColMajor, Allocator0 > &A, const Vector< complex< float >, VectFull, Allocator1 > &tau, Vector< complex< float >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltQ_FromLQ (const SeldonTranspose &trans, const Matrix< double, Prop0, ColMajor, Allocator0 > &A, const Vector< double, VectFull, Allocator1 > &tau, Vector< double, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltQ_FromLQ (const SeldonTranspose &trans, const Matrix< complex< double >, Prop0, ColMajor, Allocator0 > &A, const Vector< complex< double >, VectFull, Allocator1 > &tau, Vector< complex< double >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltQ_FromLQ (const SeldonSide &side, const SeldonTranspose &trans, const Matrix< float, Prop0, ColMajor, Allocator0 > &A, const Vector< float, VectFull, Allocator1 > &tau, Matrix< float, Prop0, ColMajor, Allocator2 > &C, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltQ_FromLQ (const SeldonSide &side, const SeldonTranspose &trans, const Matrix< complex< float >, Prop0, ColMajor, Allocator0 > &A, const Vector< complex< float >, VectFull, Allocator1 > &tau, Matrix< complex< float >, Prop0, ColMajor, Allocator2 > &C, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltQ_FromLQ (const SeldonSide &side, const SeldonTranspose &trans, const Matrix< double, Prop0, ColMajor, Allocator0 > &A, const Vector< double, VectFull, Allocator1 > &tau, Matrix< double, Prop0, ColMajor, Allocator2 > &C, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltQ_FromLQ (const SeldonSide &side, const SeldonTranspose &trans, const Matrix< complex< double >, Prop0, ColMajor, Allocator0 > &A, const Vector< complex< double >, VectFull, Allocator1 > &tau, Matrix< complex< double >, Prop0, ColMajor, Allocator2 > &C, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltQ_FromQR (const SeldonTranspose &trans, const Matrix< float, Prop0, RowMajor, Allocator0 > &A, const Vector< float, VectFull, Allocator1 > &tau, Vector< float, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltQ_FromQR (const SeldonTranspose &trans, const Matrix< complex< float >, Prop0, RowMajor, Allocator0 > &A, const Vector< complex< float >, VectFull, Allocator1 > &tau, Vector< complex< float >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltQ_FromQR (const SeldonTranspose &trans, const Matrix< double, Prop0, RowMajor, Allocator0 > &A, const Vector< double, VectFull, Allocator1 > &tau, Vector< double, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltQ_FromQR (const SeldonTranspose &trans, const Matrix< complex< double >, Prop0, RowMajor, Allocator0 > &A, const Vector< complex< double >, VectFull, Allocator1 > &tau, Vector< complex< double >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltQ_FromQR (const SeldonSide &side, const SeldonTranspose &trans, const Matrix< float, Prop0, RowMajor, Allocator0 > &A, const Vector< float, VectFull, Allocator1 > &tau, Matrix< float, Prop0, RowMajor, Allocator2 > &C, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltQ_FromQR (const SeldonSide &side, const SeldonTranspose &trans, const Matrix< complex< float >, Prop0, RowMajor, Allocator0 > &A, const Vector< complex< float >, VectFull, Allocator1 > &tau, Matrix< complex< float >, Prop0, RowMajor, Allocator2 > &C, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltQ_FromQR (const SeldonSide &side, const SeldonTranspose &trans, const Matrix< double, Prop0, RowMajor, Allocator0 > &A, const Vector< double, VectFull, Allocator1 > &tau, Matrix< double, Prop0, RowMajor, Allocator2 > &C, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltQ_FromQR (const SeldonSide &side, const SeldonTranspose &trans, const Matrix< complex< double >, Prop0, RowMajor, Allocator0 > &A, const Vector< complex< double >, VectFull, Allocator1 > &tau, Matrix< complex< double >, Prop0, RowMajor, Allocator2 > &C, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltQ_FromLQ (const SeldonTranspose &trans, const Matrix< float, Prop0, RowMajor, Allocator0 > &A, const Vector< float, VectFull, Allocator1 > &tau, Vector< float, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltQ_FromLQ (const SeldonTranspose &trans, const Matrix< complex< float >, Prop0, RowMajor, Allocator0 > &A, const Vector< complex< float >, VectFull, Allocator1 > &tau, Vector< complex< float >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltQ_FromLQ (const SeldonTranspose &trans, const Matrix< double, Prop0, RowMajor, Allocator0 > &A, const Vector< double, VectFull, Allocator1 > &tau, Vector< double, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltQ_FromLQ (const SeldonTranspose &trans, const Matrix< complex< double >, Prop0, RowMajor, Allocator0 > &A, const Vector< complex< double >, VectFull, Allocator1 > &tau, Vector< complex< double >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltQ_FromLQ (const SeldonSide &side, const SeldonTranspose &trans, const Matrix< float, Prop0, RowMajor, Allocator0 > &A, const Vector< float, VectFull, Allocator1 > &tau, Matrix< float, Prop0, RowMajor, Allocator2 > &C, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltQ_FromLQ (const SeldonSide &side, const SeldonTranspose &trans, const Matrix< complex< float >, Prop0, RowMajor, Allocator0 > &A, const Vector< complex< float >, VectFull, Allocator1 > &tau, Matrix< complex< float >, Prop0, RowMajor, Allocator2 > &C, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltQ_FromLQ (const SeldonSide &side, const SeldonTranspose &trans, const Matrix< double, Prop0, RowMajor, Allocator0 > &A, const Vector< double, VectFull, Allocator1 > &tau, Matrix< double, Prop0, RowMajor, Allocator2 > &C, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | MltQ_FromLQ (const SeldonSide &side, const SeldonTranspose &trans, const Matrix< complex< double >, Prop0, RowMajor, Allocator0 > &A, const Vector< complex< double >, VectFull, Allocator1 > &tau, Matrix< complex< double >, Prop0, RowMajor, Allocator2 > &C, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveQR (const Matrix< float, Prop0, ColMajor, Allocator0 > &A, const Vector< float, VectFull, Allocator1 > &tau, Vector< float, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveQR (const Matrix< double, Prop0, ColMajor, Allocator0 > &A, const Vector< double, VectFull, Allocator1 > &tau, Vector< double, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveQR (const Matrix< complex< float >, Prop0, ColMajor, Allocator0 > &A, const Vector< complex< float >, VectFull, Allocator1 > &tau, Vector< complex< float >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveQR (const Matrix< complex< double >, Prop0, ColMajor, Allocator0 > &A, const Vector< complex< double >, VectFull, Allocator1 > &tau, Vector< complex< double >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveQR (const Matrix< float, Prop0, RowMajor, Allocator0 > &A, const Vector< float, VectFull, Allocator1 > &tau, Vector< float, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveQR (const Matrix< double, Prop0, RowMajor, Allocator0 > &A, const Vector< double, VectFull, Allocator1 > &tau, Vector< double, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveQR (const Matrix< double, Prop0, RowMajor, Allocator0 > &A, const Vector< double, VectFull, Allocator1 > &tau, Vector< complex< double >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveQR (const Matrix< complex< float >, Prop0, RowMajor, Allocator0 > &A, const Vector< complex< float >, VectFull, Allocator1 > &tau, Vector< complex< float >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveQR (const Matrix< complex< double >, Prop0, RowMajor, Allocator0 > &A, const Vector< complex< double >, VectFull, Allocator1 > &tau, Vector< complex< double >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveLQ (const Matrix< float, Prop0, ColMajor, Allocator0 > &A, const Vector< float, VectFull, Allocator1 > &tau, Vector< float, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveLQ (const Matrix< double, Prop0, ColMajor, Allocator0 > &A, const Vector< double, VectFull, Allocator1 > &tau, Vector< double, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveLQ (const Matrix< complex< float >, Prop0, ColMajor, Allocator0 > &A, const Vector< complex< float >, VectFull, Allocator1 > &tau, Vector< complex< float >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveLQ (const Matrix< complex< double >, Prop0, ColMajor, Allocator0 > &A, const Vector< complex< double >, VectFull, Allocator1 > &tau, Vector< complex< double >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveLQ (const Matrix< float, Prop0, RowMajor, Allocator0 > &A, const Vector< float, VectFull, Allocator1 > &tau, Vector< float, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveLQ (const Matrix< double, Prop0, RowMajor, Allocator0 > &A, const Vector< double, VectFull, Allocator1 > &tau, Vector< double, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveLQ (const Matrix< complex< float >, Prop0, RowMajor, Allocator0 > &A, const Vector< complex< float >, VectFull, Allocator1 > &tau, Vector< complex< float >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveLQ (const Matrix< complex< double >, Prop0, RowMajor, Allocator0 > &A, const Vector< complex< double >, VectFull, Allocator1 > &tau, Vector< complex< double >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class T , class Prop , class Storage , class Allocator , class T2 , class Prop2 , class Storage2 , class Allocator2 > | |
void | GetLowerTriangular (const Matrix< T, Prop, Storage, Allocator > &A, Matrix< T2, Prop2, Storage2, Allocator2 > &B) |
generic function to extract lower triangular part of a matrix More... | |
template<class T , class Prop , class Storage , class Allocator , class T2 , class Prop2 , class Storage2 , class Allocator2 > | |
void | GetUpperTriangular (const Matrix< T, Prop, Storage, Allocator > &A, Matrix< T2, Prop2, Storage2, Allocator2 > &B) |
generic function to extract upper triangular part of a matrix More... | |
template<class T , class Prop , class Storage , class Allocator , class T2 , class Prop2 , class Storage2 , class Allocator2 , class T3 , class Prop3 , class Storage3 , class Allocator3 > | |
void | GetQR (const Matrix< T, Prop, Storage, Allocator > &A, Matrix< T2, Prop2, Storage2, Allocator2 > &Q, Matrix< T3, Prop3, Storage3, Allocator3 > &R) |
Generic function to explicit Q and R from QR factorisation of a matrix. More... | |
template<class T , class Prop , class Storage , class Allocator , class T2 , class Prop2 , class Storage2 , class Allocator2 , class T3 , class Prop3 , class Storage3 , class Allocator3 > | |
void | GetLQ (const Matrix< T, Prop, Storage, Allocator > &A, Matrix< T2, Prop2, Storage2, Allocator2 > &L, Matrix< T3, Prop3, Storage3, Allocator3 > &Q) |
Generic function to explicit L, and Q from LQ factorisation of a matrix. More... | |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetLU (Matrix< float, Prop0, ColMajor, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetLU (Matrix< double, Prop0, ColMajor, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetLU (Matrix< complex< float >, Prop0, ColMajor, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetLU (Matrix< complex< double >, Prop0, ColMajor, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetLU (Matrix< float, Prop0, RowMajor, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetLU (Matrix< double, Prop0, RowMajor, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetLU (Matrix< complex< float >, Prop0, RowMajor, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetLU (Matrix< complex< double >, Prop0, RowMajor, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetLU (Matrix< float, Prop0, ColSym, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetLU (Matrix< double, Prop0, ColSym, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetLU (Matrix< complex< float >, Prop0, ColSym, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetLU (Matrix< complex< double >, Prop0, ColSym, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetLU (Matrix< float, Prop0, ColSymPacked, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetLU (Matrix< double, Prop0, ColSymPacked, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetLU (Matrix< complex< float >, Prop0, ColSymPacked, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetLU (Matrix< complex< double >, Prop0, ColSymPacked, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetLU (SeldonUplo Uplo, Matrix< float, Prop0, ColSymPacked, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetLU (SeldonUplo Uplo, Matrix< double, Prop0, ColSymPacked, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetLU (SeldonUplo Uplo, Matrix< complex< float >, Prop0, ColSymPacked, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetLU (SeldonUplo Uplo, Matrix< complex< double >, Prop0, ColSymPacked, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetLU (Matrix< float, Prop0, RowSym, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetLU (Matrix< double, Prop0, RowSym, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetLU (Matrix< complex< float >, Prop0, RowSym, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetLU (Matrix< complex< double >, Prop0, RowSym, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetLU (Matrix< float, Prop0, RowSymPacked, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetLU (Matrix< double, Prop0, RowSymPacked, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetLU (Matrix< complex< float >, Prop0, RowSymPacked, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetLU (Matrix< complex< double >, Prop0, RowSymPacked, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetLU (SeldonUplo Uplo, Matrix< float, Prop0, RowSymPacked, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetLU (SeldonUplo Uplo, Matrix< double, Prop0, RowSymPacked, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetLU (SeldonUplo Uplo, Matrix< complex< float >, Prop0, RowSymPacked, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetLU (SeldonUplo Uplo, Matrix< complex< double >, Prop0, RowSymPacked, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetLU (Matrix< complex< float >, Prop0, ColHerm, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetLU (Matrix< complex< double >, Prop0, ColHerm, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetLU (Matrix< complex< float >, Prop0, ColHermPacked, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetLU (Matrix< complex< double >, Prop0, ColHermPacked, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetLU (Matrix< complex< float >, Prop0, RowHerm, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetLU (Matrix< complex< double >, Prop0, RowHerm, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetLU (Matrix< complex< float >, Prop0, RowHermPacked, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | GetLU (Matrix< complex< double >, Prop0, RowHermPacked, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveLuVector (const Matrix< float, Prop0, ColMajor, Allocator0 > &A, const Vector< int, VectFull, Allocator1 > &P, Vector< float, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveLuVector (const Matrix< double, Prop0, ColMajor, Allocator0 > &A, const Vector< int, VectFull, Allocator1 > &P, Vector< double, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveLuVector (const Matrix< complex< float >, Prop0, ColMajor, Allocator0 > &A, const Vector< int, VectFull, Allocator1 > &P, Vector< complex< float >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveLuVector (const Matrix< complex< double >, Prop0, ColMajor, Allocator0 > &A, const Vector< int, VectFull, Allocator1 > &P, Vector< complex< double >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveLuVector (const SeldonTranspose &TransA, const Matrix< float, Prop0, ColMajor, Allocator0 > &A, const Vector< int, VectFull, Allocator1 > &P, Vector< float, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveLuVector (const SeldonTranspose &TransA, const Matrix< double, Prop0, ColMajor, Allocator0 > &A, const Vector< int, VectFull, Allocator1 > &P, Vector< double, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveLuVector (const SeldonTranspose &TransA, const Matrix< complex< float >, Prop0, ColMajor, Allocator0 > &A, const Vector< int, VectFull, Allocator1 > &P, Vector< complex< float >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveLuVector (const SeldonTranspose &TransA, const Matrix< complex< double >, Prop0, ColMajor, Allocator0 > &A, const Vector< int, VectFull, Allocator1 > &P, Vector< complex< double >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveLuVector (const Matrix< float, Prop0, RowMajor, Allocator0 > &A, const Vector< int, VectFull, Allocator1 > &P, Vector< float, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveLuVector (const Matrix< double, Prop0, RowMajor, Allocator0 > &A, const Vector< int, VectFull, Allocator1 > &P, Vector< double, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveLuVector (const Matrix< complex< float >, Prop0, RowMajor, Allocator0 > &A, const Vector< int, VectFull, Allocator1 > &P, Vector< complex< float >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveLuVector (const Matrix< complex< double >, Prop0, RowMajor, Allocator0 > &A, const Vector< int, VectFull, Allocator1 > &P, Vector< complex< double >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveLuVector (const SeldonTranspose &TransA, const Matrix< float, Prop0, RowMajor, Allocator0 > &A, const Vector< int, VectFull, Allocator1 > &P, Vector< float, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveLuVector (const SeldonTranspose &TransA, const Matrix< double, Prop0, RowMajor, Allocator0 > &A, const Vector< int, VectFull, Allocator1 > &P, Vector< double, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveLuVector (const SeldonTranspose &TransA, const Matrix< complex< float >, Prop0, RowMajor, Allocator0 > &A, const Vector< int, VectFull, Allocator1 > &P, Vector< complex< float >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveLuVector (const SeldonTranspose &TransA, const Matrix< complex< double >, Prop0, RowMajor, Allocator0 > &A, const Vector< int, VectFull, Allocator1 > &P, Vector< complex< double >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveLuVector (const Matrix< float, Prop0, ColSym, Allocator0 > &A, const Vector< int, VectFull, Allocator1 > &P, Vector< float, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveLuVector (const Matrix< double, Prop0, ColSym, Allocator0 > &A, const Vector< int, VectFull, Allocator1 > &P, Vector< double, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveLuVector (const Matrix< complex< float >, Prop0, ColSym, Allocator0 > &A, const Vector< int, VectFull, Allocator1 > &P, Vector< complex< float >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveLuVector (const Matrix< complex< double >, Prop0, ColSym, Allocator0 > &A, const Vector< int, VectFull, Allocator1 > &P, Vector< complex< double >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveLuVector (const Matrix< float, Prop0, ColSymPacked, Allocator0 > &A, const Vector< int, VectFull, Allocator1 > &P, Vector< float, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveLuVector (const Matrix< double, Prop0, ColSymPacked, Allocator0 > &A, const Vector< int, VectFull, Allocator1 > &P, Vector< double, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveLuVector (const Matrix< complex< float >, Prop0, ColSymPacked, Allocator0 > &A, const Vector< int, VectFull, Allocator1 > &P, Vector< complex< float >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveLuVector (const Matrix< complex< double >, Prop0, ColSymPacked, Allocator0 > &A, const Vector< int, VectFull, Allocator1 > &P, Vector< complex< double >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveLuVector (const Matrix< float, Prop0, RowSym, Allocator0 > &A, const Vector< int, VectFull, Allocator1 > &P, Vector< float, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveLuVector (const Matrix< double, Prop0, RowSym, Allocator0 > &A, const Vector< int, VectFull, Allocator1 > &P, Vector< double, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveLuVector (const Matrix< complex< float >, Prop0, RowSym, Allocator0 > &A, const Vector< int, VectFull, Allocator1 > &P, Vector< complex< float >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveLuVector (const Matrix< complex< double >, Prop0, RowSym, Allocator0 > &A, const Vector< int, VectFull, Allocator1 > &P, Vector< complex< double >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveLuVector (const Matrix< float, Prop0, RowSymPacked, Allocator0 > &A, const Vector< int, VectFull, Allocator1 > &P, Vector< float, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveLuVector (const Matrix< double, Prop0, RowSymPacked, Allocator0 > &A, const Vector< int, VectFull, Allocator1 > &P, Vector< double, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveLuVector (const Matrix< complex< float >, Prop0, RowSymPacked, Allocator0 > &A, const Vector< int, VectFull, Allocator1 > &P, Vector< complex< float >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveLuVector (const Matrix< complex< double >, Prop0, RowSymPacked, Allocator0 > &A, const Vector< int, VectFull, Allocator1 > &P, Vector< complex< double >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveLuVector (const Matrix< complex< float >, Prop0, ColHerm, Allocator0 > &A, const Vector< int, VectFull, Allocator1 > &P, Vector< complex< float >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveLuVector (const Matrix< complex< double >, Prop0, ColHerm, Allocator0 > &A, const Vector< int, VectFull, Allocator1 > &P, Vector< complex< double >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveLuVector (const Matrix< complex< float >, Prop0, ColHermPacked, Allocator0 > &A, const Vector< int, VectFull, Allocator1 > &P, Vector< complex< float >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveLuVector (const Matrix< complex< double >, Prop0, ColHermPacked, Allocator0 > &A, const Vector< int, VectFull, Allocator1 > &P, Vector< complex< double >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveLuVector (const Matrix< complex< float >, Prop0, RowHerm, Allocator0 > &A, const Vector< int, VectFull, Allocator1 > &P, Vector< complex< float >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveLuVector (const Matrix< complex< double >, Prop0, RowHerm, Allocator0 > &A, const Vector< int, VectFull, Allocator1 > &P, Vector< complex< double >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveLuVector (const Matrix< complex< float >, Prop0, RowHermPacked, Allocator0 > &A, const Vector< int, VectFull, Allocator1 > &P, Vector< complex< float >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | SolveLuVector (const Matrix< complex< double >, Prop0, RowHermPacked, Allocator0 > &A, const Vector< int, VectFull, Allocator1 > &P, Vector< complex< double >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const Matrix< float, Prop0, ColUpTriang, Allocator0 > &A, Vector< float, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const Matrix< double, Prop0, ColUpTriang, Allocator0 > &A, Vector< double, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const Matrix< complex< float >, Prop0, ColUpTriang, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const Matrix< complex< double >, Prop0, ColUpTriang, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< float, Prop0, ColUpTriang, Allocator0 > &A, Vector< float, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< double, Prop0, ColUpTriang, Allocator0 > &A, Vector< double, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< float >, Prop0, ColUpTriang, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< double >, Prop0, ColUpTriang, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const Matrix< float, Prop0, ColLoTriang, Allocator0 > &A, Vector< float, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const Matrix< double, Prop0, ColLoTriang, Allocator0 > &A, Vector< double, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const Matrix< complex< float >, Prop0, ColLoTriang, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const Matrix< complex< double >, Prop0, ColLoTriang, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< float, Prop0, ColLoTriang, Allocator0 > &A, Vector< float, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< double, Prop0, ColLoTriang, Allocator0 > &A, Vector< double, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< float >, Prop0, ColLoTriang, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< double >, Prop0, ColLoTriang, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const Matrix< float, Prop0, ColUpTriangPacked, Allocator0 > &A, Vector< float, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const Matrix< double, Prop0, ColUpTriangPacked, Allocator0 > &A, Vector< double, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const Matrix< complex< float >, Prop0, ColUpTriangPacked, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const Matrix< complex< double >, Prop0, ColUpTriangPacked, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< float, Prop0, ColUpTriangPacked, Allocator0 > &A, Vector< float, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< double, Prop0, ColUpTriangPacked, Allocator0 > &A, Vector< double, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< float >, Prop0, ColUpTriangPacked, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< double >, Prop0, ColUpTriangPacked, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const Matrix< float, Prop0, ColLoTriangPacked, Allocator0 > &A, Vector< float, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const Matrix< double, Prop0, ColLoTriangPacked, Allocator0 > &A, Vector< double, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const Matrix< complex< float >, Prop0, ColLoTriangPacked, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const Matrix< complex< double >, Prop0, ColLoTriangPacked, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< float, Prop0, ColLoTriangPacked, Allocator0 > &A, Vector< float, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< double, Prop0, ColLoTriangPacked, Allocator0 > &A, Vector< double, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< float >, Prop0, ColLoTriangPacked, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< double >, Prop0, ColLoTriangPacked, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const Matrix< float, Prop0, RowUpTriang, Allocator0 > &A, Vector< float, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const Matrix< double, Prop0, RowUpTriang, Allocator0 > &A, Vector< double, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const Matrix< complex< float >, Prop0, RowUpTriang, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const Matrix< complex< double >, Prop0, RowUpTriang, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< float, Prop0, RowUpTriang, Allocator0 > &A, Vector< float, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< double, Prop0, RowUpTriang, Allocator0 > &A, Vector< double, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< float >, Prop0, RowUpTriang, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< double >, Prop0, RowUpTriang, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const Matrix< float, Prop0, RowLoTriang, Allocator0 > &A, Vector< float, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const Matrix< double, Prop0, RowLoTriang, Allocator0 > &A, Vector< double, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const Matrix< complex< float >, Prop0, RowLoTriang, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const Matrix< complex< double >, Prop0, RowLoTriang, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< float, Prop0, RowLoTriang, Allocator0 > &A, Vector< float, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< double, Prop0, RowLoTriang, Allocator0 > &A, Vector< double, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< float >, Prop0, RowLoTriang, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< double >, Prop0, RowLoTriang, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const Matrix< float, Prop0, RowUpTriangPacked, Allocator0 > &A, Vector< float, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const Matrix< double, Prop0, RowUpTriangPacked, Allocator0 > &A, Vector< double, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const Matrix< complex< float >, Prop0, RowUpTriangPacked, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const Matrix< complex< double >, Prop0, RowUpTriangPacked, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< float, Prop0, RowUpTriangPacked, Allocator0 > &A, Vector< float, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< double, Prop0, RowUpTriangPacked, Allocator0 > &A, Vector< double, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< float >, Prop0, RowUpTriangPacked, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< double >, Prop0, RowUpTriangPacked, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const Matrix< float, Prop0, RowLoTriangPacked, Allocator0 > &A, Vector< float, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const Matrix< double, Prop0, RowLoTriangPacked, Allocator0 > &A, Vector< double, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const Matrix< complex< float >, Prop0, RowLoTriangPacked, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const Matrix< complex< double >, Prop0, RowLoTriangPacked, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< float, Prop0, RowLoTriangPacked, Allocator0 > &A, Vector< float, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< double, Prop0, RowLoTriangPacked, Allocator0 > &A, Vector< double, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< float >, Prop0, RowLoTriangPacked, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator2 > | |
void | SolveLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< double >, Prop0, RowLoTriangPacked, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
float | ReciprocalConditionNumber (const Matrix< float, Prop0, ColMajor, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, SeldonNorm norm, float anorm, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
double | ReciprocalConditionNumber (const Matrix< double, Prop0, ColMajor, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, SeldonNorm norm, double anorm, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
float | ReciprocalConditionNumber (const Matrix< complex< float >, Prop0, ColMajor, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, SeldonNorm norm, float anorm, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
double | ReciprocalConditionNumber (const Matrix< complex< double >, Prop0, ColMajor, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, SeldonNorm norm, double anorm, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
float | ReciprocalConditionNumber (const Matrix< float, Prop0, RowMajor, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, SeldonNorm norm, float anorm, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
double | ReciprocalConditionNumber (const Matrix< double, Prop0, RowMajor, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, SeldonNorm norm, double anorm, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
float | ReciprocalConditionNumber (const Matrix< complex< float >, Prop0, RowMajor, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, SeldonNorm norm, float anorm, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
double | ReciprocalConditionNumber (const Matrix< complex< double >, Prop0, RowMajor, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, SeldonNorm norm, double anorm, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
float | ReciprocalConditionNumber (const Matrix< float, Prop0, ColSym, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, SeldonNorm norm, float anorm, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
double | ReciprocalConditionNumber (const Matrix< double, Prop0, ColSym, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, SeldonNorm norm, double anorm, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
float | ReciprocalConditionNumber (const Matrix< complex< float >, Prop0, ColSym, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, SeldonNorm norm, float anorm, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
double | ReciprocalConditionNumber (const Matrix< complex< double >, Prop0, ColSym, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, SeldonNorm norm, double anorm, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
float | ReciprocalConditionNumber (const Matrix< float, Prop0, ColSymPacked, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, SeldonNorm norm, float anorm, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
double | ReciprocalConditionNumber (const Matrix< double, Prop0, ColSymPacked, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, SeldonNorm norm, double anorm, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
float | ReciprocalConditionNumber (const Matrix< complex< float >, Prop0, ColSymPacked, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, SeldonNorm norm, float anorm, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
double | ReciprocalConditionNumber (const Matrix< complex< double >, Prop0, ColSymPacked, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, SeldonNorm norm, double anorm, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
float | ReciprocalConditionNumber (const Matrix< float, Prop0, RowSym, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, SeldonNorm norm, float anorm, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
double | ReciprocalConditionNumber (const Matrix< double, Prop0, RowSym, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, SeldonNorm norm, double anorm, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
float | ReciprocalConditionNumber (const Matrix< complex< float >, Prop0, RowSym, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, SeldonNorm norm, float anorm, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
double | ReciprocalConditionNumber (const Matrix< complex< double >, Prop0, RowSym, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, SeldonNorm norm, double anorm, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
float | ReciprocalConditionNumber (const Matrix< float, Prop0, RowSymPacked, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, SeldonNorm norm, float anorm, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
double | ReciprocalConditionNumber (const Matrix< double, Prop0, RowSymPacked, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, SeldonNorm norm, double anorm, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
float | ReciprocalConditionNumber (const Matrix< complex< float >, Prop0, RowSymPacked, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, SeldonNorm norm, float anorm, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
double | ReciprocalConditionNumber (const Matrix< complex< double >, Prop0, RowSymPacked, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, SeldonNorm norm, double anorm, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
float | ReciprocalConditionNumber (const Matrix< complex< float >, Prop0, ColHerm, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, SeldonNorm norm, float anorm, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
double | ReciprocalConditionNumber (const Matrix< complex< double >, Prop0, ColHerm, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, SeldonNorm norm, double anorm, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
float | ReciprocalConditionNumber (const Matrix< complex< float >, Prop0, ColHermPacked, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, SeldonNorm norm, float anorm, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
double | ReciprocalConditionNumber (const Matrix< complex< double >, Prop0, ColHermPacked, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, SeldonNorm norm, double anorm, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
float | ReciprocalConditionNumber (const Matrix< complex< float >, Prop0, RowHerm, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, SeldonNorm norm, float anorm, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
double | ReciprocalConditionNumber (const Matrix< complex< double >, Prop0, RowHerm, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, SeldonNorm norm, double anorm, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
float | ReciprocalConditionNumber (const Matrix< complex< float >, Prop0, RowHermPacked, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, SeldonNorm norm, float anorm, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
double | ReciprocalConditionNumber (const Matrix< complex< double >, Prop0, RowHermPacked, Allocator0 > &A, Vector< int, VectFull, Allocator1 > &P, SeldonNorm norm, double anorm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
float | ReciprocalConditionNumber (const Matrix< float, Prop0, ColUpTriang, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
double | ReciprocalConditionNumber (const Matrix< double, Prop0, ColUpTriang, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
float | ReciprocalConditionNumber (const Matrix< complex< float >, Prop0, ColUpTriang, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
double | ReciprocalConditionNumber (const Matrix< complex< double >, Prop0, ColUpTriang, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
float | ReciprocalConditionNumber (const SeldonDiag &DiagA, const Matrix< float, Prop0, ColUpTriang, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
double | ReciprocalConditionNumber (const SeldonDiag &DiagA, const Matrix< double, Prop0, ColUpTriang, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
float | ReciprocalConditionNumber (const SeldonDiag &DiagA, const Matrix< complex< float >, Prop0, ColUpTriang, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
double | ReciprocalConditionNumber (const SeldonDiag &DiagA, const Matrix< complex< double >, Prop0, ColUpTriang, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
float | ReciprocalConditionNumber (const Matrix< float, Prop0, ColLoTriang, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
double | ReciprocalConditionNumber (const Matrix< double, Prop0, ColLoTriang, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
float | ReciprocalConditionNumber (const Matrix< complex< float >, Prop0, ColLoTriang, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
double | ReciprocalConditionNumber (const Matrix< complex< double >, Prop0, ColLoTriang, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
float | ReciprocalConditionNumber (const SeldonDiag &DiagA, const Matrix< float, Prop0, ColLoTriang, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
double | ReciprocalConditionNumber (const SeldonDiag &DiagA, const Matrix< double, Prop0, ColLoTriang, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
float | ReciprocalConditionNumber (const SeldonDiag &DiagA, const Matrix< complex< float >, Prop0, ColLoTriang, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
double | ReciprocalConditionNumber (const SeldonDiag &DiagA, const Matrix< complex< double >, Prop0, ColLoTriang, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
float | ReciprocalConditionNumber (const Matrix< float, Prop0, ColUpTriangPacked, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
double | ReciprocalConditionNumber (const Matrix< double, Prop0, ColUpTriangPacked, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
float | ReciprocalConditionNumber (const Matrix< complex< float >, Prop0, ColUpTriangPacked, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
double | ReciprocalConditionNumber (const Matrix< complex< double >, Prop0, ColUpTriangPacked, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
float | ReciprocalConditionNumber (const SeldonDiag &DiagA, const Matrix< float, Prop0, ColUpTriangPacked, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
double | ReciprocalConditionNumber (const SeldonDiag &DiagA, const Matrix< double, Prop0, ColUpTriangPacked, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
float | ReciprocalConditionNumber (const SeldonDiag &DiagA, const Matrix< complex< float >, Prop0, ColUpTriangPacked, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
double | ReciprocalConditionNumber (const SeldonDiag &DiagA, const Matrix< complex< double >, Prop0, ColUpTriangPacked, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
float | ReciprocalConditionNumber (const Matrix< float, Prop0, ColLoTriangPacked, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
double | ReciprocalConditionNumber (const Matrix< double, Prop0, ColLoTriangPacked, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
float | ReciprocalConditionNumber (const Matrix< complex< float >, Prop0, ColLoTriangPacked, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
double | ReciprocalConditionNumber (const Matrix< complex< double >, Prop0, ColLoTriangPacked, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
float | ReciprocalConditionNumber (const SeldonDiag &DiagA, const Matrix< float, Prop0, ColLoTriangPacked, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
double | ReciprocalConditionNumber (const SeldonDiag &DiagA, const Matrix< double, Prop0, ColLoTriangPacked, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
float | ReciprocalConditionNumber (const SeldonDiag &DiagA, const Matrix< complex< float >, Prop0, ColLoTriangPacked, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
double | ReciprocalConditionNumber (const SeldonDiag &DiagA, const Matrix< complex< double >, Prop0, ColLoTriangPacked, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
float | ReciprocalConditionNumber (const Matrix< float, Prop0, RowUpTriang, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
double | ReciprocalConditionNumber (const Matrix< double, Prop0, RowUpTriang, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
float | ReciprocalConditionNumber (const Matrix< complex< float >, Prop0, RowUpTriang, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
double | ReciprocalConditionNumber (const Matrix< complex< double >, Prop0, RowUpTriang, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
float | ReciprocalConditionNumber (const SeldonDiag &DiagA, const Matrix< float, Prop0, RowUpTriang, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
double | ReciprocalConditionNumber (const SeldonDiag &DiagA, const Matrix< double, Prop0, RowUpTriang, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
float | ReciprocalConditionNumber (const SeldonDiag &DiagA, const Matrix< complex< float >, Prop0, RowUpTriang, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
double | ReciprocalConditionNumber (const SeldonDiag &DiagA, const Matrix< complex< double >, Prop0, RowUpTriang, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
float | ReciprocalConditionNumber (const Matrix< float, Prop0, RowLoTriang, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
double | ReciprocalConditionNumber (const Matrix< double, Prop0, RowLoTriang, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
float | ReciprocalConditionNumber (const Matrix< complex< float >, Prop0, RowLoTriang, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
double | ReciprocalConditionNumber (const Matrix< complex< double >, Prop0, RowLoTriang, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
float | ReciprocalConditionNumber (const SeldonDiag &DiagA, const Matrix< float, Prop0, RowLoTriang, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
double | ReciprocalConditionNumber (const SeldonDiag &DiagA, const Matrix< double, Prop0, RowLoTriang, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
float | ReciprocalConditionNumber (const SeldonDiag &DiagA, const Matrix< complex< float >, Prop0, RowLoTriang, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
double | ReciprocalConditionNumber (const SeldonDiag &DiagA, const Matrix< complex< double >, Prop0, RowLoTriang, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
float | ReciprocalConditionNumber (const Matrix< float, Prop0, RowUpTriangPacked, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
double | ReciprocalConditionNumber (const Matrix< double, Prop0, RowUpTriangPacked, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
float | ReciprocalConditionNumber (const Matrix< complex< float >, Prop0, RowUpTriangPacked, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
double | ReciprocalConditionNumber (const Matrix< complex< double >, Prop0, RowUpTriangPacked, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
float | ReciprocalConditionNumber (const SeldonDiag &DiagA, const Matrix< float, Prop0, RowUpTriangPacked, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
double | ReciprocalConditionNumber (const SeldonDiag &DiagA, const Matrix< double, Prop0, RowUpTriangPacked, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
float | ReciprocalConditionNumber (const SeldonDiag &DiagA, const Matrix< complex< float >, Prop0, RowUpTriangPacked, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
double | ReciprocalConditionNumber (const SeldonDiag &DiagA, const Matrix< complex< double >, Prop0, RowUpTriangPacked, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
float | ReciprocalConditionNumber (const Matrix< float, Prop0, RowLoTriangPacked, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
double | ReciprocalConditionNumber (const Matrix< double, Prop0, RowLoTriangPacked, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
float | ReciprocalConditionNumber (const Matrix< complex< float >, Prop0, RowLoTriangPacked, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
double | ReciprocalConditionNumber (const Matrix< complex< double >, Prop0, RowLoTriangPacked, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
float | ReciprocalConditionNumber (const SeldonDiag &DiagA, const Matrix< float, Prop0, RowLoTriangPacked, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
double | ReciprocalConditionNumber (const SeldonDiag &DiagA, const Matrix< double, Prop0, RowLoTriangPacked, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
float | ReciprocalConditionNumber (const SeldonDiag &DiagA, const Matrix< complex< float >, Prop0, RowLoTriangPacked, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
double | ReciprocalConditionNumber (const SeldonDiag &DiagA, const Matrix< complex< double >, Prop0, RowLoTriangPacked, Allocator0 > &A, SeldonNorm norm, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | RefineSolutionLU (const Matrix< float, Prop0, ColMajor, Allocator0 > &A, const Matrix< float, Prop0, ColMajor, Allocator1 > &Alu, const Vector< int, VectFull, Allocator2 > &P, Vector< float, VectFull, Allocator3 > &x, const Vector< float, VectFull, Allocator4 > &b, float &ferr, float &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | RefineSolutionLU (const Matrix< double, Prop0, ColMajor, Allocator0 > &A, const Matrix< double, Prop0, ColMajor, Allocator1 > &Alu, const Vector< int, VectFull, Allocator2 > &P, Vector< double, VectFull, Allocator3 > &x, const Vector< double, VectFull, Allocator4 > &b, double &ferr, double &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | RefineSolutionLU (const Matrix< complex< float >, Prop0, ColMajor, Allocator0 > &A, const Matrix< complex< float >, Prop0, ColMajor, Allocator1 > &Alu, const Vector< int, VectFull, Allocator2 > &P, Vector< complex< float >, VectFull, Allocator3 > &x, const Vector< complex< float >, VectFull, Allocator4 > &b, float &ferr, float &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | RefineSolutionLU (const Matrix< complex< double >, Prop0, ColMajor, Allocator0 > &A, const Matrix< complex< double >, Prop0, ColMajor, Allocator1 > &Alu, const Vector< int, VectFull, Allocator2 > &P, Vector< complex< double >, VectFull, Allocator3 > &x, const Vector< complex< double >, VectFull, Allocator4 > &b, double &ferr, double &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | RefineSolutionLU (const SeldonTranspose &TransA, const Matrix< float, Prop0, ColMajor, Allocator0 > &A, const Matrix< float, Prop0, ColMajor, Allocator1 > &Alu, const Vector< int, VectFull, Allocator2 > &P, Vector< float, VectFull, Allocator3 > &x, const Vector< float, VectFull, Allocator4 > &b, float &ferr, float &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | RefineSolutionLU (const SeldonTranspose &TransA, const Matrix< double, Prop0, ColMajor, Allocator0 > &A, const Matrix< double, Prop0, ColMajor, Allocator1 > &Alu, const Vector< int, VectFull, Allocator2 > &P, Vector< double, VectFull, Allocator3 > &x, const Vector< double, VectFull, Allocator4 > &b, double &ferr, double &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | RefineSolutionLU (const SeldonTranspose &TransA, const Matrix< complex< float >, Prop0, ColMajor, Allocator0 > &A, const Matrix< complex< float >, Prop0, ColMajor, Allocator1 > &Alu, const Vector< int, VectFull, Allocator2 > &P, Vector< complex< float >, VectFull, Allocator3 > &x, const Vector< complex< float >, VectFull, Allocator4 > &b, float &ferr, float &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | RefineSolutionLU (const SeldonTranspose &TransA, const Matrix< complex< double >, Prop0, ColMajor, Allocator0 > &A, const Matrix< complex< double >, Prop0, ColMajor, Allocator1 > &Alu, const Vector< int, VectFull, Allocator2 > &P, Vector< complex< double >, VectFull, Allocator3 > &x, const Vector< complex< double >, VectFull, Allocator4 > &b, double &ferr, double &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | RefineSolutionLU (const Matrix< float, Prop0, RowMajor, Allocator0 > &A, const Matrix< float, Prop0, RowMajor, Allocator1 > &Alu, const Vector< int, VectFull, Allocator2 > &P, Vector< float, VectFull, Allocator3 > &x, const Vector< float, VectFull, Allocator4 > &b, float &ferr, float &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | RefineSolutionLU (const Matrix< double, Prop0, RowMajor, Allocator0 > &A, const Matrix< double, Prop0, RowMajor, Allocator1 > &Alu, const Vector< int, VectFull, Allocator2 > &P, Vector< double, VectFull, Allocator3 > &x, const Vector< double, VectFull, Allocator4 > &b, double &ferr, double &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | RefineSolutionLU (const Matrix< complex< float >, Prop0, RowMajor, Allocator0 > &A, const Matrix< complex< float >, Prop0, RowMajor, Allocator1 > &Alu, const Vector< int, VectFull, Allocator2 > &P, Vector< complex< float >, VectFull, Allocator3 > &x, const Vector< complex< float >, VectFull, Allocator4 > &b, float &ferr, float &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | RefineSolutionLU (const Matrix< complex< double >, Prop0, RowMajor, Allocator0 > &A, const Matrix< complex< double >, Prop0, RowMajor, Allocator1 > &Alu, const Vector< int, VectFull, Allocator2 > &P, Vector< complex< double >, VectFull, Allocator3 > &x, const Vector< complex< double >, VectFull, Allocator4 > &b, double &ferr, double &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | RefineSolutionLU (const SeldonTranspose &TransA, const Matrix< float, Prop0, RowMajor, Allocator0 > &A, const Matrix< float, Prop0, RowMajor, Allocator1 > &Alu, const Vector< int, VectFull, Allocator2 > &P, Vector< float, VectFull, Allocator3 > &x, const Vector< float, VectFull, Allocator4 > &b, float &ferr, float &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | RefineSolutionLU (const SeldonTranspose &TransA, const Matrix< double, Prop0, RowMajor, Allocator0 > &A, const Matrix< double, Prop0, RowMajor, Allocator1 > &Alu, const Vector< int, VectFull, Allocator2 > &P, Vector< double, VectFull, Allocator3 > &x, const Vector< double, VectFull, Allocator4 > &b, double &ferr, double &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | RefineSolutionLU (const SeldonTranspose &TransA, const Matrix< complex< float >, Prop0, RowMajor, Allocator0 > &A, const Matrix< complex< float >, Prop0, RowMajor, Allocator1 > &Alu, const Vector< int, VectFull, Allocator2 > &P, Vector< complex< float >, VectFull, Allocator3 > &x, Vector< complex< float >, VectFull, Allocator4 > &b, float &ferr, float &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | RefineSolutionLU (const SeldonTranspose &TransA, const Matrix< complex< double >, Prop0, RowMajor, Allocator0 > &A, const Matrix< complex< double >, Prop0, RowMajor, Allocator1 > &Alu, const Vector< int, VectFull, Allocator2 > &P, Vector< complex< double >, VectFull, Allocator3 > &x, Vector< complex< double >, VectFull, Allocator4 > &b, double &ferr, double &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | RefineSolutionLU (const Matrix< float, Prop0, ColSym, Allocator0 > &A, const Matrix< float, Prop0, ColSym, Allocator1 > &Alu, const Vector< int, VectFull, Allocator2 > &P, Vector< float, VectFull, Allocator3 > &x, const Vector< float, VectFull, Allocator4 > &b, float &ferr, float &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | RefineSolutionLU (const Matrix< double, Prop0, ColSym, Allocator0 > &A, const Matrix< double, Prop0, ColSym, Allocator1 > &Alu, const Vector< int, VectFull, Allocator2 > &P, Vector< double, VectFull, Allocator3 > &x, const Vector< double, VectFull, Allocator4 > &b, double &ferr, double &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | RefineSolutionLU (const Matrix< complex< float >, Prop0, ColSym, Allocator0 > &A, const Matrix< complex< float >, Prop0, ColSym, Allocator1 > &Alu, const Vector< int, VectFull, Allocator2 > &P, Vector< complex< float >, VectFull, Allocator3 > &x, const Vector< complex< float >, VectFull, Allocator4 > &b, float &ferr, float &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | RefineSolutionLU (const Matrix< complex< double >, Prop0, ColSym, Allocator0 > &A, const Matrix< complex< double >, Prop0, ColSym, Allocator1 > &Alu, const Vector< int, VectFull, Allocator2 > &P, Vector< complex< double >, VectFull, Allocator3 > &x, const Vector< complex< double >, VectFull, Allocator4 > &b, double &ferr, double &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | RefineSolutionLU (const Matrix< float, Prop0, ColSymPacked, Allocator0 > &A, const Matrix< float, Prop0, ColSymPacked, Allocator1 > &Alu, const Vector< int, VectFull, Allocator2 > &P, Vector< float, VectFull, Allocator3 > &x, const Vector< float, VectFull, Allocator4 > &b, float &ferr, float &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | RefineSolutionLU (const Matrix< double, Prop0, ColSymPacked, Allocator0 > &A, const Matrix< double, Prop0, ColSymPacked, Allocator1 > &Alu, const Vector< int, VectFull, Allocator2 > &P, Vector< double, VectFull, Allocator3 > &x, const Vector< double, VectFull, Allocator4 > &b, double &ferr, double &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | RefineSolutionLU (const Matrix< complex< float >, Prop0, ColSymPacked, Allocator0 > &A, const Matrix< complex< float >, Prop0, ColSymPacked, Allocator1 > &Alu, const Vector< int, VectFull, Allocator2 > &P, Vector< complex< float >, VectFull, Allocator3 > &x, const Vector< complex< float >, VectFull, Allocator4 > &b, float &ferr, float &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | RefineSolutionLU (const Matrix< complex< double >, Prop0, ColSymPacked, Allocator0 > &A, const Matrix< complex< double >, Prop0, ColSymPacked, Allocator1 > &Alu, const Vector< int, VectFull, Allocator2 > &P, Vector< complex< double >, VectFull, Allocator3 > &x, const Vector< complex< double >, VectFull, Allocator4 > &b, double &ferr, double &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | RefineSolutionLU (const Matrix< float, Prop0, RowSym, Allocator0 > &A, const Matrix< float, Prop0, RowSym, Allocator1 > &Alu, const Vector< int, VectFull, Allocator2 > &P, Vector< float, VectFull, Allocator3 > &x, const Vector< float, VectFull, Allocator4 > &b, float &ferr, float &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | RefineSolutionLU (const Matrix< double, Prop0, RowSym, Allocator0 > &A, const Matrix< double, Prop0, RowSym, Allocator1 > &Alu, const Vector< int, VectFull, Allocator2 > &P, Vector< double, VectFull, Allocator3 > &x, const Vector< double, VectFull, Allocator4 > &b, double &ferr, double &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | RefineSolutionLU (const Matrix< complex< float >, Prop0, RowSym, Allocator0 > &A, const Matrix< complex< float >, Prop0, RowSym, Allocator1 > &Alu, const Vector< int, VectFull, Allocator2 > &P, Vector< complex< float >, VectFull, Allocator3 > &x, const Vector< complex< float >, VectFull, Allocator4 > &b, float &ferr, float &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | RefineSolutionLU (const Matrix< complex< double >, Prop0, RowSym, Allocator0 > &A, const Matrix< complex< double >, Prop0, RowSym, Allocator1 > &Alu, const Vector< int, VectFull, Allocator2 > &P, Vector< complex< double >, VectFull, Allocator3 > &x, const Vector< complex< double >, VectFull, Allocator4 > &b, double &ferr, double &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | RefineSolutionLU (const Matrix< float, Prop0, RowSymPacked, Allocator0 > &A, const Matrix< float, Prop0, RowSymPacked, Allocator1 > &Alu, const Vector< int, VectFull, Allocator2 > &P, Vector< float, VectFull, Allocator3 > &x, const Vector< float, VectFull, Allocator4 > &b, float &ferr, float &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | RefineSolutionLU (const Matrix< double, Prop0, RowSymPacked, Allocator0 > &A, const Matrix< double, Prop0, RowSymPacked, Allocator1 > &Alu, const Vector< int, VectFull, Allocator2 > &P, Vector< double, VectFull, Allocator3 > &x, const Vector< double, VectFull, Allocator4 > &b, double &ferr, double &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | RefineSolutionLU (const Matrix< complex< float >, Prop0, RowSymPacked, Allocator0 > &A, const Matrix< complex< float >, Prop0, RowSymPacked, Allocator1 > &Alu, const Vector< int, VectFull, Allocator2 > &P, Vector< complex< float >, VectFull, Allocator3 > &x, const Vector< complex< float >, VectFull, Allocator4 > &b, float &ferr, float &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | RefineSolutionLU (const Matrix< complex< double >, Prop0, RowSymPacked, Allocator0 > &A, const Matrix< complex< double >, Prop0, RowSymPacked, Allocator1 > &Alu, const Vector< int, VectFull, Allocator2 > &P, Vector< complex< double >, VectFull, Allocator3 > &x, const Vector< complex< double >, VectFull, Allocator4 > &b, double &ferr, double &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | RefineSolutionLU (const Matrix< complex< float >, Prop0, ColHerm, Allocator0 > &A, const Matrix< complex< float >, Prop0, ColHerm, Allocator1 > &Alu, const Vector< int, VectFull, Allocator2 > &P, Vector< complex< float >, VectFull, Allocator3 > &x, const Vector< complex< float >, VectFull, Allocator4 > &b, float &ferr, float &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | RefineSolutionLU (const Matrix< complex< double >, Prop0, ColHerm, Allocator0 > &A, const Matrix< complex< double >, Prop0, ColHerm, Allocator1 > &Alu, const Vector< int, VectFull, Allocator2 > &P, Vector< complex< double >, VectFull, Allocator3 > &x, const Vector< complex< double >, VectFull, Allocator4 > &b, double &ferr, double &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | RefineSolutionLU (const Matrix< complex< float >, Prop0, ColHermPacked, Allocator0 > &A, const Matrix< complex< float >, Prop0, ColHermPacked, Allocator1 > &Alu, const Vector< int, VectFull, Allocator2 > &P, Vector< complex< float >, VectFull, Allocator3 > &x, const Vector< complex< float >, VectFull, Allocator4 > &b, float &ferr, float &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | RefineSolutionLU (const Matrix< complex< double >, Prop0, ColHermPacked, Allocator0 > &A, const Matrix< complex< double >, Prop0, ColHermPacked, Allocator1 > &Alu, const Vector< int, VectFull, Allocator2 > &P, Vector< complex< double >, VectFull, Allocator3 > &x, const Vector< complex< double >, VectFull, Allocator4 > &b, double &ferr, double &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | RefineSolutionLU (const Matrix< complex< float >, Prop0, RowHerm, Allocator0 > &A, const Matrix< complex< float >, Prop0, RowHerm, Allocator1 > &Alu, const Vector< int, VectFull, Allocator2 > &P, Vector< complex< float >, VectFull, Allocator3 > &x, Vector< complex< float >, VectFull, Allocator4 > &b, float &ferr, float &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | RefineSolutionLU (const Matrix< complex< double >, Prop0, RowHerm, Allocator0 > &A, const Matrix< complex< double >, Prop0, RowHerm, Allocator1 > &Alu, const Vector< int, VectFull, Allocator2 > &P, Vector< complex< double >, VectFull, Allocator3 > &x, Vector< complex< double >, VectFull, Allocator4 > &b, double &ferr, double &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | RefineSolutionLU (const Matrix< complex< float >, Prop0, RowHermPacked, Allocator0 > &A, const Matrix< complex< float >, Prop0, RowHermPacked, Allocator1 > &Alu, const Vector< int, VectFull, Allocator2 > &P, Vector< complex< float >, VectFull, Allocator3 > &x, Vector< complex< float >, VectFull, Allocator4 > &b, float &ferr, float &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | RefineSolutionLU (const Matrix< complex< double >, Prop0, RowHermPacked, Allocator0 > &A, const Matrix< complex< double >, Prop0, RowHermPacked, Allocator1 > &Alu, const Vector< int, VectFull, Allocator2 > &P, Vector< complex< double >, VectFull, Allocator3 > &x, Vector< complex< double >, VectFull, Allocator4 > &b, double &ferr, double &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const Matrix< float, Prop0, ColUpTriang, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &x, const Vector< float, VectFull, Allocator2 > &b, float &ferr, float &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const Matrix< double, Prop0, ColUpTriang, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &x, const Vector< double, VectFull, Allocator2 > &b, double &ferr, double &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const Matrix< complex< float >, Prop0, ColUpTriang, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator1 > &x, const Vector< complex< float >, VectFull, Allocator2 > &b, float &ferr, float &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const Matrix< complex< double >, Prop0, ColUpTriang, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator1 > &x, const Vector< complex< double >, VectFull, Allocator2 > &b, double &ferr, double &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< float, Prop0, ColUpTriang, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &x, const Vector< float, VectFull, Allocator2 > &b, float &ferr, float &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< double, Prop0, ColUpTriang, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &x, const Vector< double, VectFull, Allocator2 > &b, double &ferr, double &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< float >, Prop0, ColUpTriang, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator1 > &x, const Vector< complex< float >, VectFull, Allocator2 > &b, float &ferr, float &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< double >, Prop0, ColUpTriang, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator1 > &x, const Vector< complex< double >, VectFull, Allocator2 > &b, double &ferr, double &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const Matrix< float, Prop0, ColLoTriang, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &x, const Vector< float, VectFull, Allocator2 > &b, float &ferr, float &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const Matrix< double, Prop0, ColLoTriang, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &x, const Vector< double, VectFull, Allocator2 > &b, double &ferr, double &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const Matrix< complex< float >, Prop0, ColLoTriang, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator1 > &x, const Vector< complex< float >, VectFull, Allocator2 > &b, float &ferr, float &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const Matrix< complex< double >, Prop0, ColLoTriang, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator1 > &x, const Vector< complex< double >, VectFull, Allocator2 > &b, double &ferr, double &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< float, Prop0, ColLoTriang, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &x, const Vector< float, VectFull, Allocator2 > &b, float &ferr, float &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< double, Prop0, ColLoTriang, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &x, const Vector< double, VectFull, Allocator2 > &b, double &ferr, double &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< float >, Prop0, ColLoTriang, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator1 > &x, const Vector< complex< float >, VectFull, Allocator2 > &b, float &ferr, float &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< double >, Prop0, ColLoTriang, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator1 > &x, const Vector< complex< double >, VectFull, Allocator2 > &b, double &ferr, double &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const Matrix< float, Prop0, ColUpTriangPacked, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &x, const Vector< float, VectFull, Allocator2 > &b, float &ferr, float &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const Matrix< double, Prop0, ColUpTriangPacked, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &x, const Vector< double, VectFull, Allocator2 > &b, double &ferr, double &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const Matrix< complex< float >, Prop0, ColUpTriangPacked, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator1 > &x, const Vector< complex< float >, VectFull, Allocator2 > &b, float &ferr, float &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const Matrix< complex< double >, Prop0, ColUpTriangPacked, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator1 > &x, const Vector< complex< double >, VectFull, Allocator2 > &b, double &ferr, double &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< float, Prop0, ColUpTriangPacked, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &x, const Vector< float, VectFull, Allocator2 > &b, float &ferr, float &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< double, Prop0, ColUpTriangPacked, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &x, const Vector< double, VectFull, Allocator2 > &b, double &ferr, double &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< float >, Prop0, ColUpTriangPacked, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator1 > &x, const Vector< complex< float >, VectFull, Allocator2 > &b, float &ferr, float &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< double >, Prop0, ColUpTriangPacked, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator1 > &x, const Vector< complex< double >, VectFull, Allocator2 > &b, double &ferr, double &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const Matrix< float, Prop0, ColLoTriangPacked, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &x, const Vector< float, VectFull, Allocator2 > &b, float &ferr, float &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const Matrix< double, Prop0, ColLoTriangPacked, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &x, const Vector< double, VectFull, Allocator2 > &b, double &ferr, double &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const Matrix< complex< float >, Prop0, ColLoTriangPacked, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator1 > &x, const Vector< complex< float >, VectFull, Allocator2 > &b, float &ferr, float &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const Matrix< complex< double >, Prop0, ColLoTriangPacked, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator1 > &x, const Vector< complex< double >, VectFull, Allocator2 > &b, double &ferr, double &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< float, Prop0, ColLoTriangPacked, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &x, const Vector< float, VectFull, Allocator2 > &b, float &ferr, float &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< double, Prop0, ColLoTriangPacked, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &x, const Vector< double, VectFull, Allocator2 > &b, double &ferr, double &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< float >, Prop0, ColLoTriangPacked, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator1 > &x, const Vector< complex< float >, VectFull, Allocator2 > &b, float &ferr, float &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< double >, Prop0, ColLoTriangPacked, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator1 > &x, const Vector< complex< double >, VectFull, Allocator2 > &b, double &ferr, double &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const Matrix< float, Prop0, RowUpTriang, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &x, const Vector< float, VectFull, Allocator2 > &b, float &ferr, float &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const Matrix< double, Prop0, RowUpTriang, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &x, const Vector< double, VectFull, Allocator2 > &b, double &ferr, double &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const Matrix< complex< float >, Prop0, RowUpTriang, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator1 > &x, const Vector< complex< float >, VectFull, Allocator2 > &b, float &ferr, float &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const Matrix< complex< double >, Prop0, RowUpTriang, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator1 > &x, const Vector< complex< double >, VectFull, Allocator2 > &b, double &ferr, double &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< float, Prop0, RowUpTriang, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &x, const Vector< float, VectFull, Allocator2 > &b, float &ferr, float &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< double, Prop0, RowUpTriang, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &x, const Vector< double, VectFull, Allocator2 > &b, double &ferr, double &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< float >, Prop0, RowUpTriang, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator1 > &x, Vector< complex< float >, VectFull, Allocator2 > &b, float &ferr, float &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< double >, Prop0, RowUpTriang, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator1 > &x, Vector< complex< double >, VectFull, Allocator2 > &b, double &ferr, double &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const Matrix< float, Prop0, RowLoTriang, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &x, const Vector< float, VectFull, Allocator2 > &b, float &ferr, float &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const Matrix< double, Prop0, RowLoTriang, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &x, const Vector< double, VectFull, Allocator2 > &b, double &ferr, double &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const Matrix< complex< float >, Prop0, RowLoTriang, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator1 > &x, const Vector< complex< float >, VectFull, Allocator2 > &b, float &ferr, float &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const Matrix< complex< double >, Prop0, RowLoTriang, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator1 > &x, const Vector< complex< double >, VectFull, Allocator2 > &b, double &ferr, double &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< float, Prop0, RowLoTriang, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &x, const Vector< float, VectFull, Allocator2 > &b, float &ferr, float &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< double, Prop0, RowLoTriang, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &x, const Vector< double, VectFull, Allocator2 > &b, double &ferr, double &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< float >, Prop0, RowLoTriang, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator1 > &x, Vector< complex< float >, VectFull, Allocator2 > &b, float &ferr, float &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< double >, Prop0, RowLoTriang, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator1 > &x, Vector< complex< double >, VectFull, Allocator2 > &b, double &ferr, double &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const Matrix< float, Prop0, RowUpTriangPacked, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &x, const Vector< float, VectFull, Allocator2 > &b, float &ferr, float &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const Matrix< double, Prop0, RowUpTriangPacked, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &x, const Vector< double, VectFull, Allocator2 > &b, double &ferr, double &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const Matrix< complex< float >, Prop0, RowUpTriangPacked, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator1 > &x, const Vector< complex< float >, VectFull, Allocator2 > &b, float &ferr, float &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const Matrix< complex< double >, Prop0, RowUpTriangPacked, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator1 > &x, const Vector< complex< double >, VectFull, Allocator2 > &b, double &ferr, double &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< float, Prop0, RowUpTriangPacked, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &x, const Vector< float, VectFull, Allocator2 > &b, float &ferr, float &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< double, Prop0, RowUpTriangPacked, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &x, const Vector< double, VectFull, Allocator2 > &b, double &ferr, double &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< float >, Prop0, RowUpTriangPacked, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator1 > &x, Vector< complex< float >, VectFull, Allocator2 > &b, float &ferr, float &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< double >, Prop0, RowUpTriangPacked, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator1 > &x, Vector< complex< double >, VectFull, Allocator2 > &b, double &ferr, double &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const Matrix< float, Prop0, RowLoTriangPacked, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &x, const Vector< float, VectFull, Allocator2 > &b, float &ferr, float &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const Matrix< double, Prop0, RowLoTriangPacked, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &x, const Vector< double, VectFull, Allocator2 > &b, double &ferr, double &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const Matrix< complex< float >, Prop0, RowLoTriangPacked, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator1 > &x, const Vector< complex< float >, VectFull, Allocator2 > &b, float &ferr, float &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const Matrix< complex< double >, Prop0, RowLoTriangPacked, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator1 > &x, const Vector< complex< double >, VectFull, Allocator2 > &b, double &ferr, double &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< float, Prop0, RowLoTriangPacked, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &x, const Vector< float, VectFull, Allocator2 > &b, float &ferr, float &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< double, Prop0, RowLoTriangPacked, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &x, const Vector< double, VectFull, Allocator2 > &b, double &ferr, double &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< float >, Prop0, RowLoTriangPacked, Allocator0 > &A, Vector< complex< float >, VectFull, Allocator1 > &x, Vector< complex< float >, VectFull, Allocator2 > &b, float &ferr, float &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | RefineSolutionLU (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< double >, Prop0, RowLoTriangPacked, Allocator0 > &A, Vector< complex< double >, VectFull, Allocator1 > &x, Vector< complex< double >, VectFull, Allocator2 > &b, double &ferr, double &berr, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< float, Prop0, ColMajor, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< double, Prop0, ColMajor, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< complex< float >, Prop0, ColMajor, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< complex< double >, Prop0, ColMajor, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< float, Prop0, RowMajor, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< double, Prop0, RowMajor, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< complex< float >, Prop0, RowMajor, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< complex< double >, Prop0, RowMajor, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< float, Prop0, ColSym, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< double, Prop0, ColSym, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< complex< float >, Prop0, ColSym, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< complex< double >, Prop0, ColSym, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< float, Prop0, ColSymPacked, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< double, Prop0, ColSymPacked, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< complex< float >, Prop0, ColSymPacked, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< complex< double >, Prop0, ColSymPacked, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< float, Prop0, RowSym, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< double, Prop0, RowSym, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< complex< float >, Prop0, RowSym, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< complex< double >, Prop0, RowSym, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< float, Prop0, RowSymPacked, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< double, Prop0, RowSymPacked, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< complex< float >, Prop0, RowSymPacked, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< complex< double >, Prop0, RowSymPacked, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< complex< float >, Prop0, ColHerm, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< complex< double >, Prop0, ColHerm, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< complex< float >, Prop0, ColHermPacked, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< complex< double >, Prop0, ColHermPacked, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< complex< float >, Prop0, RowHerm, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< complex< double >, Prop0, RowHerm, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< complex< float >, Prop0, RowHermPacked, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< complex< double >, Prop0, RowHermPacked, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< float, Prop0, ColUpTriang, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< double, Prop0, ColUpTriang, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< complex< float >, Prop0, ColUpTriang, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< complex< double >, Prop0, ColUpTriang, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (const SeldonDiag &DiagA, Matrix< float, Prop0, ColUpTriang, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (const SeldonDiag &DiagA, Matrix< double, Prop0, ColUpTriang, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (const SeldonDiag &DiagA, Matrix< complex< float >, Prop0, ColUpTriang, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (const SeldonDiag &DiagA, Matrix< complex< double >, Prop0, ColUpTriang, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< float, Prop0, ColLoTriang, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< double, Prop0, ColLoTriang, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< complex< float >, Prop0, ColLoTriang, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< complex< double >, Prop0, ColLoTriang, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (const SeldonDiag &DiagA, Matrix< float, Prop0, ColLoTriang, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (const SeldonDiag &DiagA, Matrix< double, Prop0, ColLoTriang, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (const SeldonDiag &DiagA, Matrix< complex< float >, Prop0, ColLoTriang, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (const SeldonDiag &DiagA, Matrix< complex< double >, Prop0, ColLoTriang, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< float, Prop0, ColUpTriangPacked, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< double, Prop0, ColUpTriangPacked, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< complex< float >, Prop0, ColUpTriangPacked, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< complex< double >, Prop0, ColUpTriangPacked, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (const SeldonDiag &DiagA, Matrix< float, Prop0, ColUpTriangPacked, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (const SeldonDiag &DiagA, Matrix< double, Prop0, ColUpTriangPacked, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (const SeldonDiag &DiagA, Matrix< complex< float >, Prop0, ColUpTriangPacked, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (const SeldonDiag &DiagA, Matrix< complex< double >, Prop0, ColUpTriangPacked, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< float, Prop0, ColLoTriangPacked, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< double, Prop0, ColLoTriangPacked, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< complex< float >, Prop0, ColLoTriangPacked, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< complex< double >, Prop0, ColLoTriangPacked, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (const SeldonDiag &DiagA, Matrix< float, Prop0, ColLoTriangPacked, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (const SeldonDiag &DiagA, Matrix< double, Prop0, ColLoTriangPacked, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (const SeldonDiag &DiagA, Matrix< complex< float >, Prop0, ColLoTriangPacked, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (const SeldonDiag &DiagA, Matrix< complex< double >, Prop0, ColLoTriangPacked, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< float, Prop0, RowUpTriang, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< double, Prop0, RowUpTriang, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< complex< float >, Prop0, RowUpTriang, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< complex< double >, Prop0, RowUpTriang, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (const SeldonDiag &DiagA, Matrix< float, Prop0, RowUpTriang, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (const SeldonDiag &DiagA, Matrix< double, Prop0, RowUpTriang, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (const SeldonDiag &DiagA, Matrix< complex< float >, Prop0, RowUpTriang, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (const SeldonDiag &DiagA, Matrix< complex< double >, Prop0, RowUpTriang, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< float, Prop0, RowLoTriang, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< double, Prop0, RowLoTriang, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< complex< float >, Prop0, RowLoTriang, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< complex< double >, Prop0, RowLoTriang, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (const SeldonDiag &DiagA, Matrix< float, Prop0, RowLoTriang, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (const SeldonDiag &DiagA, Matrix< double, Prop0, RowLoTriang, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (const SeldonDiag &DiagA, Matrix< complex< float >, Prop0, RowLoTriang, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (const SeldonDiag &DiagA, Matrix< complex< double >, Prop0, RowLoTriang, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< float, Prop0, RowUpTriangPacked, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< double, Prop0, RowUpTriangPacked, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< complex< float >, Prop0, RowUpTriangPacked, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< complex< double >, Prop0, RowUpTriangPacked, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (const SeldonDiag &DiagA, Matrix< float, Prop0, RowUpTriangPacked, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (const SeldonDiag &DiagA, Matrix< double, Prop0, RowUpTriangPacked, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (const SeldonDiag &DiagA, Matrix< complex< float >, Prop0, RowUpTriangPacked, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (const SeldonDiag &DiagA, Matrix< complex< double >, Prop0, RowUpTriangPacked, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< float, Prop0, RowLoTriangPacked, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< double, Prop0, RowLoTriangPacked, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< complex< float >, Prop0, RowLoTriangPacked, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (Matrix< complex< double >, Prop0, RowLoTriangPacked, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (const SeldonDiag &DiagA, Matrix< float, Prop0, RowLoTriangPacked, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (const SeldonDiag &DiagA, Matrix< double, Prop0, RowLoTriangPacked, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (const SeldonDiag &DiagA, Matrix< complex< float >, Prop0, RowLoTriangPacked, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 > | |
void | GetInverse (const SeldonDiag &DiagA, Matrix< complex< double >, Prop0, RowLoTriangPacked, Allocator0 > &A, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | GetScalingFactors (const Matrix< float, Prop0, ColMajor, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &row_scale, Vector< float, VectFull, Allocator2 > &col_scale, float &row_condition_number, float &col_condition_number, float &amax, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | GetScalingFactors (const Matrix< double, Prop0, ColMajor, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &row_scale, Vector< double, VectFull, Allocator2 > &col_scale, double &row_condition_number, double &col_condition_number, double &amax, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | GetScalingFactors (const Matrix< complex< float >, Prop0, ColMajor, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &row_scale, Vector< float, VectFull, Allocator2 > &col_scale, float &row_condition_number, float &col_condition_number, float &amax, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | GetScalingFactors (const Matrix< complex< double >, Prop0, ColMajor, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &row_scale, Vector< double, VectFull, Allocator2 > &col_scale, double &row_condition_number, double &col_condition_number, double &amax, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | GetScalingFactors (const Matrix< float, Prop0, RowMajor, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &row_scale, Vector< float, VectFull, Allocator2 > &col_scale, float &row_condition_number, float &col_condition_number, float &amax, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | GetScalingFactors (const Matrix< double, Prop0, RowMajor, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &row_scale, Vector< double, VectFull, Allocator2 > &col_scale, double &row_condition_number, double &col_condition_number, double &amax, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | GetScalingFactors (const Matrix< complex< float >, Prop0, RowMajor, Allocator0 > &A, Vector< float, VectFull, Allocator1 > &row_scale, Vector< float, VectFull, Allocator2 > &col_scale, float &row_condition_number, float &col_condition_number, float &amax, LapackInfo &info) |
template<class Prop0 , class Allocator0 , class Allocator1 , class Allocator2 > | |
void | GetScalingFactors (const Matrix< complex< double >, Prop0, RowMajor, Allocator0 > &A, Vector< double, VectFull, Allocator1 > &row_scale, Vector< double, VectFull, Allocator2 > &col_scale, double &row_condition_number, double &col_condition_number, double &amax, LapackInfo &info) |
template<class Prop , class Allocator > | |
void | GetCholesky (Matrix< double, Prop, RowSymPacked, Allocator > &A, LapackInfo &info) |
template<class Prop , class Allocator > | |
void | GetCholesky (Matrix< double, Prop, ColSymPacked, Allocator > &A, LapackInfo &info) |
template<class Prop , class Allocator > | |
void | GetCholesky (Matrix< double, Prop, RowSym, Allocator > &A, LapackInfo &info) |
template<class Prop , class Allocator > | |
void | GetCholesky (Matrix< double, Prop, ColSym, Allocator > &A, LapackInfo &info) |
template<class Prop , class Allocator > | |
void | GetCholesky (Matrix< complex< double >, Prop, RowHermPacked, Allocator > &A, LapackInfo &info) |
template<class Prop , class Allocator > | |
void | GetCholesky (Matrix< complex< double >, Prop, ColHermPacked, Allocator > &A, LapackInfo &info) |
template<class Prop , class Allocator > | |
void | GetCholesky (Matrix< complex< double >, Prop, RowHerm, Allocator > &A, LapackInfo &info) |
template<class Prop , class Allocator > | |
void | GetCholesky (Matrix< complex< double >, Prop, ColHerm, Allocator > &A, LapackInfo &info) |
template<class Prop , class Allocator , class Allocator2 > | |
void | SolveCholesky (const SeldonTranspose &TransA, const Matrix< double, Prop, RowSymPacked, Allocator > &A, Vector< double, VectFull, Allocator2 > &X, LapackInfo &info) |
template<class Prop , class Allocator , class Allocator2 > | |
void | SolveCholesky (const SeldonTranspose &TransA, const Matrix< double, Prop, ColSymPacked, Allocator > &A, Vector< double, VectFull, Allocator2 > &X, LapackInfo &info) |
template<class Prop , class Allocator , class Allocator2 > | |
void | SolveCholesky (const SeldonTranspose &TransA, const Matrix< double, Prop, RowSym, Allocator > &A, Vector< double, VectFull, Allocator2 > &X, LapackInfo &info) |
template<class Prop , class Allocator , class Allocator2 > | |
void | SolveCholesky (const SeldonTranspose &TransA, const Matrix< double, Prop, ColSym, Allocator > &A, Vector< double, VectFull, Allocator2 > &X, LapackInfo &info) |
template<class Prop , class Allocator , class Allocator2 > | |
void | SolveCholesky (const SeldonTranspose &TransA, const Matrix< complex< double >, Prop, RowHermPacked, Allocator > &A, Vector< complex< double >, VectFull, Allocator2 > &X, LapackInfo &info) |
template<class Prop , class Allocator , class Allocator2 > | |
void | SolveCholesky (const SeldonTranspose &TransA, const Matrix< complex< double >, Prop, ColHermPacked, Allocator > &A, Vector< complex< double >, VectFull, Allocator2 > &X, LapackInfo &info) |
template<class Prop , class Allocator , class Allocator2 > | |
void | SolveCholesky (const SeldonTranspose &TransA, const Matrix< complex< double >, Prop, RowHerm, Allocator > &A, Vector< complex< double >, VectFull, Allocator2 > &X, LapackInfo &info) |
template<class Prop , class Allocator , class Allocator2 > | |
void | SolveCholesky (const SeldonTranspose &TransA, const Matrix< complex< double >, Prop, ColHerm, Allocator > &A, Vector< complex< double >, VectFull, Allocator2 > &X, LapackInfo &info) |
template<class Prop , class Allocator , class Allocator2 > | |
void | MltCholesky (const SeldonTranspose &TransA, const Matrix< double, Prop, RowSymPacked, Allocator > &A, Vector< double, VectFull, Allocator2 > &X, LapackInfo &info) |
template<class Prop , class Allocator , class Allocator2 > | |
void | MltCholesky (const SeldonTranspose &TransA, const Matrix< double, Prop, ColSymPacked, Allocator > &A, Vector< double, VectFull, Allocator2 > &X, LapackInfo &info) |
template<class Prop , class Allocator , class Allocator2 > | |
void | MltCholesky (const SeldonTranspose &TransA, const Matrix< double, Prop, RowSym, Allocator > &A, Vector< double, VectFull, Allocator2 > &X, LapackInfo &info) |
template<class Prop , class Allocator , class Allocator2 > | |
void | MltCholesky (const SeldonTranspose &TransA, const Matrix< double, Prop, ColSym, Allocator > &A, Vector< double, VectFull, Allocator2 > &X, LapackInfo &info) |
template<class Prop , class Allocator , class Allocator2 > | |
void | MltCholesky (const SeldonTranspose &TransA, const Matrix< complex< double >, Prop, RowHermPacked, Allocator > &A, Vector< complex< double >, VectFull, Allocator2 > &X, LapackInfo &info) |
template<class Prop , class Allocator , class Allocator2 > | |
void | MltCholesky (const SeldonTranspose &TransA, const Matrix< complex< double >, Prop, ColHermPacked, Allocator > &A, Vector< complex< double >, VectFull, Allocator2 > &X, LapackInfo &info) |
template<class Prop , class Allocator , class Allocator2 > | |
void | MltCholesky (const SeldonTranspose &TransA, const Matrix< complex< double >, Prop, RowHerm, Allocator > &A, Vector< complex< double >, VectFull, Allocator2 > &X, LapackInfo &info) |
template<class Prop , class Allocator , class Allocator2 > | |
void | MltCholesky (const SeldonTranspose &TransA, const Matrix< complex< double >, Prop, ColHerm, Allocator > &A, Vector< complex< double >, VectFull, Allocator2 > &X, LapackInfo &info) |
template<class T , class Prop , class Storage , class Allocator , class Allocator1 , class Allocator2 > | |
void | GetAndSolveLU (Matrix< T, Prop, Storage, Allocator > &A, Vector< int, VectFull, Allocator1 > &P, Vector< T, VectFull, Allocator2 > &b, LapackInfo &info) |
template<class Alloc1 , class Alloc2 > | |
void | Add (const float &alpha, const Vector< float, VectFull, Alloc1 > &X, const float &beta, Vector< float, VectFull, Alloc2 > &Y) |
computes Y = beta Y + alpha X | |
template<class Alloc1 , class Alloc2 > | |
void | Add (const double &alpha, const Vector< double, VectFull, Alloc1 > &X, const double &beta, Vector< double, VectFull, Alloc2 > &Y) |
computes Y = beta Y + alpha X | |
template<class Alloc1 , class Alloc2 > | |
void | Add (const complex< float > &alpha, const Vector< complex< float >, VectFull, Alloc1 > &X, const complex< float > &beta, Vector< complex< float >, VectFull, Alloc2 > &Y) |
computes Y = beta Y + alpha X | |
template<class Alloc1 , class Alloc2 > | |
void | Add (const complex< double > &alpha, const Vector< complex< double >, VectFull, Alloc1 > &X, const complex< double > &beta, Vector< complex< double >, VectFull, Alloc2 > &Y) |
computes Y = beta Y + alpha X | |
template<class Alloc1 , class Alloc2 > | |
void | Add (const float &alpha, const Vector< float, VectSparse, Alloc1 > &X, Vector< float, VectFull, Alloc2 > &Y) |
computes Y = Y + alpha X | |
template<class Alloc1 , class Alloc2 > | |
void | Add (const double &alpha, const Vector< double, VectSparse, Alloc1 > &X, Vector< double, VectFull, Alloc2 > &Y) |
computes Y = Y + alpha X | |
template<class Alloc1 , class Alloc2 > | |
void | Add (const complex< float > &alpha, const Vector< complex< float >, VectSparse, Alloc1 > &X, Vector< complex< float >, VectFull, Alloc2 > &Y) |
computes Y = Y + alpha X | |
template<class Alloc1 , class Alloc2 > | |
void | Add (const complex< double > &alpha, const Vector< complex< double >, VectSparse, Alloc1 > &X, Vector< complex< double >, VectFull, Alloc2 > &Y) |
computes Y = Y + alpha X | |
template<class Alloc1 , class Alloc2 > | |
float | DotProdVector (const Vector< float, VectSparse, Alloc1 > &x, const Vector< float, VectFull, Alloc2 > &y) |
returns x^T y | |
template<class Alloc1 , class Alloc2 > | |
double | DotProdVector (const Vector< double, VectSparse, Alloc1 > &x, const Vector< double, VectFull, Alloc2 > &y) |
returns x^T y | |
template<class Alloc1 , class Alloc2 > | |
complex< float > | DotProdVector (const Vector< complex< float >, VectSparse, Alloc1 > &x, const Vector< complex< float >, VectFull, Alloc2 > &y) |
returns x^T y | |
template<class Alloc1 , class Alloc2 > | |
complex< double > | DotProdVector (const Vector< complex< double >, VectSparse, Alloc1 > &x, const Vector< complex< double >, VectFull, Alloc2 > &y) |
returns x^T y | |
template<class Alloc1 , class Alloc2 > | |
float | DotProdConjVector (const Vector< float, VectSparse, Alloc1 > &x, const Vector< float, VectFull, Alloc2 > &y) |
returns x^T y | |
template<class Alloc1 , class Alloc2 > | |
double | DotProdConjVector (const Vector< double, VectSparse, Alloc1 > &x, const Vector< double, VectFull, Alloc2 > &y) |
returns x^T y | |
template<class Alloc1 , class Alloc2 > | |
complex< float > | DotProdConjVector (const Vector< complex< float >, VectSparse, Alloc1 > &x, const Vector< complex< float >, VectFull, Alloc2 > &y) |
returns x^H y | |
template<class Alloc1 , class Alloc2 > | |
complex< double > | DotProdConjVector (const Vector< complex< double >, VectSparse, Alloc1 > &x, const Vector< complex< double >, VectFull, Alloc2 > &y) |
returns x^H y | |
template<class Alloc1 , class Alloc2 > | |
void | GatherSparseEntry (const Vector< float, VectFull, Alloc1 > &y, Vector< float, VectSparse, Alloc2 > &x) |
x = y(index) | |
template<class Alloc1 , class Alloc2 > | |
void | GatherSparseEntry (const Vector< double, VectFull, Alloc1 > &y, Vector< double, VectSparse, Alloc2 > &x) |
x = y(index) | |
template<class Alloc1 , class Alloc2 > | |
void | GatherSparseEntry (const Vector< complex< float >, VectFull, Alloc1 > &y, Vector< complex< float >, VectSparse, Alloc2 > &x) |
x = y(index) | |
template<class Alloc1 , class Alloc2 > | |
void | GatherSparseEntry (const Vector< complex< double >, VectFull, Alloc1 > &y, Vector< complex< double >, VectSparse, Alloc2 > &x) |
x = y(index) | |
template<class Alloc1 , class Alloc2 > | |
void | GatherSparseEntryZero (const Vector< float, VectFull, Alloc1 > &y, Vector< float, VectSparse, Alloc2 > &x) |
x = y(index) and y(index) = 0 | |
template<class Alloc1 , class Alloc2 > | |
void | GatherSparseEntryZero (const Vector< double, VectFull, Alloc1 > &y, Vector< double, VectSparse, Alloc2 > &x) |
x = y(index) and y(index) = 0 | |
template<class Alloc1 , class Alloc2 > | |
void | GatherSparseEntryZero (const Vector< complex< float >, VectFull, Alloc1 > &y, Vector< complex< float >, VectSparse, Alloc2 > &x) |
x = y(index) and y(index) = 0 | |
template<class Alloc1 , class Alloc2 > | |
void | GatherSparseEntryZero (const Vector< complex< double >, VectFull, Alloc1 > &y, Vector< complex< double >, VectSparse, Alloc2 > &x) |
x = y(index) and y(index) = 0 | |
template<class Alloc1 , class Alloc2 > | |
void | ApplyRot (Vector< float, VectSparse, Alloc1 > &x, Vector< float, VectFull, Alloc2 > &y, const float &c, const float &s) |
applies rotation to vectors x and y | |
template<class Alloc1 , class Alloc2 > | |
void | ApplyRot (Vector< double, VectSparse, Alloc1 > &x, Vector< double, VectFull, Alloc2 > &y, const double &c, const double &s) |
applies rotation to vectors x and y | |
template<class Alloc1 , class Alloc2 > | |
void | ScatterSparseEntry (const Vector< float, VectSparse, Alloc1 > &x, Vector< float, VectFull, Alloc2 > &y) |
y(index) = x | |
template<class Alloc1 , class Alloc2 > | |
void | ScatterSparseEntry (const Vector< double, VectSparse, Alloc1 > &x, Vector< double, VectFull, Alloc2 > &y) |
y(index) = x | |
template<class Alloc1 , class Alloc2 > | |
void | ScatterSparseEntry (const Vector< complex< float >, VectSparse, Alloc1 > &x, Vector< complex< float >, VectFull, Alloc2 > &y) |
y(index) = x | |
template<class Alloc1 , class Alloc2 > | |
void | ScatterSparseEntry (const Vector< complex< double >, VectSparse, Alloc1 > &x, Vector< complex< double >, VectFull, Alloc2 > &y) |
y(index) = x | |
template<class Alloc1 , class Alloc2 , class Alloc3 > | |
void | MltVector (const Matrix< float, General, RowSparse, Alloc1 > &A, const Vector< float, VectFull, Alloc2 > &X, Vector< float, VectFull, Alloc3 > &Y) |
Y = A X. | |
template<class Alloc1 , class Alloc2 , class Alloc3 > | |
void | MltVector (const Matrix< double, General, RowSparse, Alloc1 > &A, const Vector< double, VectFull, Alloc2 > &X, Vector< double, VectFull, Alloc3 > &Y) |
Y = A X. | |
template<class Alloc1 , class Alloc2 , class Alloc3 > | |
void | MltVector (const Matrix< complex< float >, General, RowSparse, Alloc1 > &A, const Vector< complex< float >, VectFull, Alloc2 > &X, Vector< complex< float >, VectFull, Alloc3 > &Y) |
Y = A X. | |
template<class Alloc1 , class Alloc2 , class Alloc3 > | |
void | MltVector (const Matrix< complex< double >, General, RowSparse, Alloc1 > &A, const Vector< complex< double >, VectFull, Alloc2 > &X, Vector< complex< double >, VectFull, Alloc3 > &Y) |
Y = A X. | |
template<class Alloc1 , class Alloc2 , class Alloc3 > | |
void | MltVector (const Matrix< float, Symmetric, RowSymSparse, Alloc1 > &A, const Vector< float, VectFull, Alloc2 > &X, Vector< float, VectFull, Alloc3 > &Y) |
Y = A X. | |
template<class Alloc1 , class Alloc2 , class Alloc3 > | |
void | MltVector (const Matrix< double, Symmetric, RowSymSparse, Alloc1 > &A, const Vector< double, VectFull, Alloc2 > &X, Vector< double, VectFull, Alloc3 > &Y) |
Y = A X. | |
template<class Alloc1 , class Alloc2 , class Alloc3 > | |
void | MltVector (const Matrix< complex< float >, Symmetric, RowSymSparse, Alloc1 > &A, const Vector< complex< float >, VectFull, Alloc2 > &X, Vector< complex< float >, VectFull, Alloc3 > &Y) |
Y = A X. | |
template<class Alloc1 , class Alloc2 , class Alloc3 > | |
void | MltVector (const Matrix< complex< double >, Symmetric, RowSymSparse, Alloc1 > &A, const Vector< complex< double >, VectFull, Alloc2 > &X, Vector< complex< double >, VectFull, Alloc3 > &Y) |
Y = A X. | |
template<class Alloc1 , class Alloc2 , class Alloc3 > | |
void | MltVector (const float &alpha, const Matrix< float, General, RowSparse, Alloc1 > &A, const Vector< float, VectFull, Alloc2 > &X, Vector< float, VectFull, Alloc3 > &Y) |
Y = A X. | |
template<class Alloc1 , class Alloc2 , class Alloc3 > | |
void | MltVector (const double &alpha, const Matrix< double, General, RowSparse, Alloc1 > &A, const Vector< double, VectFull, Alloc2 > &X, Vector< double, VectFull, Alloc3 > &Y) |
Y = alpha A X. | |
template<class Alloc1 , class Alloc2 , class Alloc3 > | |
void | MltVector (const complex< float > &alpha, const Matrix< complex< float >, General, RowSparse, Alloc1 > &A, const Vector< complex< float >, VectFull, Alloc2 > &X, Vector< complex< float >, VectFull, Alloc3 > &Y) |
Y = alpha A X. | |
template<class Alloc1 , class Alloc2 , class Alloc3 > | |
void | MltVector (const complex< double > &alpha, const Matrix< complex< double >, General, RowSparse, Alloc1 > &A, const Vector< complex< double >, VectFull, Alloc2 > &X, Vector< complex< double >, VectFull, Alloc3 > &Y) |
Y = alpha A X. | |
template<class Alloc1 , class Alloc2 , class Alloc3 > | |
void | MltVector (const float &alpha, const Matrix< float, Symmetric, RowSymSparse, Alloc1 > &A, const Vector< float, VectFull, Alloc2 > &X, Vector< float, VectFull, Alloc3 > &Y) |
Y = alpha A X. | |
template<class Alloc1 , class Alloc2 , class Alloc3 > | |
void | MltVector (const double &alpha, const Matrix< double, Symmetric, RowSymSparse, Alloc1 > &A, const Vector< double, VectFull, Alloc2 > &X, Vector< double, VectFull, Alloc3 > &Y) |
Y = alpha A X. | |
template<class Alloc1 , class Alloc2 , class Alloc3 > | |
void | MltVector (const complex< float > &alpha, const Matrix< complex< float >, Symmetric, RowSymSparse, Alloc1 > &A, const Vector< complex< float >, VectFull, Alloc2 > &X, Vector< complex< float >, VectFull, Alloc3 > &Y) |
Y = alpha A X. | |
template<class Alloc1 , class Alloc2 , class Alloc3 > | |
void | MltVector (const complex< double > &alpha, const Matrix< complex< double >, Symmetric, RowSymSparse, Alloc1 > &A, const Vector< complex< double >, VectFull, Alloc2 > &X, Vector< complex< double >, VectFull, Alloc3 > &Y) |
Y = alpha A X. | |
template<class Alloc1 , class Alloc2 , class Alloc3 > | |
void | MltVector (const SeldonTranspose &trans, const Matrix< float, General, RowSparse, Alloc1 > &A, const Vector< float, VectFull, Alloc2 > &X, Vector< float, VectFull, Alloc3 > &Y) |
Y = A X or A^T X. | |
template<class Alloc1 , class Alloc2 , class Alloc3 > | |
void | MltVector (const SeldonTranspose &trans, const Matrix< double, General, RowSparse, Alloc1 > &A, const Vector< double, VectFull, Alloc2 > &X, Vector< double, VectFull, Alloc3 > &Y) |
Y = A X or A^T X. | |
template<class Alloc1 , class Alloc2 , class Alloc3 > | |
void | MltVector (const SeldonTranspose &trans, const Matrix< complex< float >, General, RowSparse, Alloc1 > &A, const Vector< complex< float >, VectFull, Alloc2 > &X, Vector< complex< float >, VectFull, Alloc3 > &Y) |
Y = A X or A^T X. | |
template<class Alloc1 , class Alloc2 , class Alloc3 > | |
void | MltVector (const SeldonTranspose &trans, const Matrix< complex< double >, General, RowSparse, Alloc1 > &A, const Vector< complex< double >, VectFull, Alloc2 > &X, Vector< complex< double >, VectFull, Alloc3 > &Y) |
Y = A X or A^T X. | |
template<class Alloc1 , class Alloc2 , class Alloc3 > | |
void | MltVector (const SeldonTranspose &trans, const Matrix< float, Symmetric, RowSymSparse, Alloc1 > &A, const Vector< float, VectFull, Alloc2 > &X, Vector< float, VectFull, Alloc3 > &Y) |
Y = A X. | |
template<class Alloc1 , class Alloc2 , class Alloc3 > | |
void | MltVector (const SeldonTranspose &trans, const Matrix< double, Symmetric, RowSymSparse, Alloc1 > &A, const Vector< double, VectFull, Alloc2 > &X, Vector< double, VectFull, Alloc3 > &Y) |
Y = A X. | |
template<class Alloc1 , class Alloc2 , class Alloc3 > | |
void | MltVector (const SeldonTranspose &trans, const Matrix< complex< float >, Symmetric, RowSymSparse, Alloc1 > &A, const Vector< complex< float >, VectFull, Alloc2 > &X, Vector< complex< float >, VectFull, Alloc3 > &Y) |
Y = A X. | |
template<class Alloc1 , class Alloc2 , class Alloc3 > | |
void | MltVector (const SeldonTranspose &trans, const Matrix< complex< double >, Symmetric, RowSymSparse, Alloc1 > &A, const Vector< complex< double >, VectFull, Alloc2 > &X, Vector< complex< double >, VectFull, Alloc3 > &Y) |
Y = A X. | |
template<class Alloc1 , class Alloc2 , class Alloc3 > | |
void | MltAddVector (const float &alpha, const Matrix< float, General, RowSparse, Alloc1 > &A, const Vector< float, VectFull, Alloc2 > &X, const float &beta, Vector< float, VectFull, Alloc3 > &Y) |
Y = beta Y + alpha A X. | |
template<class Alloc1 , class Alloc2 , class Alloc3 > | |
void | MltAddVector (const double &alpha, const Matrix< double, General, RowSparse, Alloc1 > &A, const Vector< double, VectFull, Alloc2 > &X, const double &beta, Vector< double, VectFull, Alloc3 > &Y) |
Y = beta Y + alpha A X. | |
template<class Alloc1 , class Alloc2 , class Alloc3 > | |
void | MltAddVector (const complex< float > &alpha, const Matrix< complex< float >, General, RowSparse, Alloc1 > &A, const Vector< complex< float >, VectFull, Alloc2 > &X, const complex< float > &beta, Vector< complex< float >, VectFull, Alloc3 > &Y) |
Y = beta Y + alpha A X. | |
template<class Alloc1 , class Alloc2 , class Alloc3 > | |
void | MltAddVector (const complex< double > &alpha, const Matrix< complex< double >, General, RowSparse, Alloc1 > &A, const Vector< complex< double >, VectFull, Alloc2 > &X, const complex< double > &beta, Vector< complex< double >, VectFull, Alloc3 > &Y) |
Y = beta Y + alpha A X. | |
template<class Alloc1 , class Alloc2 , class Alloc3 > | |
void | MltAddVector (const float &alpha, const Matrix< float, Symmetric, RowSymSparse, Alloc1 > &A, const Vector< float, VectFull, Alloc2 > &X, const float &beta, Vector< float, VectFull, Alloc3 > &Y) |
Y = beta Y + alpha A X. | |
template<class Alloc1 , class Alloc2 , class Alloc3 > | |
void | MltAddVector (const double &alpha, const Matrix< double, Symmetric, RowSymSparse, Alloc1 > &A, const Vector< double, VectFull, Alloc2 > &X, const double &beta, Vector< double, VectFull, Alloc3 > &Y) |
Y = beta Y + alpha A X. | |
template<class Alloc1 , class Alloc2 , class Alloc3 > | |
void | MltAddVector (const complex< float > &alpha, const Matrix< complex< float >, Symmetric, RowSymSparse, Alloc1 > &A, const Vector< complex< float >, VectFull, Alloc2 > &X, const complex< float > &beta, Vector< complex< float >, VectFull, Alloc3 > &Y) |
Y = beta Y + alpha A X. | |
template<class Alloc1 , class Alloc2 , class Alloc3 > | |
void | MltAddVector (const complex< double > &alpha, const Matrix< complex< double >, Symmetric, RowSymSparse, Alloc1 > &A, const Vector< complex< double >, VectFull, Alloc2 > &X, const complex< double > &beta, Vector< complex< double >, VectFull, Alloc3 > &Y) |
Y = beta Y + alpha A X. | |
template<class Alloc1 , class Alloc2 , class Alloc3 > | |
void | MltAddVector (const float &alpha, const SeldonTranspose &TransA, const Matrix< float, General, RowSparse, Alloc1 > &A, const Vector< float, VectFull, Alloc2 > &X, const float &beta, Vector< float, VectFull, Alloc3 > &Y) |
Y = beta Y + alpha A X. | |
template<class Alloc1 , class Alloc2 , class Alloc3 > | |
void | MltAddVector (const double &alpha, const SeldonTranspose &TransA, const Matrix< double, General, RowSparse, Alloc1 > &A, const Vector< double, VectFull, Alloc2 > &X, const double &beta, Vector< double, VectFull, Alloc3 > &Y) |
Y = beta Y + alpha A X. | |
template<class Alloc1 , class Alloc2 , class Alloc3 > | |
void | MltAddVector (const complex< float > &alpha, const SeldonTranspose &TransA, const Matrix< complex< float >, General, RowSparse, Alloc1 > &A, const Vector< complex< float >, VectFull, Alloc2 > &X, const complex< float > &beta, Vector< complex< float >, VectFull, Alloc3 > &Y) |
Y = beta Y + alpha A X. | |
template<class Alloc1 , class Alloc2 , class Alloc3 > | |
void | MltAddVector (const complex< double > &alpha, const SeldonTranspose &TransA, const Matrix< complex< double >, General, RowSparse, Alloc1 > &A, const Vector< complex< double >, VectFull, Alloc2 > &X, const complex< double > &beta, Vector< complex< double >, VectFull, Alloc3 > &Y) |
Y = beta Y + alpha A X. | |
template<class Alloc1 , class Alloc2 , class Alloc3 > | |
void | MltAddVector (const float &alpha, const SeldonTranspose &TransA, const Matrix< float, Symmetric, RowSymSparse, Alloc1 > &A, const Vector< float, VectFull, Alloc2 > &X, const float &beta, Vector< float, VectFull, Alloc3 > &Y) |
Y = beta Y + alpha A X. | |
template<class Alloc1 , class Alloc2 , class Alloc3 > | |
void | MltAddVector (const double &alpha, const SeldonTranspose &TransA, const Matrix< double, Symmetric, RowSymSparse, Alloc1 > &A, const Vector< double, VectFull, Alloc2 > &X, const double &beta, Vector< double, VectFull, Alloc3 > &Y) |
Y = beta Y + alpha A X. | |
template<class Alloc1 , class Alloc2 , class Alloc3 > | |
void | MltAddVector (const complex< float > &alpha, const SeldonTranspose &TransA, const Matrix< complex< float >, Symmetric, RowSymSparse, Alloc1 > &A, const Vector< complex< float >, VectFull, Alloc2 > &X, const complex< float > &beta, Vector< complex< float >, VectFull, Alloc3 > &Y) |
Y = beta Y + alpha A X. | |
template<class Alloc1 , class Alloc2 , class Alloc3 > | |
void | MltAddVector (const complex< double > &alpha, const SeldonTranspose &TransA, const Matrix< complex< double >, Symmetric, RowSymSparse, Alloc1 > &A, const Vector< complex< double >, VectFull, Alloc2 > &X, const complex< double > &beta, Vector< complex< double >, VectFull, Alloc3 > &Y) |
Y = beta Y + alpha A X. | |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const SeldonUplo &Uplo, const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< float, Prop0, RowSparse, Allocator0 > &A, const Vector< float, VectFull, Allocator1 > &X, Vector< float, VectFull, Allocator1 > &Y) |
solves by triangular upper part or lower part of A | |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const SeldonUplo &Uplo, const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< double, Prop0, RowSparse, Allocator0 > &A, const Vector< double, VectFull, Allocator1 > &X, Vector< double, VectFull, Allocator1 > &Y) |
solves by triangular upper part or lower part of A | |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const SeldonUplo &Uplo, const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< float >, Prop0, RowSparse, Allocator0 > &A, const Vector< complex< float >, VectFull, Allocator1 > &X, Vector< complex< float >, VectFull, Allocator1 > &Y) |
solves by triangular upper part or lower part of A | |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const SeldonUplo &Uplo, const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< double >, Prop0, RowSparse, Allocator0 > &A, const Vector< complex< double >, VectFull, Allocator1 > &X, Vector< complex< double >, VectFull, Allocator1 > &Y) |
solves by triangular upper part or lower part of A | |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< float, Prop0, RowSymSparse, Allocator0 > &A, const Vector< float, VectFull, Allocator1 > &X, Vector< float, VectFull, Allocator1 > &Y) |
solves by triangular upper part of A | |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< double, Prop0, RowSymSparse, Allocator0 > &A, const Vector< double, VectFull, Allocator1 > &X, Vector< double, VectFull, Allocator1 > &Y) |
solves by triangular upper part of A | |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< float >, Prop0, RowSymSparse, Allocator0 > &A, const Vector< complex< float >, VectFull, Allocator1 > &X, Vector< complex< float >, VectFull, Allocator1 > &Y) |
solves by triangular upper part of A | |
template<class Prop0 , class Allocator0 , class Allocator1 > | |
void | Solve (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< double >, Prop0, RowSymSparse, Allocator0 > &A, const Vector< complex< double >, VectFull, Allocator1 > &X, Vector< complex< double >, VectFull, Allocator1 > &Y) |
solves by triangular upper part of A | |
template<class Alloc0 , class Alloc1 , class Alloc2 > | |
void | MltAddMatrix (const float &alpha, const SeldonTranspose &TransA, const Matrix< float, General, RowSparse, Alloc0 > &A, const SeldonTranspose &TransB, const Matrix< float, General, RowMajor, Alloc1 > &B, const float &beta, Matrix< float, General, RowMajor, Alloc2 > &C) |
C = alpha A B + beta C. | |
template<class Alloc0 , class Alloc1 , class Alloc2 > | |
void | MltAddMatrix (const double &alpha, const SeldonTranspose &TransA, const Matrix< double, General, RowSparse, Alloc0 > &A, const SeldonTranspose &TransB, const Matrix< double, General, RowMajor, Alloc1 > &B, const double &beta, Matrix< double, General, RowMajor, Alloc2 > &C) |
C = alpha A B + beta C. | |
template<class Alloc0 , class Alloc1 , class Alloc2 > | |
void | MltAddMatrix (const complex< float > &alpha, const SeldonTranspose &TransA, const Matrix< complex< float >, General, RowSparse, Alloc0 > &A, const SeldonTranspose &TransB, const Matrix< complex< float >, General, RowMajor, Alloc1 > &B, const complex< float > &beta, Matrix< complex< float >, General, RowMajor, Alloc2 > &C) |
C = alpha A B + beta C. | |
template<class Alloc0 , class Alloc1 , class Alloc2 > | |
void | MltAddMatrix (const complex< double > &alpha, const SeldonTranspose &TransA, const Matrix< complex< double >, General, RowSparse, Alloc0 > &A, const SeldonTranspose &TransB, const Matrix< complex< double >, General, RowMajor, Alloc1 > &B, const complex< double > &beta, Matrix< complex< double >, General, RowMajor, Alloc2 > &C) |
C = alpha A B + beta C. | |
template<class Alloc0 , class Alloc1 , class Alloc2 > | |
void | MltAddMatrix (const float &alpha, const SeldonTranspose &TransA, const Matrix< float, Symmetric, RowSymSparse, Alloc0 > &A, const SeldonTranspose &TransB, const Matrix< float, General, RowMajor, Alloc1 > &B, const float &beta, Matrix< float, General, RowMajor, Alloc2 > &C) |
C = alpha A B + beta C. | |
template<class Alloc0 , class Alloc1 , class Alloc2 > | |
void | MltAddMatrix (const double &alpha, const SeldonTranspose &TransA, const Matrix< double, Symmetric, RowSymSparse, Alloc0 > &A, const SeldonTranspose &TransB, const Matrix< double, General, RowMajor, Alloc1 > &B, const double &beta, Matrix< double, General, RowMajor, Alloc2 > &C) |
C = alpha A B + beta C. | |
template<class Alloc0 , class Alloc1 , class Alloc2 > | |
void | MltAddMatrix (const complex< float > &alpha, const SeldonTranspose &TransA, const Matrix< complex< float >, Symmetric, RowSymSparse, Alloc0 > &A, const SeldonTranspose &TransB, const Matrix< complex< float >, General, RowMajor, Alloc1 > &B, const complex< float > &beta, Matrix< complex< float >, General, RowMajor, Alloc2 > &C) |
C = alpha A B + beta C. | |
template<class Alloc0 , class Alloc1 , class Alloc2 > | |
void | MltAddMatrix (const complex< double > &alpha, const SeldonTranspose &TransA, const Matrix< complex< double >, Symmetric, RowSymSparse, Alloc0 > &A, const SeldonTranspose &TransB, const Matrix< complex< double >, General, RowMajor, Alloc1 > &B, const complex< double > &beta, Matrix< complex< double >, General, RowMajor, Alloc2 > &C) |
C = alpha A B + beta C. | |
template<class Alloc0 , class Alloc1 , class Alloc2 > | |
void | Solve (const SeldonUplo &Uplo, const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< float, General, RowSparse, Alloc0 > &A, const Matrix< float, General, RowMajor, Alloc1 > &B, Matrix< float, General, RowMajor, Alloc2 > &C) |
C = inv(T) B where T is a triangular part of A. | |
template<class Alloc0 , class Alloc1 , class Alloc2 > | |
void | Solve (const SeldonUplo &Uplo, const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< double, General, RowSparse, Alloc0 > &A, const Matrix< double, General, RowMajor, Alloc1 > &B, Matrix< double, General, RowMajor, Alloc2 > &C) |
C = inv(T) B where T is a triangular part of A. | |
template<class Alloc0 , class Alloc1 , class Alloc2 > | |
void | Solve (const SeldonUplo &Uplo, const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< float >, General, RowSparse, Alloc0 > &A, const Matrix< complex< float >, General, RowMajor, Alloc1 > &B, Matrix< complex< float >, General, RowMajor, Alloc2 > &C) |
C = inv(T) B where T is a triangular part of A. | |
template<class Alloc0 , class Alloc1 , class Alloc2 > | |
void | Solve (const SeldonUplo &Uplo, const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< double >, General, RowSparse, Alloc0 > &A, const Matrix< complex< double >, General, RowMajor, Alloc1 > &B, Matrix< complex< double >, General, RowMajor, Alloc2 > &C) |
C = inv(T) B where T is a triangular part of A. | |
template<class Alloc0 , class Alloc1 , class Alloc2 > | |
void | Solve (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< float, Symmetric, RowSymSparse, Alloc0 > &A, const Matrix< float, General, RowMajor, Alloc1 > &B, Matrix< float, General, RowMajor, Alloc2 > &C) |
C = inv(T) B where T is a triangular part of A. | |
template<class Alloc0 , class Alloc1 , class Alloc2 > | |
void | Solve (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< double, Symmetric, RowSymSparse, Alloc0 > &A, const Matrix< double, General, RowMajor, Alloc1 > &B, Matrix< double, General, RowMajor, Alloc2 > &C) |
C = inv(T) B where T is a triangular part of A. | |
template<class Alloc0 , class Alloc1 , class Alloc2 > | |
void | Solve (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< float >, Symmetric, RowSymSparse, Alloc0 > &A, const Matrix< complex< float >, General, RowMajor, Alloc1 > &B, Matrix< complex< float >, General, RowMajor, Alloc2 > &C) |
C = inv(T) B where T is a triangular part of A. | |
template<class Alloc0 , class Alloc1 , class Alloc2 > | |
void | Solve (const SeldonTranspose &TransA, const SeldonDiag &DiagA, const Matrix< complex< double >, Symmetric, RowSymSparse, Alloc0 > &A, const Matrix< complex< double >, General, RowMajor, Alloc1 > &B, Matrix< complex< double >, General, RowMajor, Alloc2 > &C) |
C = inv(T) B where T is a triangular part of A. | |
template<class Alloc0 , class Alloc1 > | |
void | AddMatrix (const float &alpha, const Matrix< float, General, RowSparse, Alloc0 > &A, Matrix< float, General, RowSparse, Alloc1 > &B) |
B = B + alpha A. | |
template<class Alloc0 , class Alloc1 > | |
void | AddMatrix (const double &alpha, const Matrix< double, General, RowSparse, Alloc0 > &A, Matrix< double, General, RowSparse, Alloc1 > &B) |
B = B + alpha A | |
template<class Alloc0 , class Alloc1 > | |
void | AddMatrix (const complex< float > &alpha, const Matrix< complex< float >, General, RowSparse, Alloc0 > &A, Matrix< complex< float >, General, RowSparse, Alloc1 > &B) |
B = B + alpha A | |
template<class Alloc0 , class Alloc1 > | |
void | AddMatrix (const complex< double > &alpha, const Matrix< complex< double >, General, RowSparse, Alloc0 > &A, Matrix< complex< double >, General, RowSparse, Alloc1 > &B) |
B = B + alpha A. | |
template<class Alloc0 , class Alloc1 , class Alloc2 > | |
void | MltMatrix (const Matrix< float, General, RowSparse, Alloc0 > &A, const Matrix< float, General, RowSparse, Alloc1 > &B, Matrix< float, General, RowSparse, Alloc2 > &C) |
C = A B. | |
template<class Alloc0 , class Alloc1 , class Alloc2 > | |
void | MltMatrix (const Matrix< double, General, RowSparse, Alloc0 > &A, const Matrix< double, General, RowSparse, Alloc1 > &B, Matrix< double, General, RowSparse, Alloc2 > &C) |
C = A B. | |
template<class Alloc0 , class Alloc1 , class Alloc2 > | |
void | MltMatrix (const Matrix< complex< float >, General, RowSparse, Alloc0 > &A, const Matrix< complex< float >, General, RowSparse, Alloc1 > &B, Matrix< complex< float >, General, RowSparse, Alloc2 > &C) |
C = A B. | |
template<class Alloc0 , class Alloc1 , class Alloc2 > | |
void | MltMatrix (const Matrix< complex< double >, General, RowSparse, Alloc0 > &A, const Matrix< complex< double >, General, RowSparse, Alloc1 > &B, Matrix< complex< double >, General, RowSparse, Alloc2 > &C) |
C = A B. | |
template<class Titer , class Matrix1 , class Vector1 , class Preconditioner > | |
int | BiCg (const Matrix1 &A, Vector1 &x, const Vector1 &b, Preconditioner &M, Iteration< Titer > &iter) |
Solves a linear system by using BiConjugate Gradient (BICG) More... | |
template<class Titer , class Matrix1 , class Vector1 , class Preconditioner > | |
int | BiCgcr (const Matrix1 &A, Vector1 &x, const Vector1 &b, Preconditioner &M, Iteration< Titer > &iter) |
Solves a linear system by using BiCgCr. More... | |
template<class Titer , class Matrix1 , class Vector1 , class Preconditioner > | |
int | BiCgStab (const Matrix1 &A, Vector1 &x, const Vector1 &b, Preconditioner &M, Iteration< Titer > &iter) |
Implements BiConjugate Gradient Stabilized (BICG-STAB) More... | |
template<class Titer , class Matrix1 , class Vector1 , class Preconditioner > | |
int | BiCgStabl (const Matrix1 &A, Vector1 &x, const Vector1 &b, Preconditioner &M, Iteration< Titer > &iter) |
Implements BiConjugate Gradient Stabilized (BICG-STAB(l)) More... | |
template<class Titer , class Matrix1 , class Vector1 , class Preconditioner > | |
int | Cg (const Matrix1 &A, Vector1 &x, const Vector1 &b, Preconditioner &M, Iteration< Titer > &iter) |
Solves a linear system by using Conjugate Gradient (CG) More... | |
template<class Titer , class Matrix1 , class Vector1 , class Preconditioner > | |
int | Cgne (const Matrix1 &A, Vector1 &x, const Vector1 &b, Preconditioner &M, Iteration< Titer > &iter) |
Solves a linear system using Conjugate Gradient Normal Equation (CGNE) More... | |
template<class Titer , class Matrix1 , class Vector1 , class Preconditioner > | |
int | Cgs (const Matrix1 &A, Vector1 &x, const Vector1 &b, Preconditioner &M, Iteration< Titer > &iter) |
Solves linear system using Conjugate Gradient Squared (CGS) More... | |
template<class Titer , class Matrix1 , class Vector1 , class Preconditioner > | |
int | CoCg (const Matrix1 &A, Vector1 &x, const Vector1 &b, Preconditioner &M, Iteration< Titer > &iter) |
Solves a linear system by using Conjugate Orthogonal Conjugate Gradient. More... | |
template<class Titer , class Matrix1 , class Vector1 , class Preconditioner > | |
int | Gcr (const Matrix1 &A, Vector1 &x, const Vector1 &b, Preconditioner &M, Iteration< Titer > &outer) |
Solves a linear system by using Generalized Conjugate Residual (GCR) More... | |
template<class Titer , class MatrixSparse , class Vector1 , class Preconditioner > | |
int | Gmres (const MatrixSparse &A, Vector1 &x, const Vector1 &b, Preconditioner &M, Iteration< Titer > &outer) |
Solves a linear system by using Generalized Minimum Residual (GMRES) More... | |
template<class Titer , class Matrix1 , class Vector1 , class Preconditioner > | |
int | Lsqr (const Matrix1 &A, Vector1 &x, const Vector1 &b, Preconditioner &M, Iteration< Titer > &iter) |
Solves a linear system by using Least Squares (LSQR) More... | |
template<class Titer , class Matrix1 , class Vector1 , class Preconditioner > | |
int | MinRes (const Matrix1 &A, Vector1 &x, const Vector1 &b, Preconditioner &M, Iteration< Titer > &iter) |
Solves a linear system by using Minimum Residual (MinRes) More... | |
template<class Titer , class Matrix1 , class Vector1 , class Preconditioner > | |
int | QCgs (const Matrix1 &A, Vector1 &x, const Vector1 &b, Preconditioner &M, Iteration< Titer > &iter) |
Solves linear system using Quasi-minimized Conjugate Gradient Squared. More... | |
template<class Titer , class Matrix1 , class Vector1 , class Preconditioner > | |
int | Qmr (const Matrix1 &A, Vector1 &x, const Vector1 &b, Preconditioner &M, Iteration< Titer > &iter) |
Solves a linear system by using Quasi-Minimal Residual (QMR) More... | |
template<class Titer , class Matrix1 , class Vector1 , class Preconditioner > | |
int | QmrSym (const Matrix1 &A, Vector1 &x, const Vector1 &b, Preconditioner &M, Iteration< Titer > &iter) |
Solves linear system using Symmetric Quasi-Minimal Residual (SQMR) More... | |
template<class Titer , class Matrix1 , class Vector1 , class Preconditioner > | |
int | Symmlq (const Matrix1 &A, Vector1 &x, const Vector1 &b, Preconditioner &M, Iteration< Titer > &iter) |
Solves a linear system by using Symmetric LQ (SymmLQ) More... | |
template<class Titer , class Matrix1 , class Vector1 , class Preconditioner > | |
int | TfQmr (const Matrix1 &A, Vector1 &x, const Vector1 &b, Preconditioner &M, Iteration< Titer > &iter) |
Solves a linear system by using Transpose Free Quasi-Minimal Residual. More... | |
template<class T , class Prop , class Storage , class Allocator , class Tint , class Alloc > | |
void | FindReverseCuthillMcKeeOrdering (const Matrix< T, Prop, Storage, Allocator > &A, Vector< Tint, VectFull, Alloc > &num) |
Constructs reverse Cuthill-McKee ordering from a given matrix. | |
template<class T , class Prop , class Storage , class Allocator , class Tint , class Alloc > | |
void | FindSparseOrdering (Matrix< T, Prop, Storage, Allocator > &A, Vector< Tint, VectFull, Alloc > &num, int type) |
Constructs an ordering for the factorization of a sparse matrix. | |
template<class real , class cplx , class Storage , class Allocator > | |
void | qsplit_ilut (Vector< cplx, Storage, Allocator > &a, IVect &ind, int first, int n, int ncut, const real &abs_ncut) |
template<class cplx , class Allocator1 , class Allocator2 > | |
void | GetIlut (const IlutPreconditioning< cplx, Allocator1 > ¶m, Matrix< cplx, General, ArrayRowSparse, Allocator2 > &A, IVect &iperm, IVect &rperm) |
Incomplete factorization with pivot for unsymmetric matrix. | |
template<class cplx , class Allocator > | |
void | GetIluk (int lfil, Matrix< cplx, General, ArrayRowSparse, Allocator > &A) |
template<class cplx , class Allocator > | |
void | GetIlu0 (Matrix< cplx, General, ArrayRowSparse, Allocator > &A) |
template<class cplx , class Allocator > | |
void | GetMilu0 (Matrix< cplx, General, ArrayRowSparse, Allocator > &A) |
template<class MatrixSparse , class T , class Alloc2 > | |
void | GetLU (MatrixSparse &A, IlutPreconditioning< T, Alloc2 > &mat_lu, IVect &permut, bool keep_matrix, T &x) |
template<class MatrixSparse , class T , class Alloc2 > | |
void | GetLU (MatrixSparse &A, IlutPreconditioning< T, Alloc2 > &mat_lu, IVect &permut, bool keep_matrix, complex< T > &x) |
template<class MatrixSparse , class T , class Alloc2 > | |
void | GetLU (MatrixSparse &A, IlutPreconditioning< complex< T >, Alloc2 > &mat_lu, IVect &permut, bool keep_matrix, T &x) |
template<class T0 , class Prop , class Storage , class Allocator , class T , class Alloc2 > | |
void | GetLU (Matrix< T0, Prop, Storage, Allocator > &A, IlutPreconditioning< T, Alloc2 > &mat_lu, IVect &permut, bool keep_matrix) |
template<class cplx , class Allocator1 , class Allocator2 > | |
void | GetIlut (const IlutPreconditioning< cplx, Allocator1 > ¶m, Matrix< cplx, Symmetric, ArrayRowSymSparse, Allocator2 > &A) |
Incomplete Factorization without pivot for symmetric matrix. | |
template<class cplx , class Allocator > | |
void | GetIluk (int lfil, int print_level, Matrix< cplx, Symmetric, ArrayRowSymSparse, Allocator > &A) |
Basic ilu(k) solver. More... | |
template<class cplx , class Allocator > | |
void | GetIlu0 (Matrix< cplx, Symmetric, ArrayRowSymSparse, Allocator > &A) |
template<class cplx , class Allocator > | |
void | GetMilu0 (Matrix< cplx, Symmetric, ArrayRowSymSparse, Allocator > &A) |
template<class T , class Prop , class Allocator > | |
void | GetCholesky (Matrix< T, Prop, ArrayRowSymSparse, Allocator > &A, int print_level) |
Implementation of Cholesky factorization for sparse symmetric matrix. More... | |
template<class T0 , class Prop , class Allocator0 , class T1 , class Storage , class Allocator1 > | |
void | SolveCholesky (const SeldonTranspose &TransA, const Matrix< T0, Prop, ArrayRowSymSparse, Allocator0 > &A, Vector< T1, Storage, Allocator1 > &x) |
Resolution of L x = y or L^T x = y. More... | |
template<class T0 , class Prop , class Alloc0 , class T1 , class Storage , class Allocator1 > | |
void | SolveCholesky (const SeldonTranspose &TransA, const Matrix< T0, Prop, RowSymSparse, Alloc0 > &A, Vector< T1, Storage, Allocator1 > &X) |
Resolution of L x = y or L^T x = y. More... | |
template<class T0 , class Prop , class Allocator0 , class T1 , class Storage , class Allocator1 > | |
void | MltCholesky (const SeldonTranspose &TransA, const Matrix< T0, Prop, ArrayRowSymSparse, Allocator0 > &A, Vector< T1, Storage, Allocator1 > &x) |
Computation of y = L x or y = L^T x. More... | |
template<class T0 , class Prop , class Allocator0 , class T1 , class Storage , class Allocator1 > | |
void | MltCholesky (const SeldonTranspose &TransA, const Matrix< T0, Prop, RowSymSparse, Allocator0 > &A, Vector< T1, Storage, Allocator1 > &x) |
Computation of y = L x or y = L^T x. More... | |
template<class T , class Allocator > | |
void | GetLU (Matrix< T, General, ArrayRowSparse, Allocator > &A, IVect &iperm, IVect &rperm, const double &permtol, int print_level) |
LU factorisation with pivot of unsymmetric matrix. | |
template<class T1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 > | |
void | SolveLuVector (const Matrix< T1, General, ArrayRowSparse, Allocator1 > &A, Vector< T2, Storage2, Allocator2 > &x) |
template<class T1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 > | |
void | SolveLuVector (const SeldonTranspose &transA, const Matrix< T1, General, ArrayRowSparse, Allocator1 > &A, Vector< T2, Storage2, Allocator2 > &x) |
Resolution of LU y = x (x is overwritten with y) More... | |
template<class T , class Allocator > | |
void | GetLU (Matrix< T, Symmetric, ArrayRowSymSparse, Allocator > &A, int print_level) |
LDLt factorisation without pivot for symmetric matrix. | |
template<class T1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 > | |
void | SolveLuVector (const Matrix< T1, Symmetric, ArrayRowSymSparse, Allocator1 > &A, Vector< T2, Storage2, Allocator2 > &x) |
template<class T1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 > | |
void | SolveLuVector (const SeldonTranspose &transA, const Matrix< T1, Symmetric, ArrayRowSymSparse, Allocator1 > &A, Vector< T2, Storage2, Allocator2 > &x) |
Resolution of L D L^t y = x (result is overwritten in x) More... | |
template<class MatrixSparse , class T , class Alloc2 > | |
void | GetLU (MatrixSparse &A, SparseSeldonSolver< T, Alloc2 > &mat_lu, bool keep_matrix, T &x) |
LU factorisation with natural ordering. | |
template<class MatrixSparse , class T , class Alloc2 > | |
void | GetLU (MatrixSparse &A, SparseSeldonSolver< T, Alloc2 > &mat_lu, bool keep_matrix, complex< T > &x) |
forbidden case | |
template<class MatrixSparse , class T , class Alloc2 > | |
void | GetLU (MatrixSparse &A, SparseSeldonSolver< complex< T >, Alloc2 > &mat_lu, bool keep_matrix, T &x) |
forbidden case | |
template<class T0 , class Prop , class Storage , class Allocator , class T , class Alloc2 > | |
void | GetLU (Matrix< T0, Prop, Storage, Allocator > &A, SparseSeldonSolver< T, Alloc2 > &mat_lu, bool keep_matrix) |
LU factorisation with natural ordering. | |
template<class MatrixSparse , class T , class Alloc2 > | |
void | GetLU (MatrixSparse &A, SparseSeldonSolver< T, Alloc2 > &mat_lu, IVect &permut, bool keep_matrix, T &x) |
LU factorisation with a given ordering. | |
template<class MatrixSparse , class T , class Alloc2 > | |
void | GetLU (MatrixSparse &A, SparseSeldonSolver< T, Alloc2 > &mat_lu, IVect &permut, bool keep_matrix, complex< T > &x) |
forbidden case | |
template<class MatrixSparse , class T , class Alloc2 > | |
void | GetLU (MatrixSparse &A, SparseSeldonSolver< complex< T >, Alloc2 > &mat_lu, IVect &permut, bool keep_matrix, T &x) |
forbidden case | |
template<class T0 , class Prop , class Storage , class Allocator , class T , class Alloc2 > | |
void | GetLU (Matrix< T0, Prop, Storage, Allocator > &A, SparseSeldonSolver< T, Alloc2 > &mat_lu, IVect &permut, bool keep_matrix) |
LU factorisation with a given ordering. | |
template<class T , class Alloc2 , class T1 , class Allocator > | |
void | SolveLU (SparseSeldonSolver< T, Alloc2 > &mat_lu, Vector< T1, VectFull, Allocator > &x) |
template<class T , class Alloc2 , class T1 , class Allocator > | |
void | SolveLU (const SeldonTranspose &TransA, SparseSeldonSolver< T, Alloc2 > &mat_lu, Vector< T1, VectFull, Allocator > &x) |
SELDON_EXTERN template void | CheckDim (const Vector< double, VectFull > &, const Vector< double, VectFull > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Vector< complex< double >, VectFull > &, const Vector< complex< double >, VectFull > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Vector< double, VectSparse > &, const Vector< double, VectSparse > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Vector< complex< double >, VectSparse > &, const Vector< complex< double >, VectSparse > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< double, General, ColMajor > &, const Vector< double > &, const Vector< double > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< double >, General, ColMajor > &, const Vector< complex< double > > &, const Vector< complex< double > > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< double >, General, ColMajor > &, const Vector< double > &, const Vector< double > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< double, General, ColMajor > &, const Vector< double > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< double >, General, ColMajor > &, const Vector< complex< double > > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< double >, General, ColMajor > &, const Vector< double > &, string, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< double, General, ColMajor > &, const Vector< double > &, const Vector< double > &, string, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< complex< double >, General, ColMajor > &, const Vector< complex< double > > &, const Vector< complex< double > > &, string, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< complex< double >, General, ColMajor > &, const Vector< double > &, const Vector< double > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< double, General, ColMajor > &, const Matrix< double, General, ColMajor > &, const Matrix< double, General, ColMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< double, General, ColMajor > &, const SeldonTranspose &, const Matrix< double, General, ColMajor > &, const Matrix< double, General, ColMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< double, General, ColMajor > &, const SeldonTranspose &, const Matrix< double, General, ColMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< double, General, ColMajor > &, const Matrix< double, General, ColMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< double >, General, ColMajor > &, const Matrix< complex< double >, General, ColMajor > &, const Matrix< complex< double >, General, ColMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< complex< double >, General, ColMajor > &, const SeldonTranspose &, const Matrix< complex< double >, General, ColMajor > &, const Matrix< complex< double >, General, ColMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< complex< double >, General, ColMajor > &, const SeldonTranspose &, const Matrix< complex< double >, General, ColMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< double >, General, ColMajor > &, const Matrix< complex< double >, General, ColMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< double, General, RowMajor > &, const Vector< double > &, const Vector< double > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< double >, General, RowMajor > &, const Vector< complex< double > > &, const Vector< complex< double > > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< double >, General, RowMajor > &, const Vector< double > &, const Vector< double > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< double, General, RowMajor > &, const Vector< double > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< double >, General, RowMajor > &, const Vector< complex< double > > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< double >, General, RowMajor > &, const Vector< double > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< double, General, RowMajor > &, const Matrix< double, General, RowMajor > &, const Matrix< double, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< double, General, RowMajor > &, const SeldonTranspose &, const Matrix< double, General, RowMajor > &, const Matrix< double, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< double, General, RowMajor > &, const SeldonTranspose &, const Matrix< double, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< double, General, RowMajor > &, const Matrix< double, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< double >, General, RowMajor > &, const Matrix< complex< double >, General, RowMajor > &, const Matrix< complex< double >, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< complex< double >, General, RowMajor > &, const SeldonTranspose &, const Matrix< complex< double >, General, RowMajor > &, const Matrix< complex< double >, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< complex< double >, General, RowMajor > &, const SeldonTranspose &, const Matrix< complex< double >, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< double >, General, RowMajor > &, const Matrix< complex< double >, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< double, Symmetric, RowSymPacked > &, const Vector< double > &, const Vector< double > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< double >, Symmetric, RowSymPacked > &, const Vector< complex< double > > &, const Vector< complex< double > > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< double >, Symmetric, RowSymPacked > &, const Vector< double > &, const Vector< double > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< double, Symmetric, RowSymPacked > &, const Vector< double > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< double >, Symmetric, RowSymPacked > &, const Vector< complex< double > > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< double >, Symmetric, RowSymPacked > &, const Vector< double > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< double, Symmetric, ColSymPacked > &, const Vector< double > &, const Vector< double > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< double >, Symmetric, ColSymPacked > &, const Vector< complex< double > > &, const Vector< complex< double > > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< double >, Symmetric, ColSymPacked > &, const Vector< double > &, const Vector< double > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< double, Symmetric, ColSymPacked > &, const Vector< double > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< double >, Symmetric, ColSymPacked > &, const Vector< complex< double > > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< double >, Symmetric, ColSymPacked > &, const Vector< double > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< double, Symmetric, RowSym > &, const Vector< double > &, const Vector< double > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< double >, Symmetric, RowSym > &, const Vector< complex< double > > &, const Vector< complex< double > > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< double >, Symmetric, RowSym > &, const Vector< double > &, const Vector< double > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< double, Symmetric, RowSym > &, const Vector< double > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< double >, Symmetric, RowSym > &, const Vector< complex< double > > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< double >, Symmetric, RowSym > &, const Vector< double > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< double, Symmetric, ColSym > &, const Vector< double > &, const Vector< double > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< double >, Symmetric, ColSym > &, const Vector< complex< double > > &, const Vector< complex< double > > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< double >, Symmetric, ColSym > &, const Vector< double > &, const Vector< double > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< double, Symmetric, ColSym > &, const Vector< double > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< double >, Symmetric, ColSym > &, const Vector< complex< double > > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< double >, Symmetric, ColSym > &, const Vector< double > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< double >, Hermitian, RowHerm > &, const Vector< complex< double > > &, const Vector< complex< double > > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< double >, Hermitian, RowHerm > &, const Vector< complex< double > > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< double >, Hermitian, ColHerm > &, const Vector< complex< double > > &, const Vector< complex< double > > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< double >, Hermitian, ColHerm > &, const Vector< complex< double > > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< double >, Hermitian, RowHermPacked > &, const Vector< complex< double > > &, const Vector< complex< double > > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< double >, Hermitian, RowHermPacked > &, const Vector< complex< double > > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< double >, Hermitian, ColHermPacked > &, const Vector< complex< double > > &, const Vector< complex< double > > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< double >, Hermitian, ColHermPacked > &, const Vector< complex< double > > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< double, General, RowSparse > &, const Vector< double > &, const Vector< double > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< double >, General, RowSparse > &, const Vector< complex< double > > &, const Vector< complex< double > > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< double, General, ArrayRowSparse > &, const Vector< double > &, const Vector< double > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< double >, General, ArrayRowSparse > &, const Vector< complex< double > > &, const Vector< complex< double > > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< double, Symmetric, RowSymSparse > &, const Vector< double > &, const Vector< double > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< double >, Symmetric, RowSymSparse > &, const Vector< complex< double > > &, const Vector< complex< double > > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< double, Symmetric, ArrayRowSymSparse > &, const Vector< double > &, const Vector< double > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< double >, Symmetric, ArrayRowSymSparse > &, const Vector< complex< double > > &, const Vector< complex< double > > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< double, General, ColSparse > &, const Vector< double > &, const Vector< double > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< double >, General, ColSparse > &, const Vector< complex< double > > &, const Vector< complex< double > > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< double, General, ArrayColSparse > &, const Vector< double > &, const Vector< double > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< double >, General, ArrayColSparse > &, const Vector< complex< double > > &, const Vector< complex< double > > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< double, Symmetric, ColSymSparse > &, const Vector< double > &, const Vector< double > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< double >, Symmetric, ColSymSparse > &, const Vector< complex< double > > &, const Vector< complex< double > > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< double, Symmetric, ArrayColSymSparse > &, const Vector< double > &, const Vector< double > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< double >, Symmetric, ArrayColSymSparse > &, const Vector< complex< double > > &, const Vector< complex< double > > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< double, General, RowMajor > &, const Vector< double > &, const Vector< double > &, string, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< complex< double >, General, RowMajor > &, const Vector< complex< double > > &, const Vector< complex< double > > &, string, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< complex< double >, General, RowMajor > &, const Vector< double > &, const Vector< double > &, string, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< double, General, RowSparse > &, const Vector< double > &, const Vector< double > &, string, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< complex< double >, General, RowSparse > &, const Vector< complex< double > > &, const Vector< complex< double > > &, string, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< double, General, ArrayRowSparse > &, const Vector< double > &, const Vector< double > &, string, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< complex< double >, General, ArrayRowSparse > &, const Vector< complex< double > > &, const Vector< complex< double > > &, string, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< double, Symmetric, RowSymSparse > &, const Vector< double > &, const Vector< double > &, string, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< complex< double >, Symmetric, RowSymSparse > &, const Vector< complex< double > > &, const Vector< complex< double > > &, string, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< double, Symmetric, ArrayRowSymSparse > &, const Vector< double > &, const Vector< double > &, string, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< complex< double >, Symmetric, ArrayRowSymSparse > &, const Vector< complex< double > > &, const Vector< complex< double > > &, string, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< double, General, ColSparse > &, const Vector< double > &, const Vector< double > &, string, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< complex< double >, General, ColSparse > &, const Vector< complex< double > > &, const Vector< complex< double > > &, string, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< double, General, ArrayColSparse > &, const Vector< double > &, const Vector< double > &, string, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< complex< double >, General, ArrayColSparse > &, const Vector< complex< double > > &, const Vector< complex< double > > &, string, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< double, Symmetric, ColSymSparse > &, const Vector< double > &, const Vector< double > &, string, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< complex< double >, Symmetric, ColSymSparse > &, const Vector< complex< double > > &, const Vector< complex< double > > &, string, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< double, Symmetric, ArrayColSymSparse > &, const Vector< double > &, const Vector< double > &, string, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< complex< double >, Symmetric, ArrayColSymSparse > &, const Vector< complex< double > > &, const Vector< complex< double > > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Vector< float, VectFull > &, const Vector< float, VectFull > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Vector< complex< float >, VectFull > &, const Vector< complex< float >, VectFull > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Vector< float, VectSparse > &, const Vector< float, VectSparse > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Vector< complex< float >, VectSparse > &, const Vector< complex< float >, VectSparse > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< float, General, ColMajor > &, const Vector< float > &, const Vector< float > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< float >, General, ColMajor > &, const Vector< complex< float > > &, const Vector< complex< float > > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< float >, General, ColMajor > &, const Vector< float > &, const Vector< float > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< float, General, ColMajor > &, const Vector< float > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< float >, General, ColMajor > &, const Vector< complex< float > > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< float >, General, ColMajor > &, const Vector< float > &, string, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< float, General, ColMajor > &, const Vector< float > &, const Vector< float > &, string, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< complex< float >, General, ColMajor > &, const Vector< complex< float > > &, const Vector< complex< float > > &, string, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< complex< float >, General, ColMajor > &, const Vector< float > &, const Vector< float > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< float, General, ColMajor > &, const Matrix< float, General, ColMajor > &, const Matrix< float, General, ColMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< float, General, ColMajor > &, const SeldonTranspose &, const Matrix< float, General, ColMajor > &, const Matrix< float, General, ColMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< float, General, ColMajor > &, const SeldonTranspose &, const Matrix< float, General, ColMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< float, General, ColMajor > &, const Matrix< float, General, ColMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< float >, General, ColMajor > &, const Matrix< complex< float >, General, ColMajor > &, const Matrix< complex< float >, General, ColMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< complex< float >, General, ColMajor > &, const SeldonTranspose &, const Matrix< complex< float >, General, ColMajor > &, const Matrix< complex< float >, General, ColMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< complex< float >, General, ColMajor > &, const SeldonTranspose &, const Matrix< complex< float >, General, ColMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< float >, General, ColMajor > &, const Matrix< complex< float >, General, ColMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< float, General, RowMajor > &, const Vector< float > &, const Vector< float > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< float >, General, RowMajor > &, const Vector< complex< float > > &, const Vector< complex< float > > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< float >, General, RowMajor > &, const Vector< float > &, const Vector< float > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< float, General, RowMajor > &, const Vector< float > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< float >, General, RowMajor > &, const Vector< complex< float > > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< float >, General, RowMajor > &, const Vector< float > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< float, General, RowMajor > &, const Matrix< float, General, RowMajor > &, const Matrix< float, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< float, General, RowMajor > &, const SeldonTranspose &, const Matrix< float, General, RowMajor > &, const Matrix< float, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< float, General, RowMajor > &, const SeldonTranspose &, const Matrix< float, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< float, General, RowMajor > &, const Matrix< float, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< float >, General, RowMajor > &, const Matrix< complex< float >, General, RowMajor > &, const Matrix< complex< float >, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< complex< float >, General, RowMajor > &, const SeldonTranspose &, const Matrix< complex< float >, General, RowMajor > &, const Matrix< complex< float >, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< complex< float >, General, RowMajor > &, const SeldonTranspose &, const Matrix< complex< float >, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< float >, General, RowMajor > &, const Matrix< complex< float >, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< float, Symmetric, RowSymPacked > &, const Vector< float > &, const Vector< float > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< float >, Symmetric, RowSymPacked > &, const Vector< complex< float > > &, const Vector< complex< float > > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< float >, Symmetric, RowSymPacked > &, const Vector< float > &, const Vector< float > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< float, Symmetric, RowSymPacked > &, const Vector< float > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< float >, Symmetric, RowSymPacked > &, const Vector< complex< float > > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< float >, Symmetric, RowSymPacked > &, const Vector< float > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< float, Symmetric, ColSymPacked > &, const Vector< float > &, const Vector< float > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< float >, Symmetric, ColSymPacked > &, const Vector< complex< float > > &, const Vector< complex< float > > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< float >, Symmetric, ColSymPacked > &, const Vector< float > &, const Vector< float > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< float, Symmetric, ColSymPacked > &, const Vector< float > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< float >, Symmetric, ColSymPacked > &, const Vector< complex< float > > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< float >, Symmetric, ColSymPacked > &, const Vector< float > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< float, Symmetric, RowSym > &, const Vector< float > &, const Vector< float > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< float >, Symmetric, RowSym > &, const Vector< complex< float > > &, const Vector< complex< float > > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< float >, Symmetric, RowSym > &, const Vector< float > &, const Vector< float > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< float, Symmetric, RowSym > &, const Vector< float > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< float >, Symmetric, RowSym > &, const Vector< complex< float > > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< float >, Symmetric, RowSym > &, const Vector< float > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< float, Symmetric, ColSym > &, const Vector< float > &, const Vector< float > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< float >, Symmetric, ColSym > &, const Vector< complex< float > > &, const Vector< complex< float > > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< float >, Symmetric, ColSym > &, const Vector< float > &, const Vector< float > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< float, Symmetric, ColSym > &, const Vector< float > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< float >, Symmetric, ColSym > &, const Vector< complex< float > > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< float >, Symmetric, ColSym > &, const Vector< float > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< float >, Hermitian, RowHerm > &, const Vector< complex< float > > &, const Vector< complex< float > > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< float >, Hermitian, RowHerm > &, const Vector< complex< float > > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< float >, Hermitian, ColHerm > &, const Vector< complex< float > > &, const Vector< complex< float > > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< float >, Hermitian, ColHerm > &, const Vector< complex< float > > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< float >, Hermitian, RowHermPacked > &, const Vector< complex< float > > &, const Vector< complex< float > > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< float >, Hermitian, RowHermPacked > &, const Vector< complex< float > > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< float >, Hermitian, ColHermPacked > &, const Vector< complex< float > > &, const Vector< complex< float > > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< complex< float >, Hermitian, ColHermPacked > &, const Vector< complex< float > > &, string, string) |
SELDON_EXTERN template void | FindEigenvaluesAnasazi (EigenProblem_Base< Real_wp > &, Vector< Real_wp > &, Vector< Real_wp > &, Matrix< Real_wp, General, ColMajor > &) |
SELDON_EXTERN template void | FindEigenvaluesAnasazi (EigenProblem_Base< Complex_wp > &, Vector< Complex_wp > &, Vector< Complex_wp > &, Matrix< Complex_wp, General, ColMajor > &) |
SELDON_EXTERN template void | FindEigenvaluesArpack (EigenProblem_Base< Real_wp > &, Vector< Real_wp > &, Vector< Real_wp > &, Matrix< Real_wp, General, ColMajor > &) |
SELDON_EXTERN template void | FindEigenvaluesArpack (EigenProblem_Base< Complex_wp > &, Vector< Complex_wp > &, Vector< Complex_wp > &, Matrix< Complex_wp, General, ColMajor > &) |
SELDON_EXTERN template void | MltScalar (const Real_wp &, Array3D< Real_wp > &) |
SELDON_EXTERN template void | MltScalar (const Real_wp &, Array3D< Complex_wp > &) |
SELDON_EXTERN template void | MltScalar (const Complex_wp &, Array3D< Complex_wp > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Array3D< int > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Array3D< Real_wp > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Array3D< Complex_wp > &) |
SELDON_EXTERN template void | GetLU (Matrix< Real_wp, General, BandedCol > &, Matrix< Real_wp, General, BandedCol > &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< Real_wp, General, BandedCol > &) |
SELDON_EXTERN template void | GetLU (Matrix< Complex_wp, General, BandedCol > &, Matrix< Complex_wp, General, BandedCol > &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< Complex_wp, General, BandedCol > &) |
SELDON_EXTERN template void | GetLU (Matrix< Real_wp, General, BandedCol > &, Vector< int > &, LapackInfo &) |
SELDON_EXTERN template void | SolveLU (const Matrix< Real_wp, General, BandedCol > &, const Vector< int > &, Vector< Real_wp > &, LapackInfo &) |
SELDON_EXTERN template void | SolveLU (const Matrix< Real_wp, General, BandedCol > &, const Vector< int > &, Vector< Complex_wp > &, LapackInfo &) |
SELDON_EXTERN template void | GetLU (Matrix< Complex_wp, General, BandedCol > &, Vector< int > &, LapackInfo &) |
SELDON_EXTERN template void | SolveLU (const Matrix< Complex_wp, General, BandedCol > &, const Vector< int > &, Vector< Complex_wp > &, LapackInfo &) |
SELDON_EXTERN template void | Copy (const Matrix< Real_wp, General, ArrayRowSparse > &, Matrix< Real_wp, General, BandedCol > &) |
SELDON_EXTERN template void | Copy (const Matrix< Complex_wp, General, ArrayRowSparse > &, Matrix< Complex_wp, General, BandedCol > &) |
SELDON_EXTERN template void | AddMatrix (const Real_wp &, const Matrix< Real_wp, General, BandedCol > &, Matrix< Real_wp, General, BandedCol > &) |
SELDON_EXTERN template void | AddMatrix (const Complex_wp &, const Matrix< Complex_wp, General, BandedCol > &, Matrix< Complex_wp, General, BandedCol > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const Matrix< Real_wp, General, BandedCol > &, const Vector< Real_wp > &, const Real_wp &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const Matrix< Complex_wp, General, BandedCol > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const SeldonTranspose &, const Matrix< Real_wp, General, BandedCol > &, const Vector< Real_wp > &, const Real_wp &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const SeldonTranspose &, const Matrix< Real_wp, General, BandedCol > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const SeldonTranspose &, const Matrix< Complex_wp, General, BandedCol > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const Matrix< Real_wp, General, BandedCol > &, const Vector< Real_wp > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< Real_wp, General, BandedCol > &, const Vector< Real_wp > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltVector (const Matrix< Complex_wp, General, BandedCol > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< Complex_wp, General, BandedCol > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltScalar (const Real_wp &, Matrix< Real_wp, General, BandedCol > &) |
SELDON_EXTERN template void | MltScalar (const Complex_wp &, Matrix< Complex_wp, General, BandedCol > &) |
SELDON_EXTERN template void | ScaleMatrix (Matrix< Real_wp, General, BandedCol > &, const Vector< Real_wp > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleMatrix (Matrix< Complex_wp, General, BandedCol > &, const Vector< Real_wp > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | SorVector (const Matrix< Complex_wp, General, BandedCol > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const Matrix< Complex_wp, General, BandedCol > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const Matrix< Real_wp, General, BandedCol > &, Vector< Real_wp > &, const Vector< Real_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const Matrix< Real_wp, General, BandedCol > &, Vector< Real_wp > &, const Vector< Real_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const Matrix< Real_wp, General, BandedCol > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const Matrix< Real_wp, General, BandedCol > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | GetLU (Matrix< Real_wp, General, ArrowCol > &, Matrix< Real_wp, General, ArrowCol > &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< Complex_wp, General, ArrowCol > &, Matrix< Complex_wp, General, ArrowCol > &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< Real_wp, General, ArrowCol > &) |
SELDON_EXTERN template void | GetLU (Matrix< Complex_wp, General, ArrowCol > &) |
SELDON_EXTERN template void | AddMatrix (const Real_wp &, const Matrix< Real_wp, General, ArrowCol > &, Matrix< Real_wp, General, ArrowCol > &) |
SELDON_EXTERN template void | AddMatrix (const Complex_wp &, const Matrix< Complex_wp, General, ArrowCol > &, Matrix< Complex_wp, General, ArrowCol > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const Matrix< Real_wp, General, ArrowCol > &, const Vector< Real_wp > &, const Real_wp &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const Matrix< Complex_wp, General, ArrowCol > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const SeldonTranspose &, const Matrix< Real_wp, General, ArrowCol > &, const Vector< Real_wp > &, const Real_wp &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const SeldonTranspose &, const Matrix< Complex_wp, General, ArrowCol > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const Matrix< Real_wp, General, ArrowCol > &, const Vector< Real_wp > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< Real_wp, General, ArrowCol > &, const Vector< Real_wp > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltVector (const Matrix< Complex_wp, General, ArrowCol > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< Complex_wp, General, ArrowCol > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltScalar (const Real_wp &, Matrix< Real_wp, General, ArrowCol > &) |
SELDON_EXTERN template void | MltScalar (const Complex_wp &, Matrix< Complex_wp, General, ArrowCol > &) |
SELDON_EXTERN template void | SorVector (const Matrix< Complex_wp, General, ArrowCol > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const Matrix< Complex_wp, General, ArrowCol > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const Matrix< Real_wp, General, ArrowCol > &, Vector< Real_wp > &, const Vector< Real_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const Matrix< Real_wp, General, ArrowCol > &, Vector< Real_wp > &, const Vector< Real_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | GenRot (Complex_wp &, Complex_wp &, Real_wp &, Complex_wp &) |
SELDON_EXTERN template void | ApplyRot (Real_wp &, Real_wp &, const Real_wp &, const Real_wp &) |
SELDON_EXTERN template void | ApplyRot (Complex_wp &, Complex_wp &, const Real_wp &, const Complex_wp &) |
SELDON_EXTERN template void | ApplyRot (Vector< Real_wp > &, Vector< Real_wp > &, const Real_wp &, const Real_wp &) |
SELDON_EXTERN template void | ApplyModifRot (Vector< Real_wp > &, Vector< Real_wp > &, const Real_wp *) |
SELDON_EXTERN template void | Swap (Vector< Real_wp > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | Swap (Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltScalar (const int &, Vector< int > &) |
SELDON_EXTERN template void | MltScalar (const complex< int > &, Vector< complex< int > > &) |
SELDON_EXTERN template void | MltScalar (const Real_wp &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltScalar (const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltScalar (const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | CopyVector (const Vector< int > &, Vector< int > &) |
SELDON_EXTERN template void | CopyVector (const Vector< Real_wp > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | CopyVector (const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | AddVector (const Real_wp &, const Vector< Real_wp > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | AddVector (const Complex_wp &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template Real_wp | DotProdVector (const Vector< Real_wp > &, const Vector< Real_wp > &) |
SELDON_EXTERN template Complex_wp | DotProdVector (const Vector< Complex_wp > &, const Vector< Complex_wp > &) |
SELDON_EXTERN template Real_wp | DotProdConjVector (const Vector< Real_wp > &, const Vector< Real_wp > &) |
SELDON_EXTERN template Complex_wp | DotProdConjVector (const Vector< Complex_wp > &, const Vector< Complex_wp > &) |
SELDON_EXTERN template Real_wp | Norm1 (const Vector< Real_wp > &) |
SELDON_EXTERN template Real_wp | Norm1 (const Vector< Complex_wp > &) |
SELDON_EXTERN template Real_wp | Norm2 (const Vector< Real_wp > &) |
SELDON_EXTERN template Real_wp | Norm2 (const Vector< Complex_wp > &) |
SELDON_EXTERN template size_t | GetMaxAbsIndex (const Vector< Real_wp > &) |
SELDON_EXTERN template size_t | GetMaxAbsIndex (const Vector< Complex_wp > &) |
SELDON_EXTERN template void | Mlt (const Matrix< Real_wp, General, RowUpTriang > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | Mlt (const Matrix< Complex_wp, General, RowUpTriang > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | Mlt (const Matrix< Real_wp, General, RowLoTriang > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | Mlt (const Matrix< Complex_wp, General, RowLoTriang > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | Mlt (const Matrix< Real_wp, General, RowUpTriangPacked > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | Mlt (const Matrix< Complex_wp, General, RowUpTriangPacked > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | Mlt (const Matrix< Real_wp, General, RowLoTriangPacked > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | Mlt (const Matrix< Complex_wp, General, RowLoTriangPacked > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | Mlt (const SeldonTranspose &, const SeldonDiag &, const Matrix< Real_wp, General, RowUpTriang > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | Mlt (const SeldonTranspose &, const SeldonDiag &, const Matrix< Complex_wp, General, RowUpTriang > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | Mlt (const SeldonTranspose &, const SeldonDiag &, const Matrix< Real_wp, General, RowLoTriang > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | Mlt (const SeldonTranspose &, const SeldonDiag &, const Matrix< Complex_wp, General, RowLoTriang > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | Mlt (const SeldonTranspose &, const SeldonDiag &, const Matrix< Real_wp, General, RowUpTriangPacked > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | Mlt (const SeldonTranspose &, const SeldonDiag &, const Matrix< Complex_wp, General, RowUpTriangPacked > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | Mlt (const SeldonTranspose &, const SeldonDiag &, const Matrix< Real_wp, General, RowLoTriangPacked > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | Mlt (const SeldonTranspose &, const SeldonDiag &, const Matrix< Complex_wp, General, RowLoTriangPacked > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const Matrix< Real_wp, General, ColMajor > &, const Vector< Real_wp > &, const Real_wp &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const Matrix< Complex_wp, General, ColMajor > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const Matrix< Real_wp, General, RowMajor > &, const Vector< Real_wp > &, const Real_wp &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const Matrix< Complex_wp, General, RowMajor > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const SeldonTranspose &, const Matrix< Real_wp, General, ColMajor > &, const Vector< Real_wp > &, const Real_wp &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const SeldonTranspose &, const Matrix< Complex_wp, General, ColMajor > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const SeldonTranspose &, const Matrix< Real_wp, General, RowMajor > &, const Vector< Real_wp > &, const Real_wp &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const SeldonTranspose &, const Matrix< Complex_wp, General, RowMajor > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const Matrix< Real_wp, Symmetric, RowSym > &, const Vector< Real_wp > &, const Real_wp &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const Matrix< Real_wp, Symmetric, RowSymPacked > &, const Vector< Real_wp > &, const Real_wp &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const Matrix< Complex_wp, Hermitian, RowHerm > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const Matrix< Complex_wp, Hermitian, RowHermPacked > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | Rank1Update (const Real_wp &, const Vector< Real_wp > &, const Vector< Real_wp > &, Matrix< Real_wp, General, ColMajor > &) |
SELDON_EXTERN template void | Rank1Update (const Complex_wp &, const Vector< Complex_wp > &, const Vector< Complex_wp > &, Matrix< Complex_wp, General, ColMajor > &) |
SELDON_EXTERN template void | Rank1Update (const Real_wp &, const Vector< Real_wp > &, const Vector< Real_wp > &, Matrix< Real_wp, General, RowMajor > &) |
SELDON_EXTERN template void | Rank1Update (const Complex_wp &, const Vector< Complex_wp > &, const Vector< Complex_wp > &, Matrix< Complex_wp, General, RowMajor > &) |
SELDON_EXTERN template void | Rank1Update (const Complex_wp &, const Vector< Complex_wp > &, const SeldonConjugate &, const Vector< Complex_wp > &, Matrix< Complex_wp, General, ColMajor > &) |
SELDON_EXTERN template void | Rank1Update (const Complex_wp &, const Vector< Complex_wp > &, const SeldonConjugate &, const Vector< Complex_wp > &, Matrix< Complex_wp, General, RowMajor > &) |
SELDON_EXTERN template void | Rank1Update (const Real_wp &, const Vector< Real_wp > &, Matrix< Real_wp, Symmetric, RowSym > &) |
SELDON_EXTERN template void | Rank1Update (const Real_wp &, const Vector< Real_wp > &, Matrix< Real_wp, Symmetric, RowSymPacked > &) |
SELDON_EXTERN template void | Rank1Update (const Real_wp &, const Vector< Complex_wp > &, Matrix< Complex_wp, Hermitian, RowHerm > &) |
SELDON_EXTERN template void | Rank1Update (const Real_wp &, const Vector< Complex_wp > &, Matrix< Complex_wp, Hermitian, RowHermPacked > &) |
SELDON_EXTERN template void | Rank2Update (const Real_wp &, const Vector< Real_wp > &, const Vector< Real_wp > &, Matrix< Real_wp, Symmetric, RowSym > &) |
SELDON_EXTERN template void | Rank2Update (const Real_wp &, const Vector< Real_wp > &, const Vector< Real_wp > &, Matrix< Real_wp, Symmetric, RowSymPacked > &) |
SELDON_EXTERN template void | Rank2Update (const Complex_wp &, const Vector< Complex_wp > &, const Vector< Complex_wp > &, Matrix< Complex_wp, Hermitian, RowHerm > &) |
SELDON_EXTERN template void | Rank2Update (const Complex_wp &, const Vector< Complex_wp > &, const Vector< Complex_wp > &, Matrix< Complex_wp, Hermitian, RowHermPacked > &) |
SELDON_EXTERN template void | Solve (const Matrix< Real_wp, General, RowUpTriang > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | Solve (const Matrix< Complex_wp, General, RowUpTriang > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | Solve (const Matrix< Real_wp, General, RowLoTriang > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | Solve (const Matrix< Complex_wp, General, RowLoTriang > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | Solve (const Matrix< Real_wp, General, RowUpTriangPacked > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | Solve (const Matrix< Complex_wp, General, RowUpTriangPacked > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | Solve (const Matrix< Real_wp, General, RowLoTriangPacked > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | Solve (const Matrix< Complex_wp, General, RowLoTriangPacked > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | Solve (const SeldonTranspose &, const SeldonDiag &, const Matrix< Real_wp, General, RowUpTriang > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | Solve (const SeldonTranspose &, const SeldonDiag &, const Matrix< Complex_wp, General, RowUpTriang > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | Solve (const SeldonTranspose &, const SeldonDiag &, const Matrix< Real_wp, General, RowLoTriang > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | Solve (const SeldonTranspose &, const SeldonDiag &, const Matrix< Complex_wp, General, RowLoTriang > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | Solve (const SeldonTranspose &, const SeldonDiag &, const Matrix< Real_wp, General, RowUpTriangPacked > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | Solve (const SeldonTranspose &, const SeldonDiag &, const Matrix< Complex_wp, General, RowUpTriangPacked > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | Solve (const SeldonTranspose &, const SeldonDiag &, const Matrix< Real_wp, General, RowLoTriangPacked > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | Solve (const SeldonTranspose &, const SeldonDiag &, const Matrix< Complex_wp, General, RowLoTriangPacked > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddMatrix (const Real_wp &, const Matrix< Real_wp, General, ColMajor > &, const Matrix< Real_wp, General, ColMajor > &, const Real_wp &, Matrix< Real_wp, General, ColMajor > &) |
SELDON_EXTERN template void | MltAddMatrix (const Complex_wp &, const Matrix< Complex_wp, General, ColMajor > &, const Matrix< Complex_wp, General, ColMajor > &, const Complex_wp &, Matrix< Complex_wp, General, ColMajor > &) |
SELDON_EXTERN template void | MltAddMatrix (const Real_wp &, const Matrix< Real_wp, General, RowMajor > &, const Matrix< Real_wp, General, RowMajor > &, const Real_wp &, Matrix< Real_wp, General, RowMajor > &) |
SELDON_EXTERN template void | MltAddMatrix (const Complex_wp &, const Matrix< Complex_wp, General, RowMajor > &, const Matrix< Complex_wp, General, RowMajor > &, const Complex_wp &, Matrix< Complex_wp, General, RowMajor > &) |
SELDON_EXTERN template void | MltAddMatrix (const Real_wp &, const SeldonTranspose &, const Matrix< Real_wp, General, ColMajor > &, const SeldonTranspose &, const Matrix< Real_wp, General, ColMajor > &, const Real_wp &, Matrix< Real_wp, General, ColMajor > &) |
SELDON_EXTERN template void | MltAddMatrix (const Complex_wp &, const SeldonTranspose &, const Matrix< Complex_wp, General, ColMajor > &, const SeldonTranspose &, const Matrix< Complex_wp, General, ColMajor > &, const Complex_wp &, Matrix< Complex_wp, General, ColMajor > &) |
SELDON_EXTERN template void | MltAddMatrix (const Real_wp &, const SeldonTranspose &, const Matrix< Real_wp, General, RowMajor > &, const SeldonTranspose &, const Matrix< Real_wp, General, RowMajor > &, const Real_wp &, Matrix< Real_wp, General, RowMajor > &) |
SELDON_EXTERN template void | MltAddMatrix (const Complex_wp &, const SeldonTranspose &, const Matrix< Complex_wp, General, RowMajor > &, const SeldonTranspose &, const Matrix< Complex_wp, General, RowMajor > &, const Complex_wp &, Matrix< Complex_wp, General, RowMajor > &) |
SELDON_EXTERN template void | MltAdd (const SeldonSide &, const Real_wp &, const Matrix< Real_wp, Symmetric, RowSym > &, const Matrix< Real_wp, General, RowMajor > &, const Real_wp &, Matrix< Real_wp, General, RowMajor > &) |
SELDON_EXTERN template void | MltAdd (const SeldonSide &, const Complex_wp &, const Matrix< Complex_wp, Symmetric, RowSym > &, const Matrix< Complex_wp, General, RowMajor > &, const Complex_wp &, Matrix< Complex_wp, General, RowMajor > &) |
SELDON_EXTERN template void | MltAdd (SeldonSide const &, Complex_wp const &, Matrix< Complex_wp, Hermitian, RowHerm > const &, Matrix< Complex_wp, General, RowMajor > const &, Complex_wp const &, Matrix< Complex_wp, General, RowMajor > &) |
SELDON_EXTERN template void | Mlt (const SeldonSide &, const Real_wp &, const Matrix< Real_wp, General, RowLoTriang > &, Matrix< Real_wp, General, RowMajor > &) |
SELDON_EXTERN template void | Mlt (const SeldonSide &, const Complex_wp &, const Matrix< Complex_wp, General, RowLoTriang > &, Matrix< Complex_wp, General, RowMajor > &) |
SELDON_EXTERN template void | Mlt (const SeldonSide &, const Real_wp &, const Matrix< Real_wp, General, RowUpTriang > &, Matrix< Real_wp, General, RowMajor > &) |
SELDON_EXTERN template void | Mlt (const SeldonSide &, const Complex_wp &, const Matrix< Complex_wp, General, RowUpTriang > &, Matrix< Complex_wp, General, RowMajor > &) |
SELDON_EXTERN template void | Mlt (const SeldonSide &, const Real_wp &, const SeldonTranspose &, const SeldonDiag &, const Matrix< Real_wp, General, RowLoTriang > &, Matrix< Real_wp, General, RowMajor > &) |
SELDON_EXTERN template void | Mlt (const SeldonSide &, const Complex_wp &, const SeldonTranspose &, const SeldonDiag &, const Matrix< Complex_wp, General, RowLoTriang > &, Matrix< Complex_wp, General, RowMajor > &) |
SELDON_EXTERN template void | Mlt (const SeldonSide &, const Real_wp &, const SeldonTranspose &, const SeldonDiag &, const Matrix< Real_wp, General, RowUpTriang > &, Matrix< Real_wp, General, RowMajor > &) |
SELDON_EXTERN template void | Mlt (const SeldonSide &, const Complex_wp &, const SeldonTranspose &, const SeldonDiag &, const Matrix< Complex_wp, General, RowUpTriang > &, Matrix< Complex_wp, General, RowMajor > &) |
SELDON_EXTERN template void | Solve (const SeldonSide &, const Real_wp &, const Matrix< Real_wp, General, RowLoTriang > &, Matrix< Real_wp, General, RowMajor > &) |
SELDON_EXTERN template void | Solve (const SeldonSide &, const Complex_wp &, const Matrix< Complex_wp, General, RowLoTriang > &, Matrix< Complex_wp, General, RowMajor > &) |
SELDON_EXTERN template void | Solve (const SeldonSide &, const Real_wp &, const Matrix< Real_wp, General, RowUpTriang > &, Matrix< Real_wp, General, RowMajor > &) |
SELDON_EXTERN template void | Solve (const SeldonSide &, const Complex_wp &, const Matrix< Complex_wp, General, RowUpTriang > &, Matrix< Complex_wp, General, RowMajor > &) |
SELDON_EXTERN template void | Solve (const SeldonSide &, const Real_wp &, const SeldonTranspose &, const SeldonDiag &, const Matrix< Real_wp, General, RowLoTriang > &, Matrix< Real_wp, General, RowMajor > &) |
SELDON_EXTERN template void | Solve (const SeldonSide &, const Complex_wp &, const SeldonTranspose &, const SeldonDiag &, const Matrix< Complex_wp, General, RowLoTriang > &, Matrix< Complex_wp, General, RowMajor > &) |
SELDON_EXTERN template void | Solve (const SeldonSide &, const Real_wp &, const SeldonTranspose &, const SeldonDiag &, const Matrix< Real_wp, General, RowUpTriang > &, Matrix< Real_wp, General, RowMajor > &) |
SELDON_EXTERN template void | Solve (const SeldonSide &, const Complex_wp &, const SeldonTranspose &, const SeldonDiag &, const Matrix< Complex_wp, General, RowUpTriang > &, Matrix< Complex_wp, General, RowMajor > &) |
SELDON_EXTERN template void | AddVector (const Real_wp &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | AddVector (const Real_wp &, const Vector< Real_wp, VectSparse > &, Vector< Real_wp, VectSparse > &) |
SELDON_EXTERN template void | AddVector (const Real_wp &, const Vector< Complex_wp, VectSparse > &, Vector< Complex_wp, VectSparse > &) |
SELDON_EXTERN template void | AddVector (const Complex_wp &, const Vector< Complex_wp, VectSparse > &, Vector< Complex_wp, VectSparse > &) |
SELDON_EXTERN template void | AddVector (const Real_wp &, const Vector< Real_wp, VectSparse > &, Vector< Real_wp, VectFull > &) |
SELDON_EXTERN template void | AddVector (const Real_wp &, const Vector< Complex_wp, VectSparse > &, Vector< Complex_wp, VectFull > &) |
SELDON_EXTERN template void | AddVector (const Complex_wp &, const Vector< Complex_wp, VectSparse > &, Vector< Complex_wp, VectFull > &) |
SELDON_EXTERN template void | Swap (Vector< Real_wp, VectSparse > &, Vector< Real_wp, VectSparse > &) |
SELDON_EXTERN template void | Swap (Vector< Complex_wp, VectSparse > &, Vector< Complex_wp, VectSparse > &) |
SELDON_EXTERN template void | MltScalar (const Real_wp &, Vector< Real_wp, VectSparse > &) |
SELDON_EXTERN template void | MltScalar (const Real_wp &, Vector< Complex_wp, VectSparse > &) |
SELDON_EXTERN template void | MltScalar (const Complex_wp &, Vector< Complex_wp, VectSparse > &) |
SELDON_EXTERN template Real_wp | DotProdVector (const Vector< Real_wp, VectSparse > &, const Vector< Real_wp, VectSparse > &) |
SELDON_EXTERN template Complex_wp | DotProdVector (const Vector< Complex_wp, VectSparse > &, const Vector< Complex_wp, VectSparse > &) |
SELDON_EXTERN template Real_wp | DotProdConjVector (const Vector< Real_wp, VectSparse > &, const Vector< Real_wp, VectSparse > &) |
SELDON_EXTERN template Complex_wp | DotProdConjVector (const Vector< Complex_wp, VectSparse > &, const Vector< Complex_wp, VectSparse > &) |
SELDON_EXTERN template Real_wp | DotProdVector (const Vector< Real_wp, VectSparse > &, const Vector< Real_wp, VectFull > &) |
SELDON_EXTERN template Complex_wp | DotProdVector (const Vector< Complex_wp, VectSparse > &, const Vector< Complex_wp, VectFull > &) |
SELDON_EXTERN template Real_wp | DotProdVector (const Vector< Real_wp, VectFull > &, const Vector< Real_wp, VectSparse > &) |
SELDON_EXTERN template Complex_wp | DotProdVector (const Vector< Complex_wp, VectFull > &, const Vector< Complex_wp, VectSparse > &) |
SELDON_EXTERN template void | ScatterSparseEntry (const Vector< Real_wp, VectSparse > &, Vector< Real_wp, VectFull > &) |
SELDON_EXTERN template void | CopyVector (const Vector< Real_wp, VectSparse > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | CopyVector (const Vector< Real_wp, VectSparse > &, Vector< Real_wp, VectSparse > &) |
SELDON_EXTERN template void | CopyVector (const Vector< Complex_wp, VectSparse > &, Vector< Complex_wp, VectSparse > &) |
SELDON_EXTERN template Real_wp | Norm1 (const Vector< Real_wp, VectSparse > &) |
SELDON_EXTERN template Real_wp | Norm1 (const Vector< Complex_wp, VectSparse > &) |
SELDON_EXTERN template Real_wp | Norm2 (const Vector< Real_wp, VectSparse > &) |
SELDON_EXTERN template Real_wp | Norm2 (const Vector< Complex_wp, VectSparse > &) |
SELDON_EXTERN template void | Conjugate (Vector< Real_wp > &) |
SELDON_EXTERN template void | Conjugate (Vector< Complex_wp > &) |
SELDON_EXTERN template void | Conjugate (Vector< Real_wp, VectSparse > &) |
SELDON_EXTERN template void | Conjugate (Vector< Complex_wp, VectSparse > &) |
SELDON_EXTERN template long | GetMaxAbsIndex (const Vector< Real_wp, VectSparse > &) |
SELDON_EXTERN template long | GetMaxAbsIndex (const Vector< Complex_wp, VectSparse > &) |
SELDON_EXTERN template void | SolveLuVector (const Matrix< Real_wp, General, RowUpTriang > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | SolveLuVector (const Matrix< Complex_wp, General, RowUpTriang > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | SolveLuVector (const Matrix< Real_wp, General, RowLoTriang > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | SolveLuVector (const Matrix< Complex_wp, General, RowLoTriang > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | SolveLuVector (const Matrix< Real_wp, General, RowUpTriangPacked > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | SolveLuVector (const Matrix< Complex_wp, General, RowUpTriangPacked > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | SolveLuVector (const Matrix< Real_wp, General, RowLoTriangPacked > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | SolveLuVector (const Matrix< Complex_wp, General, RowLoTriangPacked > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | CheckDim (const Vector< Real_wp > &, const Vector< Real_wp > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Vector< Complex_wp > &, const Vector< Complex_wp > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Vector< Complex_wp, VectSparse > &, const Vector< Complex_wp, VectSparse > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Complex_wp, General, RowMajor > &, const Vector< Real_wp > &, const Vector< Real_wp > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Real_wp, General, RowMajor > &, const Vector< Complex_wp > &, const Vector< Complex_wp > &Y, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Real_wp, General, RowMajor > &, const Vector< Complex_wp > &, const Vector< Complex_wp > &Y, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Real_wp, General, RowMajor > &, const Vector< Complex_wp > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Complex_wp, General, RowMajor > &, const Vector< Complex_wp > &, const Vector< Complex_wp > &Y, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Complex_wp, General, RowMajor > &, const Vector< Complex_wp > &, const Vector< Complex_wp > &Y, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Complex_wp, General, RowMajor > &, const Vector< Complex_wp > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Complex_wp, General, ColMajor > &, const Vector< Real_wp > &, const Vector< Real_wp > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Real_wp, General, ColMajor > &, const Vector< Complex_wp > &, const Vector< Complex_wp > &Y, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Real_wp, General, ColMajor > &, const Vector< Complex_wp > &, const Vector< Complex_wp > &Y, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Real_wp, General, ColMajor > &, const Vector< Complex_wp > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Complex_wp, General, ColMajor > &, const Vector< Complex_wp > &, const Vector< Complex_wp > &Y, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Complex_wp, General, ColMajor > &, const Vector< Complex_wp > &, const Vector< Complex_wp > &Y, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Complex_wp, General, ColMajor > &, const Vector< Complex_wp > &, string, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Real_wp, Symmetric, RowSym > &, const Vector< Real_wp > &, const Vector< Real_wp > &Y, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Real_wp, Symmetric, RowSym > &, const Vector< Complex_wp > &, const Vector< Complex_wp > &Y, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Real_wp, Symmetric, RowSym > &, const Vector< Complex_wp > &, const Vector< Complex_wp > &Y, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Real_wp, Symmetric, RowSym > &, const Vector< Complex_wp > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Complex_wp, Symmetric, RowSym > &, const Vector< Complex_wp > &, const Vector< Complex_wp > &Y, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Complex_wp, Symmetric, RowSym > &, const Vector< Complex_wp > &, const Vector< Complex_wp > &Y, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Complex_wp, Symmetric, RowSym > &, const Vector< Complex_wp > &, string, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Real_wp, Symmetric, RowSymPacked > &, const Vector< Real_wp > &, const Vector< Real_wp > &Y, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Real_wp, Symmetric, RowSymPacked > &, const Vector< Complex_wp > &, const Vector< Complex_wp > &Y, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Real_wp, Symmetric, RowSymPacked > &, const Vector< Complex_wp > &, const Vector< Complex_wp > &Y, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Real_wp, Symmetric, RowSymPacked > &, const Vector< Complex_wp > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Complex_wp, Symmetric, RowSymPacked > &, const Vector< Complex_wp > &, const Vector< Complex_wp > &Y, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Complex_wp, Symmetric, RowSymPacked > &, const Vector< Complex_wp > &, const Vector< Complex_wp > &Y, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Complex_wp, Symmetric, RowSymPacked > &, const Vector< Complex_wp > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Complex_wp, Hermitian, RowHerm > &, const Vector< Complex_wp > &, const Vector< Complex_wp > &Y, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Complex_wp, Hermitian, RowHerm > &, const Vector< Complex_wp > &, const Vector< Complex_wp > &Y, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Complex_wp, Hermitian, RowHerm > &, const Vector< Complex_wp > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Complex_wp, Hermitian, RowHermPacked > &, const Vector< Complex_wp > &, const Vector< Complex_wp > &Y, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Complex_wp, Hermitian, RowHermPacked > &, const Vector< Complex_wp > &, const Vector< Complex_wp > &Y, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Complex_wp, Hermitian, RowHermPacked > &, const Vector< Complex_wp > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Real_wp, General, RowLoTriang > &, const Vector< Real_wp > &, const Vector< Real_wp > &Y, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Real_wp, General, RowLoTriang > &, const Vector< Real_wp > &, const Vector< Real_wp > &Y, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Real_wp, General, RowLoTriang > &, const Vector< Real_wp > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Real_wp, General, RowLoTriang > &, const Vector< Complex_wp > &, const Vector< Complex_wp > &Y, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Real_wp, General, RowLoTriang > &, const Vector< Complex_wp > &, const Vector< Complex_wp > &Y, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Real_wp, General, RowLoTriang > &, const Vector< Complex_wp > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Complex_wp, General, RowLoTriang > &, const Vector< Complex_wp > &, const Vector< Complex_wp > &Y, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Complex_wp, General, RowLoTriang > &, const Vector< Complex_wp > &, const Vector< Complex_wp > &Y, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Complex_wp, General, RowLoTriang > &, const Vector< Complex_wp > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Real_wp, General, RowLoTriangPacked > &, const Vector< Real_wp > &, const Vector< Real_wp > &Y, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Real_wp, General, RowLoTriangPacked > &, const Vector< Real_wp > &, const Vector< Real_wp > &Y, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Real_wp, General, RowLoTriangPacked > &, const Vector< Real_wp > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Real_wp, General, RowLoTriangPacked > &, const Vector< Complex_wp > &, const Vector< Complex_wp > &Y, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Real_wp, General, RowLoTriangPacked > &, const Vector< Complex_wp > &, const Vector< Complex_wp > &Y, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Real_wp, General, RowLoTriangPacked > &, const Vector< Complex_wp > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Complex_wp, General, RowLoTriangPacked > &, const Vector< Complex_wp > &, const Vector< Complex_wp > &Y, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Complex_wp, General, RowLoTriangPacked > &, const Vector< Complex_wp > &, const Vector< Complex_wp > &Y, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Complex_wp, General, RowLoTriangPacked > &, const Vector< Complex_wp > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Real_wp, General, RowUpTriang > &, const Vector< Real_wp > &, const Vector< Real_wp > &Y, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Real_wp, General, RowUpTriang > &, const Vector< Real_wp > &, const Vector< Real_wp > &Y, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Real_wp, General, RowUpTriang > &, const Vector< Real_wp > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Real_wp, General, RowUpTriang > &, const Vector< Complex_wp > &, const Vector< Complex_wp > &Y, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Real_wp, General, RowUpTriang > &, const Vector< Complex_wp > &, const Vector< Complex_wp > &Y, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Real_wp, General, RowUpTriang > &, const Vector< Complex_wp > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Complex_wp, General, RowUpTriang > &, const Vector< Complex_wp > &, const Vector< Complex_wp > &Y, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Complex_wp, General, RowUpTriang > &, const Vector< Complex_wp > &, const Vector< Complex_wp > &Y, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Complex_wp, General, RowUpTriang > &, const Vector< Complex_wp > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Real_wp, General, RowUpTriangPacked > &, const Vector< Real_wp > &, const Vector< Real_wp > &Y, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Real_wp, General, RowUpTriangPacked > &, const Vector< Real_wp > &, const Vector< Real_wp > &Y, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Real_wp, General, RowUpTriangPacked > &, const Vector< Real_wp > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Real_wp, General, RowUpTriangPacked > &, const Vector< Complex_wp > &, const Vector< Complex_wp > &Y, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Real_wp, General, RowUpTriangPacked > &, const Vector< Complex_wp > &, const Vector< Complex_wp > &Y, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Real_wp, General, RowUpTriangPacked > &, const Vector< Complex_wp > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Complex_wp, General, RowUpTriangPacked > &, const Vector< Complex_wp > &, const Vector< Complex_wp > &Y, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Complex_wp, General, RowUpTriangPacked > &, const Vector< Complex_wp > &, const Vector< Complex_wp > &Y, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Complex_wp, General, RowUpTriangPacked > &, const Vector< Complex_wp > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Real_wp, General, RowSparse > &, const Vector< Real_wp > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Real_wp, General, RowSparse > &, const Vector< Complex_wp > &, const Vector< Complex_wp > &Y, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Real_wp, General, RowSparse > &, const Vector< Complex_wp > &, const Vector< Complex_wp > &Y, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Real_wp, General, RowSparse > &, const Vector< Complex_wp > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Complex_wp, General, RowSparse > &, const Vector< Complex_wp > &, const Vector< Complex_wp > &Y, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Complex_wp, General, RowSparse > &, const Vector< Complex_wp > &, const Vector< Complex_wp > &Y, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Complex_wp, General, RowSparse > &, const Vector< Complex_wp > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Real_wp, Symmetric, RowSymSparse > &, const Vector< Real_wp > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Real_wp, Symmetric, RowSymSparse > &, const Vector< Complex_wp > &, const Vector< Complex_wp > &Y, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Real_wp, Symmetric, RowSymSparse > &, const Vector< Complex_wp > &, const Vector< Complex_wp > &Y, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Real_wp, Symmetric, RowSymSparse > &, const Vector< Complex_wp > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Complex_wp, Symmetric, RowSymSparse > &, const Vector< Complex_wp > &, const Vector< Complex_wp > &Y, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Complex_wp, Symmetric, RowSymSparse > &, const Vector< Complex_wp > &, const Vector< Complex_wp > &Y, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Complex_wp, Symmetric, RowSymSparse > &, const Vector< Complex_wp > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Complex_wp, General, RowComplexSparse > &, const Vector< Complex_wp > &, const Vector< Complex_wp > &Y, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Complex_wp, General, RowComplexSparse > &, const Vector< Complex_wp > &, const Vector< Complex_wp > &Y, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Complex_wp, General, RowComplexSparse > &, const Vector< Complex_wp > &, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Complex_wp, Symmetric, RowSymComplexSparse > &, const Vector< Complex_wp > &, const Vector< Complex_wp > &Y, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Complex_wp, Symmetric, RowSymComplexSparse > &, const Vector< Complex_wp > &, const Vector< Complex_wp > &Y, string, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Complex_wp, Symmetric, RowSymComplexSparse > &, const Vector< Complex_wp > &, string, string) |
SELDON_EXTERN template void | CheckDim (const SeldonSide &, const Matrix< Real_wp, General, RowMajor > &, const Matrix< Real_wp, General, RowMajor > &, const Matrix< Real_wp, General, RowMajor > &Y, string) |
SELDON_EXTERN template void | CheckDim (const SeldonSide &, const Matrix< Real_wp, General, RowMajor > &, const Matrix< Real_wp, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Complex_wp, General, RowMajor > &, const Matrix< Complex_wp, General, RowMajor > &, const Matrix< Complex_wp, General, RowMajor > &Y, string) |
SELDON_EXTERN template void | CheckDim (const SeldonSide &, const Matrix< Complex_wp, General, RowMajor > &, const Matrix< Complex_wp, General, RowMajor > &, const Matrix< Complex_wp, General, RowMajor > &Y, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Complex_wp, General, RowMajor > &, const Matrix< Complex_wp, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonSide &, const Matrix< Complex_wp, General, RowMajor > &, const Matrix< Complex_wp, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Complex_wp, General, RowMajor > &, const SeldonTranspose &, const Matrix< Complex_wp, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Complex_wp, General, RowMajor > &, const SeldonTranspose &, const Matrix< Complex_wp, General, RowMajor > &, const Matrix< Complex_wp, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonSide &, const Matrix< Real_wp, General, ColMajor > &, const Matrix< Real_wp, General, ColMajor > &, const Matrix< Real_wp, General, ColMajor > &Y, string) |
SELDON_EXTERN template void | CheckDim (const SeldonSide &, const Matrix< Real_wp, General, ColMajor > &, const Matrix< Real_wp, General, ColMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Complex_wp, General, ColMajor > &, const Matrix< Complex_wp, General, ColMajor > &, const Matrix< Complex_wp, General, ColMajor > &Y, string) |
SELDON_EXTERN template void | CheckDim (const SeldonSide &, const Matrix< Complex_wp, General, ColMajor > &, const Matrix< Complex_wp, General, ColMajor > &, const Matrix< Complex_wp, General, ColMajor > &Y, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Complex_wp, General, ColMajor > &, const Matrix< Complex_wp, General, ColMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonSide &, const Matrix< Complex_wp, General, ColMajor > &, const Matrix< Complex_wp, General, ColMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Complex_wp, General, ColMajor > &, const SeldonTranspose &, const Matrix< Complex_wp, General, ColMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Complex_wp, General, ColMajor > &, const SeldonTranspose &, const Matrix< Complex_wp, General, ColMajor > &, const Matrix< Complex_wp, General, ColMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Complex_wp, Hermitian, RowHerm > &, const Matrix< Complex_wp, General, RowMajor > &, const Matrix< Complex_wp, General, RowMajor > &Y, string) |
SELDON_EXTERN template void | CheckDim (const SeldonSide &, const Matrix< Complex_wp, Hermitian, RowHerm > &, const Matrix< Complex_wp, General, RowMajor > &, const Matrix< Complex_wp, General, RowMajor > &Y, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Complex_wp, Hermitian, RowHerm > &, const Matrix< Complex_wp, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonSide &, const Matrix< Complex_wp, Hermitian, RowHerm > &, const Matrix< Complex_wp, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Complex_wp, Hermitian, RowHerm > &, const SeldonTranspose &, const Matrix< Complex_wp, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Complex_wp, Hermitian, RowHerm > &, const SeldonTranspose &, const Matrix< Complex_wp, General, RowMajor > &, const Matrix< Complex_wp, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Complex_wp, Hermitian, RowHerm > &, const Matrix< Complex_wp, Hermitian, RowHerm > &, const Matrix< Complex_wp, General, RowMajor > &Y, string) |
SELDON_EXTERN template void | CheckDim (const SeldonSide &, const Matrix< Complex_wp, Hermitian, RowHerm > &, const Matrix< Complex_wp, Hermitian, RowHerm > &, const Matrix< Complex_wp, General, RowMajor > &Y, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Complex_wp, Hermitian, RowHerm > &, const Matrix< Complex_wp, Hermitian, RowHerm > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonSide &, const Matrix< Complex_wp, Hermitian, RowHerm > &, const Matrix< Complex_wp, Hermitian, RowHerm > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Complex_wp, Hermitian, RowHerm > &, const SeldonTranspose &, const Matrix< Complex_wp, Hermitian, RowHerm > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Complex_wp, Hermitian, RowHerm > &, const SeldonTranspose &, const Matrix< Complex_wp, Hermitian, RowHerm > &, const Matrix< Complex_wp, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Real_wp, Symmetric, RowSym > &, const Matrix< Real_wp, General, RowMajor > &, const Matrix< Real_wp, General, RowMajor > &Y, string) |
SELDON_EXTERN template void | CheckDim (const SeldonSide &, const Matrix< Real_wp, Symmetric, RowSym > &, const Matrix< Real_wp, General, RowMajor > &, const Matrix< Real_wp, General, RowMajor > &Y, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Real_wp, Symmetric, RowSym > &, const Matrix< Real_wp, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonSide &, const Matrix< Real_wp, Symmetric, RowSym > &, const Matrix< Real_wp, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Real_wp, Symmetric, RowSym > &, const SeldonTranspose &, const Matrix< Real_wp, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Real_wp, Symmetric, RowSym > &, const SeldonTranspose &, const Matrix< Real_wp, General, RowMajor > &, const Matrix< Real_wp, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Complex_wp, Symmetric, RowSym > &, const Matrix< Complex_wp, General, RowMajor > &, const Matrix< Complex_wp, General, RowMajor > &Y, string) |
SELDON_EXTERN template void | CheckDim (const SeldonSide &, const Matrix< Complex_wp, Symmetric, RowSym > &, const Matrix< Complex_wp, General, RowMajor > &, const Matrix< Complex_wp, General, RowMajor > &Y, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Complex_wp, Symmetric, RowSym > &, const Matrix< Complex_wp, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonSide &, const Matrix< Complex_wp, Symmetric, RowSym > &, const Matrix< Complex_wp, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Complex_wp, Symmetric, RowSym > &, const SeldonTranspose &, const Matrix< Complex_wp, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Complex_wp, Symmetric, RowSym > &, const SeldonTranspose &, const Matrix< Complex_wp, General, RowMajor > &, const Matrix< Complex_wp, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Real_wp, General, RowLoTriang > &, const Matrix< Real_wp, General, RowMajor > &, const Matrix< Real_wp, General, RowMajor > &Y, string) |
SELDON_EXTERN template void | CheckDim (const SeldonSide &, const Matrix< Real_wp, General, RowLoTriang > &, const Matrix< Real_wp, General, RowMajor > &, const Matrix< Real_wp, General, RowMajor > &Y, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Real_wp, General, RowLoTriang > &, const Matrix< Real_wp, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonSide &, const Matrix< Real_wp, General, RowLoTriang > &, const Matrix< Real_wp, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Real_wp, General, RowLoTriang > &, const SeldonTranspose &, const Matrix< Real_wp, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Real_wp, General, RowLoTriang > &, const SeldonTranspose &, const Matrix< Real_wp, General, RowMajor > &, const Matrix< Real_wp, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Complex_wp, General, RowLoTriang > &, const Matrix< Complex_wp, General, RowMajor > &, const Matrix< Complex_wp, General, RowMajor > &Y, string) |
SELDON_EXTERN template void | CheckDim (const SeldonSide &, const Matrix< Complex_wp, General, RowLoTriang > &, const Matrix< Complex_wp, General, RowMajor > &, const Matrix< Complex_wp, General, RowMajor > &Y, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Complex_wp, General, RowLoTriang > &, const Matrix< Complex_wp, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonSide &, const Matrix< Complex_wp, General, RowLoTriang > &, const Matrix< Complex_wp, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Complex_wp, General, RowLoTriang > &, const SeldonTranspose &, const Matrix< Complex_wp, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Complex_wp, General, RowLoTriang > &, const SeldonTranspose &, const Matrix< Complex_wp, General, RowMajor > &, const Matrix< Complex_wp, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Real_wp, General, RowLoTriangPacked > &, const Matrix< Real_wp, General, RowMajor > &, const Matrix< Real_wp, General, RowMajor > &Y, string) |
SELDON_EXTERN template void | CheckDim (const SeldonSide &, const Matrix< Real_wp, General, RowLoTriangPacked > &, const Matrix< Real_wp, General, RowMajor > &, const Matrix< Real_wp, General, RowMajor > &Y, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Real_wp, General, RowLoTriangPacked > &, const Matrix< Real_wp, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonSide &, const Matrix< Real_wp, General, RowLoTriangPacked > &, const Matrix< Real_wp, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Real_wp, General, RowLoTriangPacked > &, const SeldonTranspose &, const Matrix< Real_wp, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Real_wp, General, RowLoTriangPacked > &, const SeldonTranspose &, const Matrix< Real_wp, General, RowMajor > &, const Matrix< Real_wp, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Complex_wp, General, RowLoTriangPacked > &, const Matrix< Complex_wp, General, RowMajor > &, const Matrix< Complex_wp, General, RowMajor > &Y, string) |
SELDON_EXTERN template void | CheckDim (const SeldonSide &, const Matrix< Complex_wp, General, RowLoTriangPacked > &, const Matrix< Complex_wp, General, RowMajor > &, const Matrix< Complex_wp, General, RowMajor > &Y, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Complex_wp, General, RowLoTriangPacked > &, const Matrix< Complex_wp, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonSide &, const Matrix< Complex_wp, General, RowLoTriangPacked > &, const Matrix< Complex_wp, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Complex_wp, General, RowLoTriangPacked > &, const SeldonTranspose &, const Matrix< Complex_wp, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Complex_wp, General, RowLoTriangPacked > &, const SeldonTranspose &, const Matrix< Complex_wp, General, RowMajor > &, const Matrix< Complex_wp, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Real_wp, General, RowUpTriang > &, const Matrix< Real_wp, General, RowMajor > &, const Matrix< Real_wp, General, RowMajor > &Y, string) |
SELDON_EXTERN template void | CheckDim (const SeldonSide &, const Matrix< Real_wp, General, RowUpTriang > &, const Matrix< Real_wp, General, RowMajor > &, const Matrix< Real_wp, General, RowMajor > &Y, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Real_wp, General, RowUpTriang > &, const Matrix< Real_wp, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonSide &, const Matrix< Real_wp, General, RowUpTriang > &, const Matrix< Real_wp, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Real_wp, General, RowUpTriang > &, const SeldonTranspose &, const Matrix< Real_wp, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Real_wp, General, RowUpTriang > &, const SeldonTranspose &, const Matrix< Real_wp, General, RowMajor > &, const Matrix< Real_wp, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Complex_wp, General, RowUpTriang > &, const Matrix< Complex_wp, General, RowMajor > &, const Matrix< Complex_wp, General, RowMajor > &Y, string) |
SELDON_EXTERN template void | CheckDim (const SeldonSide &, const Matrix< Complex_wp, General, RowUpTriang > &, const Matrix< Complex_wp, General, RowMajor > &, const Matrix< Complex_wp, General, RowMajor > &Y, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Complex_wp, General, RowUpTriang > &, const Matrix< Complex_wp, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonSide &, const Matrix< Complex_wp, General, RowUpTriang > &, const Matrix< Complex_wp, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Complex_wp, General, RowUpTriang > &, const SeldonTranspose &, const Matrix< Complex_wp, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Complex_wp, General, RowUpTriang > &, const SeldonTranspose &, const Matrix< Complex_wp, General, RowMajor > &, const Matrix< Complex_wp, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Real_wp, General, RowUpTriangPacked > &, const Matrix< Real_wp, General, RowMajor > &, const Matrix< Real_wp, General, RowMajor > &Y, string) |
SELDON_EXTERN template void | CheckDim (const SeldonSide &, const Matrix< Real_wp, General, RowUpTriangPacked > &, const Matrix< Real_wp, General, RowMajor > &, const Matrix< Real_wp, General, RowMajor > &Y, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Real_wp, General, RowUpTriangPacked > &, const Matrix< Real_wp, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonSide &, const Matrix< Real_wp, General, RowUpTriangPacked > &, const Matrix< Real_wp, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Real_wp, General, RowUpTriangPacked > &, const SeldonTranspose &, const Matrix< Real_wp, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Real_wp, General, RowUpTriangPacked > &, const SeldonTranspose &, const Matrix< Real_wp, General, RowMajor > &, const Matrix< Real_wp, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Complex_wp, General, RowUpTriangPacked > &, const Matrix< Complex_wp, General, RowMajor > &, const Matrix< Complex_wp, General, RowMajor > &Y, string) |
SELDON_EXTERN template void | CheckDim (const SeldonSide &, const Matrix< Complex_wp, General, RowUpTriangPacked > &, const Matrix< Complex_wp, General, RowMajor > &, const Matrix< Complex_wp, General, RowMajor > &Y, string) |
SELDON_EXTERN template void | CheckDim (const Matrix< Complex_wp, General, RowUpTriangPacked > &, const Matrix< Complex_wp, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonSide &, const Matrix< Complex_wp, General, RowUpTriangPacked > &, const Matrix< Complex_wp, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Complex_wp, General, RowUpTriangPacked > &, const SeldonTranspose &, const Matrix< Complex_wp, General, RowMajor > &, string) |
SELDON_EXTERN template void | CheckDim (const SeldonTranspose &, const Matrix< Complex_wp, General, RowUpTriangPacked > &, const SeldonTranspose &, const Matrix< Complex_wp, General, RowMajor > &, const Matrix< Complex_wp, General, RowMajor > &, string) |
SELDON_EXTERN template void | GetCholesky (Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, int) |
SELDON_EXTERN template void | SolveCholesky (const SeldonTranspose &, const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | SolveCholesky (const SeldonTranspose &, const Matrix< Real_wp, Symmetric, RowSymSparse > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | SolveCholesky (const SeldonTranspose &, const Matrix< Real_wp, Symmetric, RowSymSparse > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltCholesky (const SeldonTranspose &, const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltCholesky (const SeldonTranspose &, const Matrix< Real_wp, Symmetric, RowSymSparse > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltCholesky (const SeldonTranspose &, const Matrix< Real_wp, Symmetric, RowSymSparse > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | GetCholesky (Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, MatrixCholmod &, bool) |
SELDON_EXTERN template void | GetCholesky (Matrix< Real_wp, Symmetric, RowSymSparse > &, MatrixCholmod &, bool) |
SELDON_EXTERN template void | SolveCholesky (const SeldonTranspose &, MatrixCholmod &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltCholesky (const SeldonTranspose &, MatrixCholmod &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const DistributedMatrix< Real_wp, General, ArrayRowSparse > &, const Vector< Real_wp > &, const Real_wp &, Vector< Real_wp > &, bool) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const DistributedMatrix< Real_wp, General, ArrayRowSparse > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const SeldonTranspose &, const DistributedMatrix< Real_wp, General, ArrayRowSparse > &, const Vector< Real_wp > &, const Real_wp &, Vector< Real_wp > &, bool) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const SeldonTranspose &, const DistributedMatrix< Real_wp, General, ArrayRowSparse > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | MltVector (const DistributedMatrix< Real_wp, General, ArrayRowSparse > &, const Vector< Real_wp > &, Vector< Real_wp > &, bool) |
SELDON_EXTERN template void | MltVector (const DistributedMatrix< Real_wp, General, ArrayRowSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | MltVector (const Real_wp &, const DistributedMatrix< Real_wp, General, ArrayRowSparse > &, const Vector< Real_wp > &, Vector< Real_wp > &, bool) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const DistributedMatrix< Real_wp, General, ArrayRowSparse > &, const Vector< Real_wp > &, Vector< Real_wp > &, bool) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const DistributedMatrix< Real_wp, General, ArrayRowSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | MltScalar (const Real_wp &, DistributedMatrix< Real_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | MltMin (const DistributedMatrix< Real_wp, General, ArrayRowSparse > &, IVect &, IVect &) |
SELDON_EXTERN template void | MltMin (const DistributedMatrix< Complex_wp, General, ArrayRowSparse > &, IVect &, IVect &) |
SELDON_EXTERN template void | MltMin (const Matrix< Real_wp, General, ArrayRowSparse > &, const IVect &, IVect &, IVect &) |
SELDON_EXTERN template void | MltMin (const Matrix< Complex_wp, General, ArrayRowSparse > &, const IVect &, IVect &, IVect &) |
SELDON_EXTERN template void | AddMatrix (const Real_wp &, const DistributedMatrix< Real_wp, General, ArrayRowSparse > &, DistributedMatrix< Real_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | AddMatrix (const Real_wp &, const DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &, DistributedMatrix< Real_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template Real_wp | MaxAbs (const DistributedMatrix< Real_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | GetRowSum (Vector< Real_wp > &, const DistributedMatrix< Real_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | GetColSum (Vector< Real_wp > &, const DistributedMatrix< Real_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | GetRowColSum (Vector< Real_wp > &, Vector< Real_wp > &, const DistributedMatrix< Real_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template Real_wp | Norm1 (const DistributedMatrix< Real_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template Real_wp | NormInf (const DistributedMatrix< Real_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | Transpose (DistributedMatrix< Real_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | Conjugate (DistributedMatrix< Real_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | Transpose (const DistributedMatrix< Real_wp, General, ArrayRowSparse > &, DistributedMatrix< Real_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | TransposeConj (const DistributedMatrix< Real_wp, General, ArrayRowSparse > &, DistributedMatrix< Real_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | TransposeConj (DistributedMatrix< Real_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | GetRow (const DistributedMatrix< Real_wp, General, ArrayRowSparse > &, int, Vector< Real_wp, VectSparse > &) |
SELDON_EXTERN template void | GetCol (const DistributedMatrix< Real_wp, General, ArrayRowSparse > &, int, Vector< Real_wp, VectSparse > &) |
SELDON_EXTERN template void | SetRow (const Vector< Real_wp, VectSparse > &, int, DistributedMatrix< Real_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | SetCol (const Vector< Real_wp, VectSparse > &, int, DistributedMatrix< Real_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | ApplyPermutation (DistributedMatrix< Real_wp, General, ArrayRowSparse > &, const Vector< int > &, const Vector< int > &) |
SELDON_EXTERN template void | ApplyInversePermutation (DistributedMatrix< Real_wp, General, ArrayRowSparse > &, const Vector< int > &, const Vector< int > &) |
SELDON_EXTERN template void | SorVector (const DistributedMatrix< Real_wp, General, ArrayRowSparse > &, Vector< Real_wp > &, const Vector< Real_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const DistributedMatrix< Real_wp, General, ArrayRowSparse > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const DistributedMatrix< Real_wp, General, ArrayRowSparse > &, Vector< Real_wp > &, const Vector< Real_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const DistributedMatrix< Real_wp, General, ArrayRowSparse > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | Copy (const DistributedMatrix< Real_wp, General, ArrayRowSparse > &, DistributedMatrix< Real_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | Copy (const DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &, DistributedMatrix< Real_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | Copy (const DistributedMatrix< Real_wp, General, ArrayRowSparse > &, DistributedMatrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template Real_wp | NormFro (const DistributedMatrix< Real_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | ScaleLeftMatrix (DistributedMatrix< Real_wp, General, ArrayRowSparse > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleRightMatrix (DistributedMatrix< Real_wp, General, ArrayRowSparse > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleMatrix (DistributedMatrix< Real_wp, General, ArrayRowSparse > &, const Vector< Real_wp > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | AssembleDistributed (DistributedMatrix< Real_wp, General, ArrayRowSparse > &, Symmetric &, const MPI_Comm &, IVect &, IVect &, Vector< long > &, Vector< int > &, Vector< Real_wp > &, bool, bool) |
SELDON_EXTERN template void | AssembleDistributed (DistributedMatrix< Real_wp, General, ArrayRowSparse > &, General &, const MPI_Comm &, IVect &, IVect &, Vector< long > &, Vector< int > &, Vector< Real_wp > &, bool, bool) |
SELDON_EXTERN template void | AssembleDistributed (DistributedMatrix< Real_wp, General, ArrayRowSparse > &, Symmetric &, const MPI_Comm &, IVect &, IVect &, Vector< int64_t > &, Vector< int64_t > &, Vector< Real_wp > &, bool, bool) |
SELDON_EXTERN template void | AssembleDistributed (DistributedMatrix< Real_wp, General, ArrayRowSparse > &, General &, const MPI_Comm &, IVect &, IVect &, Vector< int64_t > &, Vector< int64_t > &, Vector< Real_wp > &, bool, bool) |
SELDON_EXTERN template void | EraseCol (const IVect &, DistributedMatrix< Real_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | EraseRow (const IVect &, DistributedMatrix< Real_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | CopySubMatrix (const DistributedMatrix< Real_wp, General, ArrayRowSparse > &, const IVect &, const IVect &, DistributedMatrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template void | CopySubMatrix (const DistributedMatrix< Real_wp, General, ArrayRowSparse > &, const IVect &, const IVect &, DistributedMatrix< Real_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | DistributeCentralizedMatrix (Matrix< Real_wp, General, ArrayRowSparse > &, const MPI_Comm &comm, int, const Vector< int > &, DistributedMatrixIntegerArray &, DistributedMatrix< Real_wp, General, ArrayRowSparse > &, bool) |
SELDON_EXTERN template void | DistributeCentralizedMatrix (Matrix< Complex_wp, General, ArrayRowSparse > &, const MPI_Comm &comm, int, const Vector< int > &, DistributedMatrixIntegerArray &, DistributedMatrix< Complex_wp, General, ArrayRowSparse > &, bool) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const DistributedMatrix< Real_wp, General, RowSparse > &, const Vector< Real_wp > &, const Real_wp &, Vector< Real_wp > &, bool) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const DistributedMatrix< Real_wp, General, RowSparse > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const SeldonTranspose &, const DistributedMatrix< Real_wp, General, RowSparse > &, const Vector< Real_wp > &, const Real_wp &, Vector< Real_wp > &, bool) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const SeldonTranspose &, const DistributedMatrix< Real_wp, General, RowSparse > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | MltVector (const DistributedMatrix< Real_wp, General, RowSparse > &, const Vector< Real_wp > &, Vector< Real_wp > &, bool) |
SELDON_EXTERN template void | MltVector (const DistributedMatrix< Real_wp, General, RowSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | MltVector (const Real_wp &, const DistributedMatrix< Real_wp, General, RowSparse > &, const Vector< Real_wp > &, Vector< Real_wp > &, bool) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const DistributedMatrix< Real_wp, General, RowSparse > &, const Vector< Real_wp > &, Vector< Real_wp > &, bool) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const DistributedMatrix< Real_wp, General, RowSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | MltScalar (const Real_wp &, DistributedMatrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template void | AddMatrix (const Real_wp &, const DistributedMatrix< Real_wp, General, RowSparse > &, DistributedMatrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template Real_wp | MaxAbs (const DistributedMatrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template void | GetRowSum (Vector< Real_wp > &, const DistributedMatrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template void | GetColSum (Vector< Real_wp > &, const DistributedMatrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template void | GetRowColSum (Vector< Real_wp > &, Vector< Real_wp > &, const DistributedMatrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template Real_wp | Norm1 (const DistributedMatrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template Real_wp | NormInf (const DistributedMatrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template void | Transpose (DistributedMatrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template void | Conjugate (DistributedMatrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template void | Transpose (const DistributedMatrix< Real_wp, General, RowSparse > &, DistributedMatrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template void | TransposeConj (const DistributedMatrix< Real_wp, General, RowSparse > &, DistributedMatrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template void | TransposeConj (DistributedMatrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template void | GetRow (const DistributedMatrix< Real_wp, General, RowSparse > &, int, Vector< Real_wp, VectSparse > &) |
SELDON_EXTERN template void | GetCol (const DistributedMatrix< Real_wp, General, RowSparse > &, int, Vector< Real_wp, VectSparse > &) |
SELDON_EXTERN template void | SetRow (const Vector< Real_wp, VectSparse > &, int, DistributedMatrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template void | SetCol (const Vector< Real_wp, VectSparse > &, int, DistributedMatrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template void | ApplyPermutation (DistributedMatrix< Real_wp, General, RowSparse > &, const Vector< int > &, const Vector< int > &) |
SELDON_EXTERN template void | ApplyInversePermutation (DistributedMatrix< Real_wp, General, RowSparse > &, const Vector< int > &, const Vector< int > &) |
SELDON_EXTERN template void | SorVector (const DistributedMatrix< Real_wp, General, RowSparse > &, Vector< Real_wp > &, const Vector< Real_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const DistributedMatrix< Real_wp, General, RowSparse > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const DistributedMatrix< Real_wp, General, RowSparse > &, Vector< Real_wp > &, const Vector< Real_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const DistributedMatrix< Real_wp, General, RowSparse > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | Copy (const DistributedMatrix< Real_wp, General, RowSparse > &, DistributedMatrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template Real_wp | NormFro (const DistributedMatrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template void | ScaleLeftMatrix (DistributedMatrix< Real_wp, General, RowSparse > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleRightMatrix (DistributedMatrix< Real_wp, General, RowSparse > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleMatrix (DistributedMatrix< Real_wp, General, RowSparse > &, const Vector< Real_wp > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | AssembleDistributed (DistributedMatrix< Real_wp, General, RowSparse > &, Symmetric &, const MPI_Comm &, IVect &, IVect &, Vector< long > &, Vector< int > &, Vector< Real_wp > &, bool, bool) |
SELDON_EXTERN template void | AssembleDistributed (DistributedMatrix< Real_wp, General, RowSparse > &, General &, const MPI_Comm &, IVect &, IVect &, Vector< long > &, Vector< int > &, Vector< Real_wp > &, bool, bool) |
SELDON_EXTERN template void | AssembleDistributed (DistributedMatrix< Real_wp, General, RowSparse > &, Symmetric &, const MPI_Comm &, IVect &, IVect &, Vector< int64_t > &, Vector< int64_t > &, Vector< Real_wp > &, bool, bool) |
SELDON_EXTERN template void | AssembleDistributed (DistributedMatrix< Real_wp, General, RowSparse > &, General &, const MPI_Comm &, IVect &, IVect &, Vector< int64_t > &, Vector< int64_t > &, Vector< Real_wp > &, bool, bool) |
SELDON_EXTERN template void | EraseCol (const IVect &, DistributedMatrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template void | EraseRow (const IVect &, DistributedMatrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template void | CopySubMatrix (const DistributedMatrix< Real_wp, General, RowSparse > &, const IVect &, const IVect &, DistributedMatrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template void | DistributeCentralizedMatrix (Matrix< Real_wp, General, RowSparse > &, const MPI_Comm &comm, int, const Vector< int > &, DistributedMatrixIntegerArray &, DistributedMatrix< Real_wp, General, RowSparse > &, bool) |
SELDON_EXTERN template void | DistributeCentralizedMatrix (Matrix< Complex_wp, General, RowSparse > &, const MPI_Comm &comm, int, const Vector< int > &, DistributedMatrixIntegerArray &, DistributedMatrix< Complex_wp, General, RowSparse > &, bool) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &, const Vector< Real_wp > &, const Real_wp &, Vector< Real_wp > &, bool) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const SeldonTranspose &, const DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &, const Vector< Real_wp > &, const Real_wp &, Vector< Real_wp > &, bool) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const SeldonTranspose &, const DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | MltVector (const DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &, const Vector< Real_wp > &, Vector< Real_wp > &, bool) |
SELDON_EXTERN template void | MltVector (const DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | MltVector (const Real_wp &, const DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &, const Vector< Real_wp > &, Vector< Real_wp > &, bool) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &, const Vector< Real_wp > &, Vector< Real_wp > &, bool) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | MltScalar (const Real_wp &, DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | MltMin (const DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &, IVect &, IVect &) |
SELDON_EXTERN template void | MltMin (const DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, IVect &, IVect &) |
SELDON_EXTERN template void | MltMin (const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, const IVect &, IVect &, IVect &) |
SELDON_EXTERN template void | MltMin (const Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, const IVect &, IVect &, IVect &) |
SELDON_EXTERN template void | AddMatrix (const Real_wp &, const DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &, DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template Real_wp | MaxAbs (const DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | GetRowSum (Vector< Real_wp > &, const DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | GetColSum (Vector< Real_wp > &, const DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | GetRowColSum (Vector< Real_wp > &, Vector< Real_wp > &, const DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template Real_wp | Norm1 (const DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template Real_wp | NormInf (const DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | Transpose (DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | Conjugate (DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | Transpose (const DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &, DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | TransposeConj (const DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &, DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | TransposeConj (DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | GetRow (const DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &, int, Vector< Real_wp, VectSparse > &) |
SELDON_EXTERN template void | GetCol (const DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &, int, Vector< Real_wp, VectSparse > &) |
SELDON_EXTERN template void | SetRow (const Vector< Real_wp, VectSparse > &, int, DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | SetCol (const Vector< Real_wp, VectSparse > &, int, DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | ApplyPermutation (DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &, const Vector< int > &, const Vector< int > &) |
SELDON_EXTERN template void | ApplyInversePermutation (DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &, const Vector< int > &, const Vector< int > &) |
SELDON_EXTERN template void | SorVector (const DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &, Vector< Real_wp > &, const Vector< Real_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &, Vector< Real_wp > &, const Vector< Real_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | Copy (const DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &, DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | Copy (const DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &, DistributedMatrix< Real_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | Copy (const DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &, DistributedMatrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template Real_wp | NormFro (const DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | ScaleMatrix (DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &, const Vector< Real_wp > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | AssembleDistributed (DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &, Symmetric &, const MPI_Comm &, IVect &, IVect &, Vector< long > &, Vector< int > &, Vector< Real_wp > &, bool, bool) |
SELDON_EXTERN template void | AssembleDistributed (DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &, General &, const MPI_Comm &, IVect &, IVect &, Vector< long > &, Vector< int > &, Vector< Real_wp > &, bool, bool) |
SELDON_EXTERN template void | AssembleDistributed (DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &, Symmetric &, const MPI_Comm &, IVect &, IVect &, Vector< int64_t > &, Vector< int64_t > &, Vector< Real_wp > &, bool, bool) |
SELDON_EXTERN template void | AssembleDistributed (DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &, General &, const MPI_Comm &, IVect &, IVect &, Vector< int64_t > &, Vector< int64_t > &, Vector< Real_wp > &, bool, bool) |
SELDON_EXTERN template void | EraseCol (const IVect &, DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | EraseRow (const IVect &, DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | CopySubMatrix (const DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &, const IVect &, const IVect &, DistributedMatrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template void | CopySubMatrix (const DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &, const IVect &, const IVect &, DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | DistributeCentralizedMatrix (Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, const MPI_Comm &comm, int, const Vector< int > &, DistributedMatrixIntegerArray &, DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &, bool) |
SELDON_EXTERN template void | DistributeCentralizedMatrix (Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, const MPI_Comm &comm, int, const Vector< int > &, DistributedMatrixIntegerArray &, DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, bool) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const DistributedMatrix< Real_wp, Symmetric, RowSymSparse > &, const Vector< Real_wp > &, const Real_wp &, Vector< Real_wp > &, bool) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const DistributedMatrix< Real_wp, Symmetric, RowSymSparse > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const SeldonTranspose &, const DistributedMatrix< Real_wp, Symmetric, RowSymSparse > &, const Vector< Real_wp > &, const Real_wp &, Vector< Real_wp > &, bool) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const SeldonTranspose &, const DistributedMatrix< Real_wp, Symmetric, RowSymSparse > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | MltVector (const DistributedMatrix< Real_wp, Symmetric, RowSymSparse > &, const Vector< Real_wp > &, Vector< Real_wp > &, bool) |
SELDON_EXTERN template void | MltVector (const DistributedMatrix< Real_wp, Symmetric, RowSymSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | MltVector (const Real_wp &, const DistributedMatrix< Real_wp, Symmetric, RowSymSparse > &, const Vector< Real_wp > &, Vector< Real_wp > &, bool) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const DistributedMatrix< Real_wp, Symmetric, RowSymSparse > &, const Vector< Real_wp > &, Vector< Real_wp > &, bool) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const DistributedMatrix< Real_wp, Symmetric, RowSymSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | MltScalar (const Real_wp &, DistributedMatrix< Real_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | AddMatrix (const Real_wp &, const DistributedMatrix< Real_wp, Symmetric, RowSymSparse > &, DistributedMatrix< Real_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template Real_wp | MaxAbs (const DistributedMatrix< Real_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | GetRowSum (Vector< Real_wp > &, const DistributedMatrix< Real_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | GetColSum (Vector< Real_wp > &, const DistributedMatrix< Real_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | GetRowColSum (Vector< Real_wp > &, Vector< Real_wp > &, const DistributedMatrix< Real_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template Real_wp | Norm1 (const DistributedMatrix< Real_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template Real_wp | NormInf (const DistributedMatrix< Real_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | Transpose (DistributedMatrix< Real_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | Conjugate (DistributedMatrix< Real_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | Transpose (const DistributedMatrix< Real_wp, Symmetric, RowSymSparse > &, DistributedMatrix< Real_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | TransposeConj (const DistributedMatrix< Real_wp, Symmetric, RowSymSparse > &, DistributedMatrix< Real_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | TransposeConj (DistributedMatrix< Real_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | GetRow (const DistributedMatrix< Real_wp, Symmetric, RowSymSparse > &, int, Vector< Real_wp, VectSparse > &) |
SELDON_EXTERN template void | GetCol (const DistributedMatrix< Real_wp, Symmetric, RowSymSparse > &, int, Vector< Real_wp, VectSparse > &) |
SELDON_EXTERN template void | SetRow (const Vector< Real_wp, VectSparse > &, int, DistributedMatrix< Real_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | SetCol (const Vector< Real_wp, VectSparse > &, int, DistributedMatrix< Real_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | ApplyPermutation (DistributedMatrix< Real_wp, Symmetric, RowSymSparse > &, const Vector< int > &, const Vector< int > &) |
SELDON_EXTERN template void | ApplyInversePermutation (DistributedMatrix< Real_wp, Symmetric, RowSymSparse > &, const Vector< int > &, const Vector< int > &) |
SELDON_EXTERN template void | SorVector (const DistributedMatrix< Real_wp, Symmetric, RowSymSparse > &, Vector< Real_wp > &, const Vector< Real_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const DistributedMatrix< Real_wp, Symmetric, RowSymSparse > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const DistributedMatrix< Real_wp, Symmetric, RowSymSparse > &, Vector< Real_wp > &, const Vector< Real_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const DistributedMatrix< Real_wp, Symmetric, RowSymSparse > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | Copy (const DistributedMatrix< Real_wp, Symmetric, RowSymSparse > &, DistributedMatrix< Real_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | Copy (const DistributedMatrix< Real_wp, Symmetric, RowSymSparse > &, DistributedMatrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template Real_wp | NormFro (const DistributedMatrix< Real_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | ScaleMatrix (DistributedMatrix< Real_wp, Symmetric, RowSymSparse > &, const Vector< Real_wp > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | AssembleDistributed (DistributedMatrix< Real_wp, Symmetric, RowSymSparse > &, Symmetric &, const MPI_Comm &, IVect &, IVect &, Vector< long > &, Vector< int > &, Vector< Real_wp > &, bool, bool) |
SELDON_EXTERN template void | AssembleDistributed (DistributedMatrix< Real_wp, Symmetric, RowSymSparse > &, General &, const MPI_Comm &, IVect &, IVect &, Vector< long > &, Vector< int > &, Vector< Real_wp > &, bool, bool) |
SELDON_EXTERN template void | AssembleDistributed (DistributedMatrix< Real_wp, Symmetric, RowSymSparse > &, Symmetric &, const MPI_Comm &, IVect &, IVect &, Vector< int64_t > &, Vector< int64_t > &, Vector< Real_wp > &, bool, bool) |
SELDON_EXTERN template void | AssembleDistributed (DistributedMatrix< Real_wp, Symmetric, RowSymSparse > &, General &, const MPI_Comm &, IVect &, IVect &, Vector< int64_t > &, Vector< int64_t > &, Vector< Real_wp > &, bool, bool) |
SELDON_EXTERN template void | EraseCol (const IVect &, DistributedMatrix< Real_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | EraseRow (const IVect &, DistributedMatrix< Real_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | CopySubMatrix (const DistributedMatrix< Real_wp, Symmetric, RowSymSparse > &, const IVect &, const IVect &, DistributedMatrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template void | CopySubMatrix (const DistributedMatrix< Real_wp, Symmetric, RowSymSparse > &, const IVect &, const IVect &, DistributedMatrix< Real_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | DistributeCentralizedMatrix (Matrix< Real_wp, Symmetric, RowSymSparse > &, const MPI_Comm &comm, int, const Vector< int > &, DistributedMatrixIntegerArray &, DistributedMatrix< Real_wp, Symmetric, RowSymSparse > &, bool) |
SELDON_EXTERN template void | DistributeCentralizedMatrix (Matrix< Complex_wp, Symmetric, RowSymSparse > &, const MPI_Comm &comm, int, const Vector< int > &, DistributedMatrixIntegerArray &, DistributedMatrix< Complex_wp, Symmetric, RowSymSparse > &, bool) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const DistributedMatrix< Complex_wp, General, ArrayRowSparse > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const SeldonTranspose &, const DistributedMatrix< Complex_wp, General, ArrayRowSparse > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | MltVector (const DistributedMatrix< Complex_wp, General, ArrayRowSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | MltVector (const Complex_wp &, const DistributedMatrix< Complex_wp, General, ArrayRowSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const DistributedMatrix< Complex_wp, General, ArrayRowSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | MltScalar (const Complex_wp &, DistributedMatrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | MltScalar (const Real_wp &, DistributedMatrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | AddMatrix (const Real_wp &, const DistributedMatrix< Complex_wp, General, ArrayRowSparse > &, DistributedMatrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | AddMatrix (const Complex_wp &, const DistributedMatrix< Complex_wp, General, ArrayRowSparse > &, DistributedMatrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | AddMatrix (const Complex_wp &, const DistributedMatrix< Real_wp, General, ArrayRowSparse > &, DistributedMatrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template Real_wp | MaxAbs (const DistributedMatrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | GetRowSum (Vector< Real_wp > &, const DistributedMatrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | GetColSum (Vector< Real_wp > &, const DistributedMatrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | GetRowColSum (Vector< Real_wp > &, Vector< Real_wp > &, const DistributedMatrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template Real_wp | Norm1 (const DistributedMatrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template Real_wp | NormInf (const DistributedMatrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | Transpose (DistributedMatrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | Conjugate (DistributedMatrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | Transpose (const DistributedMatrix< Complex_wp, General, ArrayRowSparse > &, DistributedMatrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | TransposeConj (const DistributedMatrix< Complex_wp, General, ArrayRowSparse > &, DistributedMatrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | TransposeConj (DistributedMatrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | GetRow (const DistributedMatrix< Complex_wp, General, ArrayRowSparse > &, int, Vector< Complex_wp, VectSparse > &) |
SELDON_EXTERN template void | GetCol (const DistributedMatrix< Complex_wp, General, ArrayRowSparse > &, int, Vector< Complex_wp, VectSparse > &) |
SELDON_EXTERN template void | SetRow (const Vector< Complex_wp, VectSparse > &, int, DistributedMatrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | SetCol (const Vector< Complex_wp, VectSparse > &, int, DistributedMatrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | ApplyPermutation (DistributedMatrix< Complex_wp, General, ArrayRowSparse > &, const Vector< int > &, const Vector< int > &) |
SELDON_EXTERN template void | ApplyInversePermutation (DistributedMatrix< Complex_wp, General, ArrayRowSparse > &, const Vector< int > &, const Vector< int > &) |
SELDON_EXTERN template void | SorVector (const DistributedMatrix< Complex_wp, General, ArrayRowSparse > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const DistributedMatrix< Complex_wp, General, ArrayRowSparse > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | Copy (const DistributedMatrix< Real_wp, General, ArrayRowSparse > &, DistributedMatrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | Copy (const DistributedMatrix< Real_wp, General, ArrayRowSparse > &, DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | Copy (const DistributedMatrix< Complex_wp, General, ArrayRowSparse > &, DistributedMatrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | Copy (const DistributedMatrix< Complex_wp, General, ArrayRowSparse > &, DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | Copy (const DistributedMatrix< Complex_wp, General, ArrayRowSparse > &, DistributedMatrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template Real_wp | NormFro (const DistributedMatrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | ScaleLeftMatrix (DistributedMatrix< Complex_wp, General, ArrayRowSparse > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleLeftMatrix (DistributedMatrix< Complex_wp, General, ArrayRowSparse > &, const Vector< Complex_wp > &) |
SELDON_EXTERN template void | ScaleRightMatrix (DistributedMatrix< Complex_wp, General, ArrayRowSparse > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleMatrix (DistributedMatrix< Complex_wp, General, ArrayRowSparse > &, const Vector< Real_wp > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | AssembleDistributed (DistributedMatrix< Complex_wp, General, ArrayRowSparse > &, Symmetric &, const MPI_Comm &, IVect &, IVect &, Vector< long > &, Vector< int > &, Vector< Complex_wp > &, bool, bool) |
SELDON_EXTERN template void | AssembleDistributed (DistributedMatrix< Complex_wp, General, ArrayRowSparse > &, General &, const MPI_Comm &, IVect &, IVect &, Vector< long > &, Vector< int > &, Vector< Complex_wp > &, bool, bool) |
SELDON_EXTERN template void | AssembleDistributed (DistributedMatrix< Complex_wp, General, ArrayRowSparse > &, Symmetric &, const MPI_Comm &, IVect &, IVect &, Vector< int64_t > &, Vector< int64_t > &, Vector< Complex_wp > &, bool, bool) |
SELDON_EXTERN template void | AssembleDistributed (DistributedMatrix< Complex_wp, General, ArrayRowSparse > &, General &, const MPI_Comm &, IVect &, IVect &, Vector< int64_t > &, Vector< int64_t > &, Vector< Complex_wp > &, bool, bool) |
SELDON_EXTERN template void | EraseCol (const IVect &, DistributedMatrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | EraseRow (const IVect &, DistributedMatrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | CopySubMatrix (const DistributedMatrix< Complex_wp, General, ArrayRowSparse > &, const IVect &, const IVect &, DistributedMatrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | CopySubMatrix (const DistributedMatrix< Complex_wp, General, ArrayRowSparse > &, const IVect &, const IVect &, DistributedMatrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const DistributedMatrix< Complex_wp, General, RowSparse > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const SeldonTranspose &, const DistributedMatrix< Complex_wp, General, RowSparse > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | MltVector (const DistributedMatrix< Complex_wp, General, RowSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | MltVector (const Complex_wp &, const DistributedMatrix< Complex_wp, General, RowSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const DistributedMatrix< Complex_wp, General, RowSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | MltScalar (const Complex_wp &, DistributedMatrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | AddMatrix (const Real_wp &, const DistributedMatrix< Complex_wp, General, RowSparse > &, DistributedMatrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | AddMatrix (const Complex_wp &, const DistributedMatrix< Complex_wp, General, RowSparse > &, DistributedMatrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template Real_wp | MaxAbs (const DistributedMatrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | GetRowSum (Vector< Real_wp > &, const DistributedMatrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | GetColSum (Vector< Real_wp > &, const DistributedMatrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | GetRowColSum (Vector< Real_wp > &, Vector< Real_wp > &, const DistributedMatrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template Real_wp | Norm1 (const DistributedMatrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template Real_wp | NormInf (const DistributedMatrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | Transpose (DistributedMatrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | Conjugate (DistributedMatrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | Transpose (const DistributedMatrix< Complex_wp, General, RowSparse > &, DistributedMatrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | TransposeConj (const DistributedMatrix< Complex_wp, General, RowSparse > &, DistributedMatrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | TransposeConj (DistributedMatrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | GetRow (const DistributedMatrix< Complex_wp, General, RowSparse > &, int, Vector< Complex_wp, VectSparse > &) |
SELDON_EXTERN template void | GetCol (const DistributedMatrix< Complex_wp, General, RowSparse > &, int, Vector< Complex_wp, VectSparse > &) |
SELDON_EXTERN template void | SetRow (const Vector< Complex_wp, VectSparse > &, int, DistributedMatrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | SetCol (const Vector< Complex_wp, VectSparse > &, int, DistributedMatrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | ApplyPermutation (DistributedMatrix< Complex_wp, General, RowSparse > &, const Vector< int > &, const Vector< int > &) |
SELDON_EXTERN template void | ApplyInversePermutation (DistributedMatrix< Complex_wp, General, RowSparse > &, const Vector< int > &, const Vector< int > &) |
SELDON_EXTERN template void | SorVector (const DistributedMatrix< Complex_wp, General, RowSparse > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const DistributedMatrix< Complex_wp, General, RowSparse > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | Copy (const DistributedMatrix< Complex_wp, General, RowSparse > &, DistributedMatrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template Real_wp | NormFro (const DistributedMatrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | ScaleLeftMatrix (DistributedMatrix< Complex_wp, General, RowSparse > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleRightMatrix (DistributedMatrix< Complex_wp, General, RowSparse > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleMatrix (DistributedMatrix< Complex_wp, General, RowSparse > &, const Vector< Real_wp > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | AssembleDistributed (DistributedMatrix< Complex_wp, General, RowSparse > &, Symmetric &, const MPI_Comm &, IVect &, IVect &, Vector< long > &, Vector< int > &, Vector< Complex_wp > &, bool, bool) |
SELDON_EXTERN template void | AssembleDistributed (DistributedMatrix< Complex_wp, General, RowSparse > &, General &, const MPI_Comm &, IVect &, IVect &, Vector< long > &, Vector< int > &, Vector< Complex_wp > &, bool, bool) |
SELDON_EXTERN template void | AssembleDistributed (DistributedMatrix< Complex_wp, General, RowSparse > &, Symmetric &, const MPI_Comm &, IVect &, IVect &, Vector< int64_t > &, Vector< int64_t > &, Vector< Complex_wp > &, bool, bool) |
SELDON_EXTERN template void | AssembleDistributed (DistributedMatrix< Complex_wp, General, RowSparse > &, General &, const MPI_Comm &, IVect &, IVect &, Vector< int64_t > &, Vector< int64_t > &, Vector< Complex_wp > &, bool, bool) |
SELDON_EXTERN template void | EraseCol (const IVect &, DistributedMatrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | EraseRow (const IVect &, DistributedMatrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | CopySubMatrix (const DistributedMatrix< Complex_wp, General, RowSparse > &, const IVect &, const IVect &, DistributedMatrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const SeldonTranspose &, const DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | MltVector (const DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | MltVector (const Complex_wp &, const DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | MltScalar (const Complex_wp &, DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | MltScalar (const Real_wp &, DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | AddMatrix (const Real_wp &, const DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | AddMatrix (const Complex_wp &, const DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | AddMatrix (const Complex_wp &, const DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &, DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | AddMatrix (const Complex_wp &, const DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &, DistributedMatrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | AddMatrix (const Complex_wp &, const DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, DistributedMatrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | AddMatrix (const Complex_wp &, const DistributedMatrix< Complex_wp, General, ArrayRowSparse > &, DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template Real_wp | MaxAbs (const DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | GetRowSum (Vector< Real_wp > &, const DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | GetColSum (Vector< Real_wp > &, const DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | GetRowColSum (Vector< Real_wp > &, Vector< Real_wp > &, const DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template Real_wp | Norm1 (const DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template Real_wp | NormInf (const DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | Transpose (DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | Conjugate (DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | Transpose (const DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | TransposeConj (const DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | TransposeConj (DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | GetRow (const DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, int, Vector< Complex_wp, VectSparse > &) |
SELDON_EXTERN template void | GetCol (const DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, int, Vector< Complex_wp, VectSparse > &) |
SELDON_EXTERN template void | SetRow (const Vector< Complex_wp, VectSparse > &, int, DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | SetCol (const Vector< Complex_wp, VectSparse > &, int, DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | ApplyPermutation (DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, const Vector< int > &, const Vector< int > &) |
SELDON_EXTERN template void | ApplyInversePermutation (DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, const Vector< int > &, const Vector< int > &) |
SELDON_EXTERN template void | SorVector (const DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | Copy (const DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &, DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | Copy (const DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &, DistributedMatrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | Copy (const DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | Copy (const DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, DistributedMatrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | Copy (const DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, DistributedMatrix< Complex_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | Copy (const DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, DistributedMatrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template Real_wp | NormFro (const DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | ScaleMatrix (DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, const Vector< Real_wp > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | AssembleDistributed (DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, Symmetric &, const MPI_Comm &, IVect &, IVect &, Vector< long > &, Vector< int > &, Vector< Complex_wp > &, bool, bool) |
SELDON_EXTERN template void | AssembleDistributed (DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, General &, const MPI_Comm &, IVect &, IVect &, Vector< long > &, Vector< int > &, Vector< Complex_wp > &, bool, bool) |
SELDON_EXTERN template void | AssembleDistributed (DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, Symmetric &, const MPI_Comm &, IVect &, IVect &, Vector< int64_t > &, Vector< int64_t > &, Vector< Complex_wp > &, bool, bool) |
SELDON_EXTERN template void | AssembleDistributed (DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, General &, const MPI_Comm &, IVect &, IVect &, Vector< int64_t > &, Vector< int64_t > &, Vector< Complex_wp > &, bool, bool) |
SELDON_EXTERN template void | EraseCol (const IVect &, DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | EraseRow (const IVect &, DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | CopySubMatrix (const DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, const IVect &, const IVect &, DistributedMatrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | CopySubMatrix (const DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, const IVect &, const IVect &, DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const DistributedMatrix< Complex_wp, Symmetric, RowSymSparse > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const SeldonTranspose &, const DistributedMatrix< Complex_wp, Symmetric, RowSymSparse > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | MltVector (const DistributedMatrix< Complex_wp, Symmetric, RowSymSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | MltVector (const Complex_wp &, const DistributedMatrix< Complex_wp, Symmetric, RowSymSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const DistributedMatrix< Complex_wp, Symmetric, RowSymSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | MltScalar (const Complex_wp &, DistributedMatrix< Complex_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | AddMatrix (const Complex_wp &, const DistributedMatrix< Complex_wp, Symmetric, RowSymSparse > &, DistributedMatrix< Complex_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template Real_wp | MaxAbs (const DistributedMatrix< Complex_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | GetRowSum (Vector< Real_wp > &, const DistributedMatrix< Complex_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | GetColSum (Vector< Real_wp > &, const DistributedMatrix< Complex_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | GetRowColSum (Vector< Real_wp > &, Vector< Real_wp > &, const DistributedMatrix< Complex_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template Real_wp | Norm1 (const DistributedMatrix< Complex_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template Real_wp | NormInf (const DistributedMatrix< Complex_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | Transpose (DistributedMatrix< Complex_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | Conjugate (DistributedMatrix< Complex_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | Transpose (const DistributedMatrix< Complex_wp, Symmetric, RowSymSparse > &, DistributedMatrix< Complex_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | TransposeConj (const DistributedMatrix< Complex_wp, Symmetric, RowSymSparse > &, DistributedMatrix< Complex_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | TransposeConj (DistributedMatrix< Complex_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | GetRow (const DistributedMatrix< Complex_wp, Symmetric, RowSymSparse > &, int, Vector< Complex_wp, VectSparse > &) |
SELDON_EXTERN template void | GetCol (const DistributedMatrix< Complex_wp, Symmetric, RowSymSparse > &, int, Vector< Complex_wp, VectSparse > &) |
SELDON_EXTERN template void | SetRow (const Vector< Complex_wp, VectSparse > &, int, DistributedMatrix< Complex_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | SetCol (const Vector< Complex_wp, VectSparse > &, int, DistributedMatrix< Complex_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | ApplyPermutation (DistributedMatrix< Complex_wp, Symmetric, RowSymSparse > &, const Vector< int > &, const Vector< int > &) |
SELDON_EXTERN template void | ApplyInversePermutation (DistributedMatrix< Complex_wp, Symmetric, RowSymSparse > &, const Vector< int > &, const Vector< int > &) |
SELDON_EXTERN template void | SorVector (const DistributedMatrix< Complex_wp, Symmetric, RowSymSparse > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const DistributedMatrix< Complex_wp, Symmetric, RowSymSparse > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | Copy (const DistributedMatrix< Complex_wp, Symmetric, RowSymSparse > &, DistributedMatrix< Complex_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template Real_wp | NormFro (const DistributedMatrix< Complex_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | ScaleMatrix (DistributedMatrix< Complex_wp, Symmetric, RowSymSparse > &, const Vector< Real_wp > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | AssembleDistributed (DistributedMatrix< Complex_wp, Symmetric, RowSymSparse > &, Symmetric &, const MPI_Comm &, IVect &, IVect &, Vector< long > &, Vector< int > &, Vector< Complex_wp > &, bool, bool) |
SELDON_EXTERN template void | AssembleDistributed (DistributedMatrix< Complex_wp, Symmetric, RowSymSparse > &, General &, const MPI_Comm &, IVect &, IVect &, Vector< long > &, Vector< int > &, Vector< Complex_wp > &, bool, bool) |
SELDON_EXTERN template void | AssembleDistributed (DistributedMatrix< Complex_wp, Symmetric, RowSymSparse > &, Symmetric &, const MPI_Comm &, IVect &, IVect &, Vector< int64_t > &, Vector< int64_t > &, Vector< Complex_wp > &, bool, bool) |
SELDON_EXTERN template void | AssembleDistributed (DistributedMatrix< Complex_wp, Symmetric, RowSymSparse > &, General &, const MPI_Comm &, IVect &, IVect &, Vector< int64_t > &, Vector< int64_t > &, Vector< Complex_wp > &, bool, bool) |
SELDON_EXTERN template void | EraseCol (const IVect &, DistributedMatrix< Complex_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | EraseRow (const IVect &, DistributedMatrix< Complex_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | CopySubMatrix (const DistributedMatrix< Complex_wp, Symmetric, RowSymSparse > &, const IVect &, const IVect &, DistributedMatrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const DistributedMatrix< Complex_wp, General, ArrayRowComplexSparse > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const SeldonTranspose &, const DistributedMatrix< Complex_wp, General, ArrayRowComplexSparse > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | MltVector (const DistributedMatrix< Complex_wp, General, ArrayRowComplexSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | MltVector (const Complex_wp &, const DistributedMatrix< Complex_wp, General, ArrayRowComplexSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const DistributedMatrix< Complex_wp, General, ArrayRowComplexSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | MltScalar (const Complex_wp &, DistributedMatrix< Complex_wp, General, ArrayRowComplexSparse > &) |
SELDON_EXTERN template void | MltMin (const Matrix< Complex_wp, General, ArrayRowComplexSparse > &, const IVect &, IVect &, IVect &) |
SELDON_EXTERN template void | MltMin (const DistributedMatrix< Complex_wp, General, ArrayRowComplexSparse > &, IVect &, IVect &) |
SELDON_EXTERN template Real_wp | MaxAbs (const DistributedMatrix< Complex_wp, General, ArrayRowComplexSparse > &) |
SELDON_EXTERN template void | GetRowSum (Vector< Real_wp > &, const DistributedMatrix< Complex_wp, General, ArrayRowComplexSparse > &) |
SELDON_EXTERN template void | GetColSum (Vector< Real_wp > &, const DistributedMatrix< Complex_wp, General, ArrayRowComplexSparse > &) |
SELDON_EXTERN template void | GetRowColSum (Vector< Real_wp > &, Vector< Real_wp > &, const DistributedMatrix< Complex_wp, General, ArrayRowComplexSparse > &) |
SELDON_EXTERN template Real_wp | Norm1 (const DistributedMatrix< Complex_wp, General, ArrayRowComplexSparse > &) |
SELDON_EXTERN template Real_wp | NormInf (const DistributedMatrix< Complex_wp, General, ArrayRowComplexSparse > &) |
SELDON_EXTERN template void | Transpose (DistributedMatrix< Complex_wp, General, ArrayRowComplexSparse > &) |
SELDON_EXTERN template void | Conjugate (DistributedMatrix< Complex_wp, General, ArrayRowComplexSparse > &) |
SELDON_EXTERN template void | Transpose (const DistributedMatrix< Complex_wp, General, ArrayRowComplexSparse > &, DistributedMatrix< Complex_wp, General, ArrayRowComplexSparse > &) |
SELDON_EXTERN template void | TransposeConj (const DistributedMatrix< Complex_wp, General, ArrayRowComplexSparse > &, DistributedMatrix< Complex_wp, General, ArrayRowComplexSparse > &) |
SELDON_EXTERN template void | TransposeConj (DistributedMatrix< Complex_wp, General, ArrayRowComplexSparse > &) |
SELDON_EXTERN template void | Copy (const DistributedMatrix< Complex_wp, General, ArrayRowComplexSparse > &, DistributedMatrix< Complex_wp, General, ArrayRowComplexSparse > &) |
SELDON_EXTERN template void | Copy (const DistributedMatrix< Complex_wp, General, ArrayRowComplexSparse > &, DistributedMatrix< Complex_wp, General, RowComplexSparse > &) |
SELDON_EXTERN template void | ScaleLeftMatrix (DistributedMatrix< Complex_wp, General, ArrayRowComplexSparse > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleRightMatrix (DistributedMatrix< Complex_wp, General, ArrayRowComplexSparse > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleMatrix (DistributedMatrix< Complex_wp, General, ArrayRowComplexSparse > &, const Vector< Real_wp > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | EraseCol (const IVect &, DistributedMatrix< Complex_wp, General, ArrayRowComplexSparse > &) |
SELDON_EXTERN template void | EraseRow (const IVect &, DistributedMatrix< Complex_wp, General, ArrayRowComplexSparse > &) |
SELDON_EXTERN template void | CopySubMatrix (const DistributedMatrix< Complex_wp, General, ArrayRowComplexSparse > &, const IVect &, const IVect &, DistributedMatrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const SeldonTranspose &, const DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | MltVector (const DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | MltVector (const Complex_wp &, const DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | MltScalar (const Complex_wp &, DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &) |
SELDON_EXTERN template void | MltMin (const Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &, const IVect &, IVect &, IVect &) |
SELDON_EXTERN template void | MltMin (const DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &, IVect &, IVect &) |
SELDON_EXTERN template Real_wp | MaxAbs (const DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &) |
SELDON_EXTERN template void | GetRowSum (Vector< Real_wp > &, const DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &) |
SELDON_EXTERN template void | GetColSum (Vector< Real_wp > &, const DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &) |
SELDON_EXTERN template void | GetRowColSum (Vector< Real_wp > &, Vector< Real_wp > &, const DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &) |
SELDON_EXTERN template Real_wp | Norm1 (const DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &) |
SELDON_EXTERN template Real_wp | NormInf (const DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &) |
SELDON_EXTERN template void | Transpose (DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &) |
SELDON_EXTERN template void | Conjugate (DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &) |
SELDON_EXTERN template void | Transpose (const DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &, DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &) |
SELDON_EXTERN template void | TransposeConj (const DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &, DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &) |
SELDON_EXTERN template void | TransposeConj (DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &) |
SELDON_EXTERN template void | Copy (const DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &, DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &) |
SELDON_EXTERN template void | Copy (const DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &, DistributedMatrix< Complex_wp, Symmetric, RowSymComplexSparse > &) |
SELDON_EXTERN template void | Copy (const DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &, DistributedMatrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | ScaleMatrix (DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &, const Vector< Real_wp > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | EraseCol (const IVect &, DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &) |
SELDON_EXTERN template void | EraseRow (const IVect &, DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &) |
SELDON_EXTERN template void | CopySubMatrix (const DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &, const IVect &, const IVect &, DistributedMatrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const DistributedMatrix< Complex_wp, General, RowComplexSparse > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const SeldonTranspose &, const DistributedMatrix< Complex_wp, General, RowComplexSparse > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | MltVector (const DistributedMatrix< Complex_wp, General, RowComplexSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | MltVector (const Complex_wp &, const DistributedMatrix< Complex_wp, General, RowComplexSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const DistributedMatrix< Complex_wp, General, RowComplexSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | MltScalar (const Complex_wp &, DistributedMatrix< Complex_wp, General, RowComplexSparse > &) |
SELDON_EXTERN template Real_wp | MaxAbs (const DistributedMatrix< Complex_wp, General, RowComplexSparse > &) |
SELDON_EXTERN template void | GetRowSum (Vector< Real_wp > &, const DistributedMatrix< Complex_wp, General, RowComplexSparse > &) |
SELDON_EXTERN template void | GetColSum (Vector< Real_wp > &, const DistributedMatrix< Complex_wp, General, RowComplexSparse > &) |
SELDON_EXTERN template void | GetRowColSum (Vector< Real_wp > &, Vector< Real_wp > &, const DistributedMatrix< Complex_wp, General, RowComplexSparse > &) |
SELDON_EXTERN template Real_wp | Norm1 (const DistributedMatrix< Complex_wp, General, RowComplexSparse > &) |
SELDON_EXTERN template Real_wp | NormInf (const DistributedMatrix< Complex_wp, General, RowComplexSparse > &) |
SELDON_EXTERN template void | Transpose (DistributedMatrix< Complex_wp, General, RowComplexSparse > &) |
SELDON_EXTERN template void | Conjugate (DistributedMatrix< Complex_wp, General, RowComplexSparse > &) |
SELDON_EXTERN template void | Transpose (const DistributedMatrix< Complex_wp, General, RowComplexSparse > &, DistributedMatrix< Complex_wp, General, RowComplexSparse > &) |
SELDON_EXTERN template void | TransposeConj (const DistributedMatrix< Complex_wp, General, RowComplexSparse > &, DistributedMatrix< Complex_wp, General, RowComplexSparse > &) |
SELDON_EXTERN template void | TransposeConj (DistributedMatrix< Complex_wp, General, RowComplexSparse > &) |
SELDON_EXTERN template void | Copy (const DistributedMatrix< Complex_wp, General, RowComplexSparse > &, DistributedMatrix< Complex_wp, General, RowComplexSparse > &) |
SELDON_EXTERN template void | ScaleLeftMatrix (DistributedMatrix< Complex_wp, General, RowComplexSparse > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleRightMatrix (DistributedMatrix< Complex_wp, General, RowComplexSparse > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleMatrix (DistributedMatrix< Complex_wp, General, RowComplexSparse > &, const Vector< Real_wp > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | EraseCol (const IVect &, DistributedMatrix< Complex_wp, General, RowComplexSparse > &) |
SELDON_EXTERN template void | EraseRow (const IVect &, DistributedMatrix< Complex_wp, General, RowComplexSparse > &) |
SELDON_EXTERN template void | CopySubMatrix (const DistributedMatrix< Complex_wp, General, RowComplexSparse > &, const IVect &, const IVect &, DistributedMatrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const DistributedMatrix< Complex_wp, Symmetric, RowSymComplexSparse > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const SeldonTranspose &, const DistributedMatrix< Complex_wp, Symmetric, RowSymComplexSparse > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | MltVector (const DistributedMatrix< Complex_wp, Symmetric, RowSymComplexSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | MltVector (const Complex_wp &, const DistributedMatrix< Complex_wp, Symmetric, RowSymComplexSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const DistributedMatrix< Complex_wp, Symmetric, RowSymComplexSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | MltScalar (const Complex_wp &, DistributedMatrix< Complex_wp, Symmetric, RowSymComplexSparse > &) |
SELDON_EXTERN template Real_wp | MaxAbs (const DistributedMatrix< Complex_wp, Symmetric, RowSymComplexSparse > &) |
SELDON_EXTERN template void | GetRowSum (Vector< Real_wp > &, const DistributedMatrix< Complex_wp, Symmetric, RowSymComplexSparse > &) |
SELDON_EXTERN template void | GetColSum (Vector< Real_wp > &, const DistributedMatrix< Complex_wp, Symmetric, RowSymComplexSparse > &) |
SELDON_EXTERN template void | GetRowColSum (Vector< Real_wp > &, Vector< Real_wp > &, const DistributedMatrix< Complex_wp, Symmetric, RowSymComplexSparse > &) |
SELDON_EXTERN template Real_wp | Norm1 (const DistributedMatrix< Complex_wp, Symmetric, RowSymComplexSparse > &) |
SELDON_EXTERN template Real_wp | NormInf (const DistributedMatrix< Complex_wp, Symmetric, RowSymComplexSparse > &) |
SELDON_EXTERN template void | Transpose (DistributedMatrix< Complex_wp, Symmetric, RowSymComplexSparse > &) |
SELDON_EXTERN template void | Conjugate (DistributedMatrix< Complex_wp, Symmetric, RowSymComplexSparse > &) |
SELDON_EXTERN template void | Transpose (const DistributedMatrix< Complex_wp, Symmetric, RowSymComplexSparse > &, DistributedMatrix< Complex_wp, Symmetric, RowSymComplexSparse > &) |
SELDON_EXTERN template void | TransposeConj (const DistributedMatrix< Complex_wp, Symmetric, RowSymComplexSparse > &, DistributedMatrix< Complex_wp, Symmetric, RowSymComplexSparse > &) |
SELDON_EXTERN template void | TransposeConj (DistributedMatrix< Complex_wp, Symmetric, RowSymComplexSparse > &) |
SELDON_EXTERN template void | Copy (const DistributedMatrix< Complex_wp, Symmetric, RowSymComplexSparse > &, DistributedMatrix< Complex_wp, Symmetric, RowSymComplexSparse > &) |
SELDON_EXTERN template void | Copy (const DistributedMatrix< Real_wp, General, ArrayRowSparse > &, DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | ScaleMatrix (DistributedMatrix< Complex_wp, Symmetric, RowSymComplexSparse > &, const Vector< Real_wp > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | EraseCol (const IVect &, DistributedMatrix< Complex_wp, Symmetric, RowSymComplexSparse > &) |
SELDON_EXTERN template void | EraseRow (const IVect &, DistributedMatrix< Complex_wp, Symmetric, RowSymComplexSparse > &) |
SELDON_EXTERN template void | CopySubMatrix (const DistributedMatrix< Complex_wp, Symmetric, RowSymComplexSparse > &, const IVect &, const IVect &, DistributedMatrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template Real_wp | DotProdVector (const DistributedVector< Real_wp > &, const DistributedVector< Real_wp > &) |
SELDON_EXTERN template Complex_wp | DotProdVector (const DistributedVector< Complex_wp > &, const DistributedVector< Complex_wp > &) |
SELDON_EXTERN template Real_wp | DotProdConjVector (const DistributedVector< Real_wp > &, const DistributedVector< Real_wp > &) |
SELDON_EXTERN template Complex_wp | DotProdConjVector (const DistributedVector< Complex_wp > &, const DistributedVector< Complex_wp > &) |
SELDON_EXTERN template Real_wp | Norm2 (const DistributedVector< Real_wp > &) |
SELDON_EXTERN template Real_wp | Norm2 (const DistributedVector< Complex_wp > &) |
SELDON_EXTERN template void | AssembleVector (Vector< bool > &, const MPI_Op &, const IVect &, const Vector< IVect > &, const MPI_Comm &, int, int, int) |
SELDON_EXTERN template void | AssembleVector (Vector< int > &, const MPI_Op &, const IVect &, const Vector< IVect > &, const MPI_Comm &, int, int, int) |
SELDON_EXTERN template void | AssembleVector (Vector< Real_wp > &, const MPI_Op &, const IVect &, const Vector< IVect > &, const MPI_Comm &, int, int, int) |
SELDON_EXTERN template void | AssembleVector (Vector< Complex_wp > &, const MPI_Op &, const IVect &, const Vector< IVect > &, const MPI_Comm &, int, int, int) |
SELDON_EXTERN template void | ExchangeVector (Vector< Real_wp > &, const IVect &, const Vector< IVect > &, const MPI_Comm &, int, int, int) |
SELDON_EXTERN template void | ExchangeVector (Vector< Complex_wp > &, const IVect &, const Vector< IVect > &, const MPI_Comm &, int, int, int) |
SELDON_EXTERN template void | ExchangeRelaxVector (Vector< Real_wp > &, const Real_wp &, int, const IVect &, const Vector< IVect > &, const MPI_Comm &, int, int, int) |
SELDON_EXTERN template void | ExchangeRelaxVector (Vector< Complex_wp > &, const Real_wp &, int, const IVect &, const Vector< IVect > &, const MPI_Comm &, int, int, int) |
SELDON_EXTERN template MPI_Request | MpiIsend (const MPI_Comm &, bool *, Vector< int64_t > &, int, int, int) |
SELDON_EXTERN template MPI_Request | MpiIsend (const MPI_Comm &, int *, Vector< int64_t > &, int, int, int) |
SELDON_EXTERN template MPI_Request | MpiIsend (const MPI_Comm &, long *, Vector< int64_t > &, int, int, int) |
SELDON_EXTERN template MPI_Request | MpiIsend (const MPI_Comm &, double *, Vector< int64_t > &, int, int, int) |
SELDON_EXTERN template MPI_Request | MpiIsend (const MPI_Comm &, complex< double > *, Vector< int64_t > &, int, int, int) |
SELDON_EXTERN template MPI_Request | MpiIsend (const MPI_Comm &, Vector< bool > &, Vector< int64_t > &, int, int, int) |
SELDON_EXTERN template MPI_Request | MpiIsend (const MPI_Comm &, Vector< int > &, Vector< int64_t > &, int, int, int) |
SELDON_EXTERN template MPI_Request | MpiIsend (const MPI_Comm &, Vector< long > &, Vector< int64_t > &, int, int, int) |
SELDON_EXTERN template MPI_Request | MpiIsend (const MPI_Comm &, Vector< double > &, Vector< int64_t > &, int, int, int) |
SELDON_EXTERN template MPI_Request | MpiIsend (const MPI_Comm &, Vector< complex< double > > &, Vector< int64_t > &, int, int, int) |
SELDON_EXTERN template MPI_Request | MpiIrecv (const MPI_Comm &, bool *, Vector< int64_t > &, int, int, int) |
SELDON_EXTERN template MPI_Request | MpiIrecv (const MPI_Comm &, int *, Vector< int64_t > &, int, int, int) |
SELDON_EXTERN template MPI_Request | MpiIrecv (const MPI_Comm &, long *, Vector< int64_t > &, int, int, int) |
SELDON_EXTERN template MPI_Request | MpiIrecv (const MPI_Comm &, double *, Vector< int64_t > &, int, int, int) |
SELDON_EXTERN template MPI_Request | MpiIrecv (const MPI_Comm &, complex< double > *, Vector< int64_t > &, int, int, int) |
SELDON_EXTERN template MPI_Request | MpiIrecv (const MPI_Comm &, Vector< bool > &, Vector< int64_t > &, int, int, int) |
SELDON_EXTERN template MPI_Request | MpiIrecv (const MPI_Comm &, Vector< int > &, Vector< int64_t > &, int, int, int) |
SELDON_EXTERN template MPI_Request | MpiIrecv (const MPI_Comm &, Vector< long > &, Vector< int64_t > &, int, int, int) |
SELDON_EXTERN template MPI_Request | MpiIrecv (const MPI_Comm &, Vector< double > &, Vector< int64_t > &, int, int, int) |
SELDON_EXTERN template MPI_Request | MpiIrecv (const MPI_Comm &, Vector< complex< double > > &, Vector< int64_t > &, int, int, int) |
SELDON_EXTERN template void | MpiCompleteIrecv (bool *, Vector< int64_t > &, int) |
SELDON_EXTERN template void | MpiCompleteIrecv (int *, Vector< int64_t > &, int) |
SELDON_EXTERN template void | MpiCompleteIrecv (long *, Vector< int64_t > &, int) |
SELDON_EXTERN template void | MpiCompleteIrecv (double *, Vector< int64_t > &, int) |
SELDON_EXTERN template void | MpiCompleteIrecv (complex< double > *, Vector< int64_t > &, int) |
SELDON_EXTERN template void | MpiCompleteIrecv (Vector< bool > &, Vector< int64_t > &, int) |
SELDON_EXTERN template void | MpiCompleteIrecv (Vector< int > &, Vector< int64_t > &, int) |
SELDON_EXTERN template void | MpiCompleteIrecv (Vector< long > &, Vector< int64_t > &, int) |
SELDON_EXTERN template void | MpiCompleteIrecv (Vector< double > &, Vector< int64_t > &, int) |
SELDON_EXTERN template void | MpiCompleteIrecv (Vector< complex< double > > &, Vector< int64_t > &, int) |
SELDON_EXTERN template void | MpiSsend (const MPI_Comm &, int *, Vector< int64_t > &, int, int, int) |
SELDON_EXTERN template void | MpiSsend (const MPI_Comm &, long *, Vector< int64_t > &, int, int, int) |
SELDON_EXTERN template void | MpiSsend (const MPI_Comm &, double *, Vector< int64_t > &, int, int, int) |
SELDON_EXTERN template void | MpiSsend (const MPI_Comm &, complex< double > *, Vector< int64_t > &, int, int, int) |
SELDON_EXTERN template void | MpiSsend (const MPI_Comm &, Vector< int > &, Vector< int64_t > &, int, int, int) |
SELDON_EXTERN template void | MpiSsend (const MPI_Comm &, Vector< long > &, Vector< int64_t > &, int, int, int) |
SELDON_EXTERN template void | MpiSsend (const MPI_Comm &, Vector< double > &, Vector< int64_t > &, int, int, int) |
SELDON_EXTERN template void | MpiSsend (const MPI_Comm &, Vector< complex< double > > &, Vector< int64_t > &, int, int, int) |
SELDON_EXTERN template void | MpiSend (const MPI_Comm &, double *, Vector< int64_t > &, int, int, int) |
SELDON_EXTERN template void | MpiSend (const MPI_Comm &, complex< double > *, Vector< int64_t > &, int, int, int) |
SELDON_EXTERN template void | MpiSend (const MPI_Comm &, Vector< double > &, Vector< int64_t > &, int, int, int) |
SELDON_EXTERN template void | MpiSend (const MPI_Comm &, Vector< complex< double > > &, Vector< int64_t > &, int, int, int) |
SELDON_EXTERN template void | MpiGather (const MPI_Comm &, double *, Vector< int64_t > &, double *, int, int) |
SELDON_EXTERN template void | MpiGather (const MPI_Comm &, complex< double > *, Vector< int64_t > &, complex< double > *, int, int) |
SELDON_EXTERN template void | MpiGather (const MPI_Comm &, Vector< double > &, Vector< int64_t > &, Vector< double > &, int, int) |
SELDON_EXTERN template void | MpiGather (const MPI_Comm &, Vector< complex< double > > &, Vector< int64_t > &, Vector< complex< double > > &, int, int) |
SELDON_EXTERN template void | MpiAllreduce (const MPI_Comm &, double *, Vector< int64_t > &, double *, int, const MPI_Op &) |
SELDON_EXTERN template void | MpiAllreduce (const MPI_Comm &, complex< double > *, Vector< int64_t > &, complex< double > *, int, const MPI_Op &) |
SELDON_EXTERN template void | MpiAllreduce (const MPI_Comm &, Vector< double > &, Vector< int64_t > &, Vector< double > &, int, const MPI_Op &) |
SELDON_EXTERN template void | MpiAllreduce (const MPI_Comm &, Vector< complex< double > > &, Vector< int64_t > &, Vector< complex< double > > &, int, const MPI_Op &) |
SELDON_EXTERN template void | MpiReduce (const MPI_Comm &, double *, Vector< int64_t > &, double *, int, const MPI_Op &, int) |
SELDON_EXTERN template void | MpiReduce (const MPI_Comm &, complex< double > *, Vector< int64_t > &, complex< double > *, int, const MPI_Op &, int) |
SELDON_EXTERN template void | MpiReduce (const MPI_Comm &, Vector< double > &, Vector< int64_t > &, Vector< double > &, int, const MPI_Op &, int) |
SELDON_EXTERN template void | MpiReduce (const MPI_Comm &, Vector< complex< double > > &, Vector< int64_t > &, Vector< complex< double > > &, int, const MPI_Op &, int) |
SELDON_EXTERN template void | MpiRecv (const MPI_Comm &, int *, Vector< int64_t > &, int, int, int, MPI_Status &) |
SELDON_EXTERN template void | MpiRecv (const MPI_Comm &, long *, Vector< int64_t > &, int, int, int, MPI_Status &) |
SELDON_EXTERN template void | MpiRecv (const MPI_Comm &, double *, Vector< int64_t > &, int, int, int, MPI_Status &) |
SELDON_EXTERN template void | MpiRecv (const MPI_Comm &, complex< double > *, Vector< int64_t > &, int, int, int, MPI_Status &) |
SELDON_EXTERN template void | MpiRecv (const MPI_Comm &, Vector< int > &, Vector< int64_t > &, int, int, int, MPI_Status &) |
SELDON_EXTERN template void | MpiRecv (const MPI_Comm &, Vector< long > &, Vector< int64_t > &, int, int, int, MPI_Status &) |
SELDON_EXTERN template void | MpiRecv (const MPI_Comm &, Vector< double > &, Vector< int64_t > &, int, int, int, MPI_Status &) |
SELDON_EXTERN template void | MpiRecv (const MPI_Comm &, Vector< complex< double > > &, Vector< int64_t > &, int, int, int, MPI_Status &) |
SELDON_EXTERN template void | MpiBcast (const MPI_Comm &, double *, Vector< int64_t > &, int, int) |
SELDON_EXTERN template void | MpiBcast (const MPI_Comm &, complex< double > *, Vector< int64_t > &, int, int) |
SELDON_EXTERN template void | MpiBcast (const MPI_Comm &, Vector< bool > &, Vector< int64_t > &, int, int) |
SELDON_EXTERN template void | MpiBcast (const MPI_Comm &, Vector< double > &, Vector< int64_t > &, int, int) |
SELDON_EXTERN template void | MpiBcast (const MPI_Comm &, Vector< complex< double > > &, Vector< int64_t > &, int, int) |
SELDON_EXTERN template void | SortEigenvalues (Vector< Real_wp > &, Vector< Real_wp > &, Matrix< Real_wp, General, RowMajor > &, Matrix< Real_wp, General, RowMajor > &, int, int, const Real_wp &, const Real_wp &) |
SELDON_EXTERN template void | SortEigenvalues (Vector< Complex_wp > &, Vector< Complex_wp > &, Matrix< Complex_wp, General, RowMajor > &, Matrix< Complex_wp, General, RowMajor > &, int, int, const Complex_wp &, const Complex_wp &) |
SELDON_EXTERN template void | SortEigenvalues (Vector< Real_wp > &, Vector< Real_wp > &, Matrix< Real_wp, General, ColMajor > &, Matrix< Real_wp, General, ColMajor > &, int, int, const Real_wp &, const Real_wp &) |
SELDON_EXTERN template void | SortEigenvalues (Vector< Complex_wp > &, Vector< Complex_wp > &, Matrix< Complex_wp, General, ColMajor > &, Matrix< Complex_wp, General, ColMajor > &, int, int, const Complex_wp &, const Complex_wp &) |
SELDON_EXTERN template void | ApplyScalingEigenvec (EigenProblem_Base< Real_wp > &, Vector< Real_wp > &, Vector< Real_wp > &, Matrix< Real_wp, General, ColMajor > &, const Real_wp &, const Real_wp &) |
SELDON_EXTERN template void | ApplyScalingEigenvec (EigenProblem_Base< Complex_wp > &, Vector< Complex_wp > &, Vector< Complex_wp > &, Matrix< Complex_wp, General, ColMajor > &, const Complex_wp &, const Complex_wp &) |
SELDON_EXTERN template void | GetEigenvaluesEigenvectors (EigenProblem_Base< Real_wp > &var_eig, Vector< Real_wp > &lambda, Vector< Real_wp > &lambda_imag, Matrix< Real_wp, General, ColMajor > &eigen_vec, int type) |
SELDON_EXTERN template void | GetEigenvaluesEigenvectors (EigenProblem_Base< Real_wp > &var_eig, Vector< Real_wp > &lambda, Vector< Real_wp > &lambda_imag, Matrix< Real_wp, General, RowMajor > &eigen_vec, int type) |
SELDON_EXTERN template void | GetEigenvaluesEigenvectors (EigenProblem_Base< Complex_wp > &var_eig, Vector< Complex_wp > &lambda, Vector< Complex_wp > &lambda_imag, Matrix< Complex_wp, General, ColMajor > &eigen_vec, int type) |
SELDON_EXTERN template void | GetEigenvaluesEigenvectors (EigenProblem_Base< Complex_wp > &var_eig, Vector< Complex_wp > &lambda, Vector< Complex_wp > &lambda_imag, Matrix< Complex_wp, General, RowMajor > &eigen_vec, int type) |
SELDON_EXTERN template void | FindEigenvaluesFeast (EigenProblem_Base< Real_wp > &, Vector< Real_wp > &, Vector< Real_wp > &, Matrix< Real_wp, General, ColMajor > &) |
SELDON_EXTERN template void | FindEigenvaluesFeast (EigenProblem_Base< Complex_wp > &, Vector< Complex_wp > &, Vector< Complex_wp > &, Matrix< Complex_wp, General, ColMajor > &) |
SELDON_EXTERN template void | FindEigenvaluesFeast (PolynomialEigenProblem_Base< Complex_wp > &, Vector< Complex_wp > &, Vector< Complex_wp > &, Matrix< Complex_wp, General, ColMajor > &) |
SELDON_EXTERN template void | MltScalar (const Real_wp &, Matrix< Real_wp, General, ColMajor > &) |
SELDON_EXTERN template void | MltScalar (const Real_wp &, Matrix< Real_wp, General, RowMajor > &) |
SELDON_EXTERN template void | MltScalar (const Real_wp &, Matrix< Real_wp, Symmetric, RowSymPacked > &) |
SELDON_EXTERN template void | MltScalar (const Real_wp &, Matrix< Real_wp, Symmetric, RowSym > &) |
SELDON_EXTERN template void | MltScalar (const Real_wp &, Matrix< Complex_wp, General, ColMajor > &) |
SELDON_EXTERN template void | MltScalar (const Real_wp &, Matrix< Complex_wp, General, RowMajor > &) |
SELDON_EXTERN template void | MltScalar (const Complex_wp &, Matrix< Complex_wp, General, RowMajor > &) |
SELDON_EXTERN template void | MltScalar (const Complex_wp &, Matrix< Complex_wp, General, ColMajor > &) |
SELDON_EXTERN template void | MltScalar (const Complex_wp &, Matrix< Complex_wp, Symmetric, RowSymPacked > &) |
SELDON_EXTERN template void | MltScalar (const Real_wp &, Matrix< Complex_wp, Symmetric, RowSymPacked > &) |
SELDON_EXTERN template void | MltScalar (const Complex_wp &, Matrix< Complex_wp, Symmetric, RowSym > &) |
SELDON_EXTERN template void | MltScalar (const Real_wp &, Matrix< Complex_wp, Symmetric, RowSym > &) |
SELDON_EXTERN template void | MltScalar (const Real_wp &, Matrix< Complex_wp, Hermitian, RowHerm > &) |
SELDON_EXTERN template void | MltScalar (const Real_wp &, Matrix< Complex_wp, Hermitian, RowHermPacked > &) |
SELDON_EXTERN template void | MltScalar (const Real_wp &, Matrix< Real_wp, General, RowLoTriang > &) |
SELDON_EXTERN template void | MltScalar (const Real_wp &, Matrix< Complex_wp, General, RowLoTriang > &) |
SELDON_EXTERN template void | MltScalar (const Complex_wp &, Matrix< Complex_wp, General, RowLoTriang > &) |
SELDON_EXTERN template void | MltScalar (const Real_wp &, Matrix< Real_wp, General, RowUpTriang > &) |
SELDON_EXTERN template void | MltScalar (const Real_wp &, Matrix< Complex_wp, General, RowUpTriang > &) |
SELDON_EXTERN template void | MltScalar (const Complex_wp &, Matrix< Complex_wp, General, RowUpTriang > &) |
SELDON_EXTERN template void | MltScalar (const Real_wp &, Matrix< Real_wp, General, RowLoTriangPacked > &) |
SELDON_EXTERN template void | MltScalar (const Real_wp &, Matrix< Complex_wp, General, RowLoTriangPacked > &) |
SELDON_EXTERN template void | MltScalar (const Complex_wp &, Matrix< Complex_wp, General, RowLoTriangPacked > &) |
SELDON_EXTERN template void | MltScalar (const Real_wp &, Matrix< Real_wp, General, RowUpTriangPacked > &) |
SELDON_EXTERN template void | MltScalar (const Real_wp &, Matrix< Complex_wp, General, RowUpTriangPacked > &) |
SELDON_EXTERN template void | MltScalar (const Complex_wp &, Matrix< Complex_wp, General, RowUpTriangPacked > &) |
SELDON_EXTERN template void | AddMatrix (const Complex_wp &, Matrix< Real_wp, General, RowMajor > const &, Matrix< Complex_wp, General, RowMajor > &) |
SELDON_EXTERN template void | AddMatrix (const Real_wp &, const Matrix< Real_wp, General, RowMajor > &, Matrix< Real_wp, General, RowMajor > &) |
SELDON_EXTERN template void | AddMatrix (const Complex_wp &, const Matrix< Complex_wp, General, RowMajor > &, Matrix< Complex_wp, General, RowMajor > &) |
SELDON_EXTERN template void | AddMatrix (const Real_wp &, const Matrix< Real_wp, General, ColMajor > &, Matrix< Real_wp, General, ColMajor > &) |
SELDON_EXTERN template void | AddMatrix (const Complex_wp &, const Matrix< Complex_wp, General, ColMajor > &, Matrix< Complex_wp, General, ColMajor > &) |
SELDON_EXTERN template void | AddMatrix (const Real_wp &, const Matrix< Real_wp, Symmetric, RowSymPacked > &, Matrix< Real_wp, General, RowMajor > &) |
SELDON_EXTERN template void | AddMatrix (const Complex_wp &, const Matrix< Real_wp, Symmetric, RowSymPacked > &, Matrix< Complex_wp, General, RowMajor > &) |
SELDON_EXTERN template void | AddMatrix (const Complex_wp &, const Matrix< Complex_wp, Symmetric, RowSymPacked > &, Matrix< Complex_wp, General, RowMajor > &) |
SELDON_EXTERN template void | AddMatrix (const Real_wp &, const Matrix< Real_wp, Symmetric, RowSymPacked > &, Matrix< Real_wp, Symmetric, RowSymPacked > &) |
SELDON_EXTERN template void | AddMatrix (const Complex_wp &, const Matrix< Real_wp, Symmetric, RowSymPacked > &, Matrix< Complex_wp, Symmetric, RowSymPacked > &) |
SELDON_EXTERN template void | AddMatrix (const Complex_wp &, const Matrix< Complex_wp, Symmetric, RowSymPacked > &, Matrix< Complex_wp, Symmetric, RowSymPacked > &) |
SELDON_EXTERN template void | AddMatrix (const Real_wp &, const Matrix< Real_wp, Symmetric, RowSym > &, Matrix< Real_wp, Symmetric, RowSym > &) |
SELDON_EXTERN template void | AddMatrix (const Complex_wp &, const Matrix< Complex_wp, Symmetric, RowSym > &, Matrix< Complex_wp, Symmetric, RowSym > &) |
SELDON_EXTERN template void | AddMatrix (const Real_wp &, const Matrix< Complex_wp, Hermitian, RowHerm > &, Matrix< Complex_wp, Hermitian, RowHerm > &) |
SELDON_EXTERN template void | AddMatrix (const Real_wp &, const Matrix< Complex_wp, Hermitian, RowHermPacked > &, Matrix< Complex_wp, Hermitian, RowHermPacked > &) |
SELDON_EXTERN template void | AddMatrix (const Real_wp &, const Matrix< Real_wp, General, RowLoTriang > &, Matrix< Real_wp, General, RowLoTriang > &) |
SELDON_EXTERN template void | AddMatrix (const Real_wp &, const Matrix< Complex_wp, General, RowLoTriang > &, Matrix< Complex_wp, General, RowLoTriang > &) |
SELDON_EXTERN template void | AddMatrix (const Complex_wp &, const Matrix< Complex_wp, General, RowLoTriang > &, Matrix< Complex_wp, General, RowLoTriang > &) |
SELDON_EXTERN template void | AddMatrix (const Real_wp &, const Matrix< Real_wp, General, RowLoTriangPacked > &, Matrix< Real_wp, General, RowLoTriangPacked > &) |
SELDON_EXTERN template void | AddMatrix (const Real_wp &, const Matrix< Complex_wp, General, RowLoTriangPacked > &, Matrix< Complex_wp, General, RowLoTriangPacked > &) |
SELDON_EXTERN template void | AddMatrix (const Complex_wp &, const Matrix< Complex_wp, General, RowLoTriangPacked > &, Matrix< Complex_wp, General, RowLoTriangPacked > &) |
SELDON_EXTERN template void | AddMatrix (const Real_wp &, const Matrix< Real_wp, General, RowUpTriang > &, Matrix< Real_wp, General, RowUpTriang > &) |
SELDON_EXTERN template void | AddMatrix (const Real_wp &, const Matrix< Complex_wp, General, RowUpTriang > &, Matrix< Complex_wp, General, RowUpTriang > &) |
SELDON_EXTERN template void | AddMatrix (const Complex_wp &, const Matrix< Complex_wp, General, RowUpTriang > &, Matrix< Complex_wp, General, RowUpTriang > &) |
SELDON_EXTERN template void | AddMatrix (const Real_wp &, const Matrix< Real_wp, General, RowUpTriangPacked > &, Matrix< Real_wp, General, RowUpTriangPacked > &) |
SELDON_EXTERN template void | AddMatrix (const Real_wp &, const Matrix< Complex_wp, General, RowUpTriangPacked > &, Matrix< Complex_wp, General, RowUpTriangPacked > &) |
SELDON_EXTERN template void | AddMatrix (const Complex_wp &, const Matrix< Complex_wp, General, RowUpTriangPacked > &, Matrix< Complex_wp, General, RowUpTriangPacked > &) |
SELDON_EXTERN template Real_wp | MaxAbs (const Matrix< Real_wp, General, RowMajor > &) |
SELDON_EXTERN template Real_wp | MaxAbs (const Matrix< Complex_wp, General, RowMajor > &) |
SELDON_EXTERN template Real_wp | MaxAbs (const Matrix< Real_wp, General, ColMajor > &) |
SELDON_EXTERN template Real_wp | MaxAbs (const Matrix< Complex_wp, General, ColMajor > &) |
SELDON_EXTERN template Real_wp | MaxAbs (const Matrix< Real_wp, Symmetric, RowSymPacked > &) |
SELDON_EXTERN template Real_wp | MaxAbs (const Matrix< Complex_wp, Symmetric, RowSymPacked > &) |
SELDON_EXTERN template Real_wp | MaxAbs (const Matrix< Real_wp, Symmetric, RowSym > &) |
SELDON_EXTERN template Real_wp | MaxAbs (const Matrix< Complex_wp, Symmetric, RowSym > &) |
SELDON_EXTERN template Real_wp | MaxAbs (const Matrix< Complex_wp, Hermitian, RowHerm > &) |
SELDON_EXTERN template Real_wp | MaxAbs (const Matrix< Complex_wp, Hermitian, RowHermPacked > &) |
SELDON_EXTERN template Real_wp | MaxAbs (const Matrix< Real_wp, General, RowLoTriang > &) |
SELDON_EXTERN template Real_wp | MaxAbs (const Matrix< Complex_wp, General, RowLoTriang > &) |
SELDON_EXTERN template Real_wp | MaxAbs (const Matrix< Real_wp, General, RowLoTriangPacked > &) |
SELDON_EXTERN template Real_wp | MaxAbs (const Matrix< Complex_wp, General, RowLoTriangPacked > &) |
SELDON_EXTERN template Real_wp | MaxAbs (const Matrix< Real_wp, General, RowUpTriang > &) |
SELDON_EXTERN template Real_wp | MaxAbs (const Matrix< Complex_wp, General, RowUpTriang > &) |
SELDON_EXTERN template Real_wp | MaxAbs (const Matrix< Real_wp, General, RowUpTriangPacked > &) |
SELDON_EXTERN template Real_wp | MaxAbs (const Matrix< Complex_wp, General, RowUpTriangPacked > &) |
SELDON_EXTERN template Real_wp | Norm1 (const Matrix< Real_wp, General, RowMajor > &) |
SELDON_EXTERN template Real_wp | Norm1 (const Matrix< Complex_wp, General, RowMajor > &) |
SELDON_EXTERN template Real_wp | Norm1 (const Matrix< Real_wp, General, ColMajor > &) |
SELDON_EXTERN template Real_wp | Norm1 (const Matrix< Complex_wp, General, ColMajor > &) |
SELDON_EXTERN template Real_wp | Norm1 (const Matrix< Real_wp, Symmetric, RowSymPacked > &) |
SELDON_EXTERN template Real_wp | Norm1 (const Matrix< Complex_wp, Symmetric, RowSymPacked > &) |
SELDON_EXTERN template Real_wp | Norm1 (const Matrix< Real_wp, Symmetric, RowSym > &) |
SELDON_EXTERN template Real_wp | Norm1 (const Matrix< Complex_wp, Symmetric, RowSym > &) |
SELDON_EXTERN template Real_wp | Norm1 (const Matrix< Complex_wp, Hermitian, RowHerm > &) |
SELDON_EXTERN template Real_wp | Norm1 (const Matrix< Complex_wp, Hermitian, RowHermPacked > &) |
SELDON_EXTERN template Real_wp | Norm1 (const Matrix< Real_wp, General, RowLoTriang > &) |
SELDON_EXTERN template Real_wp | Norm1 (const Matrix< Complex_wp, General, RowLoTriang > &) |
SELDON_EXTERN template Real_wp | Norm1 (const Matrix< Real_wp, General, RowLoTriangPacked > &) |
SELDON_EXTERN template Real_wp | Norm1 (const Matrix< Complex_wp, General, RowLoTriangPacked > &) |
SELDON_EXTERN template Real_wp | Norm1 (const Matrix< Real_wp, General, RowUpTriang > &) |
SELDON_EXTERN template Real_wp | Norm1 (const Matrix< Complex_wp, General, RowUpTriang > &) |
SELDON_EXTERN template Real_wp | Norm1 (const Matrix< Real_wp, General, RowUpTriangPacked > &) |
SELDON_EXTERN template Real_wp | Norm1 (const Matrix< Complex_wp, General, RowUpTriangPacked > &) |
SELDON_EXTERN template Real_wp | NormInf (const Matrix< Real_wp, General, RowMajor > &) |
SELDON_EXTERN template Real_wp | NormInf (const Matrix< Complex_wp, General, RowMajor > &) |
SELDON_EXTERN template Real_wp | NormInf (const Matrix< Real_wp, General, ColMajor > &) |
SELDON_EXTERN template Real_wp | NormInf (const Matrix< Complex_wp, General, ColMajor > &) |
SELDON_EXTERN template Real_wp | NormInf (const Matrix< Real_wp, Symmetric, RowSymPacked > &) |
SELDON_EXTERN template Real_wp | NormInf (const Matrix< Complex_wp, Symmetric, RowSymPacked > &) |
SELDON_EXTERN template Real_wp | NormInf (const Matrix< Real_wp, Symmetric, RowSym > &) |
SELDON_EXTERN template Real_wp | NormInf (const Matrix< Complex_wp, Symmetric, RowSym > &) |
SELDON_EXTERN template Real_wp | NormInf (const Matrix< Complex_wp, Hermitian, RowHerm > &) |
SELDON_EXTERN template Real_wp | NormInf (const Matrix< Complex_wp, Hermitian, RowHermPacked > &) |
SELDON_EXTERN template Real_wp | NormInf (const Matrix< Real_wp, General, RowLoTriang > &) |
SELDON_EXTERN template Real_wp | NormInf (const Matrix< Complex_wp, General, RowLoTriang > &) |
SELDON_EXTERN template Real_wp | NormInf (const Matrix< Real_wp, General, RowLoTriangPacked > &) |
SELDON_EXTERN template Real_wp | NormInf (const Matrix< Complex_wp, General, RowLoTriangPacked > &) |
SELDON_EXTERN template Real_wp | NormInf (const Matrix< Real_wp, General, RowUpTriang > &) |
SELDON_EXTERN template Real_wp | NormInf (const Matrix< Complex_wp, General, RowUpTriang > &) |
SELDON_EXTERN template Real_wp | NormInf (const Matrix< Real_wp, General, RowUpTriangPacked > &) |
SELDON_EXTERN template Real_wp | NormInf (const Matrix< Complex_wp, General, RowUpTriangPacked > &) |
SELDON_EXTERN template void | Conjugate (Matrix< Real_wp, General, RowMajor > &) |
SELDON_EXTERN template void | Conjugate (Matrix< Real_wp, General, ColMajor > &) |
SELDON_EXTERN template void | Conjugate (Matrix< Real_wp, Symmetric, RowSym > &) |
SELDON_EXTERN template void | Conjugate (Matrix< Real_wp, Symmetric, RowSymPacked > &) |
SELDON_EXTERN template void | Conjugate (Matrix< Complex_wp, General, RowMajor > &) |
SELDON_EXTERN template void | Conjugate (Matrix< Complex_wp, General, ColMajor > &) |
SELDON_EXTERN template void | Conjugate (Matrix< Complex_wp, Symmetric, RowSym > &) |
SELDON_EXTERN template void | Conjugate (Matrix< Complex_wp, Symmetric, RowSymPacked > &) |
SELDON_EXTERN template void | Conjugate (Matrix< Complex_wp, Hermitian, RowHerm > &) |
SELDON_EXTERN template void | Conjugate (Matrix< Complex_wp, Hermitian, RowHermPacked > &) |
SELDON_EXTERN template void | Transpose (Matrix< Real_wp, General, RowMajor > &) |
SELDON_EXTERN template void | Transpose (Matrix< Complex_wp, General, RowMajor > &) |
SELDON_EXTERN template void | Transpose (const Matrix< Real_wp, General, RowMajor > &, Matrix< Real_wp, General, RowMajor > &) |
SELDON_EXTERN template void | Transpose (const Matrix< Complex_wp, General, RowMajor > &, Matrix< Complex_wp, General, RowMajor > &) |
SELDON_EXTERN template void | Transpose (Matrix< Real_wp, General, ColMajor > &) |
SELDON_EXTERN template void | Transpose (Matrix< Complex_wp, General, ColMajor > &) |
SELDON_EXTERN template void | Transpose (const Matrix< Real_wp, General, ColMajor > &, Matrix< Real_wp, General, ColMajor > &) |
SELDON_EXTERN template void | Transpose (const Matrix< Complex_wp, General, ColMajor > &, Matrix< Complex_wp, General, ColMajor > &) |
SELDON_EXTERN template void | Transpose (Matrix< Real_wp, Symmetric, RowSymPacked > &) |
SELDON_EXTERN template void | Transpose (Matrix< Complex_wp, Symmetric, RowSymPacked > &) |
SELDON_EXTERN template void | Transpose (const Matrix< Real_wp, Symmetric, RowSymPacked > &, Matrix< Real_wp, Symmetric, RowSymPacked > &) |
SELDON_EXTERN template void | Transpose (const Matrix< Complex_wp, Symmetric, RowSymPacked > &, Matrix< Complex_wp, Symmetric, RowSymPacked > &) |
SELDON_EXTERN template void | Transpose (Matrix< Real_wp, Symmetric, RowSym > &) |
SELDON_EXTERN template void | Transpose (Matrix< Complex_wp, Symmetric, RowSym > &) |
SELDON_EXTERN template void | Transpose (const Matrix< Real_wp, Symmetric, RowSym > &, Matrix< Real_wp, Symmetric, RowSym > &) |
SELDON_EXTERN template void | Transpose (const Matrix< Complex_wp, Symmetric, RowSym > &, Matrix< Complex_wp, Symmetric, RowSym > &) |
SELDON_EXTERN template void | Transpose (Matrix< Complex_wp, Hermitian, RowHerm > &) |
SELDON_EXTERN template void | Transpose (const Matrix< Complex_wp, Hermitian, RowHerm > &, Matrix< Complex_wp, Hermitian, RowHerm > &) |
SELDON_EXTERN template void | Transpose (Matrix< Complex_wp, Hermitian, RowHermPacked > &) |
SELDON_EXTERN template void | Transpose (const Matrix< Complex_wp, Hermitian, RowHermPacked > &, Matrix< Complex_wp, Hermitian, RowHermPacked > &) |
SELDON_EXTERN template void | TransposeConj (const Matrix< Real_wp, General, RowMajor > &, Matrix< Real_wp, General, RowMajor > &) |
SELDON_EXTERN template void | TransposeConj (Matrix< Real_wp, General, RowMajor > &) |
SELDON_EXTERN template void | TransposeConj (const Matrix< Complex_wp, General, RowMajor > &, Matrix< Complex_wp, General, RowMajor > &) |
SELDON_EXTERN template void | TransposeConj (Matrix< Complex_wp, General, RowMajor > &) |
SELDON_EXTERN template void | TransposeConj (const Matrix< Real_wp, General, ColMajor > &, Matrix< Real_wp, General, ColMajor > &) |
SELDON_EXTERN template void | TransposeConj (Matrix< Real_wp, General, ColMajor > &) |
SELDON_EXTERN template void | TransposeConj (const Matrix< Complex_wp, General, ColMajor > &, Matrix< Complex_wp, General, ColMajor > &) |
SELDON_EXTERN template void | TransposeConj (Matrix< Complex_wp, General, ColMajor > &) |
SELDON_EXTERN template void | TransposeConj (const Matrix< Real_wp, Symmetric, RowSymPacked > &, Matrix< Real_wp, Symmetric, RowSymPacked > &) |
SELDON_EXTERN template void | TransposeConj (Matrix< Real_wp, Symmetric, RowSymPacked > &) |
SELDON_EXTERN template void | TransposeConj (const Matrix< Complex_wp, Symmetric, RowSymPacked > &, Matrix< Complex_wp, Symmetric, RowSymPacked > &) |
SELDON_EXTERN template void | TransposeConj (Matrix< Complex_wp, Symmetric, RowSymPacked > &) |
SELDON_EXTERN template void | TransposeConj (const Matrix< Real_wp, Symmetric, RowSym > &, Matrix< Real_wp, Symmetric, RowSym > &) |
SELDON_EXTERN template void | TransposeConj (Matrix< Real_wp, Symmetric, RowSym > &) |
SELDON_EXTERN template void | TransposeConj (const Matrix< Complex_wp, Symmetric, RowSym > &, Matrix< Complex_wp, Symmetric, RowSym > &) |
SELDON_EXTERN template void | TransposeConj (Matrix< Complex_wp, Symmetric, RowSym > &) |
SELDON_EXTERN template void | TransposeConj (const Matrix< Complex_wp, Hermitian, RowHerm > &, Matrix< Complex_wp, Hermitian, RowHerm > &) |
SELDON_EXTERN template void | TransposeConj (Matrix< Complex_wp, Hermitian, RowHerm > &) |
SELDON_EXTERN template void | TransposeConj (const Matrix< Complex_wp, Hermitian, RowHermPacked > &, Matrix< Complex_wp, Hermitian, RowHermPacked > &) |
SELDON_EXTERN template void | TransposeConj (Matrix< Complex_wp, Hermitian, RowHermPacked > &) |
SELDON_EXTERN template void | GetLU (Matrix< Real_wp, General, RowMajor > &) |
SELDON_EXTERN template void | GetLU (Matrix< Complex_wp, General, RowMajor > &) |
SELDON_EXTERN template void | GetLU (Matrix< Real_wp, General, ColMajor > &) |
SELDON_EXTERN template void | GetLU (Matrix< Complex_wp, General, ColMajor > &) |
SELDON_EXTERN template void | MltAddMatrix (Real_wp const &, SeldonTranspose const &, Matrix< Real_wp, General, ColMajor > const &, SeldonTranspose const &, Matrix< Real_wp, General, ColMajor > const &, Real_wp const &, Matrix< Real_wp, Symmetric, RowSymPacked > &) |
SELDON_EXTERN template void | MltAddMatrix (Real_wp const &, SeldonTranspose const &, Matrix< Real_wp, General, RowMajor > const &, SeldonTranspose const &, Matrix< Real_wp, General, RowMajor > const &, Real_wp const &, Matrix< Real_wp, Symmetric, RowSym > &) |
SELDON_EXTERN template void | MltAddMatrix (Real_wp const &, SeldonTranspose const &, Matrix< Real_wp, General, RowMajor > const &, SeldonTranspose const &, Matrix< Real_wp, General, RowMajor > const &, Real_wp const &, Matrix< Real_wp, Symmetric, RowSymPacked > &) |
SELDON_EXTERN template void | MltAddMatrix (Complex_wp const &, SeldonTranspose const &, Matrix< Complex_wp, General, RowMajor > const &, SeldonTranspose const &, Matrix< Complex_wp, General, RowMajor > const &, Complex_wp const &, Matrix< Complex_wp, Symmetric, RowSymPacked > &) |
SELDON_EXTERN template void | MltAddMatrix (Complex_wp const &, SeldonTranspose const &, Matrix< Complex_wp, General, RowMajor > const &, SeldonTranspose const &, Matrix< Complex_wp, General, RowMajor > const &, Complex_wp const &, Matrix< Complex_wp, Symmetric, RowSym > &) |
SELDON_EXTERN template void | MltAddMatrix (Complex_wp const &, Matrix< Complex_wp, General, RowMajor > const &, Matrix< Complex_wp, General, RowMajor > const &, Complex_wp const &, Matrix< Complex_wp, Symmetric, RowSym > &) |
SELDON_EXTERN template void | MltAddMatrix (Real_wp const &, Matrix< Real_wp, Symmetric, RowSymPacked > const &, Matrix< Real_wp, General, RowMajor > const &, Real_wp const &, Matrix< Real_wp, General, RowMajor > &) |
SELDON_EXTERN template void | MltAddMatrix (Complex_wp const &, Matrix< Complex_wp, Symmetric, RowSymPacked > const &, Matrix< Complex_wp, General, RowMajor > const &, Complex_wp const &, Matrix< Complex_wp, General, RowMajor > &) |
SELDON_EXTERN template void | MltAddMatrix (Real_wp const &, Matrix< Real_wp, General, RowMajor > const &, Matrix< Real_wp, Symmetric, RowSymPacked > const &, Real_wp const &, Matrix< Real_wp, General, RowMajor > &) |
SELDON_EXTERN template void | MltAddMatrix (Complex_wp const &, Matrix< Complex_wp, General, RowMajor > const &, Matrix< Complex_wp, Symmetric, RowSymPacked > const &, Complex_wp const &, Matrix< Complex_wp, General, RowMajor > &) |
SELDON_EXTERN template void | MltAddMatrix (const Real_wp &, const Matrix< Real_wp, General, RowLoTriangPacked > &, const Matrix< Real_wp, General, RowLoTriangPacked > &, const Real_wp &, Matrix< Real_wp, General, RowMajor > &) |
SELDON_EXTERN template void | MltAddMatrix (const Real_wp &, const Matrix< Real_wp, General, RowLoTriang > &, const Matrix< Real_wp, General, RowLoTriang > &, const Real_wp &, Matrix< Real_wp, General, RowMajor > &) |
SELDON_EXTERN template void | MltAddMatrix (const Real_wp &, const Matrix< Real_wp, General, RowUpTriangPacked > &, const Matrix< Real_wp, General, RowUpTriangPacked > &, const Real_wp &, Matrix< Real_wp, General, RowMajor > &) |
SELDON_EXTERN template void | MltAddMatrix (const Real_wp &, const Matrix< Real_wp, General, RowUpTriang > &, const Matrix< Real_wp, General, RowUpTriang > &, const Real_wp &, Matrix< Real_wp, General, RowMajor > &) |
SELDON_EXTERN template void | MltAddMatrix (const Complex_wp &, const Matrix< Complex_wp, General, RowLoTriangPacked > &, const Matrix< Complex_wp, General, RowLoTriangPacked > &, const Complex_wp &, Matrix< Complex_wp, General, RowMajor > &) |
SELDON_EXTERN template void | MltAddMatrix (const Complex_wp &, const Matrix< Complex_wp, General, RowLoTriang > &, const Matrix< Complex_wp, General, RowLoTriang > &, const Complex_wp &, Matrix< Complex_wp, General, RowMajor > &) |
SELDON_EXTERN template void | MltAddMatrix (const Complex_wp &, const Matrix< Complex_wp, General, RowUpTriangPacked > &, const Matrix< Complex_wp, General, RowUpTriangPacked > &, const Complex_wp &, Matrix< Complex_wp, General, RowMajor > &) |
SELDON_EXTERN template void | MltAddMatrix (const Complex_wp &, const Matrix< Complex_wp, General, RowUpTriang > &, const Matrix< Complex_wp, General, RowUpTriang > &, const Complex_wp &, Matrix< Complex_wp, General, RowMajor > &) |
SELDON_EXTERN template void | MltAddMatrix (const Real_wp &, const Matrix< Real_wp, General, RowLoTriangPacked > &, const Matrix< Real_wp, General, RowLoTriangPacked > &, const Real_wp &, Matrix< Real_wp, General, RowLoTriangPacked > &) |
SELDON_EXTERN template void | MltAddMatrix (const Real_wp &, const Matrix< Real_wp, General, RowLoTriang > &, const Matrix< Real_wp, General, RowLoTriang > &, const Real_wp &, Matrix< Real_wp, General, RowLoTriang > &) |
SELDON_EXTERN template void | MltAddMatrix (const Real_wp &, const Matrix< Real_wp, General, RowUpTriangPacked > &, const Matrix< Real_wp, General, RowUpTriangPacked > &, const Real_wp &, Matrix< Real_wp, General, RowUpTriangPacked > &) |
SELDON_EXTERN template void | MltAddMatrix (const Real_wp &, const Matrix< Real_wp, General, RowUpTriang > &, const Matrix< Real_wp, General, RowUpTriang > &, const Real_wp &, Matrix< Real_wp, General, RowUpTriang > &) |
SELDON_EXTERN template void | MltAddMatrix (const Complex_wp &, const Matrix< Complex_wp, General, RowLoTriangPacked > &, const Matrix< Complex_wp, General, RowLoTriangPacked > &, const Complex_wp &, Matrix< Complex_wp, General, RowLoTriangPacked > &) |
SELDON_EXTERN template void | MltAddMatrix (const Complex_wp &, const Matrix< Complex_wp, General, RowLoTriang > &, const Matrix< Complex_wp, General, RowLoTriang > &, const Complex_wp &, Matrix< Complex_wp, General, RowLoTriang > &) |
SELDON_EXTERN template void | MltAddMatrix (const Complex_wp &, const Matrix< Complex_wp, General, RowUpTriangPacked > &, const Matrix< Complex_wp, General, RowUpTriangPacked > &, const Complex_wp &, Matrix< Complex_wp, General, RowUpTriangPacked > &) |
SELDON_EXTERN template void | MltAddMatrix (const Complex_wp &, const Matrix< Complex_wp, General, RowUpTriang > &, const Matrix< Complex_wp, General, RowUpTriang > &, const Complex_wp &, Matrix< Complex_wp, General, RowUpTriang > &) |
SELDON_EXTERN template void | MltAddMatrix (const Real_wp &, const Matrix< Real_wp, Symmetric, RowSymPacked > &, const Matrix< Real_wp, Symmetric, RowSymPacked > &, const Real_wp &, Matrix< Real_wp, Symmetric, RowSymPacked > &) |
SELDON_EXTERN template void | MltAddMatrix (const Complex_wp &, const Matrix< Complex_wp, Symmetric, RowSymPacked > &, const Matrix< Complex_wp, Symmetric, RowSymPacked > &, const Complex_wp &, Matrix< Complex_wp, Symmetric, RowSymPacked > &) |
SELDON_EXTERN template void | MltScalar (const Real_wp &, Matrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template void | MltScalar (const Real_wp &, Matrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | MltScalar (const Complex_wp &, Matrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | MltScalar (const Real_wp &, Matrix< Real_wp, General, ColSparse > &) |
SELDON_EXTERN template void | MltScalar (const Real_wp &, Matrix< Complex_wp, General, ColSparse > &) |
SELDON_EXTERN template void | MltScalar (const Complex_wp &, Matrix< Complex_wp, General, ColSparse > &) |
SELDON_EXTERN template void | MltScalar (const Real_wp &, Matrix< Real_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | MltScalar (const Real_wp &, Matrix< Complex_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | MltScalar (const Complex_wp &, Matrix< Complex_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | AddMatrix (const Real_wp &, const Matrix< Real_wp, General, RowSparse > &, Matrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template void | AddMatrix (const Real_wp &, const Matrix< Real_wp, General, ColSparse > &, Matrix< Real_wp, General, ColSparse > &) |
SELDON_EXTERN template void | AddMatrix (const Real_wp &, const Matrix< Real_wp, Symmetric, RowSymSparse > &, Matrix< Real_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | AddMatrix (const Real_wp &, const Matrix< Complex_wp, General, RowSparse > &, Matrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | AddMatrix (const Complex_wp &, const Matrix< Complex_wp, General, RowSparse > &, Matrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | AddMatrix (const Real_wp &, const Matrix< Complex_wp, General, ColSparse > &, Matrix< Complex_wp, General, ColSparse > &) |
SELDON_EXTERN template void | AddMatrix (const Complex_wp &, const Matrix< Complex_wp, General, ColSparse > &, Matrix< Complex_wp, General, ColSparse > &) |
SELDON_EXTERN template void | AddMatrix (const Real_wp &, const Matrix< Complex_wp, Symmetric, RowSymSparse > &, Matrix< Complex_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | AddMatrix (const Complex_wp &, const Matrix< Complex_wp, Symmetric, RowSymSparse > &, Matrix< Complex_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template Real_wp | MaxAbs (const Matrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template Real_wp | MaxAbs (const Matrix< Real_wp, General, ColSparse > &) |
SELDON_EXTERN template Real_wp | MaxAbs (const Matrix< Real_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template Real_wp | MaxAbs (const Matrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template Real_wp | MaxAbs (const Matrix< Complex_wp, General, ColSparse > &) |
SELDON_EXTERN template Real_wp | MaxAbs (const Matrix< Complex_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template Real_wp | Norm1 (const Matrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template Real_wp | Norm1 (const Matrix< Real_wp, General, ColSparse > &) |
SELDON_EXTERN template Real_wp | Norm1 (const Matrix< Real_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template Real_wp | Norm1 (const Matrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template Real_wp | Norm1 (const Matrix< Complex_wp, General, ColSparse > &) |
SELDON_EXTERN template Real_wp | Norm1 (const Matrix< Complex_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template Real_wp | NormInf (const Matrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template Real_wp | NormInf (const Matrix< Real_wp, General, ColSparse > &) |
SELDON_EXTERN template Real_wp | NormInf (const Matrix< Real_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template Real_wp | NormInf (const Matrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template Real_wp | NormInf (const Matrix< Complex_wp, General, ColSparse > &) |
SELDON_EXTERN template Real_wp | NormInf (const Matrix< Complex_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | Conjugate (Matrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template void | Conjugate (Matrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | Conjugate (Matrix< Real_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | Conjugate (Matrix< Complex_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | Conjugate (Matrix< Real_wp, General, ColSparse > &) |
SELDON_EXTERN template void | Conjugate (Matrix< Complex_wp, General, ColSparse > &) |
SELDON_EXTERN template void | Transpose (Matrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template void | Transpose (Matrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | Transpose (Matrix< Real_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | Transpose (Matrix< Complex_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | Transpose (const Matrix< Real_wp, General, RowSparse > &, Matrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template void | Transpose (const Matrix< Complex_wp, General, RowSparse > &, Matrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | Transpose (const Matrix< Real_wp, Symmetric, RowSymSparse > &, Matrix< Real_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | Transpose (const Matrix< Complex_wp, Symmetric, RowSymSparse > &, Matrix< Complex_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | Transpose (Matrix< Real_wp, General, ColSparse > &) |
SELDON_EXTERN template void | Transpose (Matrix< Complex_wp, General, ColSparse > &) |
SELDON_EXTERN template void | Transpose (const Matrix< Real_wp, General, ColSparse > &, Matrix< Real_wp, General, ColSparse > &) |
SELDON_EXTERN template void | Transpose (const Matrix< Complex_wp, General, ColSparse > &, Matrix< Complex_wp, General, ColSparse > &) |
SELDON_EXTERN template void | TransposeConj (Matrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template void | TransposeConj (Matrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | TransposeConj (Matrix< Real_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | TransposeConj (Matrix< Complex_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | TransposeConj (const Matrix< Real_wp, General, RowSparse > &, Matrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template void | TransposeConj (const Matrix< Complex_wp, General, RowSparse > &, Matrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | TransposeConj (const Matrix< Real_wp, Symmetric, RowSymSparse > &, Matrix< Real_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | TransposeConj (const Matrix< Complex_wp, Symmetric, RowSymSparse > &, Matrix< Complex_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | TransposeConj (Matrix< Real_wp, General, ColSparse > &) |
SELDON_EXTERN template void | TransposeConj (Matrix< Complex_wp, General, ColSparse > &) |
SELDON_EXTERN template void | TransposeConj (const Matrix< Real_wp, General, ColSparse > &, Matrix< Real_wp, General, ColSparse > &) |
SELDON_EXTERN template void | TransposeConj (const Matrix< Complex_wp, General, ColSparse > &, Matrix< Complex_wp, General, ColSparse > &) |
SELDON_EXTERN template void | MltAddMatrix (const Real_wp &, const Matrix< Real_wp, General, RowSparse > &, const Matrix< Real_wp, General, RowMajor > &, const Real_wp &, Matrix< Real_wp, General, RowMajor > &) |
SELDON_EXTERN template void | MltAddMatrix (const Real_wp &, const SeldonTranspose &, const Matrix< Real_wp, General, RowSparse > &, const SeldonTranspose &, const Matrix< Real_wp, General, RowMajor > &, const Real_wp &, Matrix< Real_wp, General, RowMajor > &) |
SELDON_EXTERN template void | MltMatrix (const Matrix< Real_wp, General, RowSparse > &, const Matrix< Real_wp, General, RowSparse > &, Matrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template void | MltAddMatrix (const Real_wp &, const Matrix< Real_wp, General, RowSparse > &, const Matrix< Real_wp, General, RowSparse > &, const Real_wp &, Matrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template void | MltAddMatrix (const Real_wp &, const SeldonTranspose &, const Matrix< Real_wp, General, RowSparse > &, const SeldonTranspose &, const Matrix< Real_wp, General, RowSparse > &, const Real_wp &, Matrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template void | GetRow (const Matrix< Real_wp, General, ArrayRowSparse > &, int, Vector< Real_wp, VectSparse > &) |
SELDON_EXTERN template void | GetRow (const Matrix< Complex_wp, General, ArrayRowSparse > &, int, Vector< Complex_wp, VectSparse > &) |
SELDON_EXTERN template void | GetRow (const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, int, Vector< Real_wp, VectSparse > &) |
SELDON_EXTERN template void | GetRow (const Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, int, Vector< Complex_wp, VectSparse > &) |
SELDON_EXTERN template void | GetCol (const Matrix< Real_wp, General, ArrayRowSparse > &, int, Vector< Real_wp, VectSparse > &) |
SELDON_EXTERN template void | GetCol (const Matrix< Complex_wp, General, ArrayRowSparse > &, int, Vector< Complex_wp, VectSparse > &) |
SELDON_EXTERN template void | GetCol (const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, int, Vector< Real_wp, VectSparse > &) |
SELDON_EXTERN template void | GetCol (const Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, int, Vector< Complex_wp, VectSparse > &) |
SELDON_EXTERN template void | SetRow (const Vector< Real_wp, VectSparse > &, int, Matrix< Real_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | SetRow (const Vector< Complex_wp, VectSparse > &, int, Matrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | SetRow (const Vector< Real_wp, VectSparse > &, int, Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | SetRow (const Vector< Complex_wp, VectSparse > &, int, Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | SetCol (const Vector< Real_wp, VectSparse > &, int, Matrix< Real_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | SetCol (const Vector< Complex_wp, VectSparse > &, int, Matrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | SetCol (const Vector< Real_wp, VectSparse > &, int, Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | SetCol (const Vector< Complex_wp, VectSparse > &, int, Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | MltVector (const Matrix< Real_wp, General, ArrayRowSparse > &, const Vector< Real_wp > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltVector (const Matrix< Real_wp, General, ArrayRowSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const Matrix< Complex_wp, General, ArrayRowSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< Real_wp, General, ArrayRowSparse > &, const Vector< Real_wp > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< Real_wp, General, ArrayRowSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< Complex_wp, General, ArrayRowSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const Matrix< Real_wp, General, ArrayRowSparse > &, const Vector< Real_wp > &, const Real_wp &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const Matrix< Real_wp, General, ArrayRowSparse > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const Matrix< Real_wp, General, ArrayRowSparse > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const Matrix< Complex_wp, General, ArrayRowSparse > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const Matrix< Complex_wp, General, ArrayRowSparse > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const SeldonTranspose &, const Matrix< Real_wp, General, ArrayRowSparse > &, const Vector< Real_wp > &, const Real_wp &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const SeldonTranspose &, const Matrix< Real_wp, General, ArrayRowSparse > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const SeldonTranspose &, const Matrix< Real_wp, General, ArrayRowSparse > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const SeldonTranspose &, const Matrix< Complex_wp, General, ArrayRowSparse > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const SeldonTranspose &, const Matrix< Complex_wp, General, ArrayRowSparse > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const Matrix< Real_wp, General, ArrayColSparse > &, const Vector< Real_wp > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltVector (const Matrix< Real_wp, General, ArrayColSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const Matrix< Complex_wp, General, ArrayColSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< Real_wp, General, ArrayColSparse > &, const Vector< Real_wp > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< Real_wp, General, ArrayColSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< Complex_wp, General, ArrayColSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const Matrix< Real_wp, General, ArrayColSparse > &, const Vector< Real_wp > &, const Real_wp &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const Matrix< Real_wp, General, ArrayColSparse > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const Matrix< Real_wp, General, ArrayColSparse > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const Matrix< Complex_wp, General, ArrayColSparse > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const Matrix< Complex_wp, General, ArrayColSparse > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const SeldonTranspose &, const Matrix< Real_wp, General, ArrayColSparse > &, const Vector< Real_wp > &, const Real_wp &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const SeldonTranspose &, const Matrix< Real_wp, General, ArrayColSparse > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const SeldonTranspose &, const Matrix< Real_wp, General, ArrayColSparse > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const SeldonTranspose &, const Matrix< Complex_wp, General, ArrayColSparse > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const SeldonTranspose &, const Matrix< Complex_wp, General, ArrayColSparse > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, const Vector< Real_wp > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltVector (const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, const Vector< Real_wp > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, const Vector< Real_wp > &, const Real_wp &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const SeldonTranspose &, const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, const Vector< Real_wp > &, const Real_wp &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const SeldonTranspose &, const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const SeldonTranspose &, const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const SeldonTranspose &, const Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const SeldonTranspose &, const Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltScalar (const Real_wp &, Matrix< Real_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | MltScalar (const Real_wp &, Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | MltScalar (const Real_wp &, Matrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | MltScalar (const Complex_wp &, Matrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | MltScalar (const Real_wp &, Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | MltScalar (const Complex_wp &, Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | AddMatrix (const Real_wp &, const Matrix< Real_wp, General, ArrayRowSparse > &, Matrix< Real_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | AddMatrix (const Real_wp &, const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | AddMatrix (const Real_wp &, const Matrix< Complex_wp, General, ArrayRowSparse > &, Matrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | AddMatrix (const Complex_wp &, const Matrix< Complex_wp, General, ArrayRowSparse > &, Matrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | AddMatrix (const Real_wp &, const Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | AddMatrix (const Complex_wp &, const Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | AddMatrix (const Real_wp &, const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, Matrix< Real_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | AddMatrix (const Complex_wp &, const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, Matrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | AddMatrix (const Complex_wp &, const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | AddMatrix (const Complex_wp &, const Matrix< Real_wp, General, ArrayRowSparse > &, Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | AddMatrix (const Complex_wp &, const Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, Matrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | AddMatrix (const Complex_wp &, const Matrix< Real_wp, General, ArrayRowSparse > &, Matrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | AddMatrix (const Real_wp &, const Matrix< Real_wp, General, ArrayRowSparse > &, Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | AddMatrix (const Complex_wp &, const Matrix< Complex_wp, General, ArrayRowSparse > &, Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template Real_wp | MaxAbs (const Matrix< Real_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template Real_wp | MaxAbs (const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template Real_wp | MaxAbs (const Matrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template Real_wp | MaxAbs (const Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template Real_wp | Norm1 (const Matrix< Real_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template Real_wp | Norm1 (const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template Real_wp | Norm1 (const Matrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template Real_wp | Norm1 (const Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template Real_wp | NormInf (const Matrix< Real_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template Real_wp | NormInf (const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template Real_wp | NormInf (const Matrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template Real_wp | NormInf (const Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template Real_wp | NormFro (const Matrix< Real_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template Real_wp | NormFro (const Matrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template Real_wp | NormFro (const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template Real_wp | NormFro (const Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | Conjugate (Matrix< Real_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | Conjugate (Matrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | Conjugate (Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | Conjugate (Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | Transpose (Matrix< Real_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | Transpose (Matrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | Transpose (Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | Transpose (Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | Transpose (const Matrix< Real_wp, General, ArrayRowSparse > &, Matrix< Real_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | Transpose (const Matrix< Complex_wp, General, ArrayRowSparse > &, Matrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | Transpose (const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | Transpose (const Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | TransposeConj (Matrix< Real_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | TransposeConj (Matrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | TransposeConj (Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | TransposeConj (Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | TransposeConj (const Matrix< Real_wp, General, ArrayRowSparse > &, Matrix< Real_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | TransposeConj (const Matrix< Complex_wp, General, ArrayRowSparse > &, Matrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | TransposeConj (const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | TransposeConj (const Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | AddMatrix (const Real_wp &, const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | AddMatrix (const Real_wp &, const Matrix< Real_wp, General, ArrayRowSparse > &, const Matrix< Real_wp, General, ArrayRowSparse > &, Matrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | MltAddMatrix (const Real_wp &, const Matrix< Real_wp, General, ArrayRowSparse > &, const Matrix< Real_wp, General, RowMajor > &, const Real_wp &, Matrix< Real_wp, General, RowMajor > &) |
SELDON_EXTERN template void | MltAddMatrix (const Complex_wp &, const Matrix< Complex_wp, General, ArrayRowSparse > &, const Matrix< Complex_wp, General, RowMajor > &, const Complex_wp &, Matrix< Complex_wp, General, RowMajor > &) |
SELDON_EXTERN template void | MltAddMatrix (const Real_wp &, const Matrix< Real_wp, General, RowMajor > &, const Matrix< Real_wp, General, ArrayRowSparse > &, const Real_wp &, Matrix< Real_wp, General, RowMajor > &) |
SELDON_EXTERN template void | MltAddMatrix (const Complex_wp &, const Matrix< Complex_wp, General, RowMajor > &, const Matrix< Complex_wp, General, ArrayRowSparse > &, const Complex_wp &, Matrix< Complex_wp, General, RowMajor > &) |
SELDON_EXTERN template void | MltAddMatrix (const Real_wp &, const Matrix< Real_wp, General, ArrayRowSparse > &, const Matrix< Real_wp, Symmetric, RowSymPacked > &, const Real_wp &, Matrix< Real_wp, General, RowMajor > &) |
SELDON_EXTERN template void | MltAddMatrix (const Complex_wp &, const Matrix< Complex_wp, General, ArrayRowSparse > &, const Matrix< Complex_wp, Symmetric, RowSymPacked > &, const Complex_wp &, Matrix< Complex_wp, General, RowMajor > &) |
SELDON_EXTERN template void | MltAddMatrix (const Real_wp &, const Matrix< Real_wp, Symmetric, RowSymPacked > &, const Matrix< Real_wp, General, ArrayRowSparse > &, const Real_wp &, Matrix< Real_wp, General, RowMajor > &) |
SELDON_EXTERN template void | MltAddMatrix (const Complex_wp &, const Matrix< Complex_wp, Symmetric, RowSymPacked > &, const Matrix< Complex_wp, General, ArrayRowSparse > &, const Complex_wp &, Matrix< Complex_wp, General, RowMajor > &) |
SELDON_EXTERN template void | RemoveSmallEntry (Matrix< Real_wp, General, RowSparse > &, const Real_wp &) |
SELDON_EXTERN template void | RemoveSmallEntry (Matrix< Real_wp, Symmetric, RowSymSparse > &, const Real_wp &) |
SELDON_EXTERN template void | RemoveSmallEntry (Matrix< Real_wp, General, ArrayRowSparse > &, const Real_wp &) |
SELDON_EXTERN template void | RemoveSmallEntry (Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, const Real_wp &) |
SELDON_EXTERN template void | RemoveSmallEntry (Matrix< Complex_wp, General, RowSparse > &, const Real_wp &) |
SELDON_EXTERN template void | RemoveSmallEntry (Matrix< Complex_wp, Symmetric, RowSymSparse > &, const Real_wp &) |
SELDON_EXTERN template void | RemoveSmallEntry (Matrix< Complex_wp, General, ArrayRowSparse > &, const Real_wp &) |
SELDON_EXTERN template void | RemoveSmallEntry (Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, const Real_wp &) |
SELDON_EXTERN template void | EraseCol (const IVect &, Matrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template void | EraseCol (const IVect &, Matrix< Real_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | EraseCol (const IVect &, Matrix< Real_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | EraseCol (const IVect &, Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | EraseCol (const IVect &, Matrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | EraseCol (const IVect &, Matrix< Complex_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | EraseCol (const IVect &, Matrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | EraseCol (const IVect &, Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | EraseRow (const IVect &, Matrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template void | EraseRow (const IVect &, Matrix< Real_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | EraseRow (const IVect &, Matrix< Real_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | EraseRow (const IVect &, Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | EraseRow (const IVect &, Matrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | EraseRow (const IVect &, Matrix< Complex_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | EraseRow (const IVect &, Matrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | EraseRow (const IVect &, Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | GetRowSum (Vector< Real_wp > &, const Matrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template void | GetRowSum (Vector< Real_wp > &, const Matrix< Real_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | GetRowSum (Vector< Real_wp > &, const Matrix< Real_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | GetRowSum (Vector< Real_wp > &, const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | GetRowSum (Vector< Real_wp > &, const Matrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | GetRowSum (Vector< Real_wp > &, const Matrix< Complex_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | GetRowSum (Vector< Real_wp > &, const Matrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | GetRowSum (Vector< Real_wp > &, const Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | GetColSum (Vector< Real_wp > &, const Matrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template void | GetColSum (Vector< Real_wp > &, const Matrix< Real_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | GetColSum (Vector< Real_wp > &, const Matrix< Real_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | GetColSum (Vector< Real_wp > &, const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | GetColSum (Vector< Real_wp > &, const Matrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | GetColSum (Vector< Real_wp > &, const Matrix< Complex_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | GetColSum (Vector< Real_wp > &, const Matrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | GetColSum (Vector< Real_wp > &, const Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | GetRowColSum (Vector< Real_wp > &, Vector< Real_wp > &, const Matrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template void | GetRowColSum (Vector< Real_wp > &, Vector< Real_wp > &, const Matrix< Real_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | GetRowColSum (Vector< Real_wp > &, Vector< Real_wp > &, const Matrix< Real_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | GetRowColSum (Vector< Real_wp > &, Vector< Real_wp > &, const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | GetRowColSum (Vector< Real_wp > &, Vector< Real_wp > &, const Matrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | GetRowColSum (Vector< Real_wp > &, Vector< Real_wp > &, const Matrix< Complex_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | GetRowColSum (Vector< Real_wp > &, Vector< Real_wp > &, const Matrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | GetRowColSum (Vector< Real_wp > &, Vector< Real_wp > &, const Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | CopySubMatrix (const Matrix< Real_wp, General, RowSparse > &, const IVect &, const IVect &, Matrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template void | CopySubMatrix (const Matrix< Real_wp, Symmetric, RowSymSparse > &, const IVect &, const IVect &, Matrix< Real_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | CopySubMatrix (const Matrix< Real_wp, General, ArrayRowSparse > &, const IVect &, const IVect &, Matrix< Real_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | CopySubMatrix (const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, const IVect &, const IVect &, Matrix< Real_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | CopySubMatrix (const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, const IVect &, const IVect &, Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | CopySubMatrix (const Matrix< Complex_wp, General, RowSparse > &, const IVect &, const IVect &, Matrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | CopySubMatrix (const Matrix< Complex_wp, Symmetric, RowSymSparse > &, const IVect &, const IVect &, Matrix< Complex_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | CopySubMatrix (const Matrix< Complex_wp, General, ArrayRowSparse > &, const IVect &, const IVect &, Matrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | CopySubMatrix (const Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, const IVect &, const IVect &, Matrix< Complex_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | CopySubMatrix (const Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, const IVect &, const IVect &, Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | CopySubMatrix (const Matrix< Real_wp, General, ArrayRowSparse > &, const IVect &, const IVect &, Matrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template void | CopySubMatrix (const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, const IVect &, const IVect &, Matrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template void | CopySubMatrix (const Matrix< Real_wp, Symmetric, RowSymSparse > &, const IVect &, const IVect &, Matrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template void | CopySubMatrix (const Matrix< Complex_wp, General, ArrayRowSparse > &, const IVect &, const IVect &, Matrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | CopySubMatrix (const Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, const IVect &, const IVect &, Matrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | CopySubMatrix (const Matrix< Complex_wp, Symmetric, RowSymSparse > &, const IVect &, const IVect &, Matrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | MltMatrix (Matrix< Real_wp, General, ArrayRowSparse > const &, Matrix< Real_wp, General, ArrayRowSparse > const &, Matrix< Real_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | MltAddMatrix (Real_wp const &, Matrix< Real_wp, General, ArrayRowSparse > const &, Matrix< Real_wp, General, ArrayRowSparse > const &, Real_wp const &, Matrix< Real_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | MltAddMatrix (Real_wp const &, SeldonTranspose const &, Matrix< Real_wp, General, ArrayRowSparse > const &, SeldonTranspose const &, Matrix< Real_wp, General, ArrayRowSparse > const &, Real_wp const &, Matrix< Real_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | MltAddMatrix (Complex_wp const &, SeldonTranspose const &, Matrix< Complex_wp, General, ArrayRowSparse > const &, SeldonTranspose const &, Matrix< Complex_wp, General, ArrayRowSparse > const &, Complex_wp const &, Matrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | MltAddMatrix (Complex_wp const &, Matrix< Complex_wp, General, ArrayRowSparse > const &, Matrix< Complex_wp, General, ArrayRowSparse > const &, Complex_wp const &, Matrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | MltVector (const Matrix< int, General, RowSparse > &, const Vector< int > &, Vector< int > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< int, General, RowSparse > &, const Vector< int > &, Vector< int > &) |
SELDON_EXTERN template void | MltVector (const Matrix< int, General, RowSparse > &, const Vector< complex< int > > &, Vector< complex< int > > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< int, General, RowSparse > &, const Vector< complex< int > > &, Vector< complex< int > > &) |
SELDON_EXTERN template void | MltAddVector (const int &, const Matrix< int, General, RowSparse > &, const Vector< int > &, const int &, Vector< int > &) |
SELDON_EXTERN template void | MltAddVector (const int &, const SeldonTranspose &, const Matrix< int, General, RowSparse > &, const Vector< int > &, const int &, Vector< int > &) |
SELDON_EXTERN template void | MltAddVector (const complex< int > &, const Matrix< int, General, RowSparse > &, const Vector< complex< int > > &, const complex< int > &, Vector< complex< int > > &) |
SELDON_EXTERN template void | MltAddVector (const complex< int > &, const SeldonTranspose &, const Matrix< int, General, RowSparse > &, const Vector< complex< int > > &, const complex< int > &, Vector< complex< int > > &) |
SELDON_EXTERN template void | MltVector (const Matrix< int, General, ColSparse > &, const Vector< int > &, Vector< int > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< int, General, ColSparse > &, const Vector< int > &, Vector< int > &) |
SELDON_EXTERN template void | MltVector (const Matrix< int, General, ColSparse > &, const Vector< complex< int > > &, Vector< complex< int > > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< int, General, ColSparse > &, const Vector< complex< int > > &, Vector< complex< int > > &) |
SELDON_EXTERN template void | MltAddVector (const int &, const Matrix< int, General, ColSparse > &, const Vector< int > &, const int &, Vector< int > &) |
SELDON_EXTERN template void | MltAddVector (const int &, const SeldonTranspose &, const Matrix< int, General, ColSparse > &, const Vector< int > &, const int &, Vector< int > &) |
SELDON_EXTERN template void | MltAddVector (const complex< int > &, const Matrix< int, General, ColSparse > &, const Vector< complex< int > > &, const complex< int > &, Vector< complex< int > > &) |
SELDON_EXTERN template void | MltAddVector (const complex< int > &, const SeldonTranspose &, const Matrix< int, General, ColSparse > &, const Vector< complex< int > > &, const complex< int > &, Vector< complex< int > > &) |
SELDON_EXTERN template void | MltVector (const Matrix< int, Symmetric, RowSymSparse > &, const Vector< int > &, Vector< int > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< int, Symmetric, RowSymSparse > &, const Vector< int > &, Vector< int > &) |
SELDON_EXTERN template void | MltVector (const Matrix< int, Symmetric, RowSymSparse > &, const Vector< complex< int > > &, Vector< complex< int > > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< int, Symmetric, RowSymSparse > &, const Vector< complex< int > > &, Vector< complex< int > > &) |
SELDON_EXTERN template void | MltAddVector (const int &, const Matrix< int, Symmetric, RowSymSparse > &, const Vector< int > &, const int &, Vector< int > &) |
SELDON_EXTERN template void | MltAddVector (const int &, const SeldonTranspose &, const Matrix< int, Symmetric, RowSymSparse > &, const Vector< int > &, const int &, Vector< int > &) |
SELDON_EXTERN template void | MltAddVector (const complex< int > &, const Matrix< int, Symmetric, RowSymSparse > &, const Vector< complex< int > > &, const complex< int > &, Vector< complex< int > > &) |
SELDON_EXTERN template void | MltAddVector (const complex< int > &, const SeldonTranspose &, const Matrix< int, Symmetric, RowSymSparse > &, const Vector< complex< int > > &, const complex< int > &, Vector< complex< int > > &) |
SELDON_EXTERN template void | MltScalar (const Real_wp &, Matrix< Complex_wp, General, RowComplexSparse > &) |
SELDON_EXTERN template void | MltScalar (const Real_wp &, Matrix< Complex_wp, General, ArrayRowComplexSparse > &) |
SELDON_EXTERN template void | MltScalar (const Real_wp &, Matrix< Complex_wp, Symmetric, RowSymComplexSparse > &) |
SELDON_EXTERN template void | MltScalar (const Real_wp &, Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &) |
SELDON_EXTERN template void | MltScalar (const Complex_wp &, Matrix< Complex_wp, General, ArrayRowComplexSparse > &) |
SELDON_EXTERN template void | MltScalar (const Complex_wp &, Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &) |
SELDON_EXTERN template void | MltScalar (const Complex_wp &, Matrix< Complex_wp, General, RowComplexSparse > &) |
SELDON_EXTERN template void | MltScalar (const Complex_wp &, Matrix< Complex_wp, Symmetric, RowSymComplexSparse > &) |
SELDON_EXTERN template void | AddMatrix (const Real_wp &, const Matrix< Complex_wp, General, ArrayRowComplexSparse > &, Matrix< Complex_wp, General, ArrayRowComplexSparse > &) |
SELDON_EXTERN template void | AddMatrix (const Real_wp &, const Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &, Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &) |
SELDON_EXTERN template void | AddMatrix (const Real_wp &, const Matrix< Complex_wp, General, ArrayRowComplexSparse > &, Matrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | AddMatrix (const Real_wp &, const Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &, Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | AddMatrix (const Real_wp &, const Matrix< Real_wp, General, ArrayRowSparse > &, const Matrix< Real_wp, General, ArrayRowSparse > &, Matrix< Complex_wp, General, ArrayRowComplexSparse > &) |
SELDON_EXTERN template void | AddMatrix (const Real_wp &, const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &) |
SELDON_EXTERN template void | AddMatrix (const Real_wp &, const Matrix< Complex_wp, General, RowComplexSparse > &, Matrix< Complex_wp, General, RowComplexSparse > &) |
SELDON_EXTERN template void | AddMatrix (const Real_wp &, const Matrix< Complex_wp, Symmetric, RowSymComplexSparse > &, Matrix< Complex_wp, Symmetric, RowSymComplexSparse > &) |
SELDON_EXTERN template void | Transpose (Matrix< Complex_wp, General, ArrayRowComplexSparse > &) |
SELDON_EXTERN template void | Transpose (Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &) |
SELDON_EXTERN template void | Transpose (Matrix< Complex_wp, General, RowComplexSparse > &) |
SELDON_EXTERN template void | Transpose (Matrix< Complex_wp, Symmetric, RowSymComplexSparse > &) |
SELDON_EXTERN template void | Transpose (const Matrix< Complex_wp, General, ArrayRowComplexSparse > &, Matrix< Complex_wp, General, ArrayRowComplexSparse > &) |
SELDON_EXTERN template void | Transpose (const Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &, Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &) |
SELDON_EXTERN template void | Transpose (const Matrix< Complex_wp, General, RowComplexSparse > &, Matrix< Complex_wp, General, RowComplexSparse > &) |
SELDON_EXTERN template void | Transpose (const Matrix< Complex_wp, Symmetric, RowSymComplexSparse > &, Matrix< Complex_wp, Symmetric, RowSymComplexSparse > &) |
SELDON_EXTERN template void | TransposeConj (Matrix< Complex_wp, General, ArrayRowComplexSparse > &) |
SELDON_EXTERN template void | TransposeConj (Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &) |
SELDON_EXTERN template void | TransposeConj (Matrix< Complex_wp, General, RowComplexSparse > &) |
SELDON_EXTERN template void | TransposeConj (Matrix< Complex_wp, Symmetric, RowSymComplexSparse > &) |
SELDON_EXTERN template void | ApplyInversePermutation (Matrix< Complex_wp, General, ArrayRowComplexSparse > &, const IVect &, const IVect &) |
SELDON_EXTERN template void | ApplyInversePermutation (Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &, const IVect &, const IVect &) |
SELDON_EXTERN template void | ApplyPermutation (Matrix< Complex_wp, General, ArrayRowComplexSparse > &, const IVect &, const IVect &) |
SELDON_EXTERN template void | ApplyPermutation (Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &, const IVect &, const IVect &) |
SELDON_EXTERN template void | ScaleMatrix (Matrix< Complex_wp, General, ArrayRowComplexSparse > &, const Vector< Real_wp > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleMatrix (Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &, const Vector< Real_wp > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleMatrix (Matrix< Complex_wp, General, RowComplexSparse > &, const Vector< Real_wp > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleMatrix (Matrix< Complex_wp, Symmetric, RowSymComplexSparse > &, const Vector< Real_wp > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleLeftMatrix (Matrix< Complex_wp, General, ArrayRowComplexSparse > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleRightMatrix (Matrix< Complex_wp, General, ArrayRowComplexSparse > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleLeftMatrix (Matrix< Complex_wp, General, RowComplexSparse > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleRightMatrix (Matrix< Complex_wp, General, RowComplexSparse > &, const Vector< Real_wp > &) |
SELDON_EXTERN template Real_wp | MaxAbs (const Matrix< Complex_wp, General, ArrayRowComplexSparse > &) |
SELDON_EXTERN template Real_wp | MaxAbs (const Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &) |
SELDON_EXTERN template Real_wp | MaxAbs (const Matrix< Complex_wp, General, RowComplexSparse > &) |
SELDON_EXTERN template Real_wp | MaxAbs (const Matrix< Complex_wp, Symmetric, RowSymComplexSparse > &) |
SELDON_EXTERN template Real_wp | Norm1 (const Matrix< Complex_wp, General, ArrayRowComplexSparse > &) |
SELDON_EXTERN template Real_wp | Norm1 (const Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &) |
SELDON_EXTERN template Real_wp | Norm1 (const Matrix< Complex_wp, General, RowComplexSparse > &) |
SELDON_EXTERN template Real_wp | Norm1 (const Matrix< Complex_wp, Symmetric, RowSymComplexSparse > &) |
SELDON_EXTERN template Real_wp | NormInf (const Matrix< Complex_wp, General, ArrayRowComplexSparse > &) |
SELDON_EXTERN template Real_wp | NormInf (const Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &) |
SELDON_EXTERN template Real_wp | NormInf (const Matrix< Complex_wp, General, RowComplexSparse > &) |
SELDON_EXTERN template Real_wp | NormInf (const Matrix< Complex_wp, Symmetric, RowSymComplexSparse > &) |
SELDON_EXTERN template Real_wp | NormFro (const Matrix< Complex_wp, General, ArrayRowComplexSparse > &) |
SELDON_EXTERN template Real_wp | NormFro (const Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &) |
SELDON_EXTERN template void | Conjugate (Matrix< Complex_wp, General, ArrayRowComplexSparse > &) |
SELDON_EXTERN template void | Conjugate (Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &) |
SELDON_EXTERN template void | Conjugate (Matrix< Complex_wp, General, RowComplexSparse > &) |
SELDON_EXTERN template void | Conjugate (Matrix< Complex_wp, Symmetric, RowSymComplexSparse > &) |
SELDON_EXTERN template bool | IsComplexMatrix (const Matrix< Complex_wp, General, RowComplexSparse > &) |
SELDON_EXTERN template bool | IsComplexMatrix (const Matrix< Complex_wp, Symmetric, RowSymComplexSparse > &) |
SELDON_EXTERN template bool | IsComplexMatrix (const Matrix< Complex_wp, General, ArrayRowComplexSparse > &) |
SELDON_EXTERN template bool | IsComplexMatrix (const Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &) |
SELDON_EXTERN template void | RemoveSmallEntry (Matrix< Complex_wp, General, RowComplexSparse > &, const Real_wp &) |
SELDON_EXTERN template void | RemoveSmallEntry (Matrix< Complex_wp, Symmetric, RowSymComplexSparse > &, const Real_wp &) |
SELDON_EXTERN template void | RemoveSmallEntry (Matrix< Complex_wp, General, ArrayRowComplexSparse > &, const Real_wp &) |
SELDON_EXTERN template void | RemoveSmallEntry (Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &, const Real_wp &) |
SELDON_EXTERN template void | EraseCol (const IVect &, Matrix< Complex_wp, General, RowComplexSparse > &) |
SELDON_EXTERN template void | EraseCol (const IVect &, Matrix< Complex_wp, Symmetric, RowSymComplexSparse > &) |
SELDON_EXTERN template void | EraseCol (const IVect &, Matrix< Complex_wp, General, ArrayRowComplexSparse > &) |
SELDON_EXTERN template void | EraseCol (const IVect &, Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &) |
SELDON_EXTERN template void | EraseRow (const IVect &, Matrix< Complex_wp, General, RowComplexSparse > &) |
SELDON_EXTERN template void | EraseRow (const IVect &, Matrix< Complex_wp, Symmetric, RowSymComplexSparse > &) |
SELDON_EXTERN template void | EraseRow (const IVect &, Matrix< Complex_wp, General, ArrayRowComplexSparse > &) |
SELDON_EXTERN template void | EraseRow (const IVect &, Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &) |
SELDON_EXTERN template void | GetRowSum (Vector< Real_wp > &, const Matrix< Complex_wp, General, RowComplexSparse > &) |
SELDON_EXTERN template void | GetRowSum (Vector< Real_wp > &, const Matrix< Complex_wp, Symmetric, RowSymComplexSparse > &) |
SELDON_EXTERN template void | GetRowSum (Vector< Real_wp > &, const Matrix< Complex_wp, General, ArrayRowComplexSparse > &) |
SELDON_EXTERN template void | GetRowSum (Vector< Real_wp > &, const Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &) |
SELDON_EXTERN template void | GetColSum (Vector< Real_wp > &, const Matrix< Complex_wp, General, RowComplexSparse > &) |
SELDON_EXTERN template void | GetColSum (Vector< Real_wp > &, const Matrix< Complex_wp, Symmetric, RowSymComplexSparse > &) |
SELDON_EXTERN template void | GetColSum (Vector< Real_wp > &, const Matrix< Complex_wp, General, ArrayRowComplexSparse > &) |
SELDON_EXTERN template void | GetColSum (Vector< Real_wp > &, const Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &) |
SELDON_EXTERN template void | GetRowColSum (Vector< Real_wp > &, Vector< Real_wp > &, const Matrix< Complex_wp, General, RowComplexSparse > &) |
SELDON_EXTERN template void | GetRowColSum (Vector< Real_wp > &, Vector< Real_wp > &, const Matrix< Complex_wp, Symmetric, RowSymComplexSparse > &) |
SELDON_EXTERN template void | GetRowColSum (Vector< Real_wp > &, Vector< Real_wp > &, const Matrix< Complex_wp, General, ArrayRowComplexSparse > &) |
SELDON_EXTERN template void | GetRowColSum (Vector< Real_wp > &, Vector< Real_wp > &, const Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &) |
SELDON_EXTERN template void | CopySubMatrix (const Matrix< Complex_wp, General, ArrayRowComplexSparse > &, const IVect &, const IVect &, Matrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | CopySubMatrix (const Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &, const IVect &, const IVect &, Matrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | CopySubMatrix (const Matrix< Complex_wp, General, RowComplexSparse > &, const IVect &, const IVect &, Matrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | CopySubMatrix (const Matrix< Complex_wp, Symmetric, RowSymComplexSparse > &, const IVect &, const IVect &, Matrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | GetRow (const Matrix< Real_wp, General, RowSparse > &, int, Vector< Real_wp, VectSparse > &) |
SELDON_EXTERN template void | GetRow (const Matrix< Complex_wp, General, RowSparse > &, int, Vector< Complex_wp, VectSparse > &) |
SELDON_EXTERN template void | GetRow (const Matrix< Real_wp, General, ColSparse > &, int, Vector< Real_wp, VectSparse > &) |
SELDON_EXTERN template void | GetRow (const Matrix< Complex_wp, General, ColSparse > &, int, Vector< Complex_wp, VectSparse > &) |
SELDON_EXTERN template void | GetRow (const Matrix< Real_wp, Symmetric, RowSymSparse > &, int, Vector< Real_wp, VectSparse > &) |
SELDON_EXTERN template void | GetRow (const Matrix< Complex_wp, Symmetric, RowSymSparse > &, int, Vector< Complex_wp, VectSparse > &) |
SELDON_EXTERN template void | GetCol (const Matrix< Real_wp, General, RowSparse > &, int, Vector< Real_wp, VectSparse > &) |
SELDON_EXTERN template void | GetCol (const Matrix< Complex_wp, General, RowSparse > &, int, Vector< Complex_wp, VectSparse > &) |
SELDON_EXTERN template void | GetCol (const Matrix< Real_wp, General, ColSparse > &, int, Vector< Real_wp, VectSparse > &) |
SELDON_EXTERN template void | GetCol (const Matrix< Complex_wp, General, ColSparse > &, int, Vector< Complex_wp, VectSparse > &) |
SELDON_EXTERN template void | GetCol (const Matrix< Real_wp, Symmetric, RowSymSparse > &, int, Vector< Real_wp, VectSparse > &) |
SELDON_EXTERN template void | GetCol (const Matrix< Complex_wp, Symmetric, RowSymSparse > &, int, Vector< Complex_wp, VectSparse > &) |
SELDON_EXTERN template void | SetRow (const Vector< Real_wp, VectSparse > &, int, Matrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template void | SetRow (const Vector< Complex_wp, VectSparse > &, int, Matrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | SetRow (const Vector< Real_wp, VectSparse > &, int, Matrix< Real_wp, General, ColSparse > &) |
SELDON_EXTERN template void | SetRow (const Vector< Complex_wp, VectSparse > &, int, Matrix< Complex_wp, General, ColSparse > &) |
SELDON_EXTERN template void | SetRow (const Vector< Real_wp, VectSparse > &, int, Matrix< Real_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | SetRow (const Vector< Complex_wp, VectSparse > &, int, Matrix< Complex_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | SetCol (const Vector< Real_wp, VectSparse > &, int, Matrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template void | SetCol (const Vector< Complex_wp, VectSparse > &, int, Matrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | SetCol (const Vector< Real_wp, VectSparse > &, int, Matrix< Real_wp, General, ColSparse > &) |
SELDON_EXTERN template void | SetCol (const Vector< Complex_wp, VectSparse > &, int, Matrix< Complex_wp, General, ColSparse > &) |
SELDON_EXTERN template void | SetCol (const Vector< Real_wp, VectSparse > &, int, Matrix< Real_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | SetCol (const Vector< Complex_wp, VectSparse > &, int, Matrix< Complex_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | GetRow (const Matrix< Real_wp, General, RowMajor > &, int, Vector< Real_wp > &) |
SELDON_EXTERN template void | GetRow (const Matrix< Complex_wp, General, RowMajor > &, int, Vector< Complex_wp > &) |
SELDON_EXTERN template void | GetRow (const Matrix< Real_wp, General, ColMajor > &, int, Vector< Real_wp > &) |
SELDON_EXTERN template void | GetRow (const Matrix< Complex_wp, General, ColMajor > &, int, Vector< Complex_wp > &) |
SELDON_EXTERN template void | GetRow (const Matrix< Real_wp, Symmetric, RowSymPacked > &, int, Vector< Real_wp > &) |
SELDON_EXTERN template void | GetRow (const Matrix< Complex_wp, Symmetric, RowSymPacked > &, int, Vector< Complex_wp > &) |
SELDON_EXTERN template void | GetRow (const Matrix< Real_wp, Symmetric, RowSym > &, int, Vector< Real_wp > &) |
SELDON_EXTERN template void | GetRow (const Matrix< Complex_wp, Symmetric, RowSym > &, int, Vector< Complex_wp > &) |
SELDON_EXTERN template void | GetRow (const Matrix< Complex_wp, Hermitian, RowHermPacked > &, int, Vector< Complex_wp > &) |
SELDON_EXTERN template void | GetRow (const Matrix< Complex_wp, Hermitian, RowHerm > &, int, Vector< Complex_wp > &) |
SELDON_EXTERN template void | GetRow (const Matrix< Real_wp, General, RowLoTriang > &, int, Vector< Real_wp > &) |
SELDON_EXTERN template void | GetRow (const Matrix< Complex_wp, General, RowLoTriang > &, int, Vector< Complex_wp > &) |
SELDON_EXTERN template void | GetRow (const Matrix< Real_wp, General, RowUpTriang > &, int, Vector< Real_wp > &) |
SELDON_EXTERN template void | GetRow (const Matrix< Complex_wp, General, RowUpTriang > &, int, Vector< Complex_wp > &) |
SELDON_EXTERN template void | GetRow (const Matrix< Real_wp, General, RowLoTriangPacked > &, int, Vector< Real_wp > &) |
SELDON_EXTERN template void | GetRow (const Matrix< Complex_wp, General, RowLoTriangPacked > &, int, Vector< Complex_wp > &) |
SELDON_EXTERN template void | GetRow (const Matrix< Real_wp, General, RowUpTriangPacked > &, int, Vector< Real_wp > &) |
SELDON_EXTERN template void | GetRow (const Matrix< Complex_wp, General, RowUpTriangPacked > &, int, Vector< Complex_wp > &) |
SELDON_EXTERN template void | GetCol (const Matrix< Real_wp, General, RowMajor > &, int, Vector< Real_wp > &) |
SELDON_EXTERN template void | GetCol (const Matrix< Complex_wp, General, RowMajor > &, int, Vector< Complex_wp > &) |
SELDON_EXTERN template void | GetCol (const Matrix< Real_wp, General, ColMajor > &, int, Vector< Real_wp > &) |
SELDON_EXTERN template void | GetCol (const Matrix< Complex_wp, General, ColMajor > &, int, Vector< Complex_wp > &) |
SELDON_EXTERN template void | GetCol (const Matrix< Real_wp, Symmetric, RowSymPacked > &, int, Vector< Real_wp > &) |
SELDON_EXTERN template void | GetCol (const Matrix< Complex_wp, Symmetric, RowSymPacked > &, int, Vector< Complex_wp > &) |
SELDON_EXTERN template void | GetCol (const Matrix< Real_wp, Symmetric, RowSym > &, int, Vector< Real_wp > &) |
SELDON_EXTERN template void | GetCol (const Matrix< Complex_wp, Symmetric, RowSym > &, int, Vector< Complex_wp > &) |
SELDON_EXTERN template void | GetCol (const Matrix< Complex_wp, Hermitian, RowHermPacked > &, int, Vector< Complex_wp > &) |
SELDON_EXTERN template void | GetCol (const Matrix< Complex_wp, Hermitian, RowHerm > &, int, Vector< Complex_wp > &) |
SELDON_EXTERN template void | GetCol (const Matrix< Real_wp, General, RowLoTriang > &, int, Vector< Real_wp > &) |
SELDON_EXTERN template void | GetCol (const Matrix< Complex_wp, General, RowLoTriang > &, int, Vector< Complex_wp > &) |
SELDON_EXTERN template void | GetCol (const Matrix< Real_wp, General, RowUpTriang > &, int, Vector< Real_wp > &) |
SELDON_EXTERN template void | GetCol (const Matrix< Complex_wp, General, RowUpTriang > &, int, Vector< Complex_wp > &) |
SELDON_EXTERN template void | GetCol (const Matrix< Real_wp, General, RowLoTriangPacked > &, int, Vector< Real_wp > &) |
SELDON_EXTERN template void | GetCol (const Matrix< Complex_wp, General, RowLoTriangPacked > &, int, Vector< Complex_wp > &) |
SELDON_EXTERN template void | GetCol (const Matrix< Real_wp, General, RowUpTriangPacked > &, int, Vector< Real_wp > &) |
SELDON_EXTERN template void | GetCol (const Matrix< Complex_wp, General, RowUpTriangPacked > &, int, Vector< Complex_wp > &) |
SELDON_EXTERN template void | SetRow (const Vector< Real_wp > &, int, Matrix< Real_wp, General, RowMajor > &) |
SELDON_EXTERN template void | SetRow (const Vector< Complex_wp > &, int, Matrix< Complex_wp, General, RowMajor > &) |
SELDON_EXTERN template void | SetRow (const Vector< Real_wp > &, int, Matrix< Real_wp, General, ColMajor > &) |
SELDON_EXTERN template void | SetRow (const Vector< Complex_wp > &, int, Matrix< Complex_wp, General, ColMajor > &) |
SELDON_EXTERN template void | SetRow (const Vector< Real_wp > &, int, Matrix< Real_wp, Symmetric, RowSym > &) |
SELDON_EXTERN template void | SetRow (const Vector< Complex_wp > &, int, Matrix< Complex_wp, Symmetric, RowSym > &) |
SELDON_EXTERN template void | SetRow (const Vector< Real_wp > &, int, Matrix< Real_wp, Symmetric, RowSymPacked > &) |
SELDON_EXTERN template void | SetRow (const Vector< Complex_wp > &, int, Matrix< Complex_wp, Symmetric, RowSymPacked > &) |
SELDON_EXTERN template void | SetRow (const Vector< Complex_wp > &, int, Matrix< Complex_wp, Hermitian, RowHerm > &) |
SELDON_EXTERN template void | SetRow (const Vector< Complex_wp > &, int, Matrix< Complex_wp, Hermitian, RowHermPacked > &) |
SELDON_EXTERN template void | SetRow (const Vector< Real_wp > &, int, Matrix< Real_wp, General, RowLoTriang > &) |
SELDON_EXTERN template void | SetRow (const Vector< Complex_wp > &, int, Matrix< Complex_wp, General, RowLoTriang > &) |
SELDON_EXTERN template void | SetRow (const Vector< Real_wp > &, int, Matrix< Real_wp, General, RowUpTriang > &) |
SELDON_EXTERN template void | SetRow (const Vector< Complex_wp > &, int, Matrix< Complex_wp, General, RowUpTriang > &) |
SELDON_EXTERN template void | SetRow (const Vector< Real_wp > &, int, Matrix< Real_wp, General, RowLoTriangPacked > &) |
SELDON_EXTERN template void | SetRow (const Vector< Complex_wp > &, int, Matrix< Complex_wp, General, RowLoTriangPacked > &) |
SELDON_EXTERN template void | SetRow (const Vector< Real_wp > &, int, Matrix< Real_wp, General, RowUpTriangPacked > &) |
SELDON_EXTERN template void | SetRow (const Vector< Complex_wp > &, int, Matrix< Complex_wp, General, RowUpTriangPacked > &) |
SELDON_EXTERN template void | SetCol (const Vector< Real_wp > &, int, Matrix< Real_wp, General, RowMajor > &) |
SELDON_EXTERN template void | SetCol (const Vector< Complex_wp > &, int, Matrix< Complex_wp, General, RowMajor > &) |
SELDON_EXTERN template void | SetCol (const Vector< Real_wp > &, int, Matrix< Real_wp, General, ColMajor > &) |
SELDON_EXTERN template void | SetCol (const Vector< Complex_wp > &, int, Matrix< Complex_wp, General, ColMajor > &) |
SELDON_EXTERN template void | SetCol (const Vector< Real_wp > &, int, Matrix< Real_wp, Symmetric, RowSym > &) |
SELDON_EXTERN template void | SetCol (const Vector< Complex_wp > &, int, Matrix< Complex_wp, Symmetric, RowSym > &) |
SELDON_EXTERN template void | SetCol (const Vector< Real_wp > &, int, Matrix< Real_wp, Symmetric, RowSymPacked > &) |
SELDON_EXTERN template void | SetCol (const Vector< Complex_wp > &, int, Matrix< Complex_wp, Symmetric, RowSymPacked > &) |
SELDON_EXTERN template void | SetCol (const Vector< Complex_wp > &, int, Matrix< Complex_wp, Hermitian, RowHerm > &) |
SELDON_EXTERN template void | SetCol (const Vector< Complex_wp > &, int, Matrix< Complex_wp, Hermitian, RowHermPacked > &) |
SELDON_EXTERN template void | SetCol (const Vector< Real_wp > &, int, Matrix< Real_wp, General, RowLoTriang > &) |
SELDON_EXTERN template void | SetCol (const Vector< Complex_wp > &, int, Matrix< Complex_wp, General, RowLoTriang > &) |
SELDON_EXTERN template void | SetCol (const Vector< Real_wp > &, int, Matrix< Real_wp, General, RowUpTriang > &) |
SELDON_EXTERN template void | SetCol (const Vector< Complex_wp > &, int, Matrix< Complex_wp, General, RowUpTriang > &) |
SELDON_EXTERN template void | SetCol (const Vector< Real_wp > &, int, Matrix< Real_wp, General, RowLoTriangPacked > &) |
SELDON_EXTERN template void | SetCol (const Vector< Complex_wp > &, int, Matrix< Complex_wp, General, RowLoTriangPacked > &) |
SELDON_EXTERN template void | SetCol (const Vector< Real_wp > &, int, Matrix< Real_wp, General, RowUpTriangPacked > &) |
SELDON_EXTERN template void | SetCol (const Vector< Complex_wp > &, int, Matrix< Complex_wp, General, RowUpTriangPacked > &) |
SELDON_EXTERN template void | ApplyInversePermutation (Matrix< Real_wp, General, RowMajor > &, const Vector< int > &, const Vector< int > &, int) |
SELDON_EXTERN template void | ApplyInversePermutation (Matrix< Complex_wp, General, RowMajor > &, const Vector< int > &, const Vector< int > &, int) |
SELDON_EXTERN template void | ApplyInversePermutation (Matrix< Real_wp, General, ColMajor > &, const Vector< int > &, const Vector< int > &, int) |
SELDON_EXTERN template void | ApplyInversePermutation (Matrix< Complex_wp, General, ColMajor > &, const Vector< int > &, const Vector< int > &, int) |
SELDON_EXTERN template void | ApplyInversePermutation (Matrix< Real_wp, Symmetric, RowSymPacked > &, const Vector< int > &, const Vector< int > &, int) |
SELDON_EXTERN template void | ApplyInversePermutation (Matrix< Complex_wp, Symmetric, RowSymPacked > &, const Vector< int > &, const Vector< int > &, int) |
SELDON_EXTERN template void | ApplyInversePermutation (Matrix< Real_wp, Symmetric, RowSym > &, const Vector< int > &, const Vector< int > &, int) |
SELDON_EXTERN template void | ApplyInversePermutation (Matrix< Complex_wp, Symmetric, RowSym > &, const Vector< int > &, const Vector< int > &, int) |
SELDON_EXTERN template void | ApplyInversePermutation (Matrix< Complex_wp, Hermitian, RowHerm > &, const Vector< int > &, const Vector< int > &, int) |
SELDON_EXTERN template void | ApplyInversePermutation (Matrix< Complex_wp, Hermitian, RowHermPacked > &, const Vector< int > &, const Vector< int > &, int) |
SELDON_EXTERN template void | ApplyPermutation (Matrix< Real_wp, General, RowMajor > &, const Vector< int > &, const Vector< int > &, int) |
SELDON_EXTERN template void | ApplyPermutation (Matrix< Complex_wp, General, RowMajor > &, const Vector< int > &, const Vector< int > &, int) |
SELDON_EXTERN template void | ApplyPermutation (Matrix< Real_wp, General, ColMajor > &, const Vector< int > &, const Vector< int > &, int) |
SELDON_EXTERN template void | ApplyPermutation (Matrix< Complex_wp, General, ColMajor > &, const Vector< int > &, const Vector< int > &, int) |
SELDON_EXTERN template void | ApplyPermutation (Matrix< Real_wp, Symmetric, RowSymPacked > &, const Vector< int > &, const Vector< int > &, int) |
SELDON_EXTERN template void | ApplyPermutation (Matrix< Complex_wp, Symmetric, RowSymPacked > &, const Vector< int > &, const Vector< int > &, int) |
SELDON_EXTERN template void | ApplyPermutation (Matrix< Real_wp, Symmetric, RowSym > &, const Vector< int > &, const Vector< int > &, int) |
SELDON_EXTERN template void | ApplyPermutation (Matrix< Complex_wp, Symmetric, RowSym > &, const Vector< int > &, const Vector< int > &, int) |
SELDON_EXTERN template void | ApplyPermutation (Matrix< Complex_wp, Hermitian, RowHerm > &, const Vector< int > &, const Vector< int > &, int) |
SELDON_EXTERN template void | ApplyPermutation (Matrix< Complex_wp, Hermitian, RowHermPacked > &, const Vector< int > &, const Vector< int > &, int) |
SELDON_EXTERN template void | ScaleMatrix (Matrix< Real_wp, Symmetric, RowSymPacked > &, const Vector< Real_wp > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleMatrix (Matrix< Complex_wp, Symmetric, RowSymPacked > &, const Vector< Real_wp > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleMatrix (Matrix< Real_wp, Symmetric, RowSym > &, const Vector< Real_wp > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleMatrix (Matrix< Complex_wp, Symmetric, RowSym > &, const Vector< Real_wp > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleMatrix (Matrix< Real_wp, General, RowMajor > &, const Vector< Real_wp > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleMatrix (Matrix< Complex_wp, General, RowMajor > &, const Vector< Real_wp > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleMatrix (Matrix< Real_wp, General, ColMajor > &, const Vector< Real_wp > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleMatrix (Matrix< Complex_wp, General, ColMajor > &, const Vector< Real_wp > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleMatrix (Matrix< Complex_wp, Hermitian, RowHerm > &, const Vector< Real_wp > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleMatrix (Matrix< Complex_wp, Hermitian, RowHermPacked > &, const Vector< Real_wp > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleMatrix (Matrix< Real_wp, General, RowLoTriang > &, const Vector< Real_wp > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleMatrix (Matrix< Complex_wp, General, RowLoTriang > &, const Vector< Real_wp > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleMatrix (Matrix< Real_wp, General, RowLoTriangPacked > &, const Vector< Real_wp > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleMatrix (Matrix< Complex_wp, General, RowLoTriangPacked > &, const Vector< Real_wp > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleMatrix (Matrix< Real_wp, General, RowUpTriang > &, const Vector< Real_wp > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleMatrix (Matrix< Complex_wp, General, RowUpTriang > &, const Vector< Real_wp > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleMatrix (Matrix< Real_wp, General, RowUpTriangPacked > &, const Vector< Real_wp > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleMatrix (Matrix< Complex_wp, General, RowUpTriangPacked > &, const Vector< Real_wp > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleLeftMatrix (Matrix< Real_wp, General, RowMajor > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleLeftMatrix (Matrix< Complex_wp, General, RowMajor > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleLeftMatrix (Matrix< Real_wp, General, ColMajor > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleLeftMatrix (Matrix< Complex_wp, General, ColMajor > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleLeftMatrix (Matrix< Real_wp, General, RowLoTriang > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleLeftMatrix (Matrix< Complex_wp, General, RowLoTriang > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleLeftMatrix (Matrix< Real_wp, General, RowLoTriangPacked > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleLeftMatrix (Matrix< Complex_wp, General, RowLoTriangPacked > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleLeftMatrix (Matrix< Real_wp, General, RowUpTriang > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleLeftMatrix (Matrix< Complex_wp, General, RowUpTriang > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleLeftMatrix (Matrix< Real_wp, General, RowUpTriangPacked > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleLeftMatrix (Matrix< Complex_wp, General, RowUpTriangPacked > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleLeftMatrix (Matrix< Complex_wp, General, RowMajor > &, const Vector< Complex_wp > &) |
SELDON_EXTERN template void | ScaleLeftMatrix (Matrix< Complex_wp, General, ColMajor > &, const Vector< Complex_wp > &) |
SELDON_EXTERN template void | ScaleRightMatrix (Matrix< Real_wp, General, RowMajor > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleRightMatrix (Matrix< Complex_wp, General, RowMajor > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleRightMatrix (Matrix< Real_wp, General, ColMajor > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleRightMatrix (Matrix< Complex_wp, General, ColMajor > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleRightMatrix (Matrix< Real_wp, General, RowLoTriang > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleRightMatrix (Matrix< Complex_wp, General, RowLoTriang > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleRightMatrix (Matrix< Real_wp, General, RowLoTriangPacked > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleRightMatrix (Matrix< Complex_wp, General, RowLoTriangPacked > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleRightMatrix (Matrix< Real_wp, General, RowUpTriang > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleRightMatrix (Matrix< Complex_wp, General, RowUpTriang > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleRightMatrix (Matrix< Real_wp, General, RowUpTriangPacked > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleRightMatrix (Matrix< Complex_wp, General, RowUpTriangPacked > &, const Vector< Real_wp > &) |
SELDON_EXTERN template Real_wp | NormFro (const Matrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template Real_wp | NormFro (const Matrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template Real_wp | NormFro (const Matrix< Real_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template Real_wp | NormFro (const Matrix< Complex_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | MltVector (const Matrix< Real_wp, General, RowSparse > &, const Vector< Real_wp > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltVector (const Matrix< Complex_wp, General, RowSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< Real_wp, General, RowSparse > &, const Vector< Real_wp > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< Complex_wp, General, RowSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const Matrix< Real_wp, General, RowSparse > &, const Vector< Real_wp > &, const Real_wp &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const Matrix< Complex_wp, General, RowSparse > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const SeldonTranspose &, const Matrix< Real_wp, General, RowSparse > &, const Vector< Real_wp > &, const Real_wp &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const SeldonTranspose &, const Matrix< Complex_wp, General, RowSparse > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const Matrix< Real_wp, General, RowSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< Real_wp, General, RowSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const Matrix< Real_wp, General, RowSparse > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const Matrix< Real_wp, General, RowSparse > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const Matrix< Complex_wp, General, RowSparse > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const SeldonTranspose &, const Matrix< Real_wp, General, RowSparse > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const SeldonTranspose &, const Matrix< Real_wp, General, RowSparse > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const SeldonTranspose &, const Matrix< Complex_wp, General, RowSparse > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const Matrix< Real_wp, General, ColSparse > &, const Vector< Real_wp > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltVector (const Matrix< Complex_wp, General, ColSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< Real_wp, General, ColSparse > &, const Vector< Real_wp > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< Complex_wp, General, ColSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const Matrix< Real_wp, General, ColSparse > &, const Vector< Real_wp > &, const Real_wp &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const Matrix< Complex_wp, General, ColSparse > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const SeldonTranspose &, const Matrix< Real_wp, General, ColSparse > &, const Vector< Real_wp > &, const Real_wp &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const SeldonTranspose &, const Matrix< Complex_wp, General, ColSparse > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const Matrix< Real_wp, General, ColSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< Real_wp, General, ColSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const Matrix< Real_wp, General, ColSparse > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const Matrix< Real_wp, General, ColSparse > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const Matrix< Complex_wp, General, ColSparse > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const SeldonTranspose &, const Matrix< Real_wp, General, ColSparse > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const SeldonTranspose &, const Matrix< Real_wp, General, ColSparse > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const SeldonTranspose &, const Matrix< Complex_wp, General, ColSparse > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const Matrix< Real_wp, Symmetric, RowSymSparse > &, const Vector< Real_wp > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltVector (const Matrix< Complex_wp, Symmetric, RowSymSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< Real_wp, Symmetric, RowSymSparse > &, const Vector< Real_wp > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< Complex_wp, Symmetric, RowSymSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const Matrix< Real_wp, Symmetric, RowSymSparse > &, const Vector< Real_wp > &, const Real_wp &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const Matrix< Real_wp, Symmetric, RowSymSparse > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const SeldonTranspose &, const Matrix< Real_wp, Symmetric, RowSymSparse > &, const Vector< Real_wp > &, const Real_wp &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const SeldonTranspose &, const Matrix< Complex_wp, Symmetric, RowSymSparse > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const Matrix< Real_wp, Symmetric, RowSymSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< Real_wp, Symmetric, RowSymSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const Matrix< Real_wp, Symmetric, RowSymSparse > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const Matrix< Complex_wp, Symmetric, RowSymSparse > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const Matrix< Complex_wp, Symmetric, RowSymSparse > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const SeldonTranspose &, const Matrix< Real_wp, Symmetric, RowSymSparse > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const SeldonTranspose &, const Matrix< Real_wp, Symmetric, RowSymSparse > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const SeldonTranspose &, const Matrix< Complex_wp, Symmetric, RowSymSparse > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const Matrix< Real_wp, General, RowMajor > &, const Vector< Real_wp > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltVector (const Matrix< Complex_wp, General, RowMajor > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< Real_wp, General, RowMajor > &, const Vector< Real_wp > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< Complex_wp, General, RowMajor > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const Matrix< Real_wp, General, RowMajor > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< Real_wp, General, RowMajor > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const Matrix< Real_wp, General, RowMajor > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const Matrix< Real_wp, General, RowMajor > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const SeldonTranspose &, const Matrix< Real_wp, General, RowMajor > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const SeldonTranspose &, const Matrix< Real_wp, General, RowMajor > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const Matrix< Complex_wp, General, RowMajor > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const SeldonTranspose &, const Matrix< Complex_wp, General, RowMajor > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const Matrix< Real_wp, General, ColMajor > &, const Vector< Real_wp > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltVector (const Matrix< Complex_wp, General, ColMajor > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< Real_wp, General, ColMajor > &, const Vector< Real_wp > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< Complex_wp, General, ColMajor > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const Matrix< Real_wp, General, ColMajor > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< Real_wp, General, ColMajor > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const Matrix< Real_wp, General, ColMajor > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const SeldonTranspose &, const Matrix< Real_wp, General, ColMajor > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const Matrix< Real_wp, General, ColMajor > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const SeldonTranspose &, const Matrix< Real_wp, General, ColMajor > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const Matrix< Complex_wp, General, ColMajor > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const SeldonTranspose &, const Matrix< Complex_wp, General, ColMajor > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const Matrix< Real_wp, Symmetric, RowSymPacked > &, const Vector< Real_wp > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< Real_wp, Symmetric, RowSymPacked > &, const Vector< Real_wp > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const SeldonTranspose &, const Matrix< Real_wp, Symmetric, RowSymPacked > &, const Vector< Real_wp > &, const Real_wp &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltVector (const Matrix< Complex_wp, Symmetric, RowSymPacked > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< Complex_wp, Symmetric, RowSymPacked > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const Matrix< Complex_wp, Symmetric, RowSymPacked > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const SeldonTranspose &, const Matrix< Complex_wp, Symmetric, RowSymPacked > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const Matrix< Real_wp, Symmetric, RowSymPacked > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< Real_wp, Symmetric, RowSymPacked > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const Matrix< Real_wp, Symmetric, RowSymPacked > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const SeldonTranspose &, const Matrix< Real_wp, Symmetric, RowSymPacked > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const SeldonTranspose &, const Matrix< Real_wp, Symmetric, RowSymPacked > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const Matrix< Real_wp, Symmetric, RowSymPacked > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const Matrix< Real_wp, Symmetric, RowSym > &, const Vector< Real_wp > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< Real_wp, Symmetric, RowSym > &, const Vector< Real_wp > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const SeldonTranspose &, const Matrix< Real_wp, Symmetric, RowSym > &, const Vector< Real_wp > &, const Real_wp &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const Matrix< Complex_wp, Symmetric, RowSym > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const SeldonTranspose &, const Matrix< Complex_wp, Symmetric, RowSym > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const Matrix< Real_wp, Symmetric, RowSym > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< Real_wp, Symmetric, RowSym > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const SeldonTranspose &, const Matrix< Real_wp, Symmetric, RowSym > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const SeldonTranspose &, const Matrix< Real_wp, Symmetric, RowSym > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const Matrix< Real_wp, Symmetric, RowSym > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const Matrix< Real_wp, Symmetric, RowSym > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (Matrix< Complex_wp, Symmetric, RowSym > const &, Vector< Complex_wp > const &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, Matrix< Complex_wp, Symmetric, RowSym > const &, Vector< Complex_wp > const &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const Matrix< Complex_wp, Hermitian, RowHermPacked > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< Complex_wp, Hermitian, RowHermPacked > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const Matrix< Complex_wp, Hermitian, RowHermPacked > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const SeldonTranspose &, const Matrix< Complex_wp, Hermitian, RowHermPacked > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const SeldonTranspose &, const Matrix< Complex_wp, Hermitian, RowHermPacked > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const Matrix< Complex_wp, Hermitian, RowHerm > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< Complex_wp, Hermitian, RowHerm > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const Matrix< Complex_wp, Hermitian, RowHerm > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const SeldonTranspose &, const Matrix< Complex_wp, Hermitian, RowHerm > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const SeldonTranspose &, const Matrix< Complex_wp, Hermitian, RowHerm > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const Matrix< Real_wp, General, RowLoTriang > &, const Vector< Real_wp > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltVector (const Matrix< Complex_wp, General, RowLoTriang > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< Real_wp, General, RowLoTriang > &, const Vector< Real_wp > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< Complex_wp, General, RowLoTriang > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const Matrix< Real_wp, General, RowLoTriang > &, const Vector< Real_wp > &, const Real_wp &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const Matrix< Complex_wp, General, RowLoTriang > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const SeldonTranspose &, const Matrix< Real_wp, General, RowLoTriang > &, const Vector< Real_wp > &, const Real_wp &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const SeldonTranspose &, const Matrix< Complex_wp, General, RowLoTriang > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const Matrix< Real_wp, General, RowLoTriang > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< Real_wp, General, RowLoTriang > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const Matrix< Real_wp, General, RowLoTriang > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const Matrix< Real_wp, General, RowLoTriang > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const SeldonTranspose &, const Matrix< Real_wp, General, RowLoTriang > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const SeldonTranspose &, const Matrix< Real_wp, General, RowLoTriang > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const Matrix< Complex_wp, General, RowLoTriang > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const SeldonTranspose &, const Matrix< Complex_wp, General, RowLoTriang > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const Matrix< Real_wp, General, RowLoTriangPacked > &, const Vector< Real_wp > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltVector (const Matrix< Complex_wp, General, RowLoTriangPacked > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< Real_wp, General, RowLoTriangPacked > &, const Vector< Real_wp > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< Complex_wp, General, RowLoTriangPacked > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const Matrix< Real_wp, General, RowLoTriangPacked > &, const Vector< Real_wp > &, const Real_wp &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const Matrix< Real_wp, General, RowLoTriangPacked > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const Matrix< Complex_wp, General, RowLoTriangPacked > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const SeldonTranspose &, const Matrix< Real_wp, General, RowLoTriangPacked > &, const Vector< Real_wp > &, const Real_wp &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const SeldonTranspose &, const Matrix< Complex_wp, General, RowLoTriangPacked > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const Matrix< Real_wp, General, RowLoTriangPacked > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< Real_wp, General, RowLoTriangPacked > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const Matrix< Real_wp, General, RowLoTriangPacked > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const Matrix< Complex_wp, General, RowLoTriangPacked > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const SeldonTranspose &, const Matrix< Real_wp, General, RowLoTriangPacked > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const SeldonTranspose &, const Matrix< Real_wp, General, RowLoTriangPacked > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const SeldonTranspose &, const Matrix< Complex_wp, General, RowLoTriangPacked > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const Matrix< Real_wp, General, RowUpTriang > &, const Vector< Real_wp > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltVector (const Matrix< Complex_wp, General, RowUpTriang > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< Real_wp, General, RowUpTriang > &, const Vector< Real_wp > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< Complex_wp, General, RowUpTriang > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const Matrix< Real_wp, General, RowUpTriang > &, const Vector< Real_wp > &, const Real_wp &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const Matrix< Complex_wp, General, RowUpTriang > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const SeldonTranspose &, const Matrix< Real_wp, General, RowUpTriang > &, const Vector< Real_wp > &, const Real_wp &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const SeldonTranspose &, const Matrix< Complex_wp, General, RowUpTriang > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const Matrix< Real_wp, General, RowUpTriang > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< Real_wp, General, RowUpTriang > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const Matrix< Real_wp, General, RowUpTriang > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const SeldonTranspose &, const Matrix< Real_wp, General, RowUpTriang > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const Matrix< Complex_wp, General, RowUpTriang > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const SeldonTranspose &, const Matrix< Real_wp, General, RowUpTriang > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const SeldonTranspose &, const Matrix< Complex_wp, General, RowUpTriang > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (Complex_wp const &, Matrix< Real_wp, General, RowUpTriang > const &, Vector< Complex_wp > const &, Complex_wp const &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const Matrix< Real_wp, General, RowUpTriangPacked > &, const Vector< Real_wp > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltVector (const Matrix< Complex_wp, General, RowUpTriangPacked > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< Real_wp, General, RowUpTriangPacked > &, const Vector< Real_wp > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< Complex_wp, General, RowUpTriangPacked > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const Matrix< Real_wp, General, RowUpTriangPacked > &, const Vector< Real_wp > &, const Real_wp &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const Matrix< Complex_wp, General, RowUpTriangPacked > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const SeldonTranspose &, const Matrix< Real_wp, General, RowUpTriangPacked > &, const Vector< Real_wp > &, const Real_wp &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const SeldonTranspose &, const Matrix< Complex_wp, General, RowUpTriangPacked > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const Matrix< Real_wp, General, RowUpTriangPacked > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< Real_wp, General, RowUpTriangPacked > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const Matrix< Real_wp, General, RowUpTriangPacked > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const Matrix< Real_wp, General, RowUpTriangPacked > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const SeldonTranspose &, const Matrix< Real_wp, General, RowUpTriangPacked > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const SeldonTranspose &, const Matrix< Real_wp, General, RowUpTriangPacked > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const Matrix< Complex_wp, General, RowUpTriangPacked > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const SeldonTranspose &, const Matrix< Complex_wp, General, RowUpTriangPacked > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | SolveLU (const Matrix< Real_wp, General, RowMajor > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | SolveLU (const Matrix< Complex_wp, General, RowMajor > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | SolveLU (const Matrix< Real_wp, General, ColMajor > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | SolveLU (const Matrix< Complex_wp, General, ColMajor > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | Gauss (Matrix< Real_wp, General, RowMajor > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | Gauss (Matrix< Complex_wp, General, RowMajor > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | Gauss (Matrix< Real_wp, General, ColMajor > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | Gauss (Matrix< Complex_wp, General, ColMajor > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | SorVector (const Matrix< Real_wp, General, RowMajor > &, Vector< Real_wp > &, const Vector< Real_wp > &, Real_wp const &, int, int) |
SELDON_EXTERN template void | SorVector (const Matrix< Complex_wp, General, RowMajor > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, Real_wp const &, int, int) |
SELDON_EXTERN template void | SorVector (const Matrix< Real_wp, General, ColMajor > &, Vector< Real_wp > &, const Vector< Real_wp > &, Real_wp const &, int, int) |
SELDON_EXTERN template void | SorVector (const Matrix< Complex_wp, General, ColMajor > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, Real_wp const &, int, int) |
SELDON_EXTERN template void | SorVector (const Matrix< Real_wp, Symmetric, RowSymPacked > &, Vector< Real_wp > &, const Vector< Real_wp > &, Real_wp const &, int, int) |
SELDON_EXTERN template void | SorVector (const Matrix< Complex_wp, Symmetric, RowSymPacked > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, Real_wp const &, int, int) |
SELDON_EXTERN template void | SorVector (const Matrix< Real_wp, Symmetric, RowSym > &, Vector< Real_wp > &, const Vector< Real_wp > &, Real_wp const &, int, int) |
SELDON_EXTERN template void | SorVector (const Matrix< Complex_wp, Symmetric, RowSym > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, Real_wp const &, int, int) |
SELDON_EXTERN template void | SorVector (const Matrix< Complex_wp, Hermitian, RowHermPacked > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, Real_wp const &, int, int) |
SELDON_EXTERN template void | SorVector (const Matrix< Complex_wp, Hermitian, RowHerm > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, Real_wp const &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const Matrix< Real_wp, General, RowMajor > &, Vector< Real_wp > &, const Vector< Real_wp > &, Real_wp const &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const Matrix< Real_wp, General, RowMajor > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, Real_wp const &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const Matrix< Complex_wp, General, RowMajor > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, Real_wp const &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const Matrix< Real_wp, General, ColMajor > &, Vector< Real_wp > &, const Vector< Real_wp > &, Real_wp const &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const Matrix< Real_wp, General, ColMajor > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, Real_wp const &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const Matrix< Complex_wp, General, ColMajor > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, Real_wp const &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const Matrix< Real_wp, Symmetric, RowSymPacked > &, Vector< Real_wp > &, const Vector< Real_wp > &, Real_wp const &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const Matrix< Real_wp, Symmetric, RowSymPacked > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, Real_wp const &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const Matrix< Complex_wp, Symmetric, RowSymPacked > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, Real_wp const &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const Matrix< Real_wp, Symmetric, RowSym > &, Vector< Real_wp > &, const Vector< Real_wp > &, Real_wp const &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const Matrix< Real_wp, Symmetric, RowSym > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, Real_wp const &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const Matrix< Complex_wp, Symmetric, RowSym > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, Real_wp const &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const Matrix< Complex_wp, Hermitian, RowHermPacked > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, Real_wp const &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const Matrix< Complex_wp, Hermitian, RowHerm > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, Real_wp const &, int, int) |
SELDON_EXTERN template void | GaussSeidel (const Matrix< Real_wp, General, RowMajor > &, Vector< Real_wp > &, const Vector< Real_wp > &, int, int) |
SELDON_EXTERN template void | GaussSeidel (const Matrix< Complex_wp, General, RowMajor > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, int, int) |
SELDON_EXTERN template void | GaussSeidel (const Matrix< Real_wp, General, ColMajor > &, Vector< Real_wp > &, const Vector< Real_wp > &, int, int) |
SELDON_EXTERN template void | GaussSeidel (const Matrix< Complex_wp, General, ColMajor > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, int, int) |
SELDON_EXTERN template void | GaussSeidel (const Matrix< Real_wp, Symmetric, RowSymPacked > &, Vector< Real_wp > &, const Vector< Real_wp > &, int, int) |
SELDON_EXTERN template void | GaussSeidel (const Matrix< Complex_wp, Symmetric, RowSymPacked > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, int, int) |
SELDON_EXTERN template void | GaussSeidel (const Matrix< Real_wp, Symmetric, RowSym > &, Vector< Real_wp > &, const Vector< Real_wp > &, int, int) |
SELDON_EXTERN template void | GaussSeidel (const Matrix< Complex_wp, Symmetric, RowSym > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, int, int) |
SELDON_EXTERN template void | GaussSeidel (const Matrix< Complex_wp, Hermitian, RowHermPacked > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, int, int) |
SELDON_EXTERN template void | GaussSeidel (const Matrix< Complex_wp, Hermitian, RowHerm > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, int, int) |
SELDON_EXTERN template void | MltVector (const Matrix< Complex_wp, General, RowComplexSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const Matrix< Complex_wp, General, ArrayRowComplexSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const Matrix< Complex_wp, Symmetric, RowSymComplexSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< Complex_wp, General, RowComplexSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< Complex_wp, General, ArrayRowComplexSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< Complex_wp, Symmetric, RowSymComplexSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &, const Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const Matrix< Complex_wp, General, RowComplexSparse > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const Matrix< Complex_wp, General, RowComplexSparse > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const SeldonTranspose &, const Matrix< Complex_wp, General, RowComplexSparse > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const SeldonTranspose &, const Matrix< Complex_wp, General, RowComplexSparse > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const Matrix< Complex_wp, Symmetric, RowSymComplexSparse > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const Matrix< Complex_wp, Symmetric, RowSymComplexSparse > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const SeldonTranspose &, const Matrix< Complex_wp, Symmetric, RowSymComplexSparse > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const SeldonTranspose &, const Matrix< Complex_wp, Symmetric, RowSymComplexSparse > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const Matrix< Complex_wp, General, ArrayRowComplexSparse > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const Matrix< Complex_wp, General, ArrayRowComplexSparse > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const SeldonTranspose &, const Matrix< Complex_wp, General, ArrayRowComplexSparse > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const SeldonTranspose &, const Matrix< Complex_wp, General, ArrayRowComplexSparse > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Real_wp &, const SeldonTranspose &, const Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &, const Vector< Complex_wp > &, const Real_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MltAddVector (const Complex_wp &, const SeldonTranspose &, const Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &, const Vector< Complex_wp > &, const Complex_wp &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | SorVector (const Matrix< Complex_wp, General, RowComplexSparse > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const Matrix< Complex_wp, General, ArrayRowComplexSparse > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const Matrix< Complex_wp, Symmetric, RowSymComplexSparse > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const Matrix< Complex_wp, General, RowComplexSparse > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const Matrix< Complex_wp, General, ArrayRowComplexSparse > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const Matrix< Complex_wp, Symmetric, RowSymComplexSparse > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | GetLU (Matrix< Real_wp, General, ArrayRowSparse > &, IlutPreconditioning< Real_wp > &, IVect &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, IlutPreconditioning< Real_wp > &, IVect &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< Complex_wp, General, ArrayRowSparse > &, IlutPreconditioning< Complex_wp > &, IVect &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, IlutPreconditioning< Complex_wp > &, IVect &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< Real_wp, General, RowSparse > &, IlutPreconditioning< Real_wp > &, IVect &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< Real_wp, Symmetric, RowSymSparse > &, IlutPreconditioning< Real_wp > &, IVect &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< Complex_wp, General, RowSparse > &, IlutPreconditioning< Complex_wp > &, IVect &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< Complex_wp, Symmetric, RowSymSparse > &, IlutPreconditioning< Complex_wp > &, IVect &, bool) |
SELDON_EXTERN template void | ReadCoordinateMatrix (istream &, Vector< int > &, Vector< int > &, Vector< Real_wp > &, bool) |
SELDON_EXTERN template void | ReadCoordinateMatrix (istream &, Vector< int > &, Vector< int > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | ReadCoordinateMatrix (istream &, Vector< int > &, Vector< int > &, Vector< int > &, bool) |
SELDON_EXTERN template void | WriteCoordinateMatrix (ostream &, const Vector< int > &, const Vector< int > &, const Vector< Real_wp > &, bool) |
SELDON_EXTERN template void | WriteCoordinateMatrix (ostream &, const Vector< int > &, const Vector< int > &, const Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | WriteCoordinateMatrix (ostream &, const Vector< int > &, const Vector< int > &, const Vector< int > &, bool) |
SELDON_EXTERN template void | ReadCoordinateMatrix (Matrix< Real_wp, General, RowSparse > &, istream &, Real_wp &, int, long, bool) |
SELDON_EXTERN template void | ReadCoordinateMatrix (Matrix< Complex_wp, General, RowSparse > &, istream &, Complex_wp &, int, long, bool) |
SELDON_EXTERN template void | WriteCoordinateMatrix (const Matrix< Real_wp, General, RowSparse > &, ostream &, Real_wp &, int, bool) |
SELDON_EXTERN template void | WriteCoordinateMatrix (const Matrix< Complex_wp, General, RowSparse > &, ostream &, Complex_wp &, int, bool) |
SELDON_EXTERN template void | ReadCoordinateMatrix (Matrix< int, General, RowSparse > &, istream &, int &, int, long, bool) |
SELDON_EXTERN template void | WriteCoordinateMatrix (const Matrix< int, General, RowSparse > &, ostream &, int &, int, bool) |
SELDON_EXTERN template void | ReadCoordinateMatrix (Matrix< int, General, ColSparse > &, istream &, int &, int, long, bool) |
SELDON_EXTERN template void | ReadCoordinateMatrix (Matrix< Real_wp, General, ColSparse > &, istream &, Real_wp &, int, long, bool) |
SELDON_EXTERN template void | ReadCoordinateMatrix (Matrix< Complex_wp, General, ColSparse > &, istream &, Complex_wp &, int, long, bool) |
SELDON_EXTERN template void | WriteCoordinateMatrix (const Matrix< int, General, ColSparse > &, ostream &, int &, int, bool) |
SELDON_EXTERN template void | WriteCoordinateMatrix (const Matrix< Real_wp, General, ColSparse > &, ostream &, Real_wp &, int, bool) |
SELDON_EXTERN template void | WriteCoordinateMatrix (const Matrix< Complex_wp, General, ColSparse > &, ostream &, Complex_wp &, int, bool) |
SELDON_EXTERN template void | ReadCoordinateMatrix (Matrix< Real_wp, General, ArrayRowSparse > &, istream &, Real_wp &, int, long, bool) |
SELDON_EXTERN template void | ReadCoordinateMatrix (Matrix< Complex_wp, General, ArrayRowSparse > &, istream &, Complex_wp &, int, long, bool) |
SELDON_EXTERN template void | WriteCoordinateMatrix (const Matrix< Real_wp, General, ArrayRowSparse > &, ostream &, Real_wp &, int, bool) |
SELDON_EXTERN template void | WriteCoordinateMatrix (const Matrix< Complex_wp, General, ArrayRowSparse > &, ostream &, Complex_wp &, int, bool) |
SELDON_EXTERN template void | ReadCoordinateMatrix (Matrix< Real_wp, General, ArrayColSparse > &, istream &, Real_wp &, int, long, bool) |
SELDON_EXTERN template void | ReadCoordinateMatrix (Matrix< Complex_wp, General, ArrayColSparse > &, istream &, Complex_wp &, int, long, bool) |
SELDON_EXTERN template void | WriteCoordinateMatrix (const Matrix< Real_wp, General, ArrayColSparse > &, ostream &, Real_wp &, int, bool) |
SELDON_EXTERN template void | WriteCoordinateMatrix (const Matrix< Complex_wp, General, ArrayColSparse > &, ostream &, Complex_wp &, int, bool) |
SELDON_EXTERN template void | ReadCoordinateMatrix (Matrix< Real_wp, Symmetric, RowSymSparse > &, istream &, Real_wp &, int, long, bool) |
SELDON_EXTERN template void | ReadCoordinateMatrix (Matrix< Complex_wp, Symmetric, RowSymSparse > &, istream &, Complex_wp &, int, long, bool) |
SELDON_EXTERN template void | WriteCoordinateMatrix (const Matrix< Real_wp, Symmetric, RowSymSparse > &, ostream &, Real_wp &, int, bool) |
SELDON_EXTERN template void | WriteCoordinateMatrix (const Matrix< Complex_wp, Symmetric, RowSymSparse > &, ostream &, Complex_wp &, int, bool) |
SELDON_EXTERN template void | ReadCoordinateMatrix (Matrix< int, Symmetric, RowSymSparse > &, istream &, int &, int, long, bool) |
SELDON_EXTERN template void | WriteCoordinateMatrix (const Matrix< int, Symmetric, RowSymSparse > &, ostream &, int &, int, bool) |
SELDON_EXTERN template void | ReadCoordinateMatrix (Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, istream &, Real_wp &, int, long, bool) |
SELDON_EXTERN template void | ReadCoordinateMatrix (Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, istream &, Complex_wp &, int, long, bool) |
SELDON_EXTERN template void | WriteCoordinateMatrix (const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, ostream &, Real_wp &, int, bool) |
SELDON_EXTERN template void | WriteCoordinateMatrix (const Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, ostream &, Complex_wp &, int, bool) |
SELDON_EXTERN template void | ReadHarwellBoeing (string, Matrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template void | ReadHarwellBoeing (string, Matrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | ReadHarwellBoeing (string, Matrix< Real_wp, General, ColSparse > &) |
SELDON_EXTERN template void | ReadHarwellBoeing (string, Matrix< Complex_wp, General, ColSparse > &) |
SELDON_EXTERN template void | ReadHarwellBoeing (string, Matrix< Real_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | ReadHarwellBoeing (string, Matrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | ReadHarwellBoeing (string, Matrix< Real_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | ReadHarwellBoeing (string, Matrix< Complex_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | ReadHarwellBoeing (string, Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | ReadHarwellBoeing (string, Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | WriteHarwellBoeing (const Matrix< Real_wp, General, RowSparse > &, const string &) |
SELDON_EXTERN template void | WriteHarwellBoeing (const Matrix< Complex_wp, General, RowSparse > &, const string &) |
SELDON_EXTERN template void | WriteHarwellBoeing (const Matrix< Real_wp, General, ColSparse > &, const string &) |
SELDON_EXTERN template void | WriteHarwellBoeing (const Matrix< Complex_wp, General, ColSparse > &, const string &) |
SELDON_EXTERN template void | WriteHarwellBoeing (const Matrix< Real_wp, General, ArrayRowSparse > &, const string &) |
SELDON_EXTERN template void | WriteHarwellBoeing (const Matrix< Complex_wp, General, ArrayRowSparse > &, const string &) |
SELDON_EXTERN template void | WriteHarwellBoeing (const Matrix< Real_wp, Symmetric, RowSymSparse > &, const string &) |
SELDON_EXTERN template void | WriteHarwellBoeing (const Matrix< Complex_wp, Symmetric, RowSymSparse > &, const string &) |
SELDON_EXTERN template void | WriteHarwellBoeing (const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, const string &) |
SELDON_EXTERN template void | WriteHarwellBoeing (const Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, const string &) |
SELDON_EXTERN template void | ReadMatrixMarket (string, Matrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template void | ReadMatrixMarket (string, Matrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | ReadMatrixMarket (string, Matrix< Real_wp, General, ColSparse > &) |
SELDON_EXTERN template void | ReadMatrixMarket (string, Matrix< Complex_wp, General, ColSparse > &) |
SELDON_EXTERN template void | ReadMatrixMarket (string, Matrix< Real_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | ReadMatrixMarket (string, Matrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | ReadMatrixMarket (string, Matrix< Real_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | ReadMatrixMarket (string, Matrix< Complex_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | ReadMatrixMarket (string, Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | ReadMatrixMarket (string, Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | WriteMatrixMarket (const Matrix< Real_wp, General, RowSparse > &, const string &) |
SELDON_EXTERN template void | WriteMatrixMarket (const Matrix< Complex_wp, General, RowSparse > &, const string &) |
SELDON_EXTERN template void | WriteMatrixMarket (const Matrix< Real_wp, General, ColSparse > &, const string &) |
SELDON_EXTERN template void | WriteMatrixMarket (const Matrix< Complex_wp, General, ColSparse > &, const string &) |
SELDON_EXTERN template void | WriteMatrixMarket (const Matrix< Real_wp, General, ArrayRowSparse > &, const string &) |
SELDON_EXTERN template void | WriteMatrixMarket (const Matrix< Complex_wp, General, ArrayRowSparse > &, const string &) |
SELDON_EXTERN template void | WriteMatrixMarket (const Matrix< Real_wp, Symmetric, RowSymSparse > &, const string &) |
SELDON_EXTERN template void | WriteMatrixMarket (const Matrix< Complex_wp, Symmetric, RowSymSparse > &, const string &) |
SELDON_EXTERN template void | WriteMatrixMarket (const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, const string &) |
SELDON_EXTERN template void | WriteMatrixMarket (const Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, const string &) |
SELDON_EXTERN template int | BiCg (const VirtualMatrix< Real_wp > &, Vector< Real_wp > &, const Vector< Real_wp > &, Preconditioner_Base< Real_wp > &, Iteration< Real_wp > &) |
SELDON_EXTERN template int | BiCg (const VirtualMatrix< Complex_wp > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, Preconditioner_Base< Complex_wp > &, Iteration< Real_wp > &) |
SELDON_EXTERN template int | BiCgStab (const VirtualMatrix< Real_wp > &, Vector< Real_wp > &, const Vector< Real_wp > &, Preconditioner_Base< Real_wp > &, Iteration< Real_wp > &) |
SELDON_EXTERN template int | BiCgStab (const VirtualMatrix< Complex_wp > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, Preconditioner_Base< Complex_wp > &, Iteration< Real_wp > &) |
SELDON_EXTERN template int | BiCgStabl (const VirtualMatrix< Real_wp > &, Vector< Real_wp > &, const Vector< Real_wp > &, Preconditioner_Base< Real_wp > &, Iteration< Real_wp > &) |
SELDON_EXTERN template int | BiCgStabl (const VirtualMatrix< Complex_wp > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, Preconditioner_Base< Complex_wp > &, Iteration< Real_wp > &) |
SELDON_EXTERN template int | BiCgcr (const VirtualMatrix< Real_wp > &, Vector< Real_wp > &, const Vector< Real_wp > &, Preconditioner_Base< Real_wp > &, Iteration< Real_wp > &) |
SELDON_EXTERN template int | BiCgcr (const VirtualMatrix< Complex_wp > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, Preconditioner_Base< Complex_wp > &, Iteration< Real_wp > &) |
SELDON_EXTERN template int | Cg (const VirtualMatrix< Real_wp > &, Vector< Real_wp > &, const Vector< Real_wp > &, Preconditioner_Base< Real_wp > &, Iteration< Real_wp > &) |
SELDON_EXTERN template int | Cg (const VirtualMatrix< Complex_wp > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, Preconditioner_Base< Complex_wp > &, Iteration< Real_wp > &) |
SELDON_EXTERN template int | Cgne (const VirtualMatrix< Real_wp > &, Vector< Real_wp > &, const Vector< Real_wp > &, Preconditioner_Base< Real_wp > &, Iteration< Real_wp > &) |
SELDON_EXTERN template int | Cgne (const VirtualMatrix< Complex_wp > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, Preconditioner_Base< Complex_wp > &, Iteration< Real_wp > &) |
SELDON_EXTERN template int | Cgs (const VirtualMatrix< Real_wp > &, Vector< Real_wp > &, const Vector< Real_wp > &, Preconditioner_Base< Real_wp > &, Iteration< Real_wp > &) |
SELDON_EXTERN template int | Cgs (const VirtualMatrix< Complex_wp > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, Preconditioner_Base< Complex_wp > &, Iteration< Real_wp > &) |
SELDON_EXTERN template int | CoCg (const VirtualMatrix< Real_wp > &, Vector< Real_wp > &, const Vector< Real_wp > &, Preconditioner_Base< Real_wp > &, Iteration< Real_wp > &) |
SELDON_EXTERN template int | CoCg (const VirtualMatrix< Complex_wp > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, Preconditioner_Base< Complex_wp > &, Iteration< Real_wp > &) |
SELDON_EXTERN template int | Gcr (const VirtualMatrix< Real_wp > &, Vector< Real_wp > &, const Vector< Real_wp > &, Preconditioner_Base< Real_wp > &, Iteration< Real_wp > &) |
SELDON_EXTERN template int | Gcr (const VirtualMatrix< Complex_wp > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, Preconditioner_Base< Complex_wp > &, Iteration< Real_wp > &) |
SELDON_EXTERN template int | Lsqr (const VirtualMatrix< Real_wp > &, Vector< Real_wp > &, const Vector< Real_wp > &, Preconditioner_Base< Real_wp > &, Iteration< Real_wp > &) |
SELDON_EXTERN template int | Lsqr (const VirtualMatrix< Complex_wp > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, Preconditioner_Base< Complex_wp > &, Iteration< Real_wp > &) |
SELDON_EXTERN template int | MinRes (const VirtualMatrix< Real_wp > &, Vector< Real_wp > &, const Vector< Real_wp > &, Preconditioner_Base< Real_wp > &, Iteration< Real_wp > &) |
SELDON_EXTERN template int | MinRes (const VirtualMatrix< Complex_wp > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, Preconditioner_Base< Complex_wp > &, Iteration< Real_wp > &) |
SELDON_EXTERN template int | QCgs (const VirtualMatrix< Real_wp > &, Vector< Real_wp > &, const Vector< Real_wp > &, Preconditioner_Base< Real_wp > &, Iteration< Real_wp > &) |
SELDON_EXTERN template int | QCgs (const VirtualMatrix< Complex_wp > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, Preconditioner_Base< Complex_wp > &, Iteration< Real_wp > &) |
SELDON_EXTERN template int | Qmr (const VirtualMatrix< Real_wp > &, Vector< Real_wp > &, const Vector< Real_wp > &, Preconditioner_Base< Real_wp > &, Iteration< Real_wp > &) |
SELDON_EXTERN template int | Qmr (const VirtualMatrix< Complex_wp > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, Preconditioner_Base< Complex_wp > &, Iteration< Real_wp > &) |
SELDON_EXTERN template int | QmrSym (const VirtualMatrix< Real_wp > &, Vector< Real_wp > &, const Vector< Real_wp > &, Preconditioner_Base< Real_wp > &, Iteration< Real_wp > &) |
SELDON_EXTERN template int | QmrSym (const VirtualMatrix< Complex_wp > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, Preconditioner_Base< Complex_wp > &, Iteration< Real_wp > &) |
SELDON_EXTERN template int | Symmlq (const VirtualMatrix< Real_wp > &, Vector< Real_wp > &, const Vector< Real_wp > &, Preconditioner_Base< Real_wp > &, Iteration< Real_wp > &) |
SELDON_EXTERN template int | Symmlq (const VirtualMatrix< Complex_wp > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, Preconditioner_Base< Complex_wp > &, Iteration< Real_wp > &) |
SELDON_EXTERN template int | TfQmr (const VirtualMatrix< Real_wp > &, Vector< Real_wp > &, const Vector< Real_wp > &, Preconditioner_Base< Real_wp > &, Iteration< Real_wp > &) |
SELDON_EXTERN template int | TfQmr (const VirtualMatrix< Complex_wp > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, Preconditioner_Base< Complex_wp > &, Iteration< Real_wp > &) |
SELDON_EXTERN template void | GetLU (Matrix< Real_wp, General, ColMajor > &, Vector< int > &, LapackInfo &) |
SELDON_EXTERN template void | GetLU (Matrix< Complex_wp, General, ColMajor > &, Vector< int > &, LapackInfo &) |
SELDON_EXTERN template void | GetLU (Matrix< Real_wp, General, RowMajor > &, Vector< int > &, LapackInfo &) |
SELDON_EXTERN template void | GetLU (Matrix< Complex_wp, General, RowMajor > &, Vector< int > &, LapackInfo &) |
SELDON_EXTERN template void | GetLU (Matrix< Real_wp, Symmetric, RowSym > &, Vector< int > &, LapackInfo &) |
SELDON_EXTERN template void | GetLU (Matrix< Complex_wp, Symmetric, RowSym > &, Vector< int > &, LapackInfo &) |
SELDON_EXTERN template void | GetLU (Matrix< Real_wp, Symmetric, RowSymPacked > &, Vector< int > &, LapackInfo &) |
SELDON_EXTERN template void | GetLU (Matrix< Complex_wp, Symmetric, RowSymPacked > &, Vector< int > &, LapackInfo &) |
SELDON_EXTERN template void | GetLU (Matrix< Complex_wp, Hermitian, RowHerm > &, Vector< int > &, LapackInfo &) |
SELDON_EXTERN template void | GetLU (Matrix< Complex_wp, Hermitian, RowHermPacked > &, Vector< int > &, LapackInfo &) |
SELDON_EXTERN template void | SolveLuVector (const Matrix< Real_wp, General, ColMajor > &, const Vector< int > &, Vector< Real_wp > &, LapackInfo &) |
SELDON_EXTERN template void | SolveLuVector (const Matrix< Complex_wp, General, ColMajor > &, const Vector< int > &, Vector< Complex_wp > &, LapackInfo &) |
SELDON_EXTERN template void | SolveLuVector (const Matrix< Real_wp, General, RowMajor > &, const Vector< int > &, Vector< Real_wp > &, LapackInfo &) |
SELDON_EXTERN template void | SolveLuVector (const Matrix< Complex_wp, General, RowMajor > &, const Vector< int > &, Vector< Complex_wp > &, LapackInfo &) |
SELDON_EXTERN template void | SolveLuVector (const SeldonTranspose &, const Matrix< Real_wp, General, ColMajor > &, const Vector< int > &, Vector< Real_wp > &, LapackInfo &) |
SELDON_EXTERN template void | SolveLuVector (const SeldonTranspose &, const Matrix< Complex_wp, General, ColMajor > &, const Vector< int > &, Vector< Complex_wp > &, LapackInfo &) |
SELDON_EXTERN template void | SolveLuVector (const SeldonTranspose &, const Matrix< Real_wp, General, RowMajor > &, const Vector< int > &, Vector< Real_wp > &, LapackInfo &) |
SELDON_EXTERN template void | SolveLuVector (const SeldonTranspose &, const Matrix< Complex_wp, General, RowMajor > &, const Vector< int > &, Vector< Complex_wp > &, LapackInfo &) |
SELDON_EXTERN template void | SolveLuVector (const Matrix< Real_wp, Symmetric, RowSym > &, const Vector< int > &, Vector< Real_wp > &, LapackInfo &) |
SELDON_EXTERN template void | SolveLuVector (const Matrix< Complex_wp, Symmetric, RowSym > &, const Vector< int > &, Vector< Complex_wp > &, LapackInfo &) |
SELDON_EXTERN template void | SolveLuVector (const Matrix< Real_wp, Symmetric, RowSymPacked > &, const Vector< int > &, Vector< Real_wp > &, LapackInfo &) |
SELDON_EXTERN template void | SolveLuVector (const Matrix< Complex_wp, Symmetric, RowSymPacked > &, const Vector< int > &, Vector< Complex_wp > &, LapackInfo &) |
SELDON_EXTERN template void | SolveLuVector (const Matrix< Complex_wp, Hermitian, RowHerm > &, const Vector< int > &, Vector< Complex_wp > &, LapackInfo &) |
SELDON_EXTERN template void | SolveLuVector (const Matrix< Complex_wp, Hermitian, RowHermPacked > &, const Vector< int > &, Vector< Complex_wp > &, LapackInfo &) |
SELDON_EXTERN template void | SolveLU (const Matrix< Real_wp, General, RowUpTriang > &, Vector< Real_wp > &, LapackInfo &) |
SELDON_EXTERN template void | SolveLU (const Matrix< Complex_wp, General, RowUpTriang > &, Vector< Complex_wp > &, LapackInfo &) |
SELDON_EXTERN template void | SolveLU (const Matrix< Real_wp, General, RowLoTriang > &, Vector< Real_wp > &, LapackInfo &) |
SELDON_EXTERN template void | SolveLU (const Matrix< Complex_wp, General, RowLoTriang > &, Vector< Complex_wp > &, LapackInfo &) |
SELDON_EXTERN template void | SolveLU (const Matrix< Real_wp, General, RowUpTriangPacked > &, Vector< Real_wp > &, LapackInfo &) |
SELDON_EXTERN template void | SolveLU (const Matrix< Complex_wp, General, RowUpTriangPacked > &, Vector< Complex_wp > &, LapackInfo &) |
SELDON_EXTERN template void | SolveLU (const Matrix< Real_wp, General, RowLoTriangPacked > &, Vector< Real_wp > &, LapackInfo &) |
SELDON_EXTERN template void | SolveLU (const Matrix< Complex_wp, General, RowLoTriangPacked > &, Vector< Complex_wp > &, LapackInfo &) |
SELDON_EXTERN template void | SolveLU (const SeldonTranspose &, const SeldonDiag &, const Matrix< Real_wp, General, RowUpTriang > &, Vector< Real_wp > &, LapackInfo &) |
SELDON_EXTERN template void | SolveLU (const SeldonTranspose &, const SeldonDiag &, const Matrix< Complex_wp, General, RowUpTriang > &, Vector< Complex_wp > &, LapackInfo &) |
SELDON_EXTERN template void | SolveLU (const SeldonTranspose &, const SeldonDiag &, const Matrix< Real_wp, General, RowLoTriang > &, Vector< Real_wp > &, LapackInfo &) |
SELDON_EXTERN template void | SolveLU (const SeldonTranspose &, const SeldonDiag &, const Matrix< Complex_wp, General, RowLoTriang > &, Vector< Complex_wp > &, LapackInfo &) |
SELDON_EXTERN template void | SolveLU (const SeldonTranspose &, const SeldonDiag &, const Matrix< Real_wp, General, RowUpTriangPacked > &, Vector< Real_wp > &, LapackInfo &) |
SELDON_EXTERN template void | SolveLU (const SeldonTranspose &, const SeldonDiag &, const Matrix< Complex_wp, General, RowUpTriangPacked > &, Vector< Complex_wp > &, LapackInfo &) |
SELDON_EXTERN template void | SolveLU (const SeldonTranspose &, const SeldonDiag &, const Matrix< Real_wp, General, RowLoTriangPacked > &, Vector< Real_wp > &, LapackInfo &) |
SELDON_EXTERN template void | SolveLU (const SeldonTranspose &, const SeldonDiag &, const Matrix< Complex_wp, General, RowLoTriangPacked > &, Vector< Complex_wp > &, LapackInfo &) |
SELDON_EXTERN template void | SolveLU (const Matrix< Real_wp, General, RowMajor > &, const Vector< int > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | SolveLU (const Matrix< Real_wp, General, ColMajor > &, const Vector< int > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | SolveLU (const SeldonTranspose &, const Matrix< Real_wp, General, RowMajor > &, const Vector< int > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | SolveLU (const SeldonTranspose &, const Matrix< Real_wp, General, ColMajor > &, const Vector< int > &, Vector< Complex_wp > &) |
SELDON_EXTERN template Real_wp | ReciprocalConditionNumber (const Matrix< Real_wp, General, ColMajor > &, Vector< int > &, SeldonNorm, Real_wp, LapackInfo &) |
SELDON_EXTERN template Real_wp | ReciprocalConditionNumber (const Matrix< Real_wp, General, RowMajor > &, Vector< int > &, SeldonNorm, Real_wp, LapackInfo &) |
SELDON_EXTERN template Real_wp | ReciprocalConditionNumber (const Matrix< Complex_wp, General, ColMajor > &, Vector< int > &, SeldonNorm, Real_wp, LapackInfo &) |
SELDON_EXTERN template Real_wp | ReciprocalConditionNumber (const Matrix< Complex_wp, General, RowMajor > &, Vector< int > &, SeldonNorm, Real_wp, LapackInfo &) |
SELDON_EXTERN template Real_wp | ReciprocalConditionNumber (const Matrix< Real_wp, Symmetric, RowSym > &, Vector< int > &, SeldonNorm, Real_wp, LapackInfo &) |
SELDON_EXTERN template Real_wp | ReciprocalConditionNumber (const Matrix< Real_wp, Symmetric, RowSymPacked > &, Vector< int > &, SeldonNorm, Real_wp, LapackInfo &) |
SELDON_EXTERN template Real_wp | ReciprocalConditionNumber (const Matrix< Complex_wp, Symmetric, RowSym > &, Vector< int > &, SeldonNorm, Real_wp, LapackInfo &) |
SELDON_EXTERN template Real_wp | ReciprocalConditionNumber (const Matrix< Complex_wp, Symmetric, RowSymPacked > &, Vector< int > &, SeldonNorm, Real_wp, LapackInfo &) |
SELDON_EXTERN template Real_wp | ReciprocalConditionNumber (const Matrix< Complex_wp, Hermitian, RowHerm > &, Vector< int > &, SeldonNorm, Real_wp, LapackInfo &) |
SELDON_EXTERN template Real_wp | ReciprocalConditionNumber (const Matrix< Complex_wp, Hermitian, RowHermPacked > &, Vector< int > &, SeldonNorm, Real_wp, LapackInfo &) |
SELDON_EXTERN template Real_wp | ReciprocalConditionNumber (const Matrix< Real_wp, General, RowUpTriang > &, SeldonNorm, LapackInfo &) |
SELDON_EXTERN template Real_wp | ReciprocalConditionNumber (const Matrix< Real_wp, General, RowLoTriang > &, SeldonNorm, LapackInfo &) |
SELDON_EXTERN template Real_wp | ReciprocalConditionNumber (const Matrix< Real_wp, General, RowUpTriangPacked > &, SeldonNorm, LapackInfo &) |
SELDON_EXTERN template Real_wp | ReciprocalConditionNumber (const Matrix< Real_wp, General, RowLoTriangPacked > &, SeldonNorm, LapackInfo &) |
SELDON_EXTERN template Real_wp | ReciprocalConditionNumber (const Matrix< Complex_wp, General, RowUpTriang > &, SeldonNorm, LapackInfo &) |
SELDON_EXTERN template Real_wp | ReciprocalConditionNumber (const Matrix< Complex_wp, General, RowLoTriang > &, SeldonNorm, LapackInfo &) |
SELDON_EXTERN template Real_wp | ReciprocalConditionNumber (const Matrix< Complex_wp, General, RowUpTriangPacked > &, SeldonNorm, LapackInfo &) |
SELDON_EXTERN template Real_wp | ReciprocalConditionNumber (const Matrix< Complex_wp, General, RowLoTriangPacked > &, SeldonNorm, LapackInfo &) |
SELDON_EXTERN template Real_wp | ReciprocalConditionNumber (const SeldonDiag &, const Matrix< Real_wp, General, RowUpTriang > &, SeldonNorm, LapackInfo &) |
SELDON_EXTERN template Real_wp | ReciprocalConditionNumber (const SeldonDiag &, const Matrix< Real_wp, General, RowLoTriang > &, SeldonNorm, LapackInfo &) |
SELDON_EXTERN template Real_wp | ReciprocalConditionNumber (const SeldonDiag &, const Matrix< Real_wp, General, RowUpTriangPacked > &, SeldonNorm, LapackInfo &) |
SELDON_EXTERN template Real_wp | ReciprocalConditionNumber (const SeldonDiag &, const Matrix< Real_wp, General, RowLoTriangPacked > &, SeldonNorm, LapackInfo &) |
SELDON_EXTERN template Real_wp | ReciprocalConditionNumber (const SeldonDiag &, const Matrix< Complex_wp, General, RowUpTriang > &, SeldonNorm, LapackInfo &) |
SELDON_EXTERN template Real_wp | ReciprocalConditionNumber (const SeldonDiag &, const Matrix< Complex_wp, General, RowLoTriang > &, SeldonNorm, LapackInfo &) |
SELDON_EXTERN template Real_wp | ReciprocalConditionNumber (const SeldonDiag &, const Matrix< Complex_wp, General, RowUpTriangPacked > &, SeldonNorm, LapackInfo &) |
SELDON_EXTERN template Real_wp | ReciprocalConditionNumber (const SeldonDiag &, const Matrix< Complex_wp, General, RowLoTriangPacked > &, SeldonNorm, LapackInfo &) |
SELDON_EXTERN template void | RefineSolutionLU (const Matrix< Real_wp, General, ColMajor > &, const Matrix< Real_wp, General, ColMajor > &, const Vector< int > &, Vector< Real_wp > &, const Vector< Real_wp > &, Real_wp &, Real_wp &, LapackInfo &) |
SELDON_EXTERN template void | RefineSolutionLU (const Matrix< Real_wp, General, RowMajor > &, const Matrix< Real_wp, General, RowMajor > &, const Vector< int > &, Vector< Real_wp > &, const Vector< Real_wp > &, Real_wp &, Real_wp &, LapackInfo &) |
SELDON_EXTERN template void | RefineSolutionLU (const Matrix< Complex_wp, General, RowMajor > &, const Matrix< Complex_wp, General, RowMajor > &, const Vector< int > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, Real_wp &, Real_wp &, LapackInfo &) |
SELDON_EXTERN template void | RefineSolutionLU (const Matrix< Complex_wp, General, ColMajor > &, const Matrix< Complex_wp, General, ColMajor > &, const Vector< int > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, Real_wp &, Real_wp &, LapackInfo &) |
SELDON_EXTERN template void | RefineSolutionLU (const SeldonTranspose &, const Matrix< Real_wp, General, ColMajor > &, const Matrix< Real_wp, General, ColMajor > &, const Vector< int > &, Vector< Real_wp > &, const Vector< Real_wp > &, Real_wp &, Real_wp &, LapackInfo &) |
SELDON_EXTERN template void | RefineSolutionLU (const SeldonTranspose &, const Matrix< Real_wp, General, RowMajor > &, const Matrix< Real_wp, General, RowMajor > &, const Vector< int > &, Vector< Real_wp > &, const Vector< Real_wp > &, Real_wp &, Real_wp &, LapackInfo &) |
SELDON_EXTERN template void | RefineSolutionLU (const SeldonTranspose &, const Matrix< Complex_wp, General, ColMajor > &, const Matrix< Complex_wp, General, ColMajor > &, const Vector< int > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, Real_wp &, Real_wp &, LapackInfo &) |
SELDON_EXTERN template void | RefineSolutionLU (const SeldonTranspose &, const Matrix< Complex_wp, General, RowMajor > &, const Matrix< Complex_wp, General, RowMajor > &, const Vector< int > &, Vector< Complex_wp > &, Vector< Complex_wp > &, Real_wp &, Real_wp &, LapackInfo &) |
SELDON_EXTERN template void | RefineSolutionLU (const Matrix< Real_wp, Symmetric, RowSym > &, const Matrix< Real_wp, Symmetric, RowSym > &, const Vector< int > &, Vector< Real_wp > &, const Vector< Real_wp > &, Real_wp &, Real_wp &, LapackInfo &) |
SELDON_EXTERN template void | RefineSolutionLU (const Matrix< Real_wp, Symmetric, RowSymPacked > &, const Matrix< Real_wp, Symmetric, RowSymPacked > &, const Vector< int > &, Vector< Real_wp > &, const Vector< Real_wp > &, Real_wp &, Real_wp &, LapackInfo &) |
SELDON_EXTERN template void | RefineSolutionLU (const Matrix< Complex_wp, Symmetric, RowSym > &, const Matrix< Complex_wp, Symmetric, RowSym > &, const Vector< int > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, Real_wp &, Real_wp &, LapackInfo &) |
SELDON_EXTERN template void | RefineSolutionLU (const Matrix< Complex_wp, Symmetric, RowSymPacked > &, const Matrix< Complex_wp, Symmetric, RowSymPacked > &, const Vector< int > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, Real_wp &, Real_wp &, LapackInfo &) |
SELDON_EXTERN template void | RefineSolutionLU (const Matrix< Complex_wp, Hermitian, RowHerm > &, const Matrix< Complex_wp, Hermitian, RowHerm > &, const Vector< int > &, Vector< Complex_wp > &, Vector< Complex_wp > &, Real_wp &, Real_wp &, LapackInfo &) |
SELDON_EXTERN template void | RefineSolutionLU (const Matrix< Complex_wp, Hermitian, RowHermPacked > &, const Matrix< Complex_wp, Hermitian, RowHermPacked > &, const Vector< int > &, Vector< Complex_wp > &, Vector< Complex_wp > &, Real_wp &, Real_wp &, LapackInfo &) |
SELDON_EXTERN template void | RefineSolutionLU (const Matrix< Real_wp, General, RowUpTriang > &, Vector< Real_wp > &, const Vector< Real_wp > &, Real_wp &, Real_wp &, LapackInfo &) |
SELDON_EXTERN template void | RefineSolutionLU (const Matrix< Real_wp, General, RowLoTriang > &, Vector< Real_wp > &, const Vector< Real_wp > &, Real_wp &, Real_wp &, LapackInfo &) |
SELDON_EXTERN template void | RefineSolutionLU (const Matrix< Real_wp, General, RowUpTriangPacked > &, Vector< Real_wp > &, const Vector< Real_wp > &, Real_wp &, Real_wp &, LapackInfo &) |
SELDON_EXTERN template void | RefineSolutionLU (const Matrix< Real_wp, General, RowLoTriangPacked > &, Vector< Real_wp > &, const Vector< Real_wp > &, Real_wp &, Real_wp &, LapackInfo &) |
SELDON_EXTERN template void | RefineSolutionLU (const SeldonTranspose &, const SeldonDiag &, const Matrix< Real_wp, General, RowUpTriang > &, Vector< Real_wp > &, const Vector< Real_wp > &, Real_wp &, Real_wp &, LapackInfo &) |
SELDON_EXTERN template void | RefineSolutionLU (const SeldonTranspose &, const SeldonDiag &, const Matrix< Real_wp, General, RowLoTriang > &, Vector< Real_wp > &, const Vector< Real_wp > &, Real_wp &, Real_wp &, LapackInfo &) |
SELDON_EXTERN template void | RefineSolutionLU (const SeldonTranspose &, const SeldonDiag &, const Matrix< Real_wp, General, RowUpTriangPacked > &, Vector< Real_wp > &, const Vector< Real_wp > &, Real_wp &, Real_wp &, LapackInfo &) |
SELDON_EXTERN template void | RefineSolutionLU (const SeldonTranspose &, const SeldonDiag &, const Matrix< Real_wp, General, RowLoTriangPacked > &, Vector< Real_wp > &, const Vector< Real_wp > &, Real_wp &, Real_wp &, LapackInfo &) |
SELDON_EXTERN template void | RefineSolutionLU (const Matrix< Complex_wp, General, RowUpTriang > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, Real_wp &, Real_wp &, LapackInfo &) |
SELDON_EXTERN template void | RefineSolutionLU (const Matrix< Complex_wp, General, RowLoTriang > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, Real_wp &, Real_wp &, LapackInfo &) |
SELDON_EXTERN template void | RefineSolutionLU (const Matrix< Complex_wp, General, RowUpTriangPacked > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, Real_wp &, Real_wp &, LapackInfo &) |
SELDON_EXTERN template void | RefineSolutionLU (const Matrix< Complex_wp, General, RowLoTriangPacked > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, Real_wp &, Real_wp &, LapackInfo &) |
SELDON_EXTERN template void | RefineSolutionLU (const SeldonTranspose &, const SeldonDiag &, const Matrix< Complex_wp, General, RowUpTriang > &, Vector< Complex_wp > &, Vector< Complex_wp > &, Real_wp &, Real_wp &, LapackInfo &) |
SELDON_EXTERN template void | RefineSolutionLU (const SeldonTranspose &, const SeldonDiag &, const Matrix< Complex_wp, General, RowLoTriang > &, Vector< Complex_wp > &, Vector< Complex_wp > &, Real_wp &, Real_wp &, LapackInfo &) |
SELDON_EXTERN template void | RefineSolutionLU (const SeldonTranspose &, const SeldonDiag &, const Matrix< Complex_wp, General, RowUpTriangPacked > &, Vector< Complex_wp > &, Vector< Complex_wp > &, Real_wp &, Real_wp &, LapackInfo &) |
SELDON_EXTERN template void | RefineSolutionLU (const SeldonTranspose &, const SeldonDiag &, const Matrix< Complex_wp, General, RowLoTriangPacked > &, Vector< Complex_wp > &, Vector< Complex_wp > &, Real_wp &, Real_wp &, LapackInfo &) |
SELDON_EXTERN template void | GetInverse (Matrix< Real_wp, General, ColMajor > &, LapackInfo &) |
SELDON_EXTERN template void | GetInverse (Matrix< Complex_wp, General, ColMajor > &, LapackInfo &) |
SELDON_EXTERN template void | GetInverse (Matrix< Real_wp, General, RowMajor > &, LapackInfo &) |
SELDON_EXTERN template void | GetInverse (Matrix< Complex_wp, General, RowMajor > &, LapackInfo &) |
SELDON_EXTERN template void | GetInverse (Matrix< Real_wp, Symmetric, RowSym > &, LapackInfo &) |
SELDON_EXTERN template void | GetInverse (Matrix< Complex_wp, Symmetric, RowSym > &, LapackInfo &) |
SELDON_EXTERN template void | GetInverse (Matrix< Real_wp, Symmetric, RowSymPacked > &, LapackInfo &) |
SELDON_EXTERN template void | GetInverse (Matrix< Complex_wp, Symmetric, RowSymPacked > &, LapackInfo &) |
SELDON_EXTERN template void | GetInverse (Matrix< Complex_wp, Hermitian, RowHerm > &, LapackInfo &) |
SELDON_EXTERN template void | GetInverse (Matrix< Complex_wp, Hermitian, RowHermPacked > &, LapackInfo &) |
SELDON_EXTERN template void | GetInverse (Matrix< Real_wp, General, RowUpTriang > &, LapackInfo &) |
SELDON_EXTERN template void | GetInverse (Matrix< Complex_wp, General, RowUpTriang > &, LapackInfo &) |
SELDON_EXTERN template void | GetInverse (Matrix< Real_wp, General, RowLoTriang > &, LapackInfo &) |
SELDON_EXTERN template void | GetInverse (Matrix< Complex_wp, General, RowLoTriang > &, LapackInfo &) |
SELDON_EXTERN template void | GetInverse (Matrix< Real_wp, General, RowUpTriangPacked > &, LapackInfo &) |
SELDON_EXTERN template void | GetInverse (Matrix< Complex_wp, General, RowUpTriangPacked > &, LapackInfo &) |
SELDON_EXTERN template void | GetInverse (Matrix< Real_wp, General, RowLoTriangPacked > &, LapackInfo &) |
SELDON_EXTERN template void | GetInverse (Matrix< Complex_wp, General, RowLoTriangPacked > &, LapackInfo &) |
SELDON_EXTERN template void | GetInverse (const SeldonDiag &, Matrix< Real_wp, General, RowUpTriang > &, LapackInfo &) |
SELDON_EXTERN template void | GetInverse (const SeldonDiag &, Matrix< Complex_wp, General, RowUpTriang > &, LapackInfo &) |
SELDON_EXTERN template void | GetInverse (const SeldonDiag &, Matrix< Real_wp, General, RowLoTriang > &, LapackInfo &) |
SELDON_EXTERN template void | GetInverse (const SeldonDiag &, Matrix< Complex_wp, General, RowLoTriang > &, LapackInfo &) |
SELDON_EXTERN template void | GetInverse (const SeldonDiag &, Matrix< Real_wp, General, RowUpTriangPacked > &, LapackInfo &) |
SELDON_EXTERN template void | GetInverse (const SeldonDiag &, Matrix< Complex_wp, General, RowUpTriangPacked > &, LapackInfo &) |
SELDON_EXTERN template void | GetInverse (const SeldonDiag &, Matrix< Real_wp, General, RowLoTriangPacked > &, LapackInfo &) |
SELDON_EXTERN template void | GetInverse (const SeldonDiag &, Matrix< Complex_wp, General, RowLoTriangPacked > &, LapackInfo &) |
SELDON_EXTERN template void | GetScalingFactors (const Matrix< Real_wp, General, ColMajor > &, Vector< Real_wp > &, Vector< Real_wp > &, Real_wp &, Real_wp &, Real_wp &, LapackInfo &) |
SELDON_EXTERN template void | GetScalingFactors (const Matrix< Real_wp, General, RowMajor > &, Vector< Real_wp > &, Vector< Real_wp > &, Real_wp &, Real_wp &, Real_wp &, LapackInfo &) |
SELDON_EXTERN template void | GetScalingFactors (const Matrix< Complex_wp, General, ColMajor > &, Vector< Real_wp > &, Vector< Real_wp > &, Real_wp &, Real_wp &, Real_wp &, LapackInfo &) |
SELDON_EXTERN template void | GetScalingFactors (const Matrix< Complex_wp, General, RowMajor > &, Vector< Real_wp > &, Vector< Real_wp > &, Real_wp &, Real_wp &, Real_wp &, LapackInfo &) |
SELDON_EXTERN template void | GetCholesky (Matrix< Real_wp, Symmetric, RowSym > &, LapackInfo &) |
SELDON_EXTERN template void | GetCholesky (Matrix< Real_wp, Symmetric, RowSymPacked > &, LapackInfo &) |
SELDON_EXTERN template void | GetCholesky (Matrix< Complex_wp, Hermitian, RowHerm > &, LapackInfo &) |
SELDON_EXTERN template void | GetCholesky (Matrix< Complex_wp, Hermitian, RowHermPacked > &, LapackInfo &) |
SELDON_EXTERN template void | SolveCholesky (const SeldonTranspose &, const Matrix< Real_wp, Symmetric, RowSym > &, Vector< Real_wp > &, LapackInfo &) |
SELDON_EXTERN template void | SolveCholesky (const SeldonTranspose &, const Matrix< Real_wp, Symmetric, RowSymPacked > &, Vector< Real_wp > &, LapackInfo &) |
SELDON_EXTERN template void | SolveCholesky (const SeldonTranspose &, const Matrix< Complex_wp, Hermitian, RowHerm > &, Vector< Complex_wp > &, LapackInfo &) |
SELDON_EXTERN template void | SolveCholesky (const SeldonTranspose &, const Matrix< Complex_wp, Hermitian, RowHermPacked > &, Vector< Complex_wp > &, LapackInfo &) |
SELDON_EXTERN template void | MltCholesky (const SeldonTranspose &, const Matrix< Real_wp, Symmetric, RowSym > &, Vector< Real_wp > &, LapackInfo &) |
SELDON_EXTERN template void | MltCholesky (const SeldonTranspose &, const Matrix< Real_wp, Symmetric, RowSymPacked > &, Vector< Real_wp > &, LapackInfo &) |
SELDON_EXTERN template void | MltCholesky (const SeldonTranspose &, const Matrix< Complex_wp, Hermitian, RowHerm > &, Vector< Complex_wp > &, LapackInfo &) |
SELDON_EXTERN template void | MltCholesky (const SeldonTranspose &, const Matrix< Complex_wp, Hermitian, RowHermPacked > &, Vector< Complex_wp > &, LapackInfo &) |
SELDON_EXTERN template void | GetQR (Matrix< Real_wp, General, ColMajor > &, Vector< Real_wp > &, LapackInfo &) |
SELDON_EXTERN template void | GetQR (Matrix< Complex_wp, General, ColMajor > &, Vector< Complex_wp > &, LapackInfo &) |
SELDON_EXTERN template void | GetQR (Matrix< Real_wp, General, RowMajor > &, Vector< Real_wp > &, LapackInfo &) |
SELDON_EXTERN template void | GetQR (Matrix< Complex_wp, General, RowMajor > &, Vector< Complex_wp > &, LapackInfo &) |
SELDON_EXTERN template void | GetLQ (Matrix< Real_wp, General, ColMajor > &, Vector< Real_wp > &, LapackInfo &) |
SELDON_EXTERN template void | GetLQ (Matrix< Complex_wp, General, ColMajor > &, Vector< Complex_wp > &, LapackInfo &) |
SELDON_EXTERN template void | GetLQ (Matrix< Real_wp, General, RowMajor > &, Vector< Real_wp > &, LapackInfo &) |
SELDON_EXTERN template void | GetLQ (Matrix< Complex_wp, General, RowMajor > &, Vector< Complex_wp > &, LapackInfo &) |
SELDON_EXTERN template void | GetQ_FromQR (Matrix< Real_wp, General, ColMajor > &, Vector< Real_wp > &, LapackInfo &) |
SELDON_EXTERN template void | GetQ_FromQR (Matrix< Complex_wp, General, ColMajor > &, Vector< Complex_wp > &, LapackInfo &) |
SELDON_EXTERN template void | GetQ_FromQR (Matrix< Real_wp, General, RowMajor > &, Vector< Real_wp > &, LapackInfo &) |
SELDON_EXTERN template void | GetQ_FromQR (Matrix< Complex_wp, General, RowMajor > &, Vector< Complex_wp > &, LapackInfo &) |
SELDON_EXTERN template void | GetQ_FromLQ (Matrix< Real_wp, General, ColMajor > &, Vector< Real_wp > &, LapackInfo &) |
SELDON_EXTERN template void | GetQ_FromLQ (Matrix< Complex_wp, General, ColMajor > &, Vector< Complex_wp > &, LapackInfo &) |
SELDON_EXTERN template void | GetQ_FromLQ (Matrix< Real_wp, General, RowMajor > &, Vector< Real_wp > &, LapackInfo &) |
SELDON_EXTERN template void | GetQ_FromLQ (Matrix< Complex_wp, General, RowMajor > &, Vector< Complex_wp > &, LapackInfo &) |
SELDON_EXTERN template void | MltQ_FromQR (const SeldonTranspose &, const Matrix< Real_wp, General, ColMajor > &, const Vector< Real_wp > &, Vector< Real_wp > &, LapackInfo &) |
SELDON_EXTERN template void | MltQ_FromQR (const SeldonTranspose &, const Matrix< Complex_wp, General, ColMajor > &, const Vector< Complex_wp > &, Vector< Complex_wp > &, LapackInfo &) |
SELDON_EXTERN template void | MltQ_FromQR (const SeldonTranspose &, const Matrix< Real_wp, General, RowMajor > &, const Vector< Real_wp > &, Vector< Real_wp > &, LapackInfo &) |
SELDON_EXTERN template void | MltQ_FromQR (const SeldonTranspose &, const Matrix< Complex_wp, General, RowMajor > &, const Vector< Complex_wp > &, Vector< Complex_wp > &, LapackInfo &) |
SELDON_EXTERN template void | MltQ_FromQR (const SeldonSide &, const SeldonTranspose &, const Matrix< Real_wp, General, ColMajor > &, const Vector< Real_wp > &, Matrix< Real_wp, General, ColMajor > &, LapackInfo &) |
SELDON_EXTERN template void | MltQ_FromQR (const SeldonSide &, const SeldonTranspose &, const Matrix< Complex_wp, General, ColMajor > &, const Vector< Complex_wp > &, Matrix< Complex_wp, General, ColMajor > &, LapackInfo &) |
SELDON_EXTERN template void | MltQ_FromQR (const SeldonSide &, const SeldonTranspose &, const Matrix< Real_wp, General, RowMajor > &, const Vector< Real_wp > &, Matrix< Real_wp, General, RowMajor > &, LapackInfo &) |
SELDON_EXTERN template void | MltQ_FromQR (const SeldonSide &, const SeldonTranspose &, const Matrix< Complex_wp, General, RowMajor > &, const Vector< Complex_wp > &, Matrix< Complex_wp, General, RowMajor > &, LapackInfo &) |
SELDON_EXTERN template void | MltQ_FromLQ (const SeldonTranspose &, const Matrix< Real_wp, General, ColMajor > &, const Vector< Real_wp > &, Vector< Real_wp > &, LapackInfo &) |
SELDON_EXTERN template void | MltQ_FromLQ (const SeldonTranspose &, const Matrix< Complex_wp, General, ColMajor > &, const Vector< Complex_wp > &, Vector< Complex_wp > &, LapackInfo &) |
SELDON_EXTERN template void | MltQ_FromLQ (const SeldonTranspose &, const Matrix< Real_wp, General, RowMajor > &, const Vector< Real_wp > &, Vector< Real_wp > &, LapackInfo &) |
SELDON_EXTERN template void | MltQ_FromLQ (const SeldonTranspose &, const Matrix< Complex_wp, General, RowMajor > &, const Vector< Complex_wp > &, Vector< Complex_wp > &, LapackInfo &) |
SELDON_EXTERN template void | MltQ_FromLQ (const SeldonSide &, const SeldonTranspose &, const Matrix< Real_wp, General, ColMajor > &, const Vector< Real_wp > &, Matrix< Real_wp, General, ColMajor > &, LapackInfo &) |
SELDON_EXTERN template void | MltQ_FromLQ (const SeldonSide &, const SeldonTranspose &, const Matrix< Complex_wp, General, ColMajor > &, const Vector< Complex_wp > &, Matrix< Complex_wp, General, ColMajor > &, LapackInfo &) |
SELDON_EXTERN template void | MltQ_FromLQ (const SeldonSide &, const SeldonTranspose &, const Matrix< Real_wp, General, RowMajor > &, const Vector< Real_wp > &, Matrix< Real_wp, General, RowMajor > &, LapackInfo &) |
SELDON_EXTERN template void | MltQ_FromLQ (const SeldonSide &, const SeldonTranspose &, const Matrix< Complex_wp, General, RowMajor > &, const Vector< Complex_wp > &, Matrix< Complex_wp, General, RowMajor > &, LapackInfo &) |
SELDON_EXTERN template void | SolveQR (const Matrix< Real_wp, General, ColMajor > &, const Vector< Real_wp > &, Vector< Real_wp > &, LapackInfo &) |
SELDON_EXTERN template void | SolveQR (const Matrix< Complex_wp, General, ColMajor > &, const Vector< Complex_wp > &, Vector< Complex_wp > &, LapackInfo &) |
SELDON_EXTERN template void | SolveQR (const Matrix< Real_wp, General, RowMajor > &, const Vector< Real_wp > &, Vector< Real_wp > &, LapackInfo &) |
SELDON_EXTERN template void | SolveQR (const Matrix< Complex_wp, General, RowMajor > &, const Vector< Complex_wp > &, Vector< Complex_wp > &, LapackInfo &) |
SELDON_EXTERN template void | SolveLQ (const Matrix< Real_wp, General, ColMajor > &, const Vector< Real_wp > &, Vector< Real_wp > &, LapackInfo &) |
SELDON_EXTERN template void | SolveLQ (const Matrix< Complex_wp, General, ColMajor > &, const Vector< Complex_wp > &, Vector< Complex_wp > &, LapackInfo &) |
SELDON_EXTERN template void | SolveLQ (const Matrix< Real_wp, General, RowMajor > &, const Vector< Real_wp > &, Vector< Real_wp > &, LapackInfo &) |
SELDON_EXTERN template void | SolveLQ (const Matrix< Complex_wp, General, RowMajor > &, const Vector< Complex_wp > &, Vector< Complex_wp > &, LapackInfo &) |
SELDON_EXTERN template void | GetLowerTriangular (const Matrix< Real_wp, General, ColMajor > &, Matrix< Real_wp, General, ColMajor > &) |
SELDON_EXTERN template void | GetLowerTriangular (const Matrix< Complex_wp, General, ColMajor > &, Matrix< Complex_wp, General, ColMajor > &) |
SELDON_EXTERN template void | GetLowerTriangular (const Matrix< Real_wp, General, RowMajor > &, Matrix< Real_wp, General, RowMajor > &) |
SELDON_EXTERN template void | GetLowerTriangular (const Matrix< Complex_wp, General, RowMajor > &, Matrix< Complex_wp, General, RowMajor > &) |
SELDON_EXTERN template void | GetUpperTriangular (const Matrix< Real_wp, General, ColMajor > &, Matrix< Real_wp, General, ColMajor > &) |
SELDON_EXTERN template void | GetUpperTriangular (const Matrix< Complex_wp, General, ColMajor > &, Matrix< Complex_wp, General, ColMajor > &) |
SELDON_EXTERN template void | GetUpperTriangular (const Matrix< Real_wp, General, RowMajor > &, Matrix< Real_wp, General, RowMajor > &) |
SELDON_EXTERN template void | GetUpperTriangular (const Matrix< Complex_wp, General, RowMajor > &, Matrix< Complex_wp, General, RowMajor > &) |
SELDON_EXTERN template void | GetQR (const Matrix< Real_wp, General, ColMajor > &, Matrix< Real_wp, General, ColMajor > &, Matrix< Real_wp, General, ColMajor > &) |
SELDON_EXTERN template void | GetQR (const Matrix< Complex_wp, General, ColMajor > &, Matrix< Complex_wp, General, ColMajor > &, Matrix< Complex_wp, General, ColMajor > &) |
SELDON_EXTERN template void | GetQR (const Matrix< Real_wp, General, RowMajor > &, Matrix< Real_wp, General, RowMajor > &, Matrix< Real_wp, General, RowMajor > &) |
SELDON_EXTERN template void | GetQR (const Matrix< Complex_wp, General, RowMajor > &, Matrix< Complex_wp, General, RowMajor > &, Matrix< Complex_wp, General, RowMajor > &) |
SELDON_EXTERN template void | GetLQ (const Matrix< Real_wp, General, ColMajor > &, Matrix< Real_wp, General, ColMajor > &, Matrix< Real_wp, General, ColMajor > &) |
SELDON_EXTERN template void | GetLQ (const Matrix< Complex_wp, General, ColMajor > &, Matrix< Complex_wp, General, ColMajor > &, Matrix< Complex_wp, General, ColMajor > &) |
SELDON_EXTERN template void | GetLQ (const Matrix< Real_wp, General, RowMajor > &, Matrix< Real_wp, General, RowMajor > &, Matrix< Real_wp, General, RowMajor > &) |
SELDON_EXTERN template void | GetLQ (const Matrix< Complex_wp, General, RowMajor > &, Matrix< Complex_wp, General, RowMajor > &, Matrix< Complex_wp, General, RowMajor > &) |
SELDON_EXTERN template void | GetEigenvalues (Matrix< Real_wp, General, ColMajor > &, Vector< Real_wp > &, Vector< Real_wp > &, LapackInfo &info) |
SELDON_EXTERN template void | GetEigenvalues (Matrix< Real_wp, General, RowMajor > &, Vector< Real_wp > &, Vector< Real_wp > &, LapackInfo &info) |
SELDON_EXTERN template void | GetEigenvalues (Matrix< Complex_wp, General, ColMajor > &, Vector< Complex_wp > &, LapackInfo &info) |
SELDON_EXTERN template void | GetEigenvalues (Matrix< Complex_wp, General, RowMajor > &, Vector< Complex_wp > &, LapackInfo &info) |
SELDON_EXTERN template void | GetEigenvaluesEigenvectors (Matrix< Real_wp, General, ColMajor > &, Vector< Real_wp > &, Vector< Real_wp > &, Matrix< Real_wp, General, ColMajor > &, LapackInfo &info) |
SELDON_EXTERN template void | GetEigenvaluesEigenvectors (Matrix< Real_wp, General, RowMajor > &, Vector< Real_wp > &, Vector< Real_wp > &, Matrix< Real_wp, General, RowMajor > &, LapackInfo &info) |
SELDON_EXTERN template void | GetEigenvaluesEigenvectors (Matrix< Complex_wp, General, ColMajor > &, Vector< Complex_wp > &, Matrix< Complex_wp, General, ColMajor > &, LapackInfo &info) |
SELDON_EXTERN template void | GetEigenvaluesEigenvectors (Matrix< Complex_wp, General, RowMajor > &, Vector< Complex_wp > &, Matrix< Complex_wp, General, RowMajor > &, LapackInfo &info) |
SELDON_EXTERN template void | GetEigenvalues (Matrix< Real_wp, Symmetric, RowSym > &, Vector< Real_wp > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvalues (Matrix< Complex_wp, Symmetric, RowSym > &, Vector< Complex_wp > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvaluesEigenvectors (Matrix< Real_wp, Symmetric, RowSym > &, Vector< Real_wp > &, Matrix< Real_wp, General, RowMajor > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvaluesEigenvectors (Matrix< Complex_wp, Symmetric, RowSym > &, Vector< Complex_wp > &, Matrix< Complex_wp, General, RowMajor > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvalues (Matrix< Real_wp, Symmetric, RowSymPacked > &, Vector< Real_wp > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvalues (Matrix< Complex_wp, Symmetric, RowSymPacked > &, Vector< Complex_wp > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvaluesEigenvectors (Matrix< Real_wp, Symmetric, RowSymPacked > &, Vector< Real_wp > &, Matrix< Real_wp, General, RowMajor > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvaluesEigenvectors (Matrix< Complex_wp, Symmetric, RowSymPacked > &, Vector< Complex_wp > &, Matrix< Complex_wp, General, RowMajor > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvalues (Matrix< Complex_wp, Hermitian, RowHerm > &, Vector< Real_wp > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvaluesEigenvectors (Matrix< Complex_wp, Hermitian, RowHerm > &, Vector< Real_wp > &, Matrix< Complex_wp, General, RowMajor > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvalues (Matrix< Complex_wp, Hermitian, RowHermPacked > &, Vector< Real_wp > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvaluesEigenvectors (Matrix< Complex_wp, Hermitian, RowHermPacked > &, Vector< Real_wp > &, Matrix< Complex_wp, General, RowMajor > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvalues (Matrix< Real_wp, Symmetric, RowSym > &, Matrix< Real_wp, Symmetric, RowSym > &, Vector< Real_wp > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvaluesEigenvectors (Matrix< Real_wp, Symmetric, RowSym > &, Matrix< Real_wp, Symmetric, RowSym > &, Vector< Real_wp > &, Matrix< Real_wp, General, RowMajor > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvalues (Matrix< Complex_wp, Symmetric, RowSym > &, Matrix< Complex_wp, Symmetric, RowSym > &, Vector< Complex_wp > &, Vector< Complex_wp > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvaluesEigenvectors (Matrix< Complex_wp, Symmetric, RowSym > &, Matrix< Complex_wp, Symmetric, RowSym > &, Vector< Complex_wp > &, Vector< Complex_wp > &, Matrix< Complex_wp, General, RowMajor > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvalues (Matrix< Real_wp, Symmetric, RowSymPacked > &, Matrix< Real_wp, Symmetric, RowSymPacked > &, Vector< Real_wp > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvaluesEigenvectors (Matrix< Real_wp, Symmetric, RowSymPacked > &, Matrix< Real_wp, Symmetric, RowSymPacked > &, Vector< Real_wp > &, Matrix< Real_wp, General, RowMajor > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvalues (Matrix< Complex_wp, Symmetric, RowSymPacked > &, Matrix< Complex_wp, Symmetric, RowSymPacked > &, Vector< Complex_wp > &, Vector< Complex_wp > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvaluesEigenvectors (Matrix< Complex_wp, Symmetric, RowSymPacked > &, Matrix< Complex_wp, Symmetric, RowSymPacked > &, Vector< Complex_wp > &, Vector< Complex_wp > &, Matrix< Complex_wp, General, RowMajor > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvalues (Matrix< Complex_wp, Hermitian, RowHerm > &, Matrix< Complex_wp, Hermitian, RowHerm > &, Vector< Real_wp > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvaluesEigenvectors (Matrix< Complex_wp, Hermitian, RowHerm > &, Matrix< Complex_wp, Hermitian, RowHerm > &, Vector< Real_wp > &, Matrix< Complex_wp, General, RowMajor > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvalues (Matrix< Complex_wp, Hermitian, RowHermPacked > &, Matrix< Complex_wp, Hermitian, RowHermPacked > &, Vector< Real_wp > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvaluesEigenvectors (Matrix< Complex_wp, Hermitian, RowHermPacked > &, Matrix< Complex_wp, Hermitian, RowHermPacked > &, Vector< Real_wp > &, Matrix< Complex_wp, General, RowMajor > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvalues (Matrix< Real_wp, General, ColMajor > &, Matrix< Real_wp, General, ColMajor > &, Vector< Real_wp > &, Vector< Real_wp > &, Vector< Real_wp > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvalues (Matrix< Real_wp, General, RowMajor > &, Matrix< Real_wp, General, RowMajor > &, Vector< Real_wp > &, Vector< Real_wp > &, Vector< Real_wp > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvaluesEigenvectors (Matrix< Real_wp, General, ColMajor > &, Matrix< Real_wp, General, ColMajor > &, Vector< Real_wp > &, Vector< Real_wp > &, Vector< Real_wp > &, Matrix< Real_wp, General, ColMajor > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvaluesEigenvectors (Matrix< Real_wp, General, RowMajor > &, Matrix< Real_wp, General, RowMajor > &, Vector< Real_wp > &, Vector< Real_wp > &, Vector< Real_wp > &, Matrix< Real_wp, General, RowMajor > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvalues (Matrix< Complex_wp, General, ColMajor > &, Matrix< Complex_wp, General, ColMajor > &, Vector< Complex_wp > &, Vector< Complex_wp > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvalues (Matrix< Complex_wp, General, RowMajor > &, Matrix< Complex_wp, General, RowMajor > &, Vector< Complex_wp > &, Vector< Complex_wp > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvaluesEigenvectors (Matrix< Complex_wp, General, ColMajor > &, Matrix< Complex_wp, General, ColMajor > &, Vector< Complex_wp > &, Vector< Complex_wp > &, Matrix< Complex_wp, General, ColMajor > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvaluesEigenvectors (Matrix< Complex_wp, General, RowMajor > &, Matrix< Complex_wp, General, RowMajor > &, Vector< Complex_wp > &, Vector< Complex_wp > &, Matrix< Complex_wp, General, RowMajor > &, LapackInfo &) |
SELDON_EXTERN template void | GetSVD (Matrix< Real_wp, General, ColMajor > &, Vector< Real_wp > &, Matrix< Real_wp, General, ColMajor > &, Matrix< Real_wp, General, ColMajor > &, LapackInfo &) |
SELDON_EXTERN template void | GetSVD (Matrix< Real_wp, General, RowMajor > &, Vector< Real_wp > &, Matrix< Real_wp, General, RowMajor > &, Matrix< Real_wp, General, RowMajor > &, LapackInfo &) |
SELDON_EXTERN template void | GetSVD (Matrix< Complex_wp, General, ColMajor > &, Vector< Real_wp > &, Matrix< Complex_wp, General, ColMajor > &, Matrix< Complex_wp, General, ColMajor > &, LapackInfo &) |
SELDON_EXTERN template void | GetSVD (Matrix< Complex_wp, General, RowMajor > &, Vector< Real_wp > &, Matrix< Complex_wp, General, RowMajor > &, Matrix< Complex_wp, General, RowMajor > &, LapackInfo &) |
SELDON_EXTERN template void | GetPseudoInverse (Matrix< Real_wp, General, ColMajor > &, const Real_wp &, LapackInfo &) |
SELDON_EXTERN template void | GetPseudoInverse (Matrix< Real_wp, General, RowMajor > &, const Real_wp &, LapackInfo &) |
SELDON_EXTERN template void | GetPseudoInverse (Matrix< Complex_wp, General, ColMajor > &, const Real_wp &, LapackInfo &) |
SELDON_EXTERN template void | GetPseudoInverse (Matrix< Complex_wp, General, RowMajor > &, const Real_wp &, LapackInfo &) |
SELDON_EXTERN template void | GetHessenberg (Matrix< Complex_wp, General, ColMajor > &, Matrix< Complex_wp, General, ColMajor > &, LapackInfo &) |
SELDON_EXTERN template void | GetHessenberg (Matrix< Complex_wp, General, RowMajor > &, Matrix< Complex_wp, General, RowMajor > &, LapackInfo &) |
SELDON_EXTERN template void | GetHessenberg (Matrix< Complex_wp, General, ColMajor > &, Matrix< Complex_wp, General, ColMajor > &, Matrix< Complex_wp, General, ColMajor > &, Matrix< Complex_wp, General, ColMajor > &, LapackInfo &) |
SELDON_EXTERN template void | GetHessenberg (Matrix< Complex_wp, General, RowMajor > &, Matrix< Complex_wp, General, RowMajor > &, Matrix< Complex_wp, General, RowMajor > &, Matrix< Complex_wp, General, RowMajor > &, LapackInfo &) |
SELDON_EXTERN template void | GetQZ (Matrix< Complex_wp, General, ColMajor > &, Matrix< Complex_wp, General, ColMajor > &, Matrix< Complex_wp, General, ColMajor > &, Matrix< Complex_wp, General, ColMajor > &, LapackInfo &) |
SELDON_EXTERN template void | GetQZ (Matrix< Complex_wp, General, RowMajor > &, Matrix< Complex_wp, General, RowMajor > &, Matrix< Complex_wp, General, RowMajor > &, Matrix< Complex_wp, General, RowMajor > &, LapackInfo &) |
SELDON_EXTERN template void | GetHessenberg (Matrix< Real_wp, General, ColMajor > &, Matrix< Real_wp, General, ColMajor > &, LapackInfo &) |
SELDON_EXTERN template void | GetHessenberg (Matrix< Real_wp, General, RowMajor > &, Matrix< Real_wp, General, RowMajor > &, LapackInfo &) |
SELDON_EXTERN template void | GetHessenberg (Matrix< Real_wp, General, ColMajor > &, Matrix< Real_wp, General, ColMajor > &, Matrix< Real_wp, General, ColMajor > &, Matrix< Real_wp, General, ColMajor > &, LapackInfo &) |
SELDON_EXTERN template void | GetHessenberg (Matrix< Real_wp, General, RowMajor > &, Matrix< Real_wp, General, RowMajor > &, Matrix< Real_wp, General, RowMajor > &, Matrix< Real_wp, General, RowMajor > &, LapackInfo &) |
SELDON_EXTERN template void | GetQZ (Matrix< Real_wp, General, ColMajor > &, Matrix< Real_wp, General, ColMajor > &, Matrix< Real_wp, General, ColMajor > &, Matrix< Real_wp, General, ColMajor > &, LapackInfo &) |
SELDON_EXTERN template void | GetQZ (Matrix< Real_wp, General, RowMajor > &, Matrix< Real_wp, General, RowMajor > &, Matrix< Real_wp, General, RowMajor > &, Matrix< Real_wp, General, RowMajor > &, LapackInfo &) |
SELDON_EXTERN template void | SolveHessenberg (Matrix< Real_wp, General, ColMajor > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | SolveHessenberg (Matrix< Real_wp, General, RowMajor > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | SolveHessenberg (Matrix< Complex_wp, General, ColMajor > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | SolveHessenberg (Matrix< Complex_wp, General, RowMajor > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | SolveHessenbergTwo (Matrix< Real_wp, General, ColMajor > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | SolveHessenbergTwo (Matrix< Real_wp, General, RowMajor > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | SolveHessenbergTwo (Matrix< Complex_wp, General, ColMajor > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | SolveHessenbergTwo (Matrix< Complex_wp, General, RowMajor > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | SolveSylvester (Matrix< Real_wp, General, ColMajor > &, Matrix< Real_wp, General, ColMajor > &, Matrix< Real_wp, General, ColMajor > &, Matrix< Real_wp, General, ColMajor > &, Matrix< Real_wp, General, ColMajor > &) |
SELDON_EXTERN template void | SolveSylvester (Matrix< Real_wp, General, RowMajor > &, Matrix< Real_wp, General, RowMajor > &, Matrix< Real_wp, General, RowMajor > &, Matrix< Real_wp, General, RowMajor > &, Matrix< Real_wp, General, RowMajor > &) |
SELDON_EXTERN template void | SolveSylvester (Matrix< Complex_wp, General, ColMajor > &, Matrix< Complex_wp, General, ColMajor > &, Matrix< Complex_wp, General, ColMajor > &, Matrix< Complex_wp, General, ColMajor > &, Matrix< Complex_wp, General, ColMajor > &) |
SELDON_EXTERN template void | SolveSylvester (Matrix< Complex_wp, General, RowMajor > &, Matrix< Complex_wp, General, RowMajor > &, Matrix< Complex_wp, General, RowMajor > &, Matrix< Complex_wp, General, RowMajor > &, Matrix< Complex_wp, General, RowMajor > &) |
SELDON_EXTERN template void | GetAndSolveLU (Matrix< Real_wp, General, RowMajor > &, Vector< int > &, Vector< Real_wp > &, LapackInfo &) |
SELDON_EXTERN template void | GetAndSolveLU (Matrix< Complex_wp, General, RowMajor > &, Vector< int > &, Vector< Complex_wp > &, LapackInfo &) |
SELDON_EXTERN template void | GetAndSolveLU (Matrix< Real_wp, General, ColMajor > &, Vector< int > &, Vector< Real_wp > &, LapackInfo &) |
SELDON_EXTERN template void | GetAndSolveLU (Matrix< Complex_wp, General, ColMajor > &, Vector< int > &, Vector< Complex_wp > &, LapackInfo &) |
SELDON_EXTERN template void | GetAndSolveLU (Matrix< Real_wp, Symmetric, RowSym > &, Vector< int > &, Vector< Real_wp > &, LapackInfo &) |
SELDON_EXTERN template void | GetAndSolveLU (Matrix< Complex_wp, Symmetric, RowSym > &, Vector< int > &, Vector< Complex_wp > &, LapackInfo &) |
SELDON_EXTERN template void | GetAndSolveLU (Matrix< Real_wp, Symmetric, RowSymPacked > &, Vector< int > &, Vector< Real_wp > &, LapackInfo &) |
SELDON_EXTERN template void | GetAndSolveLU (Matrix< Complex_wp, Symmetric, RowSymPacked > &, Vector< int > &, Vector< Complex_wp > &, LapackInfo &) |
SELDON_EXTERN template void | GetAndSolveLU (Matrix< Complex_wp, Hermitian, RowHerm > &, Vector< int > &, Vector< Complex_wp > &, LapackInfo &) |
SELDON_EXTERN template void | GetAndSolveLU (Matrix< Complex_wp, Hermitian, RowHermPacked > &, Vector< int > &, Vector< Complex_wp > &, LapackInfo &) |
SELDON_EXTERN template void | SolveLU (const Matrix< Real_wp, General, RowUpTriang > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | SolveLU (const Matrix< Complex_wp, General, RowUpTriang > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | SolveLU (const Matrix< Real_wp, General, RowLoTriang > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | SolveLU (const Matrix< Complex_wp, General, RowLoTriang > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | SolveLU (const Matrix< Real_wp, General, RowUpTriangPacked > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | SolveLU (const Matrix< Complex_wp, General, RowUpTriangPacked > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | SolveLU (const Matrix< Real_wp, General, RowLoTriangPacked > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | SolveLU (const Matrix< Complex_wp, General, RowLoTriangPacked > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | ConvertMatrix_to_Coordinates (const Matrix< Complex_wp, General, RowComplexSparse > &, Vector< int > &, Vector< int > &, Vector< Complex_wp > &, int, bool) |
SELDON_EXTERN template void | ConvertMatrix_to_Coordinates (const Matrix< Complex_wp, Symmetric, RowSymComplexSparse > &, Vector< int > &, Vector< int > &, Vector< Complex_wp > &, int, bool) |
SELDON_EXTERN template void | ConvertMatrix_to_Coordinates (const Matrix< Complex_wp, General, ArrayRowComplexSparse > &, Vector< int > &, Vector< int > &, Vector< Complex_wp > &, int, bool) |
SELDON_EXTERN template void | ConvertMatrix_to_Coordinates (const Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &, Vector< int > &, Vector< int > &, Vector< Complex_wp > &, int, bool) |
SELDON_EXTERN template void | ConvertMatrix_from_Coordinates (const Vector< int > &, const Vector< int > &, const Vector< Complex_wp > &, Matrix< Complex_wp, General, RowComplexSparse > &, int) |
SELDON_EXTERN template void | ConvertMatrix_from_Coordinates (const Vector< int > &, const Vector< int > &, const Vector< Complex_wp > &, Matrix< Complex_wp, Symmetric, RowSymComplexSparse > &, int) |
SELDON_EXTERN template void | ConvertMatrix_from_Coordinates (const Vector< int > &, const Vector< int > &, const Vector< Complex_wp > &, Matrix< Complex_wp, General, ArrayRowComplexSparse > &, int) |
SELDON_EXTERN template void | ConvertMatrix_from_Coordinates (const Vector< int > &, const Vector< int > &, const Vector< Complex_wp > &, Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &, int) |
SELDON_EXTERN template void | ConvertToCSR (const Matrix< Complex_wp, General, RowComplexSparse > &, General &, Vector< int > &, Vector< int > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | ConvertToCSR (const Matrix< Complex_wp, General, RowComplexSparse > &, General &, Vector< long > &, Vector< int > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | ConvertToCSR (const Matrix< Complex_wp, Symmetric, RowSymComplexSparse > &, Symmetric &, Vector< int > &, Vector< int > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | ConvertToCSR (const Matrix< Complex_wp, Symmetric, RowSymComplexSparse > &, Symmetric &, Vector< long > &, Vector< int > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | ConvertToCSR (const Matrix< Complex_wp, Symmetric, RowSymComplexSparse > &, General &, Vector< int > &, Vector< int > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | ConvertToCSR (const Matrix< Complex_wp, Symmetric, RowSymComplexSparse > &, General &, Vector< long > &, Vector< int > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | ConvertToCSR (const Matrix< Complex_wp, General, ArrayRowComplexSparse > &, General &, Vector< int > &, Vector< int > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | ConvertToCSR (const Matrix< Complex_wp, General, ArrayRowComplexSparse > &, General &, Vector< long > &, Vector< int > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | ConvertToCSR (const Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &, General &, Vector< int > &, Vector< int > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | ConvertToCSR (const Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &, General &, Vector< long > &, Vector< int > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | ConvertToCSR (const Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &, Symmetric &, Vector< int > &, Vector< int > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | ConvertToCSR (const Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &, Symmetric &, Vector< long > &, Vector< int > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | ConvertToCSC (const Matrix< Complex_wp, General, RowComplexSparse > &, General &, Vector< int > &, Vector< int > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | ConvertToCSC (const Matrix< Complex_wp, General, RowComplexSparse > &, General &, Vector< long > &, Vector< int > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | ConvertToCSC (const Matrix< Complex_wp, Symmetric, RowSymComplexSparse > &, Symmetric &, Vector< int > &, Vector< int > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | ConvertToCSC (const Matrix< Complex_wp, Symmetric, RowSymComplexSparse > &, Symmetric &, Vector< long > &, Vector< int > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | ConvertToCSC (const Matrix< Complex_wp, General, ArrayRowComplexSparse > &, General &, Vector< int > &, Vector< int > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | ConvertToCSC (const Matrix< Complex_wp, General, ArrayRowComplexSparse > &, General &, Vector< long > &, Vector< int > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | ConvertToCSC (const Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &, Symmetric &, Vector< int > &, Vector< int > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | ConvertToCSC (const Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &, Symmetric &, Vector< long > &, Vector< int > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Complex_wp, General, ColSparse > &, Matrix< Complex_wp, General, RowComplexSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Complex_wp, Symmetric, RowSymSparse > &, Matrix< Complex_wp, Symmetric, RowSymComplexSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Complex_wp, General, ColSparse > &, Matrix< Complex_wp, General, ArrayRowComplexSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Complex_wp, Symmetric, RowSymSparse > &, Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Complex_wp, General, ArrayRowComplexSparse > &, Matrix< Complex_wp, General, RowComplexSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Complex_wp, General, ArrayRowComplexSparse > &, Matrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &, Matrix< Complex_wp, Symmetric, RowSymComplexSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &, Matrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &, Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Complex_wp, Symmetric, RowSymComplexSparse > &, Matrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Complex_wp, Symmetric, RowSymComplexSparse > &, Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Complex_wp, General, RowComplexSparse > &, Matrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Complex_wp, General, RowComplexSparse > &, Matrix< Complex_wp, General, ColSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Complex_wp, General, ArrayRowComplexSparse > &, Matrix< Complex_wp, General, ColSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Complex_wp, General, RowComplexSparse > &, Matrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Complex_wp, General, ArrayRowComplexSparse > &, Matrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Complex_wp, Symmetric, RowSymComplexSparse > &, Matrix< Complex_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Complex_wp, Symmetric, RowSymComplexSparse > &, Matrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &, Matrix< Complex_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &, Matrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Complex_wp, Symmetric, RowSymComplexSparse > &, Matrix< Complex_wp, Symmetric, RowSymComplexSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Complex_wp, General, RowComplexSparse > &, Matrix< Complex_wp, General, RowComplexSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &, Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Complex_wp, General, ArrayRowComplexSparse > &, Matrix< Complex_wp, General, ArrayRowComplexSparse > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Matrix< Complex_wp, General, RowComplexSparse > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Matrix< Complex_wp, General, ArrayRowComplexSparse > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Matrix< Complex_wp, Symmetric, RowSymComplexSparse > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &) |
SELDON_EXTERN template void | ReadCoordinateMatrix (Matrix< Complex_wp, General, RowComplexSparse > &, istream &, Complex_wp &, int, long, bool) |
SELDON_EXTERN template void | WriteCoordinateMatrix (const Matrix< Complex_wp, General, RowComplexSparse > &, ostream &, Complex_wp &, int, bool) |
SELDON_EXTERN template void | ReadCoordinateMatrix (Matrix< Complex_wp, General, ArrayRowComplexSparse > &, istream &, Complex_wp &, int, long, bool) |
SELDON_EXTERN template void | WriteCoordinateMatrix (const Matrix< Complex_wp, General, ArrayRowComplexSparse > &, ostream &, Complex_wp &, int, bool) |
SELDON_EXTERN template void | ReadCoordinateMatrix (Matrix< Complex_wp, Symmetric, RowSymComplexSparse > &, istream &, Complex_wp &, int, long, bool) |
SELDON_EXTERN template void | WriteCoordinateMatrix (const Matrix< Complex_wp, Symmetric, RowSymComplexSparse > &, ostream &, Complex_wp &, int, bool) |
SELDON_EXTERN template void | ReadCoordinateMatrix (Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &, istream &, Complex_wp &, int, long, bool) |
SELDON_EXTERN template void | WriteCoordinateMatrix (const Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &, ostream &, Complex_wp &, int, bool) |
SELDON_EXTERN template void | ReadHarwellBoeing (string, Matrix< Complex_wp, General, RowComplexSparse > &) |
SELDON_EXTERN template void | ReadHarwellBoeing (string, Matrix< Complex_wp, General, ArrayRowComplexSparse > &) |
SELDON_EXTERN template void | ReadHarwellBoeing (string, Matrix< Complex_wp, Symmetric, RowSymComplexSparse > &) |
SELDON_EXTERN template void | ReadHarwellBoeing (string, Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &) |
SELDON_EXTERN template void | WriteHarwellBoeing (const Matrix< Complex_wp, General, RowComplexSparse > &, const string &) |
SELDON_EXTERN template void | WriteHarwellBoeing (const Matrix< Complex_wp, General, ArrayRowComplexSparse > &, const string &) |
SELDON_EXTERN template void | WriteHarwellBoeing (const Matrix< Complex_wp, Symmetric, RowSymComplexSparse > &, const string &) |
SELDON_EXTERN template void | WriteHarwellBoeing (const Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &, const string &) |
SELDON_EXTERN template void | ReadMatrixMarket (string, Matrix< Complex_wp, General, RowComplexSparse > &) |
SELDON_EXTERN template void | ReadMatrixMarket (string, Matrix< Complex_wp, General, ArrayRowComplexSparse > &) |
SELDON_EXTERN template void | ReadMatrixMarket (string, Matrix< Complex_wp, Symmetric, RowSymComplexSparse > &) |
SELDON_EXTERN template void | ReadMatrixMarket (string, Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &) |
SELDON_EXTERN template void | WriteMatrixMarket (const Matrix< Complex_wp, General, RowComplexSparse > &, const string &) |
SELDON_EXTERN template void | WriteMatrixMarket (const Matrix< Complex_wp, General, ArrayRowComplexSparse > &, const string &) |
SELDON_EXTERN template void | WriteMatrixMarket (const Matrix< Complex_wp, Symmetric, RowSymComplexSparse > &, const string &) |
SELDON_EXTERN template void | WriteMatrixMarket (const Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &, const string &) |
SELDON_EXTERN template void | ConvertMatrix_to_Coordinates (const Matrix< Real_wp, General, RowSparse > &, Vector< int > &, Vector< int > &, Vector< Real_wp > &, int, bool) |
SELDON_EXTERN template void | ConvertMatrix_to_Coordinates (const Matrix< Complex_wp, General, RowSparse > &, Vector< int > &, Vector< int > &, Vector< Complex_wp > &, int, bool) |
SELDON_EXTERN template void | ConvertMatrix_to_Coordinates (const Matrix< int, General, RowSparse > &, Vector< int > &, Vector< int > &, Vector< int > &, int, bool) |
SELDON_EXTERN template void | ConvertMatrix_to_Coordinates (const Matrix< Real_wp, General, ColSparse > &, Vector< int > &, Vector< int > &, Vector< Real_wp > &, int, bool) |
SELDON_EXTERN template void | ConvertMatrix_to_Coordinates (const Matrix< Complex_wp, General, ColSparse > &, Vector< int > &, Vector< int > &, Vector< Complex_wp > &, int, bool) |
SELDON_EXTERN template void | ConvertMatrix_to_Coordinates (const Matrix< int, General, ColSparse > &, Vector< int > &, Vector< int > &, Vector< int > &, int, bool) |
SELDON_EXTERN template void | ConvertMatrix_to_Coordinates (const Matrix< Real_wp, Symmetric, RowSymSparse > &, Vector< int > &, Vector< int > &, Vector< Real_wp > &, int, bool) |
SELDON_EXTERN template void | ConvertMatrix_to_Coordinates (const Matrix< Complex_wp, Symmetric, RowSymSparse > &, Vector< int > &, Vector< int > &, Vector< Complex_wp > &, int, bool) |
SELDON_EXTERN template void | ConvertMatrix_to_Coordinates (const Matrix< int, Symmetric, RowSymSparse > &, Vector< int > &, Vector< int > &, Vector< int > &, int, bool) |
SELDON_EXTERN template void | ConvertMatrix_to_Coordinates (const Matrix< Real_wp, General, ArrayRowSparse > &, Vector< int > &, Vector< int > &, Vector< Real_wp > &, int, bool) |
SELDON_EXTERN template void | ConvertMatrix_to_Coordinates (const Matrix< Real_wp, General, ArrayColSparse > &, Vector< int > &, Vector< int > &, Vector< Real_wp > &, int, bool) |
SELDON_EXTERN template void | ConvertMatrix_to_Coordinates (const Matrix< Complex_wp, General, ArrayRowSparse > &, Vector< int > &, Vector< int > &, Vector< Complex_wp > &, int, bool) |
SELDON_EXTERN template void | ConvertMatrix_to_Coordinates (const Matrix< Complex_wp, General, ArrayColSparse > &, Vector< int > &, Vector< int > &, Vector< Complex_wp > &, int, bool) |
SELDON_EXTERN template void | ConvertMatrix_to_Coordinates (const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, Vector< int > &, Vector< int > &, Vector< Real_wp > &, int, bool) |
SELDON_EXTERN template void | ConvertMatrix_to_Coordinates (const Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, Vector< int > &, Vector< int > &, Vector< Complex_wp > &, int, bool) |
SELDON_EXTERN template void | ConvertMatrix_from_Coordinates (const Vector< int > &, const Vector< int > &, const Vector< Real_wp > &, Matrix< Real_wp, General, RowSparse > &, int) |
SELDON_EXTERN template void | ConvertMatrix_from_Coordinates (const Vector< int > &, const Vector< int > &, const Vector< int > &, Matrix< int, General, RowSparse > &, int) |
SELDON_EXTERN template void | ConvertMatrix_from_Coordinates (const Vector< int > &, const Vector< int > &, const Vector< Complex_wp > &, Matrix< Complex_wp, General, RowSparse > &, int) |
SELDON_EXTERN template void | ConvertMatrix_from_Coordinates (const Vector< int > &, const Vector< int > &, const Vector< Real_wp > &, Matrix< Real_wp, General, ColSparse > &, int) |
SELDON_EXTERN template void | ConvertMatrix_from_Coordinates (const Vector< int > &, const Vector< int > &, const Vector< Complex_wp > &, Matrix< Complex_wp, General, ColSparse > &, int) |
SELDON_EXTERN template void | ConvertMatrix_from_Coordinates (const Vector< int > &, const Vector< int > &, const Vector< int > &, Matrix< int, General, ColSparse > &, int) |
SELDON_EXTERN template void | ConvertMatrix_from_Coordinates (const Vector< int > &, const Vector< int > &, const Vector< Real_wp > &, Matrix< Real_wp, Symmetric, RowSymSparse > &, int) |
SELDON_EXTERN template void | ConvertMatrix_from_Coordinates (const Vector< int > &, const Vector< int > &, const Vector< int > &, Matrix< int, Symmetric, RowSymSparse > &, int) |
SELDON_EXTERN template void | ConvertMatrix_from_Coordinates (const Vector< int > &, const Vector< int > &, const Vector< Complex_wp > &, Matrix< Complex_wp, Symmetric, RowSymSparse > &, int) |
SELDON_EXTERN template void | ConvertMatrix_from_Coordinates (const Vector< int > &, const Vector< int > &, const Vector< Real_wp > &, Matrix< Real_wp, General, ArrayRowSparse > &, int) |
SELDON_EXTERN template void | ConvertMatrix_from_Coordinates (const Vector< int > &, const Vector< int > &, const Vector< Real_wp > &, Matrix< Real_wp, General, ArrayColSparse > &, int) |
SELDON_EXTERN template void | ConvertMatrix_from_Coordinates (const Vector< int > &, const Vector< int > &, const Vector< Complex_wp > &, Matrix< Complex_wp, General, ArrayRowSparse > &, int) |
SELDON_EXTERN template void | ConvertMatrix_from_Coordinates (const Vector< int > &, const Vector< int > &, const Vector< Complex_wp > &, Matrix< Complex_wp, General, ArrayColSparse > &, int) |
SELDON_EXTERN template void | ConvertMatrix_from_Coordinates (const Vector< int > &, const Vector< int > &, const Vector< Real_wp > &, Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, int) |
SELDON_EXTERN template void | ConvertMatrix_from_Coordinates (const Vector< int > &, const Vector< int > &, const Vector< Complex_wp > &, Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, int) |
SELDON_EXTERN template void | ConvertToCSC (const Matrix< Real_wp, General, RowSparse > &, General &, Vector< int > &, Vector< int > &, Vector< Real_wp > &, bool) |
SELDON_EXTERN template void | ConvertToCSC (const Matrix< Complex_wp, General, RowSparse > &, General &, Vector< int > &, Vector< int > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | ConvertToCSC (const Matrix< Real_wp, General, RowSparse > &, General &, Vector< long > &, Vector< int > &, Vector< Real_wp > &, bool) |
SELDON_EXTERN template void | ConvertToCSC (const Matrix< Complex_wp, General, RowSparse > &, General &, Vector< long > &, Vector< int > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | ConvertToCSC (const Matrix< Real_wp, General, ArrayRowSparse > &, General &, Vector< int > &, Vector< int > &, Vector< Real_wp > &, bool) |
SELDON_EXTERN template void | ConvertToCSC (const Matrix< Complex_wp, General, ArrayRowSparse > &, General &, Vector< int > &, Vector< int > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | ConvertToCSC (const Matrix< Real_wp, General, ArrayRowSparse > &, General &, Vector< long > &, Vector< int > &, Vector< Real_wp > &, bool) |
SELDON_EXTERN template void | ConvertToCSC (const Matrix< Complex_wp, General, ArrayRowSparse > &, General &, Vector< long > &, Vector< int > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | ConvertToCSC (const Matrix< Real_wp, General, ColSparse > &, General &, Vector< int > &, Vector< int > &, Vector< Real_wp > &, bool) |
SELDON_EXTERN template void | ConvertToCSC (const Matrix< Real_wp, General, ColSparse > &, General &, Vector< long > &, Vector< int > &, Vector< Real_wp > &, bool) |
SELDON_EXTERN template void | ConvertToCSC (const Matrix< Complex_wp, General, ColSparse > &, General &, Vector< int > &, Vector< int > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | ConvertToCSC (const Matrix< Complex_wp, General, ColSparse > &, General &, Vector< long > &, Vector< int > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | ConvertToCSC (const Matrix< Real_wp, Symmetric, RowSymSparse > &, General &, Vector< int > &, Vector< int > &, Vector< Real_wp > &, bool) |
SELDON_EXTERN template void | ConvertToCSC (const Matrix< Real_wp, Symmetric, RowSymSparse > &, General &, Vector< long > &, Vector< int > &, Vector< Real_wp > &, bool) |
SELDON_EXTERN template void | ConvertToCSC (const Matrix< Real_wp, Symmetric, RowSymSparse > &, Symmetric &, Vector< int > &, Vector< int > &, Vector< Real_wp > &, bool) |
SELDON_EXTERN template void | ConvertToCSC (const Matrix< Real_wp, Symmetric, RowSymSparse > &, Symmetric &, Vector< long > &, Vector< int > &, Vector< Real_wp > &, bool) |
SELDON_EXTERN template void | ConvertToCSC (const Matrix< Complex_wp, Symmetric, RowSymSparse > &, General &, Vector< int > &, Vector< int > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | ConvertToCSC (const Matrix< Complex_wp, Symmetric, RowSymSparse > &, General &, Vector< long > &, Vector< int > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | ConvertToCSC (const Matrix< Complex_wp, Symmetric, RowSymSparse > &, Symmetric &, Vector< int > &, Vector< int > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | ConvertToCSC (const Matrix< Complex_wp, Symmetric, RowSymSparse > &, Symmetric &, Vector< long > &, Vector< int > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | ConvertToCSC (const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, General &, Vector< int > &, Vector< int > &, Vector< Real_wp > &, bool) |
SELDON_EXTERN template void | ConvertToCSC (const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, General &, Vector< long > &, Vector< int > &, Vector< Real_wp > &, bool) |
SELDON_EXTERN template void | ConvertToCSC (const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, Symmetric &, Vector< int > &, Vector< int > &, Vector< Real_wp > &, bool) |
SELDON_EXTERN template void | ConvertToCSC (const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, Symmetric &, Vector< long > &, Vector< int > &, Vector< Real_wp > &, bool) |
SELDON_EXTERN template void | ConvertToCSC (const Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, General &, Vector< int > &, Vector< int > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | ConvertToCSC (const Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, General &, Vector< long > &, Vector< int > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | ConvertToCSC (const Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, Symmetric &, Vector< int > &, Vector< int > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | ConvertToCSC (const Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, Symmetric &, Vector< long > &, Vector< int > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | ConvertToCSC (const Matrix< Real_wp, General, RowSparse > &, General &, Vector< int64_t > &, Vector< int64_t > &, Vector< Real_wp > &, bool) |
SELDON_EXTERN template void | ConvertToCSC (const Matrix< Complex_wp, General, RowSparse > &, General &, Vector< int64_t > &, Vector< int64_t > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | ConvertToCSC (const Matrix< Real_wp, General, ArrayRowSparse > &, General &, Vector< int64_t > &, Vector< int64_t > &, Vector< Real_wp > &, bool) |
SELDON_EXTERN template void | ConvertToCSC (const Matrix< Complex_wp, General, ArrayRowSparse > &, General &, Vector< int64_t > &, Vector< int64_t > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | ConvertToCSC (const Matrix< Real_wp, General, ColSparse > &, General &, Vector< int64_t > &, Vector< int64_t > &, Vector< Real_wp > &, bool) |
SELDON_EXTERN template void | ConvertToCSC (const Matrix< Complex_wp, General, ColSparse > &, General &, Vector< int64_t > &, Vector< int64_t > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | ConvertToCSC (const Matrix< Real_wp, Symmetric, RowSymSparse > &, General &, Vector< int64_t > &, Vector< int64_t > &, Vector< Real_wp > &, bool) |
SELDON_EXTERN template void | ConvertToCSC (const Matrix< Real_wp, Symmetric, RowSymSparse > &, Symmetric &, Vector< int64_t > &, Vector< int64_t > &, Vector< Real_wp > &, bool) |
SELDON_EXTERN template void | ConvertToCSC (const Matrix< Complex_wp, Symmetric, RowSymSparse > &, General &, Vector< int64_t > &, Vector< int64_t > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | ConvertToCSC (const Matrix< Complex_wp, Symmetric, RowSymSparse > &, Symmetric &, Vector< int64_t > &, Vector< int64_t > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | ConvertToCSC (const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, General &, Vector< int64_t > &, Vector< int64_t > &, Vector< Real_wp > &, bool) |
SELDON_EXTERN template void | ConvertToCSC (const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, Symmetric &, Vector< int64_t > &, Vector< int64_t > &, Vector< Real_wp > &, bool) |
SELDON_EXTERN template void | ConvertToCSC (const Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, General &, Vector< int64_t > &, Vector< int64_t > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | ConvertToCSC (const Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, Symmetric &, Vector< int64_t > &, Vector< int64_t > &, Vector< Complex_wp > &, bool) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Real_wp, General, RowSparse > &, Matrix< Real_wp, General, ColSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Complex_wp, General, RowSparse > &, Matrix< Complex_wp, General, ColSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Real_wp, General, ArrayRowSparse > &, Matrix< Real_wp, General, ColSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Complex_wp, General, ArrayRowSparse > &, Matrix< Complex_wp, General, ColSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Real_wp, Symmetric, RowSymSparse > &, Matrix< Real_wp, General, ColSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Complex_wp, Symmetric, RowSymSparse > &, Matrix< Complex_wp, General, ColSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, Matrix< Real_wp, General, ColSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, Matrix< Real_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, Matrix< Complex_wp, General, ColSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Complex_wp, General, ArrayRowSparse > &, Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | ConvertToCSR (const Matrix< Real_wp, General, RowSparse > &, General &, Vector< int > &, Vector< int > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | ConvertToCSR (const Matrix< Real_wp, General, RowSparse > &, General &, Vector< long > &, Vector< int > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | ConvertToCSR (const Matrix< Complex_wp, General, RowSparse > &, General &, Vector< int > &, Vector< int > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | ConvertToCSR (const Matrix< Complex_wp, General, RowSparse > &, General &, Vector< long > &, Vector< int > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | ConvertToCSR (const Matrix< Real_wp, General, ColSparse > &, General &, Vector< int > &, Vector< int > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | ConvertToCSR (const Matrix< Real_wp, General, ColSparse > &, General &, Vector< long > &, Vector< int > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | ConvertToCSR (const Matrix< Complex_wp, General, ColSparse > &, General &, Vector< int > &, Vector< int > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | ConvertToCSR (const Matrix< Complex_wp, General, ColSparse > &, General &, Vector< long > &, Vector< int > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | ConvertToCSR (const Matrix< Real_wp, General, ArrayRowSparse > &, General &, Vector< int > &, Vector< int > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | ConvertToCSR (const Matrix< Real_wp, General, ArrayRowSparse > &, General &, Vector< long > &, Vector< int > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | ConvertToCSR (const Matrix< Complex_wp, General, ArrayRowSparse > &, General &, Vector< int > &, Vector< int > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | ConvertToCSR (const Matrix< Complex_wp, General, ArrayRowSparse > &, General &, Vector< long > &, Vector< int > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | ConvertToCSR (const Matrix< Real_wp, Symmetric, RowSymSparse > &, General &, Vector< int > &, Vector< int > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | ConvertToCSR (const Matrix< Real_wp, Symmetric, RowSymSparse > &, General &, Vector< long > &, Vector< int > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | ConvertToCSR (const Matrix< Complex_wp, Symmetric, RowSymSparse > &, General &, Vector< int > &, Vector< int > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | ConvertToCSR (const Matrix< Complex_wp, Symmetric, RowSymSparse > &, General &, Vector< long > &, Vector< int > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | ConvertToCSR (const Matrix< Real_wp, Symmetric, RowSymSparse > &, Symmetric &, Vector< int > &, Vector< int > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | ConvertToCSR (const Matrix< Real_wp, Symmetric, RowSymSparse > &, Symmetric &, Vector< long > &, Vector< int > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | ConvertToCSR (const Matrix< Complex_wp, Symmetric, RowSymSparse > &, Symmetric &, Vector< int > &, Vector< int > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | ConvertToCSR (const Matrix< Complex_wp, Symmetric, RowSymSparse > &, Symmetric &, Vector< long > &, Vector< int > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | ConvertToCSR (const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, General &, Vector< int > &, Vector< int > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | ConvertToCSR (const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, General &, Vector< long > &, Vector< int > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | ConvertToCSR (const Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, General &, Vector< int > &, Vector< int > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | ConvertToCSR (const Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, General &, Vector< long > &, Vector< int > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | ConvertToCSR (const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, Symmetric &, Vector< int > &, Vector< int > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | ConvertToCSR (const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, Symmetric &, Vector< long > &, Vector< int > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | ConvertToCSR (const Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, Symmetric &, Vector< int > &, Vector< int > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | ConvertToCSR (const Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, Symmetric &, Vector< long > &, Vector< int > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | ConvertToCSR (const Matrix< Real_wp, General, RowSparse > &, General &, Vector< int64_t > &, Vector< int64_t > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | ConvertToCSR (const Matrix< Complex_wp, General, RowSparse > &, General &, Vector< int64_t > &, Vector< int64_t > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | ConvertToCSR (const Matrix< Real_wp, General, ColSparse > &, General &, Vector< int64_t > &, Vector< int64_t > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | ConvertToCSR (const Matrix< Complex_wp, General, ColSparse > &, General &, Vector< int64_t > &, Vector< int64_t > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | ConvertToCSR (const Matrix< Real_wp, General, ArrayRowSparse > &, General &, Vector< int64_t > &, Vector< int64_t > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | ConvertToCSR (const Matrix< Complex_wp, General, ArrayRowSparse > &, General &, Vector< int64_t > &, Vector< int64_t > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | ConvertToCSR (const Matrix< Real_wp, Symmetric, RowSymSparse > &, General &, Vector< int64_t > &, Vector< int64_t > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | ConvertToCSR (const Matrix< Complex_wp, Symmetric, RowSymSparse > &, General &, Vector< int64_t > &, Vector< int64_t > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | ConvertToCSR (const Matrix< Real_wp, Symmetric, RowSymSparse > &, Symmetric &, Vector< int64_t > &, Vector< int64_t > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | ConvertToCSR (const Matrix< Complex_wp, Symmetric, RowSymSparse > &, Symmetric &, Vector< int64_t > &, Vector< int64_t > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | ConvertToCSR (const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, General &, Vector< int64_t > &, Vector< int64_t > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | ConvertToCSR (const Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, General &, Vector< int64_t > &, Vector< int64_t > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | ConvertToCSR (const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, Symmetric &, Vector< int64_t > &, Vector< int64_t > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | ConvertToCSR (const Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, Symmetric &, Vector< int64_t > &, Vector< int64_t > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Real_wp, Symmetric, RowSymSparse > &, Matrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Complex_wp, Symmetric, RowSymSparse > &, Matrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, Matrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, Matrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Real_wp, General, ColSparse > &, Matrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Complex_wp, General, ColSparse > &, Matrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Real_wp, General, ArrayRowSparse > &, Matrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Complex_wp, General, ArrayRowSparse > &, Matrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, Matrix< Complex_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Real_wp, Symmetric, RowSymSparse > &, Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Complex_wp, Symmetric, RowSymSparse > &, Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Real_wp, General, RowSparse > &, Matrix< Real_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Complex_wp, General, RowSparse > &, Matrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Real_wp, Symmetric, RowSymSparse > &, Matrix< Real_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Complex_wp, Symmetric, RowSymSparse > &, Matrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Real_wp, General, ColSparse > &, Matrix< Real_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Complex_wp, General, ColSparse > &, Matrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Real_wp, General, ArrayRowSparse > &, Matrix< Real_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Complex_wp, General, ArrayRowSparse > &, Matrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Real_wp, General, ArrayRowSparse > &, Matrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, Matrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Real_wp, General, RowSparse > &, Matrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Complex_wp, General, RowSparse > &, Matrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Real_wp, General, ColSparse > &, Matrix< Real_wp, General, ColSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Complex_wp, General, ColSparse > &, Matrix< Complex_wp, General, ColSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Real_wp, Symmetric, RowSymSparse > &, Matrix< Real_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Complex_wp, Symmetric, RowSymSparse > &, Matrix< Complex_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, Matrix< Real_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, Matrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Real_wp, General, RowSparse > &, Matrix< Real_wp, General, RowMajor > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Complex_wp, General, RowSparse > &, Matrix< Complex_wp, General, RowMajor > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Real_wp, General, ArrayRowSparse > &, Matrix< Real_wp, General, RowMajor > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Complex_wp, General, ArrayRowSparse > &, Matrix< Complex_wp, General, RowMajor > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Real_wp, General, RowMajor > &, Matrix< Real_wp, General, RowMajor > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Complex_wp, General, RowMajor > &, Matrix< Complex_wp, General, RowMajor > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Real_wp, Symmetric, RowSymPacked > &, Matrix< Real_wp, Symmetric, RowSymPacked > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Complex_wp, Symmetric, RowSymPacked > &, Matrix< Complex_wp, Symmetric, RowSymPacked > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Real_wp, Symmetric, RowSymSparse > &, Matrix< Real_wp, Symmetric, RowSymPacked > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, Matrix< Real_wp, Symmetric, RowSymPacked > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, Matrix< Complex_wp, Symmetric, RowSymPacked > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, Matrix< Real_wp, Symmetric, RowSym > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, Matrix< Complex_wp, Symmetric, RowSym > &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Real_wp, General, ArrayRowSparse > &, Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | GetSymmetricPattern (const Matrix< Real_wp, General, RowSparse > &, Matrix< int, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | GetSymmetricPattern (const Matrix< int, General, RowSparse > &, Matrix< int, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template void | GetSymmetricPattern (const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, Vector< int > &, Vector< int > &) |
SELDON_EXTERN template void | GetSymmetricPattern (const Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, Vector< int > &, Vector< int > &) |
SELDON_EXTERN template void | GetSymmetricPattern (const Matrix< Real_wp, Symmetric, RowSymSparse > &, Vector< int > &, Vector< int > &) |
SELDON_EXTERN template void | GetSymmetricPattern (const Matrix< Complex_wp, Symmetric, RowSymSparse > &, Vector< int > &, Vector< int > &) |
SELDON_EXTERN template void | GetSymmetricPattern (const Matrix< Real_wp, General, RowSparse > &, Vector< int > &, Vector< int > &) |
SELDON_EXTERN template void | GetSymmetricPattern (const Matrix< Complex_wp, General, RowSparse > &, Vector< int > &, Vector< int > &) |
SELDON_EXTERN template void | GetSymmetricPattern (const Matrix< Real_wp, General, ArrayRowSparse > &, Vector< int > &, Vector< int > &) |
SELDON_EXTERN template void | GetSymmetricPattern (const Matrix< Complex_wp, General, ArrayRowSparse > &, Vector< int > &, Vector< int > &) |
SELDON_EXTERN template void | GetSymmetricPattern (const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, Vector< int64_t > &, Vector< int64_t > &) |
SELDON_EXTERN template void | GetSymmetricPattern (const Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, Vector< int64_t > &, Vector< int64_t > &) |
SELDON_EXTERN template void | GetSymmetricPattern (const Matrix< Real_wp, Symmetric, RowSymSparse > &, Vector< int64_t > &, Vector< int64_t > &) |
SELDON_EXTERN template void | GetSymmetricPattern (const Matrix< Complex_wp, Symmetric, RowSymSparse > &, Vector< int64_t > &, Vector< int64_t > &) |
SELDON_EXTERN template void | GetSymmetricPattern (const Matrix< Real_wp, General, RowSparse > &, Vector< int64_t > &, Vector< int64_t > &) |
SELDON_EXTERN template void | GetSymmetricPattern (const Matrix< Complex_wp, General, RowSparse > &, Vector< int64_t > &, Vector< int64_t > &) |
SELDON_EXTERN template void | GetSymmetricPattern (const Matrix< Real_wp, General, ArrayRowSparse > &, Vector< int64_t > &, Vector< int64_t > &) |
SELDON_EXTERN template void | GetSymmetricPattern (const Matrix< Complex_wp, General, ArrayRowSparse > &, Vector< int64_t > &, Vector< int64_t > &) |
SELDON_EXTERN template void | GetSymmetricPattern (const Matrix< Complex_wp, General, ArrayRowComplexSparse > &, Vector< int > &, Vector< int > &) |
SELDON_EXTERN template void | GetSymmetricPattern (const Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > &, Vector< int > &, Vector< int > &) |
SELDON_EXTERN template void | ConvertToSparse (const Matrix< Real_wp, Symmetric, RowSymPacked > &, Matrix< Real_wp, Symmetric, RowSymSparse > &, const Real_wp &) |
SELDON_EXTERN template void | ConvertToSparse (const Matrix< Real_wp, General, RowMajor > &, Matrix< Real_wp, General, ArrayRowSparse > &, const Real_wp &) |
SELDON_EXTERN template void | ConvertToSparse (const Matrix< Real_wp, General, RowMajor > &, Matrix< Real_wp, General, RowSparse > &, const Real_wp &) |
SELDON_EXTERN template void | CopyMatrix (const Matrix< Real_wp, General, ArrayRowSparse > &, Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Matrix< Complex_wp, Hermitian, RowHerm > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Matrix< Real_wp, Symmetric, RowSym > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Matrix< Complex_wp, Symmetric, RowSym > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Matrix< Real_wp, General, RowUpTriang > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Matrix< Complex_wp, General, RowUpTriang > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Matrix< Real_wp, General, RowLoTriang > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Matrix< Complex_wp, General, RowLoTriang > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Matrix< Complex_wp, Hermitian, RowHermPacked > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Matrix< Real_wp, Symmetric, RowSymPacked > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Matrix< Complex_wp, Symmetric, RowSymPacked > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Matrix< Real_wp, General, RowUpTriangPacked > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Matrix< Complex_wp, General, RowUpTriangPacked > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Matrix< Real_wp, General, RowLoTriangPacked > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Matrix< Complex_wp, General, RowLoTriangPacked > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Matrix< int, General, ColMajor > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Matrix< Real_wp, General, ColMajor > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Matrix< Complex_wp, General, ColMajor > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Matrix< int, General, RowMajor > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Matrix< bool, General, RowMajor > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Matrix< Real_wp, General, RowMajor > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Matrix< Complex_wp, General, RowMajor > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Matrix< Real_wp, General, RowSparse > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Matrix< Real_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Matrix< Real_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Matrix< Complex_wp, General, RowSparse > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Matrix< Complex_wp, General, ArrayRowSparse > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Matrix< Complex_wp, Symmetric, RowSymSparse > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &) |
SELDON_EXTERN template void | GetLU (Matrix< double, Symmetric, RowSymSparse > &, MatrixMumps< double > &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< complex< double >, Symmetric, RowSymSparse > &, MatrixMumps< complex< double > > &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< double, Symmetric, ArrayRowSymSparse > &, MatrixMumps< double > &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< complex< double >, Symmetric, ArrayRowSymSparse > &, MatrixMumps< complex< double > > &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< double, General, RowSparse > &, MatrixMumps< double > &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< complex< double >, General, RowSparse > &, MatrixMumps< complex< double > > &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< double, General, ArrayRowSparse > &, MatrixMumps< double > &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< complex< double >, General, ArrayRowSparse > &, MatrixMumps< complex< double > > &, bool) |
SELDON_EXTERN template void | GetSchurMatrix (Matrix< double, Symmetric, RowSymSparse > &, MatrixMumps< double > &, const IVect &, Matrix< double, General, ColMajor > &, bool) |
SELDON_EXTERN template void | GetSchurMatrix (Matrix< complex< double >, Symmetric, RowSymSparse > &, MatrixMumps< complex< double > > &, const IVect &, Matrix< complex< double >, General, ColMajor > &, bool) |
SELDON_EXTERN template void | GetSchurMatrix (Matrix< double, Symmetric, ArrayRowSymSparse > &, MatrixMumps< double > &, const IVect &, Matrix< double, General, ColMajor > &, bool) |
SELDON_EXTERN template void | GetSchurMatrix (Matrix< complex< double >, Symmetric, ArrayRowSymSparse > &, MatrixMumps< complex< double > > &, const IVect &, Matrix< complex< double >, General, ColMajor > &, bool) |
SELDON_EXTERN template void | GetSchurMatrix (Matrix< double, General, RowSparse > &, MatrixMumps< double > &, const IVect &, Matrix< double, General, ColMajor > &, bool) |
SELDON_EXTERN template void | GetSchurMatrix (Matrix< complex< double >, General, RowSparse > &, MatrixMumps< complex< double > > &, const IVect &, Matrix< complex< double >, General, ColMajor > &, bool) |
SELDON_EXTERN template void | GetSchurMatrix (Matrix< double, General, ArrayRowSparse > &, MatrixMumps< double > &, const IVect &, Matrix< double, General, ColMajor > &, bool) |
SELDON_EXTERN template void | GetSchurMatrix (Matrix< complex< double >, General, ArrayRowSparse > &, MatrixMumps< complex< double > > &, const IVect &, Matrix< complex< double >, General, ColMajor > &, bool) |
SELDON_EXTERN template void | SolveLU (MatrixMumps< double > &, Vector< double > &) |
SELDON_EXTERN template void | SolveLU (const SeldonTranspose &, MatrixMumps< double > &, Vector< double > &) |
SELDON_EXTERN template void | SolveLU (MatrixMumps< double > &, Matrix< double, General, ColMajor > &) |
SELDON_EXTERN template void | SolveLU (MatrixMumps< double > &, Vector< complex< double > > &) |
SELDON_EXTERN template void | SolveLU (const SeldonTranspose &, MatrixMumps< double > &, Vector< complex< double > > &) |
SELDON_EXTERN template void | SolveLU (MatrixMumps< double > &, Matrix< complex< double >, General, ColMajor > &) |
SELDON_EXTERN template void | SolveLU (const SeldonTranspose &, MatrixMumps< double > &, Matrix< complex< double >, General, ColMajor > &) |
SELDON_EXTERN template void | SolveLU (MatrixMumps< complex< double > > &, Vector< double > &) |
SELDON_EXTERN template void | SolveLU (const SeldonTranspose &, MatrixMumps< complex< double > > &, Vector< double > &) |
SELDON_EXTERN template void | SolveLU (MatrixMumps< complex< double > > &, Matrix< double, General, ColMajor > &) |
SELDON_EXTERN template void | SolveLU (const SeldonTranspose &, MatrixMumps< complex< double > > &, Matrix< double, General, ColMajor > &) |
SELDON_EXTERN template void | SolveLU (MatrixMumps< complex< double > > &, Vector< complex< double > > &) |
SELDON_EXTERN template void | SolveLU (const SeldonTranspose &, MatrixMumps< complex< double > > &, Vector< complex< double > > &) |
SELDON_EXTERN template void | SolveLU (MatrixMumps< complex< double > > &, Matrix< complex< double >, General, ColMajor > &) |
SELDON_EXTERN template void | SolveLU (const SeldonTranspose &, MatrixMumps< complex< double > > &, Matrix< complex< double >, General, ColMajor > &) |
SELDON_EXTERN template void | GetLU (Matrix< double, Symmetric, RowSymSparse > &, MatrixPardiso< double > &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< complex< double >, Symmetric, RowSymSparse > &, MatrixPardiso< complex< double > > &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< double, Symmetric, ArrayRowSymSparse > &, MatrixPardiso< double > &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< complex< double >, Symmetric, ArrayRowSymSparse > &, MatrixPardiso< complex< double > > &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< double, General, RowSparse > &, MatrixPardiso< double > &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< complex< double >, General, RowSparse > &, MatrixPardiso< complex< double > > &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< double, General, ArrayRowSparse > &, MatrixPardiso< double > &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< complex< double >, General, ArrayRowSparse > &, MatrixPardiso< complex< double > > &, bool) |
SELDON_EXTERN template void | SolveLU (MatrixPardiso< double > &, Vector< double > &) |
SELDON_EXTERN template void | SolveLU (const SeldonTranspose &, MatrixPardiso< double > &, Vector< double > &) |
SELDON_EXTERN template void | SolveLU (MatrixPardiso< double > &, Matrix< double, General, ColMajor > &) |
SELDON_EXTERN template void | SolveLU (MatrixPardiso< double > &, Vector< complex< double > > &) |
SELDON_EXTERN template void | SolveLU (const SeldonTranspose &, MatrixPardiso< double > &, Vector< complex< double > > &) |
SELDON_EXTERN template void | SolveLU (MatrixPardiso< complex< double > > &, Vector< double > &) |
SELDON_EXTERN template void | SolveLU (const SeldonTranspose &, MatrixPardiso< complex< double > > &, Vector< double > &) |
SELDON_EXTERN template void | SolveLU (MatrixPardiso< complex< double > > &, Vector< complex< double > > &) |
SELDON_EXTERN template void | SolveLU (const SeldonTranspose &, MatrixPardiso< complex< double > > &, Vector< complex< double > > &) |
SELDON_EXTERN template void | SolveLU (MatrixPardiso< complex< double > > &, Matrix< complex< double >, General, ColMajor > &) |
SELDON_EXTERN template void | SolveLU (const SeldonTranspose &, MatrixPardiso< complex< double > > &, Matrix< complex< double >, General, ColMajor > &) |
SELDON_EXTERN template void | GetLU (Matrix< double, Symmetric, RowSymSparse > &, MatrixPastix< double > &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< complex< double >, Symmetric, RowSymSparse > &, MatrixPastix< complex< double > > &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< double, Symmetric, ArrayRowSymSparse > &, MatrixPastix< double > &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< complex< double >, Symmetric, ArrayRowSymSparse > &, MatrixPastix< complex< double > > &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< double, General, RowSparse > &, MatrixPastix< double > &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< complex< double >, General, RowSparse > &, MatrixPastix< complex< double > > &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< double, General, ArrayRowSparse > &, MatrixPastix< double > &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< complex< double >, General, ArrayRowSparse > &, MatrixPastix< complex< double > > &, bool) |
SELDON_EXTERN template void | SolveLU (MatrixPastix< double > &, Vector< double > &) |
SELDON_EXTERN template void | SolveLU (const SeldonTranspose &, MatrixPastix< double > &, Vector< double > &) |
SELDON_EXTERN template void | SolveLU (MatrixPastix< double > &, Matrix< double, General, ColMajor > &) |
SELDON_EXTERN template void | SolveLU (MatrixPastix< double > &, Vector< complex< double > > &) |
SELDON_EXTERN template void | SolveLU (const SeldonTranspose &, MatrixPastix< double > &, Vector< complex< double > > &) |
SELDON_EXTERN template void | SolveLU (MatrixPastix< complex< double > > &, Vector< double > &) |
SELDON_EXTERN template void | SolveLU (const SeldonTranspose &, MatrixPastix< complex< double > > &, Vector< double > &) |
SELDON_EXTERN template void | SolveLU (MatrixPastix< complex< double > > &, Vector< complex< double > > &) |
SELDON_EXTERN template void | SolveLU (const SeldonTranspose &, MatrixPastix< complex< double > > &, Vector< complex< double > > &) |
SELDON_EXTERN template void | SolveLU (MatrixPastix< complex< double > > &, Matrix< complex< double >, General, ColMajor > &) |
SELDON_EXTERN template void | SolveLU (const SeldonTranspose &, MatrixPastix< complex< double > > &, Matrix< complex< double >, General, ColMajor > &) |
SELDON_EXTERN template void | GetCholesky (Matrix< double, Symmetric, ArrayRowSymSparse > &, MatrixPastix< double > &, bool) |
SELDON_EXTERN template void | GetCholesky (Matrix< double, Symmetric, RowSymSparse > &, MatrixPastix< double > &, bool) |
SELDON_EXTERN template void | SolveCholesky (const SeldonTranspose &, MatrixPastix< double > &, Vector< double > &) |
SELDON_EXTERN template void | MltCholesky (const SeldonTranspose &, MatrixPastix< double > &, Vector< double > &) |
SELDON_EXTERN template void | ApplyInversePermutation (Matrix< Real_wp, General, RowSparse > &, const Vector< int > &, const Vector< int > &) |
SELDON_EXTERN template void | ApplyInversePermutation (Matrix< Complex_wp, General, RowSparse > &, const Vector< int > &, const Vector< int > &) |
SELDON_EXTERN template void | ApplyInversePermutation (Matrix< Real_wp, General, ColSparse > &, const Vector< int > &, const Vector< int > &) |
SELDON_EXTERN template void | ApplyInversePermutation (Matrix< Complex_wp, General, ColSparse > &, const Vector< int > &, const Vector< int > &) |
SELDON_EXTERN template void | ApplyInversePermutation (Matrix< Real_wp, Symmetric, RowSymSparse > &, const Vector< int > &, const Vector< int > &) |
SELDON_EXTERN template void | ApplyInversePermutation (Matrix< Complex_wp, Symmetric, RowSymSparse > &, const Vector< int > &, const Vector< int > &) |
SELDON_EXTERN template void | ApplyInversePermutation (Matrix< Real_wp, General, ArrayRowSparse > &, const Vector< int > &, const Vector< int > &) |
SELDON_EXTERN template void | ApplyInversePermutation (Matrix< Complex_wp, General, ArrayRowSparse > &, const Vector< int > &, const Vector< int > &) |
SELDON_EXTERN template void | ApplyInversePermutation (Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, const Vector< int > &, const Vector< int > &) |
SELDON_EXTERN template void | ApplyInversePermutation (Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, const Vector< int > &, const Vector< int > &) |
SELDON_EXTERN template void | ApplyPermutation (Matrix< Real_wp, General, RowSparse > &, const Vector< int > &, const Vector< int > &) |
SELDON_EXTERN template void | ApplyPermutation (Matrix< Complex_wp, General, RowSparse > &, const Vector< int > &, const Vector< int > &) |
SELDON_EXTERN template void | ApplyPermutation (Matrix< Real_wp, General, ColSparse > &, const Vector< int > &, const Vector< int > &) |
SELDON_EXTERN template void | ApplyPermutation (Matrix< Complex_wp, General, ColSparse > &, const Vector< int > &, const Vector< int > &) |
SELDON_EXTERN template void | ApplyPermutation (Matrix< Real_wp, Symmetric, RowSymSparse > &, const Vector< int > &, const Vector< int > &) |
SELDON_EXTERN template void | ApplyPermutation (Matrix< Complex_wp, Symmetric, RowSymSparse > &, const Vector< int > &, const Vector< int > &) |
SELDON_EXTERN template void | ApplyPermutation (Matrix< Real_wp, General, ArrayRowSparse > &, const Vector< int > &, const Vector< int > &) |
SELDON_EXTERN template void | ApplyPermutation (Matrix< Complex_wp, General, ArrayRowSparse > &, const Vector< int > &, const Vector< int > &) |
SELDON_EXTERN template void | ApplyPermutation (Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, const Vector< int > &, const Vector< int > &) |
SELDON_EXTERN template void | ApplyPermutation (Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, const Vector< int > &, const Vector< int > &) |
SELDON_EXTERN template void | ScaleMatrix (Matrix< Real_wp, General, RowSparse > &, const Vector< Real_wp > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleMatrix (Matrix< Complex_wp, General, RowSparse > &, const Vector< Real_wp > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleMatrix (Matrix< Real_wp, General, ColSparse > &, const Vector< Real_wp > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleMatrix (Matrix< Complex_wp, General, ColSparse > &, const Vector< Real_wp > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleMatrix (Matrix< Real_wp, Symmetric, RowSymSparse > &, const Vector< Real_wp > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleMatrix (Matrix< Complex_wp, Symmetric, RowSymSparse > &, const Vector< Real_wp > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleMatrix (Matrix< Real_wp, General, ArrayRowSparse > &, const Vector< Real_wp > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleMatrix (Matrix< Complex_wp, General, ArrayRowSparse > &, const Vector< Real_wp > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleMatrix (Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, const Vector< Real_wp > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleMatrix (Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, const Vector< Real_wp > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleLeftMatrix (Matrix< Real_wp, General, RowSparse > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleLeftMatrix (Matrix< Complex_wp, General, RowSparse > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleLeftMatrix (Matrix< Complex_wp, General, RowSparse > &, const Vector< Complex_wp > &) |
SELDON_EXTERN template void | ScaleLeftMatrix (Matrix< Real_wp, General, ColSparse > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleLeftMatrix (Matrix< Complex_wp, General, ColSparse > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleLeftMatrix (Matrix< Complex_wp, General, ColSparse > &, const Vector< Complex_wp > &) |
SELDON_EXTERN template void | ScaleLeftMatrix (Matrix< Real_wp, General, ArrayRowSparse > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleLeftMatrix (Matrix< Complex_wp, General, ArrayRowSparse > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleLeftMatrix (Matrix< Complex_wp, General, ArrayRowSparse > &, const Vector< Complex_wp > &) |
SELDON_EXTERN template void | ScaleRightMatrix (Matrix< Real_wp, General, RowSparse > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleRightMatrix (Matrix< Complex_wp, General, RowSparse > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleRightMatrix (Matrix< Real_wp, General, ColSparse > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleRightMatrix (Matrix< Complex_wp, General, ColSparse > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleRightMatrix (Matrix< Real_wp, General, ArrayRowSparse > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | ScaleRightMatrix (Matrix< Complex_wp, General, ArrayRowSparse > &, const Vector< Real_wp > &) |
SELDON_EXTERN template void | SorVector (const Matrix< Real_wp, General, RowSparse > &, Vector< Real_wp > &, const Vector< Real_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const Matrix< Complex_wp, General, RowSparse > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const Matrix< int, General, RowSparse > &, Vector< int > &, const Vector< int > &, const int &, int, int) |
SELDON_EXTERN template void | SorVector (const Matrix< int, General, ColSparse > &, Vector< int > &, const Vector< int > &, const int &, int, int) |
SELDON_EXTERN template void | SorVector (const Matrix< Real_wp, General, ColSparse > &, Vector< Real_wp > &, const Vector< Real_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const Matrix< Complex_wp, General, ColSparse > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const Matrix< Real_wp, General, ArrayRowSparse > &, Vector< Real_wp > &, const Vector< Real_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const Matrix< Complex_wp, General, ArrayRowSparse > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const Matrix< Real_wp, General, ArrayColSparse > &, Vector< Real_wp > &, const Vector< Real_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const Matrix< Complex_wp, General, ArrayColSparse > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const Matrix< Real_wp, Symmetric, RowSymSparse > &, Vector< Real_wp > &, const Vector< Real_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const Matrix< Complex_wp, Symmetric, RowSymSparse > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const Matrix< int, Symmetric, RowSymSparse > &, Vector< int > &, const Vector< int > &, const int &, int, int) |
SELDON_EXTERN template void | SorVector (const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, Vector< Real_wp > &, const Vector< Real_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const Matrix< Real_wp, General, RowSparse > &, Vector< Real_wp > &, const Vector< Real_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const Matrix< Real_wp, General, RowSparse > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const Matrix< Complex_wp, General, RowSparse > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const Matrix< int, General, RowSparse > &, Vector< int > &, const Vector< int > &, const int &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const Matrix< int, General, RowSparse > &, Vector< complex< int > > &, const Vector< complex< int > > &, const int &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const Matrix< int, General, ColSparse > &, Vector< int > &, const Vector< int > &, const int &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const Matrix< int, General, ColSparse > &, Vector< complex< int > > &, const Vector< complex< int > > &, const int &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const Matrix< Real_wp, General, ColSparse > &, Vector< Real_wp > &, const Vector< Real_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const Matrix< Real_wp, General, ColSparse > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const Matrix< Complex_wp, General, ColSparse > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const Matrix< Real_wp, General, ArrayRowSparse > &, Vector< Real_wp > &, const Vector< Real_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const Matrix< Real_wp, General, ArrayRowSparse > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const Matrix< Complex_wp, General, ArrayRowSparse > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const Matrix< Real_wp, General, ArrayColSparse > &, Vector< Real_wp > &, const Vector< Real_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const Matrix< Real_wp, General, ArrayColSparse > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const Matrix< Complex_wp, General, ArrayColSparse > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const Matrix< Real_wp, Symmetric, RowSymSparse > &, Vector< Real_wp > &, const Vector< Real_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const Matrix< Real_wp, Symmetric, RowSymSparse > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const Matrix< Complex_wp, Symmetric, RowSymSparse > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const Matrix< int, Symmetric, RowSymSparse > &, Vector< int > &, const Vector< int > &, const int &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const Matrix< int, Symmetric, RowSymSparse > &, Vector< complex< int > > &, const Vector< complex< int > > &, const int &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, Vector< Real_wp > &, const Vector< Real_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SorVector (const SeldonTranspose &, const Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, Vector< Complex_wp > &, const Vector< Complex_wp > &, const Real_wp &, int, int) |
SELDON_EXTERN template void | SolveLU (const SeldonTranspose &, SparseDirectSolver< Real_wp > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | SolveLU (const SeldonTranspose &, SparseDirectSolver< Real_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | SolveLU (const SeldonTranspose &, SparseDirectSolver< Complex_wp > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | SolveLU (const SeldonTranspose &, SparseDirectSolver< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | SolveLU (const SeldonTranspose &, SparseDirectSolver< Real_wp > &, Matrix< Real_wp, General, ColMajor > &) |
SELDON_EXTERN template void | SolveLU (const SeldonTranspose &, SparseDirectSolver< Real_wp > &, Matrix< Complex_wp, General, ColMajor > &) |
SELDON_EXTERN template void | SolveLU (const SeldonTranspose &, SparseDirectSolver< Complex_wp > &, Matrix< Real_wp, General, ColMajor > &) |
SELDON_EXTERN template void | SolveLU (const SeldonTranspose &, SparseDirectSolver< Complex_wp > &, Matrix< Complex_wp, General, ColMajor > &) |
SELDON_EXTERN template void | FindReverseCuthillMcKeeOrdering (const Matrix< Real_wp, Symmetric, RowSymSparse > &, Vector< int > &) |
SELDON_EXTERN template void | FindReverseCuthillMcKeeOrdering (const Matrix< Complex_wp, Symmetric, RowSymSparse > &, Vector< int > &) |
SELDON_EXTERN template void | FindReverseCuthillMcKeeOrdering (const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, Vector< int > &) |
SELDON_EXTERN template void | FindReverseCuthillMcKeeOrdering (const Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, Vector< int > &) |
SELDON_EXTERN template void | FindReverseCuthillMcKeeOrdering (const Matrix< Real_wp, General, RowSparse > &, Vector< int > &) |
SELDON_EXTERN template void | FindReverseCuthillMcKeeOrdering (const Matrix< Complex_wp, General, RowSparse > &, Vector< int > &) |
SELDON_EXTERN template void | FindReverseCuthillMcKeeOrdering (const Matrix< Real_wp, General, ArrayRowSparse > &, Vector< int > &) |
SELDON_EXTERN template void | FindReverseCuthillMcKeeOrdering (const Matrix< Complex_wp, General, ArrayRowSparse > &, Vector< int > &) |
SELDON_EXTERN template void | FindSparseOrdering (Matrix< Real_wp, Symmetric, RowSymSparse > &, Vector< int > &, int) |
SELDON_EXTERN template void | FindSparseOrdering (Matrix< Complex_wp, Symmetric, RowSymSparse > &, Vector< int > &, int) |
SELDON_EXTERN template void | FindSparseOrdering (Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, Vector< int > &, int) |
SELDON_EXTERN template void | FindSparseOrdering (Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, Vector< int > &, int) |
SELDON_EXTERN template void | FindSparseOrdering (Matrix< Real_wp, General, RowSparse > &, Vector< int > &, int) |
SELDON_EXTERN template void | FindSparseOrdering (Matrix< Complex_wp, General, RowSparse > &, Vector< int > &, int) |
SELDON_EXTERN template void | FindSparseOrdering (Matrix< Real_wp, General, ArrayRowSparse > &, Vector< int > &, int) |
SELDON_EXTERN template void | FindSparseOrdering (Matrix< Complex_wp, General, ArrayRowSparse > &, Vector< int > &, int) |
SELDON_EXTERN template void | GetLU (Matrix< Real_wp, General, ArrayRowSparse > &, IVect &, IVect &, const double &, int) |
SELDON_EXTERN template void | GetLU (Matrix< Complex_wp, General, ArrayRowSparse > &, IVect &, IVect &, const double &, int) |
SELDON_EXTERN template void | GetLU (Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, int) |
SELDON_EXTERN template void | GetLU (Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, int) |
SELDON_EXTERN template void | SolveLuVector (const Matrix< Real_wp, General, ArrayRowSparse > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | SolveLuVector (const Matrix< Real_wp, General, ArrayRowSparse > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | SolveLuVector (const Matrix< Complex_wp, General, ArrayRowSparse > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | SolveLuVector (const SeldonTranspose &, const Matrix< Real_wp, General, ArrayRowSparse > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | SolveLuVector (const SeldonTranspose &, const Matrix< Real_wp, General, ArrayRowSparse > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | SolveLuVector (const SeldonTranspose &, const Matrix< Complex_wp, General, ArrayRowSparse > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | SolveLuVector (const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | SolveLuVector (const Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | SolveLuVector (const Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | GetLU (Matrix< Real_wp, Symmetric, RowSymSparse > &, SparseSeldonSolver< Real_wp > &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< Complex_wp, Symmetric, RowSymSparse > &, SparseSeldonSolver< Complex_wp > &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, SparseSeldonSolver< Real_wp > &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, SparseSeldonSolver< Complex_wp > &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< Real_wp, General, RowSparse > &, SparseSeldonSolver< Real_wp > &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< Complex_wp, General, RowSparse > &, SparseSeldonSolver< Complex_wp > &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< Real_wp, General, ArrayRowSparse > &, SparseSeldonSolver< Real_wp > &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< Complex_wp, General, ArrayRowSparse > &, SparseSeldonSolver< Complex_wp > &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< Real_wp, Symmetric, RowSymSparse > &, SparseSeldonSolver< Real_wp > &, IVect &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< Complex_wp, Symmetric, RowSymSparse > &, SparseSeldonSolver< Complex_wp > &, IVect &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< Real_wp, Symmetric, ArrayRowSymSparse > &, SparseSeldonSolver< Real_wp > &, IVect &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > &, SparseSeldonSolver< Complex_wp > &, IVect &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< Real_wp, General, RowSparse > &, SparseSeldonSolver< Real_wp > &, IVect &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< Complex_wp, General, RowSparse > &, SparseSeldonSolver< Complex_wp > &, IVect &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< Real_wp, General, ArrayRowSparse > &, SparseSeldonSolver< Real_wp > &, IVect &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< Complex_wp, General, ArrayRowSparse > &, SparseSeldonSolver< Complex_wp > &, IVect &, bool) |
SELDON_EXTERN template void | SolveLU (const Matrix< Real_wp, Symmetric, RowSymPacked > &, const Vector< int > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | SolveLU (const SeldonTranspose &, const Matrix< Real_wp, Symmetric, RowSymPacked > &, const Vector< int > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | SolveLU (SparseSeldonSolver< Real_wp > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | SolveLU (const SeldonTranspose &, SparseSeldonSolver< Real_wp > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | SolveLU (SparseSeldonSolver< Real_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | SolveLU (const SeldonTranspose &, SparseSeldonSolver< Real_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | SolveLU (SparseSeldonSolver< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | SolveLU (const SeldonTranspose &, SparseSeldonSolver< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | GetLU (Matrix< double, Symmetric, RowSymSparse > &, MatrixSuperLU< double > &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< complex< double >, Symmetric, RowSymSparse > &, MatrixSuperLU< complex< double > > &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< double, Symmetric, ArrayRowSymSparse > &, MatrixSuperLU< double > &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< complex< double >, Symmetric, ArrayRowSymSparse > &, MatrixSuperLU< complex< double > > &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< double, General, RowSparse > &, MatrixSuperLU< double > &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< complex< double >, General, RowSparse > &, MatrixSuperLU< complex< double > > &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< double, General, ArrayRowSparse > &, MatrixSuperLU< double > &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< complex< double >, General, ArrayRowSparse > &, MatrixSuperLU< complex< double > > &, bool) |
SELDON_EXTERN template void | SolveLU (MatrixSuperLU< double > &, Vector< double > &) |
SELDON_EXTERN template void | SolveLU (const SeldonTranspose &, MatrixSuperLU< double > &, Vector< double > &) |
SELDON_EXTERN template void | SolveLU (MatrixSuperLU< double > &, Matrix< double, General, ColMajor > &) |
SELDON_EXTERN template void | SolveLU (MatrixSuperLU< double > &, Vector< complex< double > > &) |
SELDON_EXTERN template void | SolveLU (const SeldonTranspose &, MatrixSuperLU< double > &, Vector< complex< double > > &) |
SELDON_EXTERN template void | SolveLU (MatrixSuperLU< complex< double > > &, Vector< double > &) |
SELDON_EXTERN template void | SolveLU (const SeldonTranspose &, MatrixSuperLU< complex< double > > &, Vector< double > &) |
SELDON_EXTERN template void | SolveLU (MatrixSuperLU< complex< double > > &, Vector< complex< double > > &) |
SELDON_EXTERN template void | SolveLU (const SeldonTranspose &, MatrixSuperLU< complex< double > > &, Vector< complex< double > > &) |
SELDON_EXTERN template void | SolveLU (MatrixSuperLU< complex< double > > &, Matrix< complex< double >, General, ColMajor > &) |
SELDON_EXTERN template void | SolveLU (const SeldonTranspose &, MatrixSuperLU< complex< double > > &, Matrix< complex< double >, General, ColMajor > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Vector< TinyVector< Real_wp, 1 > > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Vector< TinyVector< Real_wp, 2 > > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Vector< TinyVector< Real_wp, 3 > > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Vector< TinyVector< Complex_wp, 1 > > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Vector< TinyVector< Complex_wp, 2 > > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Vector< TinyVector< Complex_wp, 3 > > &) |
SELDON_EXTERN template Real_wp | Norm2_Column (const Matrix< Real_wp > &, int, int) |
SELDON_EXTERN template void | GetCholesky (TinyMatrix< Real_wp, Symmetric, 1, 1 > &) |
SELDON_EXTERN template void | SolveCholesky (const class_SeldonTrans &, const TinyMatrix< Real_wp, Symmetric, 1, 1 > &, TinyVector< Real_wp, 1 > &) |
SELDON_EXTERN template void | SolveCholesky (const class_SeldonNoTrans &, const TinyMatrix< Real_wp, Symmetric, 1, 1 > &, TinyVector< Real_wp, 1 > &) |
SELDON_EXTERN template Real_wp | Norm2_Column (const TinyMatrix< Real_wp, General, 2, 2 > &, int, int) |
SELDON_EXTERN template void | GetInverse (TinyMatrix< Real_wp, General, 2, 2 > &) |
SELDON_EXTERN template void | GetInverse (const TinyMatrix< Real_wp, General, 2, 2 > &, TinyMatrix< Real_wp, General, 2, 2 > &) |
SELDON_EXTERN template void | GetInverse (TinyMatrix< Complex_wp, General, 2, 2 > &) |
SELDON_EXTERN template void | GetInverse (const TinyMatrix< Complex_wp, General, 2, 2 > &, TinyMatrix< Complex_wp, General, 2, 2 > &) |
SELDON_EXTERN template void | GetInverse (TinyMatrix< Real_wp, Symmetric, 2, 2 > &) |
SELDON_EXTERN template void | GetInverse (const TinyMatrix< Real_wp, Symmetric, 2, 2 > &, TinyMatrix< Real_wp, Symmetric, 2, 2 > &) |
SELDON_EXTERN template void | GetInverse (TinyMatrix< Complex_wp, Symmetric, 2, 2 > &) |
SELDON_EXTERN template void | GetInverse (const TinyMatrix< Complex_wp, Symmetric, 2, 2 > &, TinyMatrix< Complex_wp, Symmetric, 2, 2 > &) |
SELDON_EXTERN template void | GetCholesky (TinyMatrix< Real_wp, Symmetric, 2, 2 > &) |
SELDON_EXTERN template void | SolveCholesky (const class_SeldonTrans &, const TinyMatrix< Real_wp, Symmetric, 2, 2 > &, TinyVector< Real_wp, 2 > &) |
SELDON_EXTERN template void | SolveCholesky (const class_SeldonNoTrans &, const TinyMatrix< Real_wp, Symmetric, 2, 2 > &, TinyVector< Real_wp, 2 > &) |
SELDON_EXTERN template void | MltCholesky (const class_SeldonTrans &, const TinyMatrix< Real_wp, Symmetric, 2, 2 > &, TinyVector< Real_wp, 2 > &) |
SELDON_EXTERN template void | MltCholesky (const class_SeldonNoTrans &, const TinyMatrix< Real_wp, Symmetric, 2, 2 > &, TinyVector< Real_wp, 2 > &) |
SELDON_EXTERN template int | IntersectionEdges (const TinyVector< Real_wp, 2 > &pointA, const TinyVector< Real_wp, 2 > &pointB, const TinyVector< Real_wp, 2 > &pt1, const TinyVector< Real_wp, 2 > &pt2, TinyVector< Real_wp, 2 > &res, const Real_wp &threshold) |
SELDON_EXTERN template int | IntersectionDroites (const TinyVector< Real_wp, 2 > &pointA, const TinyVector< Real_wp, 2 > &pointB, const TinyVector< Real_wp, 2 > &pt1, const TinyVector< Real_wp, 2 > &pt2, TinyVector< Real_wp, 2 > &res, const Real_wp &threshold) |
SELDON_EXTERN template Real_wp | Norm2_Column (const TinyMatrix< Real_wp, General, 3, 3 > &, int, int) |
SELDON_EXTERN template Real_wp | Det (const TinyMatrix< Real_wp, General, 3, 3 > &) |
SELDON_EXTERN template Real_wp | Det (const TinyMatrix< Real_wp, Symmetric, 3, 3 > &) |
SELDON_EXTERN template void | GetInverse (TinyMatrix< Real_wp, General, 3, 3 > &) |
SELDON_EXTERN template void | GetInverse (const TinyMatrix< Real_wp, General, 3, 3 > &, TinyMatrix< Real_wp, General, 3, 3 > &) |
SELDON_EXTERN template void | GetInverse (TinyMatrix< Complex_wp, General, 3, 3 > &) |
SELDON_EXTERN template void | GetInverse (const TinyMatrix< Complex_wp, General, 3, 3 > &, TinyMatrix< Complex_wp, General, 3, 3 > &) |
SELDON_EXTERN template void | GetInverse (TinyMatrix< Real_wp, Symmetric, 3, 3 > &) |
SELDON_EXTERN template void | GetInverse (const TinyMatrix< Real_wp, Symmetric, 3, 3 > &, TinyMatrix< Real_wp, Symmetric, 3, 3 > &) |
SELDON_EXTERN template void | GetInverse (TinyMatrix< Complex_wp, Symmetric, 3, 3 > &) |
SELDON_EXTERN template void | GetInverse (const TinyMatrix< Complex_wp, Symmetric, 3, 3 > &, TinyMatrix< Complex_wp, Symmetric, 3, 3 > &) |
SELDON_EXTERN template void | GetNormalProjector (const TinyVector< Real_wp, 3 > &, TinyMatrix< Real_wp, General, 3, 3 > &) |
SELDON_EXTERN template void | GetNormalProjector (const TinyVector< Real_wp, 3 > &, TinyMatrix< Real_wp, Symmetric, 3, 3 > &) |
SELDON_EXTERN template void | GetNormalProjector (const TinyVector< Real_wp, 3 > &, TinyMatrix< Complex_wp, General, 3, 3 > &) |
SELDON_EXTERN template void | GetNormalProjector (const TinyVector< Real_wp, 3 > &, TinyMatrix< Complex_wp, Symmetric, 3, 3 > &) |
SELDON_EXTERN template void | GetNormalProjector (const TinyVector< Complex_wp, 3 > &, TinyMatrix< Complex_wp, General, 3, 3 > &) |
SELDON_EXTERN template void | GetNormalProjector (const TinyVector< Complex_wp, 3 > &, TinyMatrix< Complex_wp, Symmetric, 3, 3 > &) |
SELDON_EXTERN template void | GetTangentialProjector (const TinyVector< Real_wp, 3 > &, TinyMatrix< Real_wp, Symmetric, 3, 3 > &) |
SELDON_EXTERN template void | GetTangentialProjector (const TinyVector< Real_wp, 3 > &, TinyMatrix< Complex_wp, Symmetric, 3, 3 > &) |
SELDON_EXTERN template void | GetVectorPlane (const TinyVector< Real_wp, 3 > &, TinyVector< Real_wp, 3 > &, TinyVector< Real_wp, 3 > &) |
SELDON_EXTERN template void | GetCholesky (TinyMatrix< Real_wp, Symmetric, 3, 3 > &) |
SELDON_EXTERN template void | SolveCholesky (const class_SeldonTrans &, const TinyMatrix< Real_wp, Symmetric, 3, 3 > &, TinyVector< Real_wp, 3 > &) |
SELDON_EXTERN template void | SolveCholesky (const class_SeldonNoTrans &, const TinyMatrix< Real_wp, Symmetric, 3, 3 > &, TinyVector< Real_wp, 3 > &) |
SELDON_EXTERN template void | MltCholesky (const class_SeldonTrans &, const TinyMatrix< Real_wp, Symmetric, 3, 3 > &, TinyVector< Real_wp, 3 > &) |
SELDON_EXTERN template void | MltCholesky (const class_SeldonNoTrans &, const TinyMatrix< Real_wp, Symmetric, 3, 3 > &, TinyVector< Real_wp, 3 > &) |
SELDON_EXTERN template void | GetInverse (TinyMatrix< Real_wp, General, 4, 4 > &) |
SELDON_EXTERN template void | GetInverse (const TinyMatrix< Real_wp, General, 4, 4 > &, TinyMatrix< Real_wp, General, 4, 4 > &) |
SELDON_EXTERN template void | GetInverse (TinyMatrix< Complex_wp, General, 4, 4 > &) |
SELDON_EXTERN template void | GetInverse (const TinyMatrix< Complex_wp, General, 4, 4 > &, TinyMatrix< Complex_wp, General, 4, 4 > &) |
SELDON_EXTERN template void | GetInverse (TinyMatrix< Real_wp, Symmetric, 4, 4 > &) |
SELDON_EXTERN template void | GetInverse (const TinyMatrix< Real_wp, Symmetric, 4, 4 > &, TinyMatrix< Real_wp, Symmetric, 4, 4 > &) |
SELDON_EXTERN template void | GetInverse (TinyMatrix< Complex_wp, Symmetric, 4, 4 > &) |
SELDON_EXTERN template void | GetInverse (const TinyMatrix< Complex_wp, Symmetric, 4, 4 > &, TinyMatrix< Complex_wp, Symmetric, 4, 4 > &) |
SELDON_EXTERN template void | GetInverse (TinyMatrix< Real_wp, General, 5, 5 > &) |
SELDON_EXTERN template void | GetInverse (const TinyMatrix< Real_wp, General, 5, 5 > &, TinyMatrix< Real_wp, General, 5, 5 > &) |
SELDON_EXTERN template void | GetInverse (TinyMatrix< Complex_wp, General, 5, 5 > &) |
SELDON_EXTERN template void | GetInverse (const TinyMatrix< Complex_wp, General, 5, 5 > &, TinyMatrix< Complex_wp, General, 5, 5 > &) |
SELDON_EXTERN template void | GetInverse (TinyMatrix< Real_wp, Symmetric, 5, 5 > &) |
SELDON_EXTERN template void | GetInverse (const TinyMatrix< Real_wp, Symmetric, 5, 5 > &, TinyMatrix< Real_wp, Symmetric, 5, 5 > &) |
SELDON_EXTERN template void | GetInverse (TinyMatrix< Complex_wp, Symmetric, 5, 5 > &) |
SELDON_EXTERN template void | GetInverse (const TinyMatrix< Complex_wp, Symmetric, 5, 5 > &, TinyMatrix< Complex_wp, Symmetric, 5, 5 > &) |
SELDON_EXTERN template void | GetInverse (TinyMatrix< Real_wp, General, 6, 6 > &) |
SELDON_EXTERN template void | GetInverse (const TinyMatrix< Real_wp, General, 6, 6 > &, TinyMatrix< Real_wp, General, 6, 6 > &) |
SELDON_EXTERN template void | GetInverse (TinyMatrix< Complex_wp, General, 6, 6 > &) |
SELDON_EXTERN template void | GetInverse (const TinyMatrix< Complex_wp, General, 6, 6 > &, TinyMatrix< Complex_wp, General, 6, 6 > &) |
SELDON_EXTERN template void | GetInverse (TinyMatrix< Real_wp, Symmetric, 6, 6 > &) |
SELDON_EXTERN template void | GetInverse (const TinyMatrix< Real_wp, Symmetric, 6, 6 > &, TinyMatrix< Real_wp, Symmetric, 6, 6 > &) |
SELDON_EXTERN template void | GetInverse (TinyMatrix< Complex_wp, Symmetric, 6, 6 > &) |
SELDON_EXTERN template void | GetInverse (const TinyMatrix< Complex_wp, Symmetric, 6, 6 > &, TinyMatrix< Complex_wp, Symmetric, 6, 6 > &) |
SELDON_EXTERN template void | GetInverse (TinyMatrix< Real_wp, General, 7, 7 > &) |
SELDON_EXTERN template void | GetInverse (const TinyMatrix< Real_wp, General, 7, 7 > &, TinyMatrix< Real_wp, General, 7, 7 > &) |
SELDON_EXTERN template void | GetInverse (TinyMatrix< Complex_wp, General, 7, 7 > &) |
SELDON_EXTERN template void | GetInverse (const TinyMatrix< Complex_wp, General, 7, 7 > &, TinyMatrix< Complex_wp, General, 7, 7 > &) |
SELDON_EXTERN template Real_wp | Norm2_Column (const TinyMatrix< Real_wp, General, 5, 4 > &, int, int) |
SELDON_EXTERN template Real_wp | Norm2_Column (const TinyMatrix< Real_wp, General, 7, 7 > &, int, int) |
SELDON_EXTERN template Real_wp | Norm2_Column (const TinyMatrix< Complex_wp, General, 5, 4 > &, int, int) |
SELDON_EXTERN template Real_wp | Norm2_Column (const TinyMatrix< Complex_wp, General, 7, 7 > &, int, int) |
SELDON_EXTERN template Real_wp | Norm2_Column (const TinyMatrix< Real_wp, Symmetric, 2, 2 > &, int, int) |
SELDON_EXTERN template Real_wp | Norm2_Column (const TinyMatrix< Real_wp, Symmetric, 3, 3 > &, int, int) |
SELDON_EXTERN template Real_wp | Norm2_Column (const TinyMatrix< Real_wp, Symmetric, 5, 5 > &, int, int) |
SELDON_EXTERN template Real_wp | Norm2_Column (const TinyMatrix< Complex_wp, Symmetric, 2, 2 > &, int, int) |
SELDON_EXTERN template Real_wp | Norm2_Column (const TinyMatrix< Complex_wp, Symmetric, 3, 3 > &, int, int) |
SELDON_EXTERN template Real_wp | Norm2_Column (const TinyMatrix< Complex_wp, Symmetric, 5, 5 > &, int, int) |
SELDON_EXTERN template void | GetLU (Matrix< double, Symmetric, RowSymSparse > &, MatrixUmfPack< double > &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< complex< double >, Symmetric, RowSymSparse > &, MatrixUmfPack< complex< double > > &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< double, Symmetric, ArrayRowSymSparse > &, MatrixUmfPack< double > &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< complex< double >, Symmetric, ArrayRowSymSparse > &, MatrixUmfPack< complex< double > > &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< double, General, RowSparse > &, MatrixUmfPack< double > &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< complex< double >, General, RowSparse > &, MatrixUmfPack< complex< double > > &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< double, General, ArrayRowSparse > &, MatrixUmfPack< double > &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< complex< double >, General, ArrayRowSparse > &, MatrixUmfPack< complex< double > > &, bool) |
SELDON_EXTERN template void | SolveLU (MatrixUmfPack< double > &, Vector< double > &) |
SELDON_EXTERN template void | SolveLU (MatrixUmfPack< double > &, Matrix< double, General, ColMajor > &) |
SELDON_EXTERN template void | SolveLU (const SeldonTranspose &, MatrixUmfPack< double > &, Vector< double > &) |
SELDON_EXTERN template void | SolveLU (MatrixUmfPack< double > &, Vector< complex< double > > &) |
SELDON_EXTERN template void | SolveLU (const SeldonTranspose &, MatrixUmfPack< double > &, Vector< complex< double > > &) |
SELDON_EXTERN template void | SolveLU (MatrixUmfPack< complex< double > > &, Vector< double > &) |
SELDON_EXTERN template void | SolveLU (MatrixUmfPack< complex< double > > &, Matrix< complex< double >, General, ColMajor > &) |
SELDON_EXTERN template void | SolveLU (const SeldonTranspose &, MatrixUmfPack< complex< double > > &, Vector< double > &) |
SELDON_EXTERN template void | SolveLU (MatrixUmfPack< complex< double > > &, Vector< complex< double > > &) |
SELDON_EXTERN template void | SolveLU (const SeldonTranspose &, MatrixUmfPack< complex< double > > &, Vector< complex< double > > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Vector< bool > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Vector< char > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Vector< float > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Vector< complex< float > > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Vector< int > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Vector< int64_t > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Vector< Real_wp > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Vector< Complex_wp > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Vector< Vector< int > > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Vector< Vector< Real_wp > > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Vector< Vector< Complex_wp > > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Vector< Vector< complex< float > > > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Vector< Matrix< Complex_wp, General, ColMajor > > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Vector< int, VectSparse > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Vector< Real_wp, VectSparse > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Vector< Complex_wp, VectSparse > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Vector< string > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Vector< Vector< string > > &) |
SELDON_EXTERN template void | QuickSort (long, long, Vector< Real_wp > &) |
SELDON_EXTERN template void | QuickSort (long, long, Vector< Real_wp > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | QuickSort (long, long, Vector< Real_wp > &, Vector< int > &) |
SELDON_EXTERN template void | QuickSort (long, long, Vector< Real_wp > &, Vector< Real_wp > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | QuickSort (long, long, Vector< Real_wp > &, Vector< int > &, Vector< int > &) |
SELDON_EXTERN template void | MergeSort (long, long, Vector< int > &) |
SELDON_EXTERN template void | MergeSort (long, long, Vector< Real_wp > &) |
SELDON_EXTERN template void | MergeSort (long, long, Vector< Real_wp > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MergeSort (long, long, Vector< Real_wp > &, Vector< int > &) |
SELDON_EXTERN template void | MergeSort (long, long, Vector< Real_wp > &, Vector< Real_wp > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MergeSort (long, long, Vector< Real_wp > &, Vector< int > &, Vector< int > &) |
SELDON_EXTERN template void | MergeSort (long, long, Vector< int > &, Vector< int > &) |
SELDON_EXTERN template void | MergeSort (long, long, Vector< int > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MergeSort (long, long, Vector< int > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | MergeSort (long, long, Vector< int > &, Vector< int > &, Vector< int > &) |
SELDON_EXTERN template void | MergeSort (long, long, Vector< int > &, Vector< int > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | MergeSort (long, long, Vector< int > &, Vector< int > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | Sort (long, long, Vector< int > &) |
SELDON_EXTERN template void | Sort (long, long, Vector< Real_wp > &) |
SELDON_EXTERN template void | Sort (long, long, Vector< Real_wp > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | Sort (long, long, Vector< Real_wp > &, Vector< int > &) |
SELDON_EXTERN template void | Sort (long, long, Vector< Real_wp > &, Vector< Real_wp > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | Sort (long, long, Vector< Real_wp > &, Vector< int > &, Vector< int > &) |
SELDON_EXTERN template void | Sort (long, long, Vector< int > &, Vector< Real_wp > &, Vector< int > &) |
SELDON_EXTERN template void | Sort (long, long, Vector< int > &, Vector< Complex_wp > &, Vector< int > &) |
SELDON_EXTERN template void | Sort (long, long, Vector< int > &, Vector< int > &) |
SELDON_EXTERN template void | Sort (long, long, Vector< int > &, Vector< long > &) |
SELDON_EXTERN template void | Sort (long, long, Vector< int > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | Sort (long, long, Vector< int > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | Sort (long, long, Vector< int > &, Vector< int > &, Vector< int > &) |
SELDON_EXTERN template void | Sort (long, long, Vector< int > &, Vector< int > &, Vector< long > &) |
SELDON_EXTERN template void | Sort (long, long, Vector< int > &, Vector< int > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | Sort (long, long, Vector< int > &, Vector< int > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | Sort (long, Vector< int > &) |
SELDON_EXTERN template void | Sort (long, Vector< Real_wp > &) |
SELDON_EXTERN template void | Sort (long, Vector< Real_wp > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | Sort (long, Vector< Real_wp > &, Vector< int > &) |
SELDON_EXTERN template void | Sort (long, Vector< Real_wp > &, Vector< Real_wp > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | Sort (long, Vector< int > &, Vector< int > &) |
SELDON_EXTERN template void | Sort (long, Vector< int > &, Vector< long > &) |
SELDON_EXTERN template void | Sort (long, Vector< int > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | Sort (long, Vector< int > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | Sort (long, Vector< int > &, Vector< int > &, Vector< int > &) |
SELDON_EXTERN template void | Sort (long, Vector< int > &, Vector< int > &, Vector< long > &) |
SELDON_EXTERN template void | Sort (long, Vector< int > &, Vector< int > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | Sort (long, Vector< int > &, Vector< Real_wp > &, Vector< int > &) |
SELDON_EXTERN template void | Sort (long, Vector< int > &, Vector< int > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | Sort (long, Vector< int > &, Vector< Complex_wp > &, Vector< int > &) |
SELDON_EXTERN template void | Sort (Vector< int > &) |
SELDON_EXTERN template void | Sort (Vector< Real_wp > &) |
SELDON_EXTERN template void | Sort (Vector< int > &, Vector< int > &) |
SELDON_EXTERN template void | Sort (Vector< int > &, Vector< long > &) |
SELDON_EXTERN template void | Sort (Vector< int > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | Sort (Vector< int > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | Sort (Vector< int > &, Vector< int > &, Vector< int > &) |
SELDON_EXTERN template void | Sort (Vector< int > &, Vector< int > &, Vector< long > &) |
SELDON_EXTERN template void | Sort (Vector< int > &, Vector< int > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | Sort (Vector< int > &, Vector< int > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | Sort (Vector< Real_wp > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | Sort (Vector< Real_wp > &, Vector< int > &) |
SELDON_EXTERN template void | Sort (Vector< Real_wp > &, Vector< Real_wp > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | Sort (Vector< Real_wp > &, Vector< int > &, Vector< int > &) |
SELDON_EXTERN template void | Sort (Vector< Real_wp > &, Vector< Vector< Real_wp > > &) |
SELDON_EXTERN template void | Sort (Vector< Real_wp > &, Vector< Complex_wp > &, Vector< Vector< Real_wp > > &) |
SELDON_EXTERN template void | Sort (Vector< Real_wp > &, Vector< Vector< Complex_wp > > &) |
SELDON_EXTERN template void | Sort (Vector< Real_wp > &, Vector< Complex_wp > &, Vector< Vector< Complex_wp > > &) |
SELDON_EXTERN template void | Assemble (long &, Vector< int > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | Assemble (long &, Vector< int > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | Assemble (long &, Vector< int > &) |
SELDON_EXTERN template void | Assemble (Vector< int > &) |
SELDON_EXTERN template void | RemoveDuplicate (long &, Vector< int > &, Vector< int > &) |
SELDON_EXTERN template void | RemoveDuplicate (long &, Vector< int > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | RemoveDuplicate (long &, Vector< int > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | RemoveDuplicate (long &, Vector< int > &) |
SELDON_EXTERN template void | RemoveDuplicate (Vector< int > &, Vector< int > &) |
SELDON_EXTERN template void | RemoveDuplicate (Vector< int > &) |
SELDON_EXTERN template void | RemoveDuplicate (Vector< Real_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | RemoveDuplicate (Vector< Real_wp > &) |
SELDON_EXTERN template bool | HasElement (const Vector< int > &, const int &) |
SELDON_EXTERN template bool | HasElement (const Vector< Real_wp > &, const Real_wp &) |
SELDON_EXTERN template bool | HasElement (const Vector< Complex_wp > &, const Complex_wp &) |
SELDON_EXTERN template void | SwapPointer (Vector< int > &, Vector< int > &) |
SELDON_EXTERN template void | SwapPointer (Vector< Real_wp > &, Vector< Real_wp > &) |
SELDON_EXTERN template void | SwapPointer (Vector< Complex_wp > &, Vector< Complex_wp > &) |
SELDON_EXTERN template void | SwapPointer (Vector< Vector< int > > &, Vector< Vector< int > > &) |
SELDON_EXTERN template void | SwapPointer (Vector< Vector< Real_wp, VectSparse > > &, Vector< Vector< Real_wp, VectSparse > > &) |
SELDON_EXTERN template void | SwapPointer (Vector< Vector< Complex_wp, VectSparse > > &, Vector< Vector< Complex_wp, VectSparse > > &) |
SELDON_EXTERN template void | GetLU (Matrix< double, Symmetric, RowSymSparse > &, MatrixWsmp< double > &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< complex< double >, Symmetric, RowSymSparse > &, MatrixWsmp< complex< double > > &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< double, Symmetric, ArrayRowSymSparse > &, MatrixWsmp< double > &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< complex< double >, Symmetric, ArrayRowSymSparse > &, MatrixWsmp< complex< double > > &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< double, General, RowSparse > &, MatrixWsmp< double > &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< complex< double >, General, RowSparse > &, MatrixWsmp< complex< double > > &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< double, General, ArrayRowSparse > &, MatrixWsmp< double > &, bool) |
SELDON_EXTERN template void | GetLU (Matrix< complex< double >, General, ArrayRowSparse > &, MatrixWsmp< complex< double > > &, bool) |
SELDON_EXTERN template void | SolveLU (MatrixWsmp< double > &, Vector< double > &) |
SELDON_EXTERN template void | SolveLU (const SeldonTranspose &, MatrixWsmp< double > &, Vector< double > &) |
SELDON_EXTERN template void | SolveLU (MatrixWsmp< double > &, Matrix< double, General, ColMajor > &) |
SELDON_EXTERN template void | SolveLU (MatrixWsmp< double > &, Vector< complex< double > > &) |
SELDON_EXTERN template void | SolveLU (const SeldonTranspose &, MatrixWsmp< double > &, Vector< complex< double > > &) |
SELDON_EXTERN template void | SolveLU (MatrixWsmp< complex< double > > &, Vector< double > &) |
SELDON_EXTERN template void | SolveLU (const SeldonTranspose &, MatrixWsmp< complex< double > > &, Vector< double > &) |
SELDON_EXTERN template void | SolveLU (MatrixWsmp< complex< double > > &, Vector< complex< double > > &) |
SELDON_EXTERN template void | SolveLU (const SeldonTranspose &, MatrixWsmp< complex< double > > &, Vector< complex< double > > &) |
SELDON_EXTERN template void | SolveLU (MatrixWsmp< complex< double > > &, Matrix< complex< double >, General, ColMajor > &) |
SELDON_EXTERN template void | SolveLU (const SeldonTranspose &, MatrixWsmp< complex< double > > &, Matrix< complex< double >, General, ColMajor > &) |
SELDON_EXTERN template void | ApplyRot (Vector< @real > &, Vector< @real > &, const @real &, const @real &) |
SELDON_EXTERN template void | ApplyModifRot (Vector< @real > &, Vector< @real > &, const @real *) |
SELDON_EXTERN template void | Swap (Vector< @real_complex > &, Vector< @real_complex > &) |
SELDON_EXTERN template void | MltScalar (const @scalar &, Vector< @scalar > &) |
SELDON_EXTERN template void | CopyVector (const Vector< @real_complex > &, Vector< @real_complex > &) |
SELDON_EXTERN template void | AddVector (const @real_complex &, const Vector< @real_complex > &, Vector< @real_complex > &) |
SELDON_EXTERN template real_complex | DotProdVector (const Vector< @real_complex > &, const Vector< @real_complex > &) |
SELDON_EXTERN template complex | DotProdConjVector (const Vector< @complex > &, const Vector< @complex > &) |
SELDON_EXTERN template float | Norm1 (const Vector< float > &) |
SELDON_EXTERN template float | Norm1 (const Vector< complexfloat > &) |
SELDON_EXTERN template float | Norm2 (const Vector< float > &) |
SELDON_EXTERN template float | Norm2 (const Vector< complexfloat > &) |
SELDON_EXTERN template size_t | GetMaxAbsIndex (const Vector< @real_complex > &) |
SELDON_EXTERN template void | Mlt (const Matrix< @real_complex, General, @storage_blasT > &, Vector< @real_complex > &) |
SELDON_EXTERN template void | Mlt (const SeldonTranspose &, const SeldonDiag &, const Matrix< @real_complex, General, @storage_blasT > &, Vector< @real_complex > &) |
SELDON_EXTERN template void | MltVector (const Matrix< @real_complex, General, @storage_blasGE > &, const Vector< @real_complex > &, Vector< @real_complex > &) |
SELDON_EXTERN template void | MltVector (const Matrix< @real_complex, Symmetric, @storage_blasS > &, const Vector< @real_complex > &, Vector< @real_complex > &) |
SELDON_EXTERN template void | MltVector (const Matrix< @complex, Hermitian, @storage_blasH > &, const Vector< @complex > &, Vector< @complex > &) |
SELDON_EXTERN template void | MltVector (const SeldonTranspose &, const Matrix< @real_complex, General, @storage_blasGE > &, const Vector< @real_complex > &, Vector< @real_complex > &) |
SELDON_EXTERN template void | MltAddVector (const @real_complex &, const Matrix< @real_complex, General, @storage_blasGE > &, const Vector< @real_complex > &, const @real_complex &, Vector< @real_complex > &) |
SELDON_EXTERN template void | MltAddVector (const @real_complex &, const SeldonTranspose &, const Matrix< @real_complex, General, @storage_blasGE > &, const Vector< @real_complex > &, const @real_complex &, Vector< @real_complex > &) |
SELDON_EXTERN template void | MltAddVector (const @real_complex &, const Matrix< @real_complex, Symmetric, @storage_blasS > &, const Vector< @real_complex > &, const @real_complex &, Vector< @real_complex > &) |
SELDON_EXTERN template void | MltAddVector (const @complex &, const Matrix< @complex, Hermitian, @storage_blasH > &, const Vector< @complex > &, const @complex &, Vector< @complex > &) |
SELDON_EXTERN template void | Rank1Update (const @real_complex &, const Vector< @real_complex > &, const Vector< @real_complex > &, Matrix< @real_complex, General, @storage_blasGE > &) |
SELDON_EXTERN template void | Rank1Update (const @complex &, const Vector< @complex > &, const SeldonConjugate &, const Vector< @complex > &, Matrix< @complex, General, @storage_blasGE > &) |
SELDON_EXTERN template void | Rank1Update (const @real &, const Vector< @real > &, Matrix< @real, Symmetric, @storage_blasS > &) |
SELDON_EXTERN template void | Rank1Update (const float &, const Vector< complexfloat > &, Matrix< complexfloat, Hermitian, @storage_blasH > &) |
SELDON_EXTERN template void | Rank1Update (const double &, const Vector< complexdouble > &, Matrix< complexdouble, Hermitian, @storage_blasH > &) |
SELDON_EXTERN template void | Rank2Update (const @real &, const Vector< @real > &, const Vector< @real > &, Matrix< @real, Symmetric, @storage_blasS > &) |
SELDON_EXTERN template void | Rank2Update (const @complex &, const Vector< @complex > &, const Vector< @complex > &, Matrix< @complex, Hermitian, @storage_blasH > &) |
SELDON_EXTERN template void | Solve (const Matrix< @real_complex, General, @storage_blasT > &, Vector< @real_complex > &) |
SELDON_EXTERN template void | Solve (const SeldonTranspose &, const SeldonDiag &, const Matrix< @real_complex, General, @storage_blasT > &, Vector< @real_complex > &) |
SELDON_EXTERN template void | MltAddMatrix (const @real_complex &, const Matrix< @real_complex, General, @storage_blasGE > &, const Matrix< @real_complex, General, @storage_blasGE > &, const @real_complex &, Matrix< @real_complex, General, @storage_blasGE > &) |
SELDON_EXTERN template void | MltAddMatrix (const @real_complex &, const SeldonTranspose &, const Matrix< @real_complex, General, @storage_blasGE > &, const SeldonTranspose &, const Matrix< @real_complex, General, @storage_blasGE > &, const @real_complex &, Matrix< @real_complex, General, @storage_blasGE > &) |
SELDON_EXTERN template void | MltAdd (const SeldonSide &, const @real_complex &, const Matrix< @real_complex, Symmetric, ColSym > &, const Matrix< @real_complex, General, ColMajor > &, const @real_complex &, Matrix< @real_complex, General, ColMajor > &) |
SELDON_EXTERN template void | MltAdd (const SeldonSide &, const @real_complex &, const Matrix< @real_complex, Symmetric, RowSym > &, const Matrix< @real_complex, General, RowMajor > &, const @real_complex &, Matrix< @real_complex, General, RowMajor > &) |
SELDON_EXTERN template void | MltAdd (const SeldonSide &, const @complex &, const Matrix< @complex, Symmetric, ColHerm > &, const Matrix< @complex, General, ColMajor > &, const @complex &, Matrix< @complex, General, ColMajor > &) |
SELDON_EXTERN template void | MltAdd (const SeldonSide &, const @complex &, const Matrix< @complex, Symmetric, RowHerm > &, const Matrix< @complex, General, RowMajor > &, const @complex &, Matrix< @complex, General, RowMajor > &) |
SELDON_EXTERN template void | Mlt (const SeldonSide &, const @real_complex &, const Matrix< @real_complex, General, RowLoTriang > &, Matrix< @real_complex, General, RowMajor > &) |
SELDON_EXTERN template void | Mlt (const SeldonSide &, const @real_complex &, const Matrix< @real_complex, General, RowUpTriang > &, Matrix< @real_complex, General, RowMajor > &) |
SELDON_EXTERN template void | Mlt (const SeldonSide &, const @real_complex &, const Matrix< @real_complex, General, ColLoTriang > &, Matrix< @real_complex, General, ColMajor > &) |
SELDON_EXTERN template void | Mlt (const SeldonSide &, const @real_complex &, const Matrix< @real_complex, General, ColUpTriang > &, Matrix< @real_complex, General, ColMajor > &) |
SELDON_EXTERN template void | Mlt (const SeldonSide &, const @real_complex &, const SeldonTranspose &, const SeldonDiag &, const Matrix< @real_complex, General, RowLoTriang > &, Matrix< @real_complex, General, RowMajor > &) |
SELDON_EXTERN template void | Mlt (const SeldonSide &, const @real_complex &, const SeldonTranspose &, const SeldonDiag &, const Matrix< @real_complex, General, RowUpTriang > &, Matrix< @real_complex, General, RowMajor > &) |
SELDON_EXTERN template void | Mlt (const SeldonSide &, const @real_complex &, const SeldonTranspose &, const SeldonDiag &, const Matrix< @real_complex, General, ColLoTriang > &, Matrix< @real_complex, General, ColMajor > &) |
SELDON_EXTERN template void | Mlt (const SeldonSide &, const @real_complex &, const SeldonTranspose &, const SeldonDiag &, const Matrix< @real_complex, General, ColUpTriang > &, Matrix< @real_complex, General, ColMajor > &) |
SELDON_EXTERN template void | Solve (const SeldonSide &, const @real_complex &, const Matrix< @real_complex, General, RowLoTriang > &, Matrix< @real_complex, General, RowMajor > &) |
SELDON_EXTERN template void | Solve (const SeldonSide &, const @real_complex &, const Matrix< @real_complex, General, RowUpTriang > &, Matrix< @real_complex, General, RowMajor > &) |
SELDON_EXTERN template void | Solve (const SeldonSide &, const @real_complex &, const Matrix< @real_complex, General, ColLoTriang > &, Matrix< @real_complex, General, ColMajor > &) |
SELDON_EXTERN template void | Solve (const SeldonSide &, const @real_complex &, const Matrix< @real_complex, General, ColUpTriang > &, Matrix< @real_complex, General, ColMajor > &) |
SELDON_EXTERN template void | Solve (const SeldonSide &, const @real_complex &, const SeldonTranspose &, const SeldonDiag &, const Matrix< @real_complex, General, RowLoTriang > &, Matrix< @real_complex, General, RowMajor > &) |
SELDON_EXTERN template void | Solve (const SeldonSide &, const @real_complex &, const SeldonTranspose &, const SeldonDiag &, const Matrix< @real_complex, General, RowUpTriang > &, Matrix< @real_complex, General, RowMajor > &) |
SELDON_EXTERN template void | Solve (const SeldonSide &, const @real_complex &, const SeldonTranspose &, const SeldonDiag &, const Matrix< @real_complex, General, ColLoTriang > &, Matrix< @real_complex, General, ColMajor > &) |
SELDON_EXTERN template void | Solve (const SeldonSide &, const @real_complex &, const SeldonTranspose &, const SeldonDiag &, const Matrix< @real_complex, General, ColUpTriang > &, Matrix< @real_complex, General, ColMajor > &) |
SELDON_EXTERN template void | Conjugate (Vector< @complex > &) |
SELDON_EXTERN template void | Conjugate (Matrix< @complex, General, @storage_blasGE > &) |
SELDON_EXTERN template void | Conjugate (Matrix< @complex, Symmetric, @storage_blasS > &) |
SELDON_EXTERN template void | Conjugate (Matrix< @complex, Hermitian, @storage_blasH > &) |
SELDON_EXTERN template void | Transpose (Matrix< @real_complex, General, @storage_blasGE > &) |
SELDON_EXTERN template void | Transpose (Matrix< @real_complex, Symmetric, @storage_blasS > &) |
SELDON_EXTERN template void | Transpose (Matrix< @complex, Hermitian, @storage_blasH > &) |
SELDON_EXTERN template void | TransposeConj (Matrix< @real_complex, General, @storage_blasGE > &) |
SELDON_EXTERN template void | TransposeConj (Matrix< @real_complex, Symmetric, @storage_blasS > &) |
SELDON_EXTERN template void | TransposeConj (Matrix< @complex, Hermitian, @storage_blasH > &) |
SELDON_EXTERN template void | MltAddVector (const @real_complex &, const Matrix< @real_complex, General, RowSparse > &, const Vector< @real_complex > &, const @real_complex &, Vector< @real_complex > &) |
SELDON_EXTERN template void | MltAddVector (const @real_complex &, const SeldonTranspose &, const Matrix< @real_complex, General, RowSparse > &, const Vector< @real_complex > &, const @real_complex &, Vector< @real_complex > &) |
SELDON_EXTERN template std::string | to_str< int > (const int &) |
SELDON_EXTERN template std::string | to_str< long > (const long &) |
SELDON_EXTERN template std::string | to_str< float > (const float &) |
SELDON_EXTERN template std::string | to_str< double > (const double &) |
SELDON_EXTERN template std::string | to_str< complex< float > > (const complex< float > &) |
SELDON_EXTERN template std::string | to_str< complex< double > > (const complex< double > &) |
SELDON_EXTERN template void | to_num (std::string, int &) |
SELDON_EXTERN template void | to_num (std::string, float &) |
SELDON_EXTERN template void | to_num (std::string, double &) |
SELDON_EXTERN template void | to_num (std::string, complex< float > &) |
SELDON_EXTERN template void | to_num (std::string, complex< double > &) |
SELDON_EXTERN template int | to_num< int > (std::string) |
SELDON_EXTERN template float | to_num< float > (std::string) |
SELDON_EXTERN template double | to_num< double > (std::string) |
SELDON_EXTERN template complex< float > | to_num< complex< float > > (std::string) |
SELDON_EXTERN template complex< double > | to_num< complex< double > > (std::string) |
SELDON_EXTERN template void | SetComplexZero (@scalar &) |
SELDON_EXTERN template void | SetComplexOne (@scalar &) |
SELDON_EXTERN template void | GetLU (Matrix< @real_complex, General, @storage_blasGE > &, Vector< int > &, LapackInfo &) |
SELDON_EXTERN template void | GetLU (Matrix< @real_complex, Symmetric, @storage_blasS > &, Vector< int > &, LapackInfo &) |
SELDON_EXTERN template void | GetLU (Matrix< @complex, Hermitian, @storage_blasH > &, Vector< int > &, LapackInfo &) |
SELDON_EXTERN template void | SolveLuVector (const Matrix< @real_complex, General, @storage_blasGE > &, const Vector< int > &, Vector< @real_complex > &, LapackInfo &) |
SELDON_EXTERN template void | SolveLuVector (const SeldonTranspose &, const Matrix< @real_complex, General, @storage_blasGE > &, const Vector< int > &, Vector< @real_complex > &, LapackInfo &) |
SELDON_EXTERN template void | SolveLuVector (const Matrix< @real_complex, Symmetric, @storage_blasS > &, const Vector< int > &, Vector< @real_complex > &, LapackInfo &) |
SELDON_EXTERN template void | SolveLuVector (const Matrix< @complex, Hermitian, @storage_blasH > &, const Vector< int > &, Vector< @complex > &, LapackInfo &) |
SELDON_EXTERN template void | SolveLU (const Matrix< @real_complex, General, @storage_blasT > &, Vector< @real_complex > &, LapackInfo &) |
SELDON_EXTERN template void | SolveLU (const SeldonTranspose &, const SeldonDiag &, const Matrix< @real_complex, General, @storage_blasT > &, Vector< @real_complex > &, LapackInfo &) |
SELDON_EXTERN template real | ReciprocalConditionNumber (const Matrix< @real, General, @storage_blasGE > &, Vector< int > &, SeldonNorm, @real, LapackInfo &) |
SELDON_EXTERN template double | ReciprocalConditionNumber (const Matrix< complexdouble, General, @storage_blasGE > &, Vector< int > &, SeldonNorm, double, LapackInfo &) |
SELDON_EXTERN template real | ReciprocalConditionNumber (const Matrix< @real, Symmetric, @storage_blasS > &, Vector< int > &, SeldonNorm, @real, LapackInfo &) |
SELDON_EXTERN template double | ReciprocalConditionNumber (const Matrix< complexdouble, Symmetric, @storage_blasS > &, Vector< int > &, SeldonNorm, double, LapackInfo &) |
SELDON_EXTERN template double | ReciprocalConditionNumber (const Matrix< complexdouble, Hermitian, @storage_blasH > &, Vector< int > &, SeldonNorm, double, LapackInfo &) |
SELDON_EXTERN template real | ReciprocalConditionNumber (const Matrix< @real, General, @storage_blasT > &, SeldonNorm, LapackInfo &) |
SELDON_EXTERN template double | ReciprocalConditionNumber (const Matrix< complexdouble, General, @storage_blasT > &, SeldonNorm, LapackInfo &) |
SELDON_EXTERN template real | ReciprocalConditionNumber (const SeldonDiag &, const Matrix< @real, General, @storage_blasT > &, SeldonNorm, LapackInfo &) |
SELDON_EXTERN template double | ReciprocalConditionNumber (const SeldonDiag &, const Matrix< complexdouble, General, @storage_blasT > &, SeldonNorm, LapackInfo &) |
SELDON_EXTERN template void | RefineSolutionLU (const Matrix< @real, General, @storage_blasGE > &, const Matrix< @real, General, @storage_blasGE > &, const Vector< int > &, Vector< @real > &, const Vector< @real > &, @real &, @real &, LapackInfo &) |
SELDON_EXTERN template void | RefineSolutionLU (const SeldonTranspose &, const Matrix< @real, General, @storage_blasGE > &, const Matrix< @real, General, @storage_blasGE > &, const Vector< int > &, Vector< @real > &, const Vector< @real > &, @real &, @real &, LapackInfo &) |
SELDON_EXTERN template void | RefineSolutionLU (const Matrix< @real, Symmetric, @storage_blasS > &, const Matrix< @real, Symmetric, @storage_blasS > &, const Vector< int > &, Vector< @real > &, const Vector< @real > &, @real &, @real &, LapackInfo &) |
SELDON_EXTERN template void | RefineSolutionLU (const Matrix< complexdouble, Symmetric, @storage_blasS > &, const Matrix< complexdouble, Symmetric, @storage_blasS > &, const Vector< int > &, Vector< complexdouble > &, const Vector< complexdouble > &, double &, double &, LapackInfo &) |
SELDON_EXTERN template void | RefineSolutionLU (const Matrix< complexdouble, Hermitian, ColHerm > &, const Matrix< complexdouble, Hermitian, ColHerm > &, const Vector< int > &, Vector< complexdouble > &, const Vector< complexdouble > &, double &, double &, LapackInfo &) |
SELDON_EXTERN template void | RefineSolutionLU (const Matrix< complexdouble, Hermitian, ColHermPacked > &, const Matrix< complexdouble, Hermitian, ColHermPacked > &, const Vector< int > &, Vector< complexdouble > &, const Vector< complexdouble > &, double &, double &, LapackInfo &) |
SELDON_EXTERN template void | RefineSolutionLU (const Matrix< double, General, @storage_blasT > &, Vector< double > &, const Vector< double > &, double &, double &, LapackInfo &) |
SELDON_EXTERN template void | RefineSolutionLU (const SeldonTranspose &, const SeldonDiag &, const Matrix< double, General, @storage_blasT > &, Vector< double > &, const Vector< double > &, double &, double &, LapackInfo &) |
SELDON_EXTERN template void | RefineSolutionLU (const Matrix< complexdouble, General, @storage_blasT > &, Vector< complexdouble > &, const Vector< complexdouble > &, double &, double &, LapackInfo &) |
SELDON_EXTERN template void | RefineSolutionLU (const SeldonTranspose &, const SeldonDiag &, const Matrix< complexdouble, General, @storage_blasTCol > &, Vector< complexdouble > &, const Vector< complexdouble > &, double &, double &, LapackInfo &) |
SELDON_EXTERN template void | RefineSolutionLU (const SeldonTranspose &, const SeldonDiag &, const Matrix< complexdouble, General, @storage_blasTRow > &, Vector< complexdouble > &, Vector< complexdouble > &, double &, double &, LapackInfo &) |
SELDON_EXTERN template void | GetInverse (Matrix< @real_complex, General, @storage_blasGE > &, LapackInfo &) |
SELDON_EXTERN template void | GetInverse (Matrix< @real_complex, Symmetric, @storage_blasS > &, LapackInfo &) |
SELDON_EXTERN template void | GetInverse (Matrix< @complex, Hermitian, @storage_blasH > &, LapackInfo &) |
SELDON_EXTERN template void | GetInverse (Matrix< @real_complex, General, @storage_blasT > &, LapackInfo &) |
SELDON_EXTERN template void | GetInverse (const SeldonDiag &, Matrix< @real_complex, General, @storage_blasT > &, LapackInfo &) |
SELDON_EXTERN template void | GetScalingFactors (const Matrix< @real, General, @storage_blasGE > &, Vector< @real > &, Vector< @real > &, @real &, @real &, @real &, LapackInfo &) |
SELDON_EXTERN template void | GetScalingFactors (const Matrix< complexdouble, General, @storage_blasGE > &, Vector< double > &, Vector< double > &, double &, double &, double &, LapackInfo &) |
SELDON_EXTERN template void | GetCholesky (Matrix< double, Symmetric, @storage_blasS > &, LapackInfo &) |
SELDON_EXTERN template void | GetCholesky (Matrix< complexdouble, Hermitian, @storage_blasH > &, LapackInfo &) |
SELDON_EXTERN template void | SolveCholesky (const @trans &, const Matrix< double, Symmetric, @storage_blasS > &, Vector< double > &, LapackInfo &) |
SELDON_EXTERN template void | SolveCholesky (const @trans &, const Matrix< complexdouble, Hermitian, @storage_blasH > &, Vector< complexdouble > &, LapackInfo &) |
SELDON_EXTERN template void | MltCholesky (const @trans &, const Matrix< double, Symmetric, @storage_blasS > &, Vector< double > &, LapackInfo &) |
SELDON_EXTERN template void | MltCholesky (const @trans &, const Matrix< complexdouble, Hermitian, @storage_blasH > &, Vector< complexdouble > &, LapackInfo &) |
SELDON_EXTERN template void | GetQR (Matrix< @real_complex, General, @storage_blasGE > &, Vector< @real_complex > &, LapackInfo &) |
SELDON_EXTERN template void | GetLQ (Matrix< @real_complex, General, @storage_blasGE > &, Vector< @real_complex > &, LapackInfo &) |
SELDON_EXTERN template void | GetQ_FromQR (Matrix< @real_complex, General, @storage_blasGE > &, Vector< @real_complex > &, LapackInfo &) |
SELDON_EXTERN template void | GetQ_FromLQ (Matrix< @real_complex, General, @storage_blasGE > &, Vector< @real_complex > &, LapackInfo &) |
SELDON_EXTERN template void | MltQ_FromQR (const @trans &, const Matrix< @real_complex, General, @storage_blasGE > &, const Vector< @real_complex > &, Vector< @real_complex > &, LapackInfo &) |
SELDON_EXTERN template void | MltQ_FromQR (const @side &, const @trans &, const Matrix< @real_complex, General, @storage_blasGE > &, const Vector< @real_complex > &, Matrix< @real_complex, General, @storage_blasGE > &, LapackInfo &) |
SELDON_EXTERN template void | MltQ_FromLQ (const @trans &, const Matrix< @real_complex, General, @storage_blasGE > &, const Vector< @real_complex > &, Vector< @real_complex > &, LapackInfo &) |
SELDON_EXTERN template void | MltQ_FromLQ (const @side &, const @trans &, const Matrix< @real_complex, General, @storage_blasGE > &, const Vector< @real_complex > &, Matrix< @real_complex, General, @storage_blasGE > &, LapackInfo &) |
SELDON_EXTERN template void | SolveQR (const Matrix< @real_complex, General, @storage_blasGE > &, const Vector< @real_complex > &, Vector< @real_complex > &, LapackInfo &) |
SELDON_EXTERN template void | SolveLQ (const Matrix< @real_complex, General, @storage_blasGE > &, const Vector< @real_complex > &, Vector< @real_complex > &, LapackInfo &) |
SELDON_EXTERN template void | GetLowerTriangular (const Matrix< @real_complex, General, @storage_blasGE > &, Matrix< @real_complex, General, @storage_blasGE > &) |
SELDON_EXTERN template void | GetUpperTriangular (const Matrix< @real_complex, General, @storage_blasGE > &, Matrix< @real_complex, General, @storage_blasGE > &) |
SELDON_EXTERN template void | GetQR (const Matrix< @real_complex, General, @storage_blasGE > &, Matrix< @real_complex, General, @storage_blasGE > &, Matrix< @real_complex, General, @storage_blasGE > &) |
SELDON_EXTERN template void | GetLQ (const Matrix< @real_complex, General, @storage_blasGE > &, Matrix< @real_complex, General, @storage_blasGE > &, Matrix< @real_complex, General, @storage_blasGE > &) |
SELDON_EXTERN template void | GetEigenvalues (Matrix< @real, General, @storage_blasGE > &, Vector< @real > &, Vector< @real > &, LapackInfo &info) |
SELDON_EXTERN template void | GetEigenvalues (Matrix< @complex, General, @storage_blasGE > &, Vector< @complex > &, LapackInfo &info) |
SELDON_EXTERN template void | GetEigenvaluesEigenvectors (Matrix< @real, General, @storage_blasGE > &, Vector< @real > &, Vector< @real > &, Matrix< @real, General, @storage_blasGE > &, LapackInfo &info) |
SELDON_EXTERN template void | GetEigenvaluesEigenvectors (Matrix< @complex, General, @storage_blasGE > &, Vector< @complex > &, Matrix< @complex, General, @storage_blasGE > &, LapackInfo &info) |
SELDON_EXTERN template void | GetEigenvalues (Matrix< @real_complex, Symmetric, RowSym > &, Vector< @real_complex > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvaluesEigenvectors (Matrix< @real_complex, Symmetric, RowSym > &, Vector< @real_complex > &, Matrix< @real_complex, General, RowMajor > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvalues (Matrix< @real_complex, Symmetric, ColSym > &, Vector< @real_complex > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvaluesEigenvectors (Matrix< @real_complex, Symmetric, ColSym > &, Vector< @real_complex > &, Matrix< @real_complex, General, ColMajor > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvalues (Matrix< @real_complex, Symmetric, RowSymPacked > &, Vector< @real_complex > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvaluesEigenvectors (Matrix< @real_complex, Symmetric, RowSymPacked > &, Vector< @real_complex > &, Matrix< @real_complex, General, RowMajor > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvalues (Matrix< @real_complex, Symmetric, ColSymPacked > &, Vector< @real_complex > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvaluesEigenvectors (Matrix< @real_complex, Symmetric, ColSymPacked > &, Vector< @real_complex > &, Matrix< @real_complex, General, ColMajor > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvalues (Matrix< complex< double >, Hermitian, RowHerm > &, Vector< double > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvaluesEigenvectors (Matrix< complex< double >, Hermitian, RowHerm > &, Vector< double > &, Matrix< complex< double >, General, RowMajor > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvalues (Matrix< complex< double >, Hermitian, ColHerm > &, Vector< double > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvaluesEigenvectors (Matrix< complex< double >, Hermitian, ColHerm > &, Vector< double > &, Matrix< complex< double >, General, ColMajor > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvalues (Matrix< complex< double >, Hermitian, RowHermPacked > &, Vector< double > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvaluesEigenvectors (Matrix< complex< double >, Hermitian, RowHermPacked > &, Vector< double > &, Matrix< complex< double >, General, RowMajor > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvalues (Matrix< complex< double >, Hermitian, ColHermPacked > &, Vector< double > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvaluesEigenvectors (Matrix< complex< double >, Hermitian, ColHermPacked > &, Vector< double > &, Matrix< complex< double >, General, ColMajor > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvalues (Matrix< complex< double >, Symmetric, RowSym > &, Matrix< complex< double >, Symmetric, RowSym > &, Vector< complex< double > > &, Vector< complex< double > > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvaluesEigenvectors (Matrix< complex< double >, Symmetric, RowSym > &, Matrix< complex< double >, Symmetric, RowSym > &, Vector< complex< double > > &, Vector< complex< double > > &, Matrix< complex< double >, General, RowMajor > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvalues (Matrix< double, Symmetric, ColSym > &, Matrix< double, Symmetric, ColSym > &, Vector< double > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvaluesEigenvectors (Matrix< double, Symmetric, ColSym > &, Matrix< double, Symmetric, ColSym > &, Vector< double > &, Matrix< double, General, ColMajor > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvalues (Matrix< complex< double >, Symmetric, ColSym > &, Matrix< complex< double >, Symmetric, ColSym > &, Vector< complex< double > > &, Vector< complex< double > > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvaluesEigenvectors (Matrix< complex< double >, Symmetric, ColSym > &, Matrix< complex< double >, Symmetric, ColSym > &, Vector< complex< double > > &, Vector< complex< double > > &, Matrix< complex< double >, General, ColMajor > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvalues (Matrix< complex< double >, Symmetric, RowSymPacked > &, Matrix< complex< double >, Symmetric, RowSymPacked > &, Vector< complex< double > > &, Vector< complex< double > > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvaluesEigenvectors (Matrix< complex< double >, Symmetric, RowSymPacked > &, Matrix< complex< double >, Symmetric, RowSymPacked > &, Vector< complex< double > > &, Vector< complex< double > > &, Matrix< complex< double >, General, RowMajor > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvalues (Matrix< double, Symmetric, ColSymPacked > &, Matrix< double, Symmetric, ColSymPacked > &, Vector< double > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvaluesEigenvectors (Matrix< double, Symmetric, ColSymPacked > &, Matrix< double, Symmetric, ColSymPacked > &, Vector< double > &, Matrix< double, General, ColMajor > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvalues (Matrix< complex< double >, Symmetric, ColSymPacked > &, Matrix< complex< double >, Symmetric, ColSymPacked > &, Vector< complex< double > > &, Vector< complex< double > > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvaluesEigenvectors (Matrix< complex< double >, Symmetric, ColSymPacked > &, Matrix< complex< double >, Symmetric, ColSymPacked > &, Vector< complex< double > > &, Vector< complex< double > > &, Matrix< complex< double >, General, ColMajor > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvalues (Matrix< complex< double >, Hermitian, RowHerm > &, Matrix< complex< double >, Hermitian, RowHerm > &, Vector< double > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvaluesEigenvectors (Matrix< complex< double >, Hermitian, RowHerm > &, Matrix< complex< double >, Hermitian, RowHerm > &, Vector< double > &, Matrix< complex< double >, General, RowMajor > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvalues (Matrix< complex< double >, Hermitian, ColHerm > &, Matrix< complex< double >, Hermitian, ColHerm > &, Vector< double > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvaluesEigenvectors (Matrix< complex< double >, Hermitian, ColHerm > &, Matrix< complex< double >, Hermitian, ColHerm > &, Vector< double > &, Matrix< complex< double >, General, ColMajor > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvalues (Matrix< complex< double >, Hermitian, RowHermPacked > &, Matrix< complex< double >, Hermitian, RowHermPacked > &, Vector< double > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvaluesEigenvectors (Matrix< complex< double >, Hermitian, RowHermPacked > &, Matrix< complex< double >, Hermitian, RowHermPacked > &, Vector< double > &, Matrix< complex< double >, General, RowMajor > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvalues (Matrix< complex< double >, Hermitian, ColHermPacked > &, Matrix< complex< double >, Hermitian, ColHermPacked > &, Vector< double > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvaluesEigenvectors (Matrix< complex< double >, Hermitian, ColHermPacked > &, Matrix< complex< double >, Hermitian, ColHermPacked > &, Vector< double > &, Matrix< complex< double >, General, ColMajor > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvalues (Matrix< @real, General, @storage_blasGE > &, Matrix< @real, General, @storage_blasGE > &, Vector< @real > &, Vector< @real > &, Vector< @real > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvaluesEigenvectors (Matrix< @real, General, @storage_blasGE > &, Matrix< @real, General, @storage_blasGE > &, Vector< @real > &, Vector< @real > &, Vector< @real > &, Matrix< @real, General, @storage_blasGE > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvalues (Matrix< @complex, General, @storage_blasGE > &, Matrix< @complex, General, @storage_blasGE > &, Vector< @complex > &, Vector< @complex > &, LapackInfo &) |
SELDON_EXTERN template void | GetEigenvaluesEigenvectors (Matrix< @complex, General, @storage_blasGE > &, Matrix< @complex, General, @storage_blasGE > &, Vector< @complex > &, Vector< @complex > &, Matrix< @complex, General, @storage_blasGE > &, LapackInfo &) |
SELDON_EXTERN template void | GetSVD (Matrix< double, General, @storage_blasGE > &, Vector< double > &, Matrix< double, General, @storage_blasGE > &, Matrix< double, General, @storage_blasGE > &, LapackInfo &) |
SELDON_EXTERN template void | GetSVD (Matrix< complex< double >, General, @storage_blasGE > &, Vector< double > &, Matrix< complex< double >, General, @storage_blasGE > &, Matrix< complex< double >, General, @storage_blasGE > &, LapackInfo &) |
SELDON_EXTERN template void | GetPseudoInverse (Matrix< double, General, @storage_blasGE > &, const double &, LapackInfo &) |
SELDON_EXTERN template void | GetPseudoInverse (Matrix< complex< double >, General, @storage_blasGE > &, const double &, LapackInfo &) |
SELDON_EXTERN template void | GetHessenberg (Matrix< complex< double >, General, @storage_blasGE > &, Matrix< complex< double >, General, @storage_blasGE > &, LapackInfo &) |
SELDON_EXTERN template void | GetHessenberg (Matrix< complex< double >, General, @storage_blasGE > &, Matrix< complex< double >, General, @storage_blasGE > &, Matrix< complex< double >, General, @storage_blasGE > &, Matrix< complex< double >, General, @storage_blasGE > &, LapackInfo &) |
SELDON_EXTERN template void | GetQZ (Matrix< complex< double >, General, @storage_blasGE > &, Matrix< complex< double >, General, @storage_blasGE > &, Matrix< complex< double >, General, @storage_blasGE > &, Matrix< complex< double >, General, @storage_blasGE > &, LapackInfo &) |
SELDON_EXTERN template void | GetHessenberg (Matrix< double, General, @storage_blasGE > &, Matrix< double, General, @storage_blasGE > &, LapackInfo &) |
SELDON_EXTERN template void | GetHessenberg (Matrix< double, General, @storage_blasGE > &, Matrix< double, General, @storage_blasGE > &, Matrix< double, General, @storage_blasGE > &, Matrix< double, General, @storage_blasGE > &, LapackInfo &) |
SELDON_EXTERN template void | GetQZ (Matrix< double, General, @storage_blasGE > &, Matrix< double, General, @storage_blasGE > &, Matrix< double, General, @storage_blasGE > &, Matrix< double, General, @storage_blasGE > &, LapackInfo &) |
SELDON_EXTERN template void | SolveHessenberg (Matrix< double, General, @storage_blasGE > &, Vector< double > &) |
SELDON_EXTERN template void | SolveHessenberg (Matrix< complex< double >, General, @storage_blasGE > &, Vector< complex< double > > &) |
SELDON_EXTERN template void | SolveHessenbergTwo (Matrix< double, General, @storage_blasGE > &, Vector< double > &) |
SELDON_EXTERN template void | SolveHessenbergTwo (Matrix< complex< double >, General, @storage_blasGE > &, Vector< complex< double > > &) |
SELDON_EXTERN template void | SolveSylvester (Matrix< double, General, @storage_blasGE > &, Matrix< double, General, @storage_blasGE > &, Matrix< double, General, @storage_blasGE > &, Matrix< double, General, @storage_blasGE > &, Matrix< double, General, @storage_blasGE > &) |
SELDON_EXTERN template void | SolveSylvester (Matrix< complex< double >, General, @storage_blasGE > &, Matrix< complex< double >, General, @storage_blasGE > &, Matrix< complex< double >, General, @storage_blasGE > &, Matrix< complex< double >, General, @storage_blasGE > &, Matrix< complex< double >, General, @storage_blasGE > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Matrix< @complex, General, @storage_blasHE, MallocAlloc< @complex > > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Matrix< @real_complex, General, @storage_blasSY, MallocAlloc< @real_complex > > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Matrix< @real_complex, General, @storage_blasTR, MallocAlloc< @real_complex > > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Matrix< @complex, General, @storage_blasHE, NewAlloc< @complex > > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Matrix< @real_complex, General, @storage_blasSY, NewAlloc< @real_complex > > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Matrix< @real_complex, General, @storage_blasTR, NewAlloc< @real_complex > > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Matrix< @complex, General, @storage_blasHP, MallocAlloc< @complex > > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Matrix< @real_complex, General, @storage_blasSP, MallocAlloc< @real_complex > > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Matrix< @real_complex, General, @storage_blasTP, MallocAlloc< @real_complex > > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Matrix< @complex, General, @storage_blasHP, NewAlloc< @complex > > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Matrix< @real_complex, General, @storage_blasSP, NewAlloc< @real_complex > > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &, const Matrix< @real_complex, General, @storage_blasTP, NewAlloc< @real_complex > > &) |
SELDON_EXTERN template ostream & | operator<< (ostream &out, const Vector< @scalar, VectFull, MallocAlloc< @scalar > > &V) |
SELDON_EXTERN template ostream & | operator<< (ostream &out, const Vector< @scalar, VectFull, NewAlloc< @scalar > > &V) |
SELDON_EXTERN template void | QuickSort (int, int, Vector< @real, VectFull, NewAlloc< @real > > &) |
SELDON_EXTERN template void | QuickSort (int, int, Vector< @real, VectFull, NewAlloc< @real > > &, Vector< @real, VectFull, NewAlloc< @real > > &) |
SELDON_EXTERN template void | QuickSort (int, int, Vector< @real, VectFull, NewAlloc< @real > > &, Vector< @real, VectFull, NewAlloc< @real > > &, Vector< @real, VectFull, NewAlloc< @real > > &) |
SELDON_EXTERN template void | MergeSort (int, int, Vector< @real, VectFull, NewAlloc< @real > > &) |
SELDON_EXTERN template void | MergeSort (int, int, Vector< @real, VectFull, NewAlloc< @real > > &, Vector< @real, VectFull, NewAlloc< @real > > &) |
SELDON_EXTERN template void | MergeSort (int, int, Vector< @real, VectFull, NewAlloc< @real > > &, Vector< @real, VectFull, NewAlloc< @real > > &, Vector< @real, VectFull, NewAlloc< @real > > &) |
SELDON_EXTERN template void | Sort (int, int, Vector< @real, VectFull, NewAlloc< @real > > &) |
SELDON_EXTERN template void | Sort (int, int, Vector< @real, VectFull, NewAlloc< @real > > &, Vector< @real, VectFull, NewAlloc< @real > > &) |
SELDON_EXTERN template void | Sort (int, int, Vector< @real, VectFull, NewAlloc< @real > > &, Vector< @real, VectFull, NewAlloc< @real > > &, Vector< @real, VectFull, NewAlloc< @real > > &) |
SELDON_EXTERN template void | Sort (int, Vector< @real, VectFull, NewAlloc< @real > > &) |
SELDON_EXTERN template void | Sort (int, Vector< @real, VectFull, NewAlloc< @real > > &, Vector< @real, VectFull, NewAlloc< @real > > &) |
SELDON_EXTERN template void | Sort (int, Vector< @real, VectFull, NewAlloc< @real > > &, Vector< @real, VectFull, NewAlloc< @real > > &, Vector< @real, VectFull, NewAlloc< @real > > &) |
SELDON_EXTERN template void | Sort (Vector< @real, VectFull, NewAlloc< @real > > &) |
SELDON_EXTERN template void | Sort (Vector< @real, VectFull, NewAlloc< @real > > &, Vector< @real, VectFull, NewAlloc< @real > > &) |
SELDON_EXTERN template void | Sort (Vector< @real, VectFull, NewAlloc< @real > > &, Vector< @real, VectFull, NewAlloc< @real > > &, Vector< @real, VectFull, NewAlloc< @real > > &) |
SELDON_EXTERN template void | Assemble (int &, Vector< int, VectFull, NewAlloc< int > > &, Vector< @real, VectFull, NewAlloc< @real > > &) |
SELDON_EXTERN template void | Assemble (int &, Vector< int, VectFull, NewAlloc< int > > &) |
SELDON_EXTERN template void | Assemble (Vector< int, VectFull, NewAlloc< int > > &) |
SELDON_EXTERN template void | RemoveDuplicate (int &, Vector< int, VectFull, NewAlloc< int > > &, Vector< @real, VectFull, NewAlloc< @real > > &) |
SELDON_EXTERN template void | RemoveDuplicate (int &, Vector< int, VectFull, NewAlloc< int > > &) |
SELDON_EXTERN template void | RemoveDuplicate (Vector< int, VectFull, NewAlloc< int > > &) |
template<class T0 , class Allocator0 , class T1 , class Allocator1 > | |
void | GetRow (const Matrix< T0, General, RowSparse, Allocator0 > &M, int i, Vector< T1, VectSparse, Allocator1 > &X) |
Extracts a row from a sparse matrix. More... | |
template<class T0 , class Allocator0 , class T1 , class Allocator1 > | |
void | GetRow (const Matrix< T0, General, ColSparse, Allocator0 > &M, int i, Vector< T1, VectSparse, Allocator1 > &X) |
Extracts a row from a sparse matrix. More... | |
template<class T0 , class Allocator0 , class T1 , class Allocator1 > | |
void | GetRow (const Matrix< T0, Symmetric, RowSymSparse, Allocator0 > &M, int i, Vector< T1, VectSparse, Allocator1 > &X) |
Extracts a row from a sparse matrix. More... | |
template<class T0 , class Allocator0 , class T1 , class Allocator1 > | |
void | GetRow (const Matrix< T0, Symmetric, ColSymSparse, Allocator0 > &M, int i, Vector< T1, VectSparse, Allocator1 > &X) |
Extracts a row from a sparse matrix. More... | |
template<class T0 , class Prop0 , class Storage0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 > | |
void | GetRow (const Matrix< T0, Prop0, Storage0, Allocator0 > &M, int i, Vector< T1, Storage1, Allocator1 > &X) |
Extracts a row from a matrix. More... | |
template<class T0 , class Allocator0 , class T1 , class Allocator1 > | |
void | GetCol (const Matrix< T0, General, ColSparse, Allocator0 > &M, int j, Vector< T1, VectSparse, Allocator1 > &X) |
Extracts a column from a sparse matrix. More... | |
template<class T0 , class Allocator0 , class T1 , class Allocator1 > | |
void | GetCol (const Matrix< T0, General, RowSparse, Allocator0 > &M, int j, Vector< T1, VectSparse, Allocator1 > &X) |
Extracts a column from a matrix. More... | |
template<class T0 , class Allocator0 , class T1 , class Allocator1 > | |
void | GetCol (const Matrix< T0, Symmetric, ColSymSparse, Allocator0 > &M, int j, Vector< T1, VectSparse, Allocator1 > &X) |
Extracts a column from a sparse matrix. More... | |
template<class T0 , class Allocator0 , class T1 , class Allocator1 > | |
void | GetCol (const Matrix< T0, Symmetric, RowSymSparse, Allocator0 > &M, int j, Vector< T1, VectSparse, Allocator1 > &X) |
Extracts a column from a sparse matrix. More... | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Allocator1 > | |
void | GetCol (const Matrix< T0, Prop0, PETScSeqDense, Allocator0 > &M, int j, Vector< T1, PETScSeq, Allocator1 > &X) |
Extracts a column from a matrix. More... | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Allocator1 > | |
void | GetCol (const Matrix< T0, Prop0, PETScMPIDense, Allocator0 > &M, int j, Vector< T1, PETScPar, Allocator1 > &X) |
Extracts a column from a matrix. More... | |
template<class T0 , class Prop0 , class Storage0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 > | |
void | GetCol (const Matrix< T0, Prop0, Storage0, Allocator0 > &M, int j, Vector< T1, Storage1, Allocator1 > &X) |
Extracts a column from a matrix. More... | |
template<class T0 , class Prop0 , class Storage0 , class Allocator0 , class T1 , class Prop1 , class Storage1 , class Allocator1 > | |
void | GetCol (const Matrix< T0, Prop0, Storage0, Allocator0 > &M_in, int begin, int end, Matrix< T1, Prop1, Storage1, Allocator1 > &M_out) |
Extracts columns of a matrix. More... | |
template<class T0 , class Prop0 , class Storage0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 > | |
void | SetRow (const Vector< T1, Storage1, Allocator1 > &X, int i, Matrix< T0, Prop0, Storage0, Allocator0 > &M) |
Sets a row of a matrix. More... | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Allocator1 > | |
void | SetRow (const Vector< T1, PETScSeq, Allocator1 > &X, int i, Matrix< T0, Prop0, PETScSeqDense, Allocator0 > &M) |
Sets a row of a matrix. More... | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Allocator1 > | |
void | SetRow (const Vector< T1, PETScPar, Allocator1 > &X, int i, Matrix< T0, Prop0, PETScMPIDense, Allocator0 > &M) |
Sets a row of a matrix. More... | |
template<class T0 , class Allocator0 , class T1 , class Allocator1 > | |
void | SetRow (const Vector< T1, VectSparse, Allocator1 > &X, int i, Matrix< T0, General, RowSparse, Allocator0 > &M) |
Sets a row of a matrix. More... | |
template<class T0 , class Allocator0 , class T1 , class Allocator1 > | |
void | SetRow (const Vector< T1, VectSparse, Allocator1 > &X, int i, Matrix< T0, General, ColSparse, Allocator0 > &M) |
Sets a row of a matrix. More... | |
template<class T0 , class Allocator0 , class T1 , class Allocator1 > | |
void | SetRow (const Vector< T1, VectSparse, Allocator1 > &X, int i, Matrix< T0, Symmetric, RowSymSparse, Allocator0 > &M) |
Sets a row of a matrix. More... | |
template<class T0 , class Allocator0 , class T1 , class Allocator1 > | |
void | SetRow (const Vector< T1, VectSparse, Allocator1 > &X, int i, Matrix< T0, Symmetric, ColSymSparse, Allocator0 > &M) |
Sets a row of a matrix. More... | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 > | |
void | SetRow (const Vector< T1, Storage1, Allocator1 > &X, int i, Matrix< T0, Prop0, RowLoTriang, Allocator0 > &M) |
Sets a row of a matrix. More... | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 > | |
void | SetRow (const Vector< T1, Storage1, Allocator1 > &X, int i, Matrix< T0, Prop0, RowLoTriangPacked, Allocator0 > &M) |
Sets a row of a matrix. More... | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 > | |
void | SetRow (const Vector< T1, Storage1, Allocator1 > &X, int i, Matrix< T0, Prop0, ColLoTriang, Allocator0 > &M) |
Sets a row of a matrix. More... | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 > | |
void | SetRow (const Vector< T1, Storage1, Allocator1 > &X, int i, Matrix< T0, Prop0, ColLoTriangPacked, Allocator0 > &M) |
Sets a row of a matrix. More... | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 > | |
void | SetRow (const Vector< T1, Storage1, Allocator1 > &X, int i, Matrix< T0, Prop0, RowUpTriang, Allocator0 > &M) |
Sets a row of a matrix. More... | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 > | |
void | SetRow (const Vector< T1, Storage1, Allocator1 > &X, int i, Matrix< T0, Prop0, RowUpTriangPacked, Allocator0 > &M) |
Sets a row of a matrix. More... | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 > | |
void | SetRow (const Vector< T1, Storage1, Allocator1 > &X, int i, Matrix< T0, Prop0, ColUpTriang, Allocator0 > &M) |
Sets a row of a matrix. More... | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 > | |
void | SetRow (const Vector< T1, Storage1, Allocator1 > &X, int i, Matrix< T0, Prop0, ColUpTriangPacked, Allocator0 > &M) |
Sets a row of a matrix. More... | |
template<class T0 , class Prop0 , class Storage0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 > | |
void | SetCol (const Vector< T1, Storage1, Allocator1 > &X, int j, Matrix< T0, Prop0, Storage0, Allocator0 > &M) |
Sets a column of a matrix. More... | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Allocator1 > | |
void | SetCol (const Vector< T1, PETScSeq, Allocator1 > &X, int j, Matrix< T0, Prop0, PETScSeqDense, Allocator0 > &M) |
Sets a column of a matrix. More... | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Allocator1 > | |
void | SetCol (const Vector< T1, PETScPar, Allocator1 > &X, int j, Matrix< T0, Prop0, PETScMPIDense, Allocator0 > &M) |
Sets a column of a matrix. More... | |
template<class T0 , class Allocator0 , class T1 , class Allocator1 > | |
void | SetCol (const Vector< T1, VectFull, Allocator1 > &X, int j, Matrix< T0, General, RowSparse, Allocator0 > &M) |
Sets a column of a matrix. More... | |
template<class T0 , class Allocator0 , class T1 , class Allocator1 > | |
void | SetCol (const Vector< T1, VectSparse, Allocator1 > &X, int j, Matrix< T0, General, RowSparse, Allocator0 > &M) |
Sets a column of a matrix. More... | |
template<class T0 , class Allocator0 , class T1 , class Allocator1 > | |
void | SetCol (const Vector< T1, VectSparse, Allocator1 > &X, int j, Matrix< T0, General, ColSparse, Allocator0 > &M) |
Sets a column of a matrix. More... | |
template<class T0 , class Allocator0 , class T1 , class Allocator1 > | |
void | SetCol (const Vector< T1, VectSparse, Allocator1 > &X, int j, Matrix< T0, Symmetric, RowSymSparse, Allocator0 > &M) |
Sets a column of a matrix. More... | |
template<class T0 , class Allocator0 , class T1 , class Allocator1 > | |
void | SetCol (const Vector< T1, VectSparse, Allocator1 > &X, int j, Matrix< T0, Symmetric, ColSymSparse, Allocator0 > &M) |
Sets a column of a matrix. More... | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 > | |
void | SetCol (const Vector< T1, Storage1, Allocator1 > &X, int j, Matrix< T0, Prop0, RowLoTriang, Allocator0 > &M) |
Sets a column of a matrix. More... | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 > | |
void | SetCol (const Vector< T1, Storage1, Allocator1 > &X, int j, Matrix< T0, Prop0, RowLoTriangPacked, Allocator0 > &M) |
Sets a column of a matrix. More... | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 > | |
void | SetCol (const Vector< T1, Storage1, Allocator1 > &X, int j, Matrix< T0, Prop0, ColLoTriang, Allocator0 > &M) |
Sets a column of a matrix. More... | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 > | |
void | SetCol (const Vector< T1, Storage1, Allocator1 > &X, int j, Matrix< T0, Prop0, ColLoTriangPacked, Allocator0 > &M) |
Sets a column of a matrix. More... | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 > | |
void | SetCol (const Vector< T1, Storage1, Allocator1 > &X, int j, Matrix< T0, Prop0, RowUpTriang, Allocator0 > &M) |
Sets a column of a matrix. More... | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 > | |
void | SetCol (const Vector< T1, Storage1, Allocator1 > &X, int j, Matrix< T0, Prop0, RowUpTriangPacked, Allocator0 > &M) |
Sets a column of a matrix. More... | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 > | |
void | SetCol (const Vector< T1, Storage1, Allocator1 > &X, int j, Matrix< T0, Prop0, ColUpTriang, Allocator0 > &M) |
Sets a column of a matrix. More... | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 > | |
void | SetCol (const Vector< T1, Storage1, Allocator1 > &X, int j, Matrix< T0, Prop0, ColUpTriangPacked, Allocator0 > &M) |
Sets a column of a matrix. More... | |
template<class T , class Prop , class Allocator > | |
void | ApplyPermutation (Matrix< T, Prop, RowMajor, Allocator > &A, const Vector< int > &row_perm, const Vector< int > &col_perm, int starting_index) |
Permutation of a general matrix stored by rows. More... | |
template<class T , class Prop , class Allocator > | |
void | ApplyPermutation (Matrix< T, Prop, ColMajor, Allocator > &A, const Vector< int > &row_perm, const Vector< int > &col_perm, int starting_index) |
Permutation of a general matrix stored by columns. More... | |
template<class T , class Prop , class Allocator > | |
void | ApplyPermutation (Matrix< T, Prop, RowSymPacked, Allocator > &A, const Vector< int > &row_perm, const Vector< int > &col_perm, int starting_index) |
Permutation of a symmetric matrix stored by rows. More... | |
template<class T , class Prop , class Allocator > | |
void | ApplyPermutation (Matrix< T, Prop, ColSymPacked, Allocator > &A, const Vector< int > &row_perm, const Vector< int > &col_perm, int starting_index) |
Permutation of a symmetric matrix stored by columns. More... | |
template<class T , class Prop , class Allocator > | |
void | ApplyPermutation (Matrix< T, Prop, RowSym, Allocator > &A, const Vector< int > &row_perm, const Vector< int > &col_perm, int starting_index) |
Permutation of a symmetric matrix stored by rows. More... | |
template<class T , class Prop , class Allocator > | |
void | ApplyPermutation (Matrix< T, Prop, ColSym, Allocator > &A, const Vector< int > &row_perm, const Vector< int > &col_perm, int starting_index) |
Permutation of a symmetric matrix stored by columns. More... | |
template<class T , class Prop , class Allocator > | |
void | ApplyPermutation (Matrix< T, Prop, RowHermPacked, Allocator > &A, const Vector< int > &row_perm, const Vector< int > &col_perm, int starting_index) |
Permutation of an hermitian matrix stored by rows. More... | |
template<class T , class Prop , class Allocator > | |
void | ApplyPermutation (Matrix< T, Prop, ColHermPacked, Allocator > &A, const Vector< int > &row_perm, const Vector< int > &col_perm, int starting_index) |
Permutation of an hermitian matrix stored by columns. More... | |
template<class T , class Prop , class Allocator > | |
void | ApplyPermutation (Matrix< T, Prop, RowHerm, Allocator > &A, const Vector< int > &row_perm, const Vector< int > &col_perm, int starting_index) |
Permutation of an hermitian matrix stored by rows. More... | |
template<class T , class Prop , class Allocator > | |
void | ApplyPermutation (Matrix< T, Prop, ColHerm, Allocator > &A, const Vector< int > &row_perm, const Vector< int > &col_perm, int starting_index) |
Permutation of an hermitian matrix stored by columns. More... | |
template<class T , class Prop , class Allocator > | |
void | ApplyInversePermutation (Matrix< T, Prop, RowMajor, Allocator > &A, const Vector< int > &row_perm, const Vector< int > &col_perm, int starting_index) |
Inverse permutation of a general matrix stored by rows. More... | |
template<class T , class Prop , class Allocator > | |
void | ApplyInversePermutation (Matrix< T, Prop, ColMajor, Allocator > &A, const Vector< int > &row_perm, const Vector< int > &col_perm, int starting_index) |
Inverse permutation of a general matrix stored by columns. More... | |
template<class T , class Prop , class Allocator > | |
void | ApplyInversePermutation (Matrix< T, Prop, RowSymPacked, Allocator > &A, const Vector< int > &row_perm, const Vector< int > &col_perm, int starting_index) |
Inverse permutation of a symmetric matrix stored by rows. More... | |
template<class T , class Prop , class Allocator > | |
void | ApplyInversePermutation (Matrix< T, Prop, ColSymPacked, Allocator > &A, const Vector< int > &row_perm, const Vector< int > &col_perm, int starting_index) |
Inverse permutation of a symmetric matrix stored by columns. More... | |
template<class T , class Prop , class Allocator > | |
void | ApplyInversePermutation (Matrix< T, Prop, RowSym, Allocator > &A, const Vector< int > &row_perm, const Vector< int > &col_perm, int starting_index) |
Inverse permutation of a symmetric matrix stored by rows. More... | |
template<class T , class Prop , class Allocator > | |
void | ApplyInversePermutation (Matrix< T, Prop, ColSym, Allocator > &A, const Vector< int > &row_perm, const Vector< int > &col_perm, int starting_index) |
Inverse permutation of a symmetric matrix stored by columns. More... | |
template<class T , class Prop , class Allocator > | |
void | ApplyInversePermutation (Matrix< T, Prop, RowHermPacked, Allocator > &A, const Vector< int > &row_perm, const Vector< int > &col_perm, int starting_index) |
Inverse permutation of an hermitian matrix stored by rows. More... | |
template<class T , class Prop , class Allocator > | |
void | ApplyInversePermutation (Matrix< T, Prop, ColHermPacked, Allocator > &A, const Vector< int > &row_perm, const Vector< int > &col_perm, int starting_index) |
Inverse permutation of an hermitian matrix stored by columns. More... | |
template<class T , class Prop , class Allocator > | |
void | ApplyInversePermutation (Matrix< T, Prop, RowHerm, Allocator > &A, const Vector< int > &row_perm, const Vector< int > &col_perm, int starting_index) |
Inverse permutation of an hermitian matrix stored by rows. More... | |
template<class T , class Prop , class Allocator > | |
void | ApplyInversePermutation (Matrix< T, Prop, ColHerm, Allocator > &A, const Vector< int > &row_perm, const Vector< int > &col_perm, int starting_index) |
Inverse permutation of an hermitian matrix stored by columns. More... | |
template<class T , class Prop , class Allocator , class T1 , class Allocator1 , class T2 , class Allocator2 > | |
void | ScaleMatrix (Matrix< T, Prop, RowMajor, Allocator > &A, const Vector< T1, VectFull, Allocator1 > &Drow, const Vector< T2, VectFull, Allocator2 > &Dcol) |
Scaling of a matrix. More... | |
template<class T , class Prop , class Allocator , class T1 , class Allocator1 , class T2 , class Allocator2 > | |
void | ScaleMatrix (Matrix< T, Prop, ColMajor, Allocator > &A, const Vector< T1, VectFull, Allocator1 > &Drow, const Vector< T2, VectFull, Allocator2 > &Dcol) |
Scaling of a matrix. More... | |
template<class T , class Prop , class Allocator , class T1 , class Allocator1 , class T2 , class Allocator2 > | |
void | ScaleMatrix (Matrix< T, Prop, RowSymPacked, Allocator > &A, const Vector< T1, VectFull, Allocator1 > &Drow, const Vector< T2, VectFull, Allocator2 > &Dcol) |
Scaling of a matrix. More... | |
template<class T , class Prop , class Allocator , class T1 , class Allocator1 , class T2 , class Allocator2 > | |
void | ScaleMatrix (Matrix< T, Prop, ColSymPacked, Allocator > &A, const Vector< T1, VectFull, Allocator1 > &Drow, const Vector< T2, VectFull, Allocator2 > &Dcol) |
Scaling of a matrix. More... | |
template<class T , class Prop , class Allocator , class T1 , class Allocator1 , class T2 , class Allocator2 > | |
void | ScaleMatrix (Matrix< T, Prop, RowSym, Allocator > &A, const Vector< T1, VectFull, Allocator1 > &Drow, const Vector< T2, VectFull, Allocator2 > &Dcol) |
Scaling of a matrix. More... | |
template<class T , class Prop , class Allocator , class T1 , class Allocator1 , class T2 , class Allocator2 > | |
void | ScaleMatrix (Matrix< T, Prop, ColSym, Allocator > &A, const Vector< T1, VectFull, Allocator1 > &Drow, const Vector< T2, VectFull, Allocator2 > &Dcol) |
Scaling of a matrix. More... | |
template<class T , class Prop , class Allocator , class T1 , class Allocator1 , class T2 , class Allocator2 > | |
void | ScaleMatrix (Matrix< T, Prop, RowHermPacked, Allocator > &A, const Vector< T1, VectFull, Allocator1 > &Drow, const Vector< T2, VectFull, Allocator2 > &Dcol) |
Scaling of a matrix. More... | |
template<class T , class Prop , class Allocator , class T1 , class Allocator1 , class T2 , class Allocator2 > | |
void | ScaleMatrix (Matrix< T, Prop, ColHermPacked, Allocator > &A, const Vector< T1, VectFull, Allocator1 > &Drow, const Vector< T2, VectFull, Allocator2 > &Dcol) |
Scaling of a matrix. More... | |
template<class T , class Prop , class Allocator , class T1 , class Allocator1 , class T2 , class Allocator2 > | |
void | ScaleMatrix (Matrix< T, Prop, RowHerm, Allocator > &A, const Vector< T1, VectFull, Allocator1 > &Drow, const Vector< T2, VectFull, Allocator2 > &Dcol) |
Scaling of a matrix. More... | |
template<class T , class Prop , class Allocator , class T1 , class Allocator1 , class T2 , class Allocator2 > | |
void | ScaleMatrix (Matrix< T, Prop, ColHerm, Allocator > &A, const Vector< T1, VectFull, Allocator1 > &Drow, const Vector< T2, VectFull, Allocator2 > &Dcol) |
Scaling of a matrix. More... | |
template<class T , class Prop , class Allocator , class T1 , class Allocator1 , class T2 , class Allocator2 > | |
void | ScaleMatrix (Matrix< T, Prop, RowLoTriangPacked, Allocator > &A, const Vector< T1, VectFull, Allocator1 > &Drow, const Vector< T2, VectFull, Allocator2 > &Dcol) |
Scaling of a matrix. More... | |
template<class T , class Prop , class Allocator , class T1 , class Allocator1 , class T2 , class Allocator2 > | |
void | ScaleMatrix (Matrix< T, Prop, RowLoTriang, Allocator > &A, const Vector< T1, VectFull, Allocator1 > &Drow, const Vector< T2, VectFull, Allocator2 > &Dcol) |
Scaling of a matrix. More... | |
template<class T , class Prop , class Allocator , class T1 , class Allocator1 , class T2 , class Allocator2 > | |
void | ScaleMatrix (Matrix< T, Prop, ColLoTriangPacked, Allocator > &A, const Vector< T1, VectFull, Allocator1 > &Drow, const Vector< T2, VectFull, Allocator2 > &Dcol) |
Scaling of a matrix. More... | |
template<class T , class Prop , class Allocator , class T1 , class Allocator1 , class T2 , class Allocator2 > | |
void | ScaleMatrix (Matrix< T, Prop, ColLoTriang, Allocator > &A, const Vector< T1, VectFull, Allocator1 > &Drow, const Vector< T2, VectFull, Allocator2 > &Dcol) |
Scaling of a matrix. More... | |
template<class T , class Prop , class Allocator , class T1 , class Allocator1 , class T2 , class Allocator2 > | |
void | ScaleMatrix (Matrix< T, Prop, RowUpTriangPacked, Allocator > &A, const Vector< T1, VectFull, Allocator1 > &Drow, const Vector< T2, VectFull, Allocator2 > &Dcol) |
Scaling of a matrix. More... | |
template<class T , class Prop , class Allocator , class T1 , class Allocator1 , class T2 , class Allocator2 > | |
void | ScaleMatrix (Matrix< T, Prop, RowUpTriang, Allocator > &A, const Vector< T1, VectFull, Allocator1 > &Drow, const Vector< T2, VectFull, Allocator2 > &Dcol) |
Scaling of a matrix. More... | |
template<class T , class Prop , class Allocator , class T1 , class Allocator1 , class T2 , class Allocator2 > | |
void | ScaleMatrix (Matrix< T, Prop, ColUpTriangPacked, Allocator > &A, const Vector< T1, VectFull, Allocator1 > &Drow, const Vector< T2, VectFull, Allocator2 > &Dcol) |
Scaling of a matrix. More... | |
template<class T , class Prop , class Allocator , class T1 , class Allocator1 , class T2 , class Allocator2 > | |
void | ScaleMatrix (Matrix< T, Prop, ColUpTriang, Allocator > &A, const Vector< T1, VectFull, Allocator1 > &Drow, const Vector< T2, VectFull, Allocator2 > &Dcol) |
Scaling of a matrix. More... | |
template<class T , class Prop , class Allocator , class T1 , class Allocator1 > | |
void | ScaleLeftMatrix (Matrix< T, Prop, RowMajor, Allocator > &A, const Vector< T1, VectFull, Allocator1 > &Drow) |
Left-scaling of a matrix. More... | |
template<class T , class Prop , class Allocator , class T1 , class Allocator1 > | |
void | ScaleLeftMatrix (Matrix< T, Prop, ColMajor, Allocator > &A, const Vector< T1, VectFull, Allocator1 > &Drow) |
Left-scaling of a matrix. More... | |
template<class T , class Prop , class Allocator , class T1 , class Allocator1 > | |
void | ScaleLeftMatrix (Matrix< T, Prop, RowLoTriangPacked, Allocator > &A, const Vector< T1, VectFull, Allocator1 > &Drow) |
Left-scaling of a matrix. More... | |
template<class T , class Prop , class Allocator , class T1 , class Allocator1 > | |
void | ScaleLeftMatrix (Matrix< T, Prop, RowLoTriang, Allocator > &A, const Vector< T1, VectFull, Allocator1 > &Drow) |
Left-scaling of a matrix. More... | |
template<class T , class Prop , class Allocator , class T1 , class Allocator1 > | |
void | ScaleLeftMatrix (Matrix< T, Prop, ColLoTriangPacked, Allocator > &A, const Vector< T1, VectFull, Allocator1 > &Drow) |
Left-scaling of a matrix. More... | |
template<class T , class Prop , class Allocator , class T1 , class Allocator1 > | |
void | ScaleLeftMatrix (Matrix< T, Prop, ColLoTriang, Allocator > &A, const Vector< T1, VectFull, Allocator1 > &Drow) |
Left-scaling of a matrix. More... | |
template<class T , class Prop , class Allocator , class T1 , class Allocator1 > | |
void | ScaleLeftMatrix (Matrix< T, Prop, RowUpTriangPacked, Allocator > &A, const Vector< T1, VectFull, Allocator1 > &Drow) |
Left-scaling of a matrix. More... | |
template<class T , class Prop , class Allocator , class T1 , class Allocator1 > | |
void | ScaleLeftMatrix (Matrix< T, Prop, RowUpTriang, Allocator > &A, const Vector< T1, VectFull, Allocator1 > &Drow) |
Left-scaling of a matrix. More... | |
template<class T , class Prop , class Allocator , class T1 , class Allocator1 > | |
void | ScaleLeftMatrix (Matrix< T, Prop, ColUpTriangPacked, Allocator > &A, const Vector< T1, VectFull, Allocator1 > &Drow) |
Left-scaling of a matrix. More... | |
template<class T , class Prop , class Allocator , class T1 , class Allocator1 > | |
void | ScaleLeftMatrix (Matrix< T, Prop, ColUpTriang, Allocator > &A, const Vector< T1, VectFull, Allocator1 > &Drow) |
Left-scaling of a matrix. More... | |
template<class T , class Prop , class Allocator , class T2 , class Allocator2 > | |
void | ScaleRightMatrix (Matrix< T, Prop, RowMajor, Allocator > &A, const Vector< T2, VectFull, Allocator2 > &Dcol) |
Right-scaling of a matrix. More... | |
template<class T , class Prop , class Allocator , class T2 , class Allocator2 > | |
void | ScaleRightMatrix (Matrix< T, Prop, ColMajor, Allocator > &A, const Vector< T2, VectFull, Allocator2 > &Dcol) |
Right-scaling of a matrix. More... | |
template<class T , class Prop , class Allocator , class T2 , class Allocator2 > | |
void | ScaleRightMatrix (Matrix< T, Prop, RowLoTriangPacked, Allocator > &A, const Vector< T2, VectFull, Allocator2 > &Dcol) |
Right-scaling of a matrix. More... | |
template<class T , class Prop , class Allocator , class T2 , class Allocator2 > | |
void | ScaleRightMatrix (Matrix< T, Prop, RowLoTriang, Allocator > &A, const Vector< T2, VectFull, Allocator2 > &Dcol) |
Right-scaling of a matrix. More... | |
template<class T , class Prop , class Allocator , class T2 , class Allocator2 > | |
void | ScaleRightMatrix (Matrix< T, Prop, ColLoTriangPacked, Allocator > &A, const Vector< T2, VectFull, Allocator2 > &Dcol) |
Right-scaling of a matrix. More... | |
template<class T , class Prop , class Allocator , class T2 , class Allocator2 > | |
void | ScaleRightMatrix (Matrix< T, Prop, ColLoTriang, Allocator > &A, const Vector< T2, VectFull, Allocator2 > &Dcol) |
Right-scaling of a matrix. More... | |
template<class T , class Prop , class Allocator , class T2 , class Allocator2 > | |
void | ScaleRightMatrix (Matrix< T, Prop, RowUpTriangPacked, Allocator > &A, const Vector< T2, VectFull, Allocator2 > &Dcol) |
Right-scaling of a matrix. More... | |
template<class T , class Prop , class Allocator , class T2 , class Allocator2 > | |
void | ScaleRightMatrix (Matrix< T, Prop, RowUpTriang, Allocator > &A, const Vector< T2, VectFull, Allocator2 > &Dcol) |
Right-scaling of a matrix. More... | |
template<class T , class Prop , class Allocator , class T2 , class Allocator2 > | |
void | ScaleRightMatrix (Matrix< T, Prop, ColUpTriangPacked, Allocator > &A, const Vector< T2, VectFull, Allocator2 > &Dcol) |
Right-scaling of a matrix. More... | |
template<class T , class Prop , class Allocator , class T2 , class Allocator2 > | |
void | ScaleRightMatrix (Matrix< T, Prop, ColUpTriang, Allocator > &A, const Vector< T2, VectFull, Allocator2 > &Dcol) |
Right-scaling of a matrix. More... | |
template<class T , class Prop , class Storage , class Allocator > | |
ClassComplexType< T >::Treal | NormFro (const Matrix< T, Prop, Storage, Allocator > &A) |
Returns Frobenius norm of matrix. | |
template<class T , class Prop , class Storage , class Allocator > | |
ostream & | operator<< (ostream &out, const Matrix< T, Prop, Storage, Allocator > &A) |
template<class T > | |
void | GetInverse (const TinyMatrix< T, General, 2, 2 > &A, TinyMatrix< T, General, 2, 2 > &B) |
B = A^-1. | |
template<class T > | |
void | GetInverse (TinyMatrix< T, General, 2, 2 > &B) |
replaces B by its inverse | |
template<class T > | |
void | GetInverse (const TinyMatrix< T, Symmetric, 2, 2 > &A, TinyMatrix< T, Symmetric, 2, 2 > &B) |
B = A^-1. | |
template<class T > | |
void | GetInverse (TinyMatrix< T, Symmetric, 2, 2 > &B) |
replaces B by its inverse | |
template<class T > | |
void | GetEigenvalues (TinyMatrix< T, General, 2, 2 > &A, TinyVector< T, 2 > &LambdaR, TinyVector< T, 2 > &LambdaI) |
computes eigenvalues of A (real matrix) | |
template<class T > | |
void | GetEigenvalues (TinyMatrix< complex< T >, General, 2, 2 > &A, TinyVector< complex< T >, 2 > &Lambda) |
computes eigenvalues of A (complex matrix) | |
template<class T > | |
void | GetSquareRoot (TinyMatrix< T, Symmetric, 2, 2 > &A) |
replaces A by its square root | |
template<class T , class Prop > | |
T | Det (const TinyMatrix< T, Prop, 3, 3 > &A) |
returns determinant of matrix A | |
template<class T > | |
void | GetInverse (const TinyMatrix< T, General, 3, 3 > &A, TinyMatrix< T, General, 3, 3 > &B) |
B = A^-1. | |
template<class T > | |
void | GetInverse (TinyMatrix< T, General, 3, 3 > &B) |
replaces B by its inverse | |
template<class T > | |
void | GetInverse (const TinyMatrix< T, Symmetric, 3, 3 > &A, TinyMatrix< T, Symmetric, 3, 3 > &B) |
B = A^-1. | |
template<class T > | |
void | GetInverse (TinyMatrix< T, Symmetric, 3, 3 > &B) |
replaces B by its inverse | |
template<class T0 , class T1 > | |
void | GetTangentialProjector (const TinyVector< T0, 3 > &n, TinyMatrix< T1, Symmetric, 3, 3 > &P) |
computation of I - n n^T where n is the normale this is the projector to tangential plane | |
template<class T0 , class T1 > | |
void | GetNormalProjector (const TinyVector< T0, 3 > &n, TinyMatrix< T1, Symmetric, 3, 3 > &P) |
computation of n n^T where n is the normale this is the projector to normale | |
template<class T0 , class T1 > | |
void | GetNormalProjector (const TinyVector< T0, 3 > &n, TinyMatrix< T1, General, 3, 3 > &P) |
computation of n n^T where n is the normale this is the projector to normale | |
template<class T , class Property , int m, int n> | |
ClassComplexType< T >::Treal | Norm2_Column (const TinyMatrix< T, Property, m, n > &A, int first_row, int index_col) |
returns norm of a column of matrix A | |
template<class T , class Property , class Storage , class Allocator > | |
ClassComplexType< T >::Treal | Norm2_Column (const Matrix< T, Property, Storage, Allocator > &A, int first_row, int index_col) |
Returns 2-norm of a column of matrix A. | |
template<class T , int m> | |
void | GetInverse (TinyMatrix< T, General, m, m > &A) |
A is replaced by its inverse. More... | |
template<class T , int m> | |
void | GetInverse (const TinyMatrix< T, General, m, m > &A, TinyMatrix< T, General, m, m > &B) |
B = A^-1. | |
template<class T , int m> | |
void | GetInverse (TinyMatrix< T, Symmetric, m, m > &A) |
replaces A by its inverse More... | |
template<class T , int m> | |
void | GetInverse (const TinyMatrix< T, Symmetric, m, m > &A, TinyMatrix< T, Symmetric, m, m > &B) |
B = A^-1. | |
template<class T , int m> | |
void | GetCholesky (TinyMatrix< T, Symmetric, m, m > &A) |
replaces A by its Cholesky factorisation | |
template<class T , class T2 , int m> | |
void | SolveCholesky (const class_SeldonNoTrans &trans, const TinyMatrix< T, Symmetric, m, m > &A, TinyVector< T2, m > &x) |
solves L x = b, assuming that GetCholesky has been called | |
template<class T , class T2 , int m> | |
void | SolveCholesky (const class_SeldonTrans &trans, const TinyMatrix< T, Symmetric, m, m > &A, TinyVector< T2, m > &x) |
solves L^T x = b, assuming that GetCholesky has been called | |
template<class T , class T2 , int m> | |
void | MltCholesky (const class_SeldonNoTrans &trans, const TinyMatrix< T, Symmetric, m, m > &A, TinyVector< T2, m > &x) |
replaces x by L x, assuming that GetCholesky has been called | |
template<class T , class T2 , int m> | |
void | MltCholesky (const class_SeldonTrans &trans, const TinyMatrix< T, Symmetric, m, m > &A, TinyVector< T2, m > &x) |
replaces x by L^T x, assuming that GetCholesky has been called | |
template<int m, class T > | |
void | GetEigenvaluesEigenvectors (TinyMatrix< T, Symmetric, m, m > &A, TinyVector< T, m > &w, TinyMatrix< T, General, m, m > &z) |
computes eigenvalues and eigenvectors of matrix A | |
template<int m, class T > | |
void | GetEigenvalues (TinyMatrix< T, Symmetric, m, m > &A, TinyVector< T, m > &w) |
computes eigenvalues of matrix A | |
template<class T , int m> | |
void | GetSquareRoot (TinyMatrix< T, Symmetric, m, m > &A) |
replaces A by its square root | |
template<class T , int m, int n, class E1 , class E2 > | |
bool | operator== (const TinyMatrixExpression< T, m, n, E1 > &u, const TinyMatrixExpression< T, m, n, E2 > &v) |
returns true if *this == u | |
template<class T , int m, int n, class E1 , class E2 > | |
bool | operator!= (const TinyMatrixExpression< T, m, n, E1 > &u, const TinyMatrixExpression< T, m, n, E2 > &v) |
returns true if *this != u | |
template<class T , int m, int n, class E > | |
ostream & | operator<< (ostream &out, const TinyMatrixExpression< T, m, n, E > &A) |
displays matrix | |
template<class T , int m, int n, class E , class T1 , class E1 > | |
TinyVector< T1, m > | dot (const TinyMatrixExpression< T, m, n, E > &A, const TinyVectorExpression< T1, n, E1 > &x) |
returns A*x | |
template<class T , int m, int n, class E , class T1 , int k, class E1 > | |
TinyMatrix< T, General, m, k > | dot (const TinyMatrixExpression< T, m, n, E > &A, const TinyMatrixExpression< T1, n, k, E1 > &B) |
returns A*B | |
template<class T0 , class E0 , class T1 , class E1 , class T2 , int m, int n> | |
void | Mlt (const TinyMatrixExpression< T0, m, n, E0 > &A, const TinyVectorExpression< T1, n, E1 > &x, TinyVector< T2, m > &y) |
y = A*x | |
template<class T1 , class E1 , class T2 , class E2 , class T3 , int m, int n> | |
void | MltAdd (const TinyMatrixExpression< T1, m, n, E1 > &A, const TinyVectorExpression< T2, n, E2 > &x, TinyVector< T3, m > &y) |
y = y + A*x | |
template<class T0 , class T1 , class E1 , class T2 , class E2 , class T3 , int m, int n> | |
void | MltAdd (const T0 &alpha, const TinyMatrixExpression< T1, m, n, E1 > &A, const TinyVectorExpression< T2, n, E2 > &x, TinyVector< T3, m > &y) |
y = y + alpha*A*x | |
template<class T0 , class E0 , class T1 , class E1 , class T2 , int m, int n> | |
void | MltTrans (const TinyMatrixExpression< T0, m, n, E0 > &A, const TinyVectorExpression< T1, m, E1 > &x, TinyVector< T2, n > &y) |
y = A^t * x | |
template<class T0 , class E0 , class T1 , class E1 , class T2 , int m, int n> | |
void | Mlt (const class_SeldonTrans &, const TinyMatrixExpression< T0, m, n, E0 > &A, const TinyVectorExpression< T1, m, E1 > &x, TinyVector< T2, n > &y) |
y = A^t * x | |
template<int m, int n, class T0 , class T1 , class E1 , class T2 , class E2 , class T3 > | |
void | Rank1Update (const T0 &alpha, const TinyVectorExpression< T1, m, E1 > &x, const TinyVectorExpression< T2, n, E2 > &y, TinyMatrix< T3, General, m, n > &A) |
A = A + alpha * x y^T. | |
template<int m, int n, class T1 , class E1 , class T2 , class E2 , class T3 > | |
void | Rank1Matrix (const TinyVectorExpression< T1, m, E1 > &x, const TinyVectorExpression< T2, n, E2 > &y, TinyMatrix< T3, General, m, n > &A) |
A = x y^T. | |
template<int m, class T0 , class T1 , class E1 , class T3 > | |
void | Rank1Update (const T0 &alpha, const TinyVectorExpression< T1, m, E1 > &x, TinyMatrix< T3, Symmetric, m, m > &A) |
A = A + alpha * x y^T. | |
template<int m, class T1 , class E1 , class T3 > | |
void | Rank1Matrix (const TinyVectorExpression< T1, m, E1 > &x, TinyMatrix< T3, Symmetric, m, m > &A) |
A = x x^T. | |
template<int m, int n, class T1 , class E1 > | |
void | GetCol (const TinyMatrixExpression< T1, m, n, E1 > &A, int k, TinyVector< T1, m > &x) |
x = A(:, k) | |
template<int m, int n, class T0 , class E0 , class T1 > | |
void | GetRow (const TinyMatrixExpression< T0, m, n, E0 > &A, int k, TinyVector< T1, n > &x) |
x = A(k, :) | |
template<int m, int n, class T1 , class E1 , class Prop > | |
void | SetCol (const TinyVectorExpression< T1, m, E1 > &x, int k, TinyMatrix< T1, Prop, m, n > &A) |
A(:, k) = x. | |
template<int m, int n, class T1 , class E1 , class Prop > | |
void | SetRow (const TinyVectorExpression< T1, n, E1 > &x, int k, TinyMatrix< T1, Prop, m, n > &A) |
A(k, :) = x. | |
template<class T , int m, int n, class E , class Prop > | |
void | Copy (const TinyMatrixExpression< T, m, n, E > &A, TinyMatrix< T, Prop, m, n > &B) |
B = A. | |
template<class T0 , class E0 , class T1 , class E1 , class T2 , class Prop2 , int m, int n> | |
void | Add (const TinyMatrixExpression< T0, m, n, E0 > &A, const TinyMatrixExpression< T1, m, n, E1 > &B, TinyMatrix< T2, Prop2, m, n > &C) |
C = A + B. | |
template<class T1 , class E1 , class T2 , class Prop2 , int m, int n> | |
void | Add (const T1 &alpha, const TinyMatrixExpression< T1, m, n, E1 > &A, TinyMatrix< T2, Prop2, m, n > &B) |
B = B + alpha*A. | |
template<class T0 , class E0 , class T1 , class Prop1 , int m, int n> | |
void | Add (const TinyMatrixExpression< T0, m, n, E0 > &A, TinyMatrix< T1, Prop1, m, n > &B) |
B = B+A. | |
template<class T0 , class T1 , class Prop , int m, int n> | |
void | Mlt (const T0 &alpha, TinyMatrix< T1, General, m, n > &A) |
template<class T0 , class E0 , class T1 , class E1 , class T2 , class Prop2 , int m, int n, int k> | |
void | Mlt (const TinyMatrixExpression< T0, m, n, E0 > &A, const TinyMatrixExpression< T1, n, k, E1 > &B, TinyMatrix< T2, Prop2, m, k > &C) |
C = A*B. | |
template<class T0 , class E0 , class T1 , class E1 , class T2 , class Prop2 , int m, int n, int k> | |
void | MltTrans (const TinyMatrixExpression< T0, m, n, E0 > &A, const TinyMatrixExpression< T1, k, n, E1 > &B, TinyMatrix< T2, Prop2, m, k > &C) |
C = A*B^T. | |
template<class T3 , class T0 , class E0 , class T1 , class E1 , class T2 , class Prop2 , class T4 , int m, int n, int k> | |
void | MltAdd (const T3 &alpha, const class_SeldonTrans &, const TinyMatrixExpression< T0, n, m, E0 > &A, const class_SeldonNoTrans &, const TinyMatrixExpression< T1, n, k, E1 > &B, const T4 &beta, TinyMatrix< T2, Prop2, m, k > &C) |
C = beta C + alpha A^T B. | |
template<class T , int m, int n, class E > | |
void | Transpose (const TinyMatrixExpression< T, m, n, E > &A, TinyMatrix< T, General, n, m > &B) |
B = A^T. | |
template<class T , int m> | |
void | Transpose (TinyMatrix< T, General, m, m > &B) |
replacing B by its transposed | |
template<class T , class Prop , int m, int n> | |
ClassComplexType< T >::Treal | MaxAbs (const TinyMatrix< T, Prop, m, n > &A) |
template<class T , class Prop > | |
T | Det (const TinyMatrix< T, Prop, 1, 1 > &A) |
returns determinant of matrix A | |
template<class T > | |
void | GetInverse (const TinyMatrix< T, General, 1, 1 > &A, TinyMatrix< T, General, 1, 1 > &B) |
B = A^-1. | |
template<class T > | |
void | GetInverse (const TinyMatrix< T, Symmetric, 1, 1 > &A, TinyMatrix< T, Symmetric, 1, 1 > &B) |
B = A^-1. | |
template<class T > | |
void | GetInverse (TinyMatrix< T, General, 1, 1 > &B) |
replaces B by its inverse | |
template<class T > | |
void | GetInverse (TinyMatrix< T, Symmetric, 1, 1 > &B) |
replaces B by its inverse | |
template<class T0 , class T1 > | |
void | GetNormalProjector (const TinyVector< T0, 1 > &n, TinyMatrix< T1, Symmetric, 1, 1 > &P) |
computation of n n^T where n is the normale this is the projector to normale | |
template<class T0 , class T1 > | |
void | GetNormalProjector (const T0 &n, TinyMatrix< T1, Symmetric, 1, 1 > &P) |
computation of n n^T where n is the normale this is the projector to normale | |
template<class T , class Prop > | |
T | Det (const TinyMatrix< T, Prop, 2, 2 > &A) |
returns determinant of matrix A | |
template<class T0 , class T1 > | |
void | GetTangentialProjector (const TinyVector< T0, 2 > &n, TinyMatrix< T1, Symmetric, 2, 2 > &P) |
computation of I - n n^T where n is the normale this is the projector to tangential plane | |
template<class T0 , class T1 > | |
void | GetNormalProjector (const TinyVector< T0, 2 > &n, TinyMatrix< T1, Symmetric, 2, 2 > &P) |
computation of n n^T where n is the normale this is the projector to normale | |
template<class T0 , class T1 > | |
void | GetNormalProjector (const TinyVector< T0, 2 > &n, TinyMatrix< T1, General, 2, 2 > &P) |
computation of n n^T where n is the normale this is the projector to normale | |
template<class T0 , class T1 , int m> | |
void | GetTangentialProjector (const TinyVector< T0, m > &n, TinyMatrix< T1, Symmetric, m, m > &P) |
tangential projector P = I - n n^T for any size | |
template<class T0 , class T1 , int m> | |
void | GetNormalProjector (const TinyVector< T0, m > &n, TinyMatrix< T1, Symmetric, m, m > &P) |
normal projector P = n n^T for any size | |
template<class T , class Prop , int m, int n> | |
void | FillZero (TinyMatrix< T, Prop, m, n > &X) |
template<class T , int m, int n> | |
void | DotProdCol (const TinyMatrix< T, General, m, n > &A, const TinyMatrix< T, General, m, n > &B, TinyVector< T, n > &res) |
res = A . B, where the scalar product is performed between columns of A and B More... | |
template<class T , int m, int n, class E1 , class E2 > | |
const TinyMatrixSum< T, m, n, E1, E2 > | operator+ (const TinyMatrixExpression< T, m, n, E1 > &u, const TinyMatrixExpression< T, m, n, E2 > &v) |
returns u+v | |
template<class T , int m, int n, class E1 , class E2 > | |
const TinyMatrixSum< complex< T >, m, n, E1, E2 > | operator+ (const TinyMatrixExpression< complex< T >, m, n, E1 > &u, const TinyMatrixExpression< T, m, n, E2 > &v) |
returns u+v | |
template<class T , int m, int n, class E1 , class E2 > | |
const TinyMatrixSum< complex< T >, m, n, E1, E2 > | operator+ (const TinyMatrixExpression< T, m, n, E1 > &u, const TinyMatrixExpression< complex< T >, m, n, E2 > &v) |
returns u+v | |
template<class T , int m, int n, class E1 , class E2 > | |
const TinyMatrixDifference< T, m, n, E1, E2 > | operator- (const TinyMatrixExpression< T, m, n, E1 > &u, const TinyMatrixExpression< T, m, n, E2 > &v) |
returns u-v | |
template<class T , int m, int n, class E1 , class E2 > | |
const TinyMatrixDifference< complex< T >, m, n, E1, E2 > | operator- (const TinyMatrixExpression< complex< T >, m, n, E1 > &u, const TinyMatrixExpression< T, m, n, E2 > &v) |
returns u-v | |
template<class T , int m, int n, class E1 , class E2 > | |
const TinyMatrixDifference< complex< T >, m, n, E1, E2 > | operator- (const TinyMatrixExpression< T, m, n, E1 > &u, const TinyMatrixExpression< complex< T >, m, n, E2 > &v) |
returns u-v | |
template<class T , int m, int n, class E1 , class E2 > | |
const TinyMatrixProduct< T, m, n, E1, E2 > | operator* (const TinyMatrixExpression< T, m, n, E1 > &u, const TinyMatrixExpression< T, m, n, E2 > &v) |
returns u*v element-wise | |
template<class T , int m, int n, class E1 , class E2 > | |
const TinyMatrixProduct< complex< T >, m, n, E1, E2 > | operator* (const TinyMatrixExpression< complex< T >, m, n, E1 > &u, const TinyMatrixExpression< T, m, n, E2 > &v) |
returns u*v element-wise | |
template<class T , int m, int n, class E1 , class E2 > | |
const TinyMatrixProduct< complex< T >, m, n, E1, E2 > | operator* (const TinyMatrixExpression< T, m, n, E1 > &u, const TinyMatrixExpression< complex< T >, m, n, E2 > &v) |
returns u*v element-wise | |
template<class T , int m, int n, class E1 , class E2 > | |
const TinyMatrixDivision< T, m, n, E1, E2 > | operator/ (const TinyMatrixExpression< T, m, n, E1 > &u, const TinyMatrixExpression< T, m, n, E2 > &v) |
returns u/v element-wise | |
template<class T , int m, int n, class E1 , class E2 > | |
const TinyMatrixDivision< complex< T >, m, n, E1, E2 > | operator/ (const TinyMatrixExpression< complex< T >, m, n, E1 > &u, const TinyMatrixExpression< T, m, n, E2 > &v) |
returns u/v element-wise | |
template<class T , int m, int n, class E1 , class E2 > | |
const TinyMatrixDivision< complex< T >, m, n, E1, E2 > | operator/ (const TinyMatrixExpression< T, m, n, E1 > &u, const TinyMatrixExpression< complex< T >, m, n, E2 > &v) |
returns u/v element-wise | |
template<class T , int m, int n, class E > | |
const TinyMatrixScaled< T, m, n, T, E > | operator* (const T &alpha, const TinyMatrixExpression< T, m, n, E > &u) |
returns alpha*u | |
template<class T , int m, int n, class E > | |
const TinyMatrixScaled< complex< T >, m, n, complex< T >, E > | operator* (const complex< T > &alpha, const TinyMatrixExpression< T, m, n, E > &u) |
returns alpha*u | |
template<class T , int m, int n, class E > | |
const TinyMatrixScaled< complex< T >, m, n, T, E > | operator* (const T &alpha, const TinyMatrixExpression< complex< T >, m, n, E > &u) |
returns alpha*u | |
template<class T , int m, int n, class E > | |
const TinyMatrixScaled< T, m, n, T, E > | operator* (const TinyMatrixExpression< T, m, n, E > &u, const T &alpha) |
returns u*alpha | |
template<class T , int m, int n, class E > | |
const TinyMatrixScaled< complex< T >, m, n, complex< T >, E > | operator* (const TinyMatrixExpression< T, m, n, E > &u, const complex< T > &alpha) |
returns u*alpha | |
template<class T , int m, int n, class E > | |
const TinyMatrixScaled< complex< T >, m, n, T, E > | operator* (const TinyMatrixExpression< complex< T >, m, n, E > &u, const T &alpha) |
returns u*alpha | |
template<class T , int m, int n, class E > | |
const TinyMatrixScalDiv< T, m, n, T, E > | operator/ (const T &alpha, const TinyMatrixExpression< T, m, n, E > &u) |
returns alpha / u | |
template<class T , int m, int n, class E > | |
const TinyMatrixScalDiv< complex< T >, m, n, complex< T >, E > | operator/ (const complex< T > &alpha, const TinyMatrixExpression< T, m, n, E > &u) |
returns alpha / u | |
template<class T , int m, int n, class E > | |
const TinyMatrixScalDiv< complex< T >, m, n, T, E > | operator/ (const T &alpha, const TinyMatrixExpression< complex< T >, m, n, E > &u) |
returns alpha / u | |
template<class T , int m, int n, class E > | |
const TinyMatrixScaled< T, m, n, T, E > | operator/ (const TinyMatrixExpression< T, m, n, E > &u, const T &alpha) |
returns u / alpha | |
template<class T , int m, int n, class E > | |
const TinyMatrixScaled< complex< T >, m, n, complex< T >, E > | operator/ (const TinyMatrixExpression< T, m, n, E > &u, const complex< T > &alpha) |
returns u / alpha | |
template<class T , int m, int n, class E > | |
const TinyMatrixScaled< complex< T >, m, n, T, E > | operator/ (const TinyMatrixExpression< complex< T >, m, n, E > &u, const T &alpha) |
returns u / alpha | |
template<class T , int m, int n, class E > | |
const TinyMatrixScalSum< T, m, n, T, E > | operator+ (const T &alpha, const TinyMatrixExpression< T, m, n, E > &u) |
returns alpha + u | |
template<class T , int m, int n, class E > | |
const TinyMatrixScalSum< complex< T >, m, n, complex< T >, E > | operator+ (const complex< T > &alpha, const TinyMatrixExpression< T, m, n, E > &u) |
returns alpha + u | |
template<class T , int m, int n, class E > | |
const TinyMatrixScalSum< complex< T >, m, n, T, E > | operator+ (const T &alpha, const TinyMatrixExpression< complex< T >, m, n, E > &u) |
returns alpha + u | |
template<class T , int m, int n, class E > | |
const TinyMatrixScalSum< T, m, n, T, E > | operator+ (const TinyMatrixExpression< T, m, n, E > &u, const T &alpha) |
returns u + alpha | |
template<class T , int m, int n, class E > | |
const TinyMatrixScalSum< complex< T >, m, n, complex< T >, E > | operator+ (const TinyMatrixExpression< T, m, n, E > &u, const complex< T > &alpha) |
returns u + alpha | |
template<class T , int m, int n, class E > | |
const TinyMatrixScalSum< complex< T >, m, n, T, E > | operator+ (const TinyMatrixExpression< complex< T >, m, n, E > &u, const T &alpha) |
returns u + alpha | |
template<class T , int m, int n, class E > | |
const TinyMatrixScalSum< T, m, n, T, E > | operator- (const TinyMatrixExpression< T, m, n, E > &u, const T &alpha) |
returns u - alpha | |
template<class T , int m, int n, class E > | |
const TinyMatrixScalSum< complex< T >, m, n, complex< T >, E > | operator- (const TinyMatrixExpression< T, m, n, E > &u, const complex< T > &alpha) |
returns u - alpha | |
template<class T , int m, int n, class E > | |
const TinyMatrixScalSum< complex< T >, m, n, T, E > | operator- (const TinyMatrixExpression< complex< T >, m, n, E > &u, const T &alpha) |
returns u - alpha | |
template<class T , int m, int n, class E > | |
const TinyMatrixScalDiff< T, m, n, T, E > | operator- (const T &alpha, const TinyMatrixExpression< T, m, n, E > &u) |
returns alpha - u | |
template<class T , int m, int n, class E > | |
const TinyMatrixScalDiff< complex< T >, m, n, complex< T >, E > | operator- (const complex< T > &alpha, const TinyMatrixExpression< T, m, n, E > &u) |
returns alpha - u | |
template<class T , int m, int n, class E > | |
const TinyMatrixScalDiff< complex< T >, m, n, T, E > | operator- (const T &alpha, const TinyMatrixExpression< complex< T >, m, n, E > &u) |
returns alpha - u | |
template<class T , int m, int n, class E > | |
const TinyMatrixOpposite< T, m, n, E > | operator- (const TinyMatrixExpression< T, m, n, E > &u) |
returns -u | |
template<class T , int m, int n, class E > | |
const TinyMatrixTranspose< T, m, n, E > | transpose (const TinyMatrixExpression< T, n, m, E > &u) |
returns transpose(u) | |
template<class T0 , class T1 , class Prop , int m, int n> | |
void | Mlt (const T0 &alpha, TinyMatrix< T1, Prop, m, n > &A) |
A = A*alpha. | |
template<class T , class Allocator > | |
void | GetLU (Matrix< T, General, BandedCol, Allocator > &A, Matrix< T, General, BandedCol, Allocator > &mat_lu, bool keep_matrix) |
LU factorisation. | |
template<class T , class Allocator > | |
void | GetLU (Matrix< T, General, BandedCol, Allocator > &A) |
LU factorisation. | |
template<class Allocator > | |
void | GetLU (Matrix< double, General, BandedCol, Allocator > &A, Vector< int > &ipivot, LapackInfo &info) |
LU factorisation with row interchanges. | |
template<class Allocator > | |
void | SolveLU (const Matrix< double, General, BandedCol, Allocator > &A, const Vector< int > &ipivot, Vector< double > &b, LapackInfo &info) |
resolution of A x = b, assuming that GetLU has been called | |
template<class Allocator > | |
void | SolveLU (const Matrix< double, General, BandedCol, Allocator > &A, const Vector< int > &ipivot, Vector< complex< double > > &b, LapackInfo &info) |
resolution of A x = b, assuming that GetLU has been called | |
template<class Allocator > | |
void | GetLU (Matrix< complex< double >, General, BandedCol, Allocator > &A, Vector< int > &ipivot, LapackInfo &info) |
LU factorisation with row interchanges. | |
template<class Allocator > | |
void | SolveLU (const Matrix< complex< double >, General, BandedCol, Allocator > &A, const Vector< int > &ipivot, Vector< complex< double > > &b, LapackInfo &info) |
resolution of A x = b, assuming that GetLU has been called | |
template<class T , class Allocator > | |
void | GetLU (Matrix< T, General, BandedCol, Allocator > &A, Vector< int > &ipivot, LapackInfo &info) |
factorizes matrix with pivoting | |
template<class T , class Allocator > | |
void | SolveLU (const Matrix< T, General, BandedCol, Allocator > &A, const Vector< int > &ipivot, Vector< T > &b, LapackInfo &info) |
Solves A x = b with pivoting. | |
template<class T , class Allocator > | |
void | SolveLU (const Matrix< T, General, BandedCol, Allocator > &A, const Vector< int > &ipivot, Vector< complex< T > > &b, LapackInfo &info) |
Solves A x = b with pivoting. | |
template<class T , class Prop , class Allocator , class T1 , class Allocator1 , class T2 , class Allocator2 > | |
void | ScaleMatrix (Matrix< T, Prop, BandedCol, Allocator > &A, const Vector< T1, VectFull, Allocator1 > &Drow, const Vector< T2, VectFull, Allocator2 > &Dcol) |
Scaling of a matrix. More... | |
template<class T , class Allocator > | |
void | SolveLU (const Matrix< T, General, BandedCol, Allocator > &mat_lu, Vector< T > &x) |
resolution of A x = b, once GetLU has been called | |
template<class T , class Allocator > | |
void | SolveLU (const Matrix< T, General, BandedCol, Allocator > &mat_lu, Vector< complex< T > > &x) |
resolution of A x = b, once GetLU has been called | |
template<class T , class Allocator > | |
void | Copy (const Matrix< T, General, ArrayRowSparse, Allocator > &A, Matrix< T, General, BandedCol, Allocator > &B) |
conversion from ArrayRowSparse to band matrix | |
template<class T0 , class T1 , class Prop1 , class Allocator1 , class T2 , class Prop2 , class Allocator2 > | |
void | AddMatrix (const T0 &alpha, const Matrix< T1, Prop1, BandedCol, Allocator1 > &A, Matrix< T2, Prop2, BandedCol, Allocator2 > &B) |
B = B + alpha*A. | |
template<class T0 , class T1 , class T , class T2 , class Allocator > | |
void | MltAddVector (const T0 &alpha, const Matrix< T, General, BandedCol, Allocator > &A, const Vector< T2 > &x, const T1 &beta, Vector< T2 > &y) |
y = beta*y + alpha*A*x | |
template<class T0 , class T1 , class T , class T2 , class Allocator > | |
void | MltAddVector (const T0 &alpha, const SeldonTranspose &trans, const Matrix< T, General, BandedCol, Allocator > &A, const Vector< T2 > &x, const T1 &beta, Vector< T2 > &y) |
y = beta*y + alpha*A*x | |
template<class T , class Allocator , class T1 > | |
void | MltVector (const Matrix< T, General, BandedCol, Allocator > &A, const Vector< T1 > &x, Vector< T1 > &y) |
y = A*x | |
template<class T , class Allocator , class T1 > | |
void | MltVector (const SeldonTranspose &trans, const Matrix< T, General, BandedCol, Allocator > &A, const Vector< T1 > &x, Vector< T1 > &y) |
y = A*x | |
template<class T0 , class T1 , class Allocator > | |
void | MltScalar (const T0 &alpha, Matrix< T1, General, BandedCol, Allocator > &A) |
A = alpha*A. | |
template<class T , class Allocator > | |
ostream & | operator<< (ostream &out, const Matrix< T, General, BandedCol, Allocator > &A) |
displays matrix | |
template<class T , class Allocator > | |
void | GetLU (Matrix< T, General, ArrowCol, Allocator > &A, Matrix< T, General, ArrowCol, Allocator > &mat_lu, bool keep_matrix) |
LU factorisation. | |
template<class T , class Allocator > | |
void | GetLU (Matrix< T, General, ArrowCol, Allocator > &A) |
LU factorisation. | |
template<class T , class Allocator > | |
void | SolveLU (const Matrix< T, General, ArrowCol, Allocator > &mat_lu, Vector< T > &x) |
resolution of A x = b, once GetLU has been called | |
template<class T , class Allocator > | |
void | SolveLU (const Matrix< T, General, ArrowCol, Allocator > &mat_lu, Vector< complex< T > > &x) |
resolution of A x = b, once GetLU has been called | |
template<class T0 , class T1 , class Prop1 , class Allocator1 , class T2 , class Prop2 , class Allocator2 > | |
void | AddMatrix (const T0 &alpha, const Matrix< T1, Prop1, ArrowCol, Allocator1 > &A, Matrix< T2, Prop2, ArrowCol, Allocator2 > &B) |
B = B + alpha*A. | |
template<class T0 , class T1 , class T , class T2 , class Allocator > | |
void | MltAddVector (const T0 &alpha, const Matrix< T, General, ArrowCol, Allocator > &A, const Vector< T2 > &x, const T1 &beta, Vector< T2 > &y) |
y = beta*y + alpha*A*x | |
template<class T0 , class T1 , class T , class T2 , class Allocator > | |
void | MltAddVector (const T0 &alpha, const SeldonTranspose &trans, const Matrix< T, General, ArrowCol, Allocator > &A, const Vector< T2 > &x, const T1 &beta, Vector< T2 > &y) |
y = beta*y + alpha*A*x | |
template<class T , class Allocator , class T1 > | |
void | MltVector (const Matrix< T, General, ArrowCol, Allocator > &A, const Vector< T1 > &x, Vector< T1 > &y) |
y = A*x | |
template<class T , class Allocator , class T1 > | |
void | MltVector (const SeldonTranspose &trans, const Matrix< T, General, ArrowCol, Allocator > &A, const Vector< T1 > &x, Vector< T1 > &y) |
y = A*x | |
template<class T0 , class T1 , class Allocator > | |
void | MltScalar (const T0 &alpha, Matrix< T1, General, ArrowCol, Allocator > &A) |
A = alpha*A. | |
template<class T , class Allocator > | |
ostream & | operator<< (ostream &out, const Matrix< T, General, ArrowCol, Allocator > &A) |
displays matrix | |
template<class T0 , class T1 , class Allocator > | |
void | AddVector (const T0 &alpha, const Matrix< T1, General, BandedCol, Allocator > &A, Matrix< T1, General, BandedCol, Allocator > &B) |
B = B + alpha*A. | |
template<class T0 , class T1 , class Allocator1 , class T2 , class Allocator2 > | |
void | AddMatrix (const T0 &alpha, const Matrix< T1, Symmetric, ArrayRowSymComplexSparse, Allocator1 > &A, Matrix< T2, Symmetric, ArrayRowSymComplexSparse, Allocator2 > &B) |
B = B + alpha A. | |
template<class T0 , class T1 , class Allocator1 , class T2 , class Allocator2 > | |
void | AddMatrix (const T0 &alpha, const Matrix< T1, Symmetric, ArrayRowSymComplexSparse, Allocator1 > &A, Matrix< T2, Symmetric, ArrayRowSymSparse, Allocator2 > &B) |
B = B + alpha A | |
template<class T0 , class T1 , class Allocator1 , class T2 , class Allocator2 > | |
void | AddMatrix (const T0 &alpha, const Matrix< T1, General, ArrayRowComplexSparse, Allocator1 > &A, Matrix< T2, General, ArrayRowSparse, Allocator2 > &B) |
B = B + alpha A. | |
template<class T0 , class T1 , class Allocator1 , class T2 , class Allocator2 > | |
void | AddMatrix (const T0 &alpha, const Matrix< T1, General, ArrayRowComplexSparse, Allocator1 > &A, Matrix< T2, General, ArrayRowComplexSparse, Allocator2 > &B) |
B = B + alpha A. | |
template<class T0 , class T1 , class Prop1 , class Allocator1 , class T2 , class Prop2 , class Allocator2 , class T3 , class Prop3 , class Allocator3 > | |
void | AddMatrix (const T0 &alpha, const Matrix< T1, Prop1, ArrayRowSymSparse, Allocator1 > &A, const Matrix< T2, Prop2, ArrayRowSymSparse, Allocator2 > &B, Matrix< T3, Prop3, ArrayRowSymComplexSparse, Allocator3 > &C) |
C = C + complex(A,B) | |
template<class T0 , class T1 , class Prop1 , class Allocator1 , class T2 , class Prop2 , class Allocator2 , class T3 , class Prop3 , class Allocator3 > | |
void | AddMatrix (const T0 &alpha, const Matrix< T1, Prop1, ArrayRowSparse, Allocator1 > &A, const Matrix< T2, Prop2, ArrayRowSparse, Allocator2 > &B, Matrix< T3, Prop3, ArrayRowComplexSparse, Allocator3 > &C) |
C = C + complex(A,B) | |
template<class T , class Allocator > | |
void | Add_csr_ptr (const T &alpha, long *ptr_A, int *ind_A, T *data_A, long *ptr_B, int *ind_B, T *data_B, int m, Vector< long > &Ptr, Vector< int > &Ind, Vector< T, VectFull, Allocator > &Val) |
template<class T0 , class T1 , class Allocator1 , class T2 , class Allocator2 > | |
void | AddMatrix (const T0 &alpha, const Matrix< T1, Symmetric, RowSymComplexSparse, Allocator1 > &A, Matrix< T2, Symmetric, RowSymComplexSparse, Allocator2 > &B) |
B = B + alpha A. | |
template<class T0 , class T1 , class Allocator1 , class T2 , class Allocator2 > | |
void | AddMatrix (const T0 &alpha, const Matrix< T1, General, RowComplexSparse, Allocator1 > &A, Matrix< T2, General, RowComplexSparse, Allocator2 > &B) |
B = B + alpha A. | |
template<class T0 , class T1 , class Allocator1 , class T2 , class Allocator2 > | |
void | AddMatrix (const complex< T0 > &alpha, const Matrix< T1, Symmetric, RowSymComplexSparse, Allocator1 > &A, Matrix< T2, Symmetric, RowSymComplexSparse, Allocator2 > &B) |
B = B + alpha A. | |
template<class T0 , class T1 , class Allocator1 , class T2 , class Allocator2 > | |
void | AddMatrix (const complex< T0 > &alpha, const Matrix< T1, General, RowComplexSparse, Allocator1 > &A, Matrix< T2, General, RowComplexSparse, Allocator2 > &B) |
B = B + alpha A. | |
template<class T0 , class T , class Prop , class Allocator > | |
void | MltScalar (const T0 &alpha, Matrix< T, Prop, ArrayRowComplexSparse, Allocator > &A) |
multiplication by a scalar | |
template<class T0 , class T , class Prop , class Allocator > | |
void | MltScalar (const complex< T0 > &alpha, Matrix< T, Prop, ArrayRowComplexSparse, Allocator > &A) |
multiplication by a scalar | |
template<class T0 , class T , class Prop , class Allocator > | |
void | MltScalar (const T0 &alpha, Matrix< T, Prop, ArrayRowSymComplexSparse, Allocator > &A) |
multiplication by a scalar | |
template<class T0 , class T , class Prop , class Allocator > | |
void | MltScalar (const complex< T0 > &alpha, Matrix< T, Prop, ArrayRowSymComplexSparse, Allocator > &A) |
multiplication by a scalar | |
template<class T0 , class T , class Prop , class Allocator > | |
void | MltScalar (const T0 &alpha, Matrix< T, Prop, RowComplexSparse, Allocator > &A) |
multiplication by a scalar | |
template<class T0 , class T , class Prop , class Allocator > | |
void | MltScalar (const complex< T0 > &alpha, Matrix< T, Prop, RowComplexSparse, Allocator > &A) |
multiplication by a scalar | |
template<class T0 , class T , class Prop , class Allocator > | |
void | MltScalar (const T0 &alpha, Matrix< T, Prop, RowSymComplexSparse, Allocator > &A) |
multiplication by a scalar | |
template<class T0 , class T , class Prop , class Allocator > | |
void | MltScalar (const complex< T0 > &alpha, Matrix< T, Prop, RowSymComplexSparse, Allocator > &A) |
multiplication by a scalar | |
template<class T , class Prop , class Allocator > | |
void | ApplyInversePermutation (Matrix< T, Prop, ArrayRowComplexSparse, Allocator > &A, const IVect &row_perm, const IVect &col_perm) |
Permutation of a general matrix stored by rows. More... | |
template<class T , class Prop , class Allocator > | |
void | ApplyInversePermutation (Matrix< T, Prop, ArrayRowSymComplexSparse, Allocator > &A, const IVect &row_perm, const IVect &col_perm) |
Permutation of a symmetric matrix stored by rows. More... | |
template<class T , class Prop , class Allocator > | |
void | ApplyPermutation (Matrix< T, Prop, ArrayRowComplexSparse, Allocator > &A, const Vector< int > &row_perm, const Vector< int > &col_perm) |
Permutation of rows and columns of a matrix. More... | |
template<class T , class Prop , class Allocator > | |
void | ApplyPermutation (Matrix< T, Prop, ArrayRowSymComplexSparse, Allocator > &A, const Vector< int > &row_perm, const Vector< int > &col_perm) |
Permutation of rows and columns of a matrix. More... | |
template<class Prop , class T1 , class Allocator1 , class T2 , class Allocator2 , class T3 , class Allocator3 > | |
void | ScaleMatrix (Matrix< T1, Prop, ArrayRowSymComplexSparse, Allocator1 > &A, const Vector< T2, VectFull, Allocator2 > &scale_left, const Vector< T3, VectFull, Allocator3 > &scale_right) |
Each row and column are scaled. More... | |
template<class Prop , class T1 , class Allocator1 , class T2 , class Allocator2 , class T3 , class Allocator3 > | |
void | ScaleMatrix (Matrix< T1, Prop, ArrayRowComplexSparse, Allocator1 > &A, const Vector< T2, VectFull, Allocator2 > &scale_left, const Vector< T3, VectFull, Allocator3 > &scale_right) |
Each row and column are scaled. More... | |
template<class T1 , class Allocator1 , class Prop , class T2 , class Allocator2 > | |
void | ScaleLeftMatrix (Matrix< T1, Prop, ArrayRowComplexSparse, Allocator1 > &A, const Vector< T2, VectFull, Allocator2 > &scale) |
Each row is scaled. More... | |
template<class T1 , class Allocator1 , class Prop , class T2 , class Allocator2 > | |
void | ScaleRightMatrix (Matrix< T1, Prop, ArrayRowComplexSparse, Allocator1 > &A, const Vector< T2, VectFull, Allocator2 > &scale) |
Each column is scaled. More... | |
template<class Prop , class T1 , class Allocator1 , class T2 , class Allocator2 , class T3 , class Allocator3 > | |
void | ScaleMatrix (Matrix< T1, Prop, RowSymComplexSparse, Allocator1 > &A, const Vector< T2, VectFull, Allocator2 > &scale_left, const Vector< T3, VectFull, Allocator3 > &scale_right) |
Each row and column are scaled. More... | |
template<class Prop , class T1 , class Allocator1 , class T2 , class Allocator2 , class T3 , class Allocator3 > | |
void | ScaleMatrix (Matrix< T1, Prop, RowComplexSparse, Allocator1 > &A, const Vector< T2, VectFull, Allocator2 > &scale_left, const Vector< T3, VectFull, Allocator3 > &scale_right) |
Each row and column are scaled. More... | |
template<class T1 , class Allocator1 , class Prop , class T2 , class Allocator2 > | |
void | ScaleLeftMatrix (Matrix< T1, Prop, RowComplexSparse, Allocator1 > &A, const Vector< T2, VectFull, Allocator2 > &scale) |
Each row is scaled. More... | |
template<class T1 , class Allocator1 , class Prop , class T2 , class Allocator2 > | |
void | ScaleRightMatrix (Matrix< T1, Prop, RowComplexSparse, Allocator1 > &A, const Vector< T2, VectFull, Allocator2 > &scale) |
Each column is scaled. More... | |
template<class T , class Allocator > | |
void | Transpose (const Matrix< T, General, ArrayRowComplexSparse, Allocator > &A, Matrix< T, General, ArrayRowComplexSparse, Allocator > &B) |
Matrix transposition. | |
template<class T , class Allocator > | |
void | Transpose (const Matrix< T, General, RowComplexSparse, Allocator > &A, Matrix< T, General, RowComplexSparse, Allocator > &B) |
Matrix transposition. | |
template<class T , class Prop , class Allocator > | |
ClassComplexType< T >::Treal | MaxAbs (const Matrix< T, Prop, ArrayRowComplexSparse, Allocator > &A) |
Returns the maximum (in absolute value) of a matrix. More... | |
template<class T , class Prop , class Allocator > | |
ClassComplexType< T >::Treal | MaxAbs (const Matrix< T, Prop, RowComplexSparse, Allocator > &A) |
Returns the maximum (in absolute value) of a matrix. More... | |
template<class T , class Prop , class Allocator > | |
ClassComplexType< T >::Treal | Norm1 (const Matrix< T, Prop, ArrayRowComplexSparse, Allocator > &A) |
Returns the 1-norm of a matrix. More... | |
template<class T , class Prop , class Allocator > | |
ClassComplexType< T >::Treal | Norm1 (const Matrix< T, Prop, RowComplexSparse, Allocator > &A) |
Returns the 1-norm of a matrix. More... | |
template<class T , class Prop , class Allocator > | |
ClassComplexType< T >::Treal | NormInf (const Matrix< T, Prop, ArrayRowComplexSparse, Allocator > &A) |
Returns the infinity-norm of a matrix. More... | |
template<class T , class Prop , class Allocator > | |
ClassComplexType< T >::Treal | NormInf (const Matrix< T, Prop, RowComplexSparse, Allocator > &A) |
Returns the infinity-norm of a matrix. More... | |
template<class T , class Prop , class Allocator > | |
ClassComplexType< T >::Treal | MaxAbs (const Matrix< T, Prop, ArrayRowSymComplexSparse, Allocator > &A) |
Returns the maximum (in absolute value) of a matrix. More... | |
template<class T , class Prop , class Allocator > | |
ClassComplexType< T >::Treal | MaxAbs (const Matrix< T, Prop, RowSymComplexSparse, Allocator > &A) |
Returns the maximum (in absolute value) of a matrix. More... | |
template<class T , class Prop , class Allocator > | |
ClassComplexType< T >::Treal | Norm1 (const Matrix< T, Prop, ArrayRowSymComplexSparse, Allocator > &A) |
Returns the 1-norm of a matrix. More... | |
template<class T , class Prop , class Allocator > | |
ClassComplexType< T >::Treal | Norm1 (const Matrix< T, Prop, RowSymComplexSparse, Allocator > &A) |
Returns the 1-norm of a matrix. More... | |
template<class T , class Prop , class Allocator > | |
ClassComplexType< T >::Treal | NormInf (const Matrix< T, Prop, ArrayRowSymComplexSparse, Allocator > &A) |
Returns the infinity-norm of a matrix. More... | |
template<class T , class Prop , class Allocator > | |
ClassComplexType< T >::Treal | NormInf (const Matrix< T, Prop, RowSymComplexSparse, Allocator > &A) |
Returns the infinity-norm of a matrix. More... | |
template<class T , class Prop , class Allocator > | |
ClassComplexType< T >::Treal | NormFro (const Matrix< T, Prop, ArrayRowComplexSparse, Allocator > &A) |
Returns Frobenius norm of matrix. | |
template<class T , class Prop , class Allocator > | |
ClassComplexType< T >::Treal | NormFro (const Matrix< T, Prop, ArrayRowSymComplexSparse, Allocator > &A) |
Returns Frobenius norm of matrix. | |
template<class T , class Prop , class Allocator > | |
void | Conjugate (Matrix< T, Prop, ArrayRowComplexSparse, Allocator > &A) |
A is replaced by its conjugate. | |
template<class T , class Prop , class Allocator > | |
void | Conjugate (Matrix< T, Prop, ArrayRowSymComplexSparse, Allocator > &A) |
A is replaced by its conjugate. | |
template<class T , class Prop , class Allocator > | |
void | Conjugate (Matrix< T, Prop, RowComplexSparse, Allocator > &A) |
A is replaced by its conjugate. | |
template<class T , class Prop , class Allocator > | |
void | Conjugate (Matrix< T, Prop, RowSymComplexSparse, Allocator > &A) |
A is replaced by its conjugate. | |
template<class T , class Allocator > | |
void | Transpose (const Matrix< T, Symmetric, ArrayRowSymComplexSparse, Allocator > &A, Matrix< T, Symmetric, ArrayRowSymComplexSparse, Allocator > &B) |
Matrix transposition. | |
template<class T , class Allocator > | |
void | Transpose (Matrix< T, General, ArrayRowComplexSparse, Allocator > &A) |
Matrix transposition. | |
template<class T , class Allocator > | |
void | Transpose (Matrix< T, Symmetric, ArrayRowSymComplexSparse, Allocator > &A) |
Matrix transposition. | |
template<class T , class Allocator > | |
void | Transpose (const Matrix< T, Symmetric, RowSymComplexSparse, Allocator > &A, Matrix< T, Symmetric, RowSymComplexSparse, Allocator > &B) |
Matrix transposition. | |
template<class T , class Allocator > | |
void | Transpose (Matrix< T, General, RowComplexSparse, Allocator > &A) |
Matrix transposition. | |
template<class T , class Allocator > | |
void | Transpose (Matrix< T, Symmetric, RowSymComplexSparse, Allocator > &A) |
Matrix transposition. | |
template<class T , class Prop , class Allocator , class T0 > | |
void | RemoveSmallEntry (Matrix< T, Prop, RowComplexSparse, Allocator > &A, const T0 &epsilon) |
drops non-zero entries below epsilon | |
template<class T , class Prop , class Allocator , class T0 > | |
void | RemoveSmallEntry (Matrix< T, Prop, RowSymComplexSparse, Allocator > &A, const T0 &epsilon) |
drops non-zero entries below epsilon | |
template<class T1 , class Prop , class Allocator > | |
void | EraseCol (const IVect &col_number, Matrix< T1, Prop, ArrayRowSymComplexSparse, Allocator > &A) |
clears several columns of a sparse matrix More... | |
template<class T1 , class Prop , class Allocator > | |
void | EraseCol (const IVect &col_number, Matrix< T1, Prop, ArrayRowComplexSparse, Allocator > &A) |
clears several columns of a sparse matrix More... | |
template<class T1 , class Prop , class Allocator > | |
void | EraseCol (const IVect &col_number, Matrix< T1, Prop, RowComplexSparse, Allocator > &A) |
clears several columns of a sparse matrix More... | |
template<class T1 , class Prop , class Allocator > | |
void | EraseCol (const IVect &col_number, Matrix< T1, Prop, RowSymComplexSparse, Allocator > &A) |
clears several columns of a sparse matrix More... | |
template<class T1 , class Prop , class Allocator > | |
void | EraseRow (const IVect &col_number, Matrix< T1, Prop, ArrayRowSymComplexSparse, Allocator > &A) |
clears several rows of a sparse matrix More... | |
template<class T1 , class Prop , class Allocator > | |
void | EraseRow (const IVect &col_number, Matrix< T1, Prop, ArrayRowComplexSparse, Allocator > &A) |
clears several rows of a sparse matrix More... | |
template<class T1 , class Prop , class Allocator > | |
void | EraseRow (const IVect &col_number, Matrix< T1, Prop, RowComplexSparse, Allocator > &A) |
clears several rows of a sparse matrix More... | |
template<class T1 , class Prop , class Allocator > | |
void | EraseRow (const IVect &col_number, Matrix< T1, Prop, RowSymComplexSparse, Allocator > &A) |
clears several rows of a sparse matrix More... | |
template<class T > | |
void | GetRowSum (Vector< typename ClassComplexType< T >::Treal > &diagonal_scale_left, const Matrix< T, Symmetric, ArrayRowSymComplexSparse > &mat) |
For each row of the matrix, computation of the sum of absolute values. More... | |
template<class T > | |
void | GetRowSum (Vector< typename ClassComplexType< T >::Treal > &diagonal_scale_left, const Matrix< T, General, ArrayRowComplexSparse > &mat) |
For each row of the matrix, computation of the sum of absolute values. More... | |
template<class T > | |
void | GetRowSum (Vector< typename ClassComplexType< T >::Treal > &diagonal_scale_left, const Matrix< T, Symmetric, RowSymComplexSparse > &mat) |
For each row of the matrix, computation of the sum of absolute values. More... | |
template<class T > | |
void | GetRowSum (Vector< typename ClassComplexType< T >::Treal > &diagonal_scale_left, const Matrix< T, General, RowComplexSparse > &mat) |
For each row of the matrix, computation of the sum of absolute values. More... | |
template<class T > | |
void | GetColSum (Vector< typename ClassComplexType< T >::Treal > &diagonal_scale, const Matrix< T, Symmetric, ArrayRowSymComplexSparse > &mat) |
For each column of the matrix, computation of the sum of absolute values. More... | |
template<class T > | |
void | GetColSum (Vector< typename ClassComplexType< T >::Treal > &diagonal_scale, const Matrix< T, General, ArrayRowComplexSparse > &mat) |
For each column of the matrix, computation of the sum of absolute values. More... | |
template<class T > | |
void | GetColSum (Vector< typename ClassComplexType< T >::Treal > &diagonal_scale, const Matrix< T, Symmetric, RowSymComplexSparse > &mat) |
For each column of the matrix, computation of the sum of absolute values. More... | |
template<class T > | |
void | GetColSum (Vector< typename ClassComplexType< T >::Treal > &diagonal_scale, const Matrix< T, General, RowComplexSparse > &mat) |
For each column of the matrix, computation of the sum of absolute values. More... | |
template<class T > | |
void | GetRowColSum (Vector< typename ClassComplexType< T >::Treal > &sum_row, Vector< typename ClassComplexType< T >::Treal > &sum_col, const Matrix< T, Symmetric, ArrayRowSymComplexSparse > &mat) |
For each row and column of the matrix, computation of the sum of absolute values. More... | |
template<class T > | |
void | GetRowColSum (Vector< typename ClassComplexType< T >::Treal > &sum_row, Vector< typename ClassComplexType< T >::Treal > &sum_col, const Matrix< T, General, ArrayRowComplexSparse > &mat) |
For each row and column of the matrix, computation of the sum of absolute values. More... | |
template<class T > | |
void | GetRowColSum (Vector< typename ClassComplexType< T >::Treal > &sum_row, Vector< typename ClassComplexType< T >::Treal > &sum_col, const Matrix< T, Symmetric, RowSymComplexSparse > &mat) |
For each row and column of the matrix, computation of the sum of absolute values. More... | |
template<class T > | |
void | GetRowColSum (Vector< typename ClassComplexType< T >::Treal > &sum_row, Vector< typename ClassComplexType< T >::Treal > &sum_col, const Matrix< T, General, RowComplexSparse > &mat) |
For each row and column of the matrix, computation of the sum of absolute values. More... | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Allocator1 > | |
void | CopySubMatrix (const Matrix< T0, Prop0, ArrayRowComplexSparse, Allocator0 > &A, const IVect &row, const IVect &col, Vector< int > &RowNum, Vector< int > &ColNum, Vector< complex< T1 >, VectFull, Allocator1 > &Value) |
extracts some rows/columns of a matrix | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Allocator1 > | |
void | CopySubMatrix (const Matrix< T0, Prop0, ArrayRowSymComplexSparse, Allocator0 > &A, const IVect &row, const IVect &col, Vector< int > &RowNum, Vector< int > &ColNum, Vector< complex< T1 >, VectFull, Allocator1 > &Value) |
extracts some rows/columns of a matrix | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Allocator1 > | |
void | CopySubMatrix (const Matrix< T0, Prop0, RowComplexSparse, Allocator0 > &A, const IVect &row, const IVect &col, Vector< int > &RowNum, Vector< int > &ColNum, Vector< complex< T1 >, VectFull, Allocator1 > &Value) |
extracts some rows/columns of a matrix | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Allocator1 > | |
void | CopySubMatrix (const Matrix< T0, Prop0, RowSymComplexSparse, Allocator0 > &A, const IVect &row, const IVect &col, Vector< int > &RowNum, Vector< int > &ColNum, Vector< complex< T1 >, VectFull, Allocator1 > &Value) |
extracts some rows/columns of a matrix | |
template<class T1 , class Prop1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T4 , class Storage4 , class Allocator4 > | |
void | MltVector (const Matrix< T1, Prop1, RowComplexSparse, Allocator1 > &M, const Vector< T2, Storage2, Allocator2 > &X, Vector< T4, Storage4, Allocator4 > &Y) |
template<class T1 , class Prop1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T4 , class Storage4 , class Allocator4 > | |
void | MltVector (const Matrix< T1, Prop1, ColComplexSparse, Allocator1 > &M, const Vector< T2, Storage2, Allocator2 > &X, Vector< T4, Storage4, Allocator4 > &Y) |
template<class T1 , class Prop1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T4 , class Storage4 , class Allocator4 > | |
void | MltVector (const Matrix< T1, Prop1, RowSymComplexSparse, Allocator1 > &M, const Vector< T2, Storage2, Allocator2 > &X, Vector< T4, Storage4, Allocator4 > &Y) |
template<class T1 , class Prop1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T4 , class Storage4 , class Allocator4 > | |
void | MltVector (const Matrix< T1, Prop1, ColSymComplexSparse, Allocator1 > &M, const Vector< T2, Storage2, Allocator2 > &X, Vector< T4, Storage4, Allocator4 > &Y) |
template<class T1 , class Prop1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T4 , class Storage4 , class Allocator4 > | |
void | MltVector (const SeldonTranspose &Trans, const Matrix< T1, Prop1, RowComplexSparse, Allocator1 > &M, const Vector< T2, Storage2, Allocator2 > &X, Vector< T4, Storage4, Allocator4 > &Y) |
template<class T1 , class Prop1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T4 , class Storage4 , class Allocator4 > | |
void | MltVector (const SeldonTranspose &Trans, const Matrix< T1, Prop1, ColComplexSparse, Allocator1 > &M, const Vector< T2, Storage2, Allocator2 > &X, Vector< T4, Storage4, Allocator4 > &Y) |
template<class T1 , class Prop1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T4 , class Storage4 , class Allocator4 > | |
void | MltVector (const SeldonTranspose &Trans, const Matrix< T1, Prop1, RowSymComplexSparse, Allocator1 > &M, const Vector< T2, Storage2, Allocator2 > &X, Vector< T4, Storage4, Allocator4 > &Y) |
template<class T1 , class Prop1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T4 , class Storage4 , class Allocator4 > | |
void | MltVector (const SeldonTranspose &Trans, const Matrix< T1, Prop1, ColSymComplexSparse, Allocator1 > &M, const Vector< T2, Storage2, Allocator2 > &X, Vector< T4, Storage4, Allocator4 > &Y) |
template<class T1 , class T2 , class T3 , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | MltVector (const Matrix< T1, Symmetric, ArrayRowSymComplexSparse, Allocator1 > &A, const Vector< T2, VectFull, Allocator2 > &B, Vector< T3, VectFull, Allocator3 > &C) |
template<class T1 , class T2 , class T3 , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | MltVector (const SeldonTranspose &Trans, const Matrix< T1, Symmetric, ArrayRowSymComplexSparse, Allocator1 > &A, const Vector< T2, VectFull, Allocator2 > &B, Vector< T3, VectFull, Allocator3 > &C) |
template<class T1 , class T2 , class T3 , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | MltVector (const Matrix< T1, Symmetric, ArrayColSymComplexSparse, Allocator1 > &A, const Vector< T2, VectFull, Allocator2 > &B, Vector< T3, VectFull, Allocator3 > &C) |
template<class T1 , class T2 , class T3 , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | MltVector (const SeldonTranspose &Trans, const Matrix< T1, Symmetric, ArrayColSymComplexSparse, Allocator1 > &A, const Vector< T2, VectFull, Allocator2 > &B, Vector< T3, VectFull, Allocator3 > &C) |
template<class T1 , class T2 , class T3 , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | MltVector (const Matrix< T1, General, ArrayRowComplexSparse, Allocator1 > &A, const Vector< T2, VectFull, Allocator2 > &B, Vector< T3, VectFull, Allocator3 > &C) |
template<class T1 , class T2 , class T3 , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | MltVector (const SeldonTranspose &Trans, const Matrix< T1, General, ArrayRowComplexSparse, Allocator1 > &A, const Vector< T2, VectFull, Allocator2 > &B, Vector< T3, VectFull, Allocator3 > &C) |
template<class T1 , class T2 , class T3 , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | MltVector (const Matrix< T1, General, ArrayColComplexSparse, Allocator1 > &A, const Vector< T2, VectFull, Allocator2 > &B, Vector< T3, VectFull, Allocator3 > &C) |
template<class T1 , class T2 , class T3 , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | MltVector (const SeldonTranspose &Trans, const Matrix< T1, General, ArrayColComplexSparse, Allocator1 > &A, const Vector< T2, VectFull, Allocator2 > &B, Vector< T3, VectFull, Allocator3 > &C) |
template<class T0 , class T1 , class Prop1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 , class T4 , class Storage4 , class Allocator4 > | |
void | MltAddVector (const T0 &alpha, const Matrix< T1, Prop1, RowComplexSparse, Allocator1 > &M, const Vector< T2, Storage2, Allocator2 > &X, const T3 &beta, Vector< T4, Storage4, Allocator4 > &Y) |
template<class T0 , class T1 , class Prop1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 , class T4 , class Storage4 , class Allocator4 > | |
void | MltAddVector (const T0 &alpha, const Matrix< T1, Prop1, ColComplexSparse, Allocator1 > &M, const Vector< T2, Storage2, Allocator2 > &X, const T3 &beta, Vector< T4, Storage4, Allocator4 > &Y) |
template<class T0 , class T1 , class Prop1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 , class T4 , class Storage4 , class Allocator4 > | |
void | MltAddVector (const T0 &alpha, const Matrix< T1, Prop1, RowSymComplexSparse, Allocator1 > &M, const Vector< T2, Storage2, Allocator2 > &X, const T3 &beta, Vector< T4, Storage4, Allocator4 > &Y) |
template<class T0 , class T1 , class Prop1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 , class T4 , class Storage4 , class Allocator4 > | |
void | MltAddVector (const T0 &alpha, const Matrix< T1, Prop1, ColSymComplexSparse, Allocator1 > &M, const Vector< T2, Storage2, Allocator2 > &X, const T3 &beta, Vector< T4, Storage4, Allocator4 > &Y) |
template<class T0 , class T1 , class Prop1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 , class T4 , class Storage4 , class Allocator4 > | |
void | MltAddVector (const T0 &alpha, const SeldonTranspose &Trans, const Matrix< T1, Prop1, RowComplexSparse, Allocator1 > &M, const Vector< T2, Storage2, Allocator2 > &X, const T3 &beta, Vector< T4, Storage4, Allocator4 > &Y) |
template<class T0 , class T1 , class Prop1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 , class T4 , class Storage4 , class Allocator4 > | |
void | MltAddVector (const T0 &alpha, const SeldonTranspose &Trans, const Matrix< T1, Prop1, ColComplexSparse, Allocator1 > &M, const Vector< T2, Storage2, Allocator2 > &X, const T3 &beta, Vector< T4, Storage4, Allocator4 > &Y) |
template<class T0 , class T1 , class Prop1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 , class T4 , class Storage4 , class Allocator4 > | |
void | MltAddVector (const T0 &alpha, const SeldonTranspose &Trans, const Matrix< T1, Prop1, RowSymComplexSparse, Allocator1 > &M, const Vector< T2, Storage2, Allocator2 > &X, const T3 &beta, Vector< T4, Storage4, Allocator4 > &Y) |
template<class T0 , class T1 , class Prop1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 , class T4 , class Storage4 , class Allocator4 > | |
void | MltAddVector (const T0 &alpha, const SeldonTranspose &Trans, const Matrix< T1, Prop1, ColSymComplexSparse, Allocator1 > &M, const Vector< T2, Storage2, Allocator2 > &X, const T3 &beta, Vector< T4, Storage4, Allocator4 > &Y) |
template<class T0 , class T1 , class T2 , class T3 , class T4 , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | MltAddVector (const T0 &alpha, const Matrix< T1, Symmetric, ArrayRowSymComplexSparse, Allocator1 > &A, const Vector< T2, VectFull, Allocator2 > &B, const T4 &beta, Vector< T3, VectFull, Allocator3 > &C) |
template<class T0 , class T1 , class T2 , class T3 , class T4 , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | MltAddVector (const T0 &alpha, const SeldonTranspose &Trans, const Matrix< T1, Symmetric, ArrayRowSymComplexSparse, Allocator1 > &A, const Vector< T2, VectFull, Allocator2 > &B, const T4 &beta, Vector< T3, VectFull, Allocator3 > &C) |
template<class T0 , class T1 , class T2 , class T3 , class T4 , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | MltAddVector (const T0 &alpha, const Matrix< T1, Symmetric, ArrayColSymComplexSparse, Allocator1 > &A, const Vector< T2, VectFull, Allocator2 > &B, const T4 &beta, Vector< T3, VectFull, Allocator3 > &C) |
template<class T0 , class T1 , class T2 , class T3 , class T4 , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | MltAddVector (const T0 &alpha, const SeldonTranspose &Trans, const Matrix< T1, Symmetric, ArrayColSymComplexSparse, Allocator1 > &A, const Vector< T2, VectFull, Allocator2 > &B, const T4 &beta, Vector< T3, VectFull, Allocator3 > &C) |
template<class T0 , class T1 , class T2 , class T3 , class T4 , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | MltAddVector (const T0 &alpha, const Matrix< T1, General, ArrayRowComplexSparse, Allocator1 > &A, const Vector< T2, VectFull, Allocator2 > &B, const T4 &beta, Vector< T3, VectFull, Allocator3 > &C) |
template<class T0 , class T1 , class T2 , class T3 , class T4 , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | MltAddVector (const T0 &alpha, const SeldonTranspose &Trans, const Matrix< T1, General, ArrayRowComplexSparse, Allocator1 > &A, const Vector< T2, VectFull, Allocator2 > &B, const T4 &beta, Vector< T3, VectFull, Allocator3 > &C) |
template<class T0 , class T1 , class T2 , class T3 , class T4 , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | MltAddVector (const T0 &alpha, const Matrix< T1, General, ArrayColComplexSparse, Allocator1 > &A, const Vector< T2, VectFull, Allocator2 > &B, const T4 &beta, Vector< T3, VectFull, Allocator3 > &C) |
template<class T0 , class T1 , class T2 , class T3 , class T4 , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | MltAddVector (const T0 &alpha, const SeldonTranspose &Trans, const Matrix< T1, General, ArrayColComplexSparse, Allocator1 > &A, const Vector< T2, VectFull, Allocator2 > &B, const T4 &beta, Vector< T3, VectFull, Allocator3 > &C) |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 > | |
void | SorVector (const Matrix< T0, Prop0, RowComplexSparse, Allocator0 > &A, Vector< complex< T2 >, Storage2, Allocator2 > &X, const Vector< complex< T1 >, Storage1, Allocator1 > &B, const T3 &omega, int iter, int type_ssor) |
Successive overrelaxation. More... | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 > | |
void | SorVector (const Matrix< T0, Prop0, ArrayRowComplexSparse, Allocator0 > &A, Vector< complex< T2 >, Storage2, Allocator2 > &X, const Vector< complex< T1 >, Storage1, Allocator1 > &B, const T3 &omega, int iter, int type_ssor) |
Successive overrelaxation. More... | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 > | |
void | SorVector (const Matrix< T0, Prop0, ColComplexSparse, Allocator0 > &A, Vector< complex< T2 >, Storage2, Allocator2 > &X, const Vector< complex< T1 >, Storage1, Allocator1 > &B, const T3 &omega, int iter, int type_ssor) |
Successive overrelaxation. More... | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 > | |
void | SorVector (const Matrix< T0, Prop0, ArrayColComplexSparse, Allocator0 > &A, Vector< complex< T2 >, Storage2, Allocator2 > &X, const Vector< complex< T1 >, Storage1, Allocator1 > &B, const T3 &omega, int iter, int type_ssor) |
Successive overrelaxation. More... | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 > | |
void | SorVector (const Matrix< T0, Prop0, RowSymComplexSparse, Allocator0 > &A, Vector< complex< T2 >, Storage2, Allocator2 > &X, const Vector< complex< T1 >, Storage1, Allocator1 > &B, const T3 &omega, int iter, int type_ssor) |
Successive overrelaxation. More... | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 > | |
void | SorVector (const Matrix< T0, Prop0, ArrayRowSymComplexSparse, Allocator0 > &A, Vector< complex< T2 >, Storage2, Allocator2 > &X, const Vector< complex< T1 >, Storage1, Allocator1 > &B, const T3 &omega, int iter, int type_ssor) |
Successive overrelaxation. More... | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 > | |
void | SorVector (const Matrix< T0, Prop0, ColSymComplexSparse, Allocator0 > &A, Vector< complex< T2 >, Storage2, Allocator2 > &X, const Vector< complex< T1 >, Storage1, Allocator1 > &B, const T3 &omega, int iter, int type_ssor) |
Successive overrelaxation. More... | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 > | |
void | SorVector (const Matrix< T0, Prop0, ArrayColSymComplexSparse, Allocator0 > &A, Vector< complex< T2 >, Storage2, Allocator2 > &X, const Vector< complex< T1 >, Storage1, Allocator1 > &B, const T3 &omega, int iter, int type_ssor) |
Successive overrelaxation. More... | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 > | |
void | SorVector (const SeldonTranspose &transM, const Matrix< T0, Prop0, ColComplexSparse, Allocator0 > &A, Vector< complex< T2 >, Storage2, Allocator2 > &X, const Vector< complex< T1 >, Storage1, Allocator1 > &B, const T3 &omega, int iter, int type_ssor) |
Successive overrelaxation. More... | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 > | |
void | SorVector (const SeldonTranspose &transM, const Matrix< T0, Prop0, ArrayColComplexSparse, Allocator0 > &A, Vector< complex< T2 >, Storage2, Allocator2 > &X, const Vector< complex< T1 >, Storage1, Allocator1 > &B, const T3 &omega, int iter, int type_ssor) |
Successive overrelaxation. More... | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 > | |
void | SorVector (const SeldonTranspose &transM, const Matrix< T0, Prop0, RowComplexSparse, Allocator0 > &A, Vector< complex< T2 >, Storage2, Allocator2 > &X, const Vector< complex< T1 >, Storage1, Allocator1 > &B, const T3 &omega, int iter, int type_ssor) |
Successive overrelaxation. More... | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 > | |
void | SorVector (const SeldonTranspose &transM, const Matrix< T0, Prop0, ArrayRowComplexSparse, Allocator0 > &A, Vector< complex< T2 >, Storage2, Allocator2 > &X, const Vector< complex< T1 >, Storage1, Allocator1 > &B, const T3 &omega, int iter, int type_ssor) |
Successive overrelaxation. More... | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 > | |
void | SorVector (const SeldonTranspose &transM, const Matrix< T0, Prop0, RowSymComplexSparse, Allocator0 > &A, Vector< complex< T2 >, Storage2, Allocator2 > &X, const Vector< complex< T1 >, Storage1, Allocator1 > &B, const T3 &omega, int iter, int type_ssor) |
Successive overrelaxation. More... | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 > | |
void | SorVector (const SeldonTranspose &transM, const Matrix< T0, Prop0, ArrayRowSymComplexSparse, Allocator0 > &A, Vector< complex< T2 >, Storage2, Allocator2 > &X, const Vector< complex< T1 >, Storage1, Allocator1 > &B, const T3 &omega, int iter, int type_ssor) |
Successive overrelaxation. More... | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 > | |
void | SorVector (const SeldonTranspose &transM, const Matrix< T0, Prop0, ColSymComplexSparse, Allocator0 > &A, Vector< complex< T2 >, Storage2, Allocator2 > &X, const Vector< complex< T1 >, Storage1, Allocator1 > &B, const T3 &omega, int iter, int type_ssor) |
Successive overrelaxation. More... | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 > | |
void | SorVector (const SeldonTranspose &transM, const Matrix< T0, Prop0, ArrayColSymComplexSparse, Allocator0 > &A, Vector< complex< T2 >, Storage2, Allocator2 > &X, const Vector< complex< T1 >, Storage1, Allocator1 > &B, const T3 &omega, int iter, int type_ssor) |
Successive overrelaxation. More... | |
template<class T , class Prop , class Allocator1 , class Allocator2 , class Tint , class Allocator3 , class Allocator4 > | |
void | ConvertMatrix_to_Coordinates (const Matrix< T, Prop, RowComplexSparse, Allocator1 > &A, Vector< Tint, VectFull, Allocator2 > &IndRow, Vector< Tint, VectFull, Allocator3 > &IndCol, Vector< T, VectFull, Allocator4 > &Val, int index, bool sym) |
Conversion from RowComplexSparse to coordinate format. | |
template<class T , class Prop , class Allocator1 , class Allocator2 , class Tint , class Allocator3 , class Allocator4 > | |
void | ConvertMatrix_to_Coordinates (const Matrix< T, Prop, ColComplexSparse, Allocator1 > &A, Vector< Tint, VectFull, Allocator2 > &IndRow, Vector< Tint, VectFull, Allocator3 > &IndCol, Vector< T, VectFull, Allocator4 > &Val, int index, bool sym) |
Conversion from ColComplexSparse to coordinate format. | |
template<class T , class Prop , class Allocator1 , class Allocator2 , class Tint , class Allocator3 , class Allocator4 > | |
void | ConvertMatrix_to_Coordinates (const Matrix< T, Prop, RowSymComplexSparse, Allocator1 > &A, Vector< Tint, VectFull, Allocator2 > &IndRow, Vector< Tint, VectFull, Allocator3 > &IndCol, Vector< T, VectFull, Allocator4 > &Val, int index, bool sym) |
Conversion from ArrayRowSymComplexSparse to coordinate format. | |
template<class T , class Prop , class Allocator1 , class Allocator2 , class Tint , class Allocator3 , class Allocator4 > | |
void | ConvertMatrix_to_Coordinates (const Matrix< T, Prop, ColSymComplexSparse, Allocator1 > &A, Vector< Tint, VectFull, Allocator2 > &IndRow, Vector< Tint, VectFull, Allocator3 > &IndCol, Vector< T, VectFull, Allocator4 > &Val, int index, bool sym) |
Conversion from ColSymComplexSparse to coordinate format. | |
template<class T , class Prop , class Allocator1 , class Allocator2 , class Tint , class Allocator3 , class Allocator4 > | |
void | ConvertMatrix_to_Coordinates (const Matrix< T, Prop, ArrayRowComplexSparse, Allocator1 > &A, Vector< Tint, VectFull, Allocator2 > &IndRow, Vector< Tint, VectFull, Allocator3 > &IndCol, Vector< T, VectFull, Allocator4 > &Val, int index, bool sym) |
Conversion from ArrayRowComplexSparse to coordinate format. | |
template<class T , class Prop , class Allocator1 , class Allocator2 , class Tint , class Allocator3 , class Allocator4 > | |
void | ConvertMatrix_to_Coordinates (const Matrix< T, Prop, ArrayColComplexSparse, Allocator1 > &A, Vector< Tint, VectFull, Allocator2 > &IndRow, Vector< Tint, VectFull, Allocator3 > &IndCol, Vector< T, VectFull, Allocator4 > &Val, int index, bool sym) |
Conversion from ArrayColComplexSparse to coordinate format. | |
template<class T , class Prop , class Allocator1 , class Allocator2 , class Tint , class Allocator3 , class Allocator4 > | |
void | ConvertMatrix_to_Coordinates (const Matrix< T, Prop, ArrayRowSymComplexSparse, Allocator1 > &A, Vector< Tint, VectFull, Allocator2 > &IndRow, Vector< Tint, VectFull, Allocator3 > &IndCol, Vector< T, VectFull, Allocator4 > &Val, int index, bool sym) |
Conversion from ArrayRowSymComplexSparse to coordinate format. | |
template<class T , class Prop , class Allocator1 , class Allocator2 , class Tint , class Allocator3 , class Allocator4 > | |
void | ConvertMatrix_to_Coordinates (const Matrix< T, Prop, ArrayColSymComplexSparse, Allocator1 > &A, Vector< Tint, VectFull, Allocator2 > &IndRow, Vector< Tint, VectFull, Allocator3 > &IndCol, Vector< T, VectFull, Allocator4 > &Val, int index, bool sym) |
Conversion from ArrayColSymComplexSparse to coordinate format. | |
template<class T , class Prop , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | ConvertMatrix_from_Coordinates (const Vector< int, VectFull, Allocator1 > &IndRow, const Vector< int, VectFull, Allocator2 > &IndCol, const Vector< T, VectFull, Allocator3 > &Val, Matrix< T, Prop, RowComplexSparse, Allocator4 > &A, int index) |
Conversion from coordinate format to RowComplexSparse. | |
template<class T , class Prop , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | ConvertMatrix_from_Coordinates (const Vector< int, VectFull, Allocator1 > &IndRow, const Vector< int, VectFull, Allocator2 > &IndCol, const Vector< T, VectFull, Allocator3 > &Val, Matrix< T, Prop, ColComplexSparse, Allocator4 > &A, int index) |
Conversion from coordinate format to ColComplexSparse. | |
template<class T , class Prop , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | ConvertMatrix_from_Coordinates (const Vector< int, VectFull, Allocator1 > &IndRow, const Vector< int, VectFull, Allocator2 > &IndCol, const Vector< T, VectFull, Allocator3 > &Val, Matrix< T, Prop, RowSymComplexSparse, Allocator4 > &A, int index) |
Conversion from coordinate format to RowSymComplexSparse. | |
template<class T , class Prop , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | ConvertMatrix_from_Coordinates (const Vector< int, VectFull, Allocator1 > &IndRow, const Vector< int, VectFull, Allocator2 > &IndCol, const Vector< T, VectFull, Allocator3 > &Val, Matrix< T, Prop, ColSymComplexSparse, Allocator4 > &A, int index) |
Conversion from coordinate format to ColSymComplexSparse. | |
template<class T , class Prop , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | ConvertMatrix_from_Coordinates (const Vector< int, VectFull, Allocator1 > &IndRow, const Vector< int, VectFull, Allocator2 > &IndCol, const Vector< T, VectFull, Allocator3 > &Val, Matrix< T, Prop, ArrayRowComplexSparse, Allocator4 > &A, int index) |
Conversion from coordinate format to ArrayRowComplexSparse. | |
template<class T , class Prop , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | ConvertMatrix_from_Coordinates (const Vector< int, VectFull, Allocator1 > &IndRow, const Vector< int, VectFull, Allocator2 > &IndCol, const Vector< T, VectFull, Allocator3 > &Val, Matrix< T, Prop, ArrayColComplexSparse, Allocator4 > &A, int index) |
Conversion from coordinate format to ArrayColComplexSparse. | |
template<class T , class Prop , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | ConvertMatrix_from_Coordinates (const Vector< int, VectFull, Allocator1 > &IndRow, const Vector< int, VectFull, Allocator2 > &IndCol, const Vector< T, VectFull, Allocator3 > &Val, Matrix< T, Prop, ArrayRowSymComplexSparse, Allocator4 > &A, int index) |
Conversion from coordinate format to ArrayRowSymComplexSparse. | |
template<class T , class Prop , class Allocator1 , class Allocator2 , class Allocator3 , class Allocator4 > | |
void | ConvertMatrix_from_Coordinates (const Vector< int, VectFull, Allocator1 > &IndRow, const Vector< int, VectFull, Allocator2 > &IndCol, const Vector< T, VectFull, Allocator3 > &Val, Matrix< T, Prop, ArrayColSymComplexSparse, Allocator4 > &A, int index) |
Conversion from coordinate format to ArrayRowSymComplexSparse. | |
template<class T , class Prop , class Alloc1 , class Tint0 , class Tint1 , class Alloc2 , class Alloc3 , class Alloc4 > | |
void | ConvertToCSR (const Matrix< T, Prop, RowComplexSparse, Alloc1 > &A, General &sym, Vector< Tint0, VectFull, Alloc2 > &Ptr, Vector< Tint1, VectFull, Alloc3 > &IndCol, Vector< T, VectFull, Alloc4 > &Value) |
Conversion from RowComplexSparse to CSR. | |
template<class T , class Prop , class Alloc1 , class Tint0 , class Tint1 , class Alloc2 , class Alloc3 , class Alloc4 > | |
void | ConvertToCSR (const Matrix< T, Prop, ColComplexSparse, Alloc1 > &A, General &sym, Vector< Tint0, VectFull, Alloc2 > &Ptr, Vector< Tint1, VectFull, Alloc3 > &IndCol, Vector< T, VectFull, Alloc4 > &Val) |
Conversion from ColComplexSparse to CSR format. | |
template<class T , class Prop , class Alloc1 , class Tint0 , class Tint1 , class Alloc2 , class Alloc3 , class Alloc4 > | |
void | ConvertToCSR (const Matrix< T, Prop, RowSymComplexSparse, Alloc1 > &A, Symmetric &sym, Vector< Tint0, VectFull, Alloc2 > &Ptr, Vector< Tint1, VectFull, Alloc3 > &IndCol, Vector< T, VectFull, Alloc4 > &Value) |
Conversion from RowSymComplexSparse to CSR. | |
template<class T , class Prop , class Alloc1 , class Tint0 , class Tint1 , class Alloc2 , class Alloc3 , class Alloc4 > | |
void | ConvertToCSR (const Matrix< T, Prop, RowSymComplexSparse, Alloc1 > &A, General &sym, Vector< Tint0, VectFull, Alloc2 > &Ptr, Vector< Tint1, VectFull, Alloc3 > &IndCol, Vector< T, VectFull, Alloc4 > &Val) |
Conversion from RowSymComplexSparse to CSR format. | |
template<class T , class Prop , class Alloc1 , class Tint0 , class Tint1 , class Alloc2 , class Alloc3 , class Alloc4 > | |
void | ConvertToCSR (const Matrix< T, Prop, ColSymComplexSparse, Alloc1 > &A, Symmetric &sym, Vector< Tint0, VectFull, Alloc2 > &Ptr, Vector< Tint1, VectFull, Alloc3 > &IndCol, Vector< T, VectFull, Alloc4 > &Val) |
Conversion from ColSymComplexSparse to CSR format. | |
template<class T , class Prop , class Alloc1 , class Tint0 , class Tint1 , class Alloc2 , class Alloc3 , class Alloc4 > | |
void | ConvertToCSR (const Matrix< T, Prop, ColSymComplexSparse, Alloc1 > &A, General &sym, Vector< Tint0, VectFull, Alloc2 > &Ptr, Vector< Tint1, VectFull, Alloc3 > &IndCol, Vector< T, VectFull, Alloc4 > &Val) |
Conversion from ColSymComplexSparse to CSR format. | |
template<class T , class Prop , class Alloc1 , class Tint0 , class Tint1 , class Alloc2 , class Alloc3 , class Alloc4 > | |
void | ConvertToCSR (const Matrix< T, Prop, ArrayRowComplexSparse, Alloc1 > &A, General &sym, Vector< Tint0, VectFull, Alloc2 > &Ptr, Vector< Tint1, VectFull, Alloc3 > &IndCol, Vector< T, VectFull, Alloc4 > &Value) |
Conversion from ArrayRowComplexSparse to CSR. | |
template<class T , class Prop , class Alloc1 , class Tint0 , class Tint1 , class Alloc2 , class Alloc3 , class Alloc4 > | |
void | ConvertToCSR (const Matrix< T, Prop, ArrayColComplexSparse, Alloc1 > &A, General &sym, Vector< Tint0, VectFull, Alloc2 > &Ptr, Vector< Tint1, VectFull, Alloc3 > &IndCol, Vector< T, VectFull, Alloc4 > &Val) |
Conversion from ArrayColComplexSparse to CSR format. | |
template<class T , class Prop , class Alloc1 , class Tint0 , class Tint1 , class Alloc2 , class Alloc3 , class Alloc4 > | |
void | ConvertToCSR (const Matrix< T, Prop, ArrayRowSymComplexSparse, Alloc1 > &A, Symmetric &sym, Vector< Tint0, VectFull, Alloc2 > &Ptr, Vector< Tint1, VectFull, Alloc3 > &IndCol, Vector< T, VectFull, Alloc4 > &Value) |
Conversion from ArrayRowSymComplexSparse to CSR. | |
template<class T , class Prop , class Alloc1 , class Tint0 , class Tint1 , class Alloc2 , class Alloc3 , class Alloc4 > | |
void | ConvertToCSR (const Matrix< T, Prop, ArrayRowSymComplexSparse, Alloc1 > &A, General &sym, Vector< Tint0, VectFull, Alloc2 > &Ptr, Vector< Tint1, VectFull, Alloc3 > &IndCol, Vector< T, VectFull, Alloc4 > &Value) |
Conversion from ArrayRowSymComplexSparse to CSR. | |
template<class T , class Prop , class Alloc1 , class Tint0 , class Tint1 , class Alloc2 , class Alloc3 , class Alloc4 > | |
void | ConvertToCSR (const Matrix< T, Prop, ArrayColSymComplexSparse, Alloc1 > &A, Symmetric &sym, Vector< Tint0, VectFull, Alloc2 > &Ptr, Vector< Tint1, VectFull, Alloc3 > &IndCol, Vector< T, VectFull, Alloc4 > &Val) |
Conversion from ArrayColSymComplexSparse to CSR format. | |
template<class T , class Prop , class Alloc1 , class Tint0 , class Tint1 , class Alloc2 , class Alloc3 , class Alloc4 > | |
void | ConvertToCSR (const Matrix< T, Prop, ArrayColSymComplexSparse, Alloc1 > &A, General &sym, Vector< Tint0, VectFull, Alloc2 > &Ptr, Vector< Tint1, VectFull, Alloc3 > &IndCol, Vector< T, VectFull, Alloc4 > &Val) |
Conversion from ArrayColSymComplexSparse to CSR format. | |
template<class T , class Prop , class Alloc1 , class Tint0 , class Tint1 , class Alloc2 , class Alloc3 , class Alloc4 > | |
void | ConvertToCSC (const Matrix< T, Prop, RowComplexSparse, Alloc1 > &A, General &sym, Vector< Tint0, VectFull, Alloc2 > &Ptr, Vector< Tint1, VectFull, Alloc3 > &IndRow, Vector< T, VectFull, Alloc4 > &Val, bool sym_pat) |
Conversion from RowComplexSparse to CSC format. More... | |
template<class T , class Prop , class Alloc1 , class Tint0 , class Tint1 , class Alloc2 , class Alloc3 , class Alloc4 > | |
void | ConvertToCSC (const Matrix< T, Prop, ColComplexSparse, Alloc1 > &A, General &sym, Vector< Tint0, VectFull, Alloc2 > &Ptr, Vector< Tint1, VectFull, Alloc3 > &IndCol, Vector< T, VectFull, Alloc4 > &Value, bool sym_pat) |
Conversion from ColComplexSparse to CSC. | |
template<class T , class Prop , class Alloc1 , class Tint0 , class Tint1 , class Alloc2 , class Alloc3 , class Alloc4 > | |
void | ConvertToCSC (const Matrix< T, Prop, RowSymComplexSparse, Alloc1 > &A, Symmetric &sym, Vector< Tint0, VectFull, Alloc2 > &Ptr, Vector< Tint1, VectFull, Alloc3 > &IndRow, Vector< T, VectFull, Alloc4 > &Val, bool sym_pat) |
Conversion from RowSymComplexSparse to CSC format. | |
template<class T , class Prop , class Alloc1 , class Tint0 , class Tint1 , class Alloc2 , class Alloc3 , class Alloc4 > | |
void | ConvertToCSC (const Matrix< T, Prop, RowSymComplexSparse, Alloc1 > &A, General &sym, Vector< Tint0, VectFull, Alloc2 > &Ptr, Vector< Tint1, VectFull, Alloc3 > &IndRow, Vector< T, VectFull, Alloc4 > &Val, bool sym_pat) |
Conversion from RowSymComplexSparse to CSC format. | |
template<class T , class Prop , class Alloc1 , class Tint0 , class Tint1 , class Alloc2 , class Alloc3 , class Alloc4 > | |
void | ConvertToCSC (const Matrix< T, Prop, ColSymComplexSparse, Alloc1 > &A, Symmetric &sym, Vector< Tint0, VectFull, Alloc2 > &Ptr, Vector< Tint1, VectFull, Alloc3 > &IndCol, Vector< T, VectFull, Alloc4 > &Value, bool sym_pat) |
Conversion from ColSymComplexSparse to CSC. | |
template<class T , class Prop , class Alloc1 , class Tint0 , class Tint1 , class Alloc2 , class Alloc3 , class Alloc4 > | |
void | ConvertToCSC (const Matrix< T, Prop, ColSymComplexSparse, Alloc1 > &A, General &sym, Vector< Tint0, VectFull, Alloc2 > &Ptr, Vector< Tint1, VectFull, Alloc3 > &IndRow, Vector< T, VectFull, Alloc4 > &Val, bool sym_pat) |
Conversion from ColSymComplexSparse to CSC format. | |
template<class T , class Prop , class Alloc1 , class Tint0 , class Tint1 , class Alloc2 , class Alloc3 , class Alloc4 > | |
void | ConvertToCSC (const Matrix< T, Prop, ArrayRowComplexSparse, Alloc1 > &A, General &sym, Vector< Tint0, VectFull, Alloc2 > &Ptr, Vector< Tint1, VectFull, Alloc3 > &IndRow, Vector< T, VectFull, Alloc4 > &Val, bool sym_pat) |
Conversion from ArrayRowComplexSparse to CSC format. More... | |
template<class T , class Prop , class Alloc1 , class Tint0 , class Tint1 , class Alloc2 , class Alloc3 , class Alloc4 > | |
void | ConvertToCSC (const Matrix< T, Prop, ArrayColComplexSparse, Alloc1 > &A, General &sym, Vector< Tint0, VectFull, Alloc2 > &Ptr, Vector< Tint1, VectFull, Alloc3 > &IndCol, Vector< T, VectFull, Alloc4 > &Value, bool sym_pat) |
Conversion from ArrayColComplexSparse to CSC. | |
template<class T , class Prop , class Alloc1 , class Tint0 , class Tint1 , class Alloc2 , class Alloc3 , class Alloc4 > | |
void | ConvertToCSC (const Matrix< T, Prop, ArrayRowSymComplexSparse, Alloc1 > &A, Symmetric &sym, Vector< Tint0, VectFull, Alloc2 > &Ptr, Vector< Tint1, VectFull, Alloc3 > &IndRow, Vector< T, VectFull, Alloc4 > &Val, bool sym_pat) |
Conversion from ArrayRowSymComplexSparse to CSC format. | |
template<class T , class Prop , class Alloc1 , class Tint0 , class Tint1 , class Alloc2 , class Alloc3 , class Alloc4 > | |
void | ConvertToCSC (const Matrix< T, Prop, ArrayRowSymComplexSparse, Alloc1 > &A, General &sym, Vector< Tint0, VectFull, Alloc2 > &Ptr, Vector< Tint1, VectFull, Alloc3 > &IndRow, Vector< T, VectFull, Alloc4 > &Val, bool sym_pat) |
Conversion from ArrayRowSymComplexSparse to CSC format. | |
template<class T , class Prop , class Alloc1 , class Tint0 , class Tint1 , class Alloc2 , class Alloc3 , class Alloc4 > | |
void | ConvertToCSC (const Matrix< T, Prop, ArrayColSymComplexSparse, Alloc1 > &A, Symmetric &sym, Vector< Tint0, VectFull, Alloc2 > &Ptr, Vector< Tint1, VectFull, Alloc3 > &IndCol, Vector< T, VectFull, Alloc4 > &Value, bool sym_pat) |
Conversion from ArrayColSymComplexSparse to CSC. | |
template<class T , class Prop , class Alloc1 , class Tint0 , class Tint1 , class Alloc2 , class Alloc3 , class Alloc4 > | |
void | ConvertToCSC (const Matrix< T, Prop, ArrayColSymComplexSparse, Alloc1 > &A, General &sym, Vector< Tint0, VectFull, Alloc2 > &Ptr, Vector< Tint1, VectFull, Alloc3 > &IndRow, Vector< T, VectFull, Alloc4 > &Val, bool sym_pat) |
Conversion from ArrayColSymComplexSparse to CSC format. | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, ArrayRowSymComplexSparse, Allocator0 > &mat_array, Matrix< T1, Prop1, RowSparse, Allocator1 > &mat_csr) |
Conversion from ArrayRowSymComplexSparse to RowSparse. | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, ArrayRowSymComplexSparse, Allocator0 > &mat_array, Matrix< T1, Prop1, RowSymSparse, Allocator1 > &mat_csr) |
Conversion from ArrayRowSymComplexSparse to RowSymSparse. | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, ArrayRowComplexSparse, Allocator0 > &mat_array, Matrix< T1, Prop1, RowSparse, Allocator1 > &mat_csr) |
Conversion from ArrayRowComplexSparse to RowSparse. | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, ArrayColSymComplexSparse, Allocator0 > &mat_array, Matrix< T1, Prop1, RowSparse, Allocator1 > &mat_csr) |
Conversion from ArrayColSymComplexSparse to RowSparse. | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, ArrayColSymComplexSparse, Allocator0 > &mat_array, Matrix< T1, Prop1, RowSymSparse, Allocator1 > &mat_csr) |
Conversion from ArrayColSymComplexSparse to RowSymSparse. | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, ArrayColComplexSparse, Allocator0 > &mat_array, Matrix< T1, Prop1, RowSparse, Allocator1 > &mat_csr) |
Conversion from ArrayColComplexSparse to RowSparse. | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, RowSymComplexSparse, Allocator0 > &mat_array, Matrix< T1, Prop1, RowSparse, Allocator1 > &mat_csr) |
Conversion from RowSymComplexSparse to RowSparse. | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, RowSymComplexSparse, Allocator0 > &mat_array, Matrix< T1, Prop1, RowSymSparse, Allocator1 > &mat_csr) |
Conversion from RowSymComplexSparse to RowSymSparse. | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, RowComplexSparse, Allocator0 > &mat_array, Matrix< T1, Prop1, RowSparse, Allocator1 > &mat_csr) |
Conversion from RowComplexSparse to RowSparse. | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, ColSymComplexSparse, Allocator0 > &mat_array, Matrix< T1, Prop1, RowSparse, Allocator1 > &mat_csr) |
Conversion from ColSymComplexSparse to RowSparse. | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, ColSymComplexSparse, Allocator0 > &mat_array, Matrix< T1, Prop1, RowSymSparse, Allocator1 > &mat_csr) |
Conversion from ColSymComplexSparse to RowSymSparse. | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, ColComplexSparse, Allocator0 > &mat_array, Matrix< T1, Prop1, RowSparse, Allocator1 > &mat_csr) |
Conversion from ColComplexSparse to RowSparse. | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, ArrayRowComplexSparse, Allocator0 > &A, Matrix< T1, Prop1, ColSparse, Allocator1 > &B) |
Conversion from ArrayRowComplexSparse to ColSparse. | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, ArrayRowSymComplexSparse, Allocator0 > &A, Matrix< T1, Prop1, ColSparse, Allocator1 > &B) |
Conversion from ArrayRowSymComplexSparse to ColSparse. | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, ArrayRowSymComplexSparse, Allocator0 > &A, Matrix< T1, Prop1, ColSymSparse, Allocator1 > &B) |
Conversion from ArrayRowSymComplexSparse to ColSymSparse. | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, ArrayColComplexSparse, Allocator0 > &A, Matrix< T1, Prop1, ColSparse, Allocator1 > &B) |
Conversion from ArrayColComplexSparse to ColSparse. | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, ArrayColSymComplexSparse, Allocator0 > &A, Matrix< T1, Prop1, ColSparse, Allocator1 > &B) |
Conversion from ArrayColSymComplexSparse to ColSparse. | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, ArrayColSymComplexSparse, Allocator0 > &A, Matrix< T1, Prop1, ColSymSparse, Allocator1 > &B) |
Conversion from ArrayColSymComplexSparse to ColSymSparse. | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, RowComplexSparse, Allocator0 > &A, Matrix< T1, Prop1, ColSparse, Allocator1 > &B) |
Conversion from RowComplexSparse to ColSparse. | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, RowSymComplexSparse, Allocator0 > &A, Matrix< T1, Prop1, ColSparse, Allocator1 > &B) |
Conversion from RowSymComplexSparse to ColSparse. | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, RowSymComplexSparse, Allocator0 > &A, Matrix< T1, Prop1, ColSymSparse, Allocator1 > &B) |
Conversion from RowSymComplexSparse to ColSymSparse. | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, ColComplexSparse, Allocator0 > &A, Matrix< T1, Prop1, ColSparse, Allocator1 > &B) |
Conversion from ColComplexSparse to ColSparse. | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, ColSymComplexSparse, Allocator0 > &A, Matrix< T1, Prop1, ColSparse, Allocator1 > &B) |
Conversion from ColSymComplexSparse to ColSparse. | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, ColSymComplexSparse, Allocator0 > &A, Matrix< T1, Prop1, ColSymSparse, Allocator1 > &B) |
Conversion from ColSymComplexSparse to ColSymSparse. | |
template<class T , class Prop , class Allocator > | |
void | CopyMatrix (const Matrix< T, Prop, RowComplexSparse, Allocator > &A, Matrix< T, Prop, RowComplexSparse, Allocator > &B) |
B = A. | |
template<class T , class Prop , class Allocator > | |
void | CopyMatrix (const Matrix< T, Prop, RowSymComplexSparse, Allocator > &A, Matrix< T, Prop, RowSymComplexSparse, Allocator > &B) |
B = A. | |
template<class T , class Prop , class Allocator > | |
void | CopyMatrix (const Matrix< T, Prop, ColComplexSparse, Allocator > &A, Matrix< T, Prop, ColComplexSparse, Allocator > &B) |
B = A. | |
template<class T , class Prop , class Allocator > | |
void | CopyMatrix (const Matrix< T, Prop, ColSymComplexSparse, Allocator > &A, Matrix< T, Prop, ColSymComplexSparse, Allocator > &B) |
B = A. | |
template<class T , class Prop , class Allocator > | |
void | CopyMatrix (const Matrix< T, Prop, ArrayRowSymComplexSparse, Allocator > &A, Matrix< T, Prop, ArrayRowSymComplexSparse, Allocator > &B) |
B = A. | |
template<class T , class Prop , class Allocator > | |
void | CopyMatrix (const Matrix< T, Prop, ArrayRowComplexSparse, Allocator > &A, Matrix< T, Prop, ArrayRowComplexSparse, Allocator > &B) |
B = A. | |
template<class T , class Prop , class Allocator > | |
void | CopyMatrix (const Matrix< T, Prop, ArrayColComplexSparse, Allocator > &A, Matrix< T, Prop, ArrayColComplexSparse, Allocator > &B) |
B = A. | |
template<class T , class Prop , class Allocator > | |
void | CopyMatrix (const Matrix< T, Prop, ArrayColSymComplexSparse, Allocator > &A, Matrix< T, Prop, ArrayColSymComplexSparse, Allocator > &B) |
B = A. | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, ColSparse, Allocator0 > &A, Matrix< T1, Prop1, RowComplexSparse, Allocator1 > &B) |
Conversion from ColSparse to RowComplexSparse. | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, ColSparse, Allocator0 > &A, Matrix< T1, Prop1, ColComplexSparse, Allocator1 > &B) |
conversion from ColSparse to ColComplexSparse | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, RowSymSparse, Allocator0 > &A, Matrix< T1, Prop1, ColSymComplexSparse, Allocator1 > &B) |
Conversion from RowSymSparse to ColSymComplexSparse. | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, RowSymSparse, Allocator0 > &A, Matrix< T1, Prop1, RowSymComplexSparse, Allocator1 > &B) |
conversion from RowSymSparse to RowSymComplexSparse | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, ColSparse, Allocator0 > &A, Matrix< T1, Prop1, ArrayRowComplexSparse, Allocator1 > &B) |
Conversion from ColSparse to ArrayRowComplexSparse. | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, ColSparse, Allocator0 > &A, Matrix< T1, Prop1, ArrayColComplexSparse, Allocator1 > &B) |
conversion from ColSparse to ArrayColComplexSparse | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, RowSymSparse, Allocator0 > &A, Matrix< T1, Prop1, ArrayColSymComplexSparse, Allocator1 > &B) |
Conversion from RowSymSparse to ArrayColSymComplexSparse. | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, RowSymSparse, Allocator0 > &A, Matrix< T1, Prop1, ArrayRowSymComplexSparse, Allocator1 > &B) |
conversion from RowSymSparse to ArrayRowSymComplexSparse | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, ArrayRowComplexSparse, Allocator0 > &mat_array, Matrix< T1, Prop1, RowComplexSparse, Allocator1 > &mat_csr) |
Conversion from ArrayRowComplexSparse to RowComplexSparse. | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, ArrayRowSymComplexSparse, Allocator0 > &mat_array, Matrix< T1, Prop1, RowSymComplexSparse, Allocator1 > &mat_csr) |
Conversion from ArrayRowSymComplexSparse to RowSymComplexSparse. | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, ArrayRowSymComplexSparse, Allocator0 > &mat_array, Matrix< T1, Prop1, ArrayRowSparse, Allocator1 > &mat_csr) |
Conversion from ArrayRowSymComplexSparse to ArrayRowSparse. | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, ArrayRowSymComplexSparse, Allocator0 > &A, Matrix< T1, Prop1, ArrayRowSymSparse, Allocator1 > &B) |
Conversion from ArrayRowSymComplexSparse to ArrayRowSymSparse. | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, ArrayRowComplexSparse, Allocator0 > &A, Matrix< T1, Prop1, ArrayRowSparse, Allocator1 > &B) |
Conversion from ArrayRowComplexSparse to ArrayRowSparse. | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, RowSymComplexSparse, Allocator0 > &mat_array, Matrix< T1, Prop1, ArrayRowSparse, Allocator1 > &mat_csr) |
Conversion from RowSymComplexSparse to ArrayRowSparse. | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, RowComplexSparse, Allocator0 > &A, Matrix< T1, Prop1, ArrayRowSparse, Allocator1 > &B) |
Conversion from RowComplexSparse to ArrayRowSparse. | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, RowSymComplexSparse, Allocator0 > &A, Matrix< T1, Prop1, ArrayRowSymSparse, Allocator1 > &B) |
Conversion from RowSymComplexSparse to ArrayRowSymSparse. | |
template<class T0 , class Prop0 , class Allocator0 > | |
void | CopyMatrix (const Matrix< T0, Prop0, RowSymComplexSparse, Allocator0 > &A, Matrix< T0, Prop0, RowSymComplexSparse, Allocator0 > &B) |
template<class T0 , class Prop0 , class Allocator0 > | |
void | CopyMatrix (const Matrix< T0, Prop0, ColSymComplexSparse, Allocator0 > &A, Matrix< T0, Prop0, ColSymComplexSparse, Allocator0 > &B) |
template<class T0 , class Prop0 , class Allocator0 > | |
void | CopyMatrix (const Matrix< T0, Prop0, RowComplexSparse, Allocator0 > &A, Matrix< T0, Prop0, RowComplexSparse, Allocator0 > &B) |
template<class T0 , class Prop0 , class Allocator0 > | |
void | CopyMatrix (const Matrix< T0, Prop0, ColComplexSparse, Allocator0 > &A, Matrix< T0, Prop0, ColComplexSparse, Allocator0 > &B) |
template<class T0 , class Prop0 , class Allocator0 > | |
void | CopyMatrix (const Matrix< T0, Prop0, ArrayRowSymComplexSparse, Allocator0 > &A, Matrix< T0, Prop0, ArrayRowSymComplexSparse, Allocator0 > &B) |
template<class T0 , class Prop0 , class Allocator0 > | |
void | CopyMatrix (const Matrix< T0, Prop0, ArrayColSymComplexSparse, Allocator0 > &A, Matrix< T0, Prop0, ArrayColSymComplexSparse, Allocator0 > &B) |
template<class T0 , class Prop0 , class Allocator0 > | |
void | CopyMatrix (const Matrix< T0, Prop0, ArrayRowComplexSparse, Allocator0 > &A, Matrix< T0, Prop0, ArrayRowComplexSparse, Allocator0 > &B) |
template<class T0 , class Prop0 , class Allocator0 > | |
void | CopyMatrix (const Matrix< T0, Prop0, ArrayColComplexSparse, Allocator0 > &A, Matrix< T0, Prop0, ArrayColComplexSparse, Allocator0 > &B) |
template<class T0 , class T1 , class Prop1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 , class T4 , class Storage4 , class Allocator4 > | |
void | MltAddVector (const T0 &alpha, const DistributedMatrix< T1, Prop1, Storage1, Allocator1 > &M, const Vector< T2, Storage2, Allocator2 > &X, const T3 &beta, Vector< T4, Storage4, Allocator4 > &Yres, bool assemble) |
matrix vector product with a distributed matrix | |
template<class T0 , class T1 , class Prop1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 , class T4 , class Storage4 , class Allocator4 > | |
void | MltAddVector (const T0 &alpha, const SeldonTranspose &Trans, const DistributedMatrix< T1, Prop1, Storage1, Allocator1 > &M, const Vector< T2, Storage2, Allocator2 > &X, const T3 &beta, Vector< T4, Storage4, Allocator4 > &Yres, bool assemble) |
matrix vector product with a distributed matrix | |
template<class T1 , class Prop1 , class Allocator1 > | |
void | MltMin (const Matrix< T1, Prop1, ArrayRowSparse, Allocator1 > &A, const IVect &global, IVect &Y, IVect &Yproc) |
matrix-vector product selecting the minimal processor number and column number for each row | |
template<class T1 , class Prop1 , class Allocator1 > | |
void | MltMin (const Matrix< T1, Prop1, ArrayRowSymSparse, Allocator1 > &A, const IVect &global, IVect &Y, IVect &Yproc) |
matrix-vector product selecting the minimal processor number and column number for each row | |
template<class T1 , class Prop1 , class Storage1 , class Allocator1 > | |
void | MltMin (const DistributedMatrix< T1, Prop1, Storage1, Allocator1 > &M, IVect &Y, IVect &Yproc) |
matrix vector product with a distributed matrix (minimal column numbers) | |
template<class T0 , class T1 , class Prop1 , class Storage1 , class Allocator1 , class T2 , class Prop2 , class Storage2 , class Allocator2 > | |
void | AddMatrix (const T0 &alpha, const DistributedMatrix< T1, Prop1, Storage1, Allocator1 > &A, DistributedMatrix< T2, Prop2, Storage2, Allocator2 > &B) |
Adds two distributed matrices (B = B + alpha A) | |
template<class T1 , class Prop1 , class Storage1 , class Allocator1 > | |
ClassComplexType< T1 >::Treal | MaxAbs (const DistributedMatrix< T1, Prop1, Storage1, Allocator1 > &A) |
returns the maximal element (in absolute value) of the matrix More... | |
template<class T0 , class T , class Prop , class Storage , class Allocator > | |
void | GetRowSum (Vector< T0 > &vec_sum, const DistributedMatrix< T, Prop, Storage, Allocator > &A) |
For each row of the matrix, computation of the sum of absolute values. More... | |
template<class T0 , class T , class Prop , class Storage , class Allocator > | |
void | GetColSum (Vector< T0 > &vec_sum, const DistributedMatrix< T, Prop, Storage, Allocator > &A) |
For each column of the matrix, computation of the sum of absolute values. More... | |
template<class T0 , class T , class Prop , class Storage , class Allocator > | |
void | GetRowColSum (Vector< T0 > &sum_row, Vector< T0 > &sum_col, const DistributedMatrix< T, Prop, Storage, Allocator > &A) |
gets sum of absolute value for each row and each colum More... | |
template<class T1 , class Prop1 , class Storage1 , class Allocator1 > | |
ClassComplexType< T1 >::Treal | Norm1 (const DistributedMatrix< T1, Prop1, Storage1, Allocator1 > &A) |
returns the 1-norm of A More... | |
template<class T1 , class Prop1 , class Storage1 , class Allocator1 > | |
ClassComplexType< T1 >::Treal | NormInf (const DistributedMatrix< T1, Prop1, Storage1, Allocator1 > &A) |
returns the infinity norm of A More... | |
template<class T1 , class Prop1 , class Storage1 , class Allocator1 > | |
void | Transpose (DistributedMatrix< T1, Prop1, Storage1, Allocator1 > &A) |
replaces A by its transpose | |
template<class T1 , class Prop1 , class Storage1 , class Allocator1 > | |
void | Conjugate (DistributedMatrix< T1, Prop1, Storage1, Allocator1 > &A) |
replaces A by its conjugate | |
template<class T1 , class Prop1 , class Storage1 , class Allocator1 > | |
void | Transpose (const DistributedMatrix< T1, Prop1, Storage1, Allocator1 > &A, DistributedMatrix< T1, Prop1, Storage1, Allocator1 > &B) |
computes B = transpose(A) | |
template<class T , class Prop , class Storage , class Allocator > | |
void | TransposeConj (const DistributedMatrix< T, Prop, Storage, Allocator > &A, DistributedMatrix< T, Prop, Storage, Allocator > &B) |
Matrix transposition and conjugation. | |
template<class T , class Prop , class Storage , class Allocator > | |
void | TransposeConj (DistributedMatrix< T, Prop, Storage, Allocator > &A) |
Matrix transposition and conjugation. | |
template<class T1 , class Prop1 , class Storage1 , class Allocator1 , class T2 , class Prop2 , class Storage2 , class Allocator2 , class T4 , class Prop4 , class Storage4 , class Allocator4 > | |
void | MltMatrix (const DistributedMatrix< T1, Prop1, Storage1, Allocator1 > &A, const DistributedMatrix< T2, Prop2, Storage2, Allocator2 > &B, DistributedMatrix< T4, Prop4, Storage4, Allocator4 > &C) |
computes C = A B | |
template<class T0 , class T1 , class Prop1 , class Storage1 , class Allocator1 , class T2 , class Prop2 , class Storage2 , class Allocator2 , class T3 , class T4 , class Prop4 , class Storage4 , class Allocator4 > | |
void | MltAddMatrix (const T0 &alpha, const DistributedMatrix< T1, Prop1, Storage1, Allocator1 > &A, const DistributedMatrix< T2, Prop2, Storage2, Allocator2 > &B, const T3 &beta, DistributedMatrix< T4, Prop4, Storage4, Allocator4 > &C) |
computes C = beta C + alpha A B | |
template<class T0 , class T1 , class Prop1 , class Storage1 , class Allocator1 , class T2 , class Prop2 , class Storage2 , class Allocator2 , class T3 , class T4 , class Prop4 , class Storage4 , class Allocator4 > | |
void | MltAddMatrix (const T0 &alpha, const SeldonTranspose &transA, const DistributedMatrix< T1, Prop1, Storage1, Allocator1 > &A, const SeldonTranspose &transB, const DistributedMatrix< T2, Prop2, Storage2, Allocator2 > &B, const T3 &beta, DistributedMatrix< T4, Prop4, Storage4, Allocator4 > &C) |
computes C = beta C + alpha A B (with transposes) | |
template<class T0 , class Prop0 , class Storage0 , class Allocator0 , class T1 , class Allocator1 > | |
void | GetRow (const DistributedMatrix< T0, Prop0, Storage0, Allocator0 > &A, int i, Vector< T1, VectSparse, Allocator1 > &X) |
X = M(i, :) | |
template<class T0 , class Prop0 , class Storage0 , class Allocator0 , class T1 , class Allocator1 > | |
void | GetCol (const DistributedMatrix< T0, Prop0, Storage0, Allocator0 > &A, int i, Vector< T1, VectSparse, Allocator1 > &X) |
X = M(:, i) | |
template<class T0 , class Prop0 , class Storage0 , class Allocator0 , class T1 , class Allocator1 > | |
void | SetRow (const Vector< T1, VectSparse, Allocator1 > &X, int i, DistributedMatrix< T0, Prop0, Storage0, Allocator0 > &A) |
M(i, :) = X. | |
template<class T0 , class Prop0 , class Storage0 , class Allocator0 , class T1 , class Allocator1 > | |
void | SetCol (const Vector< T1, VectSparse, Allocator1 > &X, int i, DistributedMatrix< T0, Prop0, Storage0, Allocator0 > &A) |
M(:, i) = X. | |
template<class T , class Prop , class Storage , class Allocator > | |
void | ApplyPermutation (DistributedMatrix< T, Prop, Storage, Allocator > &A, const Vector< int > &row_perm, const Vector< int > &col_perm) |
applies permutation on rows and columns of A | |
template<class T , class Prop , class Storage , class Allocator > | |
void | ApplyInversePermutation (DistributedMatrix< T, Prop, Storage, Allocator > &A, const Vector< int > &row_perm, const Vector< int > &col_perm) |
applies permutation on rows and columns of A | |
template<class T0 , class Prop0 , class Storage0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 > | |
void | SorVector (const DistributedMatrix< T0, Prop0, Storage0, Allocator0 > &A, Vector< T2, Storage2, Allocator2 > &X, const Vector< T1, Storage1, Allocator1 > &B, const T3 &omega, int iter, int type_ssor) |
applies successive over-relaxation steps to solve A X = B | |
template<class T0 , class Prop0 , class Storage0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 > | |
void | SorVector (const SeldonTranspose &transM, const DistributedMatrix< T0, Prop0, Storage0, Allocator0 > &A, Vector< T2, Storage2, Allocator2 > &X, const Vector< T1, Storage1, Allocator1 > &B, const T3 &omega, int iter, int type_ssor) |
applies successive over-relaxation steps to solve A^T X = B | |
template<class T1 , class Prop , class Storage , class Allocator , class T2 , class Allocator2 , class Allocator3 > | |
void | GetCol (const DistributedMatrix< T1, Prop, Storage, Allocator > &A, const IVect &col_number, Vector< Vector< T2, VectSparse, Allocator2 >, VectSparse, Allocator3 > &V) |
extracts a set of sparse columns from matrix A | |
template<class T , class Prop1 , class Storage1 , class Allocator1 , class Prop2 , class Storage2 , class Allocator2 > | |
void | Copy (const DistributedMatrix< T, Prop1, Storage1, Allocator1 > &A, DistributedMatrix< T, Prop2, Storage2, Allocator2 > &B) |
converts a distributed matrix to another one | |
template<class T , class Prop1 , class Storage1 , class Allocator1 , class Prop2 , class Storage2 , class Allocator2 > | |
void | Copy (const DistributedMatrix< T, Prop1, Storage1, Allocator1 > &A, DistributedMatrix< complex< T >, Prop2, Storage2, Allocator2 > &B) |
converts a distributed matrix to another one | |
template<class T1 , class Prop1 , class Storage1 , class Allocator1 , class T2 , class Prop2 , class Storage2 , class Allocator2 > | |
void | CopyReal (const DistributedMatrix< T1, Prop1, Storage1, Allocator1 > &A, DistributedMatrix< T2, Prop2, Storage2, Allocator2 > &B) |
extracts real part of a matrix | |
template<class T , class Prop , class Storage , class Allocator > | |
ClassComplexType< T >::Treal | NormFro (const DistributedMatrix< T, Prop, Storage, Allocator > &A) |
returns Froebenius norm of matrix A | |
template<class T , class Storage , class Allocator , class T1 , class Allocator1 > | |
void | ScaleLeftMatrix (DistributedMatrix< T, General, Storage, Allocator > &A, const Vector< T1, VectFull, Allocator1 > &Drow) |
multiplies rows by coefficients | |
template<class T , class Storage , class Allocator , class T1 , class Allocator1 > | |
void | ScaleRightMatrix (DistributedMatrix< T, General, Storage, Allocator > &A, const Vector< T1, VectFull, Allocator1 > &Dcol) |
multiplies columns by coefficients | |
template<class T , class Prop , class Storage , class Allocator , class T1 , class Allocator1 , class T2 , class Allocator2 > | |
void | ScaleMatrix (DistributedMatrix< T, Prop, Storage, Allocator > &A, const Vector< T1, VectFull, Allocator1 > &Drow, const Vector< T2, VectFull, Allocator2 > &Dcol) |
multiplies rows and columns by coefficients | |
template<class Prop , class Storage , class Alloc , class Tint0 , class Tint1 , class T > | |
void | AssembleDistributed (DistributedMatrix< T, Prop, Storage, Alloc > &A, Symmetric &sym, const MPI_Comm &comm, IVect &row_numbers, IVect &local_row_numbers, Vector< Tint0 > &PtrA, Vector< Tint1 > &IndA, Vector< T > &ValA, bool sym_pattern, bool reorder) |
assembling a distributed matrix, global rows are given in CSR form More... | |
template<class Prop , class Storage , class Alloc , class Tint0 , class Tint1 , class T > | |
void | AssembleDistributed (DistributedMatrix< T, Prop, Storage, Alloc > &A, General &prop, const MPI_Comm &comm, IVect &col_numbers, IVect &local_col_numbers, Vector< Tint0 > &PtrA, Vector< Tint1 > &IndA, Vector< T > &ValA, bool sym_pattern, bool reorder) |
assembling a distributed matrix, global columns are given in CSC form More... | |
template<class T1 , class Prop1 , class Storage1 , class Allocator1 > | |
void | EraseCol (const IVect &num, DistributedMatrix< T1, Prop1, Storage1, Allocator1 > &A) |
clears several columns of a sparse matrix More... | |
template<class T1 , class Prop1 , class Storage1 , class Allocator1 > | |
void | EraseRow (const IVect &num, DistributedMatrix< T1, Prop1, Storage1, Allocator1 > &A) |
clears several rows of a sparse matrix More... | |
template<class T0 , class Prop0 , class Storage0 , class Allocator0 , class T1 , class Prop1 , class Storage1 , class Allocator1 > | |
void | CopySubMatrix (const DistributedMatrix< T0, Prop0, Storage0, Allocator0 > &A, const IVect &row, const IVect &col, DistributedMatrix< T1, Prop1, Storage1, Allocator1 > &B) |
extracts a sub-matrix B from matrix A | |
template<class T0 , class Prop0 , class Storage0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 > | |
void | MltVector (const DistributedMatrix< T0, Prop0, Storage0, Allocator0 > &M, const Vector< T1, Storage1, Allocator1 > &X, Vector< T2, Storage2, Allocator2 > &Y, bool assemble) |
Performs the multiplication of a matrix with a vector. | |
template<class T1 , class Prop1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 , class Storage3 , class Allocator3 > | |
void | MltVector (const T3 &alpha, const DistributedMatrix< T1, Prop1, Storage1, Allocator1 > &M, const Vector< T2, Storage2, Allocator2 > &X, Vector< T3, Storage3, Allocator3 > &Y, bool assemble) |
Performs the multiplication of a matrix with a vector. | |
template<class T1 , class Prop1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 , class Storage3 , class Allocator3 > | |
void | MltVector (const SeldonTranspose &Trans, const DistributedMatrix< T1, Prop1, Storage1, Allocator1 > &M, const Vector< T2, Storage2, Allocator2 > &X, Vector< T3, Storage3, Allocator3 > &Y, bool assemble) |
Performs the multiplication of a matrix with a vector. | |
template<class T0 , class T1 , class Prop1 , class Storage1 , class Allocator1 > | |
void | MltScalar (const T0 &alpha, DistributedMatrix< T1, Prop1, Storage1, Allocator1 > &A) |
multiplication by a scalar | |
template<class T , class Prop1 , class Storage1 , class Allocator1 , class Prop2 , class Storage2 , class Allocator2 > | |
void | Copy (const DistributedMatrix< complex< T >, Prop1, Storage1, Allocator1 > &A, DistributedMatrix< T, Prop2, Storage2, Allocator2 > &B) |
converts a distributed matrix to another one | |
template<class TypeDist > | |
void | EraseDistantEntries (MPI_Comm &comm, const Vector< bool > &IsRowDropped, const Vector< bool > &IsRowDroppedDistant, TypeDist &dist_row, Vector< IVect > &proc_row, TypeDist &dist_col, Vector< IVect > &proc_col) |
template<class T , class Prop , class Storage , class Allocator > | |
void | Mlt (const T &alpha, DistributedMatrix< T, Prop, Storage, Allocator > &A) |
template<class T , class Prop , class Storage , class Allocator > | |
void | Mlt (const T &alpha, DistributedMatrix< complex< T >, Prop, Storage, Allocator > &A) |
template<class T , class Prop1 , class Storage1 , class Allocator1 , class Prop2 , class Storage2 , class Allocator2 > | |
void | Add (const T &alpha, const DistributedMatrix< T, Prop1, Storage1, Allocator1 > &A, DistributedMatrix< T, Prop2, Storage2, Allocator2 > &B) |
template<class T , class Prop1 , class Storage1 , class Allocator1 , class Prop2 , class Storage2 , class Allocator2 > | |
void | Add (const complex< T > &alpha, const DistributedMatrix< T, Prop1, Storage1, Allocator1 > &A, DistributedMatrix< complex< T >, Prop2, Storage2, Allocator2 > &B) |
template<class T , class Prop1 , class Storage1 , class Allocator1 , class Prop2 , class Storage2 , class Allocator2 > | |
void | Add (const T &alpha, const DistributedMatrix< complex< T >, Prop1, Storage1, Allocator1 > &A, DistributedMatrix< complex< T >, Prop2, Storage2, Allocator2 > &B) |
template<class T , class Prop1 , class Storage1 , class Allocator1 , class Prop2 , class Storage2 , class Allocator2 > | |
void | Add (const T &alpha, const DistributedMatrix< complex< T >, Prop1, Storage1, Allocator1 > &A, DistributedMatrix< T, Prop2, Storage2, Allocator2 > &B) |
template<class T0 , class Prop0 , class Storage0 , class Allocator0 > | |
void | Mlt (const DistributedMatrix< T0, Prop0, Storage0, Allocator0 > &, const Vector< T0 > &X, Vector< T0 > &Y, bool assemble=true) |
template<class T0 , class Prop0 , class Storage0 , class Allocator0 > | |
void | Mlt (const DistributedMatrix< T0, Prop0, Storage0, Allocator0 > &, const Vector< complex< T0 > > &X, Vector< complex< T0 > > &Y, bool assemble=true) |
template<class T0 , class Prop0 , class Storage0 , class Allocator0 > | |
void | Mlt (const DistributedMatrix< complex< T0 >, Prop0, Storage0, Allocator0 > &, const Vector< T0 > &X, Vector< T0 > &Y, bool assemble=true) |
template<class T0 , class Prop0 , class Storage0 , class Allocator0 > | |
void | Mlt (const SeldonTranspose &trans, const DistributedMatrix< T0, Prop0, Storage0, Allocator0 > &A, const Vector< T0 > &X, Vector< T0 > &Y, bool assemble=true) |
template<class T0 , class Prop0 , class Storage0 , class Allocator0 > | |
void | Mlt (const SeldonTranspose &trans, const DistributedMatrix< T0, Prop0, Storage0, Allocator0 > &A, const Vector< complex< T0 > > &X, Vector< complex< T0 > > &Y, bool assemble=true) |
template<class T0 , class Prop0 , class Storage0 , class Allocator0 > | |
void | Mlt (const SeldonTranspose &trans, const DistributedMatrix< complex< T0 >, Prop0, Storage0, Allocator0 > &A, const Vector< T0 > &X, Vector< T0 > &Y, bool assemble=true) |
template<class T0 , class Prop0 , class Storage0 , class Allocator0 > | |
void | MltAdd (const T0 &alpha, const DistributedMatrix< T0, Prop0, Storage0, Allocator0 > &A, const Vector< T0 > &X, const T0 &beta, Vector< T0 > &Y, bool assemble=true) |
template<class T0 , class Prop0 , class Storage0 , class Allocator0 > | |
void | MltAdd (const complex< T0 > &alpha, const DistributedMatrix< T0, Prop0, Storage0, Allocator0 > &A, const Vector< complex< T0 > > &X, const complex< T0 > &beta, Vector< complex< T0 > > &Y, bool assemble=true) |
template<class T0 , class Prop0 , class Storage0 , class Allocator0 > | |
void | MltAdd (const T0 &alpha, const DistributedMatrix< complex< T0 >, Prop0, Storage0, Allocator0 > &A, const Vector< T0 > &X, const T0 &beta, Vector< T0 > &Y, bool assemble=true) |
template<class T0 , class Prop0 , class Storage0 , class Allocator0 > | |
void | MltAdd (const T0 &alpha, const SeldonTranspose &trans, const DistributedMatrix< T0, Prop0, Storage0, Allocator0 > &A, const Vector< T0 > &X, const T0 &beta, Vector< T0 > &Y, bool assemble=true) |
template<class T0 , class Prop0 , class Storage0 , class Allocator0 > | |
void | MltAdd (const complex< T0 > &alpha, const SeldonTranspose &trans, const DistributedMatrix< T0, Prop0, Storage0, Allocator0 > &A, const Vector< complex< T0 > > &X, const complex< T0 > &beta, Vector< complex< T0 > > &Y, bool assemble=true) |
template<class T0 , class Prop0 , class Storage0 , class Allocator0 > | |
void | MltAdd (const T0 &alpha, const SeldonTranspose &trans, const DistributedMatrix< complex< T0 >, Prop0, Storage0, Allocator0 > &A, const Vector< T0 > &X, const T0 &beta, Vector< T0 > &Y, bool assemble=true) |
template<class T , class Prop0 , class Storage0 , class Allocator0 , class Storage1 , class Allocator1 , class Storage2 , class Allocator2 > | |
void | SOR (const DistributedMatrix< T, Prop0, Storage0, Allocator0 > &M, Vector< T, Storage2, Allocator2 > &Y, const Vector< T, Storage1, Allocator1 > &X, const T &omega, int iter, int type_ssor=2) |
template<class T , class Prop0 , class Storage0 , class Allocator0 , class Storage1 , class Allocator1 , class Storage2 , class Allocator2 > | |
void | SOR (const SeldonTranspose &, const DistributedMatrix< T, Prop0, Storage0, Allocator0 > &M, Vector< T, Storage2, Allocator2 > &Y, const Vector< T, Storage1, Allocator1 > &X, const T &omega, int iter, int type_ssor=3) |
template<class T , class Prop0 , class Storage0 , class Allocator0 , class Storage1 , class Allocator1 , class Storage2 , class Allocator2 > | |
void | SOR (const DistributedMatrix< T, Prop0, Storage0, Allocator0 > &M, Vector< complex< T >, Storage2, Allocator2 > &Y, const Vector< complex< T >, Storage1, Allocator1 > &X, const T &omega, int iter, int type_ssor=2) |
template<class T , class Prop0 , class Storage0 , class Allocator0 , class Storage1 , class Allocator1 , class Storage2 , class Allocator2 > | |
void | SOR (const SeldonTranspose &, const DistributedMatrix< T, Prop0, Storage0, Allocator0 > &M, Vector< complex< T >, Storage2, Allocator2 > &Y, const Vector< complex< T >, Storage1, Allocator1 > &X, const T &omega, int iter, int type_ssor=3) |
template<class T , class Prop0 , class Storage0 , class Allocator0 , class Storage1 , class Allocator1 , class Storage2 , class Allocator2 > | |
void | SOR (const DistributedMatrix< complex< T >, Prop0, Storage0, Allocator0 > &M, Vector< T, Storage2, Allocator2 > &Y, const Vector< T, Storage1, Allocator1 > &X, const T &omega, int iter, int type_ssor=2) |
template<class T , class Prop0 , class Storage0 , class Allocator0 , class Storage1 , class Allocator1 , class Storage2 , class Allocator2 > | |
void | SOR (const SeldonTranspose &, const DistributedMatrix< complex< T >, Prop0, Storage0, Allocator0 > &M, Vector< T, Storage2, Allocator2 > &Y, const Vector< T, Storage1, Allocator1 > &X, const T &omega, int iter, int type_ssor=3) |
template<class T , class Prop > | |
void | DistributeCentralizedMatrix (Matrix< T, Prop, RowSparse > &A, const MPI_Comm &comm, int root_proc, const Vector< int > &num_proc, DistributedMatrixIntegerArray &Binfo, DistributedMatrix< T, Prop, RowSparse > &B, bool keep_matrix) |
template<class T , class Prop > | |
void | DistributeCentralizedMatrix (Matrix< T, Prop, RowSymSparse > &A, const MPI_Comm &comm, int root_proc, const Vector< int > &num_proc, DistributedMatrixIntegerArray &Binfo, DistributedMatrix< T, Prop, RowSymSparse > &B, bool keep_matrix) |
template<class T , class Prop > | |
void | DistributeCentralizedMatrix (Matrix< T, Prop, ArrayRowSparse > &A, const MPI_Comm &comm, int root_proc, const Vector< int > &num_proc, DistributedMatrixIntegerArray &Binfo, DistributedMatrix< T, Prop, ArrayRowSparse > &B, bool keep_matrix) |
template<class T , class Prop > | |
void | DistributeCentralizedMatrix (Matrix< T, Prop, ArrayRowSymSparse > &A, const MPI_Comm &comm, int root_proc, const Vector< int > &num_proc, DistributedMatrixIntegerArray &Binfo, DistributedMatrix< T, Prop, ArrayRowSymSparse > &B, bool keep_matrix) |
template<class T0 , class Allocator0 , class T1 , class Allocator1 > | |
void | GetRow (const Matrix< T0, General, ArrayRowSparse, Allocator0 > &A, int i, Vector< T1, VectSparse, Allocator1 > &X) |
Extracts a row from a sparse matrix. More... | |
template<class T0 , class Allocator0 , class T1 , class Allocator1 > | |
void | GetRow (const Matrix< T0, General, ArrayColSparse, Allocator0 > &M, int i, Vector< T1, VectSparse, Allocator1 > &X) |
Extracts a row from a sparse matrix. More... | |
template<class T0 , class Allocator0 , class T1 , class Allocator1 > | |
void | GetRow (const Matrix< T0, Symmetric, ArrayRowSymSparse, Allocator0 > &M, int i, Vector< T1, VectSparse, Allocator1 > &X) |
Extracts a row from a sparse matrix. More... | |
template<class T0 , class Allocator0 , class T1 , class Allocator1 > | |
void | GetRow (const Matrix< T0, Symmetric, ArrayColSymSparse, Allocator0 > &M, int i, Vector< T1, VectSparse, Allocator1 > &X) |
Extracts a row from a sparse matrix. More... | |
template<class T0 , class Allocator0 , class T1 , class Allocator1 > | |
void | SetRow (const Vector< T1, VectSparse, Allocator1 > &X, int i, Matrix< T0, General, ArrayRowSparse, Allocator0 > &M) |
Sets a row of a matrix. More... | |
template<class T0 , class Allocator0 , class T1 , class Allocator1 > | |
void | SetRow (const Vector< T1, VectSparse, Allocator1 > &X, int i, Matrix< T0, General, ArrayColSparse, Allocator0 > &M) |
Sets a row of a matrix. More... | |
template<class T0 , class Allocator0 , class T1 , class Allocator1 > | |
void | SetRow (const Vector< T1, VectSparse, Allocator1 > &X, int i, Matrix< T0, Symmetric, ArrayRowSymSparse, Allocator0 > &M) |
Sets a row of a matrix. More... | |
template<class T0 , class Allocator0 , class T1 , class Allocator1 > | |
void | SetRow (const Vector< T1, VectSparse, Allocator1 > &X, int i, Matrix< T0, Symmetric, ArrayColSymSparse, Allocator0 > &M) |
Sets a row of a matrix. More... | |
template<class T0 , class Allocator0 , class T1 , class Allocator1 > | |
void | GetCol (const Matrix< T0, General, ArrayRowSparse, Allocator0 > &M, int j, Vector< T1, VectSparse, Allocator1 > &X) |
Extracts a column from a matrix. More... | |
template<class T0 , class Allocator0 , class T1 , class Allocator1 > | |
void | GetCol (const Matrix< T0, General, ArrayColSparse, Allocator0 > &A, int j, Vector< T1, VectSparse, Allocator1 > &X) |
Extracts a column from a matrix. More... | |
template<class T0 , class Allocator0 , class T1 , class Allocator1 > | |
void | GetCol (const Matrix< T0, Symmetric, ArrayRowSymSparse, Allocator0 > &M, int j, Vector< T1, VectSparse, Allocator1 > &X) |
Extracts a column from a sparse matrix. More... | |
template<class T0 , class Allocator0 , class T1 , class Allocator1 > | |
void | GetCol (const Matrix< T0, Symmetric, ArrayColSymSparse, Allocator0 > &M, int j, Vector< T1, VectSparse, Allocator1 > &X) |
Extracts a column from a sparse matrix. More... | |
template<class T0 , class Allocator0 , class T1 , class Allocator1 > | |
void | SetCol (const Vector< T1, VectSparse, Allocator1 > &X, int j, Matrix< T0, General, ArrayRowSparse, Allocator0 > &M) |
Sets a column of a matrix. More... | |
template<class T0 , class Allocator0 , class T1 , class Allocator1 > | |
void | SetCol (const Vector< T1, VectSparse, Allocator1 > &X, int j, Matrix< T0, General, ArrayColSparse, Allocator0 > &M) |
Sets a column of a matrix. More... | |
template<class T0 , class Allocator0 , class T1 , class Allocator1 > | |
void | SetCol (const Vector< T1, VectSparse, Allocator1 > &X, int j, Matrix< T0, Symmetric, ArrayRowSymSparse, Allocator0 > &M) |
Sets a column of a matrix. More... | |
template<class T0 , class Allocator0 , class T1 , class Allocator1 > | |
void | SetCol (const Vector< T1, VectSparse, Allocator1 > &X, int j, Matrix< T0, Symmetric, ArrayColSymSparse, Allocator0 > &M) |
Sets a column of a matrix. More... | |
template<class T1 , class T2 , class T3 , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | MltVector (const Matrix< T1, Symmetric, ArrayRowSymSparse, Allocator1 > &A, const Vector< T2, VectFull, Allocator2 > &B, Vector< T3, VectFull, Allocator3 > &C) |
template<class T1 , class T2 , class T3 , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | MltVector (const SeldonTranspose &Trans, const Matrix< T1, Symmetric, ArrayRowSymSparse, Allocator1 > &A, const Vector< T2, VectFull, Allocator2 > &B, Vector< T3, VectFull, Allocator3 > &C) |
template<class T1 , class T2 , class T3 , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | MltVector (const Matrix< T1, Symmetric, ArrayColSymSparse, Allocator1 > &A, const Vector< T2, VectFull, Allocator2 > &B, Vector< T3, VectFull, Allocator3 > &C) |
template<class T1 , class T2 , class T3 , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | MltVector (const SeldonTranspose &Trans, const Matrix< T1, Symmetric, ArrayColSymSparse, Allocator1 > &A, const Vector< T2, VectFull, Allocator2 > &B, Vector< T3, VectFull, Allocator3 > &C) |
template<class T1 , class T2 , class T3 , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | MltVector (const Matrix< T1, General, ArrayRowSparse, Allocator1 > &A, const Vector< T2, VectFull, Allocator2 > &B, Vector< T3, VectFull, Allocator3 > &C) |
template<class T1 , class T2 , class T3 , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | MltVector (const SeldonTranspose &Trans, const Matrix< T1, General, ArrayRowSparse, Allocator1 > &A, const Vector< T2, VectFull, Allocator2 > &B, Vector< T3, VectFull, Allocator3 > &C) |
template<class T1 , class T2 , class T3 , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | MltVector (const Matrix< T1, General, ArrayColSparse, Allocator1 > &A, const Vector< T2, VectFull, Allocator2 > &B, Vector< T3, VectFull, Allocator3 > &C) |
template<class T1 , class T2 , class T3 , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | MltVector (const SeldonTranspose &Trans, const Matrix< T1, General, ArrayColSparse, Allocator1 > &A, const Vector< T2, VectFull, Allocator2 > &B, Vector< T3, VectFull, Allocator3 > &C) |
template<class T0 , class T1 , class T2 , class T3 , class T4 , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | MltAddVector (const T0 &alpha, const Matrix< T1, Symmetric, ArrayRowSymSparse, Allocator1 > &A, const Vector< T2, VectFull, Allocator2 > &B, const T4 &beta, Vector< T3, VectFull, Allocator3 > &C) |
template<class T0 , class T1 , class T2 , class T3 , class T4 , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | MltAddVector (const T0 &alpha, const SeldonTranspose &Trans, const Matrix< T1, Symmetric, ArrayRowSymSparse, Allocator1 > &A, const Vector< T2, VectFull, Allocator2 > &B, const T4 &beta, Vector< T3, VectFull, Allocator3 > &C) |
template<class T0 , class T1 , class T2 , class T3 , class T4 , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | MltAddVector (const T0 &alpha, const Matrix< T1, Symmetric, ArrayColSymSparse, Allocator1 > &A, const Vector< T2, VectFull, Allocator2 > &B, const T4 &beta, Vector< T3, VectFull, Allocator3 > &C) |
template<class T0 , class T1 , class T2 , class T3 , class T4 , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | MltAddVector (const T0 &alpha, const SeldonTranspose &Trans, const Matrix< T1, Symmetric, ArrayColSymSparse, Allocator1 > &A, const Vector< T2, VectFull, Allocator2 > &B, const T4 &beta, Vector< T3, VectFull, Allocator3 > &C) |
template<class T0 , class T1 , class T2 , class T3 , class T4 , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | MltAddVector (const T0 &alpha, const Matrix< T1, General, ArrayRowSparse, Allocator1 > &A, const Vector< T2, VectFull, Allocator2 > &B, const T4 &beta, Vector< T3, VectFull, Allocator3 > &C) |
template<class T0 , class T1 , class T2 , class T3 , class T4 , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | MltAddVector (const T0 &alpha, const SeldonTranspose &Trans, const Matrix< T1, General, ArrayRowSparse, Allocator1 > &A, const Vector< T2, VectFull, Allocator2 > &B, const T4 &beta, Vector< T3, VectFull, Allocator3 > &C) |
template<class T0 , class T1 , class T2 , class T3 , class T4 , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | MltAddVector (const T0 &alpha, const Matrix< T1, General, ArrayColSparse, Allocator1 > &A, const Vector< T2, VectFull, Allocator2 > &B, const T4 &beta, Vector< T3, VectFull, Allocator3 > &C) |
template<class T0 , class T1 , class T2 , class T3 , class T4 , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | MltAddVector (const T0 &alpha, const SeldonTranspose &Trans, const Matrix< T1, General, ArrayColSparse, Allocator1 > &A, const Vector< T2, VectFull, Allocator2 > &B, const T4 &beta, Vector< T3, VectFull, Allocator3 > &C) |
template<class T0 , class T1 , class T2 , class Allocator1 , class Allocator2 > | |
void | AddMatrix (const T0 &alpha, const Matrix< T1, General, ArrayRowSparse, Allocator1 > &A, Matrix< T2, General, ArrayRowSparse, Allocator2 > &B) |
template<class T0 , class T1 , class T2 , class Allocator1 , class Allocator2 > | |
void | AddMatrix (const T0 &alpha, const Matrix< T1, General, ArrayColSparse, Allocator1 > &A, Matrix< T2, General, ArrayColSparse, Allocator2 > &B) |
template<class T0 , class T1 , class T2 , class Allocator1 , class Allocator2 > | |
void | AddMatrix (const T0 &alpha, const Matrix< T1, Symmetric, ArrayRowSymSparse, Allocator1 > &A, Matrix< T2, Symmetric, ArrayRowSymSparse, Allocator2 > &B) |
template<class T0 , class T1 , class T2 , class Allocator1 , class Allocator2 > | |
void | AddMatrix (const T0 &alpha, const Matrix< T1, Symmetric, ArrayColSymSparse, Allocator1 > &A, Matrix< T2, Symmetric, ArrayColSymSparse, Allocator2 > &B) |
template<class T0 , class T1 , class T2 , class T3 , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | AddMatrix (const T0 &alpha, const Matrix< T1, General, ArrayRowSparse, Allocator1 > &A, const Matrix< T2, General, ArrayRowSparse, Allocator2 > &B, Matrix< complex< T3 >, General, ArrayRowSparse, Allocator3 > &C) |
template<class T0 , class T1 , class T2 , class T3 , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | AddMatrix (const T0 &alpha, const Matrix< T1, Symmetric, ArrayRowSymSparse, Allocator1 > &A, const Matrix< T2, Symmetric, ArrayRowSymSparse, Allocator2 > &B, Matrix< complex< T3 >, Symmetric, ArrayRowSymSparse, Allocator3 > &C) |
template<class T0 , class T1 , class T2 , class Allocator1 , class Allocator2 > | |
void | AddMatrix (const T0 &alpha, const Matrix< T1, Symmetric, ArrayRowSymSparse, Allocator1 > &A, Matrix< T2, General, ArrayRowSparse, Allocator2 > &B) |
template<class T0 , class T , class Allocator > | |
void | MltScalar (const T0 &alpha, Matrix< T, General, ArrayRowSparse, Allocator > &A) |
template<class T0 , class T , class Allocator > | |
void | MltScalar (const T0 &alpha, Matrix< T, General, ArrayColSparse, Allocator > &A) |
template<class T0 , class T , class Allocator > | |
void | MltScalar (const T0 &alpha, Matrix< T, Symmetric, ArrayRowSymSparse, Allocator > &A) |
template<class T0 , class T , class Allocator > | |
void | MltScalar (const T0 &alpha, Matrix< T, Symmetric, ArrayColSymSparse, Allocator > &A) |
template<class T0 , class T1 , class Prop1 , class Allocator1 , class T4 , class T2 , class Prop2 , class Storage2 , class Allocator2 , class T3 , class Prop3 , class Storage3 , class Allocator3 > | |
void | MltAddMatrix (const T0 &alpha, const Matrix< T1, Prop1, ArrayRowSparse, Allocator1 > &A, const Matrix< T2, Prop2, Storage2, Allocator2 > &B, const T4 &beta, Matrix< T3, Prop3, Storage3, Allocator3 > &C) |
template<class T0 , class T1 , class Prop1 , class Storage1 , class Allocator1 , class T4 , class T2 , class Prop2 , class Allocator2 , class T3 , class Prop3 , class Storage3 , class Allocator3 > | |
void | MltAddMatrix (const T0 &alpha, const Matrix< T1, Prop1, Storage1, Allocator1 > &A, const Matrix< T2, Prop2, ArrayRowSparse, Allocator2 > &B, const T4 &beta, Matrix< T3, Prop3, Storage3, Allocator3 > &C) |
template<class T , class Prop , class Allocator > | |
ClassComplexType< T >::Treal | MaxAbs (const Matrix< T, Prop, ArrayRowSparse, Allocator > &A) |
Returns the maximum (in absolute value) of a matrix. More... | |
template<class T , class Prop , class Allocator > | |
ClassComplexType< T >::Treal | Norm1 (const Matrix< T, Prop, ArrayRowSparse, Allocator > &A) |
Returns the 1-norm of a matrix. More... | |
template<class T , class Prop , class Allocator > | |
ClassComplexType< T >::Treal | NormInf (const Matrix< T, Prop, ArrayRowSparse, Allocator > &A) |
Returns the infinity-norm of a matrix. More... | |
template<class T , class Prop , class Allocator > | |
ClassComplexType< T >::Treal | MaxAbs (const Matrix< T, Prop, ArrayColSparse, Allocator > &A) |
Returns the maximum (in absolute value) of a matrix. More... | |
template<class T , class Prop , class Allocator > | |
ClassComplexType< T >::Treal | Norm1 (const Matrix< T, Prop, ArrayColSparse, Allocator > &A) |
Returns the 1-norm of a matrix. More... | |
template<class T , class Prop , class Allocator > | |
ClassComplexType< T >::Treal | NormInf (const Matrix< T, Prop, ArrayColSparse, Allocator > &A) |
Returns the infinity-norm of a matrix. More... | |
template<class T , class Prop , class Allocator > | |
ClassComplexType< T >::Treal | MaxAbs (const Matrix< T, Prop, ArrayRowSymSparse, Allocator > &A) |
Returns the maximum (in absolute value) of a matrix. More... | |
template<class T , class Prop , class Allocator > | |
ClassComplexType< T >::Treal | Norm1 (const Matrix< T, Prop, ArrayRowSymSparse, Allocator > &A) |
Returns the 1-norm of a matrix. More... | |
template<class T , class Prop , class Allocator > | |
ClassComplexType< T >::Treal | NormInf (const Matrix< T, Prop, ArrayRowSymSparse, Allocator > &A) |
Returns the infinity-norm of a matrix. More... | |
template<class T , class Prop , class Allocator > | |
ClassComplexType< T >::Treal | MaxAbs (const Matrix< T, Prop, ArrayColSymSparse, Allocator > &A) |
Returns the maximum (in absolute value) of a matrix. More... | |
template<class T , class Prop , class Allocator > | |
ClassComplexType< T >::Treal | Norm1 (const Matrix< T, Prop, ArrayColSymSparse, Allocator > &A) |
Returns the 1-norm of a matrix. More... | |
template<class T , class Prop , class Allocator > | |
ClassComplexType< T >::Treal | NormInf (const Matrix< T, Prop, ArrayColSymSparse, Allocator > &A) |
Returns the infinity-norm of a matrix. More... | |
template<class T , class Prop , class Allocator > | |
ClassComplexType< T >::Treal | NormFro (const Matrix< T, Prop, ArrayRowSparse, Allocator > &A) |
Returns Frobenius norm of matrix. | |
template<class T , class Prop , class Allocator > | |
ClassComplexType< T >::Treal | NormFro (const Matrix< T, Prop, ArrayRowSymSparse, Allocator > &A) |
Returns Frobenius norm of matrix. | |
template<class T , class Allocator > | |
void | Transpose (const Matrix< T, General, ArrayRowSparse, Allocator > &A, Matrix< T, General, ArrayRowSparse, Allocator > &B) |
Matrix transposition. | |
template<class T , class Allocator > | |
void | Transpose (Matrix< T, General, ArrayRowSparse, Allocator > &A) |
Matrix transposition. | |
template<class T , class Allocator > | |
void | Transpose (const Matrix< T, General, ArrayColSparse, Allocator > &A, Matrix< T, General, ArrayColSparse, Allocator > &B) |
Matrix transposition. | |
template<class T , class Allocator > | |
void | Transpose (Matrix< T, General, ArrayColSparse, Allocator > &A) |
Matrix transposition. | |
template<class T , class Allocator > | |
void | Conjugate (Matrix< T, General, ArrayRowSparse, Allocator > &A) |
Replaces A by its conjugate. | |
template<class T , class Allocator > | |
void | Conjugate (Matrix< T, General, ArrayColSparse, Allocator > &A) |
Replaces A by its conjugate. | |
template<class T , class Allocator > | |
void | Conjugate (Matrix< T, Symmetric, ArrayRowSymSparse, Allocator > &A) |
Replaces A by its conjugate. | |
template<class T , class Allocator > | |
void | Conjugate (Matrix< T, Symmetric, ArrayColSymSparse, Allocator > &A) |
Replaces A by its conjugate. | |
template<class T1 , class Prop1 , class Allocator1 , class T2 , class Prop2 , class Allocator2 , class T4 , class Prop4 , class Allocator4 > | |
void | MltMatrix (const Matrix< T1, Prop1, ArrayRowSparse, Allocator1 > &A, const Matrix< T2, Prop2, ArrayRowSparse, Allocator2 > &B, Matrix< T4, Prop4, ArrayRowSparse, Allocator4 > &C) |
template<class T0 , class T1 , class Prop1 , class Allocator1 , class T2 , class Prop2 , class Allocator2 , class T3 , class T4 , class Prop4 , class Allocator4 > | |
void | MltAddMatrix (const T0 &alpha, const Matrix< T1, Prop1, ArrayRowSparse, Allocator1 > &A, const Matrix< T2, Prop2, ArrayRowSparse, Allocator2 > &B, const T3 &beta, Matrix< T4, Prop4, ArrayRowSparse, Allocator4 > &C) |
template<class T0 , class T1 , class Prop1 , class Allocator1 , class T2 , class Prop2 , class Allocator2 , class T3 , class T4 , class Prop4 , class Allocator4 > | |
void | MltAddMatrix (const T0 &alpha, const SeldonTranspose &TransA, const Matrix< T1, Prop1, ArrayRowSparse, Allocator1 > &A, const SeldonTranspose &TransB, const Matrix< T2, Prop2, ArrayRowSparse, Allocator2 > &B, const T3 &beta, Matrix< T4, Prop4, ArrayRowSparse, Allocator4 > &C) |
template<class T , class Prop , class Storage , class Allocator , class T0 > | |
void | RemoveSmallEntry (Matrix< T, Prop, Storage, Allocator > &A, const T0 &epsilon) |
drops non-zero entries below epsilon | |
template<class T , class Prop , class Allocator , class T0 > | |
void | RemoveSmallEntry (Matrix< T, Prop, RowSparse, Allocator > &A, const T0 &epsilon) |
drops non-zero entries below epsilon | |
template<class T , class Prop , class Allocator , class T0 > | |
void | RemoveSmallEntry (Matrix< T, Prop, RowSymSparse, Allocator > &A, const T0 &epsilon) |
drops non-zero entries below epsilon | |
template<class T1 , class Prop , class Allocator > | |
void | EraseCol (const IVect &col_number, Matrix< T1, Prop, ArrayRowSymSparse, Allocator > &A) |
clears several columns of a sparse matrix More... | |
template<class T1 , class Prop , class Allocator > | |
void | EraseCol (const IVect &col_number, Matrix< T1, Prop, ArrayRowSparse, Allocator > &A) |
clears several columns of a sparse matrix More... | |
template<class T1 , class Prop , class Allocator > | |
void | EraseCol (const IVect &col_number, Matrix< T1, Prop, RowSparse, Allocator > &A) |
clears several columns of a sparse matrix More... | |
template<class T1 , class Prop , class Allocator > | |
void | EraseCol (const IVect &col_number, Matrix< T1, Prop, RowSymSparse, Allocator > &A) |
clears several columns of a sparse matrix More... | |
template<class T1 , class Prop , class Storage , class Allocator > | |
void | EraseCol (const IVect &col_number, Matrix< T1, Prop, Storage, Allocator > &A) |
clears several columns of a sparse matrix More... | |
template<class T1 , class Prop , class Storage , class Allocator > | |
void | EraseRow (const IVect &col_number, Matrix< T1, Prop, Storage, Allocator > &A) |
clears several rows of a sparse matrix More... | |
template<class T1 , class Prop , class Allocator > | |
void | EraseRow (const IVect &col_number, Matrix< T1, Prop, ArrayRowSymSparse, Allocator > &A) |
clears several rows of a sparse matrix More... | |
template<class T1 , class Prop , class Allocator > | |
void | EraseRow (const IVect &col_number, Matrix< T1, Prop, ArrayRowSparse, Allocator > &A) |
clears several rows of a sparse matrix More... | |
template<class T1 , class Prop , class Allocator > | |
void | EraseRow (const IVect &col_number, Matrix< T1, Prop, RowSparse, Allocator > &A) |
clears several rows of a sparse matrix More... | |
template<class T1 , class Prop , class Allocator > | |
void | EraseRow (const IVect &col_number, Matrix< T1, Prop, RowSymSparse, Allocator > &A) |
clears several rows of a sparse matrix More... | |
template<class T , class Complexe , class Allocator > | |
void | GetRowSum (Vector< T > &diagonal_scale_left, const Matrix< Complexe, General, ArrayRowSparse, Allocator > &mat_direct) |
For each row of the matrix, computation of the sum of absolute values. More... | |
template<class T , class Complexe , class Allocator > | |
void | GetRowSum (Vector< T > &diagonal_scale_left, const Matrix< Complexe, Symmetric, ArrayRowSymSparse, Allocator > &mat_direct) |
For each row of the matrix, computation of the sum of absolute values. More... | |
template<class T , class Complexe , class Allocator > | |
void | GetRowSum (Vector< T > &diagonal_scale_left, const Matrix< Complexe, General, RowSparse, Allocator > &mat_direct) |
For each row of the matrix, computation of the sum of absolute values. More... | |
template<class T , class Complexe , class Allocator > | |
void | GetRowSum (Vector< T > &diagonal_scale_left, const Matrix< Complexe, Symmetric, RowSymSparse, Allocator > &mat_direct) |
For each row of the matrix, computation of the sum of absolute values. More... | |
template<class T , class Complexe , class Allocator > | |
void | GetColSum (Vector< T > &diagonal_scale, const Matrix< Complexe, General, ArrayRowSparse, Allocator > &mat_direct) |
For each column of the matrix, computation of the sum of absolute values. More... | |
template<class T , class Complexe , class Allocator > | |
void | GetColSum (Vector< T > &diagonal_scale, const Matrix< Complexe, Symmetric, ArrayRowSymSparse, Allocator > &mat_direct) |
For each column of the matrix, computation of the sum of absolute values. More... | |
template<class T , class Complexe , class Allocator > | |
void | GetColSum (Vector< T > &diagonal_scale, const Matrix< Complexe, General, RowSparse, Allocator > &mat_direct) |
For each column of the matrix, computation of the sum of absolute values. More... | |
template<class T , class Complexe , class Allocator > | |
void | GetColSum (Vector< T > &diagonal_scale, const Matrix< Complexe, Symmetric, RowSymSparse, Allocator > &mat_direct) |
For each column of the matrix, computation of the sum of absolute values. More... | |
template<class T , class Complexe , class Allocator > | |
void | GetRowColSum (Vector< T > &sum_row, Vector< T > &sum_col, const Matrix< Complexe, General, ArrayRowSparse, Allocator > &A) |
For each row and column of the matrix, computation of the sum of absolute values. More... | |
template<class T , class Complexe , class Allocator > | |
void | GetRowColSum (Vector< T > &sum_row, Vector< T > &sum_col, const Matrix< Complexe, Symmetric, ArrayRowSymSparse, Allocator > &A) |
For each row and column of the matrix computation of the sum of absolute values. More... | |
template<class T , class Complexe , class Allocator > | |
void | GetRowColSum (Vector< T > &sum_row, Vector< T > &sum_col, const Matrix< Complexe, General, RowSparse, Allocator > &A) |
For each row and column of the matrix, computation of the sum of absolute values. More... | |
template<class T , class Complexe , class Allocator > | |
void | GetRowColSum (Vector< T > &sum_row, Vector< T > &sum_col, const Matrix< Complexe, Symmetric, RowSymSparse, Allocator > &A) |
For each row and column of the matrix, computation of the sum of absolute values. More... | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Allocator1 > | |
void | CopySubMatrix (const Matrix< T0, Prop0, ArrayRowSparse, Allocator0 > &A, const IVect &row, const IVect &col, Vector< int > &RowNum, Vector< int > &ColNum, Vector< T1, VectFull, Allocator1 > &Value) |
extracts some rows/columns of a matrix | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Allocator1 > | |
void | CopySubMatrix (const Matrix< T0, Prop0, ArrayRowSymSparse, Allocator0 > &A, const IVect &row, const IVect &col, Vector< int > &RowNum, Vector< int > &ColNum, Vector< T1, VectFull, Allocator1 > &Value) |
extracts some rows/columns of a matrix | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Allocator1 > | |
void | CopySubMatrix (const Matrix< T0, Prop0, RowSparse, Allocator0 > &A, const IVect &row, const IVect &col, Vector< int > &RowNum, Vector< int > &ColNum, Vector< T1, VectFull, Allocator1 > &Value) |
extracts some rows/columns of a matrix | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Allocator1 > | |
void | CopySubMatrix (const Matrix< T0, Prop0, RowSymSparse, Allocator0 > &A, const IVect &row, const IVect &col, Vector< int > &RowNum, Vector< int > &ColNum, Vector< T1, VectFull, Allocator1 > &Value) |
extracts some rows/columns of a matrix | |
template<class T0 , class Prop0 , class Storage0 , class Allocator0 , class T1 , class Prop1 , class Storage1 , class Allocator1 > | |
void | CopySubMatrix (const Matrix< T0, Prop0, Storage0, Allocator0 > &A, const IVect &row, const IVect &col, Matrix< T1, Prop1, Storage1, Allocator1 > &B) |
extracts some rows/columns of a matrix | |
template<class T > | |
void | ReadComplexValue (istream &FileStream, T &entry) |
reads a real or complex value in a file | |
template<class T > | |
void | ReadComplexValue (istream &FileStream, complex< T > &entry) |
reads a real or complex value in a file | |
template<class T > | |
void | WriteComplexValue (ostream &FileStream, const T &entry) |
reads a real or complex value in a file | |
template<class T > | |
void | WriteComplexValue (ostream &FileStream, const complex< T > &entry) |
reads a real or complex value in a file | |
template<class Tint , class AllocInt , class T , class Allocator > | |
void | ReadCoordinateMatrix (istream &FileStream, Vector< Tint, VectFull, AllocInt > &row_numbers, Vector< Tint, VectFull, AllocInt > &col_numbers, Vector< T, VectFull, Allocator > &values, bool cplx) |
Reading of matrix in coordinate format. More... | |
template<class Matrix1 , class T > | |
void | ReadCoordinateMatrix (Matrix1 &A, istream &FileStream, T &zero, int index, long nnz, bool cplx) |
Reading of matrix in coordinate format. More... | |
template<class Tint , class AllocInt , class T , class Allocator > | |
void | WriteCoordinateMatrix (ostream &FileStream, const Vector< Tint, VectFull, AllocInt > &row_numbers, const Vector< Tint, VectFull, AllocInt > &col_numbers, const Vector< T, VectFull, Allocator > &values, bool cplx) |
Writes a matrix in coordinate format. More... | |
template<class T0 , class Prop0 , class Storage0 , class Alloc0 , class T > | |
void | WriteCoordinateMatrix (const Matrix< T0, Prop0, Storage0, Alloc0 > &A, ostream &FileStream, T &zero, int index, bool cplx) |
Writes matrix in coordinate format. More... | |
template<class T , class Prop , class Allocator > | |
void | ReadHarwellBoeing (string filename, Matrix< T, Prop, ColSparse, Allocator > &A) |
Reads a sparse matrix in a file in Harwell-Boeing format. More... | |
template<class T , class Prop , class Allocator > | |
void | ReadHarwellBoeing (string filename, Matrix< complex< T >, Prop, ColSparse, Allocator > &A) |
template<class T , class Prop , class Allocator > | |
void | ReadHarwellBoeing (string filename, Matrix< T, Prop, RowSymSparse, Allocator > &A) |
template<class T , class Prop , class Allocator > | |
void | ReadHarwellBoeing (string filename, Matrix< complex< T >, Prop, RowSymSparse, Allocator > &A) |
template<class T , class T2 , class Storage , class Allocator > | |
void | ReadHarwellBoeing (string filename, const T2 &val, Matrix< T, Symmetric, Storage, Allocator > &A) |
template<class T , class T2 , class Storage , class Allocator > | |
void | ReadHarwellBoeing (string filename, const T2 &val, Matrix< T, General, Storage, Allocator > &A) |
template<class T , class T2 , class Storage , class Allocator > | |
void | ReadHarwellBoeing (string filename, const complex< T2 > &val, Matrix< T, Symmetric, Storage, Allocator > &A) |
template<class T , class T2 , class Storage , class Allocator > | |
void | ReadHarwellBoeing (string filename, const complex< T2 > &val, Matrix< T, General, Storage, Allocator > &A) |
template<class T , class Prop , class Storage , class Allocator > | |
void | ReadHarwellBoeing (string filename, Matrix< T, Prop, Storage, Allocator > &A) |
template<class T > | |
void | ReadComplexValuesHarwell (long Nnonzero, int Nline_val, int line_width_val, int element_width_val, istream &input_stream, T *A_data) |
template<class T > | |
void | ReadComplexValuesHarwell (long Nnonzero, int Nline_val, int line_width_val, int element_width_val, istream &input_stream, complex< T > *A_data) |
template<class T , class Prop , class Storage , class Allocator > | |
void | ReadHarwellBoeing (string filename, string value_type, string matrix_type, Matrix< T, Prop, Storage, Allocator > &A) |
Reads a sparse matrix in a file in Harwell-Boeing format. More... | |
template<class T > | |
void | PrintComplexValuesHarwell (long nnz, const Vector< complex< T > > &Val, ofstream &file_out) |
template<class T > | |
void | PrintComplexValuesHarwell (long nnz, const Vector< T > &Val, ofstream &file_out) |
template<class T , class Prop , class Storage , class Allocator > | |
void | WriteHarwellBoeing (const Matrix< T, Prop, Storage, Allocator > &A, const string &file_name) |
A is written in Harwell-Boeing file. | |
template<class T , class Prop , class Storage , class Allocator > | |
void | ReadMatrixMarket (string filename, Matrix< T, Prop, Storage, Allocator > &A) |
Reads a matrix from a Matrix-Market file. | |
template<class T , class Prop , class Storage , class Allocator > | |
void | WriteMatrixMarket (const Matrix< T, Prop, Storage, Allocator > &A, const string &file_name) |
writing a matrix in Matrix-Market format | |
template<class T , class Prop , class Allocator > | |
ostream & | operator<< (ostream &out, const Matrix< T, Prop, ArrayRowSparse, Allocator > &A) |
template<class T , class Prop , class Allocator > | |
ostream & | operator<< (ostream &out, const Matrix< T, Prop, ArrayColSparse, Allocator > &A) |
template<class T , class Prop , class Allocator > | |
ostream & | operator<< (ostream &out, const Matrix< T, Prop, ArrayRowSymSparse, Allocator > &A) |
template<class T , class Prop , class Allocator > | |
ostream & | operator<< (ostream &out, const Matrix< T, Prop, ArrayColSymSparse, Allocator > &A) |
template<class T , class Prop , class Allocator1 , class Allocator2 , class Tint , class Allocator3 , class Allocator4 > | |
void | ConvertMatrix_to_Coordinates (const Matrix< T, Prop, RowSparse, Allocator1 > &A, Vector< Tint, VectFull, Allocator2 > &IndRow, Vector< Tint, VectFull, Allocator3 > &IndCol, Vector< T, VectFull, Allocator4 > &Val, int index, bool sym) |
Conversion from RowSparse to coordinate format. | |
template<class T , class Prop , class Allocator1 , class Allocator2 , class Tint , class Allocator3 , class Allocator4 > | |
void | ConvertMatrix_to_Coordinates (const Matrix< T, Prop, ColSparse, Allocator1 > &A, Vector< Tint, VectFull, Allocator2 > &IndRow, Vector< Tint, VectFull, Allocator3 > &IndCol, Vector< T, VectFull, Allocator4 > &Val, int index, bool sym) |
Conversion from ColSparse to coordinate format. | |
template<class T , class Prop , class Allocator1 , class Allocator2 , class Tint , class Allocator3 , class Allocator4 > | |
void | ConvertMatrix_to_Coordinates (const Matrix< T, Prop, RowSymSparse, Allocator1 > &A, Vector< Tint, VectFull, Allocator2 > &IndRow, Vector< Tint, VectFull, Allocator3 > &IndCol, Vector< T, VectFull, Allocator4 > &Val, int index, bool sym) |
Conversion from RowSymSparse to coordinate format. | |
template<class T , class Prop , class Allocator1 , class Allocator2 , class Tint , class Allocator3 , class Allocator4 > | |
void | ConvertMatrix_to_Coordinates (const Matrix< T, Prop, ColSymSparse, Allocator1 > &A, Vector< Tint, VectFull, Allocator2 > &IndRow, Vector< Tint, VectFull, Allocator3 > &IndCol, Vector< T, VectFull, Allocator4 > &Val, int index, bool sym) |
Conversion from ColSymSparse to coordinate format. | |
template<class T , class Prop , class Allocator1 , class Allocator2 , class Tint , class Allocator3 , class Allocator4 > | |
void | ConvertMatrix_to_Coordinates (const Matrix< T, Prop, ArrayRowSparse, Allocator1 > &A, Vector< Tint, VectFull, Allocator2 > &IndRow, Vector< Tint, VectFull, Allocator3 > &IndCol, Vector< T, VectFull, Allocator4 > &Val, int index, bool sym) |
Conversion from ArrayRowSparse to coordinate format. | |
template<class T , class Prop , class Allocator1 , class Allocator2 , class Tint , class Allocator3 , class Allocator4 > | |
void | ConvertMatrix_to_Coordinates (const Matrix< T, Prop, ArrayColSparse, Allocator1 > &A, Vector< Tint, VectFull, Allocator2 > &IndRow, Vector< Tint, VectFull, Allocator3 > &IndCol, Vector< T, VectFull, Allocator4 > &Val, int index, bool sym) |
Conversion from ArrayColSparse to coordinate format. | |
template<class T , class Prop , class Allocator1 , class Allocator2 , class Tint , class Allocator3 , class Allocator4 > | |
void | ConvertMatrix_to_Coordinates (const Matrix< T, Prop, ArrayRowSymSparse, Allocator1 > &A, Vector< Tint, VectFull, Allocator2 > &IndRow, Vector< Tint, VectFull, Allocator3 > &IndCol, Vector< T, VectFull, Allocator4 > &Val, int index, bool sym) |
Conversion from ArrayRowSymSparse to coordinate format. | |
template<class T , class Prop , class Allocator1 , class Allocator2 , class Tint , class Allocator3 , class Allocator4 > | |
void | ConvertMatrix_to_Coordinates (const Matrix< T, Prop, ArrayColSymSparse, Allocator1 > &A, Vector< Tint, VectFull, Allocator2 > &IndRow, Vector< Tint, VectFull, Allocator3 > &IndCol, Vector< T, VectFull, Allocator4 > &Val, int index, bool sym) |
Conversion from ArrayColSymSparse to coordinate format. | |
template<class T , class Prop , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | ConvertMatrix_from_Coordinates (const Vector< int, VectFull, Allocator1 > &IndRow, const Vector< int, VectFull, Allocator2 > &IndCol, const Vector< T, VectFull, Allocator3 > &Values, Matrix< T, Prop, RowSparse, Allocator3 > &A, int index) |
Conversion from coordinate format to RowSparse. More... | |
template<class T , class Prop , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | ConvertMatrix_from_Coordinates (const Vector< int, VectFull, Allocator1 > &IndRow, const Vector< int, VectFull, Allocator2 > &IndCol, const Vector< T, VectFull, Allocator3 > &Values, Matrix< T, Prop, ColSparse, Allocator3 > &A, int index) |
Conversion from coordinate format to ColSparse. More... | |
template<class T , class Prop , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | ConvertMatrix_from_Coordinates (const Vector< int, VectFull, Allocator1 > &IndRow, const Vector< int, VectFull, Allocator2 > &IndCol, const Vector< T, VectFull, Allocator3 > &Values, Matrix< T, Prop, RowSymSparse, Allocator3 > &A, int index) |
Conversion from coordinate format to RowSymSparse. | |
template<class T , class Prop , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | ConvertMatrix_from_Coordinates (const Vector< int, VectFull, Allocator1 > &IndRow, const Vector< int, VectFull, Allocator2 > &IndCol, const Vector< T, VectFull, Allocator3 > &Values, Matrix< T, Prop, ColSymSparse, Allocator3 > &A, int index) |
Conversion from coordinate format to ColSymSparse. | |
template<class T , class Prop , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | ConvertMatrix_from_Coordinates (const Vector< int, VectFull, Allocator1 > &IndRow, const Vector< int, VectFull, Allocator2 > &IndCol, const Vector< T, VectFull, Allocator3 > &Values, Matrix< T, Prop, ArrayRowSparse, Allocator3 > &A, int index) |
Conversion from coordinate format to ArrayRowSparse. | |
template<class T , class Prop , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | ConvertMatrix_from_Coordinates (const Vector< int, VectFull, Allocator1 > &IndRow, const Vector< int, VectFull, Allocator2 > &IndCol, const Vector< T, VectFull, Allocator3 > &Values, Matrix< T, Prop, ArrayColSparse, Allocator3 > &A, int index) |
Conversion from coordinate format to ArrayColSparse. | |
template<class T , class Prop , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | ConvertMatrix_from_Coordinates (const Vector< int, VectFull, Allocator1 > &IndRow, const Vector< int, VectFull, Allocator2 > &IndCol, const Vector< T, VectFull, Allocator3 > &Values, Matrix< T, Prop, ArrayRowSymSparse, Allocator3 > &A, int index) |
Conversion from coordinate format to ArrayRowSymSparse. | |
template<class T , class Prop , class Allocator1 , class Allocator2 , class Allocator3 > | |
void | ConvertMatrix_from_Coordinates (const Vector< int, VectFull, Allocator1 > &IndRow, const Vector< int, VectFull, Allocator2 > &IndCol, const Vector< T, VectFull, Allocator3 > &Values, Matrix< T, Prop, ArrayColSymSparse, Allocator3 > &A, int index) |
Conversion from coordinate format to ArrayColSymSparse. | |
template<class T , class Prop , class Alloc1 , class Tint0 , class Tint1 , class Alloc2 , class Alloc3 , class Alloc4 > | |
void | ConvertToCSC (const Matrix< T, Prop, RowSparse, Alloc1 > &A, General &sym, Vector< Tint0, VectFull, Alloc2 > &Ptr, Vector< Tint1, VectFull, Alloc3 > &IndRow, Vector< T, VectFull, Alloc4 > &Val, bool sym_pat) |
Conversion from RowSparse to CSC format. More... | |
template<class T , class Prop , class Alloc1 , class Tint0 , class Tint1 , class Alloc2 , class Alloc3 , class Alloc4 > | |
void | ConvertToCSC (const Matrix< T, Prop, ArrayRowSparse, Alloc1 > &A, General &sym, Vector< Tint0, VectFull, Alloc2 > &Ptr, Vector< Tint1, VectFull, Alloc3 > &IndRow, Vector< T, VectFull, Alloc4 > &Val, bool sym_pat) |
Conversion from ArrayRowSparse to CSC. | |
template<class T , class Prop , class Alloc1 , class Tint0 , class Tint1 , class Alloc2 , class Alloc3 , class Alloc4 > | |
void | ConvertToCSC (const Matrix< T, Prop, ColSparse, Alloc1 > &A, General &sym, Vector< Tint0, VectFull, Alloc2 > &Ptr, Vector< Tint1, VectFull, Alloc3 > &IndRow, Vector< T, VectFull, Alloc4 > &Val, bool sym_pat) |
Conversion from ColSparse to CSC. | |
template<class T , class Prop , class Alloc1 , class Tint0 , class Tint1 , class Alloc2 , class Alloc3 , class Alloc4 > | |
void | ConvertToCSC (const Matrix< T, Prop, ArrayColSparse, Alloc1 > &A, General &sym, Vector< Tint0, VectFull, Alloc2 > &Ptr, Vector< Tint1, VectFull, Alloc3 > &IndRow, Vector< T, VectFull, Alloc4 > &Val, bool sym_pat) |
Conversion from ArrayColSparse to CSC. | |
template<class T , class Prop , class Alloc1 , class Tint0 , class Tint1 , class Alloc2 , class Alloc3 , class Alloc4 > | |
void | ConvertToCSC (const Matrix< T, Prop, ColSymSparse, Alloc1 > &A, Symmetric &sym, Vector< Tint0, VectFull, Alloc2 > &Ptr, Vector< Tint1, VectFull, Alloc3 > &Ind, Vector< T, VectFull, Alloc4 > &Value, bool sym_pat) |
Conversion from ColSymSparse to symmetric CSC. | |
template<class T , class Prop , class Alloc1 , class Tint0 , class Tint1 , class Alloc2 , class Alloc3 , class Alloc4 > | |
void | ConvertToCSC (const Matrix< T, Prop, ColSymSparse, Alloc1 > &A, General &sym, Vector< Tint0, VectFull, Alloc2 > &Ptr, Vector< Tint1, VectFull, Alloc3 > &IndRow, Vector< T, VectFull, Alloc4 > &Value, bool sym_pat) |
Conversion from ColSymSparse to CSC. | |
template<class T , class Prop , class Alloc1 , class Tint0 , class Tint1 , class Alloc2 , class Alloc3 , class Alloc4 > | |
void | ConvertToCSC (const Matrix< T, Prop, ArrayColSymSparse, Alloc1 > &A, Symmetric &sym, Vector< Tint0, VectFull, Alloc2 > &Ptr, Vector< Tint1, VectFull, Alloc3 > &Ind, Vector< T, VectFull, Alloc4 > &Value, bool sym_pat) |
Conversion from ArrayColSymSparse to symmetric CSC format. | |
template<class T , class Prop , class Alloc1 , class Tint0 , class Tint1 , class Alloc2 , class Alloc3 , class Alloc4 > | |
void | ConvertToCSC (const Matrix< T, Prop, ArrayColSymSparse, Alloc1 > &A, General &sym, Vector< Tint0, VectFull, Alloc2 > &Ptr, Vector< Tint1, VectFull, Alloc3 > &IndRow, Vector< T, VectFull, Alloc4 > &Value, bool sym_pat) |
Conversion from ArrayColSymSparse to CSC format. | |
template<class T , class Prop , class Alloc1 , class Tint0 , class Tint1 , class Alloc2 , class Alloc3 , class Alloc4 > | |
void | ConvertToCSC (const Matrix< T, Prop, RowSymSparse, Alloc1 > &A, Symmetric &sym, Vector< Tint0, VectFull, Alloc2 > &Ptr, Vector< Tint1, VectFull, Alloc3 > &IndRow, Vector< T, VectFull, Alloc4 > &Val, bool sym_pat) |
Conversion from RowSymSparse to symmetric CSC. | |
template<class T , class Prop , class Alloc1 , class Tint0 , class Tint1 , class Alloc2 , class Alloc3 , class Alloc4 > | |
void | ConvertToCSC (const Matrix< T, Prop, RowSymSparse, Alloc1 > &A, General &sym, Vector< Tint0, VectFull, Alloc2 > &Ptr, Vector< Tint1, VectFull, Alloc3 > &IndRow, Vector< T, VectFull, Alloc4 > &Value, bool sym_pat) |
Conversion from RowSymSparse to CSC. | |
template<class T , class Prop , class Alloc1 , class Tint0 , class Tint1 , class Alloc2 , class Alloc3 , class Alloc4 > | |
void | ConvertToCSC (const Matrix< T, Prop, ArrayRowSymSparse, Alloc1 > &A, Symmetric &sym, Vector< Tint0, VectFull, Alloc2 > &Ptr, Vector< Tint1, VectFull, Alloc3 > &IndRow, Vector< T, VectFull, Alloc4 > &Val, bool sym_pat) |
Conversion from ArrayRowSymSparse to symmetric CSC. | |
template<class T , class Prop , class Alloc1 , class Tint0 , class Tint1 , class Alloc2 , class Alloc3 , class Alloc4 > | |
void | ConvertToCSC (const Matrix< T, Prop, ArrayRowSymSparse, Alloc1 > &A, General &sym, Vector< Tint0, VectFull, Alloc2 > &Ptr, Vector< Tint1, VectFull, Alloc3 > &IndRow, Vector< T, VectFull, Alloc4 > &Value, bool sym_pat) |
Conversion from ArrayRowSymSparse to CSC. | |
template<class T , class Prop , class Allocator > | |
void | CopyMatrix (const Matrix< T, Prop, RowMajor, Allocator > &A, Matrix< T, Prop, RowMajor, Allocator > &B) |
B = A. | |
template<class T , class Prop , class Allocator > | |
void | CopyMatrix (const Matrix< T, Prop, RowSymPacked, Allocator > &A, Matrix< T, Prop, RowSymPacked, Allocator > &B) |
B = A. | |
template<class T , class Prop , class Allocator > | |
void | CopyMatrix (const Matrix< T, Prop, ColMajor, Allocator > &A, Matrix< T, Prop, ColMajor, Allocator > &B) |
B = A. | |
template<class T , class Prop , class Allocator > | |
void | CopyMatrix (const Matrix< T, Prop, ColSymPacked, Allocator > &A, Matrix< T, Prop, ColSymPacked, Allocator > &B) |
B = A. | |
template<class T , class Prop , class Allocator > | |
void | CopyMatrix (const Matrix< T, Prop, RowSparse, Allocator > &A, Matrix< T, Prop, RowSparse, Allocator > &B) |
B = A. | |
template<class T , class Prop , class Allocator > | |
void | CopyMatrix (const Matrix< T, Prop, RowSymSparse, Allocator > &A, Matrix< T, Prop, RowSymSparse, Allocator > &B) |
B = A. | |
template<class T , class Prop , class Allocator > | |
void | CopyMatrix (const Matrix< T, Prop, ColSparse, Allocator > &A, Matrix< T, Prop, ColSparse, Allocator > &B) |
B = A. | |
template<class T , class Prop , class Allocator > | |
void | CopyMatrix (const Matrix< T, Prop, ColSymSparse, Allocator > &A, Matrix< T, Prop, ColSymSparse, Allocator > &B) |
B = A. | |
template<class T , class Prop , class Allocator > | |
void | CopyMatrix (const Matrix< T, Prop, ArrayRowSymSparse, Allocator > &A, Matrix< T, Prop, ArrayRowSymSparse, Allocator > &B) |
B = A. | |
template<class T , class Prop , class Allocator > | |
void | CopyMatrix (const Matrix< T, Prop, ArrayRowSparse, Allocator > &A, Matrix< T, Prop, ArrayRowSparse, Allocator > &B) |
B = A. | |
template<class T , class Prop , class Allocator > | |
void | CopyMatrix (const Matrix< T, Prop, ArrayColSparse, Allocator > &A, Matrix< T, Prop, ArrayColSparse, Allocator > &B) |
B = A. | |
template<class T , class Prop , class Allocator > | |
void | CopyMatrix (const Matrix< T, Prop, ArrayColSymSparse, Allocator > &A, Matrix< T, Prop, ArrayColSymSparse, Allocator > &B) |
B = A. | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, ArrayColSparse, Allocator0 > &mat_array, Matrix< T1, Prop1, ColSparse, Allocator1 > &mat_csc) |
Conversion from ArrayColSparse to ColSparse. | |
template<class T , class Prop , class Alloc1 , class Alloc2 > | |
void | CopyMatrix (const Matrix< T, Prop, RowSparse, Alloc1 > &A, Matrix< T, Prop, ColSparse, Alloc2 > &B) |
Conversion from row-sparse to column-sparse. | |
template<class T , class Prop , class Alloc1 , class Alloc2 > | |
void | CopyMatrix (const Matrix< T, Prop, RowSparse, Alloc1 > &A, Matrix< T, Prop, ArrayColSparse, Alloc2 > &B) |
Conversion from RowSparse to ArrayColSparse. | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, ArrayRowSparse, Allocator0 > &mat_array, Matrix< T1, Prop1, ColSparse, Allocator1 > &mat_csr) |
Conversion from ArrayRowSparse to ColSparse. | |
template<class T , class Prop , class Alloc1 , class Alloc2 > | |
void | CopyMatrix (const Matrix< T, Prop, RowSymSparse, Alloc1 > &A, Matrix< T, Prop, ColSymSparse, Alloc2 > &B) |
Conversion from RowSymSparse to ColSymSparse. | |
template<class T , class Prop , class Alloc1 , class Alloc2 > | |
void | CopyMatrix (const Matrix< T, Prop, ArrayRowSymSparse, Alloc1 > &A, Matrix< T, Prop, ColSymSparse, Alloc2 > &B) |
Conversion from ArrayRowSymSparse to ColSymSparse. | |
template<class T , class Prop , class Alloc1 , class Alloc2 > | |
void | CopyMatrix (const Matrix< T, Prop, ArrayColSymSparse, Alloc1 > &A, Matrix< T, Prop, ColSymSparse, Alloc2 > &B) |
Conversion from ArrayColSymSparse to ColSymSparse. | |
template<class T , class Prop1 , class Prop2 , class Alloc1 , class Alloc2 > | |
void | CopyMatrix (const Matrix< T, Prop1, RowSymSparse, Alloc1 > &A, Matrix< T, Prop2, ColSparse, Alloc2 > &B) |
Conversion from RowSymSparse to ColSparse. | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, ArrayRowSymSparse, Allocator0 > &A, Matrix< T1, Prop1, ColSparse, Allocator1 > &B) |
Conversion from ArrayRowSymSparse to ColSparse. | |
template<class T , class Prop1 , class Prop2 , class Alloc1 , class Alloc2 > | |
void | CopyMatrix (const Matrix< T, Prop1, ColSymSparse, Alloc1 > &A, Matrix< T, Prop2, ColSparse, Alloc2 > &B) |
Conversion from ColSymSparse to ColSparse. | |
template<class T , class Prop1 , class Prop2 , class Alloc1 , class Alloc2 > | |
void | CopyMatrix (const Matrix< T, Prop1, ArrayColSymSparse, Alloc1 > &A, Matrix< T, Prop2, ColSparse, Alloc2 > &B) |
Conversion from ArrayColSymSparse to ColSparse. | |
template<class T , class Prop , class Alloc1 , class Tint0 , class Tint1 , class Alloc2 , class Alloc3 , class Alloc4 > | |
void | ConvertToCSR (const Matrix< T, Prop, RowSparse, Alloc1 > &A, General &sym, Vector< Tint0, VectFull, Alloc2 > &Ptr, Vector< Tint1, VectFull, Alloc3 > &IndCol, Vector< T, VectFull, Alloc4 > &Value) |
Conversion from RowSparse to CSR. | |
template<class T , class Prop , class Alloc1 , class Tint0 , class Tint1 , class Alloc2 , class Alloc3 , class Alloc4 > | |
void | ConvertToCSR (const Matrix< T, Prop, ColSparse, Alloc1 > &A, General &sym, Vector< Tint0, VectFull, Alloc2 > &Ptr, Vector< Tint1, VectFull, Alloc3 > &IndCol, Vector< T, VectFull, Alloc4 > &Value) |
Conversion from ColSparse to CSR. | |
template<class T , class Prop , class Alloc1 , class Tint0 , class Tint1 , class Alloc2 , class Alloc3 , class Alloc4 > | |
void | ConvertToCSR (const Matrix< T, Prop, ArrayColSparse, Alloc1 > &A, General &sym, Vector< Tint0, VectFull, Alloc2 > &Ptr, Vector< Tint1, VectFull, Alloc3 > &IndCol, Vector< T, VectFull, Alloc4 > &Value) |
Conversion from ArrayColSparse to CSR. | |
template<class T , class Prop , class Alloc1 , class Tint0 , class Tint1 , class Alloc2 , class Alloc3 , class Alloc4 > | |
void | ConvertToCSR (const Matrix< T, Prop, ArrayRowSparse, Alloc1 > &A, General &sym, Vector< Tint0, VectFull, Alloc2 > &Ptr, Vector< Tint1, VectFull, Alloc3 > &IndCol, Vector< T, VectFull, Alloc4 > &Value) |
Conversion from ArrayRowSparse to CSR. | |
template<class T , class Prop , class Alloc1 , class Tint0 , class Tint1 , class Alloc2 , class Alloc3 , class Alloc4 > | |
void | ConvertToCSR (const Matrix< T, Prop, ArrayRowSparse, Alloc1 > &A, Symmetric &sym, Vector< Tint0, VectFull, Alloc2 > &Ptr, Vector< Tint1, VectFull, Alloc3 > &IndCol, Vector< T, VectFull, Alloc4 > &Value) |
Conversion from ArrayRowSparse to symmetric CSR. | |
template<class T , class Prop , class Alloc1 , class Tint0 , class Tint1 , class Alloc2 , class Alloc3 , class Alloc4 > | |
void | ConvertToCSR (const Matrix< T, Prop, ColSymSparse, Alloc1 > &A, Symmetric &sym, Vector< Tint0, VectFull, Alloc2 > &Ptr, Vector< Tint1, VectFull, Alloc3 > &IndCol, Vector< T, VectFull, Alloc4 > &Val) |
Conversion from ColSymSparse to symmetric CSR. | |
template<class T , class Prop , class Alloc1 , class Tint0 , class Tint1 , class Alloc2 , class Alloc3 , class Alloc4 > | |
void | ConvertToCSR (const Matrix< T, Prop, ColSymSparse, Alloc1 > &A, General &sym, Vector< Tint0, VectFull, Alloc2 > &Ptr, Vector< Tint1, VectFull, Alloc3 > &IndCol, Vector< T, VectFull, Alloc4 > &Value) |
Conversion from ColSymSparse to CSR. | |
template<class T , class Prop , class Alloc1 , class Tint0 , class Tint1 , class Alloc2 , class Alloc3 , class Alloc4 > | |
void | ConvertToCSR (const Matrix< T, Prop, ArrayColSymSparse, Alloc1 > &A, Symmetric &sym, Vector< Tint0, VectFull, Alloc2 > &Ptr, Vector< Tint1, VectFull, Alloc3 > &IndCol, Vector< T, VectFull, Alloc4 > &Val) |
Conversion from ArrayColSymSparse to symmetric CSR. | |
template<class T , class Prop , class Alloc1 , class Tint0 , class Tint1 , class Alloc2 , class Alloc3 , class Alloc4 > | |
void | ConvertToCSR (const Matrix< T, Prop, ArrayColSymSparse, Alloc1 > &A, General &sym, Vector< Tint0, VectFull, Alloc2 > &Ptr, Vector< Tint1, VectFull, Alloc3 > &IndCol, Vector< T, VectFull, Alloc4 > &Value) |
Conversion from ArrayColSymSparse to CSR. | |
template<class T , class Prop , class Alloc1 , class Tint0 , class Tint1 , class Alloc2 , class Alloc3 , class Alloc4 > | |
void | ConvertToCSR (const Matrix< T, Prop, RowSymSparse, Alloc1 > &A, Symmetric &sym, Vector< Tint0, VectFull, Alloc2 > &IndRow, Vector< Tint1, VectFull, Alloc3 > &IndCol, Vector< T, VectFull, Alloc4 > &Val) |
Conversion from RowSymSparse to CSR. | |
template<class T , class Prop , class Alloc1 , class Tint0 , class Tint1 , class Alloc2 , class Alloc3 , class Alloc4 > | |
void | ConvertToCSR (const Matrix< T, Prop, RowSymSparse, Alloc1 > &A, General &sym, Vector< Tint0, VectFull, Alloc2 > &Ptr, Vector< Tint1, VectFull, Alloc3 > &IndCol, Vector< T, VectFull, Alloc4 > &Value) |
Conversion from RowSymSparse to CSR. | |
template<class T , class Prop , class Alloc1 , class Tint0 , class Tint1 , class Alloc2 , class Alloc3 , class Alloc4 > | |
void | ConvertToCSR (const Matrix< T, Prop, ArrayRowSymSparse, Alloc1 > &A, Symmetric &sym, Vector< Tint0, VectFull, Alloc2 > &IndRow, Vector< Tint1, VectFull, Alloc3 > &IndCol, Vector< T, VectFull, Alloc4 > &Val) |
Conversion from ArrayRowSymSparse to CSR. | |
template<class T , class Prop , class Alloc1 , class Tint0 , class Tint1 , class Alloc2 , class Alloc3 , class Alloc4 > | |
void | ConvertToCSR (const Matrix< T, Prop, ArrayRowSymSparse, Alloc1 > &A, General &sym, Vector< Tint0, VectFull, Alloc2 > &Ptr, Vector< Tint1, VectFull, Alloc3 > &IndCol, Vector< T, VectFull, Alloc4 > &Value) |
Conversion from ArrayRowSymSparse to CSR. | |
template<class T1 , class T2 , class Prop1 , class Prop2 , class Alloc1 , class Alloc2 > | |
void | CopyMatrix (const Matrix< T1, Prop1, ColSparse, Alloc1 > &A, Matrix< T2, Prop2, RowSparse, Alloc2 > &B) |
Conversion from column-oriented sparse to row-oriented sparse. More... | |
template<class T1 , class T2 , class Prop1 , class Prop2 , class Alloc1 , class Alloc2 > | |
void | CopyMatrix (const Matrix< T1, Prop1, ArrayColSparse, Alloc1 > &A, Matrix< T2, Prop2, RowSparse, Alloc2 > &B) |
Conversion from ArrayColSparse to RowSparse. More... | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, ArrayRowSparse, Allocator0 > &mat_array, Matrix< T1, Prop1, RowSparse, Allocator1 > &mat_csr) |
Conversion from ArrayRowSparse to RowSparse. | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, ArrayRowSparse, Allocator0 > &mat_array, Matrix< T1, Prop1, RowSymSparse, Allocator1 > &mat_csr) |
Conversion from ArrayRowSparse to RowSymSparse. | |
template<class T , class Prop , class Alloc1 , class Alloc2 > | |
void | CopyMatrix (const Matrix< T, Prop, ColSymSparse, Alloc1 > &A, Matrix< T, Prop, RowSymSparse, Alloc2 > &B) |
Conversion from ColSymSparse to RowSymSparse. | |
template<class T , class Prop1 , class Prop2 , class Alloc1 , class Alloc2 > | |
void | CopyMatrix (const Matrix< T, Prop1, ColSymSparse, Alloc1 > &A, Matrix< T, Prop2, RowSparse, Alloc2 > &B) |
Conversion from ColSymSparse to RowSparse. | |
template<class T , class Prop , class Alloc1 , class Alloc2 > | |
void | CopyMatrix (const Matrix< T, Prop, ArrayColSymSparse, Alloc1 > &A, Matrix< T, Prop, RowSymSparse, Alloc2 > &B) |
Conversion from ArrayColSymSparse to RowSymSparse. | |
template<class T , class Prop1 , class Prop2 , class Alloc1 , class Alloc2 > | |
void | CopyMatrix (const Matrix< T, Prop1, ArrayColSymSparse, Alloc1 > &A, Matrix< T, Prop2, RowSparse, Alloc2 > &B) |
Conversion from ArrayColSymSparse to RowSparse. | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, RowSymSparse, Allocator0 > &mat_array, Matrix< T1, Prop1, RowSparse, Allocator1 > &mat_csr) |
Conversion from RowSymSparse to RowSparse. | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, ArrayRowSymSparse, Allocator0 > &mat_array, Matrix< T1, Prop1, RowSymSparse, Allocator1 > &mat_csr) |
Conversion from ArrayRowSymSparse to RowSymSparse. | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, ArrayRowSymSparse, Allocator0 > &mat_array, Matrix< T1, Prop1, RowSparse, Allocator1 > &mat_csr) |
Conversion from ArrayRowSymSparse to RowSparse. | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, RowSymSparse, Allocator0 > &A, Matrix< T1, Prop1, ArrayRowSymSparse, Allocator1 > &B) |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, ColSymSparse, Allocator0 > &A, Matrix< T1, Prop1, ArrayRowSymSparse, Allocator1 > &B) |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, RowSymSparse, Allocator0 > &A, Matrix< T1, Prop1, ArrayColSymSparse, Allocator1 > &B) |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, RowSymSparse, Allocator0 > &A, Matrix< T1, Prop1, ArrayRowSparse, Allocator1 > &B) |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, RowSparse, Allocator0 > &A, Matrix< T1, Prop1, ArrayRowSparse, Allocator1 > &B) |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, ColSparse, Allocator0 > &A, Matrix< T1, Prop1, ArrayColSparse, Allocator1 > &B) |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, ColSparse, Allocator0 > &Acsc, Matrix< T1, Prop1, ArrayRowSparse, Allocator1 > &B) |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, ArrayRowSymSparse, Allocator0 > &A, Matrix< T1, Prop1, ArrayRowSymSparse, Allocator1 > &B) |
From ArrayRowSymSparse to ArrayRowSymSparse (T0 and T1 different) | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, ArrayRowSparse, Allocator0 > &A, Matrix< T1, Prop1, ArrayRowSparse, Allocator1 > &B) |
From ArrayRowSparse to ArrayRowSparse (T0 and T1 different) | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, ArrayRowSparse, Allocator0 > &A, Matrix< T1, Prop1, ArrayRowSymSparse, Allocator1 > &B) |
upper part of A is used to obtain a symmetric matrix | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, ArrayColSymSparse, Allocator0 > &A, Matrix< T1, Prop1, ArrayRowSymSparse, Allocator1 > &B) |
conversion from ArrayColSymSparse to ArrayRowSymSparse | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, ArrayColSparse, Allocator0 > &Acsc, Matrix< T1, Prop1, ArrayRowSparse, Allocator1 > &B) |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, ArrayRowSymSparse, Allocator0 > &A, Matrix< T1, Prop1, ArrayRowSparse, Allocator1 > &B) |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, ArrayRowSymSparse, Allocator0 > &A, Matrix< T1, Prop1, ArrayColSparse, Allocator1 > &B) |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Prop1 , class Allocator1 > | |
void | CopyMatrix (const Matrix< T0, Prop0, ArrayRowSparse, Allocator0 > &A, Matrix< T1, Prop1, ArrayColSparse, Allocator1 > &B) |
Conversion from ArrayRowSparse to ArrayColSparse. | |
template<class T , class Prop , class Storage , class Allocator , class Tint0 , class Tint1 , class Allocator2 , class Allocator3 > | |
void | GetSymmetricPattern (const Matrix< T, Prop, Storage, Allocator > &A, Vector< Tint0, VectFull, Allocator2 > &Ptr, Vector< Tint1, VectFull, Allocator3 > &Ind) |
Returns pattern of A + A' in CSR format. More... | |
template<class T , class Prop , class Storage , class Allocator , class AllocI > | |
void | GetSymmetricPattern (const Matrix< T, Prop, Storage, Allocator > &A, Matrix< int, Symmetric, RowSymSparse, AllocI > &B) |
template<class T , class Prop , class Allocator1 , class Allocator2 > | |
void | CopyMatrix (const Matrix< T, Prop, RowSparse, Allocator1 > &A, Matrix< T, Prop, RowMajor, Allocator2 > &B) |
conversion from RowSparse to RowMajor | |
template<class T1 , class T2 , class Prop1 , class Prop2 , class Allocator1 , class Allocator2 > | |
void | CopyMatrix (const Matrix< T1, Prop1, ArrayRowSparse, Allocator1 > &A, Matrix< T2, Prop2, RowMajor, Allocator2 > &B) |
conversion from ArrayRowSparse to RowMajor | |
template<class T , class Prop , class Allocator1 , class Allocator2 > | |
void | CopyMatrix (const Matrix< T, Prop, RowSymSparse, Allocator1 > &A, Matrix< T, Prop, RowSymPacked, Allocator2 > &B) |
conversion from RowSymSparse to RowSymPacked | |
template<class T , class Prop , class Allocator1 , class Allocator2 > | |
void | CopyMatrix (const Matrix< T, Prop, ArrayRowSymSparse, Allocator1 > &A, Matrix< T, Prop, RowSymPacked, Allocator2 > &B) |
conversion from ArrayRowSymSparse to RowSymPacked | |
template<class T , class Prop , class Allocator1 , class Allocator2 > | |
void | CopyMatrix (const Matrix< T, Prop, ArrayRowSymSparse, Allocator1 > &A, Matrix< T, Prop, ColSymPacked, Allocator2 > &B) |
conversion from ArrayRowSymSparse to ColSymPacked | |
template<class T , class Prop , class Allocator1 , class Allocator2 > | |
void | CopyMatrix (const Matrix< T, Prop, ArrayRowSymSparse, Allocator1 > &A, Matrix< T, Prop, RowSym, Allocator2 > &B) |
conversion from ArrayRowSymSparse to RowSym | |
template<class T , class Prop , class Allocator1 , class Allocator2 > | |
void | CopyMatrix (const Matrix< T, Prop, ArrayRowSymSparse, Allocator1 > &A, Matrix< T, Prop, ColSym, Allocator2 > &B) |
conversion from ArrayRowSymSparse to ColSym | |
template<class T , class Prop1 , class Prop2 , class Alloc1 , class Alloc2 > | |
void | CopyMatrix (const Matrix< T, Prop1, PETScMPIDense, Alloc1 > &A, Matrix< T, Prop2, RowMajor, Alloc2 > &B) |
template<class T , class Prop1 , class Prop2 , class Alloc1 , class Alloc2 > | |
void | CopyMatrix (const Matrix< T, Prop1, RowMajor, Alloc1 > &A, Matrix< T, Prop2, PETScMPIDense, Alloc2 > &B) |
template<class T > | |
void | ConvertToSparse (const Matrix< T, Symmetric, RowSymPacked > &A, Matrix< T, Symmetric, RowSymSparse > &B, const T &threshold) |
conversion from RowSymPacked to RowSymSparse | |
template<class T > | |
void | ConvertToSparse (const Matrix< T, General, RowMajor > &A, Matrix< T, General, ArrayRowSparse > &B, const T &threshold) |
conversion from RowMajor to ArrayRowSparse | |
template<class T > | |
void | ConvertToSparse (const Matrix< T, General, RowMajor > &A, Matrix< T, General, RowSparse > &B, const T &threshold) |
conversion from RowMajor to RowSparse | |
template<class T , class Prop , class Allocator > | |
void | ApplyInversePermutation (Matrix< T, Prop, RowSparse, Allocator > &A, const Vector< int > &row_perm, const Vector< int > &col_perm) |
Permutation of a general matrix stored by rows. More... | |
template<class T , class Prop , class Allocator > | |
void | ApplyInversePermutation (Matrix< T, Prop, ColSparse, Allocator > &A, const Vector< int > &row_perm, const Vector< int > &col_perm) |
Permutation of a general matrix stored by columns. More... | |
template<class T , class Prop , class Allocator > | |
void | ApplyInversePermutation (Matrix< T, Prop, RowSymSparse, Allocator > &A, const Vector< int > &row_perm, const Vector< int > &col_perm) |
Permutation of a symmetric matrix stored by rows. More... | |
template<class T , class Prop , class Allocator > | |
void | ApplyInversePermutation (Matrix< T, Prop, ColSymSparse, Allocator > &A, const Vector< int > &row_perm, const Vector< int > &col_perm) |
Permutation of a symmetric matrix stored by columns. More... | |
template<class T , class Prop , class Allocator > | |
void | ApplyInversePermutation (Matrix< T, Prop, ArrayRowSparse, Allocator > &A, const IVect &row_perm, const IVect &col_perm) |
Permutation of a general matrix stored by rows. More... | |
template<class T , class Prop , class Allocator > | |
void | ApplyInversePermutation (Matrix< T, Prop, ArrayColSparse, Allocator > &A, const IVect &row_perm, const IVect &col_perm) |
Permutation of a general matrix stored by columns. More... | |
template<class T , class Prop , class Allocator > | |
void | ApplyInversePermutation (Matrix< T, Prop, ArrayColSymSparse, Allocator > &A, const IVect &row_perm, const IVect &col_perm) |
Permutation of a symmetric matrix stored by columns. More... | |
template<class T , class Prop , class Allocator > | |
void | ApplyInversePermutation (Matrix< T, Prop, ArrayRowSymSparse, Allocator > &A, const IVect &row_perm, const IVect &col_perm) |
Permutation of a symmetric matrix stored by rows. More... | |
template<class T , class Prop , class Allocator > | |
void | ApplyPermutation (Matrix< T, Prop, RowSparse, Allocator > &A, const Vector< int > &row_perm, const Vector< int > &col_perm) |
Permutation of rows and columns of a matrix. More... | |
template<class T , class Prop , class Allocator > | |
void | ApplyPermutation (Matrix< T, Prop, ColSparse, Allocator > &A, const Vector< int > &row_perm, const Vector< int > &col_perm) |
Permutation of rows and columns of a matrix. More... | |
template<class T , class Prop , class Allocator > | |
void | ApplyPermutation (Matrix< T, Prop, RowSymSparse, Allocator > &A, const Vector< int > &row_perm, const Vector< int > &col_perm) |
Permutation of rows and columns of a matrix. More... | |
template<class T , class Prop , class Allocator > | |
void | ApplyPermutation (Matrix< T, Prop, ColSymSparse, Allocator > &A, const Vector< int > &row_perm, const Vector< int > &col_perm) |
Permutation of rows and columns of a matrix. More... | |
template<class T , class Prop , class Allocator > | |
void | ApplyPermutation (Matrix< T, Prop, ArrayRowSparse, Allocator > &A, const Vector< int > &row_perm, const Vector< int > &col_perm) |
Permutation of rows and columns of a matrix. More... | |
template<class T , class Prop , class Allocator > | |
void | ApplyPermutation (Matrix< T, Prop, ArrayColSparse, Allocator > &A, const Vector< int > &row_perm, const Vector< int > &col_perm) |
Permutation of rows and columns of a matrix. More... | |
template<class T , class Prop , class Allocator > | |
void | ApplyPermutation (Matrix< T, Prop, ArrayRowSymSparse, Allocator > &A, const Vector< int > &row_perm, const Vector< int > &col_perm) |
Permutation of rows and columns of a matrix. More... | |
template<class T , class Prop , class Allocator > | |
void | ApplyPermutation (Matrix< T, Prop, ArrayColSymSparse, Allocator > &A, const Vector< int > &row_perm, const Vector< int > &col_perm) |
Permutation of rows and columns of a matrix. More... | |
template<class Prop , class T1 , class Allocator1 , class T2 , class Allocator2 , class T3 , class Allocator3 > | |
void | ScaleMatrix (Matrix< T1, Prop, RowSparse, Allocator1 > &A, const Vector< T2, VectFull, Allocator2 > &scale_left, const Vector< T3, VectFull, Allocator3 > &scale_right) |
Each row and column are scaled. More... | |
template<class Prop , class T1 , class Allocator1 , class T2 , class Allocator2 , class T3 , class Allocator3 > | |
void | ScaleMatrix (Matrix< T1, Prop, ColSparse, Allocator1 > &A, const Vector< T2, VectFull, Allocator2 > &scale_left, const Vector< T3, VectFull, Allocator3 > &scale_right) |
Each row and column are scaled. More... | |
template<class Prop , class T1 , class Allocator1 , class T2 , class Allocator2 , class T3 , class Allocator3 > | |
void | ScaleMatrix (Matrix< T1, Prop, RowSymSparse, Allocator1 > &A, const Vector< T2, VectFull, Allocator2 > &scale_left, const Vector< T3, VectFull, Allocator3 > &scale_right) |
Each row and column are scaled. More... | |
template<class Prop , class T1 , class Allocator1 , class T2 , class Allocator2 , class T3 , class Allocator3 > | |
void | ScaleMatrix (Matrix< T1, Prop, ColSymSparse, Allocator1 > &A, const Vector< T2, VectFull, Allocator2 > &scale_left, const Vector< T3, VectFull, Allocator3 > &scale_right) |
Each row and column are scaled. More... | |
template<class Prop , class T1 , class Allocator1 , class T2 , class Allocator2 , class T3 , class Allocator3 > | |
void | ScaleMatrix (Matrix< T1, Prop, ArrayRowSparse, Allocator1 > &A, const Vector< T2, VectFull, Allocator2 > &scale_left, const Vector< T3, VectFull, Allocator3 > &scale_right) |
Each row and column are scaled. More... | |
template<class Prop , class T1 , class Allocator1 , class T2 , class Allocator2 , class T3 , class Allocator3 > | |
void | ScaleMatrix (Matrix< T1, Prop, ArrayColSparse, Allocator1 > &A, const Vector< T2, VectFull, Allocator2 > &scale_left, const Vector< T3, VectFull, Allocator3 > &scale_right) |
Each row and column are scaled. More... | |
template<class Prop , class T1 , class Allocator1 , class T2 , class Allocator2 , class T3 , class Allocator3 > | |
void | ScaleMatrix (Matrix< T1, Prop, ArrayRowSymSparse, Allocator1 > &A, const Vector< T2, VectFull, Allocator2 > &scale_left, const Vector< T3, VectFull, Allocator3 > &scale_right) |
Each row and column are scaled. More... | |
template<class Prop , class T1 , class Allocator1 , class T2 , class Allocator2 , class T3 , class Allocator3 > | |
void | ScaleMatrix (Matrix< T1, Prop, ArrayColSymSparse, Allocator1 > &A, const Vector< T2, VectFull, Allocator2 > &scale_left, const Vector< T3, VectFull, Allocator3 > &scale_right) |
Each row and column are scaled. More... | |
template<class T1 , class Allocator1 , class Prop , class T2 , class Allocator2 > | |
void | ScaleLeftMatrix (Matrix< T1, Prop, RowSparse, Allocator1 > &A, const Vector< T2, VectFull, Allocator2 > &scale) |
Each row is scaled. More... | |
template<class T1 , class Allocator1 , class Prop , class T2 , class Allocator2 > | |
void | ScaleLeftMatrix (Matrix< T1, Prop, ColSparse, Allocator1 > &A, const Vector< T2, VectFull, Allocator2 > &scale) |
Each row is scaled. More... | |
template<class T1 , class Allocator1 , class Prop , class T2 , class Allocator2 > | |
void | ScaleLeftMatrix (Matrix< T1, Prop, ArrayRowSparse, Allocator1 > &A, const Vector< T2, VectFull, Allocator2 > &scale) |
Each row is scaled. More... | |
template<class T1 , class Allocator1 , class Prop , class T2 , class Allocator2 > | |
void | ScaleLeftMatrix (Matrix< T1, Prop, ArrayColSparse, Allocator1 > &A, const Vector< T2, VectFull, Allocator2 > &scale) |
Each row is scaled. More... | |
template<class T1 , class Allocator1 , class Prop , class T2 , class Allocator2 > | |
void | ScaleRightMatrix (Matrix< T1, Prop, RowSparse, Allocator1 > &A, const Vector< T2, VectFull, Allocator2 > &scale) |
Each column is scaled. More... | |
template<class T1 , class Allocator1 , class Prop , class T2 , class Allocator2 > | |
void | ScaleRightMatrix (Matrix< T1, Prop, ColSparse, Allocator1 > &A, const Vector< T2, VectFull, Allocator2 > &scale) |
Each column is scaled. More... | |
template<class T1 , class Allocator1 , class Prop , class T2 , class Allocator2 > | |
void | ScaleRightMatrix (Matrix< T1, Prop, ArrayRowSparse, Allocator1 > &A, const Vector< T2, VectFull, Allocator2 > &scale) |
Each column is scaled. More... | |
template<class T1 , class Allocator1 , class Prop , class T2 , class Allocator2 > | |
void | ScaleRightMatrix (Matrix< T1, Prop, ArrayColSparse, Allocator1 > &A, const Vector< T2, VectFull, Allocator2 > &scale) |
Each column is scaled. More... | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 > | |
void | SorVector (const Matrix< T0, Prop0, RowSparse, Allocator0 > &A, Vector< T2, Storage2, Allocator2 > &X, const Vector< T1, Storage1, Allocator1 > &B, const T3 &omega, int iter, int type_ssor) |
Successive overrelaxation. More... | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 > | |
void | SorVector (const Matrix< T0, Prop0, ArrayRowSparse, Allocator0 > &A, Vector< T2, Storage2, Allocator2 > &X, const Vector< T1, Storage1, Allocator1 > &B, const T3 &omega, int iter, int type_ssor) |
Successive overrelaxation. More... | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 > | |
void | SorVector (const Matrix< T0, Prop0, RowSymSparse, Allocator0 > &A, Vector< T2, Storage2, Allocator2 > &X, const Vector< T1, Storage1, Allocator1 > &B, const T3 &omega, int iter, int type_ssor) |
Successive overrelaxation. More... | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 > | |
void | SorVector (const Matrix< T0, Prop0, ArrayRowSymSparse, Allocator0 > &A, Vector< T2, Storage2, Allocator2 > &X, const Vector< T1, Storage1, Allocator1 > &B, const T3 &omega, int iter, int type_ssor) |
Successive overrelaxation. More... | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 > | |
void | SorVector (const Matrix< T0, Prop0, ColSparse, Allocator0 > &A, Vector< T2, Storage2, Allocator2 > &X, const Vector< T1, Storage1, Allocator1 > &B, const T3 &omega, int iter, int type_ssor) |
Successive overrelaxation. More... | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 > | |
void | SorVector (const Matrix< T0, Prop0, ArrayColSparse, Allocator0 > &A, Vector< T2, Storage2, Allocator2 > &X, const Vector< T1, Storage1, Allocator1 > &B, const T3 &omega, int iter, int type_ssor) |
Successive overrelaxation. More... | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 > | |
void | SorVector (const Matrix< T0, Prop0, ColSymSparse, Allocator0 > &A, Vector< T2, Storage2, Allocator2 > &X, const Vector< T1, Storage1, Allocator1 > &B, const T3 &omega, int iter, int type_ssor) |
Successive overrelaxation. More... | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 > | |
void | SorVector (const Matrix< T0, Prop0, ArrayColSymSparse, Allocator0 > &A, Vector< T2, Storage2, Allocator2 > &X, const Vector< T1, Storage1, Allocator1 > &B, const T3 &omega, int iter, int type_ssor) |
Successive overrelaxation. More... | |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 > | |
void | SorVector (const SeldonTranspose &transM, const Matrix< T0, Prop0, RowSparse, Allocator0 > &A, Vector< T2, Storage2, Allocator2 > &X, const Vector< T1, Storage1, Allocator1 > &B, const T3 &omega, int iter, int type_ssor) |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 > | |
void | SorVector (const SeldonTranspose &transM, const Matrix< T0, Prop0, ColSparse, Allocator0 > &A, Vector< T2, Storage2, Allocator2 > &X, const Vector< T1, Storage1, Allocator1 > &B, const T3 &omega, int iter, int type_ssor) |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 > | |
void | SorVector (const SeldonTranspose &transM, const Matrix< T0, Prop0, RowSymSparse, Allocator0 > &A, Vector< T2, Storage2, Allocator2 > &X, const Vector< T1, Storage1, Allocator1 > &B, const T3 &omega, int iter, int type_ssor) |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 > | |
void | SorVector (const SeldonTranspose &transM, const Matrix< T0, Prop0, ColSymSparse, Allocator0 > &A, Vector< T2, Storage2, Allocator2 > &X, const Vector< T1, Storage1, Allocator1 > &B, const T3 &omega, int iter, int type_ssor) |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 > | |
void | SorVector (const SeldonTranspose &transM, const Matrix< T0, Prop0, ArrayRowSparse, Allocator0 > &A, Vector< T2, Storage2, Allocator2 > &X, const Vector< T1, Storage1, Allocator1 > &B, const T3 &omega, int iter, int type_ssor) |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 > | |
void | SorVector (const SeldonTranspose &transM, const Matrix< T0, Prop0, ArrayColSparse, Allocator0 > &A, Vector< T2, Storage2, Allocator2 > &X, const Vector< T1, Storage1, Allocator1 > &B, const T3 &omega, int iter, int type_ssor) |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 > | |
void | SorVector (const SeldonTranspose &transM, const Matrix< T0, Prop0, ArrayRowSymSparse, Allocator0 > &A, Vector< T2, Storage2, Allocator2 > &X, const Vector< T1, Storage1, Allocator1 > &B, const T3 &omega, int iter, int type_ssor) |
template<class T0 , class Prop0 , class Allocator0 , class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 > | |
void | SorVector (const SeldonTranspose &transM, const Matrix< T0, Prop0, ArrayColSymSparse, Allocator0 > &A, Vector< T2, Storage2, Allocator2 > &X, const Vector< T1, Storage1, Allocator1 > &B, const T3 &omega, int iter, int type_ssor) |
template void | ConvertMatrix_to_Coordinates (const Matrix< double, General, RowSparse, MallocAlloc< double > > &A, Vector< int > &IndRow, Vector< int > &IndCol, Vector< double, VectFull > &Val, int index=0, bool sym=false) |
template void | ConvertMatrix_from_Coordinates (Vector< int > &IndRow, Vector< int > &IndCol, Vector< double, VectFull > &Val, Matrix< double, General, RowSparse, MallocAlloc< double > > &A, int index=0) |
Str | instance (const Str input) |
void | SetComplex (complex< int > input, int input2) |
void | skip_vector_double (istream &input_stream) |
void | skip_matrix_double (istream &input_stream) |
string | GetExtension (const string &nom) |
returns extension of a string | |
string | GetBaseString (const string &nom) |
returns base of a string | |
void | InitSeldon (int argc, char **argv) |
Function to call in parallel to initialize MPI. | |
int | FinalizeSeldon () |
template<class T > | |
void | PrintArray (T *v, int lgth) |
template<class T > | |
Str | operator+ (const Str &s, const T &input) |
Adds an element to an instance of 'Str'. More... | |
ostream & | operator<< (ostream &out, Str &in) |
Converts a 'str' instance to an 'ostream' instance. | |
ostream & | operator<< (ostream &out, Str in) |
Converts a 'str' instance to an 'ostream' instance. | |
template<typename T > | |
std::string | to_str (const T &input) |
Converts most types to string. More... | |
template<class T > | |
void | to_num (std::string s, T &num) |
Converts string to most types, specially numbers. More... | |
template<class T > | |
T | to_num (std::string s) |
Converts string to most types, specially numbers. More... | |
template<class T > | |
void | SetComplexZero (T &number) |
Sets a number to zero. More... | |
template<class T > | |
void | SetComplexZero (std::complex< T > &number) |
Sets a complex number to zero. More... | |
template<class T > | |
void | SetComplexOne (T &number) |
Sets a number to one. More... | |
template<class T > | |
void | SetComplexOne (std::complex< T > &number) |
Sets a complex number to (1, 0). More... | |
template<class T > | |
void | SetComplexReal (int n, std::complex< T > &number) |
Sets a complex number to (n, 0). More... | |
template<class T > | |
void | SetComplexReal (int n, T &number) |
Sets a real number to n. More... | |
template<class T > | |
void | SetComplexReal (bool n, std::complex< T > &number) |
Sets a complex number to (n, 0). More... | |
void | SetComplexReal (int x, std::complex< int > &number) |
Sets a complex number to (n, 0). | |
template<class T > | |
void | SetComplexReal (const T &x, std::complex< T > &number) |
Sets a complex number to (x, 0). More... | |
template<class T > | |
void | SetComplexReal (const std::complex< T > &x, T &number) |
Sets a complex number to (x, 0). More... | |
template<class T0 , class T1 > | |
void | SetComplexReal (const T0 &x, T1 &number) |
Sets a complex number to x. More... | |
template<class T > | |
T | ComplexAbs (const T &val) |
returns absolute value of val | |
template<class T > | |
T | ComplexAbs (const std::complex< T > &val) |
returns modulus of val | |
template<class T > | |
T | absSquare (const T &z) |
returns the square modulus of z | |
template<class T > | |
T | absSquare (const std::complex< T > &z) |
returns the square modulus of z | |
template<class T > | |
bool | IsComplexNumber (const T &number) |
Returns true for a complex number. | |
template<class T > | |
bool | IsComplexNumber (const std::complex< T > &number) |
Returns true for a complex number. | |
void | CheckBounds (long i, long length1_, string nom) |
void | CheckBounds (int i, int j, int length1_, int length2_, string nom) |
void | CheckBoundsSym (int i, int j, int length1_, int length2_, string nom) |
void | CheckBoundsTriang (int i, int j, int length1_, int length2_, bool uplo, string nom) |
void | CheckBounds (int i, int j, int k, int length1_, int length2_, int length3_, string nom) |
void | CheckBounds (int i, int j, int k, int l, int length1_, int length2_, int length3_, int length4_, string nom) |
void | CheckBounds (int i, int j, int k, int l, int m, int length0, int length1, int length2, int length3, int length4, string nom) |
void | CheckBounds (int i, int j, int k, int l, int m, int n, int length0, int length1, int length2, int length3, int length4, int length5, string nom) |
void | CheckBounds (int i, int j, int k, int l, int m, int n, int o, int length0, int length1, int length2, int length3, int length4, int length5, int length6, string nom) |
void | CheckBounds (int i, int j, int k, int l, int m, int n, int o, int p, int length0, int length1, int length2, int length3, int length4, int length5, int length6, int length7, string nom) |
void | CheckBounds (int i, int j, int k, int l, int m, int n, int o, int p, int q, int length0, int length1, int length2, int length3, int length4, int length5, int length6, int length7, int length8, string nom) |
void | CheckPointer (void *ptr, string name) |
template<class T > | |
MPI_Request | MpiIsend (const MPI_Comm &comm, T *x, Vector< int64_t > &xtmp, int n, int proc, int tag) |
template<class T > | |
MPI_Request | MpiIsend (const MPI_Comm &comm, Vector< T > &x, Vector< int64_t > &xtmp, int n, int proc, int tag) |
template<class T > | |
MPI_Request | MpiIrecv (const MPI_Comm &comm, T *x, Vector< int64_t > &xtmp, int n, int proc, int tag) |
template<class T > | |
MPI_Request | MpiIrecv (const MPI_Comm &comm, Vector< T > &x, Vector< int64_t > &xtmp, int n, int proc, int tag) |
template<class T > | |
void | MpiCompleteIrecv (T *x, Vector< int64_t > &xtmp, int n) |
template<class T > | |
void | MpiCompleteIrecv (Vector< T > &x, Vector< int64_t > &xtmp, int n) |
template<class T > | |
void | MpiSsend (const MPI_Comm &comm, T *x, Vector< int64_t > &xtmp, int n, int proc, int tag) |
template<class T > | |
void | MpiSsend (const MPI_Comm &comm, Vector< T > &x, Vector< int64_t > &xtmp, int n, int proc, int tag) |
template<class T > | |
void | MpiSend (const MPI_Comm &comm, T *x, Vector< int64_t > &xtmp, int n, int proc, int tag) |
template<class T > | |
void | MpiSend (const MPI_Comm &comm, Vector< T > &x, Vector< int64_t > &xtmp, int n, int proc, int tag) |
template<class T > | |
void | MpiGather (const MPI_Comm &comm, T *x, Vector< int64_t > &xtmp, T *y, int n, int proc) |
template<class T > | |
void | MpiGather (const MPI_Comm &comm, Vector< T > &x, Vector< int64_t > &xtmp, Vector< T > &y, int n, int proc) |
template<class T > | |
void | MpiAllreduce (const MPI_Comm &comm, T *x, Vector< int64_t > &xtmp, T *y, int n, const MPI_Op &op) |
template<class T > | |
void | MpiAllreduce (const MPI_Comm &comm, Vector< T > &x, Vector< int64_t > &xtmp, Vector< T > &y, int n, const MPI_Op &op) |
template<class T > | |
void | MpiReduce (const MPI_Comm &comm, T *x, Vector< int64_t > &xtmp, T *y, int n, const MPI_Op &op, int proc) |
template<class T > | |
void | MpiReduce (const MPI_Comm &comm, Vector< T > &x, Vector< int64_t > &xtmp, Vector< T > &y, int n, const MPI_Op &op, int proc) |
template<class T > | |
void | MpiRecv (const MPI_Comm &comm, T *x, Vector< int64_t > &xtmp, int n, int proc, int tag, MPI_Status &status) |
template<class T > | |
void | MpiRecv (const MPI_Comm &comm, Vector< T > &x, Vector< int64_t > &xtmp, int n, int proc, int tag, MPI_Status &status) |
template<class T > | |
void | MpiBcast (const MPI_Comm &comm, T *x, Vector< int64_t > &xtmp, int n, int proc) |
template<class T > | |
void | MpiBcast (const MPI_Comm &comm, Vector< T > &x, Vector< int64_t > &xtmp, int n, int proc) |
MPI_Datatype | GetMpiDataType (const Vector< bool > &) |
MPI_Datatype | GetMpiDataType (const Vector< int > &) |
MPI_Datatype | GetMpiDataType (const Vector< long > &) |
MPI_Datatype | GetMpiDataType (const Vector< float > &) |
MPI_Datatype | GetMpiDataType (const Vector< complex< float > > &) |
MPI_Datatype | GetMpiDataType (const Vector< double > &) |
MPI_Datatype | GetMpiDataType (const Vector< complex< double > > &) |
MPI_Datatype | GetMpiDataType (const Vector< long double > &) |
MPI_Datatype | GetMpiDataType (const Vector< complex< long double > > &) |
MPI_Datatype | GetMpiDataType (const bool &) |
MPI_Datatype | GetMpiDataType (const int &) |
MPI_Datatype | GetMpiDataType (const long &) |
MPI_Datatype | GetMpiDataType (const float &) |
MPI_Datatype | GetMpiDataType (const complex< float > &) |
MPI_Datatype | GetMpiDataType (const double &) |
MPI_Datatype | GetMpiDataType (const complex< double > &) |
MPI_Datatype | GetMpiDataType (const long double &) |
MPI_Datatype | GetMpiDataType (const complex< long double > &) |
template<class T > | |
int | GetRatioMpiDataType (const T &) |
template<class T > | |
int | GetRatioMpiDataType (const Vector< T > &) |
template<class T > | |
int | GetRatioMpiDataType (const complex< T > &) |
template<class T > | |
int | GetRatioMpiDataType (const Vector< complex< T > > &) |
template<class T > | |
int | GetRatioMpiDataType (complex< T > &) |
template<class T1 , class Allocator1 > | |
T1 | DotProdVector (const DistributedVector< T1, Allocator1 > &X, const DistributedVector< T1, Allocator1 > &Y) |
computation of scalar product X.Y More... | |
template<class T1 , class Allocator1 > | |
T1 | DotProdConjVector (const DistributedVector< T1, Allocator1 > &X, const DistributedVector< T1, Allocator1 > &Y) |
computation of scalar product X'.Y More... | |
template<class T , class Allocator > | |
T | Norm2 (const DistributedVector< complex< T >, Allocator > &x) |
returns euclidian norm of vector x | |
template<class T , class Allocator > | |
T | Norm2 (const DistributedVector< T, Allocator > &x) |
returns euclidian norm of vector x | |
template<class T > | |
T | minComplex (const T &x, const T &y) |
minimum for real numbers | |
template<class T > | |
complex< T > | minComplex (const complex< T > &x, const complex< T > &y) |
minimum for complex numbers | |
template<class T > | |
T | maxComplex (const T &x, const T &y) |
maximum for real numbers | |
template<class T > | |
complex< T > | maxComplex (const complex< T > &x, const complex< T > &y) |
maximum for complex numbers | |
void | ExtractDistributedSharedNumbers (const IVect &MatchingNumber_Subdomain, const Vector< IVect > &MatchingDofOrig_Subdomain, const Vector< bool > &is_local, int nb_ddl_local, IVect &MatchingNumber_Local, Vector< IVect > &MatchingDof_Local) |
extracts MatchingNumber_Local / MatchingDof_Local from arrays MatchingNumber_Subdomain / MatchingDofOrig_Subdomain | |
void | AssembleVectorMin (Vector< int > &X, Vector< int > &Xproc, const IVect &ProcNumber, const Vector< IVect > &DofNumber, const MPI_Comm &comm, int Nvol, int nb_u, int tag) |
assembles minimums of two vectors | |
template<class T > | |
void | AssembleVector (Vector< T > &X, const MPI_Op &oper, const IVect &ProcNumber, const Vector< IVect > &DofNumber, const MPI_Comm &comm, int Nvol, int nb_u, int tag) |
assembles a distributed vector (some rows are shared between processors) More... | |
template<class T > | |
void | ExchangeVector (Vector< T > &X, const IVect &ProcNumber, const Vector< IVect > &DofNumber, const MPI_Comm &comm, int Nvol, int nb_u, int tag) |
assembles a distributed vector (some rows are shared between processors) More... | |
template<class T , class Treal > | |
void | ExchangeRelaxVector (Vector< T > &X, const Treal &omega, int proc, const IVect &ProcNumber, const Vector< IVect > &DofNumber, const MPI_Comm &comm, int Nvol, int nb_u, int tag) |
exchanges a distributed vector (some rows are shared between processors) only values on shared rows are exchanged More... | |
template<class T > | |
T | DotProd (const DistributedVector< T > &X, const DistributedVector< T > &Y) |
template<class T > | |
complex< T > | DotProd (const DistributedVector< complex< T > > &X, const DistributedVector< T > &Y) |
template<class T > | |
complex< T > | DotProd (const DistributedVector< T > &X, const DistributedVector< complex< T > > &Y) |
template<class T > | |
T | DotProdConj (const DistributedVector< T > &X, const DistributedVector< T > &Y) |
template<class T > | |
complex< T > | DotProdConj (const DistributedVector< complex< T > > &X, const DistributedVector< complex< T > > &Y) |
template<class T > | |
complex< T > | DotProdConj (const DistributedVector< complex< T > > &X, const DistributedVector< T > &Y) |
template<class T > | |
complex< T > | DotProdConj (const DistributedVector< T > &X, const DistributedVector< complex< T > > &Y) |
template<class T , class Storage , class Allocator > | |
long | PartitionQuickSort (long m, long n, Vector< T, Storage, Allocator > &t) |
Intermediary function used for quick sort algorithm. | |
template<class T , class Storage , class Allocator > | |
void | QuickSort (long m, long n, Vector< T, Storage, Allocator > &t) |
Vector t is sorted by using QuickSort algorithm. More... | |
template<class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 > | |
long | PartitionQuickSort (long m, long n, Vector< T1, Storage1, Allocator1 > &t1, Vector< T2, Storage2, Allocator2 > &t2) |
Intermediary function used for quick sort algorithm. | |
template<class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 > | |
void | QuickSort (long m, long n, Vector< T1, Storage1, Allocator1 > &t1, Vector< T2, Storage2, Allocator2 > &t2) |
Vector t1 is sorted by using QuickSort algorithm. More... | |
template<class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 , class Storage3 , class Allocator3 > | |
long | PartitionQuickSort (long m, long n, Vector< T1, Storage1, Allocator1 > &t1, Vector< T2, Storage2, Allocator2 > &t2, Vector< T3, Storage3, Allocator3 > &t3) |
Intermediary function used for quick sort algorithm. | |
template<class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 , class Storage3 , class Allocator3 > | |
void | QuickSort (long m, long n, Vector< T1, Storage1, Allocator1 > &t1, Vector< T2, Storage2, Allocator2 > &t2, Vector< T3, Storage3, Allocator3 > &t3) |
Vector t1 is sorted by using QuickSort algorithm. More... | |
template<class T , class Storage , class Allocator > | |
void | MergeSort (long m, long n, Vector< T, Storage, Allocator > &tab1) |
Vector tab1 is sorted by using MergeSort algorithm. More... | |
template<class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 > | |
void | MergeSort (long m, long n, Vector< T1, Storage1, Allocator1 > &tab1, Vector< T2, Storage2, Allocator2 > &tab2) |
Vector tab1 is sorted by using MergeSort algorithm. More... | |
template<class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 , class Storage3 , class Allocator3 > | |
void | MergeSort (long m, long n, Vector< T1, Storage1, Allocator1 > &tab1, Vector< T2, Storage2, Allocator2 > &tab2, Vector< T3, Storage3, Allocator3 > &tab3) |
Vector tab1 is sorted by using MergeSort algorithm. More... | |
template<class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 > | |
void | Assemble (long &n, Vector< int, Storage1, Allocator1 > &Node, Vector< T2, Storage2, Allocator2 > &Vect) |
Assembles a sparse vector. More... | |
template<class T , class Storage1 , class Allocator1 > | |
void | Assemble (long &n, Vector< T, Storage1, Allocator1 > &Node) |
Sorts and removes duplicate entries of a vector. More... | |
template<class T , class Storage1 , class Allocator1 > | |
void | Assemble (Vector< T, Storage1, Allocator1 > &Node) |
Sorts and removes duplicate entries of a vector. | |
template<class T , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 > | |
void | RemoveDuplicate (long &n, Vector< T, Storage1, Allocator1 > &Node, Vector< T2, Storage2, Allocator2 > &Node2) |
Sorts and removes duplicate entries of a vector. More... | |
template<class T , class Storage1 , class Allocator1 > | |
void | RemoveDuplicate (long &n, Vector< T, Storage1, Allocator1 > &Node) |
Sorts and removes duplicate entries of a vector. | |
template<class T , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 > | |
void | RemoveDuplicate (Vector< T, Storage1, Allocator1 > &Node, Vector< T2, Storage2, Allocator2 > &Node2) |
Sorts and removes duplicate entries of a vector. More... | |
template<class T , class Storage1 , class Allocator1 > | |
void | RemoveDuplicate (Vector< T, Storage1, Allocator1 > &Node) |
Sorts and removes duplicate entries of a vector. | |
template<class T , class Storage , class Allocator > | |
void | Sort (long m, long n, Vector< T, Storage, Allocator > &V) |
Sorts vector V between a start position and an end position. | |
template<class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 > | |
void | Sort (long m, long n, Vector< T1, Storage1, Allocator1 > &V, Vector< T2, Storage2, Allocator2 > &V2) |
Sorts vector V between a start position and an end position. More... | |
template<class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 , class Storage3 , class Allocator3 > | |
void | Sort (long m, long n, Vector< T1, Storage1, Allocator1 > &V, Vector< T2, Storage2, Allocator2 > &V2, Vector< T3, Storage3, Allocator3 > &V3) |
Sorts vector V between a start position and an end position. More... | |
template<class T , class Storage , class Allocator > | |
void | Sort (long n, Vector< T, Storage, Allocator > &V) |
Sorts the n first elements of V. | |
template<class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 > | |
void | Sort (long n, Vector< T1, Storage1, Allocator1 > &V, Vector< T2, Storage2, Allocator2 > &V2) |
Sorts the n first elements of V. More... | |
template<class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 , class Storage3 , class Allocator3 > | |
void | Sort (long n, Vector< T1, Storage1, Allocator1 > &V, Vector< T2, Storage2, Allocator2 > &V2, Vector< T3, Storage3, Allocator3 > &V3) |
Sorts the n first elements of V. More... | |
template<class T , class Storage , class Allocator > | |
void | Sort (Vector< T, Storage, Allocator > &V) |
Sorts vector V. | |
template<class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 > | |
void | Sort (Vector< T1, Storage1, Allocator1 > &V, Vector< T2, Storage2, Allocator2 > &V2) |
Sorts vector V. More... | |
template<class T1 , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 , class T3 , class Storage3 , class Allocator3 > | |
void | Sort (Vector< T1, Storage1, Allocator1 > &V, Vector< T2, Storage2, Allocator2 > &V2, Vector< T3, Storage3, Allocator3 > &V3) |
Sorts vector V. More... | |
template<class T , class Storage , class Allocator > | |
bool | HasElement (const Vector< T, Storage, Allocator > &X, const T &a) |
Whether X contains element a. | |
template<class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 > | |
void | Assemble (int &n, Vector< int, Storage1, Allocator1 > &Node, Vector< T2, Storage2, Allocator2 > &Vect) |
template<class T , class Storage1 , class Allocator1 > | |
void | Assemble (int &n, Vector< T, Storage1, Allocator1 > &Node) |
template<class T , class Storage1 , class Allocator1 , class T2 , class Storage2 , class Allocator2 > | |
void | RemoveDuplicate (int &n, Vector< T, Storage1, Allocator1 > &Node, Vector< T2, Storage2, Allocator2 > &Node2) |
template<class T , class Storage1 , class Allocator1 > | |
void | RemoveDuplicate (int &n, Vector< T, Storage1, Allocator1 > &Node) |
template<class T , template< class U > class Allocator> | |
ostream & | operator<< (ostream &out, const Vector< FloatDouble, DenseSparseCollection, Allocator< T > > &V) |
operator<< overloaded for vector collections. More... | |
template<class T , class Allocator > | |
ostream & | operator<< (ostream &out, const Vector< T, PETScSeq, Allocator > &V) |
operator<< overloaded for vectors. More... | |
template<class T , class Allocator > | |
ostream & | operator<< (ostream &out, const Vector< T, PETScPar, Allocator > &V) |
operator<< overloaded for vectors. More... | |
template<class T , class Allocator > | |
ostream & | operator<< (ostream &out, const Vector< T, VectSparse, Allocator > &V) |
operator<< overloaded for sparse vectors. More... | |
template<class T > | |
int | IntersectionEdges (const TinyVector< T, 2 > &pointA, const TinyVector< T, 2 > &pointB, const TinyVector< T, 2 > &pt1, const TinyVector< T, 2 > &pt2, TinyVector< T, 2 > &res, const T &threshold) |
intersection of edges [pointA,pointB] and [pt1,pt2] More... | |
template<class T > | |
int | IntersectionDroites (const TinyVector< T, 2 > &pointA, const TinyVector< T, 2 > &pointB, const TinyVector< T, 2 > &pt1, const TinyVector< T, 2 > &pt2, TinyVector< T, 2 > &res, const T &threshold) |
intersection of lines [pointA,pointB] and [pt1,pt2] More... | |
template<class T > | |
void | GetVectorPlane (const TinyVector< T, 3 > &normale, TinyVector< T, 3 > &u1, TinyVector< T, 3 > &u2) |
constructing tangent vectors u1 and u2, from normale to a plane | |
template<int m> | |
bool | operator== (const TinyVector< int, m > &u, const TinyVector< int, m > &v) |
returns true if u == v, false otherwise | |
template<int m> | |
bool | operator!= (const TinyVector< int, m > &u, const TinyVector< int, m > &v) |
returns false if u == v, true otherwise | |
template<int m> | |
bool | operator<= (const TinyVector< int, m > &u, const TinyVector< int, m > &v) |
returns true if u <= v, false otherwise | |
template<int m> | |
bool | operator< (const TinyVector< int, m > &u, const TinyVector< int, m > &v) |
returns *this < u | |
template<int m> | |
bool | operator>= (const TinyVector< int, m > &u, const TinyVector< int, m > &v) |
returns true if u >= v, false otherwise | |
template<int m> | |
bool | operator> (const TinyVector< int, m > &u, const TinyVector< int, m > &v) |
returns true if u > v, false otherwise | |
template<class T , int m, class E1 , class E2 > | |
bool | operator== (const TinyVectorExpression< T, m, E1 > &u, const TinyVectorExpression< T, m, E2 > &v) |
returns true if u == v, false otherwise | |
template<class T , int m, class E1 , class E2 > | |
bool | operator!= (const TinyVectorExpression< T, m, E1 > &u, const TinyVectorExpression< T, m, E2 > &v) |
returns false if u == v, true otherwise | |
template<class T , int m, class E1 , class E2 > | |
bool | operator<= (const TinyVectorExpression< T, m, E1 > &u, const TinyVectorExpression< T, m, E2 > &v) |
returns true if u <= v, false otherwise | |
template<class T , int m, class E1 , class E2 > | |
bool | operator< (const TinyVectorExpression< T, m, E1 > &u, const TinyVectorExpression< T, m, E2 > &v) |
returns *this < u | |
template<class T , int m, class E1 , class E2 > | |
bool | operator>= (const TinyVectorExpression< int, m, E1 > &u, const TinyVectorExpression< int, m, E2 > &v) |
template<class T , int m, class E1 , class E2 > | |
bool | operator> (const TinyVectorExpression< T, m, E1 > &u, const TinyVectorExpression< T, m, E2 > &v) |
returns true if u > v, false otherwise | |
template<class T , int m> | |
ostream & | operator<< (ostream &out, const TinyVector< T, m > &V) |
displays V | |
template<class T , int m> | |
istream & | operator>> (istream &in, TinyVector< T, m > &V) |
reads V | |
template<class T , int m, class E1 , class E2 > | |
T | DotProd (const TinyVectorExpression< T, m, E1 > &u, const TinyVectorExpression< T, m, E2 > &v) |
returns scalar product (u,v) | |
template<class T , int m, class E1 , class E2 > | |
complex< T > | DotProd (const TinyVectorExpression< T, m, E1 > &u, const TinyVectorExpression< complex< T >, m, E2 > &v) |
returns scalar product (u,v) | |
template<class T , int m, class E1 , class E2 > | |
complex< T > | DotProd (const TinyVectorExpression< complex< T >, m, E1 > &u, const TinyVectorExpression< T, m, E2 > &v) |
returns (u,v) where u is complex and v real | |
template<class T , int m, class E1 , class E2 > | |
complex< T > | DotProdConj (const TinyVectorExpression< complex< T >, m, E1 > &u, const TinyVectorExpression< complex< T >, m, E2 > &v) |
returns (conj(u), v) | |
template<class T , int m, class E > | |
ClassComplexType< T >::Treal | AbsSquare (const TinyVectorExpression< T, m, E > &u) |
returns || u ||^2 | |
template<class T , int m, class E > | |
ClassComplexType< T >::Treal | Norm1 (const TinyVectorExpression< T, m, E > &u) |
returns || u ||_1 | |
template<class T , int m, class E > | |
ClassComplexType< T >::Treal | NormInf (const TinyVectorExpression< T, m, E > &u) |
returns || u ||_\infty | |
template<class T , int m> | |
T | Distance (const TinyVector< T, m > &u, const TinyVector< T, m > &v) |
returns || u-v || | |
template<class T , int m, class E > | |
ClassComplexType< T >::Treal | Norm2 (const TinyVectorExpression< T, m, E > &p) |
returns || v ||_2 | |
template<class T0 , class T1 , class T2 , int m> | |
void | Add (const TinyVector< T0, m > &x, const TinyVector< T1, m > &y, TinyVector< T2, m > &z) |
z = x + y | |
template<class T0 , class T1 , class T2 , int m> | |
void | Add (const T0 &alpha, const TinyVector< T1, m > &y, TinyVector< T2, m > &x) |
x = x + alpha*y | |
template<class T0 , class T , int m> | |
void | Mlt (const T0 &alpha, TinyVector< T, m > &p) |
x = alpha * x | |
template<int p, int m, class T0 , class T1 > | |
void | ExtractVector (const Vector< Vector< TinyVector< T0, p > > > &u, int j, int k, int offset, TinyVector< T1, m > &v) |
v(:) = u(offset+:)(j)(k) | |
template<int m, class T0 , class T1 > | |
void | ExtractVector (const Vector< Vector< T0 > > &u, int j, int offset, TinyVector< T1, m > &v) |
v(:) = u(offset+:)(j) | |
template<int m, class T0 , class T1 > | |
void | CopyVector (const TinyVector< T1, m > &v, int j, int offset, Vector< Vector< T0 > > &u) |
u(offset+:)(j) = v(:) | |
template<int m, class T0 , class T1 > | |
void | ExtractVector (const Vector< T0 > &Vh, const IVect &row_num, int nb, TinyVector< T1, m > &tmp) |
tmp = Vh(row_num(nb+:)) | |
template<int m, class T0 , class T1 > | |
void | ExtractVector (const TinyVector< T1, m > &tmp, const IVect &row_num, int nb, Vector< T0 > &Vh) |
Vh(row_num(nb+:)) = tmp. | |
template<int m, class T0 , class T1 > | |
void | AddVector (const T0 &alpha, const TinyVector< T1, m > &tmp, const IVect &row_num, int nb, Vector< T0 > &Vh) |
Vh(row_num(nb+:)) += alpha * tmp. | |
template<int m, class T0 , class T1 > | |
void | ExtractVectorConj (const Vector< T0 > &Vh, const IVect &row_num, int nb, TinyVector< T1, m > &tmp) |
tmp = conj(Vh(row_num(nb+:))) | |
template<int m, class T0 , class T1 > | |
void | ExtractVectorConj (const TinyVector< T1, m > &tmp, const IVect &row_num, int nb, Vector< T0 > &Vh) |
Vh(row_num(nb+:)) = conj(tmp) | |
template<int m, class T0 , class T1 > | |
void | AddVectorConj (const T0 &alpha, const TinyVector< T1, m > &tmp, const IVect &row_num, int nb, Vector< T0 > &Vh) |
Vh(row_num(nb+:)) += alpha * conj(tmp) | |
template<int m, class T0 , class T1 > | |
void | CopyVector (const TinyVector< Vector< T0 >, m > &uvec, int j, TinyVector< T1, m > &u) |
u(:) = uvec(:)(j) | |
template<int m, class T0 , class T1 > | |
void | CopyVector (const TinyVector< T1, m > &u, int j, TinyVector< Vector< T0 >, m > &uvec) |
uvec(:)(j) = u(:) | |
template<int m, class T0 , class T1 > | |
void | CopyVector (const TinyVector< T1, m > &u, int j, Vector< T0 > &uvec) |
uvec(m*j + :) = u(:) | |
template<int m, class T0 , class T1 > | |
void | CopyVector (const Vector< T0 > &uvec, int j, TinyVector< T1, m > &u) |
u(:) = uvec(m*j + :) | |
template<int m, class T > | |
void | CopyVector (const Vector< complex< T > > &Vh, int j, TinyVector< T, m > &vr, TinyVector< T, m > &vi) |
vr(:) = real(Vh(m*j + :)) and vi(:) = imag(Vh(m*j + :)) | |
template<int m, class T0 , class T1 > | |
void | AddVector (const TinyVector< T1, m > &u, int offset, Vector< T0 > &uvec) |
uvec(offset + :) += u(:) | |
template<int m, class T0 , class T1 > | |
void | AddVector (const Vector< T0 > &uvec, int offset, TinyVector< T1, m > &u) |
u(:) += uvec(offset + :) | |
template<int m, class T0 , class T1 > | |
void | ExtractVector (const TinyVector< T1, m > &u, int offset, Vector< T0 > &uvec) |
uvec(offset + :) = u(:) | |
template<int m, class T0 , class T1 > | |
void | ExtractVector (const Vector< T0 > &uvec, int offset, TinyVector< T1, m > &u) |
u(:) = uvec(offset + :) | |
template<class T0 , int m> | |
void | SymmetrizePointPlane (const TinyVector< T0, m > &u, const TinyVector< T0, m > &normale, const T0 &d, TinyVector< T0, m > &v) |
Applies the symmetry with respect to the hyperplane a x + b y + c z + .. + d = 0 v = S(u) where S is this symmetry, normale contains (a, b, c, ...) | |
template<class T , int m> | |
void | UpdateMinimum (const TinyVector< T, m > &u, TinyVector< T, m > &v) |
sets v = min(v, u) elementwise | |
template<class T , int m> | |
void | UpdateMaximum (const TinyVector< T, m > &u, TinyVector< T, m > &v) |
sets v = max(v, u) elementwise | |
template<int m, class T0 , class T1 > | |
void | MltVector (const T1 &alpha, int j, TinyVector< Vector< T0 >, m > &uvec) |
uvec(:)(j) *= alpha | |
template<class T , int p> | |
void | Mlt (const T &alpha, Vector< TinyVector< T, p > > &X) |
template<class T , class Prop , class Storage , int p> | |
void | Mlt (const SeldonTranspose &, const Matrix< T, Prop, Storage > &A, const Vector< TinyVector< T, p > > &x, Vector< TinyVector< T, p > > &y) |
template<class T , class Prop , class Storage , int p> | |
void | Mlt (const Matrix< T, Prop, Storage > &A, const Vector< TinyVector< T, p > > &x, Vector< TinyVector< T, p > > &y) |
template<class T1 , class T2 , class T3 > | |
void | TimesProd (const TinyVector< T1, 3 > &u, const TinyVector< T2, 3 > &v, TinyVector< T3, 3 > &res) |
cross product res = u^v where u,v and res are vectors | |
template<class T > | |
void | ForceZeroVdotN (const TinyVector< T, 2 > &normale, TinyVector< T, 2 > &v0) |
modifies v0 such that v0 \cdot normale = 0 | |
template<class T > | |
void | ForceZeroVdotN (const TinyVector< T, 3 > &normale, TinyVector< T, 3 > &v0) |
modifies v0 such that v0 \cdot normale = 0 | |
template<class T > | |
bool | PointInsideBoundingBox (const TinyVector< T, 2 > &x, const TinyVector< TinyVector< T, 2 >, 2 > &s) |
returns true if x is inside the bounding box s | |
template<class T > | |
bool | PointInsideBoundingBox (const TinyVector< T, 3 > &x, const TinyVector< TinyVector< T, 3 >, 2 > &s) |
returns true if x is inside the bounding box s | |
template<class T0 , class T1 , class T2 , class T3 > | |
void | GenerateSymPts (const TinyVector< T0, 3 > &u, TinyVector< T1, 3 > &v, TinyVector< T2, 3 > &w, TinyVector< T3, 3 > &t) |
generates four points respecting the symmetry of the reference pyramid with one point | |
template<class T > | |
T | Determinant (const TinyVector< T, 3 > &u, const TinyVector< T, 3 > &v, const TinyVector< T, 3 > &w) |
res = (u^v) . w = det(u,v,w) where u,v and w are vectors | |
void | FillZero (double &X) |
Sets x to 0. | |
void | FillZero (complex< double > &X) |
Sets x to 0. | |
void | FillZero (int &X) |
Sets x to 0. | |
void | FillZero (float &X) |
Sets x to 0. | |
void | FillZero (complex< float > &X) |
Sets x to 0. | |
void | FillZero (bool &X) |
Sets x to 0. | |
template<class T , class Storage , class Allocator > | |
void | FillZero (Vector< T, Storage, Allocator > &X) |
fills all the elements in vector X with 0 | |
template<class T , class Prop , class Storage , class Allocator > | |
void | FillZero (Matrix< T, Prop, Storage, Allocator > &X) |
fills all the elements in vector X with 0 | |
template<class T , class Prop , class Allocator > | |
void | FillZero (Matrix< T, Prop, RowSparse, Allocator > &X) |
Sets x to 0. | |
template<class T , int m> | |
void | FillZero (TinyVector< T, m > &X) |
Sets x to 0. | |
template<class T > | |
void | FillZero (T &x) |
Sets x to 0. | |
template<class T > | |
void | FillZero (complex< T > &x) |
Sets x to 0. | |
template<class T , int p> | |
void | SetComplexZero (TinyVector< T, p > &x) |
template<class T > | |
bool | IsComplexZero (const T &x) |
template<class T > | |
bool | IsComplexZero (const complex< T > &x) |
template<class T , int m, class E1 , class E2 > | |
const TinyVectorSum< T, m, E1, E2 > | operator+ (const TinyVectorExpression< T, m, E1 > &u, const TinyVectorExpression< T, m, E2 > &v) |
returns u+v | |
template<class T , int m, class E1 , class E2 > | |
const TinyVectorSum< complex< T >, m, E1, E2 > | operator+ (const TinyVectorExpression< complex< T >, m, E1 > &u, const TinyVectorExpression< T, m, E2 > &v) |
returns u+v | |
template<class T , int m, class E1 , class E2 > | |
const TinyVectorSum< complex< T >, m, E1, E2 > | operator+ (const TinyVectorExpression< T, m, E1 > &u, const TinyVectorExpression< complex< T >, m, E2 > &v) |
returns u+v | |
template<class T , int m, class E1 , class E2 > | |
const TinyVectorDifference< T, m, E1, E2 > | operator- (const TinyVectorExpression< T, m, E1 > &u, const TinyVectorExpression< T, m, E2 > &v) |
returns u-v | |
template<class T , int m, class E1 , class E2 > | |
const TinyVectorDifference< complex< T >, m, E1, E2 > | operator- (const TinyVectorExpression< complex< T >, m, E1 > &u, const TinyVectorExpression< T, m, E2 > &v) |
returns u-v | |
template<class T , int m, class E1 , class E2 > | |
const TinyVectorDifference< complex< T >, m, E1, E2 > | operator- (const TinyVectorExpression< T, m, E1 > &u, const TinyVectorExpression< complex< T >, m, E2 > &v) |
returns u-v | |
template<class T , int m, class E1 , class E2 > | |
const TinyVectorProduct< T, m, E1, E2 > | operator* (const TinyVectorExpression< T, m, E1 > &u, const TinyVectorExpression< T, m, E2 > &v) |
returns u*v element-wise | |
template<class T , int m, class E1 , class E2 > | |
const TinyVectorProduct< complex< T >, m, E1, E2 > | operator* (const TinyVectorExpression< complex< T >, m, E1 > &u, const TinyVectorExpression< T, m, E2 > &v) |
returns u*v element-wise | |
template<class T , int m, class E1 , class E2 > | |
const TinyVectorProduct< complex< T >, m, E1, E2 > | operator* (const TinyVectorExpression< T, m, E1 > &u, const TinyVectorExpression< complex< T >, m, E2 > &v) |
returns u*v element-wise | |
template<class T , int m, class E1 , class E2 > | |
const TinyVectorDivision< T, m, E1, E2 > | operator/ (const TinyVectorExpression< T, m, E1 > &u, const TinyVectorExpression< T, m, E2 > &v) |
returns u/v element-wise | |
template<class T , int m, class E1 , class E2 > | |
const TinyVectorDivision< complex< T >, m, E1, E2 > | operator/ (const TinyVectorExpression< complex< T >, m, E1 > &u, const TinyVectorExpression< T, m, E2 > &v) |
returns u/v element-wise | |
template<class T , int m, class E1 , class E2 > | |
const TinyVectorDivision< complex< T >, m, E1, E2 > | operator/ (const TinyVectorExpression< T, m, E1 > &u, const TinyVectorExpression< complex< T >, m, E2 > &v) |
returns u/v element-wise | |
template<class T , int m, class E > | |
const TinyVectorScaled< T, m, T, E > | operator* (const T &alpha, const TinyVectorExpression< T, m, E > &u) |
returns alpha*u | |
template<class T , int m, class E > | |
const TinyVectorScaled< complex< T >, m, complex< T >, E > | operator* (const complex< T > &alpha, const TinyVectorExpression< T, m, E > &u) |
returns alpha*u | |
template<class T , int m, class E > | |
const TinyVectorScaled< complex< T >, m, T, E > | operator* (const T &alpha, const TinyVectorExpression< complex< T >, m, E > &u) |
returns alpha*u | |
template<class T , int m, class E > | |
const TinyVectorScaled< T, m, T, E > | operator* (const TinyVectorExpression< T, m, E > &u, const T &alpha) |
returns u*alpha | |
template<class T , int m, class E > | |
const TinyVectorScaled< complex< T >, m, complex< T >, E > | operator* (const TinyVectorExpression< T, m, E > &u, const complex< T > &alpha) |
returns u*alpha | |
template<class T , int m, class E > | |
const TinyVectorScaled< complex< T >, m, T, E > | operator* (const TinyVectorExpression< complex< T >, m, E > &u, const T &alpha) |
returns u*alpha | |
template<class T , int m, class E > | |
const TinyVectorScalDiv< T, m, T, E > | operator/ (const T &alpha, const TinyVectorExpression< T, m, E > &u) |
returns alpha / u | |
template<class T , int m, class E > | |
const TinyVectorScalDiv< complex< T >, m, complex< T >, E > | operator/ (const complex< T > &alpha, const TinyVectorExpression< T, m, E > &u) |
returns alpha / u | |
template<class T , int m, class E > | |
const TinyVectorScalDiv< complex< T >, m, T, E > | operator/ (const T &alpha, const TinyVectorExpression< complex< T >, m, E > &u) |
returns alpha / u | |
template<class T , int m, class E > | |
const TinyVectorScaled< T, m, T, E > | operator/ (const TinyVectorExpression< T, m, E > &u, const T &alpha) |
returns u / alpha | |
template<class T , int m, class E > | |
const TinyVectorScaled< complex< T >, m, complex< T >, E > | operator/ (const TinyVectorExpression< T, m, E > &u, const complex< T > &alpha) |
returns u / alpha | |
template<class T , int m, class E > | |
const TinyVectorScaled< complex< T >, m, T, E > | operator/ (const TinyVectorExpression< complex< T >, m, E > &u, const T &alpha) |
returns u / alpha | |
template<class T , int m, class E > | |
const TinyVectorScalSum< T, m, T, E > | operator+ (const T &alpha, const TinyVectorExpression< T, m, E > &u) |
returns alpha + u | |
template<class T , int m, class E > | |
const TinyVectorScalSum< complex< T >, m, complex< T >, E > | operator+ (const complex< T > &alpha, const TinyVectorExpression< T, m, E > &u) |
returns alpha + u | |
template<class T , int m, class E > | |
const TinyVectorScalSum< complex< T >, m, T, E > | operator+ (const T &alpha, const TinyVectorExpression< complex< T >, m, E > &u) |
returns alpha + u | |
template<class T , int m, class E > | |
const TinyVectorScalSum< T, m, T, E > | operator+ (const TinyVectorExpression< T, m, E > &u, const T &alpha) |
returns u + alpha | |
template<class T , int m, class E > | |
const TinyVectorScalSum< complex< T >, m, complex< T >, E > | operator+ (const TinyVectorExpression< T, m, E > &u, const complex< T > &alpha) |
returns u + alpha | |
template<class T , int m, class E > | |
const TinyVectorScalSum< complex< T >, m, T, E > | operator+ (const TinyVectorExpression< complex< T >, m, E > &u, const T &alpha) |
returns u + alpha | |
template<class T , int m, class E > | |
const TinyVectorScalSum< T, m, T, E > | operator- (const TinyVectorExpression< T, m, E > &u, const T &alpha) |
returns u - alpha | |
template<class T , int m, class E > | |
const TinyVectorScalSum< complex< T >, m, complex< T >, E > | operator- (const TinyVectorExpression< T, m, E > &u, const complex< T > &alpha) |
returns u - alpha | |
template<class T , int m, class E > | |
const TinyVectorScalSum< complex< T >, m, T, E > | operator- (const TinyVectorExpression< complex< T >, m, E > &u, const T &alpha) |
returns u - alpha | |
template<class T , int m, class E > | |
const TinyVectorScalDiff< T, m, T, E > | operator- (const T &alpha, const TinyVectorExpression< T, m, E > &u) |
returns alpha - u | |
template<class T , int m, class E > | |
const TinyVectorScalDiff< complex< T >, m, complex< T >, E > | operator- (const complex< T > &alpha, const TinyVectorExpression< T, m, E > &u) |
returns alpha - u | |
template<class T , int m, class E > | |
const TinyVectorScalDiff< complex< T >, m, T, E > | operator- (const T &alpha, const TinyVectorExpression< complex< T >, m, E > &u) |
returns alpha - u | |
template<class T , int m, class E > | |
const TinyVectorOpposite< T, m, E > | operator- (const TinyVectorExpression< T, m, E > &u) |
returns -u | |
template<class T , int m, class E1 , class E2 > | |
bool | operator>= (const TinyVectorExpression< T, m, E1 > &u, const TinyVectorExpression< T, m, E2 > &v) |
returns true if u >= v, false otherwise | |
template<class T1 , class T2 > | |
T1 | TimesProd (const TinyVector< T1, 2 > &u, const TinyVector< T2, 2 > &v) |
cross product for 2-D vector | |
template<class T , class Prop , class Allocator > | |
void | FillZero (Matrix< T, Prop, ArrayRowSparse, Allocator > &X) |
Sets x to 0. | |
template<class T , class Storage , class Allocator > | |
ostream & | operator<< (ostream &out, const Vector< T, Storage, Allocator > &V) |
operator<< overloaded for vectors. More... | |
template<class T , class Allocator > | |
ostream & | operator<< (ostream &out, const Vector< T, Collection, Allocator > &V) |
operator<< overloaded for vector collections. More... | |
template<class T , class E1 , class E2 > | |
const VectorSum< T, E1, E2 > | operator+ (const VectorExpression< T, E1 > &u, const VectorExpression< T, E2 > &v) |
returns u+v | |
template<class T , class E1 , class E2 > | |
const VectorSum< complex< T >, E1, E2 > | operator+ (const VectorExpression< complex< T >, E1 > &u, const VectorExpression< T, E2 > &v) |
returns u+v | |
template<class T , class E1 , class E2 > | |
const VectorSum< complex< T >, E1, E2 > | operator+ (const VectorExpression< T, E1 > &u, const VectorExpression< complex< T >, E2 > &v) |
returns u+v | |
template<class T , class E1 , class E2 > | |
const VectorDifference< T, E1, E2 > | operator- (const VectorExpression< T, E1 > &u, const VectorExpression< T, E2 > &v) |
returns u-v | |
template<class T , class E1 , class E2 > | |
const VectorDifference< complex< T >, E1, E2 > | operator- (const VectorExpression< complex< T >, E1 > &u, const VectorExpression< T, E2 > &v) |
returns u-v | |
template<class T , class E1 , class E2 > | |
const VectorDifference< complex< T >, E1, E2 > | operator- (const VectorExpression< T, E1 > &u, const VectorExpression< complex< T >, E2 > &v) |
returns u-v | |
template<class T , class E1 , class E2 > | |
const VectorProduct< T, E1, E2 > | operator* (const VectorExpression< T, E1 > &u, const VectorExpression< T, E2 > &v) |
returns u*v element-wise | |
template<class T , class E1 , class E2 > | |
const VectorProduct< complex< T >, E1, E2 > | operator* (const VectorExpression< complex< T >, E1 > &u, const VectorExpression< T, E2 > &v) |
returns u*v element-wise | |
template<class T , class E1 , class E2 > | |
const VectorProduct< complex< T >, E1, E2 > | operator* (const VectorExpression< T, E1 > &u, const VectorExpression< complex< T >, E2 > &v) |
returns u*v element-wise | |
template<class T , class E1 , class E2 > | |
const VectorDivision< T, E1, E2 > | operator/ (const VectorExpression< T, E1 > &u, const VectorExpression< T, E2 > &v) |
returns u/v element-wise | |
template<class T , class E1 , class E2 > | |
const VectorDivision< complex< T >, E1, E2 > | operator/ (const VectorExpression< complex< T >, E1 > &u, const VectorExpression< T, E2 > &v) |
returns u/v element-wise | |
template<class T , class E1 , class E2 > | |
const VectorDivision< complex< T >, E1, E2 > | operator/ (const VectorExpression< T, E1 > &u, const VectorExpression< complex< T >, E2 > &v) |
returns u/v element-wise | |
template<class T , class E > | |
const VectorScaled< T, T, E > | operator* (const T &alpha, const VectorExpression< T, E > &u) |
returns alpha*u | |
template<class T , class E > | |
const VectorScaled< complex< T >, complex< T >, E > | operator* (const complex< T > &alpha, const VectorExpression< T, E > &u) |
returns alpha*u | |
template<class T , class E > | |
const VectorScaled< complex< T >, T, E > | operator* (const T &alpha, const VectorExpression< complex< T >, E > &u) |
returns alpha*u | |
template<class T , class E > | |
const VectorScaled< T, T, E > | operator* (const VectorExpression< T, E > &u, const T &alpha) |
returns u*alpha | |
template<class T , class E > | |
const VectorScaled< complex< T >, complex< T >, E > | operator* (const VectorExpression< T, E > &u, const complex< T > &alpha) |
returns u*alpha | |
template<class T , class E > | |
const VectorScaled< complex< T >, T, E > | operator* (const VectorExpression< complex< T >, E > &u, const T &alpha) |
returns u*alpha | |
template<class T , class E > | |
const VectorScalDiv< T, T, E > | operator/ (const T &alpha, const VectorExpression< T, E > &u) |
returns alpha / u | |
template<class T , class E > | |
const VectorScalDiv< complex< T >, complex< T >, E > | operator/ (const complex< T > &alpha, const VectorExpression< T, E > &u) |
returns alpha / u | |
template<class T , class E > | |
const VectorScalDiv< complex< T >, T, E > | operator/ (const T &alpha, const VectorExpression< complex< T >, E > &u) |
returns alpha / u | |
template<class T , class E > | |
const VectorScaled< T, T, E > | operator/ (const VectorExpression< T, E > &u, const T &alpha) |
returns u / alpha | |
template<class T , class E > | |
const VectorScaled< complex< T >, complex< T >, E > | operator/ (const VectorExpression< T, E > &u, const complex< T > &alpha) |
returns u / alpha | |
template<class T , class E > | |
const VectorScaled< complex< T >, T, E > | operator/ (const VectorExpression< complex< T >, E > &u, const T &alpha) |
returns u / alpha | |
template<class T , class E > | |
const VectorScalSum< T, T, E > | operator+ (const T &alpha, const VectorExpression< T, E > &u) |
returns alpha + u | |
template<class T , class E > | |
const VectorScalSum< complex< T >, complex< T >, E > | operator+ (const complex< T > &alpha, const VectorExpression< T, E > &u) |
returns alpha + u | |
template<class T , class E > | |
const VectorScalSum< complex< T >, T, E > | operator+ (const T &alpha, const VectorExpression< complex< T >, E > &u) |
returns alpha + u | |
template<class T , class E > | |
const VectorScalSum< T, T, E > | operator+ (const VectorExpression< T, E > &u, const T &alpha) |
returns u + alpha | |
template<class T , class E > | |
const VectorScalSum< complex< T >, complex< T >, E > | operator+ (const VectorExpression< T, E > &u, const complex< T > &alpha) |
returns u + alpha | |
template<class T , class E > | |
const VectorScalSum< complex< T >, T, E > | operator+ (const VectorExpression< complex< T >, E > &u, const T &alpha) |
returns u + alpha | |
template<class T , class E > | |
const VectorScalDiff< T, T, E > | operator- (const T &alpha, const VectorExpression< T, E > &u) |
returns alpha - u | |
template<class T , class E > | |
const VectorScalDiff< complex< T >, complex< T >, E > | operator- (const complex< T > &alpha, const VectorExpression< T, E > &u) |
returns alpha - u | |
template<class T , class E > | |
const VectorScalDiff< complex< T >, T, E > | operator- (const T &alpha, const VectorExpression< complex< T >, E > &u) |
returns alpha - u | |
template<class T , class E > | |
const VectorScalSum< T, T, E > | operator- (const VectorExpression< T, E > &u, const T &alpha) |
returns u - alpha | |
template<class T , class E > | |
const VectorScalSum< complex< T >, complex< T >, E > | operator- (const VectorExpression< T, E > &u, const complex< T > &alpha) |
returns u - alpha | |
template<class T , class E > | |
const VectorScalSum< complex< T >, T, E > | operator- (const VectorExpression< complex< T >, E > &u, const T &alpha) |
returns u - alpha | |
template<class T , class E > | |
const VectorOpposite< T, E > | operator- (const VectorExpression< T, E > &u) |
returns -u | |
Variables | |
SELDON_EXTERN template class | ArpackSolver< Real_wp, Real_wp > |
SELDON_EXTERN template class | Array3D< int > |
SELDON_EXTERN template class | Array3D< float > |
SELDON_EXTERN template class | Array3D< double > |
SELDON_EXTERN template class | Array3D< complex< float > > |
SELDON_EXTERN template class | Array3D< complex< double > > |
SELDON_EXTERN template class | Array4D< Real_wp > |
SELDON_EXTERN template class | Array4D< Complex_wp > |
SELDON_EXTERN template class | Matrix_Band< Real_wp, General, BandedCol > |
SELDON_EXTERN template class | Matrix_Band< Complex_wp, General, BandedCol > |
SELDON_EXTERN template class | Matrix< Real_wp, General, BandedCol > |
SELDON_EXTERN template class | Matrix< Complex_wp, General, BandedCol > |
SELDON_EXTERN template class | Matrix_Band< Real_wp, General, ArrowCol > |
SELDON_EXTERN template class | Matrix_Band< Complex_wp, General, ArrowCol > |
SELDON_EXTERN template class | Matrix_Arrow< Real_wp, General, ArrowCol > |
SELDON_EXTERN template class | Matrix_Arrow< Complex_wp, General, ArrowCol > |
SELDON_EXTERN template class | Matrix< Real_wp, General, ArrowCol > |
SELDON_EXTERN template class | Matrix< Complex_wp, General, ArrowCol > |
SELDON_EXTERN template class | SparseCholeskySolver< Real_wp > |
SELDON_EXTERN template class | NaNAlloc< char > |
SELDON_EXTERN template class | NaNAlloc< bool > |
SELDON_EXTERN template class | NaNAlloc< unsigned > |
SELDON_EXTERN template class | NaNAlloc< int > |
SELDON_EXTERN template class | NaNAlloc< long > |
SELDON_EXTERN template class | NaNAlloc< unsigned long > |
SELDON_EXTERN template class | NaNAlloc< unsigned long long > |
SELDON_EXTERN template class | NaNAlloc< long long > |
SELDON_EXTERN template class | NaNAlloc< float > |
SELDON_EXTERN template class | NaNAlloc< double > |
SELDON_EXTERN template class | NaNAlloc< long double > |
SELDON_EXTERN template class | NaNAlloc< complex< float > > |
SELDON_EXTERN template class | NaNAlloc< complex< double > > |
SELDON_EXTERN template class | NaNAlloc< complex< long double > > |
SELDON_EXTERN template class | MallocObject< Vector< Real_wp > > |
SELDON_EXTERN template class | MallocObject< Vector< Complex_wp > > |
SELDON_EXTERN template class | MallocObject< Vector< Vector< Real_wp >, VectFull, MallocObject< Vector< Real_wp > > > > |
SELDON_EXTERN template class | MallocObject< Vector< Vector< Complex_wp >, VectFull, MallocObject< Vector< Complex_wp > > > > |
SELDON_EXTERN template class | DistributedMatrix_Base< Real_wp > |
SELDON_EXTERN template class | DistributedMatrix_Base< Complex_wp > |
SELDON_EXTERN template class | DistributedMatrix< Real_wp, General, ArrayRowSparse > |
SELDON_EXTERN template class | DistributedMatrix< Real_wp, General, RowSparse > |
SELDON_EXTERN template class | DistributedMatrix< Real_wp, Symmetric, ArrayRowSymSparse > |
SELDON_EXTERN template class | DistributedMatrix< Real_wp, Symmetric, RowSymSparse > |
SELDON_EXTERN template class | DistributedMatrix< Complex_wp, General, ArrayRowSparse > |
SELDON_EXTERN template class | DistributedMatrix< Complex_wp, General, RowSparse > |
SELDON_EXTERN template class | DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymSparse > |
SELDON_EXTERN template class | DistributedMatrix< Complex_wp, Symmetric, RowSymSparse > |
SELDON_EXTERN template class | DistributedMatrix< Complex_wp, General, ArrayRowComplexSparse > |
SELDON_EXTERN template class | DistributedMatrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > |
SELDON_EXTERN template class | DistributedMatrix< Complex_wp, General, RowComplexSparse > |
SELDON_EXTERN template class | DistributedMatrix< Complex_wp, Symmetric, RowSymComplexSparse > |
SELDON_EXTERN template class | SparseDistributedSolver< Real_wp > |
SELDON_EXTERN template class | SparseDistributedSolver< Complex_wp > |
SELDON_EXTERN template class | DistributedVector< Real_wp > |
SELDON_EXTERN template class | DistributedVector< Complex_wp > |
SELDON_EXTERN template class | GeneralEigenProblem< Real_wp > |
SELDON_EXTERN template class | GeneralEigenProblem< Complex_wp > |
SELDON_EXTERN template class | EigenProblem_Base< Real_wp > |
SELDON_EXTERN template class | EigenProblem_Base< Complex_wp > |
SELDON_EXTERN template class | VirtualEigenProblem< Real_wp, Real_wp, Real_wp > |
SELDON_EXTERN template class | VirtualEigenProblem< Complex_wp, Complex_wp, Real_wp > |
SELDON_EXTERN template class | VirtualEigenProblem< Complex_wp, Real_wp, Complex_wp > |
SELDON_EXTERN template class | VirtualEigenProblem< Complex_wp, Complex_wp, Complex_wp > |
SELDON_EXTERN template class | DenseEigenProblem< Real_wp, Real_wp, General, RowMajor, Real_wp, Symmetric, RowSymPacked > |
SELDON_EXTERN template class | DenseEigenProblem< Complex_wp, Complex_wp, General, RowMajor, Real_wp, Symmetric, RowSymPacked > |
SELDON_EXTERN template class | DenseEigenProblem< Real_wp, Real_wp, Symmetric, RowSymPacked, Real_wp, Symmetric, RowSymPacked > |
SELDON_EXTERN template class | SparseEigenProblem< Real_wp, Matrix< Real_wp, Symmetric, ArrayRowSymSparse >, Matrix< Real_wp, Symmetric, ArrayRowSymSparse > > |
SELDON_EXTERN template class | SparseEigenProblem< Complex_wp, Matrix< Complex_wp, Symmetric, ArrayRowSymSparse >, Matrix< Real_wp, Symmetric, ArrayRowSymSparse > > |
SELDON_EXTERN template class | SparseEigenProblem< Real_wp, Matrix< Real_wp, General, ArrayRowSparse >, Matrix< Real_wp, Symmetric, ArrayRowSymSparse > > |
SELDON_EXTERN template class | SparseEigenProblem< Complex_wp, Matrix< Complex_wp, General, ArrayRowSparse >, Matrix< Real_wp, Symmetric, ArrayRowSymSparse > > |
SELDON_EXTERN template class | SparseEigenProblem< Complex_wp, Matrix< Real_wp, General, ArrayRowSparse >, Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > > |
SELDON_EXTERN template class | SparseEigenProblem< Complex_wp, Matrix< Real_wp, Symmetric, ArrayRowSymSparse >, Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > > |
SELDON_EXTERN template class | SparseEigenProblem< Complex_wp, Matrix< Complex_wp, General, ArrayRowSparse >, Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > > |
SELDON_EXTERN template class | SparseEigenProblem< Complex_wp, Matrix< Complex_wp, Symmetric, ArrayRowSymSparse >, Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > > |
SELDON_EXTERN template class | SparseEigenProblem< Complex_wp, Matrix< Real_wp, General, ArrayRowSparse >, Matrix< Complex_wp, General, ArrayRowSparse > > |
SELDON_EXTERN template class | SparseEigenProblem< Complex_wp, Matrix< Real_wp, Symmetric, ArrayRowSymSparse >, Matrix< Complex_wp, General, ArrayRowSparse > > |
SELDON_EXTERN template class | SparseEigenProblem< Complex_wp, Matrix< Complex_wp, General, ArrayRowSparse >, Matrix< Complex_wp, General, ArrayRowSparse > > |
SELDON_EXTERN template class | SparseEigenProblem< Complex_wp, Matrix< Complex_wp, Symmetric, ArrayRowSymSparse >, Matrix< Complex_wp, General, ArrayRowSparse > > |
SELDON_EXTERN template class | SparseEigenProblem< Real_wp, Matrix< Real_wp, General, ArrayRowSparse >, Matrix< Real_wp, General, ArrayRowSparse > > |
SELDON_EXTERN template class | SparseEigenProblem< Real_wp, Matrix< Real_wp, Symmetric, ArrayRowSymSparse >, Matrix< Real_wp, General, ArrayRowSparse > > |
SELDON_EXTERN template class | SparseEigenProblem< Complex_wp, Matrix< Complex_wp, General, ArrayRowSparse >, Matrix< Real_wp, General, ArrayRowSparse > > |
SELDON_EXTERN template class | SparseEigenProblem< Complex_wp, Matrix< Complex_wp, Symmetric, ArrayRowSymSparse >, Matrix< Real_wp, General, ArrayRowSparse > > |
SELDON_EXTERN template class | PolynomialEigenProblem_Base< Real_wp > |
SELDON_EXTERN template class | PolynomialEigenProblem_Base< Complex_wp > |
SELDON_EXTERN template class | PolynomialEigenProblem< Real_wp > |
SELDON_EXTERN template class | PolynomialEigenProblem< Complex_wp > |
SELDON_EXTERN template class | PolynomialDenseEigenProblem< Real_wp, General, RowMajor > |
SELDON_EXTERN template class | PolynomialSparseEigenProblem< Real_wp, Matrix< Real_wp, Symmetric, ArrayRowSymSparse > > |
SELDON_EXTERN template class | PolynomialSparseEigenProblem< Complex_wp, Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > > |
SELDON_EXTERN template class | PolynomialSparseEigenProblem< Complex_wp, Matrix< Complex_wp, General, ArrayRowSparse >, Matrix< Complex_wp, General, ArrayRowSparse > > |
SELDON_EXTERN template class | HyprePreconditioner< HYPRE_Complex > |
SELDON_EXTERN template class | IlutPreconditioning< Real_wp > |
SELDON_EXTERN template class | IlutPreconditioning< Complex_wp > |
SELDON_EXTERN template class | Iteration< Real_wp > |
SELDON_EXTERN template class | Matrix_ComplexSparse< Complex_wp, General, RowComplexSparse > |
SELDON_EXTERN template class | Matrix< Complex_wp, General, RowComplexSparse > |
SELDON_EXTERN template class | Matrix_SymComplexSparse< Complex_wp, Symmetric, RowSymComplexSparse > |
SELDON_EXTERN template class | Matrix< Complex_wp, Symmetric, RowSymComplexSparse > |
SELDON_EXTERN template class | Matrix_ArrayComplexSparse< Complex_wp, General, ArrayRowComplexSparse > |
SELDON_EXTERN template class | Matrix< Complex_wp, General, ArrayRowComplexSparse > |
SELDON_EXTERN template class | Matrix_ArrayComplexSparse< Complex_wp, Symmetric, ArrayRowSymComplexSparse > |
SELDON_EXTERN template class | Matrix< Complex_wp, Symmetric, ArrayRowSymComplexSparse > |
SELDON_EXTERN template class | Matrix_Hermitian< Complex_wp, Hermitian, RowHerm > |
SELDON_EXTERN template class | Matrix< Complex_wp, Hermitian, RowHerm > |
SELDON_EXTERN template class | Matrix_Symmetric< Real_wp, Symmetric, RowSym > |
SELDON_EXTERN template class | Matrix_Symmetric< Complex_wp, Symmetric, RowSym > |
SELDON_EXTERN template class | Matrix< Real_wp, Symmetric, RowSym > |
SELDON_EXTERN template class | Matrix< Complex_wp, Symmetric, RowSym > |
SELDON_EXTERN template class | Matrix_Triangular< Real_wp, General, RowUpTriang > |
SELDON_EXTERN template class | Matrix_Triangular< Complex_wp, General, RowUpTriang > |
SELDON_EXTERN template class | Matrix_Triangular< Real_wp, General, RowLoTriang > |
SELDON_EXTERN template class | Matrix_Triangular< Complex_wp, General, RowLoTriang > |
SELDON_EXTERN template class | Matrix< Real_wp, General, RowUpTriang > |
SELDON_EXTERN template class | Matrix< Complex_wp, General, RowUpTriang > |
SELDON_EXTERN template class | Matrix< Real_wp, General, RowLoTriang > |
SELDON_EXTERN template class | Matrix< Complex_wp, General, RowLoTriang > |
SELDON_EXTERN template class | Matrix_HermPacked< Complex_wp, Hermitian, RowHermPacked > |
SELDON_EXTERN template class | Matrix< Complex_wp, Hermitian, RowHermPacked > |
SELDON_EXTERN template class | Matrix_SymPacked< Real_wp, Symmetric, RowSymPacked > |
SELDON_EXTERN template class | Matrix_SymPacked< Complex_wp, Symmetric, RowSymPacked > |
SELDON_EXTERN template class | Matrix< Real_wp, Symmetric, RowSymPacked > |
SELDON_EXTERN template class | Matrix< Complex_wp, Symmetric, RowSymPacked > |
SELDON_EXTERN template class | Matrix_TriangPacked< Real_wp, General, RowUpTriangPacked > |
SELDON_EXTERN template class | Matrix_TriangPacked< Complex_wp, General, RowUpTriangPacked > |
SELDON_EXTERN template class | Matrix_TriangPacked< Real_wp, General, RowLoTriangPacked > |
SELDON_EXTERN template class | Matrix_TriangPacked< Complex_wp, General, RowLoTriangPacked > |
SELDON_EXTERN template class | Matrix< Real_wp, General, RowUpTriangPacked > |
SELDON_EXTERN template class | Matrix< Complex_wp, General, RowUpTriangPacked > |
SELDON_EXTERN template class | Matrix< Real_wp, General, RowLoTriangPacked > |
SELDON_EXTERN template class | Matrix< Complex_wp, General, RowLoTriangPacked > |
SELDON_EXTERN template class | VirtualMatrix< bool > |
SELDON_EXTERN template class | VirtualMatrix< int > |
SELDON_EXTERN template class | VirtualMatrix< float > |
SELDON_EXTERN template class | VirtualMatrix< Real_wp > |
SELDON_EXTERN template class | VirtualMatrix< complex< float > > |
SELDON_EXTERN template class | VirtualMatrix< Complex_wp > |
SELDON_EXTERN template class | VirtualMatrix< Matrix< Real_wp > > |
SELDON_EXTERN template class | Matrix_Pointers< int, General, ColMajor > |
SELDON_EXTERN template class | Matrix_Pointers< Real_wp, General, ColMajor > |
SELDON_EXTERN template class | Matrix_Pointers< Complex_wp, General, ColMajor > |
SELDON_EXTERN template class | Matrix_Pointers< bool, General, RowMajor > |
SELDON_EXTERN template class | Matrix_Pointers< int, General, RowMajor > |
SELDON_EXTERN template class | Matrix_Pointers< float, General, RowMajor > |
SELDON_EXTERN template class | Matrix_Pointers< Real_wp, General, RowMajor > |
SELDON_EXTERN template class | Matrix_Pointers< complex< float >, General, RowMajor > |
SELDON_EXTERN template class | Matrix_Pointers< Complex_wp, General, RowMajor > |
SELDON_EXTERN template class | Matrix< int, General, ColMajor > |
SELDON_EXTERN template class | Matrix< Real_wp, General, ColMajor > |
SELDON_EXTERN template class | Matrix< Complex_wp, General, ColMajor > |
SELDON_EXTERN template class | Matrix< int, General, RowMajor > |
SELDON_EXTERN template class | Matrix< float, General, RowMajor > |
SELDON_EXTERN template class | Matrix< Real_wp, General, RowMajor > |
SELDON_EXTERN template class | Matrix< complex< float >, General, RowMajor > |
SELDON_EXTERN template class | Matrix< Complex_wp, General, RowMajor > |
SELDON_EXTERN template class | Matrix_Sparse< int, General, RowSparse > |
SELDON_EXTERN template class | Matrix_Sparse< int, General, ColSparse > |
SELDON_EXTERN template class | Matrix_Sparse< Real_wp, General, RowSparse > |
SELDON_EXTERN template class | Matrix_Sparse< Real_wp, General, ColSparse > |
SELDON_EXTERN template class | Matrix_Sparse< Complex_wp, General, RowSparse > |
SELDON_EXTERN template class | Matrix_Sparse< Complex_wp, General, ColSparse > |
SELDON_EXTERN template class | Matrix< int, General, RowSparse > |
SELDON_EXTERN template class | Matrix< int, General, ColSparse > |
SELDON_EXTERN template class | Matrix< Real_wp, General, RowSparse > |
SELDON_EXTERN template class | Matrix< Real_wp, General, ColSparse > |
SELDON_EXTERN template class | Matrix< Complex_wp, General, RowSparse > |
SELDON_EXTERN template class | Matrix< Complex_wp, General, ColSparse > |
SELDON_EXTERN template class | Matrix_SymSparse< int, Symmetric, RowSymSparse > |
SELDON_EXTERN template class | Matrix_SymSparse< Real_wp, Symmetric, RowSymSparse > |
SELDON_EXTERN template class | Matrix_SymSparse< Complex_wp, Symmetric, RowSymSparse > |
SELDON_EXTERN template class | Matrix< Real_wp, Symmetric, RowSymSparse > |
SELDON_EXTERN template class | Matrix< Complex_wp, Symmetric, RowSymSparse > |
SELDON_EXTERN template class | Matrix_ArraySparse< Real_wp, General, ArrayRowSparse > |
SELDON_EXTERN template class | Matrix_ArraySparse< Complex_wp, General, ArrayRowSparse > |
SELDON_EXTERN template class | Matrix< Real_wp, General, ArrayRowSparse > |
SELDON_EXTERN template class | Matrix< Complex_wp, General, ArrayRowSparse > |
SELDON_EXTERN template class | Matrix_ArraySparse< Real_wp, General, ArrayColSparse > |
SELDON_EXTERN template class | Matrix_ArraySparse< Complex_wp, General, ArrayColSparse > |
SELDON_EXTERN template class | Matrix< Real_wp, General, ArrayColSparse > |
SELDON_EXTERN template class | Matrix< Complex_wp, General, ArrayColSparse > |
SELDON_EXTERN template class | Matrix_ArraySparse< Real_wp, Symmetric, ArrayRowSymSparse > |
SELDON_EXTERN template class | Matrix_ArraySparse< Complex_wp, Symmetric, ArrayRowSymSparse > |
SELDON_EXTERN template class | Matrix< Real_wp, Symmetric, ArrayRowSymSparse > |
SELDON_EXTERN template class | Matrix< Complex_wp, Symmetric, ArrayRowSymSparse > |
SELDON_EXTERN template class | MatrixMumps< double > |
SELDON_EXTERN template class | MatrixMumps< complex< double > > |
SELDON_EXTERN template class | MatrixPardiso< double > |
SELDON_EXTERN template class | MatrixPardiso< complex< double > > |
SELDON_EXTERN template class | MatrixPastix< double > |
SELDON_EXTERN template class | MatrixPastix< complex< double > > |
SELDON_EXTERN template class | SparseDirectSolver< Real_wp > |
SELDON_EXTERN template class | SparseDirectSolver< Complex_wp > |
SELDON_EXTERN template class | VirtualSparseDirectSolver< Real_wp > |
SELDON_EXTERN template class | VirtualSparseDirectSolver< Complex_wp > |
SELDON_EXTERN template class | SparseSeldonSolver< Real_wp > |
SELDON_EXTERN template class | SparseSeldonSolver< Complex_wp > |
SELDON_EXTERN template class | MatrixSuperLU< double > |
SELDON_EXTERN template class | MatrixSuperLU< complex< double > > |
SELDON_EXTERN template class | MatrixSuperLU_Base< double > |
SELDON_EXTERN template class | MatrixSuperLU_Base< complex< double > > |
SELDON_EXTERN template class | Vector_Base< TinyVector< Real_wp, 1 > > |
SELDON_EXTERN template class | Vector_Base< TinyVector< Real_wp, 2 > > |
SELDON_EXTERN template class | Vector_Base< TinyVector< Real_wp, 3 > > |
SELDON_EXTERN template class | Vector_Base< TinyVector< Real_wp, 4 > > |
SELDON_EXTERN template class | Vector_Base< TinyVector< Real_wp, 5 > > |
SELDON_EXTERN template class | Vector_Base< TinyVector< Real_wp, 6 > > |
SELDON_EXTERN template class | Vector_Base< TinyVector< Real_wp, 7 > > |
SELDON_EXTERN template class | Vector_Base< TinyVector< Complex_wp, 1 > > |
SELDON_EXTERN template class | Vector_Base< TinyVector< Complex_wp, 2 > > |
SELDON_EXTERN template class | Vector_Base< TinyVector< Complex_wp, 3 > > |
SELDON_EXTERN template class | Vector_Base< TinyVector< Complex_wp, 4 > > |
SELDON_EXTERN template class | Vector_Base< TinyVector< Complex_wp, 5 > > |
SELDON_EXTERN template class | Vector_Base< TinyVector< Complex_wp, 6 > > |
SELDON_EXTERN template class | Vector_Base< TinyVector< Complex_wp, 7 > > |
SELDON_EXTERN template class | MatrixUmfPack< double > |
SELDON_EXTERN template class | MatrixUmfPack< complex< double > > |
SELDON_EXTERN template class | MatrixUmfPack_Base< double > |
SELDON_EXTERN template class | MatrixUmfPack_Base< complex< double > > |
SELDON_EXTERN template class | Vector_Base< bool > |
SELDON_EXTERN template class | Vector_Base< char > |
SELDON_EXTERN template class | Vector_Base< int > |
SELDON_EXTERN template class | Vector_Base< long > |
SELDON_EXTERN template class | Vector_Base< long long > |
SELDON_EXTERN template class | Vector_Base< double > |
SELDON_EXTERN template class | Vector_Base< complex< double > > |
SELDON_EXTERN template class | Vector_Base< float > |
SELDON_EXTERN template class | Vector_Base< complex< float > > |
SELDON_EXTERN template class | Vector< bool > |
SELDON_EXTERN template class | Vector< char > |
SELDON_EXTERN template class | Vector< int > |
SELDON_EXTERN template class | Vector< long > |
SELDON_EXTERN template class | Vector< long long > |
SELDON_EXTERN template class | Vector< double > |
SELDON_EXTERN template class | Vector< complex< double > > |
SELDON_EXTERN template class | Vector< float > |
SELDON_EXTERN template class | Vector< complex< float > > |
SELDON_EXTERN template class | Vector< int, VectSparse > |
SELDON_EXTERN template class | Vector< Real_wp, VectSparse > |
SELDON_EXTERN template class | Vector< Complex_wp, VectSparse > |
SELDON_EXTERN template class | Vector_Base< string > |
SELDON_EXTERN template class | Vector_Base< Vector< bool > > |
SELDON_EXTERN template class | Vector_Base< Vector< int > > |
SELDON_EXTERN template class | Vector_Base< Vector< Real_wp > > |
SELDON_EXTERN template class | Vector_Base< Vector< Real_wp >, MallocObject< Vector< Real_wp > > > |
SELDON_EXTERN template class | Vector_Base< Vector< Complex_wp > > |
SELDON_EXTERN template class | Vector_Base< Vector< Complex_wp >, MallocObject< Vector< Real_wp > > > |
SELDON_EXTERN template class | Vector2< Real_wp > |
SELDON_EXTERN template class | Vector2< Complex_wp > |
SELDON_EXTERN template class | Vector3< Real_wp > |
SELDON_EXTERN template class | Vector3< Complex_wp > |
SELDON_EXTERN template class | MatrixWsmp< double > |
SELDON_EXTERN template class | MatrixWsmp< complex< double > > |
SELDON_EXTERN template class | Matrix_Hermitian< @complex, General, @storage_blasHP, MallocAlloc< @complex > > |
SELDON_EXTERN template class | Matrix< @complex, General, @storage_blasHE, MallocAlloc< @complex > > |
SELDON_EXTERN template class | Matrix_Symmetric< @real_complex, General, @storage_blasSY, MallocAlloc< @real_complex > > |
SELDON_EXTERN template class | Matrix< @real_complex, General, @storage_blasSY, MallocAlloc< @real_complex > > |
SELDON_EXTERN template class | Matrix_Triangular< @real_complex, General, @storage_blasTR, MallocAlloc< @real_complex > > |
SELDON_EXTERN template class | Matrix< @real_complex, General, @storage_blasTR, MallocAlloc< @real_complex > > |
SELDON_EXTERN template class | Matrix_Hermitian< @complex, General, @storage_blasHP, NewAlloc< @complex > > |
SELDON_EXTERN template class | Matrix< @complex, General, @storage_blasHE, NewAlloc< @complex > > |
SELDON_EXTERN template class | Matrix_Symmetric< @real_complex, General, @storage_blasSY, NewAlloc< @real_complex > > |
SELDON_EXTERN template class | Matrix< @real_complex, General, @storage_blasSY, NewAlloc< @real_complex > > |
SELDON_EXTERN template class | Matrix_Triangular< @real_complex, General, @storage_blasTR, NewAlloc< @real_complex > > |
SELDON_EXTERN template class | Matrix< @real_complex, General, @storage_blasTR, NewAlloc< @real_complex > > |
SELDON_EXTERN template class | Matrix_HermPacked< @complex, General, @storage_blasHP, MallocAlloc< @complex > > |
SELDON_EXTERN template class | Matrix< @complex, General, @storage_blasHP, MallocAlloc< @complex > > |
SELDON_EXTERN template class | Matrix_SymPacked< @real_complex, General, @storage_blasSP, MallocAlloc< @real_complex > > |
SELDON_EXTERN template class | Matrix< @real_complex, General, @storage_blasSP, MallocAlloc< @real_complex > > |
SELDON_EXTERN template class | Matrix_TriangPacked< @real_complex, General, @storage_blasTP, MallocAlloc< @real_complex > > |
SELDON_EXTERN template class | Matrix< @real_complex, General, @storage_blasTP, MallocAlloc< @real_complex > > |
SELDON_EXTERN template class | Matrix_HermPacked< @complex, General, @storage_blasHP, NewAlloc< @complex > > |
SELDON_EXTERN template class | Matrix< @complex, General, @storage_blasHP, NewAlloc< @complex > > |
SELDON_EXTERN template class | Matrix_SymPacked< @real_complex, General, @storage_blasSP, NewAlloc< @real_complex > > |
SELDON_EXTERN template class | Matrix< @real_complex, General, @storage_blasSP, NewAlloc< @real_complex > > |
SELDON_EXTERN template class | Matrix_TriangPacked< @real_complex, General, @storage_blasTP, NewAlloc< @real_complex > > |
SELDON_EXTERN template class | Matrix< @real_complex, General, @storage_blasTP, NewAlloc< @real_complex > > |
SELDON_EXTERN template class | MallocAlloc< @scalar > |
SELDON_EXTERN template class | Vector_Base< @scalar, MallocAlloc< @scalar > > |
SELDON_EXTERN template class | Vector< @scalar, VectFull, MallocAlloc< @scalar > > |
SELDON_EXTERN template class | NewAlloc< @scalar > |
SELDON_EXTERN template class | Vector_Base< @scalar, NewAlloc< @scalar > > |
SELDON_EXTERN template class | Vector< @scalar, VectFull, NewAlloc< @scalar > > |
LapackInfo | lapack_info (0) |
class_SeldonTrans | SeldonTrans |
class_SeldonNoTrans | SeldonNoTrans |
class_SeldonConjTrans | SeldonConjTrans |
class_SeldonNonUnit | SeldonNonUnit |
class_SeldonUnit | SeldonUnit |
SeldonUplo | SeldonUpper (0) |
SeldonUplo | SeldonLower (1) |
SeldonNorm | SeldonNormInf (0) |
SeldonNorm | SeldonNorm1 (1) |
SeldonConjugate | SeldonUnconj (false) |
SeldonConjugate | SeldonConj (true) |
class_SeldonLeft | SeldonLeft |
class_SeldonRight | SeldonRight |
Seldon namespace.
void Seldon::AddMatrix | ( | const T0 & | alpha, |
const Matrix< FloatDouble, General, DenseSparseCollection, Allocator1 > & | A, | ||
Matrix< FloatDouble, General, DenseSparseCollection, Allocator2 > & | B | ||
) |
Multiplies a FloatDouble collection by a scalar.
[in] | alpha | scalar. |
[in,out] | M | matrix to be multiplied. |
Definition at line 1751 of file Functions_Matrix.cxx.
void Seldon::AddMatrix | ( | const T0 & | alpha, |
const Matrix< T1, Prop1, ColMajorCollection, Allocator1 > & | A, | ||
Matrix< T2, Prop2, ColMajorCollection, Allocator2 > & | B | ||
) |
Adds two matrices.
It performs the operation where is a scalar, and and are matrices.
[in] | alpha | scalar. |
[in] | A | matrix. |
[in,out] | B | matrix, result of the addition of B (on entry) and A times alpha. |
Definition at line 1674 of file Functions_Matrix.cxx.
void Seldon::AddMatrix | ( | const T0 & | alpha, |
const Matrix< T1, Prop1, ColSparse, Allocator1 > & | A, | ||
Matrix< T2, Prop2, ColSparse, Allocator2 > & | B | ||
) |
Adds two matrices.
It performs the operation where is a scalar, and and are matrices.
[in] | alpha | scalar. |
[in] | A | matrix. |
[in,out] | B | matrix, result of the addition of B (on entry) and A times alpha. |
Definition at line 2008 of file Functions_Matrix.cxx.
void Seldon::AddMatrix | ( | const T0 & | alpha, |
const Matrix< T1, Prop1, ColSymSparse, Allocator1 > & | A, | ||
Matrix< T2, Prop2, ColSymSparse, Allocator2 > & | B | ||
) |
Adds two matrices.
It performs the operation where is a scalar, and and are matrices.
[in] | alpha | scalar. |
[in] | A | matrix. |
[in,out] | B | matrix, result of the addition of B (on entry) and A times alpha. |
Definition at line 2044 of file Functions_Matrix.cxx.
void Seldon::AddMatrix | ( | const T0 & | alpha, |
const Matrix< T1, Prop1, RowMajorCollection, Allocator1 > & | A, | ||
Matrix< T2, Prop2, RowMajorCollection, Allocator2 > & | B | ||
) |
Adds two matrices.
It performs the operation where is a scalar, and and are matrices.
[in] | alpha | scalar. |
[in] | A | matrix. |
[in,out] | B | matrix, result of the addition of B (on entry) and A times alpha. |
Definition at line 1648 of file Functions_Matrix.cxx.
void Seldon::AddMatrix | ( | const T0 & | alpha, |
const Matrix< T1, Prop1, RowSparse, Allocator1 > & | A, | ||
Matrix< T2, Prop2, RowSparse, Allocator2 > & | B | ||
) |
Adds two matrices.
It performs the operation where is a scalar, and and are matrices.
[in] | alpha | scalar. |
[in] | A | matrix. |
[in,out] | B | matrix, result of the addition of B (on entry) and A times alpha. |
Definition at line 1990 of file Functions_Matrix.cxx.
void Seldon::AddMatrix | ( | const T0 & | alpha, |
const Matrix< T1, Prop1, RowSymSparse, Allocator1 > & | A, | ||
Matrix< T2, Prop2, RowSymSparse, Allocator2 > & | B | ||
) |
Adds two matrices.
It performs the operation where is a scalar, and and are matrices.
[in] | alpha | scalar. |
[in] | A | matrix. |
[in,out] | B | matrix, result of the addition of B (on entry) and A times alpha. |
Definition at line 2026 of file Functions_Matrix.cxx.
void Seldon::AddMatrix | ( | const T0 & | alpha, |
const Matrix< T1, Prop1, Storage1, Allocator1 > & | A, | ||
Matrix< T2, Prop2, Storage2, Allocator2 > & | B | ||
) |
Adds two matrices.
It performs the operation where is a scalar, and and are matrices.
[in] | alpha | scalar. |
[in] | A | matrix. |
[in,out] | B | matrix, result of the addition of B (on entry) and A times alpha. |
Definition at line 1619 of file Functions_Matrix.cxx.
void Seldon::ApplyInversePermutation | ( | Matrix< T, Prop, ArrayColSparse, Allocator > & | A, |
const IVect & | row_perm, | ||
const IVect & | col_perm | ||
) |
Permutation of a general matrix stored by columns.
B(row_perm(i), col_perm(j)) = A(i,j) and A = B. Equivalent Matlab operation: A(row_perm, col_perm) = A.
Definition at line 402 of file Permutation_ScalingMatrix.cxx.
void Seldon::ApplyInversePermutation | ( | Matrix< T, Prop, ArrayColSymSparse, Allocator > & | A, |
const IVect & | row_perm, | ||
const IVect & | col_perm | ||
) |
Permutation of a symmetric matrix stored by columns.
B(row_perm(i),col_perm(j)) = A(i,j) and A = B. Equivalent Matlab operation: A(row_perm, col_perm) = A.
Definition at line 453 of file Permutation_ScalingMatrix.cxx.
void Seldon::ApplyInversePermutation | ( | Matrix< T, Prop, ArrayRowComplexSparse, Allocator > & | A, |
const IVect & | row_perm, | ||
const IVect & | col_perm | ||
) |
Permutation of a general matrix stored by rows.
B(row_perm(i), col_perm(j)) = A(i,j) and A = B. Equivalent Matlab operation: A(row_perm, col_perm) = A.
Definition at line 629 of file Functions_MatrixComplex.cxx.
void Seldon::ApplyInversePermutation | ( | Matrix< T, Prop, ArrayRowSparse, Allocator > & | A, |
const IVect & | row_perm, | ||
const IVect & | col_perm | ||
) |
Permutation of a general matrix stored by rows.
B(row_perm(i), col_perm(j)) = A(i,j) and A = B. Equivalent Matlab operation: A(row_perm, col_perm) = A.
Definition at line 352 of file Permutation_ScalingMatrix.cxx.
void Seldon::ApplyInversePermutation | ( | Matrix< T, Prop, ArrayRowSymComplexSparse, Allocator > & | A, |
const IVect & | row_perm, | ||
const IVect & | col_perm | ||
) |
Permutation of a symmetric matrix stored by rows.
B(row_perm(i),col_perm(j)) = A(i,j) and A = B. Equivalent Matlab operation: A(row_perm, col_perm) = A.
Definition at line 690 of file Functions_MatrixComplex.cxx.
void Seldon::ApplyInversePermutation | ( | Matrix< T, Prop, ArrayRowSymSparse, Allocator > & | A, |
const IVect & | row_perm, | ||
const IVect & | col_perm | ||
) |
Permutation of a symmetric matrix stored by rows.
B(row_perm(i),col_perm(j)) = A(i,j) and A = B. Equivalent Matlab operation: A(row_perm, col_perm) = A.
Definition at line 523 of file Permutation_ScalingMatrix.cxx.
void Seldon::ApplyInversePermutation | ( | Matrix< T, Prop, ColHerm, Allocator > & | A, |
const Vector< int > & | row_perm, | ||
const Vector< int > & | col_perm, | ||
int | starting_index | ||
) |
Inverse permutation of an hermitian matrix stored by columns.
B(row_perm(i), row_perm(j)) = A(i,j) and A = B.
Equivalent Matlab operation: A(row_perm, row_perm) = A.
Definition at line 2002 of file Functions.cxx.
void Seldon::ApplyInversePermutation | ( | Matrix< T, Prop, ColHermPacked, Allocator > & | A, |
const Vector< int > & | row_perm, | ||
const Vector< int > & | col_perm, | ||
int | starting_index | ||
) |
Inverse permutation of an hermitian matrix stored by columns.
B(row_perm(i), row_perm(j)) = A(i,j) and A = B.
Equivalent Matlab operation: A(row_perm, row_perm) = A.
Definition at line 1960 of file Functions.cxx.
void Seldon::ApplyInversePermutation | ( | Matrix< T, Prop, ColMajor, Allocator > & | A, |
const Vector< int > & | row_perm, | ||
const Vector< int > & | col_perm, | ||
int | starting_index | ||
) |
Inverse permutation of a general matrix stored by columns.
B(row_perm(i), col_perm(j)) = A(i,j) and A = B.
Equivalent Matlab operation: A(row_perm, col_perm) = A.
Definition at line 1834 of file Functions.cxx.
void Seldon::ApplyInversePermutation | ( | Matrix< T, Prop, ColSparse, Allocator > & | A, |
const Vector< int > & | row_perm, | ||
const Vector< int > & | col_perm | ||
) |
Permutation of a general matrix stored by columns.
B(row_perm(i), col_perm(j)) = A(i,j) and A = B. Equivalent Matlab operation: A(row_perm, col_perm) = A.
Definition at line 142 of file Permutation_ScalingMatrix.cxx.
void Seldon::ApplyInversePermutation | ( | Matrix< T, Prop, ColSym, Allocator > & | A, |
const Vector< int > & | row_perm, | ||
const Vector< int > & | col_perm, | ||
int | starting_index | ||
) |
Inverse permutation of a symmetric matrix stored by columns.
B(row_perm(i), row_perm(j)) = A(i,j) and A = B.
Equivalent Matlab operation: A(row_perm, row_perm) = A.
Definition at line 1918 of file Functions.cxx.
void Seldon::ApplyInversePermutation | ( | Matrix< T, Prop, ColSymPacked, Allocator > & | A, |
const Vector< int > & | row_perm, | ||
const Vector< int > & | col_perm, | ||
int | starting_index | ||
) |
Inverse permutation of a symmetric matrix stored by columns.
B(row_perm(i), row_perm(j)) = A(i,j) and A = B.
Equivalent Matlab operation: A(row_perm, row_perm) = A.
Definition at line 1876 of file Functions.cxx.
void Seldon::ApplyInversePermutation | ( | Matrix< T, Prop, ColSymSparse, Allocator > & | A, |
const Vector< int > & | row_perm, | ||
const Vector< int > & | col_perm | ||
) |
Permutation of a symmetric matrix stored by columns.
B(row_perm(i), row_perm(j)) = A(i,j) and A = B. Equivalent Matlab operation: A(row_perm, row_perm) = A.
Definition at line 290 of file Permutation_ScalingMatrix.cxx.
void Seldon::ApplyInversePermutation | ( | Matrix< T, Prop, RowHerm, Allocator > & | A, |
const Vector< int > & | row_perm, | ||
const Vector< int > & | col_perm, | ||
int | starting_index | ||
) |
Inverse permutation of an hermitian matrix stored by rows.
B(row_perm(i), row_perm(j)) = A(i,j) and A = B.
Equivalent Matlab operation: A(row_perm, row_perm) = A.
Definition at line 1981 of file Functions.cxx.
void Seldon::ApplyInversePermutation | ( | Matrix< T, Prop, RowHermPacked, Allocator > & | A, |
const Vector< int > & | row_perm, | ||
const Vector< int > & | col_perm, | ||
int | starting_index | ||
) |
Inverse permutation of an hermitian matrix stored by rows.
B(row_perm(i), row_perm(j)) = A(i,j) and A = B.
Equivalent Matlab operation: A(row_perm, row_perm) = A.
Definition at line 1939 of file Functions.cxx.
void Seldon::ApplyInversePermutation | ( | Matrix< T, Prop, RowMajor, Allocator > & | A, |
const Vector< int > & | row_perm, | ||
const Vector< int > & | col_perm, | ||
int | starting_index | ||
) |
Inverse permutation of a general matrix stored by rows.
B(row_perm(i), col_perm(j)) = A(i,j) and A = B.
Equivalent Matlab operation: A(row_perm, col_perm) = A.
Definition at line 1813 of file Functions.cxx.
void Seldon::ApplyInversePermutation | ( | Matrix< T, Prop, RowSparse, Allocator > & | A, |
const Vector< int > & | row_perm, | ||
const Vector< int > & | col_perm | ||
) |
Permutation of a general matrix stored by rows.
B(row_perm(i), col_perm(j)) = A(i,j) and A = B. Equivalent Matlab operation: A(row_perm, col_perm) = A.
Definition at line 55 of file Permutation_ScalingMatrix.cxx.
void Seldon::ApplyInversePermutation | ( | Matrix< T, Prop, RowSym, Allocator > & | A, |
const Vector< int > & | row_perm, | ||
const Vector< int > & | col_perm, | ||
int | starting_index | ||
) |
Inverse permutation of a symmetric matrix stored by rows.
B(row_perm(i), row_perm(j)) = A(i,j) and A = B.
Equivalent Matlab operation: A(row_perm, row_perm) = A.
Definition at line 1897 of file Functions.cxx.
void Seldon::ApplyInversePermutation | ( | Matrix< T, Prop, RowSymPacked, Allocator > & | A, |
const Vector< int > & | row_perm, | ||
const Vector< int > & | col_perm, | ||
int | starting_index | ||
) |
Inverse permutation of a symmetric matrix stored by rows.
B(row_perm(i), row_perm(j)) = A(i,j) and A = B.
Equivalent Matlab operation: A(row_perm, row_perm) = A.
Definition at line 1855 of file Functions.cxx.
void Seldon::ApplyInversePermutation | ( | Matrix< T, Prop, RowSymSparse, Allocator > & | A, |
const Vector< int > & | row_perm, | ||
const Vector< int > & | col_perm | ||
) |
Permutation of a symmetric matrix stored by rows.
B(row_perm(i), row_perm(j)) = A(i,j) and A = B. Equivalent Matlab operation: A(row_perm, row_perm) = A.
Definition at line 228 of file Permutation_ScalingMatrix.cxx.
void Seldon::ApplyPermutation | ( | Matrix< T, Prop, ArrayColSparse, Allocator > & | A, |
const Vector< int > & | row_perm, | ||
const Vector< int > & | col_perm | ||
) |
Permutation of rows and columns of a matrix.
B(i, j) = A(row_perm(i), col_perm(j)) and A = B. Equivalent Matlab operation: A = A(row_perm, col_perm)
Definition at line 704 of file Permutation_ScalingMatrix.cxx.
void Seldon::ApplyPermutation | ( | Matrix< T, Prop, ArrayColSymSparse, Allocator > & | A, |
const Vector< int > & | row_perm, | ||
const Vector< int > & | col_perm | ||
) |
Permutation of rows and columns of a matrix.
B(i, j) = A(row_perm(i), row_perm(j)) and A = B. Equivalent Matlab operation: A = A(row_perm, row_perm)
Definition at line 744 of file Permutation_ScalingMatrix.cxx.
void Seldon::ApplyPermutation | ( | Matrix< T, Prop, ArrayRowComplexSparse, Allocator > & | A, |
const Vector< int > & | row_perm, | ||
const Vector< int > & | col_perm | ||
) |
Permutation of rows and columns of a matrix.
B(i, j) = A(row_perm(i), col_perm(j)) and A = B. Equivalent Matlab operation: A = A(row_perm, col_perm)
Definition at line 820 of file Functions_MatrixComplex.cxx.
void Seldon::ApplyPermutation | ( | Matrix< T, Prop, ArrayRowSparse, Allocator > & | A, |
const Vector< int > & | row_perm, | ||
const Vector< int > & | col_perm | ||
) |
Permutation of rows and columns of a matrix.
B(i, j) = A(row_perm(i), col_perm(j)) and A = B. Equivalent Matlab operation: A = A(row_perm, col_perm)
Definition at line 682 of file Permutation_ScalingMatrix.cxx.
void Seldon::ApplyPermutation | ( | Matrix< T, Prop, ArrayRowSymComplexSparse, Allocator > & | A, |
const Vector< int > & | row_perm, | ||
const Vector< int > & | col_perm | ||
) |
Permutation of rows and columns of a matrix.
B(i, j) = A(row_perm(i), row_perm(j)) and A = B. Equivalent Matlab operation: A = A(row_perm, row_perm)
Definition at line 842 of file Functions_MatrixComplex.cxx.
void Seldon::ApplyPermutation | ( | Matrix< T, Prop, ArrayRowSymSparse, Allocator > & | A, |
const Vector< int > & | row_perm, | ||
const Vector< int > & | col_perm | ||
) |
Permutation of rows and columns of a matrix.
B(i, j) = A(row_perm(i), row_perm(j)) and A = B. Equivalent Matlab operation: A = A(row_perm, row_perm)
Definition at line 726 of file Permutation_ScalingMatrix.cxx.
void Seldon::ApplyPermutation | ( | Matrix< T, Prop, ColHerm, Allocator > & | A, |
const Vector< int > & | row_perm, | ||
const Vector< int > & | col_perm, | ||
int | starting_index | ||
) |
Permutation of an hermitian matrix stored by columns.
B(i, j) = A(row_perm(i), row_perm(j)) and A = B.
Definition at line 1792 of file Functions.cxx.
void Seldon::ApplyPermutation | ( | Matrix< T, Prop, ColHermPacked, Allocator > & | A, |
const Vector< int > & | row_perm, | ||
const Vector< int > & | col_perm, | ||
int | starting_index | ||
) |
Permutation of an hermitian matrix stored by columns.
B(i, j) = A(row_perm(i), row_perm(j)) and A = B.
Definition at line 1754 of file Functions.cxx.
void Seldon::ApplyPermutation | ( | Matrix< T, Prop, ColMajor, Allocator > & | A, |
const Vector< int > & | row_perm, | ||
const Vector< int > & | col_perm, | ||
int | starting_index | ||
) |
Permutation of a general matrix stored by columns.
B(i, j) = A(row_perm(i), col_perm(j)) and A = B.
Definition at line 1640 of file Functions.cxx.
void Seldon::ApplyPermutation | ( | Matrix< T, Prop, ColSparse, Allocator > & | A, |
const Vector< int > & | row_perm, | ||
const Vector< int > & | col_perm | ||
) |
Permutation of rows and columns of a matrix.
B(i, j) = A(row_perm(i), col_perm(j)) and A = B. Equivalent Matlab operation: A = A(row_perm, col_perm)
Definition at line 624 of file Permutation_ScalingMatrix.cxx.
void Seldon::ApplyPermutation | ( | Matrix< T, Prop, ColSym, Allocator > & | A, |
const Vector< int > & | row_perm, | ||
const Vector< int > & | col_perm, | ||
int | starting_index | ||
) |
Permutation of a symmetric matrix stored by columns.
B(i, j) = A(row_perm(i), row_perm(j)) and A = B.
Definition at line 1716 of file Functions.cxx.
void Seldon::ApplyPermutation | ( | Matrix< T, Prop, ColSymPacked, Allocator > & | A, |
const Vector< int > & | row_perm, | ||
const Vector< int > & | col_perm, | ||
int | starting_index | ||
) |
Permutation of a symmetric matrix stored by columns.
B(i, j) = A(row_perm(i), row_perm(j)) and A = B.
Definition at line 1678 of file Functions.cxx.
void Seldon::ApplyPermutation | ( | Matrix< T, Prop, ColSymSparse, Allocator > & | A, |
const Vector< int > & | row_perm, | ||
const Vector< int > & | col_perm | ||
) |
Permutation of rows and columns of a matrix.
B(i, j) = A(row_perm(i), row_perm(j)) and A = B. Equivalent Matlab operation: A = A(row_perm, row_perm)
Definition at line 664 of file Permutation_ScalingMatrix.cxx.
void Seldon::ApplyPermutation | ( | Matrix< T, Prop, RowHerm, Allocator > & | A, |
const Vector< int > & | row_perm, | ||
const Vector< int > & | col_perm, | ||
int | starting_index | ||
) |
Permutation of an hermitian matrix stored by rows.
B(i, j) = A(row_perm(i), row_perm(j)) and A = B.
Definition at line 1773 of file Functions.cxx.
void Seldon::ApplyPermutation | ( | Matrix< T, Prop, RowHermPacked, Allocator > & | A, |
const Vector< int > & | row_perm, | ||
const Vector< int > & | col_perm, | ||
int | starting_index | ||
) |
Permutation of an hermitian matrix stored by rows.
B(i, j) = A(row_perm(i), row_perm(j)) and A = B.
Definition at line 1735 of file Functions.cxx.
void Seldon::ApplyPermutation | ( | Matrix< T, Prop, RowMajor, Allocator > & | A, |
const Vector< int > & | row_perm, | ||
const Vector< int > & | col_perm, | ||
int | starting_index | ||
) |
Permutation of a general matrix stored by rows.
B(i, j) = A(row_perm(i), col_perm(j)) and A = B.
Definition at line 1621 of file Functions.cxx.
void Seldon::ApplyPermutation | ( | Matrix< T, Prop, RowSparse, Allocator > & | A, |
const Vector< int > & | row_perm, | ||
const Vector< int > & | col_perm | ||
) |
Permutation of rows and columns of a matrix.
B(i, j) = A(row_perm(i), col_perm(j)) and A = B. Equivalent Matlab operation: A = A(row_perm, col_perm)
Definition at line 602 of file Permutation_ScalingMatrix.cxx.
void Seldon::ApplyPermutation | ( | Matrix< T, Prop, RowSym, Allocator > & | A, |
const Vector< int > & | row_perm, | ||
const Vector< int > & | col_perm, | ||
int | starting_index | ||
) |
Permutation of a symmetric matrix stored by rows.
B(i, j) = A(row_perm(i), row_perm(j)) and A = B.
Definition at line 1697 of file Functions.cxx.
void Seldon::ApplyPermutation | ( | Matrix< T, Prop, RowSymPacked, Allocator > & | A, |
const Vector< int > & | row_perm, | ||
const Vector< int > & | col_perm, | ||
int | starting_index | ||
) |
Permutation of a symmetric matrix stored by rows.
B(i, j) = A(row_perm(i), row_perm(j)) and A = B.
Definition at line 1659 of file Functions.cxx.
void Seldon::ApplyPermutation | ( | Matrix< T, Prop, RowSymSparse, Allocator > & | A, |
const Vector< int > & | row_perm, | ||
const Vector< int > & | col_perm | ||
) |
Permutation of rows and columns of a matrix.
B(i, j) = A(row_perm(i), row_perm(j)) and A = B. Equivalent Matlab operation: A = A(row_perm, row_perm)
Definition at line 646 of file Permutation_ScalingMatrix.cxx.
void Seldon::ApplyScalingEigenvec | ( | EigenPb & | var, |
Vector1 & | eigen_values, | ||
Vector1 & | lambda_imag, | ||
Matrix1 & | eigen_vectors, | ||
const complex< T0 > & | shiftr, | ||
const complex< T0 > & | shifti | ||
) |
modification of eigenvectors to take into account scaling by mass matrix
One may desire to use matrix D^-1/2 K D^-1/2 or L^-1 K L^-T instead of K in order to solve a standard eigenvalue problem instead of a generalized one. => eigenvectors are recovered by multiplying them by matrix D^1/2 or by L^T with this function
Definition at line 983 of file EigenvalueSolver.cxx.
void Seldon::ApplyScalingEigenvec | ( | EigenPb & | var, |
Vector1 & | eigen_values, | ||
Vector1 & | lambda_imag, | ||
Matrix1 & | eigen_vectors, | ||
const T0 & | shiftr, | ||
const T0 & | shifti | ||
) |
modification of eigenvectors to take into account scaling by mass matrix
One may desire to use matrix D^-1/2 K D^-1/2 or L^-1 K L^-T instead of K in order to solve a standard eigenvalue problem instead of a generalized one. => eigenvectors are recovered by multiplying them by matrix D^1/2 or by L^T with this function
Definition at line 846 of file EigenvalueSolver.cxx.
void Seldon::ApplyScalingEigenvec | ( | EigenProblem_Base< complex< T0 > > & | var, |
Vector< complex< T0 > > & | eigen_values, | ||
Vector< complex< T0 > > & | lambda_imag, | ||
Matrix< complex< T0 >, Prop, Storage > & | eigen_vectors, | ||
const complex< T0 > & | shiftr, | ||
const complex< T0 > & | shifti | ||
) |
modification of eigenvectors to take into account scaling by mass matrix
One may desire to use matrix D^-1/2 K D^-1/2 or L^-1 K L^-T instead of K in order to solve a standard eigenvalue problem instead of a generalized one. => eigenvectors are recovered by multiplying them by matrix D^1/2 or by L^T with this function
Definition at line 1618 of file VirtualEigenvalueSolver.cxx.
void Seldon::ApplyScalingEigenvec | ( | EigenProblem_Base< T0 > & | var, |
Vector< T0 > & | eigen_values, | ||
Vector< T0 > & | lambda_imag, | ||
Matrix< T0, Prop, Storage > & | eigen_vectors, | ||
const T0 & | shiftr, | ||
const T0 & | shifti | ||
) |
modification of eigenvectors to take into account scaling by mass matrix
One may desire to use matrix D^-1/2 K D^-1/2 or L^-1 K L^-T instead of K in order to solve a standard eigenvalue problem instead of a generalized one. => eigenvectors are recovered by multiplying them by matrix D^1/2 or by L^T with this function
Definition at line 1468 of file VirtualEigenvalueSolver.cxx.
void Seldon::Assemble | ( | long & | n, |
Vector< int, Storage1, Allocator1 > & | Node, | ||
Vector< T2, Storage2, Allocator2 > & | Vect | ||
) |
Assembles a sparse vector.
The function sorts the indices in Node and adds the corresponding values of Vect corresponding.
For example, if Node = [3 2 2 0], Vect = [1.0 0.4 0.4 -0.3], the function will return: n = 3, Node = [0 2 3], Vect = [-0.3 0.8 1.0].
[in,out] | n | on entry, the number of elements to assemble; on exit, the number of values after assembling. |
[in,out] | Node | positions in the vector. |
[in,out] | Vect | values. |
Definition at line 528 of file Functions_Arrays.cxx.
void Seldon::Assemble | ( | long & | n, |
Vector< T, Storage1, Allocator1 > & | Node | ||
) |
Sorts and removes duplicate entries of a vector.
[in,out] | n | on entry, the number of elements to assemble; on exit, the number of values after assembling. |
[in,out] | Node | vector to be assembled. |
Definition at line 561 of file Functions_Arrays.cxx.
void Seldon::AssembleDistributed | ( | DistributedMatrix< T, Prop, Storage, Alloc > & | A, |
General & | prop, | ||
const MPI_Comm & | comm, | ||
IVect & | col_numbers, | ||
IVect & | local_col_numbers, | ||
Vector< Tint0 > & | PtrA, | ||
Vector< Tint1 > & | IndA, | ||
Vector< T > & | ValA, | ||
bool | sym_pattern, | ||
bool | reorder | ||
) |
assembling a distributed matrix, global columns are given in CSC form
[in] | A | distributed matrix |
[in] | prop | the matrix is assumed to be unsymmetric |
[in] | comm | MPI communicator |
[out] | col_numbers | global column numbers |
[out] | local_col_numbers | local column numbers |
[out] | PtrA | Index of first element stored for each column |
[out] | IndA | global row numbers |
[out] | ValA | values |
[in] | sym_pattern | if true, the pattern of the unsymmetric matrix is symmetrized |
Definition at line 6106 of file DistributedMatrix.cxx.
void Seldon::AssembleDistributed | ( | DistributedMatrix< T, Prop, Storage, Alloc > & | A, |
Symmetric & | sym, | ||
const MPI_Comm & | comm, | ||
IVect & | row_numbers, | ||
IVect & | local_row_numbers, | ||
Vector< Tint0 > & | PtrA, | ||
Vector< Tint1 > & | IndA, | ||
Vector< T > & | ValA, | ||
bool | sym_pattern, | ||
bool | reorder | ||
) |
assembling a distributed matrix, global rows are given in CSR form
[in] | A | distributed matrix |
[in] | sym | the matrix is assumed to be symmetric, only upper part is assembled |
[in] | comm | MPI communicator |
[out] | row_numbers | global row numbers |
[out] | local_row_numbers | local row numbers |
[out] | PtrA | Index of first element stored for each row |
[out] | IndA | global column numbers |
[out] | ValA | values |
[in] | sym_pattern | not used |
Definition at line 6063 of file DistributedMatrix.cxx.
void Seldon::AssembleVector | ( | Vector< T > & | X, |
const MPI_Op & | oper, | ||
const IVect & | ProcNumber, | ||
const Vector< IVect > & | DofNumber, | ||
const MPI_Comm & | comm, | ||
int | Nvol, | ||
int | nb_u, | ||
int | tag | ||
) |
assembles a distributed vector (some rows are shared between processors)
[in,out] | X | vector to assemble |
[in] | oper | reduction operator (MPI_SUM, MPI_MIN or MPI_MAX) |
[in] | ProcNumber | processors interacting with the current processor |
[in] | DofNumber | for each processor, rows to send/receive |
[in] | comm | MPI communicator |
[in] | Nvol | DofNumber will be included between <0, Nvol-1> |
[in] | nb_u | number of unknowns (X is supposed to be of size >= Nvol*nb_u) |
[in] | tag | MPI tag For each unknown, it is assumed that the same row numbers are affected, that's why you can provide DofNumber for only the first unknown and consider that rows of other unknowns are obtained with the operation m*Nvol + i, m in <0, nb_u-1> and m in <0, Nvol-1> |
Definition at line 297 of file DistributedVector.cxx.
int Seldon::BiCg | ( | const Matrix1 & | A, |
Vector1 & | x, | ||
const Vector1 & | b, | ||
Preconditioner & | M, | ||
Iteration< Titer > & | iter | ||
) |
Solves a linear system by using BiConjugate Gradient (BICG)
Solves the unsymmetric linear system Ax = b using the Preconditioned BiConjugate Gradient method.
return value of 0 indicates convergence within the maximum number of iterations (determined by the iter object). return value of 1 indicates a failure to converge.
See: R. Fletcher, Conjugate gradient methods for indefinite systems, In Numerical Analysis Dundee 1975, G. Watson, ed., Springer Verlag, Berlin, New York, 1976 pp. 73-89
int Seldon::BiCgcr | ( | const Matrix1 & | A, |
Vector1 & | x, | ||
const Vector1 & | b, | ||
Preconditioner & | M, | ||
Iteration< Titer > & | iter | ||
) |
Solves a linear system by using BiCgCr.
Solves the symmetric linear system Ax = b using the BiConjugate Gradient Conjugate Residual method.
See Iterative Methods for the Solution of Very Large Complex Symmetric Linear Systems of Equations in Electrodynamics, Markus Clemens, Thomas Weiland Fachbereich 18 Elektrische Nachrichtentechnik, Fachgebiet Theorie Elektromagnetischer Felder, Technische Hochschule Darmstadt, Schlossgartenstr. 8, D-64289 Darmstadt, Germany
[in] | A | Complex Symmetric Matrix |
[in,out] | x | Vector on input it is the initial guess on output it is the solution |
[in] | b | Vector right hand side of the linear system |
[in] | M | Right preconditioner |
[in] | iter | Iteration parameters |
Definition at line 52 of file BiCgcr.cxx.
int Seldon::BiCgStab | ( | const Matrix1 & | A, |
Vector1 & | x, | ||
const Vector1 & | b, | ||
Preconditioner & | M, | ||
Iteration< Titer > & | iter | ||
) |
Implements BiConjugate Gradient Stabilized (BICG-STAB)
return value of 0 indicates convergence within the maximum number of iterations (determined by the iter object). return value of 1 indicates a failure to converge.
See: H. Van der Vorst, Bi-CGSTAB: A fast and smoothly converging variant of BiCG for the solution of nonsysmmetric linear systems, SIAM J. Sci. Statist. Comput. 13(1992), pp. 631-644
[in] | A | Complex General Matrix |
[in,out] | x | Vector on input it is the initial guess on output it is the solution |
[in] | b | Vector right hand side of the linear system |
[in] | M | Right preconditioner |
[in] | iter | Iteration parameters |
Definition at line 50 of file BiCgStab.cxx.
int Seldon::BiCgStabl | ( | const Matrix1 & | A, |
Vector1 & | x, | ||
const Vector1 & | b, | ||
Preconditioner & | M, | ||
Iteration< Titer > & | iter | ||
) |
Implements BiConjugate Gradient Stabilized (BICG-STAB(l))
return value of 0 indicates convergence within the maximum number of iterations (determined by the iter object). return value of 1 indicates a failure to converge.
See G L.G. Sleijpen, D. R. Fokkema BICGSTAB(l) For Linear Equations Involving Unsymmetric Matrices With Complex Spectrum
[in] | A | Complex General Matrix |
[in,out] | x | Vector on input it is the initial guess on output it is the solution |
[in] | b | Vector right hand side of the linear system |
[in] | M | Right preconditioner |
[in] | iter | Iteration parameters |
Definition at line 50 of file BiCgStabl.cxx.
int Seldon::Cg | ( | const Matrix1 & | A, |
Vector1 & | x, | ||
const Vector1 & | b, | ||
Preconditioner & | M, | ||
Iteration< Titer > & | iter | ||
) |
Solves a linear system by using Conjugate Gradient (CG)
Solves the symmetric positive definite linear system A x = b.
return value of 0 indicates convergence within the maximum number of iterations (determined by the iter object). return value of 1 indicates a failure to converge.
See M. R. Hestenes nd E. Stiefel, Methods of conjugate gradients for solving linear system, Journal of Research of the National Bureau of Standards, 49(1952), pp. 409-436
int Seldon::Cgne | ( | const Matrix1 & | A, |
Vector1 & | x, | ||
const Vector1 & | b, | ||
Preconditioner & | M, | ||
Iteration< Titer > & | iter | ||
) |
Solves a linear system using Conjugate Gradient Normal Equation (CGNE)
Solves the unsymmetric linear system A x = b.
return value of 0 indicates convergence within the maximum number of iterations (determined by the iter object). return value of 1 indicates a failure to converge.
[in] | A | Complex General Matrix |
[in,out] | x | Vector on input it is the initial guess on output it is the solution |
[in] | b | Right hand side of the linear system |
[in] | M | Left preconditioner |
[in] | iter | Iteration parameters |
You should avoid this function since A A^T is often bad-conditioned, and prefer another iterative algorithm
int Seldon::Cgs | ( | const Matrix1 & | A, |
Vector1 & | x, | ||
const Vector1 & | b, | ||
Preconditioner & | M, | ||
Iteration< Titer > & | iter | ||
) |
Solves linear system using Conjugate Gradient Squared (CGS)
Solves the unsymmetric linear system Ax = b using the Conjugate Gradient Squared method.
return value of 0 indicates convergence within the maximum number of iterations (determined by the iter object). return value of 1 indicates a failure to converge.
See: P. Sonneveld, CGS, a fast Lanczos-type solver for nonsymmetric linear systems, SIAM, J.Sci. Statist. Comput., 10(1989), pp. 36-52
void Seldon::CheckDim | ( | const Matrix< T0, Prop0, ColMajorCollection, Allocator0 > & | M, |
const Vector< T1, Collection, Allocator1 > & | X, | ||
const Vector< T2, Collection, Allocator2 > & | Y, | ||
string | function | ||
) |
Checks the compatibility of the dimensions.
Checks that M X + Y -> Y is possible according to the dimensions of the matrix M and the vectors X and Y. If the dimensions are incompatible, an exception is raised (a WrongDim object is thrown).
M | matrix. |
X | vector. |
Y | vector. |
function | (optional) function in which the compatibility is checked. Default: "". |
Definition at line 2236 of file Functions_MatVect.cxx.
void Seldon::CheckDim | ( | const Matrix< T0, Prop0, RowMajorCollection, Allocator0 > & | M, |
const Vector< T1, Collection, Allocator1 > & | X, | ||
const Vector< T2, Collection, Allocator2 > & | Y, | ||
string | function | ||
) |
Checks the compatibility of the dimensions.
Checks that M X + Y -> Y is possible according to the dimensions of the matrix M and the vectors X and Y. If the dimensions are incompatible, an exception is raised (a WrongDim object is thrown).
M | matrix. |
X | vector. |
Y | vector. |
function | (optional) function in which the compatibility is checked. Default: "". |
Definition at line 2197 of file Functions_MatVect.cxx.
void Seldon::CheckDim | ( | const Matrix< T0, Prop0, Storage0, Allocator0 > & | A, |
const Matrix< T1, Prop1, Storage1, Allocator1 > & | B, | ||
const Matrix< T2, Prop2, Storage2, Allocator2 > & | C, | ||
string | function | ||
) |
Checks the compatibility of the dimensions.
Checks that A B + C -> C is possible according to the dimensions of the matrices A, B and C. If the dimensions are incompatible, an exception is raised (a WrongDim object is thrown).
A | matrix. |
B | matrix. |
C | matrix. |
function | (optional) function in which the compatibility is checked. Default: "". |
Definition at line 2132 of file Functions_Matrix.cxx.
void Seldon::CheckDim | ( | const Matrix< T0, Prop0, Storage0, Allocator0 > & | A, |
const Matrix< T1, Prop1, Storage1, Allocator1 > & | B, | ||
string | function | ||
) |
Checks the compatibility of the dimensions.
Checks that A B is possible according to the dimensions of the matrices A and B. If the dimensions are incompatible, an exception is raised (a WrongDim object is thrown).
A | matrix. |
B | matrix. \function (optional) function in which the compatibility is checked. Default: "". |
Definition at line 2323 of file Functions_Matrix.cxx.
void Seldon::CheckDim | ( | const Matrix< T0, Prop0, Storage0, Allocator0 > & | M, |
const Vector< T1, Collection, Allocator1 > & | X, | ||
const Vector< T2, Storage2, Allocator2 > & | Y, | ||
string | function | ||
) |
Checks the compatibility of the dimensions.
Checks that M X + Y -> Y is possible according to the dimensions of the matrix M and the vectors X and Y. If the dimensions are incompatible, an exception is raised (a WrongDim object is thrown).
M | matrix. |
X | vector. |
Y | vector. |
function | (optional) function in which the compatibility is checked. Default: "". |
Definition at line 2275 of file Functions_MatVect.cxx.
void Seldon::CheckDim | ( | const Matrix< T0, Prop0, Storage0, Allocator0 > & | M, |
const Vector< T1, Storage1, Allocator1 > & | X, | ||
const Vector< T2, Storage2, Allocator2 > & | Y, | ||
string | function | ||
) |
Checks the compatibility of the dimensions.
Checks that M X + Y -> Y is possible according to the dimensions of the matrix M and the vectors X and Y. If the dimensions are incompatible, an exception is raised (a WrongDim object is thrown).
M | matrix. |
X | vector. |
Y | vector. |
function | (optional) function in which the compatibility is checked. Default: "". |
Definition at line 2157 of file Functions_MatVect.cxx.
void Seldon::CheckDim | ( | const Matrix< T0, Prop0, Storage0, Allocator0 > & | M, |
const Vector< T1, Storage1, Allocator1 > & | X, | ||
string | function, | ||
string | op | ||
) |
Checks the compatibility of the dimensions.
Checks that M X is possible according to the dimensions of the matrix M and the vector X. If the dimensions are incompatible, an exception is raised (a WrongDim object is thrown).
M | matrix. |
X | vector. |
function | (optional) function in which the compatibility is checked. Default: "". |
op | (optional) operation to be performed. Default: "M X". |
Definition at line 2364 of file Functions_MatVect.cxx.
void Seldon::CheckDim | ( | const SeldonSide & | side, |
const Matrix< T0, Prop0, Storage0, Allocator0 > & | A, | ||
const Matrix< T1, Prop1, Storage1, Allocator1 > & | B, | ||
const Matrix< T2, Prop2, Storage2, Allocator2 > & | C, | ||
string | function | ||
) |
Checks the compatibility of the dimensions.
Checks that A B + C -> C or B A + C -> C is possible according to the dimensions of the matrices A, B and C. If the dimensions are incompatible, an exception is raised (a WrongDim object is thrown).
side | side by which A is multiplied by B. |
A | matrix. |
B | matrix. |
C | matrix. \function (optional) function in which the compatibility is checked. Default: "". |
Definition at line 2169 of file Functions_Matrix.cxx.
void Seldon::CheckDim | ( | const SeldonSide & | side, |
const Matrix< T0, Prop0, Storage0, Allocator0 > & | A, | ||
const Matrix< T1, Prop1, Storage1, Allocator1 > & | B, | ||
string | function | ||
) |
Checks the compatibility of the dimensions.
Checks that A B or B A is possible according to the dimensions of the matrices A and B. If the dimensions are incompatible, an exception is raised (a WrongDim object is thrown).
side | side by which A is multiplied by B. |
A | matrix. |
B | matrix. \function (optional) function in which the compatibility is checked. Default: "". |
Definition at line 2343 of file Functions_Matrix.cxx.
void Seldon::CheckDim | ( | const SeldonTranspose & | trans, |
const Matrix< T0, Prop0, Storage0, Allocator0 > & | M, | ||
const Vector< T1, Storage1, Allocator1 > & | X, | ||
const Vector< T2, Storage2, Allocator2 > & | Y, | ||
string | function, | ||
string | op | ||
) |
Checks the compatibility of the dimensions.
Checks that M X + Y -> Y is possible according to the dimensions of the matrix M and the vectors X and Y. If the dimensions are incompatible, an exception is raised (a WrongDim object is thrown).
trans | status of the matrix M, e.g. transposed. |
M | matrix. |
X | vector. |
Y | vector. |
function | (optional) function in which the compatibility is checked. Default: "". |
op | (optional) operation to be performed on the vectors. Default: "M X + Y -> Y". |
Definition at line 2317 of file Functions_MatVect.cxx.
void Seldon::CheckDim | ( | const SeldonTranspose & | TransA, |
const Matrix< T0, Prop0, Storage0, Allocator0 > & | A, | ||
const SeldonTranspose & | TransB, | ||
const Matrix< T1, Prop1, Storage1, Allocator1 > & | B, | ||
const Matrix< T2, Prop2, Storage2, Allocator2 > & | C, | ||
string | function | ||
) |
Checks the compatibility of the dimensions.
Checks that A B + C -> C is possible according to the dimensions of the matrices A, B and C. If the dimensions are incompatible, an exception is raised (a WrongDim object is thrown).
TransA | status of A, e.g. transposed. |
A | matrix. |
TransB | status of B, e.g. transposed. |
B | matrix. |
C | matrix. \function (optional) function in which the compatibility is checked. Default: "". |
Definition at line 2272 of file Functions_Matrix.cxx.
void Seldon::CheckDim | ( | const SeldonTranspose & | TransA, |
const Matrix< T0, Prop0, Storage0, Allocator0 > & | A, | ||
const SeldonTranspose & | TransB, | ||
const Matrix< T1, Prop1, Storage1, Allocator1 > & | B, | ||
string | function | ||
) |
Checks the compatibility of the dimensions.
Checks that A B -> C is possible according to the dimensions of the matrices A and B. If the dimensions are incompatible, an exception is raised (a WrongDim object is thrown).
TransA | status of A, e.g. transposed. |
A | matrix. |
TransB | status of B, e.g. transposed. |
B | matrix. \function (optional) function in which the compatibility is checked. Default: "". |
Definition at line 2219 of file Functions_Matrix.cxx.
void Seldon::CheckDim | ( | const Vector< FloatDouble, DenseSparseCollection, Allocator0< T0 > > & | X, |
const Vector< FloatDouble, DenseSparseCollection, Allocator1< T1 > > & | Y, | ||
string | function, | ||
string | op | ||
) |
Checks the compatibility of the dimensions.
Checks that X + Y is possible according to the dimensions of the vectors X and Y. If the dimensions are incompatible, an exception is raised (a WrongDim object is thrown).
X | vector. |
Y | vector. |
function | (optional) function in which the compatibility is checked. Default: "". |
op | (optional) operation to be performed on the vectors. Default: "X + Y". |
Definition at line 1012 of file Functions_Vector.cxx.
void Seldon::CheckDim | ( | const Vector< T0, Collection, Allocator0 > & | X, |
const Vector< T1, Collection, Allocator1 > & | Y, | ||
string | function, | ||
string | op | ||
) |
Checks the compatibility of the dimensions.
Checks that X + Y is possible according to the dimensions of the vectors X and Y. If the dimensions are incompatible, an exception is raised (a WrongDim object is thrown).
X | vector. |
Y | vector. |
function | (optional) function in which the compatibility is checked. Default: "". |
op | (optional) operation to be performed on the vectors. Default: "X + Y". |
Definition at line 904 of file Functions_Vector.cxx.
void Seldon::CheckDim | ( | const Vector< T0, Storage0, Allocator0 > & | X, |
const Vector< T1, Storage1, Allocator1 > & | Y, | ||
string | function, | ||
string | op | ||
) |
Checks the compatibility of the dimensions.
Checks that X + Y is possible according to the dimensions of the vectors X and Y. If the dimensions are incompatible, an exception is raised (a WrongDim object is thrown).
X | vector. |
Y | vector. |
function | (optional) function in which the compatibility is checked. Default: "". |
op | (optional) operation to be performed on the vectors. Default: "X + Y". |
Definition at line 848 of file Functions_Vector.cxx.
void Seldon::CheckDim | ( | const Vector< T0, VectFull, Allocator0 > & | X, |
Vector< T1, Collection, Allocator1 > & | Y, | ||
string | function, | ||
string | op | ||
) |
Checks the compatibility of the dimensions.
Checks that X + Y is possible according to the dimensions of the vectors X and Y. If the dimensions are incompatible, an exception is raised (a WrongDim object is thrown).
X | vector. |
Y | vector. |
function | (optional) function in which the compatibility is checked. Default: "". |
op | (optional) operation to be performed on the vectors. Default: "X + Y". |
Definition at line 977 of file Functions_Vector.cxx.
void Seldon::CheckDim | ( | const Vector< T0, VectSparse, Allocator0 > & | X, |
const Vector< T1, VectSparse, Allocator1 > & | Y, | ||
string | function, | ||
string | op | ||
) |
Checks the compatibility of the dimensions.
Checks that X + Y is possible according to the dimensions of the vectors X and Y. If the dimensions are incompatible, an exception is raised (a WrongDim object is thrown).
X | vector. |
Y | vector. |
function | (optional) function in which the compatibility is checked. Default: "". |
op | (optional) operation to be performed on the vectors. Default: "X + Y". |
Definition at line 882 of file Functions_Vector.cxx.
void Seldon::CheckDim | ( | const Vector< Vector< T0, VectSparse, Allocator0 >, Collection, Allocator00 > & | X, |
const Vector< Vector< T1, VectSparse, Allocator1 >, Collection, Allocator11 > & | Y, | ||
string | function, | ||
string | op | ||
) |
Checks the compatibility of the dimensions.
Checks that X + Y is possible according to the dimensions of the vectors X and Y. If the dimensions are incompatible, an exception is raised (a WrongDim object is thrown).
X | vector. |
Y | vector. |
function | (optional) function in which the compatibility is checked. Default: "". |
op | (optional) operation to be performed on the vectors. Default: "X + Y". |
Definition at line 941 of file Functions_Vector.cxx.
int Seldon::CoCg | ( | const Matrix1 & | A, |
Vector1 & | x, | ||
const Vector1 & | b, | ||
Preconditioner & | M, | ||
Iteration< Titer > & | iter | ||
) |
Solves a linear system by using Conjugate Orthogonal Conjugate Gradient.
Solves the symmetric complex linear system A x = b.
return value of 0 indicates convergence within the maximum number of iterations (determined by the iter object). return value of 1 indicates a failure to converge.
See H. Van der Vorst, J. Melissen, A Petrow-Galerkin type method solving Ax=b where A is symmetric complex IEEE Trans. Mag., vol 26, no 2, pp 706-708, 1990
void Seldon::ConvertMatrix_from_Coordinates | ( | const Vector< int, VectFull, Allocator1 > & | IndRow, |
const Vector< int, VectFull, Allocator2 > & | IndCol, | ||
const Vector< T, VectFull, Allocator3 > & | Values, | ||
Matrix< T, Prop, ColSparse, Allocator3 > & | A, | ||
int | index | ||
) |
Conversion from coordinate format to ColSparse.
Definition at line 581 of file Matrix_Conversions.cxx.
void Seldon::ConvertMatrix_from_Coordinates | ( | const Vector< int, VectFull, Allocator1 > & | IndRow, |
const Vector< int, VectFull, Allocator2 > & | IndCol, | ||
const Vector< T, VectFull, Allocator3 > & | Values, | ||
Matrix< T, Prop, RowSparse, Allocator3 > & | A, | ||
int | index | ||
) |
Conversion from coordinate format to RowSparse.
Contrary to the other conversion functions ConvertMatrix_from_Coordinates, this one accepts duplicates.
[in] | IndRow | row indexes of the non-zero elements. |
[in] | IndCol | column indexes of the non-zero elements. |
[in] | Val | values of the non-zero elements. |
[in,out] | A | matrix defined by IndRow, IndCol and Val. |
[in] | index | index of the first column and of the first row. In input, the matrix A can be allocated at the correct size, in that case the number of rows and columns are given by the size of the matrix A. If you want to take exactly the numbers of rows and columns contained in the triplet (IndRow, IndCol, Val) you should call A.Clear() before calling this function. |
Definition at line 515 of file Matrix_Conversions.cxx.
void Seldon::ConvertToCSC | ( | const Matrix< T, Prop, ArrayRowComplexSparse, Alloc1 > & | A, |
General & | sym, | ||
Vector< Tint0, VectFull, Alloc2 > & | Ptr, | ||
Vector< Tint1, VectFull, Alloc3 > & | IndRow, | ||
Vector< T, VectFull, Alloc4 > & | Val, | ||
bool | sym_pat | ||
) |
Conversion from ArrayRowComplexSparse to CSC format.
if sym_pat is equal to true, the pattern is symmetrized by adding artificial null entries
Definition at line 3200 of file Matrix_ComplexConversions.cxx.
void Seldon::ConvertToCSC | ( | const Matrix< T, Prop, RowComplexSparse, Alloc1 > & | A, |
General & | sym, | ||
Vector< Tint0, VectFull, Alloc2 > & | Ptr, | ||
Vector< Tint1, VectFull, Alloc3 > & | IndRow, | ||
Vector< T, VectFull, Alloc4 > & | Val, | ||
bool | sym_pat | ||
) |
Conversion from RowComplexSparse to CSC format.
if sym_pat is equal to true, the pattern is symmetrized by adding artificial null entries
Definition at line 2740 of file Matrix_ComplexConversions.cxx.
void Seldon::ConvertToCSC | ( | const Matrix< T, Prop, RowSparse, Alloc1 > & | A, |
General & | sym, | ||
Vector< Tint0, VectFull, Alloc2 > & | Ptr, | ||
Vector< Tint1, VectFull, Alloc3 > & | IndRow, | ||
Vector< T, VectFull, Alloc4 > & | Val, | ||
bool | sym_pat | ||
) |
Conversion from RowSparse to CSC format.
if sym_pat is equal to true, the pattern is symmetrized by adding artificial null entries
Definition at line 1006 of file Matrix_Conversions.cxx.
void Seldon::CopyMatrix | ( | const Matrix< T1, Prop1, ArrayColSparse, Alloc1 > & | A, |
Matrix< T2, Prop2, RowSparse, Alloc2 > & | B | ||
) |
Conversion from ArrayColSparse to RowSparse.
[in] | A | matrix to be converted. |
[out] | B | converted matrix. |
Definition at line 2646 of file Matrix_Conversions.cxx.
void Seldon::CopyMatrix | ( | const Matrix< T1, Prop1, ColSparse, Alloc1 > & | A, |
Matrix< T2, Prop2, RowSparse, Alloc2 > & | B | ||
) |
Conversion from column-oriented sparse to row-oriented sparse.
[in] | A | matrix to be converted. |
[out] | B | converted matrix. |
Definition at line 2623 of file Matrix_Conversions.cxx.
|
inline |
res = A . B, where the scalar product is performed between columns of A and B
res = res + A . B, where the scalar product is performed between columns of A and B
Definition at line 1680 of file TinyMatrixInline.cxx.
T1 Seldon::DotProdConjVector | ( | const DistributedVector< T1, Allocator1 > & | X, |
const DistributedVector< T1, Allocator1 > & | Y | ||
) |
computation of scalar product X'.Y
Overlapped rows are correctly handled so that the result is the scalar product of the global vectors. The result should be the same on each processor.
Definition at line 69 of file DistributedVector.cxx.
T1 Seldon::DotProdVector | ( | const DistributedVector< T1, Allocator1 > & | X, |
const DistributedVector< T1, Allocator1 > & | Y | ||
) |
computation of scalar product X.Y
Overlapped rows are correctly handled so that the result is the scalar product of the global vectors. The result should be the same on each processor.
Definition at line 34 of file DistributedVector.cxx.
void Seldon::EraseCol | ( | const IVect & | col_number, |
Matrix< T1, Prop, ArrayRowComplexSparse, Allocator > & | A | ||
) |
clears several columns of a sparse matrix
[in] | col_number | numbers of the columns to be cleared |
[in,out] | A | sparse matrix where columns are erased |
Definition at line 1963 of file Functions_MatrixComplex.cxx.
void Seldon::EraseCol | ( | const IVect & | col_number, |
Matrix< T1, Prop, ArrayRowSparse, Allocator > & | A | ||
) |
clears several columns of a sparse matrix
[in] | col_number | numbers of the columns to be cleared |
[in,out] | A | sparse matrix where columns are erased |
Definition at line 2824 of file Functions_MatrixArray.cxx.
void Seldon::EraseCol | ( | const IVect & | col_number, |
Matrix< T1, Prop, ArrayRowSymComplexSparse, Allocator > & | A | ||
) |
clears several columns of a sparse matrix
[in] | col_number | numbers of the columns to be cleared |
[in,out] | A | sparse matrix where columns are erased |
Definition at line 1893 of file Functions_MatrixComplex.cxx.
void Seldon::EraseCol | ( | const IVect & | col_number, |
Matrix< T1, Prop, ArrayRowSymSparse, Allocator > & | A | ||
) |
clears several columns of a sparse matrix
[in] | col_number | numbers of the columns to be cleared |
[in,out] | A | sparse matrix where columns are erased |
Definition at line 2777 of file Functions_MatrixArray.cxx.
void Seldon::EraseCol | ( | const IVect & | col_number, |
Matrix< T1, Prop, RowComplexSparse, Allocator > & | A | ||
) |
clears several columns of a sparse matrix
[in] | col_number | numbers of the columns to be cleared |
[in,out] | A | sparse matrix where columns are erased |
Definition at line 2021 of file Functions_MatrixComplex.cxx.
void Seldon::EraseCol | ( | const IVect & | col_number, |
Matrix< T1, Prop, RowSparse, Allocator > & | A | ||
) |
clears several columns of a sparse matrix
[in] | col_number | numbers of the columns to be cleared |
[in,out] | A | sparse matrix where columns are erased |
Definition at line 2863 of file Functions_MatrixArray.cxx.
void Seldon::EraseCol | ( | const IVect & | col_number, |
Matrix< T1, Prop, RowSymComplexSparse, Allocator > & | A | ||
) |
clears several columns of a sparse matrix
[in] | col_number | numbers of the columns to be cleared |
[in,out] | A | sparse matrix where columns are erased |
Definition at line 2090 of file Functions_MatrixComplex.cxx.
void Seldon::EraseCol | ( | const IVect & | col_number, |
Matrix< T1, Prop, RowSymSparse, Allocator > & | A | ||
) |
clears several columns of a sparse matrix
[in] | col_number | numbers of the columns to be cleared |
[in,out] | A | sparse matrix where columns are erased |
Definition at line 2910 of file Functions_MatrixArray.cxx.
void Seldon::EraseCol | ( | const IVect & | col_number, |
Matrix< T1, Prop, Storage, Allocator > & | A | ||
) |
clears several columns of a sparse matrix
[in] | col_number | numbers of the columns to be cleared |
[in,out] | A | sparse matrix where columns are erased |
Definition at line 2966 of file Functions_MatrixArray.cxx.
void Seldon::EraseCol | ( | const IVect & | num, |
DistributedMatrix< T1, Prop1, Storage1, Allocator1 > & | A | ||
) |
clears several columns of a sparse matrix
[in] | num | numbers of the columns to be cleared |
[in] | comm | MPI communicator |
[in,out] | A | sparse matrix where columns are erased In this functions the column numbers are assumed to be increasing |
Definition at line 6143 of file DistributedMatrix.cxx.
void Seldon::EraseRow | ( | const IVect & | col_number, |
Matrix< T1, Prop, ArrayRowComplexSparse, Allocator > & | A | ||
) |
clears several rows of a sparse matrix
[in] | col_number | numbers of the rows to be cleared |
[in,out] | A | sparse matrix where rows are erased |
Definition at line 2185 of file Functions_MatrixComplex.cxx.
void Seldon::EraseRow | ( | const IVect & | col_number, |
Matrix< T1, Prop, ArrayRowSparse, Allocator > & | A | ||
) |
clears several rows of a sparse matrix
[in] | col_number | numbers of the rows to be cleared |
[in,out] | A | sparse matrix where rows are erased |
Definition at line 3007 of file Functions_MatrixArray.cxx.
void Seldon::EraseRow | ( | const IVect & | col_number, |
Matrix< T1, Prop, ArrayRowSymComplexSparse, Allocator > & | A | ||
) |
clears several rows of a sparse matrix
[in] | col_number | numbers of the rows to be cleared |
[in,out] | A | sparse matrix where rows are erased |
Definition at line 2172 of file Functions_MatrixComplex.cxx.
void Seldon::EraseRow | ( | const IVect & | col_number, |
Matrix< T1, Prop, ArrayRowSymSparse, Allocator > & | A | ||
) |
clears several rows of a sparse matrix
[in] | col_number | numbers of the rows to be cleared |
[in,out] | A | sparse matrix where rows are erased |
Definition at line 2994 of file Functions_MatrixArray.cxx.
void Seldon::EraseRow | ( | const IVect & | col_number, |
Matrix< T1, Prop, RowComplexSparse, Allocator > & | A | ||
) |
clears several rows of a sparse matrix
[in] | col_number | numbers of the rows to be cleared |
[in,out] | A | sparse matrix where rows are erased |
Definition at line 2202 of file Functions_MatrixComplex.cxx.
void Seldon::EraseRow | ( | const IVect & | col_number, |
Matrix< T1, Prop, RowSparse, Allocator > & | A | ||
) |
clears several rows of a sparse matrix
[in] | col_number | numbers of the rows to be cleared |
[in,out] | A | sparse matrix where rows are erased |
Definition at line 3021 of file Functions_MatrixArray.cxx.
void Seldon::EraseRow | ( | const IVect & | col_number, |
Matrix< T1, Prop, RowSymComplexSparse, Allocator > & | A | ||
) |
clears several rows of a sparse matrix
[in] | col_number | numbers of the rows to be cleared |
[in,out] | A | sparse matrix where rows are erased |
Definition at line 2271 of file Functions_MatrixComplex.cxx.
void Seldon::EraseRow | ( | const IVect & | col_number, |
Matrix< T1, Prop, RowSymSparse, Allocator > & | A | ||
) |
clears several rows of a sparse matrix
[in] | col_number | numbers of the rows to be cleared |
[in,out] | A | sparse matrix where rows are erased |
Definition at line 3067 of file Functions_MatrixArray.cxx.
void Seldon::EraseRow | ( | const IVect & | col_number, |
Matrix< T1, Prop, Storage, Allocator > & | A | ||
) |
clears several rows of a sparse matrix
[in] | col_number | numbers of the rows to be cleared |
[in,out] | A | sparse matrix where rows are erased |
Definition at line 2980 of file Functions_MatrixArray.cxx.
void Seldon::EraseRow | ( | const IVect & | num, |
DistributedMatrix< T1, Prop1, Storage1, Allocator1 > & | A | ||
) |
clears several rows of a sparse matrix
[in] | num | numbers of the rows to be cleared |
[in] | comm | MPI communicator |
[in,out] | A | sparse matrix where rows are erased In this functions the row numbers are assumed to be increasing |
Definition at line 6161 of file DistributedMatrix.cxx.
void Seldon::ExchangeRelaxVector | ( | Vector< T > & | X, |
const Treal & | omega, | ||
int | proc, | ||
const IVect & | ProcNumber, | ||
const Vector< IVect > & | DofNumber, | ||
const MPI_Comm & | comm, | ||
int | Nvol, | ||
int | nb_u, | ||
int | tag | ||
) |
exchanges a distributed vector (some rows are shared between processors) only values on shared rows are exchanged
[in,out] | X | vector to assemble |
[in] | ProcNumber | processors interacting with the current processor |
[in] | DofNumber | for each processor, rows to send/receive |
[in] | comm | MPI communicator |
[in] | Nvol | DofNumber will be included between <0, Nvol-1> |
[in] | nb_u | number of unknowns (X is supposed to be of size >= Nvol*nb_u) |
[in] | tag | MPI tag For each unknown, it is assumed that the same row numbers are affected, that's why you can provide DofNumber for only the first unknown and consider that rows of other unknowns are obtained with the operation m*Nvol + i, m in <0, nb_u-1> and m in <0, Nvol-1> |
Definition at line 509 of file DistributedVector.cxx.
void Seldon::ExchangeVector | ( | Vector< T > & | X, |
const IVect & | ProcNumber, | ||
const Vector< IVect > & | DofNumber, | ||
const MPI_Comm & | comm, | ||
int | Nvol, | ||
int | nb_u, | ||
int | tag | ||
) |
assembles a distributed vector (some rows are shared between processors)
[in,out] | X | vector to assemble |
[in] | oper | reduction operator (MPI_SUM, MPI_MIN or MPI_MAX) |
[in] | ProcNumber | processors interacting with the current processor |
[in] | DofNumber | for each processor, rows to send/receive |
[in] | comm | MPI communicator |
[in] | Nvol | DofNumber will be included between <0, Nvol-1> |
[in] | nb_u | number of unknowns (X is supposed to be of size >= Nvol*nb_u) |
[in] | tag | MPI tag For each unknown, it is assumed that the same row numbers are affected, that's why you can provide DofNumber for only the first unknown and consider that rows of other unknowns are obtained with the operation m*Nvol + i, m in <0, nb_u-1> and m in <0, Nvol-1> |
Definition at line 415 of file DistributedVector.cxx.
void Seldon::FindEigenvaluesAnasazi | ( | EigenProblem & | var, |
Vector< T, VectFull, Allocator1 > & | eigen_values, | ||
Vector< T, VectFull, Allocator2 > & | lambda_imag, | ||
Matrix< T, General, ColMajor, Allocator3 > & | eigen_vectors | ||
) |
computation of eigenvalues and related eigenvectors
[in,out] | var | eigenproblem to solve |
[out] | eigen_values | eigenvalue |
[out] | eigen_vectors | eigenvectors |
Definition at line 244 of file Anasazi.cxx.
void Seldon::FindEigenvaluesArpack | ( | EigenProblem & | var, |
Vector< T, VectFull, Allocator1 > & | eigen_values, | ||
Vector< T, VectFull, Allocator2 > & | lambda_imag, | ||
Matrix< T, General, ColMajor, Allocator3 > & | eigen_vectors | ||
) |
computation of eigenvalues and related eigenvectors
[in,out] | var | eigenproblem to solve |
[out] | eigen_values | eigenvalue |
[out] | eigen_vectors | eigenvectors |
Definition at line 41 of file Arpack.cxx.
void Seldon::Gauss | ( | Matrix< T0, Prop0, Storage0, Allocator0 > & | M, |
Vector< T1, Storage1, Allocator1 > & | X | ||
) |
Solves M*Y = X with Gauss method.
Warning: M is modified. The results are stored in X. There is no partial pivoting performed here, the method will fail if a diagonal coefficient generated during the factorisation is equal to 0 For dense matrices, use rather GetLU/SolveLU
Definition at line 1505 of file Functions_MatVect.cxx.
void Seldon::GaussSeidel | ( | const Matrix< T0, Prop0, Storage0, Allocator0 > & | M, |
Vector< T2, Storage2, Allocator2 > & | Y, | ||
const Vector< T1, Storage1, Allocator1 > & | X, | ||
int | iter, | ||
int | type_algo | ||
) |
Solve M*Y = X with Gauss-Seidel method.
Solving M Y = X by using Gauss-Seidel algorithm. iter is the number of iterations. type_algo = 2 forward sweep type_algo = 3 backward sweep type_algo = 0 forward and backward sweep
Definition at line 1566 of file Functions_MatVect.cxx.
int Seldon::Gcr | ( | const Matrix1 & | A, |
Vector1 & | x, | ||
const Vector1 & | b, | ||
Preconditioner & | M, | ||
Iteration< Titer > & | outer | ||
) |
Solves a linear system by using Generalized Conjugate Residual (GCR)
Solves the linear system Ax = b with restarted Preconditioned Generalized Conjugate Residual Algorithm.
return value of 0 indicates convergence within the maximum number of iterations (determined by the iter object). return value of 1 indicates a failure to converge.
See: Y. Saad, Iterative Methods for Sparse Linear System, PWS Publishing Company, 1996
|
inline |
This function solves where is a matrix, and and are vectors.
[in] | M | the sparse matrix of the linear system, to be factorized in LU form by UMFPACK, SuperLU or Mumps. On exit, M is cleared. |
[in,out] | Y | on entry, the right-hand side ; on exit, the solution of the system. |
Definition at line 255 of file SparseDirectSolverInline.cxx.
|
inline |
This function solves where is a matrix, and and are vectors.
[in] | M | the sparse matrix of the linear system, to be factorized in LU form by UMFPACK, SuperLU or Mumps. On exit, M is cleared. |
[in,out] | Y | on entry, the right-hand side ; on exit, the solution of the system. |
Definition at line 285 of file SparseDirectSolverInline.cxx.
|
inline |
This function solves where is a matrix, and and are vectors.
[in] | M | the sparse matrix of the linear system, to be factorized in LU form by UMFPACK, SuperLU or Mumps. On exit, M is cleared. |
[in,out] | Y | on entry, the right-hand side ; on exit, the solution of the system. |
Definition at line 235 of file SparseDirectSolverInline.cxx.
|
inline |
This function solves where is a matrix, and and are vectors.
[in] | M | the sparse matrix of the linear system, to be factorized in LU form by UMFPACK, SuperLU or Mumps. On exit, M is cleared. |
[in,out] | Y | on entry, the right-hand side ; on exit, the solution of the system. |
Definition at line 265 of file SparseDirectSolverInline.cxx.
|
inline |
This function solves where is a matrix, and and are vectors.
[in] | M | the sparse matrix of the linear system, to be factorized in LU form by UMFPACK, SuperLU or Mumps. On exit, M is cleared. |
[in,out] | Y | on entry, the right-hand side ; on exit, the solution of the system. |
Definition at line 245 of file SparseDirectSolverInline.cxx.
|
inline |
This function solves where is a matrix, and and are vectors.
[in] | M | the sparse matrix of the linear system, to be factorized in LU form by UMFPACK, SuperLU or Mumps. On exit, M is cleared. |
[in,out] | Y | on entry, the right-hand side ; on exit, the solution of the system. |
Definition at line 275 of file SparseDirectSolverInline.cxx.
void Seldon::GetAndSolveLU | ( | Matrix< T0, Prop0, Storage0, Allocator0 > & | M, |
Vector< T1, Storage1, Allocator1 > & | Y | ||
) |
Solves a linear system using LU factorization.
This function solves where is a matrix, and and are vectors.
[in] | M | the matrix of the linear system, to be factorized in LU form. On exit, M contains its LU factorization. |
[in,out] | Y | on entry, the right-hand side ; on exit, the solution of the system. |
Definition at line 1841 of file Functions_MatVect.cxx.
void Seldon::GetCholesky | ( | Matrix< T, Prop, ArrayRowSymSparse, Allocator > & | A, |
int | print_level | ||
) |
Implementation of Cholesky factorization for sparse symmetric matrix.
This method may be slow for large matrices. For large matrices, it is more efficient to use an external library (Cholmod for example). No renumbering is performed by this method.
Definition at line 34 of file SparseCholeskyFactorisation.cxx.
void Seldon::GetCol | ( | const Matrix< T0, General, ArrayColSparse, Allocator0 > & | A, |
int | j, | ||
Vector< T1, VectSparse, Allocator1 > & | X | ||
) |
Extracts a column from a matrix.
M | matrix |
j | column index |
X | column extracted X = M(:, j) |
Definition at line 591 of file Functions_MatrixArray.cxx.
void Seldon::GetCol | ( | const Matrix< T0, General, ArrayRowSparse, Allocator0 > & | M, |
int | j, | ||
Vector< T1, VectSparse, Allocator1 > & | X | ||
) |
Extracts a column from a matrix.
M | matrix |
j | column index |
X | column extracted X = M(:, j) |
Definition at line 551 of file Functions_MatrixArray.cxx.
void Seldon::GetCol | ( | const Matrix< T0, General, ColSparse, Allocator0 > & | M, |
int | j, | ||
Vector< T1, VectSparse, Allocator1 > & | X | ||
) |
Extracts a column from a sparse matrix.
M | sparse matrix |
j | column index |
X | column extracted X = M(:, j) |
Definition at line 261 of file Functions.cxx.
void Seldon::GetCol | ( | const Matrix< T0, General, RowSparse, Allocator0 > & | M, |
int | j, | ||
Vector< T1, VectSparse, Allocator1 > & | X | ||
) |
Extracts a column from a matrix.
M | matrix |
j | column index |
X | column extracted X = M(:, j) |
Definition at line 295 of file Functions.cxx.
void Seldon::GetCol | ( | const Matrix< T0, Prop0, PETScMPIDense, Allocator0 > & | M, |
int | j, | ||
Vector< T1, PETScPar, Allocator1 > & | X | ||
) |
Extracts a column from a matrix.
[in] | M | matrix. |
[in] | j | column index. |
[out] | X | extracted column. |
Definition at line 388 of file Functions.cxx.
void Seldon::GetCol | ( | const Matrix< T0, Prop0, PETScSeqDense, Allocator0 > & | M, |
int | j, | ||
Vector< T1, PETScSeq, Allocator1 > & | X | ||
) |
Extracts a column from a matrix.
[in] | M | matrix. |
[in] | j | column index. |
[out] | X | extracted column. |
Definition at line 369 of file Functions.cxx.
void Seldon::GetCol | ( | const Matrix< T0, Prop0, Storage0, Allocator0 > & | M, |
int | j, | ||
Vector< T1, Storage1, Allocator1 > & | X | ||
) |
Extracts a column from a matrix.
M | matrix |
j | column index |
X | column extracted X = M(:, j) |
Definition at line 408 of file Functions.cxx.
void Seldon::GetCol | ( | const Matrix< T0, Prop0, Storage0, Allocator0 > & | M_in, |
int | begin, | ||
int | end, | ||
Matrix< T1, Prop1, Storage1, Allocator1 > & | M_out | ||
) |
Extracts columns of a matrix.
Columns [begin, end[ of M_in are returned in M_out.
[in] | M_in | input matrix. |
[in] | begin | first column of M_in to extract. |
[in] | end | the last column to be extracted from M_in is end - 1. |
[out] | M_out | on exit, matrix composed of the columns begin to end - 1 of M_in. M_out is reallocated if necessary. |
Definition at line 430 of file Functions.cxx.
void Seldon::GetCol | ( | const Matrix< T0, Symmetric, ArrayColSymSparse, Allocator0 > & | M, |
int | j, | ||
Vector< T1, VectSparse, Allocator1 > & | X | ||
) |
Extracts a column from a sparse matrix.
M | sparse matrix |
j | column index |
X | column extracted X = M(:, j) |
Definition at line 636 of file Functions_MatrixArray.cxx.
void Seldon::GetCol | ( | const Matrix< T0, Symmetric, ArrayRowSymSparse, Allocator0 > & | M, |
int | j, | ||
Vector< T1, VectSparse, Allocator1 > & | X | ||
) |
Extracts a column from a sparse matrix.
M | sparse matrix |
j | column index |
X | column extracted X = M(:, j) |
Definition at line 620 of file Functions_MatrixArray.cxx.
void Seldon::GetCol | ( | const Matrix< T0, Symmetric, ColSymSparse, Allocator0 > & | M, |
int | j, | ||
Vector< T1, VectSparse, Allocator1 > & | X | ||
) |
Extracts a column from a sparse matrix.
M | sparse matrix |
j | column index |
X | column extracted X = M(:, j) |
Definition at line 337 of file Functions.cxx.
void Seldon::GetCol | ( | const Matrix< T0, Symmetric, RowSymSparse, Allocator0 > & | M, |
int | j, | ||
Vector< T1, VectSparse, Allocator1 > & | X | ||
) |
Extracts a column from a sparse matrix.
M | sparse matrix |
j | column index |
X | column extracted X = M(:, j) |
Definition at line 353 of file Functions.cxx.
void Seldon::GetColSum | ( | Vector< T > & | diagonal_scale, |
const Matrix< Complexe, General, ArrayRowSparse, Allocator > & | mat_direct | ||
) |
For each column of the matrix, computation of the sum of absolute values.
[out] | diagonal_scale | vector containing the sum of the magnitudes of non-zero entries of each column |
[in] | mat_direct | given matrix |
Definition at line 3177 of file Functions_MatrixArray.cxx.
void Seldon::GetColSum | ( | Vector< T > & | diagonal_scale, |
const Matrix< Complexe, General, RowSparse, Allocator > & | mat_direct | ||
) |
For each column of the matrix, computation of the sum of absolute values.
[out] | diagonal_scale | vector containing the sum of the magnitudes of non-zero entries of each column |
[in] | mat_direct | given matrix |
Definition at line 3213 of file Functions_MatrixArray.cxx.
void Seldon::GetColSum | ( | Vector< T > & | diagonal_scale, |
const Matrix< Complexe, Symmetric, ArrayRowSymSparse, Allocator > & | mat_direct | ||
) |
For each column of the matrix, computation of the sum of absolute values.
[out] | diagonal_scale | vector containing the sum of the magnitudes of non-zero entries of each column |
[in] | mat_direct | given matrix |
Definition at line 3198 of file Functions_MatrixArray.cxx.
void Seldon::GetColSum | ( | Vector< T > & | diagonal_scale, |
const Matrix< Complexe, Symmetric, RowSymSparse, Allocator > & | mat_direct | ||
) |
For each column of the matrix, computation of the sum of absolute values.
[out] | diagonal_scale | vector containing the sum of the magnitudes of non-zero entries of each column |
[in] | mat_direct | given matrix |
Definition at line 3237 of file Functions_MatrixArray.cxx.
void Seldon::GetColSum | ( | Vector< T0 > & | vec_sum, |
const DistributedMatrix< T, Prop, Storage, Allocator > & | A | ||
) |
For each column of the matrix, computation of the sum of absolute values.
The result is different from a sequential execution (because some non-zero entries may be shared by different processors)
Definition at line 5524 of file DistributedMatrix.cxx.
void Seldon::GetColSum | ( | Vector< typename ClassComplexType< T >::Treal > & | diagonal_scale, |
const Matrix< T, General, ArrayRowComplexSparse > & | mat | ||
) |
For each column of the matrix, computation of the sum of absolute values.
[out] | diagonal_scale | vector containing the sum of the magnitudes of non-zero entries of each column |
[in] | mat | given matrix |
Definition at line 2423 of file Functions_MatrixComplex.cxx.
void Seldon::GetColSum | ( | Vector< typename ClassComplexType< T >::Treal > & | diagonal_scale, |
const Matrix< T, General, RowComplexSparse > & | mat | ||
) |
For each column of the matrix, computation of the sum of absolute values.
[out] | diagonal_scale | vector containing the sum of the magnitudes of non-zero entries of each column |
[in] | mat | given matrix |
Definition at line 2461 of file Functions_MatrixComplex.cxx.
void Seldon::GetColSum | ( | Vector< typename ClassComplexType< T >::Treal > & | diagonal_scale, |
const Matrix< T, Symmetric, ArrayRowSymComplexSparse > & | mat | ||
) |
For each column of the matrix, computation of the sum of absolute values.
[out] | diagonal_scale | vector containing the sum of the magnitudes of non-zero entries of each column |
[in] | mat | given matrix |
Definition at line 2409 of file Functions_MatrixComplex.cxx.
void Seldon::GetColSum | ( | Vector< typename ClassComplexType< T >::Treal > & | diagonal_scale, |
const Matrix< T, Symmetric, RowSymComplexSparse > & | mat | ||
) |
For each column of the matrix, computation of the sum of absolute values.
[out] | diagonal_scale | vector containing the sum of the magnitudes of non-zero entries of each column |
[in] | mat | given matrix |
Definition at line 2447 of file Functions_MatrixComplex.cxx.
void Seldon::GetHessenberg | ( | Matrix< complex< double >, General, ColMajor, Alloc > & | A, |
Matrix< complex< double >, General, ColMajor, Alloc > & | B, | ||
Matrix< complex< double >, General, ColMajor, Alloc > & | Q, | ||
Matrix< complex< double >, General, ColMajor, Alloc > & | Z, | ||
LapackInfo & | info | ||
) |
Reduces A and B to their Hessenberg form.
From square matrices A and B, this method produces an upper Hessenberg matrix AA and an upper triangular matrix BB and orthogonal matrices Q, Z such that Q^H A Z = AA and Q^H B Z = BB A and B are overwritten with matrices AA and BB Equivalent Matlab function : [A, B, Q, Z] = hess(A, B); Q = Q'; Z = Z';
Definition at line 4546 of file Lapack_Eigenvalues.cxx.
void Seldon::GetHessenberg | ( | Matrix< complex< double >, General, ColMajor, Alloc > & | A, |
Matrix< complex< double >, General, ColMajor, Alloc > & | Q, | ||
LapackInfo & | info | ||
) |
Reduces A to their Hessenberg form.
This methode reduces A to Hessenberg form through orthogonal transformation such that Q^H A Q = AA, AA being an Hessenberg matrix. A is overwritten with matrix AA Equivalent Matlab function : [Q, A] = hess(A);
Definition at line 4494 of file Lapack_Eigenvalues.cxx.
void Seldon::GetHessenberg | ( | Matrix< double, General, ColMajor, Alloc > & | A, |
Matrix< double, General, ColMajor, Alloc > & | B, | ||
Matrix< double, General, ColMajor, Alloc > & | Q, | ||
Matrix< double, General, ColMajor, Alloc > & | Z, | ||
LapackInfo & | info | ||
) |
Reduces A and B to their Hessenberg form.
From square matrices A and B, this method produces an upper Hessenberg matrix AA and an upper triangular matrix BB and orthogonal matrices Q, Z such that Q^T A Z = AA and Q^T B Z = BB A and B are overwritten with matrices AA and BB Equivalent Matlab function : [A, B, Q, Z] = hess(A, B); Q = Q'; Z = Z';
Definition at line 5152 of file Lapack_Eigenvalues.cxx.
void Seldon::GetIluk | ( | int | lfil, |
int | print_level, | ||
Matrix< cplx, Symmetric, ArrayRowSymSparse, Allocator > & | A | ||
) |
Basic ilu(k) solver.
lfil | level k |
print_level | if print_level > 0, messages are displayed |
A | on input the matrix, on output factors L and U |
Definition at line 355 of file SymmetricIlutPreconditioning.cxx.
void Seldon::GetInverse | ( | TinyMatrix< T, General, m, m > & | A | ) |
A is replaced by its inverse.
LU factorisation is performed, then inverse is formed All the loops are unrolled, so that this function is very efficient for small values of m, more efficient than Lapack when m < 10. Partial pivoting is used so that this algorithm always works if A is invertible.
Definition at line 290 of file TinyMatrix.cxx.
void Seldon::GetInverse | ( | TinyMatrix< T, Symmetric, m, m > & | A | ) |
replaces A by its inverse
For symmetric matrices, we use the unsymmetric algorithm. It should be more efficient to write a specified algorithm for symmetric matrices.
Definition at line 327 of file TinyMatrix.cxx.
void Seldon::GetLowerTriangular | ( | const Matrix< T, Prop, Storage, Allocator > & | A, |
Matrix< T2, Prop2, Storage2, Allocator2 > & | B | ||
) |
generic function to extract lower triangular part of a matrix
Equivalent Matlab function : B = tril(A)
Definition at line 2567 of file Lapack_LeastSquares.cxx.
void Seldon::GetLQ | ( | const Matrix< T, Prop, Storage, Allocator > & | A, |
Matrix< T2, Prop2, Storage2, Allocator2 > & | L, | ||
Matrix< T3, Prop3, Storage3, Allocator3 > & | Q | ||
) |
Generic function to explicit L, and Q from LQ factorisation of a matrix.
Equivalent Matlab function : [L, Q] = lq(A)
Definition at line 2645 of file Lapack_LeastSquares.cxx.
void Seldon::GetLU | ( | Matrix< T0, Prop0, Storage0, Allocator0 > & | A | ) |
Returns the LU factorization of a matrix.
It factorizes the matrix A into L and U, so that , L is a lower triangular matrix with ones on the diagonal, and U is an upper triangular matrix. On exit, the LU factorization is stored inside A: L in the lower part and U in the upper part. The diagonal elements are those of U. The diagonal elements of L are known to be ones.
[in,out] | A | on entry, the matrix to be factorized; on exit, the LU factorization. |
Definition at line 2073 of file Functions_Matrix.cxx.
void Seldon::GetQR | ( | const Matrix< T, Prop, Storage, Allocator > & | A, |
Matrix< T2, Prop2, Storage2, Allocator2 > & | Q, | ||
Matrix< T3, Prop3, Storage3, Allocator3 > & | R | ||
) |
Generic function to explicit Q and R from QR factorisation of a matrix.
Equivalent Matlab function : [Q, R] = qr(A)
Definition at line 2621 of file Lapack_LeastSquares.cxx.
void Seldon::GetQZ | ( | Matrix< complex< double >, General, ColMajor, Alloc > & | A, |
Matrix< complex< double >, General, ColMajor, Alloc > & | B, | ||
Matrix< complex< double >, General, ColMajor, Alloc > & | Q, | ||
Matrix< complex< double >, General, ColMajor, Alloc > & | Z, | ||
LapackInfo & | info | ||
) |
Reduces A and B to quasi-triangular matrices.
From square matrices A and B, this method produces triangular matrices AA, BB and orthogonal matrices Q, Z such that Q^H A Z = AA and Q^H B Z = BB A and B are overwritten with matrices AA and BB Equivalent Matlab function : [A, B, Q, Z] = qz(A, B); Q = Q'; Z = Z';
Definition at line 4617 of file Lapack_Eigenvalues.cxx.
void Seldon::GetQZ | ( | Matrix< double, General, ColMajor, Alloc > & | A, |
Matrix< double, General, ColMajor, Alloc > & | B, | ||
Matrix< double, General, ColMajor, Alloc > & | Q, | ||
Matrix< double, General, ColMajor, Alloc > & | Z, | ||
LapackInfo & | info | ||
) |
Reduces A and B to quasi-triangular matrices.
From square matrices A and B, this method produces quasi-triangular matrices AA, BB and orthogonal matrices Q, Z such that Q^T A Z = AA and Q^T B Z = BB A and B are overwritten with matrices AA and BB Equivalent Matlab function : [A, B, Q, Z] = qz(A, B,'real'); Q = Q'; Z = Z';
Definition at line 5223 of file Lapack_Eigenvalues.cxx.
void Seldon::GetRow | ( | const Matrix< T0, General, ArrayColSparse, Allocator0 > & | M, |
int | i, | ||
Vector< T1, VectSparse, Allocator1 > & | X | ||
) |
Extracts a row from a sparse matrix.
M | sparse matrix |
i | row index |
X | row extracted X = M(i, :) |
Definition at line 120 of file Functions_MatrixArray.cxx.
void Seldon::GetRow | ( | const Matrix< T0, General, ArrayRowSparse, Allocator0 > & | A, |
int | i, | ||
Vector< T1, VectSparse, Allocator1 > & | X | ||
) |
Extracts a row from a sparse matrix.
A | sparse matrix |
i | row index |
X | row extracted X = A(i, :) |
Definition at line 91 of file Functions_MatrixArray.cxx.
void Seldon::GetRow | ( | const Matrix< T0, General, ColSparse, Allocator0 > & | M, |
int | i, | ||
Vector< T1, VectSparse, Allocator1 > & | X | ||
) |
Extracts a row from a sparse matrix.
M | sparse matrix |
i | row index |
X | row extracted X = M(i, :) |
Definition at line 114 of file Functions.cxx.
void Seldon::GetRow | ( | const Matrix< T0, General, RowSparse, Allocator0 > & | M, |
int | i, | ||
Vector< T1, VectSparse, Allocator1 > & | X | ||
) |
Extracts a row from a sparse matrix.
M | sparse matrix |
i | row index |
X | row extracted X = M(i, :) |
Definition at line 80 of file Functions.cxx.
void Seldon::GetRow | ( | const Matrix< T0, Prop0, Storage0, Allocator0 > & | M, |
int | i, | ||
Vector< T1, Storage1, Allocator1 > & | X | ||
) |
Extracts a row from a matrix.
M | matrix |
i | row index |
X | row extracted X = M(i, :) |
Definition at line 241 of file Functions.cxx.
void Seldon::GetRow | ( | const Matrix< T0, Symmetric, ArrayColSymSparse, Allocator0 > & | M, |
int | i, | ||
Vector< T1, VectSparse, Allocator1 > & | X | ||
) |
Extracts a row from a sparse matrix.
M | sparse matrix |
i | row index |
X | row extracted X = M(i, :) |
Definition at line 199 of file Functions_MatrixArray.cxx.
void Seldon::GetRow | ( | const Matrix< T0, Symmetric, ArrayRowSymSparse, Allocator0 > & | M, |
int | i, | ||
Vector< T1, VectSparse, Allocator1 > & | X | ||
) |
Extracts a row from a sparse matrix.
M | sparse matrix |
i | row index |
X | row extracted X = M(i, :) |
Definition at line 157 of file Functions_MatrixArray.cxx.
void Seldon::GetRow | ( | const Matrix< T0, Symmetric, ColSymSparse, Allocator0 > & | M, |
int | i, | ||
Vector< T1, VectSparse, Allocator1 > & | X | ||
) |
Extracts a row from a sparse matrix.
M | sparse matrix |
i | row index |
X | row extracted X = M(i, :) |
Definition at line 197 of file Functions.cxx.
void Seldon::GetRow | ( | const Matrix< T0, Symmetric, RowSymSparse, Allocator0 > & | M, |
int | i, | ||
Vector< T1, VectSparse, Allocator1 > & | X | ||
) |
Extracts a row from a sparse matrix.
M | sparse matrix |
i | row index |
X | row extracted X = M(i, :) |
Definition at line 154 of file Functions.cxx.
void Seldon::GetRowColSum | ( | Vector< T > & | sum_row, |
Vector< T > & | sum_col, | ||
const Matrix< Complexe, General, ArrayRowSparse, Allocator > & | A | ||
) |
For each row and column of the matrix, computation of the sum of absolute values.
[out] | sum_row | vector containing the sum of the magnitudes of non-zero entries of each row |
[out] | sum_col | vector containing the sum of the magnitudes of non-zero entries of each column |
[in] | A | given matrix |
Definition at line 3255 of file Functions_MatrixArray.cxx.
void Seldon::GetRowColSum | ( | Vector< T > & | sum_row, |
Vector< T > & | sum_col, | ||
const Matrix< Complexe, General, RowSparse, Allocator > & | A | ||
) |
For each row and column of the matrix, computation of the sum of absolute values.
[out] | sum_row | vector containing the sum of the magnitudes of non-zero entries of each row |
[out] | sum_col | vector containing the sum of the magnitudes of non-zero entries of each column |
[in] | A | given matrix |
Definition at line 3304 of file Functions_MatrixArray.cxx.
void Seldon::GetRowColSum | ( | Vector< T > & | sum_row, |
Vector< T > & | sum_col, | ||
const Matrix< Complexe, Symmetric, ArrayRowSymSparse, Allocator > & | A | ||
) |
For each row and column of the matrix computation of the sum of absolute values.
[out] | sum_row | vector containing the sum of the magnitudes of non-zero entries of each row |
[out] | sum_col | vector containing the sum of the magnitudes of non-zero entries of each column |
[in] | A | given matrix |
Definition at line 3284 of file Functions_MatrixArray.cxx.
void Seldon::GetRowColSum | ( | Vector< T > & | sum_row, |
Vector< T > & | sum_col, | ||
const Matrix< Complexe, Symmetric, RowSymSparse, Allocator > & | A | ||
) |
For each row and column of the matrix, computation of the sum of absolute values.
[out] | sum_row | vector containing the sum of the magnitudes of non-zero entries of each row |
[out] | sum_col | vector containing the sum of the magnitudes of non-zero entries of each column |
[in] | A | given matrix |
Definition at line 3336 of file Functions_MatrixArray.cxx.
void Seldon::GetRowColSum | ( | Vector< T0 > & | sum_row, |
Vector< T0 > & | sum_col, | ||
const DistributedMatrix< T, Prop, Storage, Allocator > & | A | ||
) |
gets sum of absolute value for each row and each colum
The result is different from a sequential execution (because some non-zero entries may be shared by different processors)
Definition at line 5540 of file DistributedMatrix.cxx.
void Seldon::GetRowColSum | ( | Vector< typename ClassComplexType< T >::Treal > & | sum_row, |
Vector< typename ClassComplexType< T >::Treal > & | sum_col, | ||
const Matrix< T, General, ArrayRowComplexSparse > & | mat | ||
) |
For each row and column of the matrix, computation of the sum of absolute values.
[out] | sum_row | vector containing the sum of the magnitudes of non-zero entries of each row |
[out] | sum_col | vector containing the sum of the magnitudes of non-zero entries of each column |
[in] | mat | given matrix |
Definition at line 2513 of file Functions_MatrixComplex.cxx.
void Seldon::GetRowColSum | ( | Vector< typename ClassComplexType< T >::Treal > & | sum_row, |
Vector< typename ClassComplexType< T >::Treal > & | sum_col, | ||
const Matrix< T, General, RowComplexSparse > & | mat | ||
) |
For each row and column of the matrix, computation of the sum of absolute values.
[out] | sum_row | vector containing the sum of the magnitudes of non-zero entries of each row |
[out] | sum_col | vector containing the sum of the magnitudes of non-zero entries of each column |
[in] | mat | given matrix |
Definition at line 2568 of file Functions_MatrixComplex.cxx.
void Seldon::GetRowColSum | ( | Vector< typename ClassComplexType< T >::Treal > & | sum_row, |
Vector< typename ClassComplexType< T >::Treal > & | sum_col, | ||
const Matrix< T, Symmetric, ArrayRowSymComplexSparse > & | mat | ||
) |
For each row and column of the matrix, computation of the sum of absolute values.
[out] | sum_row | vector containing the sum of the magnitudes of non-zero entries of each row |
[out] | sum_col | vector containing the sum of the magnitudes of non-zero entries of each column |
[in] | mat | given matrix |
Definition at line 2494 of file Functions_MatrixComplex.cxx.
void Seldon::GetRowColSum | ( | Vector< typename ClassComplexType< T >::Treal > & | sum_row, |
Vector< typename ClassComplexType< T >::Treal > & | sum_col, | ||
const Matrix< T, Symmetric, RowSymComplexSparse > & | mat | ||
) |
For each row and column of the matrix, computation of the sum of absolute values.
[out] | sum_row | vector containing the sum of the magnitudes of non-zero entries of each row |
[out] | sum_col | vector containing the sum of the magnitudes of non-zero entries of each column |
[in] | mat | given matrix |
Definition at line 2549 of file Functions_MatrixComplex.cxx.
void Seldon::GetRowSum | ( | Vector< T > & | diagonal_scale_left, |
const Matrix< Complexe, General, ArrayRowSparse, Allocator > & | mat_direct | ||
) |
For each row of the matrix, computation of the sum of absolute values.
[out] | diagonal_scale_left | vector containing the sum of the magnitudes of non-zero entries of each row |
[in] | mat_direct | given matrix |
Definition at line 3081 of file Functions_MatrixArray.cxx.
void Seldon::GetRowSum | ( | Vector< T > & | diagonal_scale_left, |
const Matrix< Complexe, General, RowSparse, Allocator > & | mat_direct | ||
) |
For each row of the matrix, computation of the sum of absolute values.
[out] | diagonal_scale_left | vector containing the sum of the magnitudes of non-zero entries of each row |
[in] | mat_direct | given matrix |
Definition at line 3127 of file Functions_MatrixArray.cxx.
void Seldon::GetRowSum | ( | Vector< T > & | diagonal_scale_left, |
const Matrix< Complexe, Symmetric, ArrayRowSymSparse, Allocator > & | mat_direct | ||
) |
For each row of the matrix, computation of the sum of absolute values.
[out] | diagonal_scale_left | vector containing the sum of the magnitudes of non-zero entries of each row |
[in] | mat_direct | given matrix |
Definition at line 3102 of file Functions_MatrixArray.cxx.
void Seldon::GetRowSum | ( | Vector< T > & | diagonal_scale_left, |
const Matrix< Complexe, Symmetric, RowSymSparse, Allocator > & | mat_direct | ||
) |
For each row of the matrix, computation of the sum of absolute values.
[out] | diagonal_scale_left | vector containing the sum of the magnitudes of non-zero entries of each row |
[in] | mat_direct | given matrix |
Definition at line 3150 of file Functions_MatrixArray.cxx.
void Seldon::GetRowSum | ( | Vector< T0 > & | vec_sum, |
const DistributedMatrix< T, Prop, Storage, Allocator > & | A | ||
) |
For each row of the matrix, computation of the sum of absolute values.
The result is different from a sequential execution (because some non-zero entries may be shared by different processors)
Definition at line 5507 of file DistributedMatrix.cxx.
void Seldon::GetRowSum | ( | Vector< typename ClassComplexType< T >::Treal > & | diagonal_scale_left, |
const Matrix< T, General, ArrayRowComplexSparse > & | mat | ||
) |
For each row of the matrix, computation of the sum of absolute values.
[out] | diagonal_scale_left | vector containing the sum of the magnitudes of non-zero entries of each row |
[in] | mat | given matrix |
Definition at line 2319 of file Functions_MatrixComplex.cxx.
void Seldon::GetRowSum | ( | Vector< typename ClassComplexType< T >::Treal > & | diagonal_scale_left, |
const Matrix< T, General, RowComplexSparse > & | mat | ||
) |
For each row of the matrix, computation of the sum of absolute values.
[out] | diagonal_scale_left | vector containing the sum of the magnitudes of non-zero entries of each row |
[in] | mat | given matrix |
Definition at line 2381 of file Functions_MatrixComplex.cxx.
void Seldon::GetRowSum | ( | Vector< typename ClassComplexType< T >::Treal > & | diagonal_scale_left, |
const Matrix< T, Symmetric, ArrayRowSymComplexSparse > & | mat | ||
) |
For each row of the matrix, computation of the sum of absolute values.
[out] | diagonal_scale_left | vector containing the sum of the magnitudes of non-zero entries of each row |
[in] | mat | given matrix |
Definition at line 2285 of file Functions_MatrixComplex.cxx.
void Seldon::GetRowSum | ( | Vector< typename ClassComplexType< T >::Treal > & | diagonal_scale_left, |
const Matrix< T, Symmetric, RowSymComplexSparse > & | mat | ||
) |
For each row of the matrix, computation of the sum of absolute values.
[out] | diagonal_scale_left | vector containing the sum of the magnitudes of non-zero entries of each row |
[in] | mat | given matrix |
Definition at line 2343 of file Functions_MatrixComplex.cxx.
void Seldon::GetSymmetricPattern | ( | const Matrix< T, Prop, Storage, Allocator > & | A, |
Vector< Tint0, VectFull, Allocator2 > & | Ptr, | ||
Vector< Tint1, VectFull, Allocator3 > & | Ind | ||
) |
Returns pattern of A + A' in CSR format.
From a sparse matrix, we compute the pattern of A + A' so that this pattern is symmetric even if A is non-symmetric
Definition at line 3356 of file Matrix_Conversions.cxx.
void Seldon::GetUpperTriangular | ( | const Matrix< T, Prop, Storage, Allocator > & | A, |
Matrix< T2, Prop2, Storage2, Allocator2 > & | B | ||
) |
generic function to extract upper triangular part of a matrix
Equivalent Matlab function : B = triu(A)
Definition at line 2594 of file Lapack_LeastSquares.cxx.
int Seldon::Gmres | ( | const MatrixSparse & | A, |
Vector1 & | x, | ||
const Vector1 & | b, | ||
Preconditioner & | M, | ||
Iteration< Titer > & | outer | ||
) |
Solves a linear system by using Generalized Minimum Residual (GMRES)
Solves the unsymmetric linear system Ax = b using restarted GMRES.
return value of 0 indicates convergence within the maximum number of iterations (determined by the iter object). return value of 1 indicates a failure to converge.
See: Y. Saad and M. Schulter. GMRES: A generalized minimum residual algorithm for solving nonsysmmetric linear systems, SIAM J. Sci. Statist. Comp. 7(1986), pp, 856-869
int Seldon::IntersectionDroites | ( | const TinyVector< T, 2 > & | pointA, |
const TinyVector< T, 2 > & | pointB, | ||
const TinyVector< T, 2 > & | pt1, | ||
const TinyVector< T, 2 > & | pt2, | ||
TinyVector< T, 2 > & | res, | ||
const T & | threshold | ||
) |
intersection of lines [pointA,pointB] and [pt1,pt2]
[in] | pointA | a point of the first line |
[in] | pointB | a point of the first line |
[in] | pt1 | a point of the second line |
[in] | pt2 | a point of the second line |
[out] | res | intersection |
[in] | threshold | accuracy of points |
Definition at line 74 of file TinyVector.cxx.
int Seldon::IntersectionEdges | ( | const TinyVector< T, 2 > & | pointA, |
const TinyVector< T, 2 > & | pointB, | ||
const TinyVector< T, 2 > & | pt1, | ||
const TinyVector< T, 2 > & | pt2, | ||
TinyVector< T, 2 > & | res, | ||
const T & | threshold | ||
) |
intersection of edges [pointA,pointB] and [pt1,pt2]
[in] | pointA | first extremity of the first edge |
[in] | pointB | second extremity of the first edge |
[in] | pt1 | first extremity of the second edge |
[in] | pt2 | second extremity of the second edge |
[out] | res | intersection |
[in] | threshold | accuracy of points |
Definition at line 19 of file TinyVector.cxx.
int Seldon::Lsqr | ( | const Matrix1 & | A, |
Vector1 & | x, | ||
const Vector1 & | b, | ||
Preconditioner & | M, | ||
Iteration< Titer > & | iter | ||
) |
Solves a linear system by using Least Squares (LSQR)
Solves the unsymmetric linear system A x = b.
return value of 0 indicates convergence within the maximum number of iterations (determined by the iter object). return value of 1 indicates a failure to converge.
ClassComplexType< T1 >::Treal Seldon::MaxAbs | ( | const DistributedMatrix< T1, Prop1, Storage1, Allocator1 > & | A | ) |
returns the maximal element (in absolute value) of the matrix
The result will be different from a sequential execution since A(i, j) is obtained as a sum of values stored in different processors
Definition at line 5490 of file DistributedMatrix.cxx.
ClassComplexType< T >::Treal Seldon::MaxAbs | ( | const Matrix< T, Prop, ArrayColSparse, Allocator > & | A | ) |
Returns the maximum (in absolute value) of a matrix.
[in] | A | matrix. |
Definition at line 1940 of file Functions_MatrixArray.cxx.
ClassComplexType< T >::Treal Seldon::MaxAbs | ( | const Matrix< T, Prop, ArrayColSymSparse, Allocator > & | A | ) |
Returns the maximum (in absolute value) of a matrix.
[in] | A | matrix. |
Definition at line 2057 of file Functions_MatrixArray.cxx.
ClassComplexType< T >::Treal Seldon::MaxAbs | ( | const Matrix< T, Prop, ArrayRowComplexSparse, Allocator > & | A | ) |
Returns the maximum (in absolute value) of a matrix.
[in] | A | matrix. |
Definition at line 1195 of file Functions_MatrixComplex.cxx.
ClassComplexType< T >::Treal Seldon::MaxAbs | ( | const Matrix< T, Prop, ArrayRowSparse, Allocator > & | A | ) |
Returns the maximum (in absolute value) of a matrix.
[in] | A | matrix. |
Definition at line 1878 of file Functions_MatrixArray.cxx.
ClassComplexType< T >::Treal Seldon::MaxAbs | ( | const Matrix< T, Prop, ArrayRowSymComplexSparse, Allocator > & | A | ) |
Returns the maximum (in absolute value) of a matrix.
[in] | A | matrix. |
Definition at line 1482 of file Functions_MatrixComplex.cxx.
ClassComplexType< T >::Treal Seldon::MaxAbs | ( | const Matrix< T, Prop, ArrayRowSymSparse, Allocator > & | A | ) |
Returns the maximum (in absolute value) of a matrix.
[in] | A | matrix. |
Definition at line 2002 of file Functions_MatrixArray.cxx.
ClassComplexType< T >::Treal Seldon::MaxAbs | ( | const Matrix< T, Prop, ColSparse, Allocator > & | A | ) |
Returns the maximum (in absolute value) of a matrix.
[in] | A | matrix. |
Definition at line 2524 of file Functions_Matrix.cxx.
ClassComplexType< T >::Treal Seldon::MaxAbs | ( | const Matrix< T, Prop, ColSymSparse, Allocator > & | A | ) |
Returns the maximum (in absolute value) of a matrix.
[in] | A | matrix. |
Definition at line 2641 of file Functions_Matrix.cxx.
ClassComplexType< T >::Treal Seldon::MaxAbs | ( | const Matrix< T, Prop, RowComplexSparse, Allocator > & | A | ) |
Returns the maximum (in absolute value) of a matrix.
[in] | A | matrix. |
Definition at line 1239 of file Functions_MatrixComplex.cxx.
ClassComplexType< T >::Treal Seldon::MaxAbs | ( | const Matrix< T, Prop, RowSparse, Allocator > & | A | ) |
Returns the maximum (in absolute value) of a matrix.
[in] | A | matrix. |
Definition at line 2462 of file Functions_Matrix.cxx.
ClassComplexType< T >::Treal Seldon::MaxAbs | ( | const Matrix< T, Prop, RowSymComplexSparse, Allocator > & | A | ) |
Returns the maximum (in absolute value) of a matrix.
[in] | A | matrix. |
Definition at line 1526 of file Functions_MatrixComplex.cxx.
ClassComplexType< T >::Treal Seldon::MaxAbs | ( | const Matrix< T, Prop, RowSymSparse, Allocator > & | A | ) |
Returns the maximum (in absolute value) of a matrix.
[in] | A | matrix. |
Definition at line 2586 of file Functions_Matrix.cxx.
ClassComplexType< T >::Treal Seldon::MaxAbs | ( | const Matrix< T, Prop, Storage, Allocator > & | A | ) |
Returns the maximum (in absolute value) of a matrix.
[in] | A | matrix. |
Definition at line 2386 of file Functions_Matrix.cxx.
void Seldon::MergeSort | ( | long | m, |
long | n, | ||
Vector< T, Storage, Allocator > & | tab1 | ||
) |
Vector tab1 is sorted by using MergeSort algorithm.
Sorts array tab1 between position m and n.
Definition at line 256 of file Functions_Arrays.cxx.
void Seldon::MergeSort | ( | long | m, |
long | n, | ||
Vector< T1, Storage1, Allocator1 > & | tab1, | ||
Vector< T2, Storage2, Allocator2 > & | tab2 | ||
) |
Vector tab1 is sorted by using MergeSort algorithm.
Sorts array tab1 between position m and n. The sort operation affects tab2.
Definition at line 347 of file Functions_Arrays.cxx.
void Seldon::MergeSort | ( | long | m, |
long | n, | ||
Vector< T1, Storage1, Allocator1 > & | tab1, | ||
Vector< T2, Storage2, Allocator2 > & | tab2, | ||
Vector< T3, Storage3, Allocator3 > & | tab3 | ||
) |
Vector tab1 is sorted by using MergeSort algorithm.
Sorts array tab1 between position m and n. The sort operation affects tab2 and tab3.
Definition at line 430 of file Functions_Arrays.cxx.
int Seldon::MinRes | ( | const Matrix1 & | A, |
Vector1 & | x, | ||
const Vector1 & | b, | ||
Preconditioner & | M, | ||
Iteration< Titer > & | iter | ||
) |
Solves a linear system by using Minimum Residual (MinRes)
Solves a real symmetric linear system Ax = b with restarted Preconditioned Minimum Residual Algorithm.
return value of 0 indicates convergence within the maximum number of iterations (determined by the iter object). return value of 1 indicates a failure to converge.
See C. PAIGE AND M. SAUNDERS, Solution of sparse indefinite systems of linear equations, SIAM J. Numer. Anal., 12 (1975), pp. 617-629.
[in] | A | Real Symmetric Matrix |
[in,out] | x | Vector on input it is the initial guess on output it is the solution |
[in] | b | Vector right hand side of the linear system |
[in] | M | Right preconditioner |
[in] | iter | Iteration parameters |
Definition at line 53 of file MinRes.cxx.
void Seldon::MltAddMatrix | ( | const T0 & | alpha, |
const Matrix< FloatDouble, General, DenseSparseCollection, Allocator1 > & | A, | ||
const Matrix< FloatDouble, General, DenseSparseCollection, Allocator2 > & | B, | ||
const T3 & | beta, | ||
Matrix< FloatDouble, General, DenseSparseCollection, Allocator4 > & | C | ||
) |
Multiplies a FloatDouble collection by a scalar.
[in] | alpha | scalar. |
[in,out] | M | matrix to be multiplied. |
Definition at line 1188 of file Functions_Matrix.cxx.
void Seldon::MltAddMatrix | ( | const T0 & | alpha, |
const Matrix< T1, Prop1, ColMajorCollection, Allocator1 > & | A, | ||
const Matrix< T2, Prop2, ColMajorCollection, Allocator2 > & | B, | ||
const T3 & | beta, | ||
Matrix< T4, Prop4, ColMajorCollection, Allocator4 > & | C | ||
) |
Multiplies two matrices, and adds the result to a third matrix.
It performs the operation where and are scalars, and , and are matrices.
[in] | alpha | scalar. |
[in] | A | matrix. |
[in] | B | matrix. |
[in] | beta | scalar. |
[in,out] | C | matrix, result of the product of A with B, times alpha, plus beta times C. |
Definition at line 983 of file Functions_Matrix.cxx.
void Seldon::MltAddMatrix | ( | const T0 & | alpha, |
const Matrix< T1, Prop1, PETScMPIDense, Allocator1 > & | A, | ||
const Matrix< T2, General, RowMajor, Allocator2 > & | B, | ||
const T3 & | beta, | ||
Matrix< T4, Prop4, PETScMPIDense, Allocator4 > & | C | ||
) |
Multiplies two matrices, and adds the result to a third matrix.
It performs the operation where and are scalars, and , and are matrices.
[in] | alpha | scalar. |
[in] | A | matrix. |
[in] | B | matrix. |
[in] | beta | scalar. |
[in,out] | C | matrix, result of the product of A with B, times alpha, plus beta times C. |
Definition at line 885 of file Functions_Matrix.cxx.
void Seldon::MltAddMatrix | ( | const T0 & | alpha, |
const Matrix< T1, Prop1, RowMajorCollection, Allocator1 > & | A, | ||
const Matrix< T2, Prop2, RowMajorCollection, Allocator2 > & | B, | ||
const T3 & | beta, | ||
Matrix< T4, Prop4, RowMajorCollection, Allocator4 > & | C | ||
) |
Multiplies two matrices, and adds the result to a third matrix.
It performs the operation where and are scalars, and , and are matrices.
[in] | alpha | scalar. |
[in] | A | matrix. |
[in] | B | matrix. |
[in] | beta | scalar. |
[in,out] | C | matrix, result of the product of A with B, times alpha, plus beta times C. |
Definition at line 941 of file Functions_Matrix.cxx.
void Seldon::MltAddMatrix | ( | const T0 & | alpha, |
const Matrix< T1, Prop1, RowSparse, Allocator1 > & | A, | ||
const Matrix< T2, Prop2, RowSparse, Allocator2 > & | B, | ||
const T3 & | beta, | ||
Matrix< T4, Prop4, RowSparse, Allocator4 > & | C | ||
) |
Multiplies two row-major sparse matrices and adds the result to a third.
It performs the operation where , and are row-major sparse matrices in Harwell-Boeing format, and and are scalars.
[in] | alpha | scalar. |
[in] | A | row-major sparse matrix in Harwell-Boeing format. |
[in] | B | row-major sparse matrix in Harwell-Boeing format. |
[in] | beta | scalar. |
[in,out] | C | row-major sparse matrix in Harwell-Boeing format. On exit, it is equal to . |
Definition at line 1265 of file Functions_Matrix.cxx.
void Seldon::MltAddMatrix | ( | const T0 & | alpha, |
const Matrix< T1, Prop1, Storage1, Allocator1 > & | A, | ||
const Matrix< T2, Prop2, Storage2, Allocator2 > & | B, | ||
const T3 & | beta, | ||
Matrix< T4, Prop4, Storage4, Allocator4 > & | C | ||
) |
Multiplies two matrices, and adds the result to a third matrix.
It performs the operation where and are scalars, and , and are matrices.
[in] | alpha | scalar. |
[in] | A | matrix. |
[in] | B | matrix. |
[in] | beta | scalar. |
[in,out] | C | matrix, result of the product of A with B, times alpha, plus beta times C. |
Definition at line 617 of file Functions_Matrix.cxx.
void Seldon::MltAddMatrix | ( | const T0 & | alpha, |
const SeldonTranspose & | TransA, | ||
const Matrix< T1, Prop1, RowMajor, Allocator1 > & | A, | ||
const SeldonTranspose & | TransB, | ||
const Matrix< T2, Prop2, RowSparse, Allocator2 > & | B, | ||
const T3 & | beta, | ||
Matrix< T4, Prop4, RowMajor, Allocator4 > & | C | ||
) |
Multiplies a row-major matrix with a row-major sparse matrix and adds it to a third.
It performs the operation where and are row-major dense matrices and a row-major sparse matrix in Harwell-Boeing format.
[in] | A | row-major dense matrix. |
[in] | B | row-major sparse matrix in Harwell-Boeing format. |
[out] | C | resulting row-major dense matrix. |
Definition at line 1547 of file Functions_Matrix.cxx.
void Seldon::MltAddMatrix | ( | const T0 & | alpha, |
const SeldonTranspose & | TransA, | ||
const Matrix< T1, Prop1, RowSparse, Allocator1 > & | A, | ||
const SeldonTranspose & | TransB, | ||
const Matrix< T2, Prop2, RowSparse, Allocator2 > & | B, | ||
const T3 & | beta, | ||
Matrix< T4, Prop4, RowSparse, Allocator4 > & | C | ||
) |
Multiplies two row-major sparse matrices and adds the result to a third.
It performs the operation or where , and are row-major sparse matrices in Harwell-Boeing format, and and are scalars.
[in] | alpha | scalar. |
[in] | TransA | status of A: it must be SeldonNoTrans. This argument is required for consistency with the interface for full matrices. |
[in] | A | row-major sparse matrix in Harwell-Boeing format. |
[in] | TransB | status of B: SeldonNoTrans or SeldonTrans. |
[in] | B | row-major sparse matrix in Harwell-Boeing format. |
[in] | beta | scalar. |
[in,out] | C | row-major sparse matrix in Harwell-Boeing format. On exit, it is equal to or . |
Definition at line 1324 of file Functions_Matrix.cxx.
void Seldon::MltAddMatrix | ( | const T0 & | alpha, |
const SeldonTranspose & | TransA, | ||
const Matrix< T1, Prop1, Storage1, Allocator1 > & | A, | ||
const SeldonTranspose & | TransB, | ||
const Matrix< T2, Prop2, Storage2, Allocator2 > & | B, | ||
const T3 & | beta, | ||
Matrix< T4, Prop4, Storage4, Allocator4 > & | C | ||
) |
Multiplies two matrices, and adds the result to a third matrix.
It performs the operation or , where and are scalars, and , and are matrices.
[in] | alpha | scalar. |
[in] | TransA | status of A: SeldonNoTrans, SeldonTrans or SeldonConjTrans. |
[in] | A | matrix. |
[in] | TransB | status of B: SeldonNoTrans, SeldonTrans or SeldonConjTrans. |
[in] | B | matrix. |
[in] | beta | scalar. |
[in,out] | C | matrix, result of the product of A with B or B^T, times alpha, plus beta times C. |
Definition at line 688 of file Functions_Matrix.cxx.
void Seldon::MltAddVector | ( | const T0 & | alpha, |
const Matrix< T1, Prop1, ColMajorCollection, Allocator1 > & | M, | ||
const Vector< T2, Collection, Allocator2 > & | X, | ||
const T3 & | beta, | ||
Vector< T4, Collection, Allocator4 > & | Y | ||
) |
Performs the multiplication of a matrix collection with a vector collection, and adds the result to another vector.
It performs the operation where and are scalars, is a matrix, and is a vector of length . The vector must be of length .
[in] | alpha | scalar. |
[in] | M | m by n matrix colection. |
[in] | X | vector collection of length n. |
[in] | beta | scalar. |
[in,out] | Y | vector collection of length m, result of the product of M by X, times alpha, plus Y (on entry) times beta. |
Definition at line 1383 of file Functions_MatVect.cxx.
void Seldon::MltAddVector | ( | const T0 & | alpha, |
const Matrix< T1, Prop1, RowMajorCollection, Allocator1 > & | M, | ||
const Vector< T2, Collection, Allocator2 > & | X, | ||
const T3 & | beta, | ||
Vector< T4, Collection, Allocator4 > & | Y | ||
) |
Performs the multiplication of a matrix collection with a vector collection, and adds the result to another vector.
It performs the operation where and are scalars, is a matrix, and is a vector of length . The vector must be of length .
[in] | alpha | scalar. |
[in] | M | m by n matrix colection. |
[in] | X | vector collection of length n. |
[in] | beta | scalar. |
[in,out] | Y | vector collection of length m, result of the product of M by X, times alpha, plus Y (on entry) times beta. |
Definition at line 1341 of file Functions_MatVect.cxx.
void Seldon::MltAddVector | ( | const T0 & | alpha, |
const Matrix< T1, Prop1, Storage1, Allocator1 > & | M, | ||
const Vector< T2, Storage2, Allocator2 > & | X, | ||
const T3 & | beta, | ||
Vector< T4, Collection, Allocator4 > & | Y | ||
) |
Performs the multiplication of a matrix with a vector, and adds the result to another vector.
It performs the operation where and are scalars, is a matrix, and is a vector of length . The vector must be of length .
[in] | alpha | scalar. |
[in] | M | m by n matrix. |
[in] | X | vector of length n. |
[in] | beta | scalar. |
[in,out] | Y | vector of length m, result of the product of M by X, times alpha, plus Y (on entry) times beta. |
Definition at line 1289 of file Functions_MatVect.cxx.
void Seldon::MltAddVector | ( | const T0 & | alpha, |
const Matrix< T1, Prop1, Storage1, Allocator1 > & | M, | ||
const Vector< T2, Storage2, Allocator2 > & | X, | ||
const T3 & | beta, | ||
Vector< T4, Storage4, Allocator4 > & | Y | ||
) |
Performs the multiplication of a matrix with a vector, and adds the result to another vector.
It performs the operation where and are scalars, is a matrix, and is a vector of length . The vector must be of length .
[in] | alpha | scalar. |
[in] | M | m by n matrix. |
[in] | X | vector of length n. |
[in] | beta | scalar. |
[in,out] | Y | vector of length m, result of the product of M by X, times alpha, plus Y (on entry) times beta. |
Definition at line 1236 of file Functions_MatVect.cxx.
void Seldon::MltAddVector | ( | const T0 & | alpha, |
const SeldonTranspose & | Trans, | ||
const Matrix< T1, Prop1, Storage1, Allocator1 > & | M, | ||
const Vector< T2, Storage2, Allocator2 > & | X, | ||
const T3 & | beta, | ||
Vector< T4, Storage4, Allocator4 > & | Y | ||
) |
Performs the multiplication of a matrix (possibly transposed) with a vector, and adds the result to another vector.
It performs the operation or where and are scalars, is a matrix or a matrix, and is a vector of length . The vector must be of length .
[in] | alpha | scalar. |
[in] | Trans | transposition status of M: it may be SeldonNoTrans, SeldonTrans or SeldonConjTrans |
[in] | M | m by n matrix, or n by m matrix if transposed. |
[in] | X | vector of length n. |
[in] | beta | scalar. |
[in,out] | Y | vector of length m, result of the product of M by X, times alpha, plus Y (on entry) times beta. |
Definition at line 1428 of file Functions_MatVect.cxx.
void Seldon::MltCholesky | ( | const SeldonTranspose & | TransA, |
const Matrix< T0, Prop, ArrayRowSymSparse, Allocator0 > & | A, | ||
Vector< T1, Storage, Allocator1 > & | x | ||
) |
Computation of y = L x or y = L^T x.
[in] | TransA | SeldonTrans or SeldonNoTrans. |
[in] | A | Cholesky factorization obtained after calling "GetCholesky". |
[in,out] | x | on exit, it is overwritten by the value of y. |
Definition at line 354 of file SparseCholeskyFactorisation.cxx.
void Seldon::MltCholesky | ( | const SeldonTranspose & | TransA, |
const Matrix< T0, Prop, RowSymSparse, Allocator0 > & | A, | ||
Vector< T1, Storage, Allocator1 > & | x | ||
) |
Computation of y = L x or y = L^T x.
[in] | TransA | SeldonTrans or SeldonNoTrans. |
[in] | A | Cholesky factorization obtained after calling "GetCholesky". |
[in,out] | x | on exit, it is overwritten by the value of y. |
Definition at line 404 of file SparseCholeskyFactorisation.cxx.
void Seldon::MltMatrix | ( | const class_SeldonNoTrans & | , |
const Matrix< T0, Prop0, RowMajor, Allocator0 > & | A, | ||
const class_SeldonTrans & | , | ||
const Matrix< T1, Prop1, RowSparse, Allocator1 > & | B, | ||
Matrix< T2, Prop2, RowMajor, Allocator2 > & | C | ||
) |
Multiplies two row-major sparse matrices in Harwell-Boeing format.
It performs the operation where , and are row-major sparse matrices in Harwell-Boeing format.
[in] | A | row-major sparse matrix in Harwell-Boeing format. |
[in] | B | row-major sparse matrix in Harwell-Boeing format. |
[out] | C | row-major sparse matrix in Harwell-Boeing format,result of the product of A with B transposed. It does not need to have the right non-zero entries. |
Definition at line 404 of file Functions_Matrix.cxx.
void Seldon::MltMatrix | ( | const class_SeldonNoTrans & | , |
const Matrix< T0, Prop0, RowSparse, Allocator0 > & | A, | ||
const class_SeldonTrans & | , | ||
const Matrix< T1, Prop1, RowSparse, Allocator1 > & | B, | ||
Matrix< T2, Prop2, RowSparse, Allocator2 > & | C | ||
) |
Multiplies two row-major sparse matrices in Harwell-Boeing format.
It performs the operation where , and are row-major sparse matrices in Harwell-Boeing format.
[in] | A | row-major sparse matrix in Harwell-Boeing format. |
[in] | B | row-major sparse matrix in Harwell-Boeing format. |
[out] | C | row-major sparse matrix in Harwell-Boeing format, result of the product of A with B transposed. It does not need to have the right non-zero entries. |
Definition at line 446 of file Functions_Matrix.cxx.
void Seldon::MltMatrix | ( | const Matrix< T0, Prop0, RowMajor, Allocator0 > & | A, |
const Matrix< T1, Prop1, RowSparse, Allocator1 > & | B, | ||
Matrix< T2, Prop2, RowMajor, Allocator2 > & | C | ||
) |
Multiplies two row-major sparse matrices in Harwell-Boeing format.
It performs the operation where , and are row-major sparse matrices in Harwell-Boeing format.
[in] | A | row-major sparse matrix in Harwell-Boeing format. |
[in] | B | row-major sparse matrix in Harwell-Boeing format. |
[out] | C | row-major sparse matrix in Harwell-Boeing format, result of the product of A with B. It does not need to have the right non-zero entries. |
Definition at line 364 of file Functions_Matrix.cxx.
void Seldon::MltMatrix | ( | const Matrix< T0, Prop0, RowSparse, Allocator0 > & | A, |
const Matrix< T1, Prop1, RowSparse, Allocator1 > & | B, | ||
Matrix< T2, Prop2, RowSparse, Allocator2 > & | C | ||
) |
Multiplies two row-major sparse matrices in Harwell-Boeing format.
It performs the operation where , and are row-major sparse matrices in Harwell-Boeing format.
[in] | A | row-major sparse matrix in Harwell-Boeing format. |
[in] | B | row-major sparse matrix in Harwell-Boeing format. |
[out] | C | row-major sparse matrix in Harwell-Boeing format, result of the product of A with B. It does not need to have the right non-zero entries. |
Definition at line 207 of file Functions_Matrix.cxx.
void Seldon::MltScalar | ( | const T0 & | alpha, |
Array3D< T, Allocator > & | A | ||
) |
Multiplication of all elements of a 3D array by a scalar.
[in] | alpha | scalar by which A should be multiplied. |
[in,out] | A | the array to be multiplied by alpha. |
Definition at line 539 of file Array3D.cxx.
void Seldon::MltScalar | ( | const T0 & | alpha, |
Matrix< FloatDouble, General, DenseSparseCollection, Allocator > & | A | ||
) |
Multiplies a FloatDouble collection by a scalar.
[in] | alpha | scalar. |
[in,out] | M | matrix to be multiplied. |
Definition at line 142 of file Functions_Matrix.cxx.
void Seldon::MltScalar | ( | const T0 & | alpha, |
Matrix< T1, Prop1, ColMajorCollection, Allocator1 > & | A | ||
) |
Multiplies a matrix by a scalar.
[in] | alpha | scalar. |
[in,out] | M | matrix to be multiplied. |
Definition at line 109 of file Functions_Matrix.cxx.
void Seldon::MltScalar | ( | const T0 & | alpha, |
Matrix< T1, Prop1, RowMajorCollection, Allocator1 > & | A | ||
) |
Multiplies a matrix by a scalar.
[in] | alpha | scalar. |
[in,out] | M | matrix to be multiplied. |
Definition at line 126 of file Functions_Matrix.cxx.
void Seldon::MltScalar | ( | const T0 & | alpha, |
Matrix< T1, Prop1, Storage1, Allocator1 > & | A | ||
) | |||
throw | ( | ||
) |
Multiplies a matrix by a scalar.
[in] | alpha | scalar. |
[in,out] | M | matrix to be multiplied. |
Definition at line 90 of file Functions_Matrix.cxx.
ClassComplexType< T1 >::Treal Seldon::Norm1 | ( | const DistributedMatrix< T1, Prop1, Storage1, Allocator1 > & | A | ) |
returns the 1-norm of A
The result is different from a sequential execution (because some non-zero entries may be shared by different processors)
Definition at line 5557 of file DistributedMatrix.cxx.
ClassComplexType< T >::Treal Seldon::Norm1 | ( | const Matrix< T, Prop, ArrayColSparse, Allocator > & | A | ) |
Returns the 1-norm of a matrix.
[in] | A | matrix. |
Definition at line 1958 of file Functions_MatrixArray.cxx.
ClassComplexType< T >::Treal Seldon::Norm1 | ( | const Matrix< T, Prop, ArrayColSymSparse, Allocator > & | A | ) |
Returns the 1-norm of a matrix.
[in] | A | matrix. |
Definition at line 2075 of file Functions_MatrixArray.cxx.
ClassComplexType< T >::Treal Seldon::Norm1 | ( | const Matrix< T, Prop, ArrayRowComplexSparse, Allocator > & | A | ) |
Returns the 1-norm of a matrix.
[in] | A | matrix. |
Definition at line 1288 of file Functions_MatrixComplex.cxx.
ClassComplexType< T >::Treal Seldon::Norm1 | ( | const Matrix< T, Prop, ArrayRowSparse, Allocator > & | A | ) |
Returns the 1-norm of a matrix.
[in] | A | matrix. |
Definition at line 1896 of file Functions_MatrixArray.cxx.
ClassComplexType< T >::Treal Seldon::Norm1 | ( | const Matrix< T, Prop, ArrayRowSymComplexSparse, Allocator > & | A | ) |
Returns the 1-norm of a matrix.
[in] | A | matrix. |
Definition at line 1575 of file Functions_MatrixComplex.cxx.
ClassComplexType< T >::Treal Seldon::Norm1 | ( | const Matrix< T, Prop, ArrayRowSymSparse, Allocator > & | A | ) |
Returns the 1-norm of a matrix.
[in] | A | matrix. |
Definition at line 2020 of file Functions_MatrixArray.cxx.
ClassComplexType< T >::Treal Seldon::Norm1 | ( | const Matrix< T, Prop, ColSparse, Allocator > & | A | ) |
Returns the 1-norm of a matrix.
[in] | A | matrix. |
Definition at line 2542 of file Functions_Matrix.cxx.
ClassComplexType< T >::Treal Seldon::Norm1 | ( | const Matrix< T, Prop, ColSymSparse, Allocator > & | A | ) |
Returns the 1-norm of a matrix.
[in] | A | matrix. |
Definition at line 2659 of file Functions_Matrix.cxx.
ClassComplexType< T >::Treal Seldon::Norm1 | ( | const Matrix< T, Prop, RowComplexSparse, Allocator > & | A | ) |
Returns the 1-norm of a matrix.
[in] | A | matrix. |
Definition at line 1333 of file Functions_MatrixComplex.cxx.
ClassComplexType< T >::Treal Seldon::Norm1 | ( | const Matrix< T, Prop, RowSparse, Allocator > & | A | ) |
Returns the 1-norm of a matrix.
[in] | A | matrix. |
Definition at line 2480 of file Functions_Matrix.cxx.
ClassComplexType< T >::Treal Seldon::Norm1 | ( | const Matrix< T, Prop, RowSymComplexSparse, Allocator > & | A | ) |
Returns the 1-norm of a matrix.
[in] | A | matrix. |
Definition at line 1638 of file Functions_MatrixComplex.cxx.
ClassComplexType< T >::Treal Seldon::Norm1 | ( | const Matrix< T, Prop, RowSymSparse, Allocator > & | A | ) |
Returns the 1-norm of a matrix.
[in] | A | matrix. |
Definition at line 2604 of file Functions_Matrix.cxx.
ClassComplexType< T >::Treal Seldon::Norm1 | ( | const Matrix< T, Prop, Storage, Allocator > & | A | ) |
Returns the 1-norm of a matrix.
[in] | A | matrix. |
Definition at line 2408 of file Functions_Matrix.cxx.
ClassComplexType< T1 >::Treal Seldon::Norm1 | ( | const Vector< T1, Storage1, Allocator1 > & | X | ) |
returns 1-norm of X
For complex numbers, we use |z| = |Re(z)| + |Im(z)| so that the function is the same as Blas equivalent dzasum
Definition at line 592 of file Functions_Vector.cxx.
ClassComplexType< T1 >::Treal Seldon::Norm1 | ( | const Vector< T1, VectSparse, Allocator1 > & | X | ) |
returns 1-norm of X
For complex numbers, we use |z| = |Re(z)| + |Im(z)| so that the function is the same as Blas equivalent dzasum
Definition at line 610 of file Functions_Vector.cxx.
ClassComplexType< T1 >::Treal Seldon::NormInf | ( | const DistributedMatrix< T1, Prop1, Storage1, Allocator1 > & | A | ) |
returns the infinity norm of A
The result is different from a sequential execution (because some non-zero entries may be shared by different processors)
Definition at line 5586 of file DistributedMatrix.cxx.
ClassComplexType< T >::Treal Seldon::NormInf | ( | const Matrix< T, Prop, ArrayColSparse, Allocator > & | A | ) |
Returns the infinity-norm of a matrix.
[in] | A | matrix. |
Definition at line 1982 of file Functions_MatrixArray.cxx.
ClassComplexType< T >::Treal Seldon::NormInf | ( | const Matrix< T, Prop, ArrayColSymSparse, Allocator > & | A | ) |
Returns the infinity-norm of a matrix.
[in] | A | matrix. |
Definition at line 2099 of file Functions_MatrixArray.cxx.
ClassComplexType< T >::Treal Seldon::NormInf | ( | const Matrix< T, Prop, ArrayRowComplexSparse, Allocator > & | A | ) |
Returns the infinity-norm of a matrix.
[in] | A | matrix. |
Definition at line 1383 of file Functions_MatrixComplex.cxx.
ClassComplexType< T >::Treal Seldon::NormInf | ( | const Matrix< T, Prop, ArrayRowSparse, Allocator > & | A | ) |
Returns the infinity-norm of a matrix.
[in] | A | matrix. |
Definition at line 1916 of file Functions_MatrixArray.cxx.
ClassComplexType< T >::Treal Seldon::NormInf | ( | const Matrix< T, Prop, ArrayRowSymComplexSparse, Allocator > & | A | ) |
Returns the infinity-norm of a matrix.
[in] | A | matrix. |
Definition at line 1706 of file Functions_MatrixComplex.cxx.
ClassComplexType< T >::Treal Seldon::NormInf | ( | const Matrix< T, Prop, ArrayRowSymSparse, Allocator > & | A | ) |
Returns the infinity-norm of a matrix.
[in] | A | matrix. |
Definition at line 2044 of file Functions_MatrixArray.cxx.
ClassComplexType< T >::Treal Seldon::NormInf | ( | const Matrix< T, Prop, ColSparse, Allocator > & | A | ) |
Returns the infinity-norm of a matrix.
[in] | A | matrix. |
Definition at line 2566 of file Functions_Matrix.cxx.
ClassComplexType< T >::Treal Seldon::NormInf | ( | const Matrix< T, Prop, ColSymSparse, Allocator > & | A | ) |
Returns the infinity-norm of a matrix.
[in] | A | matrix. |
Definition at line 2683 of file Functions_Matrix.cxx.
ClassComplexType< T >::Treal Seldon::NormInf | ( | const Matrix< T, Prop, RowComplexSparse, Allocator > & | A | ) |
Returns the infinity-norm of a matrix.
[in] | A | matrix. |
Definition at line 1430 of file Functions_MatrixComplex.cxx.
ClassComplexType< T >::Treal Seldon::NormInf | ( | const Matrix< T, Prop, RowSparse, Allocator > & | A | ) |
Returns the infinity-norm of a matrix.
[in] | A | matrix. |
Definition at line 2500 of file Functions_Matrix.cxx.
ClassComplexType< T >::Treal Seldon::NormInf | ( | const Matrix< T, Prop, RowSymComplexSparse, Allocator > & | A | ) |
Returns the infinity-norm of a matrix.
[in] | A | matrix. |
Definition at line 1719 of file Functions_MatrixComplex.cxx.
ClassComplexType< T >::Treal Seldon::NormInf | ( | const Matrix< T, Prop, RowSymSparse, Allocator > & | A | ) |
Returns the infinity-norm of a matrix.
[in] | A | matrix. |
Definition at line 2628 of file Functions_Matrix.cxx.
ClassComplexType< T >::Treal Seldon::NormInf | ( | const Matrix< T, Prop, Storage, Allocator > & | A | ) |
Returns the infinity-norm of a matrix.
[in] | A | matrix. |
Definition at line 2435 of file Functions_Matrix.cxx.
Adds an element to an instance of 'Str'.
[in] | s | 'Str' instance. |
[in] | input | element added at the end of the string. |
Definition at line 104 of file CommonInline.cxx.
ostream & Seldon::operator<< | ( | ostream & | out, |
const Array3D< T, Allocator > & | A | ||
) |
operator<< overloaded for a 3D array.
out | output stream. |
A | the 3D array. |
Definition at line 513 of file Array3D.cxx.
ostream & Seldon::operator<< | ( | ostream & | out, |
const Array4D< T, Allocator > & | A | ||
) |
operator<< overloaded for a 4D array.
out | output stream. |
A | the 4D array. |
Definition at line 490 of file Array4D.cxx.
ostream & Seldon::operator<< | ( | ostream & | out, |
const Array< T, N, Allocator > & | A | ||
) |
ostream & Seldon::operator<< | ( | ostream & | out, |
const Matrix< T, Prop, Storage, Allocator > & | A | ||
) |
out | output stream. |
A | matrix to be put in the stream. |
Definition at line 272 of file Matrix_Base.cxx.
ostream & Seldon::operator<< | ( | ostream & | out, |
const Vector< FloatDouble, DenseSparseCollection, Allocator< T > > & | V | ||
) |
operator<< overloaded for vector collections.
[in] | out | output stream. |
[in] | V | vector collection to be put in the stream. |
Definition at line 959 of file HeterogeneousCollection.cxx.
ostream & Seldon::operator<< | ( | ostream & | out, |
const Vector< T, Collection, Allocator > & | V | ||
) |
operator<< overloaded for vector collections.
[in] | out | output stream. |
[in] | V | vector collection to be put in the stream. |
Definition at line 735 of file VectorCollection.cxx.
ostream & Seldon::operator<< | ( | ostream & | out, |
const Vector< T, PETScPar, Allocator > & | V | ||
) |
operator<< overloaded for vectors.
out | output stream. |
V | vector to be put in the stream. |
Definition at line 512 of file PetscVector.cxx.
ostream & Seldon::operator<< | ( | ostream & | out, |
const Vector< T, PETScSeq, Allocator > & | V | ||
) |
operator<< overloaded for vectors.
out | output stream. |
V | vector to be put in the stream. |
Definition at line 317 of file PetscVector.cxx.
ostream & Seldon::operator<< | ( | ostream & | out, |
const Vector< T, Storage, Allocator > & | V | ||
) |
operator<< overloaded for vectors.
out | output stream. |
V | vector to be put in the stream. |
Definition at line 482 of file Vector.cxx.
ostream & Seldon::operator<< | ( | ostream & | out, |
const Vector< T, VectSparse, Allocator > & | V | ||
) |
operator<< overloaded for sparse vectors.
out | output stream. |
V | vector to be put in the stream. |
Definition at line 1055 of file SparseVector.cxx.
int Seldon::QCgs | ( | const Matrix1 & | A, |
Vector1 & | x, | ||
const Vector1 & | b, | ||
Preconditioner & | M, | ||
Iteration< Titer > & | iter | ||
) |
Solves linear system using Quasi-minimized Conjugate Gradient Squared.
Solves the unsymmetric linear system Ax = b using the Quasi-minimized Conjugate Gradient Squared method.
return value of 0 indicates convergence within the maximum number of iterations (determined by the iter object). return value of 1 indicates a failure to converge.
see A Comparative Study of Preconditioned Lanczos Methods for Nonsymmetric Linear Systems C. H. Tong, Sandia Report
int Seldon::Qmr | ( | const Matrix1 & | A, |
Vector1 & | x, | ||
const Vector1 & | b, | ||
Preconditioner & | M, | ||
Iteration< Titer > & | iter | ||
) |
Solves a linear system by using Quasi-Minimal Residual (QMR)
Solves the unsymmetric linear system Ax = b using the Quasi-Minimal Residual method.
See: R. W. Freund and N. M. Nachtigal, A quasi-minimal residual method for non-Hermitian linear systems, Numerical Math., 60(1991), pp. 315-339
int Seldon::QmrSym | ( | const Matrix1 & | A, |
Vector1 & | x, | ||
const Vector1 & | b, | ||
Preconditioner & | M, | ||
Iteration< Titer > & | iter | ||
) |
Solves linear system using Symmetric Quasi-Minimal Residual (SQMR)
Solves the symmetric linear system Ax = b using the Quasi-Minimal Residual method.
See: R. W. Freund and N. M. Nachtigal, A quasi-minimal residual method for non-Hermitian linear systems, Numerical Math., 60(1991), pp. 315-339
[in] | A | Complex Symmetric Matrix |
[in,out] | x | Vector on input it is the initial guess on output it is the solution |
[in] | b | Right hand side of the linear system |
[in] | M | Left preconditioner |
[in] | iter | Iteration parameters |
Definition at line 48 of file QmrSym.cxx.
void Seldon::QuickSort | ( | long | m, |
long | n, | ||
Vector< T, Storage, Allocator > & | t | ||
) |
Vector t is sorted by using QuickSort algorithm.
Sorts array t between position m and n.
Definition at line 106 of file Functions_Arrays.cxx.
void Seldon::QuickSort | ( | long | m, |
long | n, | ||
Vector< T1, Storage1, Allocator1 > & | t1, | ||
Vector< T2, Storage2, Allocator2 > & | t2 | ||
) |
Vector t1 is sorted by using QuickSort algorithm.
Sorts array t2 between position m and n, the sorting operation affects vector t2.
Definition at line 167 of file Functions_Arrays.cxx.
void Seldon::QuickSort | ( | long | m, |
long | n, | ||
Vector< T1, Storage1, Allocator1 > & | t1, | ||
Vector< T2, Storage2, Allocator2 > & | t2, | ||
Vector< T3, Storage3, Allocator3 > & | t3 | ||
) |
Vector t1 is sorted by using QuickSort algorithm.
Sorts array t1 between position m and n, the sorting operation affects vectors t2 and t3.
Definition at line 237 of file Functions_Arrays.cxx.
void Seldon::ReadCoordinateMatrix | ( | istream & | FileStream, |
Vector< Tint, VectFull, AllocInt > & | row_numbers, | ||
Vector< Tint, VectFull, AllocInt > & | col_numbers, | ||
Vector< T, VectFull, Allocator > & | values, | ||
bool | cplx | ||
) |
Reading of matrix in coordinate format.
FileStream | stream where the matrix is read |
row_numbers | row indices |
col_numbers | column indices |
values | |
cplx | if true, imaginary and real part are in two separate columns |
Definition at line 104 of file IOMatrixMarket.cxx.
void Seldon::ReadCoordinateMatrix | ( | Matrix1 & | A, |
istream & | FileStream, | ||
T & | zero, | ||
int | index, | ||
long | nnz, | ||
bool | cplx | ||
) |
Reading of matrix in coordinate format.
A | output matrix |
FileStream | stream where the matrix is read |
zero | type of value to read (double or complex<double>) |
index | starting index (usually 0 or 1) |
nnz | number of non-zero entries |
cplx | if true, imaginary and real part are in two separate columns If nnz is equal to -1, we consider that the number of non-zero entries is unknown and is deduced from the number of lines present in the stream |
Definition at line 183 of file IOMatrixMarket.cxx.
void Seldon::ReadHarwellBoeing | ( | string | filename, |
const complex< T2 > & | val, | ||
Matrix< T, General, Storage, Allocator > & | A | ||
) |
This functions was written to read the files in Harwell-Boeing format as distributed on the Matrix Market, http://math.nist.gov/MatrixMarket/. A file from Matrix Market is associated with a type encoded in three characters (which is usually its extension). The supported types have:
[in] | filename | path to the file that contains the matrix. |
[out] | A | the matrix to be structured and filled with the values of filename. |
Definition at line 379 of file IOMatrixMarket.cxx.
void Seldon::ReadHarwellBoeing | ( | string | filename, |
const complex< T2 > & | val, | ||
Matrix< T, Symmetric, Storage, Allocator > & | A | ||
) |
This functions was written to read the files in Harwell-Boeing format as distributed on the Matrix Market, http://math.nist.gov/MatrixMarket/. A file from Matrix Market is associated with a type encoded in three characters (which is usually its extension). The supported types have:
[in] | filename | path to the file that contains the matrix. |
[out] | A | the matrix to be structured and filled with the values of filename. |
Definition at line 367 of file IOMatrixMarket.cxx.
void Seldon::ReadHarwellBoeing | ( | string | filename, |
const T2 & | val, | ||
Matrix< T, General, Storage, Allocator > & | A | ||
) |
This functions was written to read the files in Harwell-Boeing format as distributed on the Matrix Market, http://math.nist.gov/MatrixMarket/. A file from Matrix Market is associated with a type encoded in three characters (which is usually its extension). The supported types have:
[in] | filename | path to the file that contains the matrix. |
[out] | A | the matrix to be structured and filled with the values of filename. |
Definition at line 355 of file IOMatrixMarket.cxx.
void Seldon::ReadHarwellBoeing | ( | string | filename, |
const T2 & | val, | ||
Matrix< T, Symmetric, Storage, Allocator > & | A | ||
) |
This functions was written to read the files in Harwell-Boeing format as distributed on the Matrix Market, http://math.nist.gov/MatrixMarket/. A file from Matrix Market is associated with a type encoded in three characters (which is usually its extension). The supported types have:
[in] | filename | path to the file that contains the matrix. |
[out] | A | the matrix to be structured and filled with the values of filename. |
Definition at line 343 of file IOMatrixMarket.cxx.
void Seldon::ReadHarwellBoeing | ( | string | filename, |
Matrix< complex< T >, Prop, ColSparse, Allocator > & | A | ||
) |
This functions was written to read the files in Harwell-Boeing format as distributed on the Matrix Market, http://math.nist.gov/MatrixMarket/. A file from Matrix Market is associated with a type encoded in three characters (which is usually its extension). The supported types have:
[in] | filename | path to the file that contains the matrix. |
[out] | A | the matrix to be structured and filled with the values of filename. |
Definition at line 313 of file IOMatrixMarket.cxx.
void Seldon::ReadHarwellBoeing | ( | string | filename, |
Matrix< complex< T >, Prop, RowSymSparse, Allocator > & | A | ||
) |
This functions was written to read the files in Harwell-Boeing format as distributed on the Matrix Market, http://math.nist.gov/MatrixMarket/. A file from Matrix Market is associated with a type encoded in three characters (which is usually its extension). The supported types have:
[in] | filename | path to the file that contains the matrix. |
[out] | A | the matrix to be structured and filled with the values of filename. |
Definition at line 333 of file IOMatrixMarket.cxx.
void Seldon::ReadHarwellBoeing | ( | string | filename, |
Matrix< T, Prop, ColSparse, Allocator > & | A | ||
) |
Reads a sparse matrix in a file in Harwell-Boeing format.
This functions was written to read the files in Harwell-Boeing format as distributed on the Matrix Market, http://math.nist.gov/MatrixMarket/. A file from Matrix Market is associated with a type encoded in three characters (which is usually its extension). The supported types have:
[in] | filename | path to the file that contains the matrix. |
[out] | A | the matrix to be structured and filled with the values of filename. |
Definition at line 303 of file IOMatrixMarket.cxx.
void Seldon::ReadHarwellBoeing | ( | string | filename, |
Matrix< T, Prop, RowSymSparse, Allocator > & | A | ||
) |
This functions was written to read the files in Harwell-Boeing format as distributed on the Matrix Market, http://math.nist.gov/MatrixMarket/. A file from Matrix Market is associated with a type encoded in three characters (which is usually its extension). The supported types have:
[in] | filename | path to the file that contains the matrix. |
[out] | A | the matrix to be structured and filled with the values of filename. |
Definition at line 323 of file IOMatrixMarket.cxx.
void Seldon::ReadHarwellBoeing | ( | string | filename, |
Matrix< T, Prop, Storage, Allocator > & | A | ||
) |
This functions was written to read the files in Harwell-Boeing format as distributed on the Matrix Market, http://math.nist.gov/MatrixMarket/. A file from Matrix Market is associated with a type encoded in three characters (which is usually its extension). The supported types have:
[in] | filename | path to the file that contains the matrix. |
[out] | A | the matrix to be structured and filled with the values of filename. |
Definition at line 391 of file IOMatrixMarket.cxx.
void Seldon::ReadHarwellBoeing | ( | string | filename, |
string | value_type, | ||
string | matrix_type, | ||
Matrix< T, Prop, Storage, Allocator > & | A | ||
) |
Reads a sparse matrix in a file in Harwell-Boeing format.
This functions was written to read the files in Harwell-Boeing format as distributed on the Matrix Market, http://math.nist.gov/MatrixMarket/. A file from Matrix Market is associated with a type encoded in three characters (which is usually its extension). The supported types have:
[in] | filename | path to the file that contains the matrix. |
[in] | value_type | the type of involved data: only "real" is supported. |
[in] | matrix_type | the type of matrix: only "general" is supported. |
[out] | A | the matrix to be structured and filled with the values of filename. |
Definition at line 493 of file IOMatrixMarket.cxx.
void Seldon::RemoveDuplicate | ( | long & | n, |
Vector< T, Storage1, Allocator1 > & | Node, | ||
Vector< T2, Storage2, Allocator2 > & | Node2 | ||
) |
Sorts and removes duplicate entries of a vector.
Sorting operations on Node also affect Node2.
Definition at line 596 of file Functions_Arrays.cxx.
void Seldon::RemoveDuplicate | ( | Vector< T, Storage1, Allocator1 > & | Node, |
Vector< T2, Storage2, Allocator2 > & | Node2 | ||
) |
Sorts and removes duplicate entries of a vector.
Sorting operations of Node also affect Node2.
Definition at line 631 of file Functions_Arrays.cxx.
void Seldon::ScaleLeftMatrix | ( | Matrix< T, Prop, ColLoTriang, Allocator > & | A, |
const Vector< T1, VectFull, Allocator1 > & | Drow | ||
) |
Left-scaling of a matrix.
A is replaced by Drow A where Drow is diagonal and stored as a dense vector
Definition at line 2427 of file Functions.cxx.
void Seldon::ScaleLeftMatrix | ( | Matrix< T, Prop, ColLoTriangPacked, Allocator > & | A, |
const Vector< T1, VectFull, Allocator1 > & | Drow | ||
) |
Left-scaling of a matrix.
A is replaced by Drow A where Drow is diagonal and stored as a dense vector
Definition at line 2411 of file Functions.cxx.
void Seldon::ScaleLeftMatrix | ( | Matrix< T, Prop, ColMajor, Allocator > & | A, |
const Vector< T1, VectFull, Allocator1 > & | Drow | ||
) |
Left-scaling of a matrix.
A is replaced by Drow A where Drow is diagonal and stored as a dense vector
Definition at line 2363 of file Functions.cxx.
void Seldon::ScaleLeftMatrix | ( | Matrix< T, Prop, ColUpTriang, Allocator > & | A, |
const Vector< T1, VectFull, Allocator1 > & | Drow | ||
) |
Left-scaling of a matrix.
A is replaced by Drow A where Drow is diagonal and stored as a dense vector
Definition at line 2491 of file Functions.cxx.
void Seldon::ScaleLeftMatrix | ( | Matrix< T, Prop, ColUpTriangPacked, Allocator > & | A, |
const Vector< T1, VectFull, Allocator1 > & | Drow | ||
) |
Left-scaling of a matrix.
A is replaced by Drow A where Drow is diagonal and stored as a dense vector
Definition at line 2475 of file Functions.cxx.
void Seldon::ScaleLeftMatrix | ( | Matrix< T, Prop, RowLoTriang, Allocator > & | A, |
const Vector< T1, VectFull, Allocator1 > & | Drow | ||
) |
Left-scaling of a matrix.
A is replaced by Drow A where Drow is diagonal and stored as a dense vector
Definition at line 2395 of file Functions.cxx.
void Seldon::ScaleLeftMatrix | ( | Matrix< T, Prop, RowLoTriangPacked, Allocator > & | A, |
const Vector< T1, VectFull, Allocator1 > & | Drow | ||
) |
Left-scaling of a matrix.
A is replaced by Drow A where Drow is diagonal and stored as a dense vector
Definition at line 2379 of file Functions.cxx.
void Seldon::ScaleLeftMatrix | ( | Matrix< T, Prop, RowMajor, Allocator > & | A, |
const Vector< T1, VectFull, Allocator1 > & | Drow | ||
) |
Left-scaling of a matrix.
A is replaced by Drow A where Drow is diagonal and stored as a dense vector
Definition at line 2347 of file Functions.cxx.
void Seldon::ScaleLeftMatrix | ( | Matrix< T, Prop, RowUpTriang, Allocator > & | A, |
const Vector< T1, VectFull, Allocator1 > & | Drow | ||
) |
Left-scaling of a matrix.
A is replaced by Drow A where Drow is diagonal and stored as a dense vector
Definition at line 2459 of file Functions.cxx.
void Seldon::ScaleLeftMatrix | ( | Matrix< T, Prop, RowUpTriangPacked, Allocator > & | A, |
const Vector< T1, VectFull, Allocator1 > & | Drow | ||
) |
Left-scaling of a matrix.
A is replaced by Drow A where Drow is diagonal and stored as a dense vector
Definition at line 2443 of file Functions.cxx.
void Seldon::ScaleLeftMatrix | ( | Matrix< T1, Prop, ArrayColSparse, Allocator1 > & | A, |
const Vector< T2, VectFull, Allocator2 > & | scale | ||
) |
Each row is scaled.
We compute diag(S)*A where S = scale.
Definition at line 985 of file Permutation_ScalingMatrix.cxx.
void Seldon::ScaleLeftMatrix | ( | Matrix< T1, Prop, ArrayRowComplexSparse, Allocator1 > & | A, |
const Vector< T2, VectFull, Allocator2 > & | scale | ||
) |
Each row is scaled.
We compute diag(S)*A where S = scale.
Definition at line 905 of file Functions_MatrixComplex.cxx.
void Seldon::ScaleLeftMatrix | ( | Matrix< T1, Prop, ArrayRowSparse, Allocator1 > & | A, |
const Vector< T2, VectFull, Allocator2 > & | scale | ||
) |
Each row is scaled.
We compute diag(S)*A where S = scale.
Definition at line 969 of file Permutation_ScalingMatrix.cxx.
void Seldon::ScaleLeftMatrix | ( | Matrix< T1, Prop, ColSparse, Allocator1 > & | A, |
const Vector< T2, VectFull, Allocator2 > & | scale | ||
) |
Each row is scaled.
We compute diag(S)*A where S = scale.
Definition at line 950 of file Permutation_ScalingMatrix.cxx.
void Seldon::ScaleLeftMatrix | ( | Matrix< T1, Prop, RowComplexSparse, Allocator1 > & | A, |
const Vector< T2, VectFull, Allocator2 > & | scale | ||
) |
Each row is scaled.
We compute diag(S)*A where S = scale.
Definition at line 1004 of file Functions_MatrixComplex.cxx.
void Seldon::ScaleLeftMatrix | ( | Matrix< T1, Prop, RowSparse, Allocator1 > & | A, |
const Vector< T2, VectFull, Allocator2 > & | scale | ||
) |
Each row is scaled.
We compute diag(S)*A where S = scale.
Definition at line 931 of file Permutation_ScalingMatrix.cxx.
void Seldon::ScaleMatrix | ( | Matrix< T, Prop, BandedCol, Allocator > & | A, |
const Vector< T1, VectFull, Allocator1 > & | Drow, | ||
const Vector< T2, VectFull, Allocator2 > & | Dcol | ||
) |
Scaling of a matrix.
A is replaced by Drow A Dcol where Drow and Dcol are diagonal matrices and stored as dense vectors
Definition at line 1367 of file BandMatrix.cxx.
void Seldon::ScaleMatrix | ( | Matrix< T, Prop, ColHerm, Allocator > & | A, |
const Vector< T1, VectFull, Allocator1 > & | Drow, | ||
const Vector< T2, VectFull, Allocator2 > & | Dcol | ||
) |
Scaling of a matrix.
A is replaced by Drow A Drow where Drow and Dcol are diagonal matrices and stored as dense vectors
Definition at line 2186 of file Functions.cxx.
void Seldon::ScaleMatrix | ( | Matrix< T, Prop, ColHermPacked, Allocator > & | A, |
const Vector< T1, VectFull, Allocator1 > & | Drow, | ||
const Vector< T2, VectFull, Allocator2 > & | Dcol | ||
) |
Scaling of a matrix.
A is replaced by Drow A Drow where Drow and Dcol are diagonal matrices and stored as dense vectors
Definition at line 2150 of file Functions.cxx.
void Seldon::ScaleMatrix | ( | Matrix< T, Prop, ColLoTriang, Allocator > & | A, |
const Vector< T1, VectFull, Allocator1 > & | Drow, | ||
const Vector< T2, VectFull, Allocator2 > & | Dcol | ||
) |
Scaling of a matrix.
A is replaced by Drow A Dcol where Drow and Dcol are diagonal matrices and stored as dense vectors
Definition at line 2258 of file Functions.cxx.
void Seldon::ScaleMatrix | ( | Matrix< T, Prop, ColLoTriangPacked, Allocator > & | A, |
const Vector< T1, VectFull, Allocator1 > & | Drow, | ||
const Vector< T2, VectFull, Allocator2 > & | Dcol | ||
) |
Scaling of a matrix.
A is replaced by Drow A Dcol where Drow and Dcol are diagonal matrices and stored as dense vectors
Definition at line 2240 of file Functions.cxx.
void Seldon::ScaleMatrix | ( | Matrix< T, Prop, ColMajor, Allocator > & | A, |
const Vector< T1, VectFull, Allocator1 > & | Drow, | ||
const Vector< T2, VectFull, Allocator2 > & | Dcol | ||
) |
Scaling of a matrix.
A is replaced by Drow A Dcol where Drow and Dcol are diagonal matrices and stored as dense vectors
Definition at line 2042 of file Functions.cxx.
void Seldon::ScaleMatrix | ( | Matrix< T, Prop, ColSym, Allocator > & | A, |
const Vector< T1, VectFull, Allocator1 > & | Drow, | ||
const Vector< T2, VectFull, Allocator2 > & | Dcol | ||
) |
Scaling of a matrix.
A is replaced by Drow A Drow where Drow and Dcol are diagonal matrices and stored as dense vectors
Definition at line 2114 of file Functions.cxx.
void Seldon::ScaleMatrix | ( | Matrix< T, Prop, ColSymPacked, Allocator > & | A, |
const Vector< T1, VectFull, Allocator1 > & | Drow, | ||
const Vector< T2, VectFull, Allocator2 > & | Dcol | ||
) |
Scaling of a matrix.
A is replaced by Drow A Drow where Drow and Dcol are diagonal matrices and stored as dense vectors
Definition at line 2078 of file Functions.cxx.
void Seldon::ScaleMatrix | ( | Matrix< T, Prop, ColUpTriang, Allocator > & | A, |
const Vector< T1, VectFull, Allocator1 > & | Drow, | ||
const Vector< T2, VectFull, Allocator2 > & | Dcol | ||
) |
Scaling of a matrix.
A is replaced by Drow A Dcol where Drow and Dcol are diagonal matrices and stored as dense vectors
Definition at line 2330 of file Functions.cxx.
void Seldon::ScaleMatrix | ( | Matrix< T, Prop, ColUpTriangPacked, Allocator > & | A, |
const Vector< T1, VectFull, Allocator1 > & | Drow, | ||
const Vector< T2, VectFull, Allocator2 > & | Dcol | ||
) |
Scaling of a matrix.
A is replaced by Drow A Dcol where Drow and Dcol are diagonal matrices and stored as dense vectors
Definition at line 2312 of file Functions.cxx.
void Seldon::ScaleMatrix | ( | Matrix< T, Prop, RowHerm, Allocator > & | A, |
const Vector< T1, VectFull, Allocator1 > & | Drow, | ||
const Vector< T2, VectFull, Allocator2 > & | Dcol | ||
) |
Scaling of a matrix.
A is replaced by Drow A Drow where Drow and Dcol are diagonal matrices and stored as dense vectors
Definition at line 2168 of file Functions.cxx.
void Seldon::ScaleMatrix | ( | Matrix< T, Prop, RowHermPacked, Allocator > & | A, |
const Vector< T1, VectFull, Allocator1 > & | Drow, | ||
const Vector< T2, VectFull, Allocator2 > & | Dcol | ||
) |
Scaling of a matrix.
A is replaced by Drow A Drow where Drow and Dcol are diagonal matrices and stored as dense vectors
Definition at line 2132 of file Functions.cxx.
void Seldon::ScaleMatrix | ( | Matrix< T, Prop, RowLoTriang, Allocator > & | A, |
const Vector< T1, VectFull, Allocator1 > & | Drow, | ||
const Vector< T2, VectFull, Allocator2 > & | Dcol | ||
) |
Scaling of a matrix.
A is replaced by Drow A Dcol where Drow and Dcol are diagonal matrices and stored as dense vectors
Definition at line 2222 of file Functions.cxx.
void Seldon::ScaleMatrix | ( | Matrix< T, Prop, RowLoTriangPacked, Allocator > & | A, |
const Vector< T1, VectFull, Allocator1 > & | Drow, | ||
const Vector< T2, VectFull, Allocator2 > & | Dcol | ||
) |
Scaling of a matrix.
A is replaced by Drow A Dcol where Drow and Dcol are diagonal matrices and stored as dense vectors
Definition at line 2204 of file Functions.cxx.
void Seldon::ScaleMatrix | ( | Matrix< T, Prop, RowMajor, Allocator > & | A, |
const Vector< T1, VectFull, Allocator1 > & | Drow, | ||
const Vector< T2, VectFull, Allocator2 > & | Dcol | ||
) |
Scaling of a matrix.
A is replaced by Drow A Dcol where Drow and Dcol are diagonal matrices and stored as dense vectors
Definition at line 2024 of file Functions.cxx.
void Seldon::ScaleMatrix | ( | Matrix< T, Prop, RowSym, Allocator > & | A, |
const Vector< T1, VectFull, Allocator1 > & | Drow, | ||
const Vector< T2, VectFull, Allocator2 > & | Dcol | ||
) |
Scaling of a matrix.
A is replaced by Drow A Drow where Drow and Dcol are diagonal matrices and stored as dense vectors
Definition at line 2096 of file Functions.cxx.
void Seldon::ScaleMatrix | ( | Matrix< T, Prop, RowSymPacked, Allocator > & | A, |
const Vector< T1, VectFull, Allocator1 > & | Drow, | ||
const Vector< T2, VectFull, Allocator2 > & | Dcol | ||
) |
Scaling of a matrix.
A is replaced by Drow A Drow where Drow and Dcol are diagonal matrices and stored as dense vectors
Definition at line 2060 of file Functions.cxx.
void Seldon::ScaleMatrix | ( | Matrix< T, Prop, RowUpTriang, Allocator > & | A, |
const Vector< T1, VectFull, Allocator1 > & | Drow, | ||
const Vector< T2, VectFull, Allocator2 > & | Dcol | ||
) |
Scaling of a matrix.
A is replaced by Drow A Dcol where Drow and Dcol are diagonal matrices and stored as dense vectors
Definition at line 2294 of file Functions.cxx.
void Seldon::ScaleMatrix | ( | Matrix< T, Prop, RowUpTriangPacked, Allocator > & | A, |
const Vector< T1, VectFull, Allocator1 > & | Drow, | ||
const Vector< T2, VectFull, Allocator2 > & | Dcol | ||
) |
Scaling of a matrix.
A is replaced by Drow A Dcol where Drow and Dcol are diagonal matrices and stored as dense vectors
Definition at line 2276 of file Functions.cxx.
void Seldon::ScaleMatrix | ( | Matrix< T1, Prop, ArrayColSparse, Allocator1 > & | A, |
const Vector< T2, VectFull, Allocator2 > & | scale_left, | ||
const Vector< T3, VectFull, Allocator3 > & | scale_right | ||
) |
Each row and column are scaled.
We compute diag(scale_left)*A*diag(scale_right).
Definition at line 870 of file Permutation_ScalingMatrix.cxx.
void Seldon::ScaleMatrix | ( | Matrix< T1, Prop, ArrayColSymSparse, Allocator1 > & | A, |
const Vector< T2, VectFull, Allocator2 > & | scale_left, | ||
const Vector< T3, VectFull, Allocator3 > & | scale_right | ||
) |
Each row and column are scaled.
We compute diag(scale_left)*A*diag(scale_right).
Definition at line 905 of file Permutation_ScalingMatrix.cxx.
void Seldon::ScaleMatrix | ( | Matrix< T1, Prop, ArrayRowComplexSparse, Allocator1 > & | A, |
const Vector< T2, VectFull, Allocator2 > & | scale_left, | ||
const Vector< T3, VectFull, Allocator3 > & | scale_right | ||
) |
Each row and column are scaled.
We compute diag(scale_left)*A*diag(scale_right).
Definition at line 883 of file Functions_MatrixComplex.cxx.
void Seldon::ScaleMatrix | ( | Matrix< T1, Prop, ArrayRowSparse, Allocator1 > & | A, |
const Vector< T2, VectFull, Allocator2 > & | scale_left, | ||
const Vector< T3, VectFull, Allocator3 > & | scale_right | ||
) |
Each row and column are scaled.
We compute diag(scale_left)*A*diag(scale_right).
Definition at line 852 of file Permutation_ScalingMatrix.cxx.
void Seldon::ScaleMatrix | ( | Matrix< T1, Prop, ArrayRowSymComplexSparse, Allocator1 > & | A, |
const Vector< T2, VectFull, Allocator2 > & | scale_left, | ||
const Vector< T3, VectFull, Allocator3 > & | scale_right | ||
) |
Each row and column are scaled.
We compute diag(scale_left)*A*diag(scale_right).
Definition at line 860 of file Functions_MatrixComplex.cxx.
void Seldon::ScaleMatrix | ( | Matrix< T1, Prop, ArrayRowSymSparse, Allocator1 > & | A, |
const Vector< T2, VectFull, Allocator2 > & | scale_left, | ||
const Vector< T3, VectFull, Allocator3 > & | scale_right | ||
) |
Each row and column are scaled.
We compute diag(scale_left)*A*diag(scale_right).
Definition at line 887 of file Permutation_ScalingMatrix.cxx.
void Seldon::ScaleMatrix | ( | Matrix< T1, Prop, ColSparse, Allocator1 > & | A, |
const Vector< T2, VectFull, Allocator2 > & | scale_left, | ||
const Vector< T3, VectFull, Allocator3 > & | scale_right | ||
) |
Each row and column are scaled.
We compute diag(scale_left)*A*diag(scale_right).
Definition at line 791 of file Permutation_ScalingMatrix.cxx.
void Seldon::ScaleMatrix | ( | Matrix< T1, Prop, ColSymSparse, Allocator1 > & | A, |
const Vector< T2, VectFull, Allocator2 > & | scale_left, | ||
const Vector< T3, VectFull, Allocator3 > & | scale_right | ||
) |
Each row and column are scaled.
We compute diag(scale_left)*A*diag(scale_left).
Definition at line 832 of file Permutation_ScalingMatrix.cxx.
void Seldon::ScaleMatrix | ( | Matrix< T1, Prop, RowComplexSparse, Allocator1 > & | A, |
const Vector< T2, VectFull, Allocator2 > & | scale_left, | ||
const Vector< T3, VectFull, Allocator3 > & | scale_right | ||
) |
Each row and column are scaled.
We compute diag(scale_left)*A*diag(scale_right).
Definition at line 976 of file Functions_MatrixComplex.cxx.
void Seldon::ScaleMatrix | ( | Matrix< T1, Prop, RowSparse, Allocator1 > & | A, |
const Vector< T2, VectFull, Allocator2 > & | scale_left, | ||
const Vector< T3, VectFull, Allocator3 > & | scale_right | ||
) |
Each row and column are scaled.
We compute diag(scale_left)*A*diag(scale_right).
Definition at line 770 of file Permutation_ScalingMatrix.cxx.
void Seldon::ScaleMatrix | ( | Matrix< T1, Prop, RowSymComplexSparse, Allocator1 > & | A, |
const Vector< T2, VectFull, Allocator2 > & | scale_left, | ||
const Vector< T3, VectFull, Allocator3 > & | scale_right | ||
) |
Each row and column are scaled.
We compute diag(scale_left)*A*diag(scale_right).
Definition at line 948 of file Functions_MatrixComplex.cxx.
void Seldon::ScaleMatrix | ( | Matrix< T1, Prop, RowSymSparse, Allocator1 > & | A, |
const Vector< T2, VectFull, Allocator2 > & | scale_left, | ||
const Vector< T3, VectFull, Allocator3 > & | scale_right | ||
) |
Each row and column are scaled.
We compute diag(scale_left)*A*diag(scale_left).
Definition at line 811 of file Permutation_ScalingMatrix.cxx.
void Seldon::ScaleRightMatrix | ( | Matrix< T, Prop, ColLoTriang, Allocator > & | A, |
const Vector< T2, VectFull, Allocator2 > & | Dcol | ||
) |
Right-scaling of a matrix.
A is replaced by A Dcol where Dcol is diagonal and stored as a dense vector
Definition at line 2587 of file Functions.cxx.
void Seldon::ScaleRightMatrix | ( | Matrix< T, Prop, ColLoTriangPacked, Allocator > & | A, |
const Vector< T2, VectFull, Allocator2 > & | Dcol | ||
) |
Right-scaling of a matrix.
A is replaced by A Dcol where Dcol is diagonal and stored as a dense vector
Definition at line 2571 of file Functions.cxx.
void Seldon::ScaleRightMatrix | ( | Matrix< T, Prop, ColMajor, Allocator > & | A, |
const Vector< T2, VectFull, Allocator2 > & | Dcol | ||
) |
Right-scaling of a matrix.
A is replaced by A Dcol where Dcol is diagonal and stored as a dense vector
Definition at line 2523 of file Functions.cxx.
void Seldon::ScaleRightMatrix | ( | Matrix< T, Prop, ColUpTriang, Allocator > & | A, |
const Vector< T2, VectFull, Allocator2 > & | Dcol | ||
) |
Right-scaling of a matrix.
A is replaced by A Dcol where Dcol is diagonal and stored as a dense vector
Definition at line 2651 of file Functions.cxx.
void Seldon::ScaleRightMatrix | ( | Matrix< T, Prop, ColUpTriangPacked, Allocator > & | A, |
const Vector< T2, VectFull, Allocator2 > & | Dcol | ||
) |
Right-scaling of a matrix.
A is replaced by A Dcol where Dcol is diagonal and stored as a dense vector
Definition at line 2635 of file Functions.cxx.
void Seldon::ScaleRightMatrix | ( | Matrix< T, Prop, RowLoTriang, Allocator > & | A, |
const Vector< T2, VectFull, Allocator2 > & | Dcol | ||
) |
Right-scaling of a matrix.
A is replaced by A Dcol where Dcol is diagonal and stored as a dense vector
Definition at line 2555 of file Functions.cxx.
void Seldon::ScaleRightMatrix | ( | Matrix< T, Prop, RowLoTriangPacked, Allocator > & | A, |
const Vector< T2, VectFull, Allocator2 > & | Dcol | ||
) |
Right-scaling of a matrix.
A is replaced by A Dcol where Dcol is diagonal and stored as a dense vector
Definition at line 2539 of file Functions.cxx.
void Seldon::ScaleRightMatrix | ( | Matrix< T, Prop, RowMajor, Allocator > & | A, |
const Vector< T2, VectFull, Allocator2 > & | Dcol | ||
) |
Right-scaling of a matrix.
A is replaced by A Dcol where Dcol is diagonal and stored as a dense vector
Definition at line 2507 of file Functions.cxx.
void Seldon::ScaleRightMatrix | ( | Matrix< T, Prop, RowUpTriang, Allocator > & | A, |
const Vector< T2, VectFull, Allocator2 > & | Dcol | ||
) |
Right-scaling of a matrix.
A is replaced by A Dcol where Dcol is diagonal and stored as a dense vector
Definition at line 2619 of file Functions.cxx.
void Seldon::ScaleRightMatrix | ( | Matrix< T, Prop, RowUpTriangPacked, Allocator > & | A, |
const Vector< T2, VectFull, Allocator2 > & | Dcol | ||
) |
Right-scaling of a matrix.
A is replaced by A Dcol where Dcol is diagonal and stored as a dense vector
Definition at line 2603 of file Functions.cxx.
void Seldon::ScaleRightMatrix | ( | Matrix< T1, Prop, ArrayColSparse, Allocator1 > & | A, |
const Vector< T2, VectFull, Allocator2 > & | scale | ||
) |
Each column is scaled.
We compute A*diag(S) where S = scale.
Definition at line 1062 of file Permutation_ScalingMatrix.cxx.
void Seldon::ScaleRightMatrix | ( | Matrix< T1, Prop, ArrayRowComplexSparse, Allocator1 > & | A, |
const Vector< T2, VectFull, Allocator2 > & | scale | ||
) |
Each column is scaled.
We compute A*diag(S) where S = scale.
Definition at line 926 of file Functions_MatrixComplex.cxx.
void Seldon::ScaleRightMatrix | ( | Matrix< T1, Prop, ArrayRowSparse, Allocator1 > & | A, |
const Vector< T2, VectFull, Allocator2 > & | scale | ||
) |
Each column is scaled.
We compute A*diag(S) where S = scale.
Definition at line 1046 of file Permutation_ScalingMatrix.cxx.
void Seldon::ScaleRightMatrix | ( | Matrix< T1, Prop, ColSparse, Allocator1 > & | A, |
const Vector< T2, VectFull, Allocator2 > & | scale | ||
) |
Each column is scaled.
We compute A*diag(S) where S = scale.
Definition at line 1028 of file Permutation_ScalingMatrix.cxx.
void Seldon::ScaleRightMatrix | ( | Matrix< T1, Prop, RowComplexSparse, Allocator1 > & | A, |
const Vector< T2, VectFull, Allocator2 > & | scale | ||
) |
Each column is scaled.
We compute A*diag(S) where S = scale.
Definition at line 1029 of file Functions_MatrixComplex.cxx.
void Seldon::ScaleRightMatrix | ( | Matrix< T1, Prop, RowSparse, Allocator1 > & | A, |
const Vector< T2, VectFull, Allocator2 > & | scale | ||
) |
Each column is scaled.
We compute A*diag(S) where S = scale.
Definition at line 1008 of file Permutation_ScalingMatrix.cxx.
void Seldon::SetCol | ( | const Vector< T1, PETScPar, Allocator1 > & | X, |
int | j, | ||
Matrix< T0, Prop0, PETScMPIDense, Allocator0 > & | M | ||
) |
Sets a column of a matrix.
[in] | X | new column j of M. |
[in] | j | column index. |
[out] | M | matrix. |
Definition at line 1167 of file Functions.cxx.
void Seldon::SetCol | ( | const Vector< T1, PETScSeq, Allocator1 > & | X, |
int | j, | ||
Matrix< T0, Prop0, PETScSeqDense, Allocator0 > & | M | ||
) |
Sets a column of a matrix.
[in] | X | new column j of M. |
[in] | j | column index. |
[out] | M | matrix. |
Definition at line 1148 of file Functions.cxx.
void Seldon::SetCol | ( | const Vector< T1, Storage1, Allocator1 > & | X, |
int | j, | ||
Matrix< T0, Prop0, ColLoTriang, Allocator0 > & | M | ||
) |
Sets a column of a matrix.
M | matrix |
j | column index |
X | new column of M M(:, j) = X |
Definition at line 1523 of file Functions.cxx.
void Seldon::SetCol | ( | const Vector< T1, Storage1, Allocator1 > & | X, |
int | j, | ||
Matrix< T0, Prop0, ColLoTriangPacked, Allocator0 > & | M | ||
) |
Sets a column of a matrix.
M | matrix |
j | column index |
X | new column of M M(:, j) = X |
Definition at line 1540 of file Functions.cxx.
void Seldon::SetCol | ( | const Vector< T1, Storage1, Allocator1 > & | X, |
int | j, | ||
Matrix< T0, Prop0, ColUpTriang, Allocator0 > & | M | ||
) |
Sets a column of a matrix.
M | matrix |
j | column index |
X | new column of M M(:, j) = X |
Definition at line 1591 of file Functions.cxx.
void Seldon::SetCol | ( | const Vector< T1, Storage1, Allocator1 > & | X, |
int | j, | ||
Matrix< T0, Prop0, ColUpTriangPacked, Allocator0 > & | M | ||
) |
Sets a column of a matrix.
M | matrix |
j | column index |
X | new column of M M(:, j) = X |
Definition at line 1608 of file Functions.cxx.
void Seldon::SetCol | ( | const Vector< T1, Storage1, Allocator1 > & | X, |
int | j, | ||
Matrix< T0, Prop0, RowLoTriang, Allocator0 > & | M | ||
) |
Sets a column of a matrix.
M | matrix |
j | column index |
X | new column of M M(:, j) = X |
Definition at line 1489 of file Functions.cxx.
void Seldon::SetCol | ( | const Vector< T1, Storage1, Allocator1 > & | X, |
int | j, | ||
Matrix< T0, Prop0, RowLoTriangPacked, Allocator0 > & | M | ||
) |
Sets a column of a matrix.
M | matrix |
j | column index |
X | new column of M M(:, j) = X |
Definition at line 1506 of file Functions.cxx.
void Seldon::SetCol | ( | const Vector< T1, Storage1, Allocator1 > & | X, |
int | j, | ||
Matrix< T0, Prop0, RowUpTriang, Allocator0 > & | M | ||
) |
Sets a column of a matrix.
M | matrix |
j | column index |
X | new column of M M(:, j) = X |
Definition at line 1557 of file Functions.cxx.
void Seldon::SetCol | ( | const Vector< T1, Storage1, Allocator1 > & | X, |
int | j, | ||
Matrix< T0, Prop0, RowUpTriangPacked, Allocator0 > & | M | ||
) |
Sets a column of a matrix.
M | matrix |
j | column index |
X | new column of M M(:, j) = X |
Definition at line 1574 of file Functions.cxx.
void Seldon::SetCol | ( | const Vector< T1, Storage1, Allocator1 > & | X, |
int | j, | ||
Matrix< T0, Prop0, Storage0, Allocator0 > & | M | ||
) |
Sets a column of a matrix.
[in] | X | new column j of M. |
j | column index | |
M | matrix M(:, j) = X |
Definition at line 1129 of file Functions.cxx.
void Seldon::SetCol | ( | const Vector< T1, VectFull, Allocator1 > & | X, |
int | j, | ||
Matrix< T0, General, RowSparse, Allocator0 > & | M | ||
) |
Sets a column of a matrix.
[in] | X | new column j of M. |
[in] | j | column index. |
[out] | M | matrix. M(:, j) = X |
Definition at line 1187 of file Functions.cxx.
void Seldon::SetCol | ( | const Vector< T1, VectSparse, Allocator1 > & | X, |
int | j, | ||
Matrix< T0, General, ArrayColSparse, Allocator0 > & | M | ||
) |
Sets a column of a matrix.
M | matrix |
j | column index |
X | new column of M M(:, j) = X |
Definition at line 737 of file Functions_MatrixArray.cxx.
void Seldon::SetCol | ( | const Vector< T1, VectSparse, Allocator1 > & | X, |
int | j, | ||
Matrix< T0, General, ArrayRowSparse, Allocator0 > & | M | ||
) |
Sets a column of a matrix.
M | matrix |
j | column index |
X | new column of M M(:, j) = X |
Definition at line 653 of file Functions_MatrixArray.cxx.
void Seldon::SetCol | ( | const Vector< T1, VectSparse, Allocator1 > & | X, |
int | j, | ||
Matrix< T0, General, ColSparse, Allocator0 > & | M | ||
) |
Sets a column of a matrix.
M | matrix |
j | column index |
X | new column of M M(:, j) = X |
Definition at line 1377 of file Functions.cxx.
void Seldon::SetCol | ( | const Vector< T1, VectSparse, Allocator1 > & | X, |
int | j, | ||
Matrix< T0, General, RowSparse, Allocator0 > & | M | ||
) |
Sets a column of a matrix.
[in] | X | new column j of M. |
[in] | j | column index. |
[out] | M | matrix. M(:, j) = X |
Definition at line 1210 of file Functions.cxx.
void Seldon::SetCol | ( | const Vector< T1, VectSparse, Allocator1 > & | X, |
int | j, | ||
Matrix< T0, Symmetric, ArrayColSymSparse, Allocator0 > & | M | ||
) |
Sets a column of a matrix.
M | matrix |
j | column index |
X | new column of M M(:, j) = X |
Definition at line 776 of file Functions_MatrixArray.cxx.
void Seldon::SetCol | ( | const Vector< T1, VectSparse, Allocator1 > & | X, |
int | j, | ||
Matrix< T0, Symmetric, ArrayRowSymSparse, Allocator0 > & | M | ||
) |
Sets a column of a matrix.
M | matrix |
j | column index |
X | new column of M M(:, j) = X |
Definition at line 759 of file Functions_MatrixArray.cxx.
void Seldon::SetCol | ( | const Vector< T1, VectSparse, Allocator1 > & | X, |
int | j, | ||
Matrix< T0, Symmetric, ColSymSparse, Allocator0 > & | M | ||
) |
Sets a column of a matrix.
M | matrix |
j | column index |
X | new column of M M(:, j) = X |
Definition at line 1472 of file Functions.cxx.
void Seldon::SetCol | ( | const Vector< T1, VectSparse, Allocator1 > & | X, |
int | j, | ||
Matrix< T0, Symmetric, RowSymSparse, Allocator0 > & | M | ||
) |
Sets a column of a matrix.
M | matrix |
j | column index |
X | new column of M M(:, j) = X |
Definition at line 1456 of file Functions.cxx.
|
inline |
Sets a complex number to (1, 0).
[in,out] | number | complex number to be set to (1, 0). |
Definition at line 212 of file CommonInline.cxx.
|
inline |
Sets a number to one.
[in,out] | number | number to be set to one. |
Definition at line 201 of file CommonInline.cxx.
|
inline |
Sets a complex number to (n, 0).
[in,out] | number | complex number to be set to (n, 0). |
Definition at line 245 of file CommonInline.cxx.
|
inline |
Sets a complex number to (x, 0).
[in,out] | number | complex number to be set to (x, 0). |
Definition at line 274 of file CommonInline.cxx.
|
inline |
Sets a complex number to (x, 0).
[in,out] | number | complex number to be set to (x, 0). |
Definition at line 263 of file CommonInline.cxx.
|
inline |
Sets a complex number to x.
[in,out] | number | complex number to be set to x. |
Definition at line 285 of file CommonInline.cxx.
|
inline |
Sets a complex number to (n, 0).
[in,out] | number | complex number to be set to (n, 0). |
Definition at line 234 of file CommonInline.cxx.
|
inline |
Sets a real number to n.
[in,out] | number | real umber to be set to n. |
Definition at line 223 of file CommonInline.cxx.
|
inline |
Sets a complex number to zero.
[in,out] | number | complex number to be set to zero. |
Definition at line 190 of file CommonInline.cxx.
|
inline |
Sets a number to zero.
[in,out] | number | number to be set to zero. |
Definition at line 179 of file CommonInline.cxx.
void Seldon::SetRow | ( | const Vector< T1, PETScPar, Allocator1 > & | X, |
int | i, | ||
Matrix< T0, Prop0, PETScMPIDense, Allocator0 > & | M | ||
) |
Sets a row of a matrix.
[in] | X | new row i of M. |
[in] | i | row index. |
[out] | M | matrix. |
Definition at line 486 of file Functions.cxx.
void Seldon::SetRow | ( | const Vector< T1, PETScSeq, Allocator1 > & | X, |
int | i, | ||
Matrix< T0, Prop0, PETScSeqDense, Allocator0 > & | M | ||
) |
Sets a row of a matrix.
[in] | X | new row i of M. |
[in] | i | row index. |
[out] | M | matrix. |
Definition at line 469 of file Functions.cxx.
void Seldon::SetRow | ( | const Vector< T1, Storage1, Allocator1 > & | X, |
int | i, | ||
Matrix< T0, Prop0, ColLoTriang, Allocator0 > & | M | ||
) |
Sets a row of a matrix.
M | matrix |
i | row index |
X | new row of M M(i, :) = X |
Definition at line 1027 of file Functions.cxx.
void Seldon::SetRow | ( | const Vector< T1, Storage1, Allocator1 > & | X, |
int | i, | ||
Matrix< T0, Prop0, ColLoTriangPacked, Allocator0 > & | M | ||
) |
Sets a row of a matrix.
M | matrix |
i | row index |
X | new row of M M(i, :) = X |
Definition at line 1044 of file Functions.cxx.
void Seldon::SetRow | ( | const Vector< T1, Storage1, Allocator1 > & | X, |
int | i, | ||
Matrix< T0, Prop0, ColUpTriang, Allocator0 > & | M | ||
) |
Sets a row of a matrix.
M | matrix |
i | row index |
X | new row of M M(i, :) = X |
Definition at line 1095 of file Functions.cxx.
void Seldon::SetRow | ( | const Vector< T1, Storage1, Allocator1 > & | X, |
int | i, | ||
Matrix< T0, Prop0, ColUpTriangPacked, Allocator0 > & | M | ||
) |
Sets a row of a matrix.
M | matrix |
i | row index |
X | new row of M M(i, :) = X |
Definition at line 1112 of file Functions.cxx.
void Seldon::SetRow | ( | const Vector< T1, Storage1, Allocator1 > & | X, |
int | i, | ||
Matrix< T0, Prop0, RowLoTriang, Allocator0 > & | M | ||
) |
Sets a row of a matrix.
M | matrix |
i | row index |
X | new row of M M(i, :) = X |
Definition at line 993 of file Functions.cxx.
void Seldon::SetRow | ( | const Vector< T1, Storage1, Allocator1 > & | X, |
int | i, | ||
Matrix< T0, Prop0, RowLoTriangPacked, Allocator0 > & | M | ||
) |
Sets a row of a matrix.
M | matrix |
i | row index |
X | new row of M M(i, :) = X |
Definition at line 1010 of file Functions.cxx.
void Seldon::SetRow | ( | const Vector< T1, Storage1, Allocator1 > & | X, |
int | i, | ||
Matrix< T0, Prop0, RowUpTriang, Allocator0 > & | M | ||
) |
Sets a row of a matrix.
M | matrix |
i | row index |
X | new row of M M(i, :) = X |
Definition at line 1061 of file Functions.cxx.
void Seldon::SetRow | ( | const Vector< T1, Storage1, Allocator1 > & | X, |
int | i, | ||
Matrix< T0, Prop0, RowUpTriangPacked, Allocator0 > & | M | ||
) |
Sets a row of a matrix.
M | matrix |
i | row index |
X | new row of M M(i, :) = X |
Definition at line 1078 of file Functions.cxx.
void Seldon::SetRow | ( | const Vector< T1, Storage1, Allocator1 > & | X, |
int | i, | ||
Matrix< T0, Prop0, Storage0, Allocator0 > & | M | ||
) |
Sets a row of a matrix.
M | matrix |
i | row index |
X | new row of M M(i, :) = X |
Definition at line 450 of file Functions.cxx.
void Seldon::SetRow | ( | const Vector< T1, VectSparse, Allocator1 > & | X, |
int | i, | ||
Matrix< T0, General, ArrayColSparse, Allocator0 > & | M | ||
) |
Sets a row of a matrix.
M | matrix |
i | row index |
X | new row of M M(i, :) = X |
Definition at line 264 of file Functions_MatrixArray.cxx.
void Seldon::SetRow | ( | const Vector< T1, VectSparse, Allocator1 > & | X, |
int | i, | ||
Matrix< T0, General, ArrayRowSparse, Allocator0 > & | M | ||
) |
Sets a row of a matrix.
M | matrix |
i | row index |
X | new row of M M(i, :) = X |
Definition at line 242 of file Functions_MatrixArray.cxx.
void Seldon::SetRow | ( | const Vector< T1, VectSparse, Allocator1 > & | X, |
int | i, | ||
Matrix< T0, General, ColSparse, Allocator0 > & | M | ||
) |
Sets a row of a matrix.
M | matrix |
i | row index |
X | new row of M M(i, :) = X |
Definition at line 567 of file Functions.cxx.
void Seldon::SetRow | ( | const Vector< T1, VectSparse, Allocator1 > & | X, |
int | i, | ||
Matrix< T0, General, RowSparse, Allocator0 > & | M | ||
) |
Sets a row of a matrix.
M | matrix |
i | row index |
X | new row of M M(i, :) = X |
Definition at line 503 of file Functions.cxx.
void Seldon::SetRow | ( | const Vector< T1, VectSparse, Allocator1 > & | X, |
int | i, | ||
Matrix< T0, Symmetric, ArrayColSymSparse, Allocator0 > & | M | ||
) |
Sets a row of a matrix.
M | matrix |
i | row index |
X | new row of M M(i, :) = X |
Definition at line 445 of file Functions_MatrixArray.cxx.
void Seldon::SetRow | ( | const Vector< T1, VectSparse, Allocator1 > & | X, |
int | i, | ||
Matrix< T0, Symmetric, ArrayRowSymSparse, Allocator0 > & | M | ||
) |
Sets a row of a matrix.
M | matrix |
i | row index |
X | new row of M M(i, :) = X |
Definition at line 346 of file Functions_MatrixArray.cxx.
void Seldon::SetRow | ( | const Vector< T1, VectSparse, Allocator1 > & | X, |
int | i, | ||
Matrix< T0, Symmetric, ColSymSparse, Allocator0 > & | M | ||
) |
Sets a row of a matrix.
M | matrix |
i | row index |
X | new row of M M(i, :) = X |
Definition at line 845 of file Functions.cxx.
void Seldon::SetRow | ( | const Vector< T1, VectSparse, Allocator1 > & | X, |
int | i, | ||
Matrix< T0, Symmetric, RowSymSparse, Allocator0 > & | M | ||
) |
Sets a row of a matrix.
M | matrix |
i | row index |
X | new row of M M(i, :) = X |
Definition at line 689 of file Functions.cxx.
void Seldon::SolveCholesky | ( | const SeldonTranspose & | TransA, |
const Matrix< T0, Prop, ArrayRowSymSparse, Allocator0 > & | A, | ||
Vector< T1, Storage, Allocator1 > & | x | ||
) |
Resolution of L x = y or L^T x = y.
[in] | TransA | SeldonTrans or SeldonNoTrans. |
[in] | A | Cholesky factorization obtained after calling "GetCholesky". |
[in,out] | x | on exit, it is overwritten by the solution. |
Definition at line 259 of file SparseCholeskyFactorisation.cxx.
void Seldon::SolveCholesky | ( | const SeldonTranspose & | TransA, |
const Matrix< T0, Prop, RowSymSparse, Alloc0 > & | A, | ||
Vector< T1, Storage, Allocator1 > & | X | ||
) |
Resolution of L x = y or L^T x = y.
[in] | TransA | SeldonTrans or SeldonNoTrans. |
[in] | A | Cholesky factorization obtained after calling "GetCholesky". |
[in,out] | x | on exit, it is overwritten by the solution. |
Definition at line 308 of file SparseCholeskyFactorisation.cxx.
void Seldon::SolveLuVector | ( | const Matrix< T0, Prop0, Storage0, Allocator0 > & | M, |
Vector< T1, Storage1, Allocator1 > & | Y | ||
) |
Solves a linear system whose matrix has been LU-factorized.
This function solves where is a matrix, and and are vectors. The matrix M cannot be provided as such to this function: it must already be factorized in LU form.
[in] | M | the matrix of the linear system, already factorized in LU form. The lower part of M should be L, and the upper part should be U. The diagonal of M should be the diagonal of U. The diagonal elements of L are assumed to be ones. |
[in,out] | Y | on entry, the right-hand side ; on exit, the solution of the system. |
Definition at line 1782 of file Functions_MatVect.cxx.
void Seldon::SolveLuVector | ( | const SeldonTranspose & | transA, |
const Matrix< T1, General, ArrayRowSparse, Allocator1 > & | A, | ||
Vector< T2, Storage2, Allocator2 > & | x | ||
) |
Resolution of LU y = x (x is overwritten with y)
L and U are assumed to be stored in A. The diagonal of A contains the inverse of the diagonal of U.
Definition at line 715 of file SparseSolver.cxx.
void Seldon::SolveLuVector | ( | const SeldonTranspose & | transA, |
const Matrix< T1, Symmetric, ArrayRowSymSparse, Allocator1 > & | A, | ||
Vector< T2, Storage2, Allocator2 > & | x | ||
) |
Resolution of L D L^t y = x (result is overwritten in x)
The factor L^t is assumed to be stored in matrix A. The diagonal of A is equal to the inverse of diagonal D.
Definition at line 1036 of file SparseSolver.cxx.
void Seldon::SolveSylvester | ( | Matrix< double, Prop, Storage, Allocator > & | A, |
Matrix< double, Prop, Storage, Allocator > & | B, | ||
Matrix< double, Prop, Storage, Allocator > & | C, | ||
Matrix< double, Prop, Storage, Allocator > & | D, | ||
Matrix< double, Prop, Storage, Allocator > & | E | ||
) |
Solves A X B^T + C X D^T = E, E is overwritten with result X. A, B, C and D are modified
Definition at line 5471 of file Lapack_Eigenvalues.cxx.
void Seldon::Sort | ( | long | m, |
long | n, | ||
Vector< T1, Storage1, Allocator1 > & | V, | ||
Vector< T2, Storage2, Allocator2 > & | V2 | ||
) |
Sorts vector V between a start position and an end position.
The sorting operation of V also affects V2.
Definition at line 671 of file Functions_Arrays.cxx.
void Seldon::Sort | ( | long | m, |
long | n, | ||
Vector< T1, Storage1, Allocator1 > & | V, | ||
Vector< T2, Storage2, Allocator2 > & | V2, | ||
Vector< T3, Storage3, Allocator3 > & | V3 | ||
) |
Sorts vector V between a start position and an end position.
The sorting operation of V also affects V2 and V3.
Definition at line 685 of file Functions_Arrays.cxx.
void Seldon::Sort | ( | long | n, |
Vector< T1, Storage1, Allocator1 > & | V, | ||
Vector< T2, Storage2, Allocator2 > & | V2 | ||
) |
Sorts the n first elements of V.
The sorting operation of V also affects V2.
Definition at line 707 of file Functions_Arrays.cxx.
void Seldon::Sort | ( | long | n, |
Vector< T1, Storage1, Allocator1 > & | V, | ||
Vector< T2, Storage2, Allocator2 > & | V2, | ||
Vector< T3, Storage3, Allocator3 > & | V3 | ||
) |
Sorts the n first elements of V.
The sorting operation of V also affects V2 and V3.
Definition at line 721 of file Functions_Arrays.cxx.
void Seldon::Sort | ( | Vector< T1, Storage1, Allocator1 > & | V, |
Vector< T2, Storage2, Allocator2 > & | V2 | ||
) |
Sorts vector V.
The sorting operation of V also affects V2.
Definition at line 743 of file Functions_Arrays.cxx.
void Seldon::Sort | ( | Vector< T1, Storage1, Allocator1 > & | V, |
Vector< T2, Storage2, Allocator2 > & | V2, | ||
Vector< T3, Storage3, Allocator3 > & | V3 | ||
) |
Sorts vector V.
The sorting operation of V also affects V2 and V3.
Definition at line 757 of file Functions_Arrays.cxx.
void Seldon::SorVector | ( | const Matrix< T0, Prop0, ArrayColComplexSparse, Allocator0 > & | A, |
Vector< complex< T2 >, Storage2, Allocator2 > & | X, | ||
const Vector< complex< T1 >, Storage1, Allocator1 > & | B, | ||
const T3 & | omega, | ||
int | iter, | ||
int | type_ssor | ||
) |
Successive overrelaxation.
Solving A X = B by using S.O.R algorithm. omega is the relaxation parameter, iter the number of iterations. type_ssor = 2 forward sweep type_ssor = 3 backward sweep type_ssor = 0 forward and backward sweep
Definition at line 2438 of file Functions_MatVectComplex.cxx.
void Seldon::SorVector | ( | const Matrix< T0, Prop0, ArrayColSparse, Allocator0 > & | A, |
Vector< T2, Storage2, Allocator2 > & | X, | ||
const Vector< T1, Storage1, Allocator1 > & | B, | ||
const T3 & | omega, | ||
int | iter, | ||
int | type_ssor | ||
) |
Successive overrelaxation.
Solving A X = B by using S.O.R algorithm. omega is the relaxation parameter, iter the number of iterations. type_ssor = 2 forward sweep type_ssor = 3 backward sweep type_ssor = 0 forward and backward sweep
Definition at line 560 of file Relaxation_MatVect.cxx.
void Seldon::SorVector | ( | const Matrix< T0, Prop0, ArrayColSymComplexSparse, Allocator0 > & | A, |
Vector< complex< T2 >, Storage2, Allocator2 > & | X, | ||
const Vector< complex< T1 >, Storage1, Allocator1 > & | B, | ||
const T3 & | omega, | ||
int | iter, | ||
int | type_ssor | ||
) |
Successive overrelaxation.
Solving A X = B by using S.O.R algorithm. omega is the relaxation parameter, iter the number of iterations. type_ssor = 2 forward sweep type_ssor = 3 backward sweep type_ssor = 0 forward and backward sweep
Definition at line 3079 of file Functions_MatVectComplex.cxx.
void Seldon::SorVector | ( | const Matrix< T0, Prop0, ArrayColSymSparse, Allocator0 > & | A, |
Vector< T2, Storage2, Allocator2 > & | X, | ||
const Vector< T1, Storage1, Allocator1 > & | B, | ||
const T3 & | omega, | ||
int | iter, | ||
int | type_ssor | ||
) |
Successive overrelaxation.
Solving A X = B by using S.O.R algorithm. omega is the relaxation parameter, iter the number of iterations. type_ssor = 2 forward sweep type_ssor = 3 backward sweep type_ssor = 0 forward and backward sweep
Definition at line 784 of file Relaxation_MatVect.cxx.
void Seldon::SorVector | ( | const Matrix< T0, Prop0, ArrayRowComplexSparse, Allocator0 > & | A, |
Vector< complex< T2 >, Storage2, Allocator2 > & | X, | ||
const Vector< complex< T1 >, Storage1, Allocator1 > & | B, | ||
const T3 & | omega, | ||
int | iter, | ||
int | type_ssor | ||
) |
Successive overrelaxation.
Solving A X = B by using S.O.R algorithm. omega is the relaxation parameter, iter the number of iterations. type_ssor = 2 forward sweep type_ssor = 3 backward sweep type_ssor = 0 forward and backward sweep
Definition at line 2147 of file Functions_MatVectComplex.cxx.
void Seldon::SorVector | ( | const Matrix< T0, Prop0, ArrayRowSparse, Allocator0 > & | A, |
Vector< T2, Storage2, Allocator2 > & | X, | ||
const Vector< T1, Storage1, Allocator1 > & | B, | ||
const T3 & | omega, | ||
int | iter, | ||
int | type_ssor | ||
) |
Successive overrelaxation.
Solving A X = B by using S.O.R algorithm. omega is the relaxation parameter, iter the number of iterations. type_ssor = 2 forward sweep type_ssor = 3 backward sweep type_ssor = 0 forward and backward sweep
Definition at line 137 of file Relaxation_MatVect.cxx.
void Seldon::SorVector | ( | const Matrix< T0, Prop0, ArrayRowSymComplexSparse, Allocator0 > & | A, |
Vector< complex< T2 >, Storage2, Allocator2 > & | X, | ||
const Vector< complex< T1 >, Storage1, Allocator1 > & | B, | ||
const T3 & | omega, | ||
int | iter, | ||
int | type_ssor | ||
) |
Successive overrelaxation.
Solving A X = B by using S.O.R algorithm. omega is the relaxation parameter, iter the number of iterations. type_ssor = 2 forward sweep type_ssor = 3 backward sweep type_ssor = 0 forward and backward sweep
Definition at line 2781 of file Functions_MatVectComplex.cxx.
void Seldon::SorVector | ( | const Matrix< T0, Prop0, ArrayRowSymSparse, Allocator0 > & | A, |
Vector< T2, Storage2, Allocator2 > & | X, | ||
const Vector< T1, Storage1, Allocator1 > & | B, | ||
const T3 & | omega, | ||
int | iter, | ||
int | type_ssor | ||
) |
Successive overrelaxation.
Solving A X = B by using S.O.R algorithm. omega is the relaxation parameter, iter the number of iterations. type_ssor = 2 forward sweep type_ssor = 3 backward sweep type_ssor = 0 forward and backward sweep
Definition at line 332 of file Relaxation_MatVect.cxx.
void Seldon::SorVector | ( | const Matrix< T0, Prop0, ColComplexSparse, Allocator0 > & | A, |
Vector< complex< T2 >, Storage2, Allocator2 > & | X, | ||
const Vector< complex< T1 >, Storage1, Allocator1 > & | B, | ||
const T3 & | omega, | ||
int | iter, | ||
int | type_ssor | ||
) |
Successive overrelaxation.
Solving A X = B by using S.O.R algorithm. omega is the relaxation parameter, iter the number of iterations. type_ssor = 2 forward sweep type_ssor = 3 backward sweep type_ssor = 0 forward and backward sweep
Definition at line 2240 of file Functions_MatVectComplex.cxx.
void Seldon::SorVector | ( | const Matrix< T0, Prop0, ColSparse, Allocator0 > & | A, |
Vector< T2, Storage2, Allocator2 > & | X, | ||
const Vector< T1, Storage1, Allocator1 > & | B, | ||
const T3 & | omega, | ||
int | iter, | ||
int | type_ssor | ||
) |
Successive overrelaxation.
Solving A X = B by using S.O.R algorithm. omega is the relaxation parameter, iter the number of iterations. type_ssor = 2 forward sweep type_ssor = 3 backward sweep type_ssor = 0 forward and backward sweep
Definition at line 433 of file Relaxation_MatVect.cxx.
void Seldon::SorVector | ( | const Matrix< T0, Prop0, ColSymComplexSparse, Allocator0 > & | A, |
Vector< complex< T2 >, Storage2, Allocator2 > & | X, | ||
const Vector< complex< T1 >, Storage1, Allocator1 > & | B, | ||
const T3 & | omega, | ||
int | iter, | ||
int | type_ssor | ||
) |
Successive overrelaxation.
Solving A X = B by using S.O.R algorithm. omega is the relaxation parameter, iter the number of iterations. type_ssor = 2 forward sweep type_ssor = 3 backward sweep type_ssor = 0 forward and backward sweep
Definition at line 2926 of file Functions_MatVectComplex.cxx.
void Seldon::SorVector | ( | const Matrix< T0, Prop0, ColSymSparse, Allocator0 > & | A, |
Vector< T2, Storage2, Allocator2 > & | X, | ||
const Vector< T1, Storage1, Allocator1 > & | B, | ||
const T3 & | omega, | ||
int | iter, | ||
int | type_ssor | ||
) |
Successive overrelaxation.
Solving A X = B by using S.O.R algorithm. omega is the relaxation parameter, iter the number of iterations. type_ssor = 2 forward sweep type_ssor = 3 backward sweep type_ssor = 0 forward and backward sweep
Definition at line 678 of file Relaxation_MatVect.cxx.
void Seldon::SorVector | ( | const Matrix< T0, Prop0, RowComplexSparse, Allocator0 > & | A, |
Vector< complex< T2 >, Storage2, Allocator2 > & | X, | ||
const Vector< complex< T1 >, Storage1, Allocator1 > & | B, | ||
const T3 & | omega, | ||
int | iter, | ||
int | type_ssor | ||
) |
Successive overrelaxation.
Solving A X = B by using S.O.R algorithm. omega is the relaxation parameter, iter the number of iterations. type_ssor = 2 forward sweep type_ssor = 3 backward sweep type_ssor = 0 forward and backward sweep
Definition at line 2048 of file Functions_MatVectComplex.cxx.
void Seldon::SorVector | ( | const Matrix< T0, Prop0, RowSparse, Allocator0 > & | A, |
Vector< T2, Storage2, Allocator2 > & | X, | ||
const Vector< T1, Storage1, Allocator1 > & | B, | ||
const T3 & | omega, | ||
int | iter, | ||
int | type_ssor | ||
) |
Successive overrelaxation.
Solving A X = B by using S.O.R algorithm. omega is the relaxation parameter, iter the number of iterations. type_ssor = 2 forward sweep type_ssor = 3 backward sweep type_ssor = 0 forward and backward sweep
Definition at line 44 of file Relaxation_MatVect.cxx.
void Seldon::SorVector | ( | const Matrix< T0, Prop0, RowSymComplexSparse, Allocator0 > & | A, |
Vector< complex< T2 >, Storage2, Allocator2 > & | X, | ||
const Vector< complex< T1 >, Storage1, Allocator1 > & | B, | ||
const T3 & | omega, | ||
int | iter, | ||
int | type_ssor | ||
) |
Successive overrelaxation.
Solving A X = B by using S.O.R algorithm. omega is the relaxation parameter, iter the number of iterations. type_ssor = 2 forward sweep type_ssor = 3 backward sweep type_ssor = 0 forward and backward sweep
Definition at line 2628 of file Functions_MatVectComplex.cxx.
void Seldon::SorVector | ( | const Matrix< T0, Prop0, RowSymSparse, Allocator0 > & | A, |
Vector< T2, Storage2, Allocator2 > & | X, | ||
const Vector< T1, Storage1, Allocator1 > & | B, | ||
const T3 & | omega, | ||
int | iter, | ||
int | type_ssor | ||
) |
Successive overrelaxation.
Solving A X = B by using S.O.R algorithm. omega is the relaxation parameter, iter the number of iterations. type_ssor = 2 forward sweep type_ssor = 3 backward sweep type_ssor = 0 forward and backward sweep
Definition at line 228 of file Relaxation_MatVect.cxx.
void Seldon::SorVector | ( | const Matrix< T0, Prop0, Storage0, Allocator0 > & | M, |
Vector< T2, Storage2, Allocator2 > & | Y, | ||
const Vector< T1, Storage1, Allocator1 > & | X, | ||
const T3 & | omega, | ||
int | iter, | ||
int | type_ssor | ||
) |
Solve M Y = X with S.O.R. method.
Solving M Y = X by using S.O.R algorithm. omega is the relaxation parameter, iter the number of iterations. type_ssor = 2 forward sweep type_ssor = 3 backward sweep type_ssor = 0 forward and backward sweep
Definition at line 1638 of file Functions_MatVect.cxx.
void Seldon::SorVector | ( | const SeldonTranspose & | transM, |
const Matrix< T0, Prop0, ArrayColComplexSparse, Allocator0 > & | A, | ||
Vector< complex< T2 >, Storage2, Allocator2 > & | X, | ||
const Vector< complex< T1 >, Storage1, Allocator1 > & | B, | ||
const T3 & | omega, | ||
int | iter, | ||
int | type_ssor | ||
) |
Successive overrelaxation.
Solving A X = B by using S.O.R algorithm. omega is the relaxation parameter, iter the number of iterations. type_ssor = 2 forward sweep type_ssor = 3 backward sweep type_ssor = 0 forward and backward sweep
Definition at line 3327 of file Functions_MatVectComplex.cxx.
void Seldon::SorVector | ( | const SeldonTranspose & | transM, |
const Matrix< T0, Prop0, ArrayColSymComplexSparse, Allocator0 > & | A, | ||
Vector< complex< T2 >, Storage2, Allocator2 > & | X, | ||
const Vector< complex< T1 >, Storage1, Allocator1 > & | B, | ||
const T3 & | omega, | ||
int | iter, | ||
int | type_ssor | ||
) |
Successive overrelaxation.
Solving A X = B by using S.O.R algorithm. omega is the relaxation parameter, iter the number of iterations. type_ssor = 2 forward sweep type_ssor = 3 backward sweep type_ssor = 0 forward and backward sweep
Definition at line 3883 of file Functions_MatVectComplex.cxx.
void Seldon::SorVector | ( | const SeldonTranspose & | transM, |
const Matrix< T0, Prop0, ArrayRowComplexSparse, Allocator0 > & | A, | ||
Vector< complex< T2 >, Storage2, Allocator2 > & | X, | ||
const Vector< complex< T1 >, Storage1, Allocator1 > & | B, | ||
const T3 & | omega, | ||
int | iter, | ||
int | type_ssor | ||
) |
Successive overrelaxation.
Solving A X = B by using S.O.R algorithm. omega is the relaxation parameter, iter the number of iterations. type_ssor = 2 forward sweep type_ssor = 3 backward sweep type_ssor = 0 forward and backward sweep
Definition at line 3626 of file Functions_MatVectComplex.cxx.
void Seldon::SorVector | ( | const SeldonTranspose & | transM, |
const Matrix< T0, Prop0, ArrayRowSymComplexSparse, Allocator0 > & | A, | ||
Vector< complex< T2 >, Storage2, Allocator2 > & | X, | ||
const Vector< complex< T1 >, Storage1, Allocator1 > & | B, | ||
const T3 & | omega, | ||
int | iter, | ||
int | type_ssor | ||
) |
Successive overrelaxation.
Solving A X = B by using S.O.R algorithm. omega is the relaxation parameter, iter the number of iterations. type_ssor = 2 forward sweep type_ssor = 3 backward sweep type_ssor = 0 forward and backward sweep
Definition at line 3841 of file Functions_MatVectComplex.cxx.
void Seldon::SorVector | ( | const SeldonTranspose & | transM, |
const Matrix< T0, Prop0, ColComplexSparse, Allocator0 > & | A, | ||
Vector< complex< T2 >, Storage2, Allocator2 > & | X, | ||
const Vector< complex< T1 >, Storage1, Allocator1 > & | B, | ||
const T3 & | omega, | ||
int | iter, | ||
int | type_ssor | ||
) |
Successive overrelaxation.
Solving A^T X = B by using S.O.R algorithm. omega is the relaxation parameter, iter the number of iterations. type_ssor = 2 forward sweep type_ssor = 3 backward sweep type_ssor = 0 forward and backward sweep
Definition at line 3224 of file Functions_MatVectComplex.cxx.
void Seldon::SorVector | ( | const SeldonTranspose & | transM, |
const Matrix< T0, Prop0, ColSymComplexSparse, Allocator0 > & | A, | ||
Vector< complex< T2 >, Storage2, Allocator2 > & | X, | ||
const Vector< complex< T1 >, Storage1, Allocator1 > & | B, | ||
const T3 & | omega, | ||
int | iter, | ||
int | type_ssor | ||
) |
Successive overrelaxation.
Solving A X = B by using S.O.R algorithm. omega is the relaxation parameter, iter the number of iterations. type_ssor = 2 forward sweep type_ssor = 3 backward sweep type_ssor = 0 forward and backward sweep
Definition at line 3862 of file Functions_MatVectComplex.cxx.
void Seldon::SorVector | ( | const SeldonTranspose & | transM, |
const Matrix< T0, Prop0, RowComplexSparse, Allocator0 > & | A, | ||
Vector< complex< T2 >, Storage2, Allocator2 > & | X, | ||
const Vector< complex< T1 >, Storage1, Allocator1 > & | B, | ||
const T3 & | omega, | ||
int | iter, | ||
int | type_ssor | ||
) |
Successive overrelaxation.
Solving A X = B by using S.O.R algorithm. omega is the relaxation parameter, iter the number of iterations. type_ssor = 2 forward sweep type_ssor = 3 backward sweep type_ssor = 0 forward and backward sweep
Definition at line 3424 of file Functions_MatVectComplex.cxx.
void Seldon::SorVector | ( | const SeldonTranspose & | transM, |
const Matrix< T0, Prop0, RowSymComplexSparse, Allocator0 > & | A, | ||
Vector< complex< T2 >, Storage2, Allocator2 > & | X, | ||
const Vector< complex< T1 >, Storage1, Allocator1 > & | B, | ||
const T3 & | omega, | ||
int | iter, | ||
int | type_ssor | ||
) |
Successive overrelaxation.
Solving A X = B by using S.O.R algorithm. omega is the relaxation parameter, iter the number of iterations. type_ssor = 2 forward sweep type_ssor = 3 backward sweep type_ssor = 0 forward and backward sweep
Definition at line 3820 of file Functions_MatVectComplex.cxx.
void Seldon::SorVector | ( | const SeldonTranspose & | transM, |
const Matrix< T0, Prop0, Storage0, Allocator0 > & | M, | ||
Vector< T2, Storage2, Allocator2 > & | Y, | ||
const Vector< T1, Storage1, Allocator1 > & | X, | ||
const T3 & | omega, | ||
int | iter, | ||
int | type_ssor | ||
) |
Solve M^T Y = X with S.O.R. method.
Solving M Y = X by using S.O.R algorithm. omega is the relaxation parameter, iter the number of iterations. type_ssor = 2 forward sweep type_ssor = 3 backward sweep type_ssor = 0 forward and backward sweep
Definition at line 1702 of file Functions_MatVect.cxx.
|
inline |
Solves a sparse linear system using LU factorization.
This function solves where is a matrix, and and are vectors.
[in] | M | the sparse matrix of the linear system, to be factorized in LU form by UMFPACK, SuperLU or Mumps. On exit, M is cleared. |
[in,out] | Y | on entry, the right-hand side ; on exit, the solution of the system. |
Definition at line 217 of file SparseDirectSolverInline.cxx.
int Seldon::Symmlq | ( | const Matrix1 & | A, |
Vector1 & | x, | ||
const Vector1 & | b, | ||
Preconditioner & | M, | ||
Iteration< Titer > & | iter | ||
) |
Solves a linear system by using Symmetric LQ (SymmLQ)
Solves the real symmetric linear system Ax = b with restarted Preconditioned Symmetric LQ Algorithm.
return value of 0 indicates convergence within the maximum number of iterations (determined by the iter object). return value of 1 indicates a failure to converge.
See C. PAIGE AND M. SAUNDERS, Solution of sparse indefinite systems of linear equations, SIAM J. Numer. Anal., 12 (1975), pp. 617-629.
[in] | A | Real Symmetric Matrix |
[in,out] | x | Vector on input it is the initial guess on output it is the solution |
[in] | b | Vector right hand side of the linear system |
[in] | M | Right preconditioner |
[in] | iter | Iteration parameters |
Definition at line 52 of file Symmlq.cxx.
int Seldon::TfQmr | ( | const Matrix1 & | A, |
Vector1 & | x, | ||
const Vector1 & | b, | ||
Preconditioner & | M, | ||
Iteration< Titer > & | iter | ||
) |
Solves a linear system by using Transpose Free Quasi-Minimal Residual.
Solves the unsymmetric linear system Ax = b using TFQMR.
return value of 0 indicates convergence within the maximum number of iterations (determined by the iter object). return value of 1 indicates a failure to converge.
See: R. W. Freund, A Transpose-Free Quasi-Minimal Residual algorithm for non-Hermitian linear system. SIAM J. on Sci. Comp. 14(1993), pp. 470-482
|
inline |
Converts string to most types, specially numbers.
[in] | s | string to be converted. |
Definition at line 165 of file CommonInline.cxx.
|
inline |
Converts string to most types, specially numbers.
[in] | s | string to be converted. |
[out] | num | s converted to 'T'. |
Definition at line 152 of file CommonInline.cxx.
|
inline |
Converts most types to string.
input | variable to be converted. |
Definition at line 137 of file CommonInline.cxx.
void Seldon::WriteCoordinateMatrix | ( | const Matrix< T0, Prop0, Storage0, Alloc0 > & | A, |
ostream & | FileStream, | ||
T & | zero, | ||
int | index, | ||
bool | cplx | ||
) |
Writes matrix in coordinate format.
A | output matrix |
FileStream | stream where the matrix is read |
zero | type of value to read (double or complex<double>) |
index | starting index (usually 0 or 1) |
cplx | if true, imaginary and real part are in two separate columns |
Definition at line 253 of file IOMatrixMarket.cxx.
void Seldon::WriteCoordinateMatrix | ( | ostream & | FileStream, |
const Vector< Tint, VectFull, AllocInt > & | row_numbers, | ||
const Vector< Tint, VectFull, AllocInt > & | col_numbers, | ||
const Vector< T, VectFull, Allocator > & | values, | ||
bool | cplx | ||
) |
Writes a matrix in coordinate format.
FileStream | stream where the matrix is read |
row_numbers | row indices |
col_numbers | column indices |
values | |
cplx | if true, imaginary and real part are written in two separate columns |
Definition at line 219 of file IOMatrixMarket.cxx.