MOOCHO (Single Doxygen Collection)  Version of the Day
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Groups Pages
Typedefs | Enumerations | Functions
BLAS_Cpp Namespace Reference

Typedefs

typedef FortranTypes::f_int f_int
 
typedef FortranTypes::f_real f_real
 
typedef FortranTypes::f_dbl_prec f_dbl_prec
 
typedef size_t size_type
 Size type. More...
 

Enumerations

enum  Side { left, right }
 SIDE. More...
 
enum  Transp { no_trans, trans, conj_trans }
 TRANS. More...
 
enum  Uplo { upper, lower }
 UPLO. More...
 
enum  Diag { unit, nonunit }
 DIAG. More...
 

Functions

Uplo operator! (Uplo uplo)
 Return the opposite of Uplo argument. More...
 
Transp bool_to_trans (bool return_trans)
 Return Transp given a bool. More...
 
bool trans_to_bool (Transp _trans)
 Returns true if _trans == trans. More...
 
Transp operator! (Transp _trans)
 Return the opposite of the transpose argument. More...
 
Transp trans_not (Transp _trans)
 Return the opposite of the transpose argument. More...
 
Transp trans_trans (Transp _trans1, Transp _trans2)
 Return the transpose of the transpose argument. More...
 
const char * trans_to_string (Transp _trans)
 Give a string name to Transp value. More...
 
size_type rows (size_type rows, size_type cols, BLAS_Cpp::Transp _trans)
 Return rows of a possible transposed matrix. More...
 
size_type cols (size_type rows, size_type cols, BLAS_Cpp::Transp _trans)
 Return columns of a possible transposed matrix. More...
 
const char SideChar [] = {'L' , 'R' }
 
const char TransChar [] = {'N' , 'T' , 'C' }
 
const char UploChar [] = {'U' , 'L' }
 
const char DiagChar [] = {'U' , 'N' }
 
void rotg (f_dbl_prec *a, f_dbl_prec *b, f_dbl_prec *c, f_dbl_prec *s)
 
void rot (const f_int &N, f_dbl_prec *X, const f_int &INCX, f_dbl_prec *Y, const f_int &INCY, const f_dbl_prec &C, const f_dbl_prec &S)
 
void swap (const f_int &N, f_dbl_prec *X, const f_int &INCX, f_dbl_prec *Y, const f_int &INCY)
 
void scal (const f_int &N, const f_dbl_prec &ALPHA, f_dbl_prec *X, const f_int &INCX)
 
void copy (const f_int &N, const f_dbl_prec *X, const f_int &INCX, f_dbl_prec *Y, const f_int &INCY)
 
void axpy (const f_int &N, const f_dbl_prec &A, const f_dbl_prec *X, const f_int &INCX, f_dbl_prec *Y, const f_int &INCY)
 
f_dbl_prec dot (const f_int &N, const f_dbl_prec *X, const f_int &INCX, const f_dbl_prec *Y, const f_int &INCY)
 
f_dbl_prec nrm2 (const f_int &N, const f_dbl_prec *X, const f_int &INCX)
 
f_dbl_prec asum (const f_int &N, const f_dbl_prec *X, const f_int &INCX)
 
f_dbl_prec iamax (const f_int &N, const f_dbl_prec *X, const f_int &INCX)
 
void gemv (Transp transa, f_int m, f_int n, f_dbl_prec alpha, const f_dbl_prec *pa, f_int lda, const f_dbl_prec *x, f_int incx, f_dbl_prec beta, f_dbl_prec *py, f_int incy)
 
void gbmv (Transp transa, f_int m, f_int n, f_int kl, f_int ku, f_dbl_prec alpha, const f_dbl_prec *pa, f_int lda, const f_dbl_prec *x, f_int incx, f_dbl_prec beta, f_dbl_prec *py, f_int incy)
 
void symv (Uplo uplo, f_int n, f_dbl_prec alpha, const f_dbl_prec *pa, f_int lda, const f_dbl_prec *x, f_int incx, f_dbl_prec beta, f_dbl_prec *py, f_int incy)
 
void sbmv (Uplo uplo, f_int n, f_int k, f_dbl_prec alpha, const f_dbl_prec *pa, f_int lda, const f_dbl_prec *x, f_int incx, f_dbl_prec beta, f_dbl_prec *py, f_int incy)
 
void spmv (Uplo uplo, f_int n, f_dbl_prec alpha, const f_dbl_prec *pap, const f_dbl_prec *x, f_int incx, f_dbl_prec beta, f_dbl_prec *py, f_int incy)
 
void trmv (Uplo uplo, Transp trans, Diag diag, f_int n, const f_dbl_prec *pa, f_int lda, f_dbl_prec *px, f_int incx)
 
void tbmv (Uplo uplo, Transp trans, Diag diag, f_int n, f_int k, const f_dbl_prec *pa, f_int lda, f_dbl_prec *px, f_int incx)
 
void tpmv (Uplo uplo, Transp trans, Diag diag, f_int n, const f_dbl_prec *pap, f_dbl_prec *px, f_int incx)
 
void trsv (Uplo uplo, Transp trans, Diag diag, f_int n, const f_dbl_prec *pa, f_int lda, f_dbl_prec *px, f_int incx)
 
void tbsv (Uplo uplo, Transp trans, Diag diag, f_int n, f_int k, const f_dbl_prec *pa, f_int lda, f_dbl_prec *px, f_int incx)
 
void tpsv (Uplo uplo, Transp trans, Diag diag, f_int n, const f_dbl_prec *pap, f_dbl_prec *px, f_int incx)
 
void ger (f_int m, f_int n, f_dbl_prec alpha, const f_dbl_prec *px, f_int incx, const f_dbl_prec *py, f_int incy, f_dbl_prec *pa, f_int lda)
 
void syr (Uplo uplo, f_int n, f_dbl_prec alpha, const f_dbl_prec *px, f_int incx, f_dbl_prec *pa, f_int lda)
 
void spr (Uplo uplo, f_int n, f_dbl_prec alpha, const f_dbl_prec *px, f_int incx, f_dbl_prec *pap)
 
void syr2 (Uplo uplo, f_int n, f_dbl_prec alpha, const f_dbl_prec *px, f_int incx, const f_dbl_prec *py, f_int incy, f_dbl_prec *pa, f_int lda)
 
void spr2 (Uplo uplo, f_int n, f_dbl_prec alpha, const f_dbl_prec *px, f_int incx, const f_dbl_prec *py, f_int incy, f_dbl_prec *pap)
 
void gemm (Transp transa, Transp transb, f_int m, f_int n, f_int k, f_dbl_prec alpha, const f_dbl_prec *pa, f_int lda, const f_dbl_prec *pb, f_int ldb, f_dbl_prec beta, f_dbl_prec *pc, f_int ldc)
 
void symm (Side side, Uplo uplo, f_int m, f_int n, f_dbl_prec alpha, const f_dbl_prec *pa, f_int lda, const f_dbl_prec *pb, f_int ldb, f_dbl_prec beta, f_dbl_prec *pc, f_int ldc)
 
void syrk (Uplo uplo, Transp trans, f_int n, f_int k, f_dbl_prec alpha, const f_dbl_prec *pa, f_int lda, f_dbl_prec beta, f_dbl_prec *pc, f_int ldc)
 
void syr2k (Uplo uplo, Transp trans, f_int n, f_int k, f_dbl_prec alpha, const f_dbl_prec *pa, f_int lda, const f_dbl_prec *pb, f_int ldb, f_dbl_prec beta, f_dbl_prec *pc, f_int ldc)
 
void trmm (Side side, Uplo uplo, Transp transa, Diag diag, f_int m, f_int n, f_dbl_prec alpha, const f_dbl_prec *pa, f_int lda, f_dbl_prec *pb, f_int ldb)
 
void trsm (Side side, Uplo uplo, Transp transa, Diag diag, f_int m, f_int n, f_dbl_prec alpha, const f_dbl_prec *pa, f_int lda, f_dbl_prec *pb, f_int ldb)
 

Typedef Documentation

typedef FortranTypes::f_int BLAS_Cpp::f_int

Definition at line 54 of file DenseLinAlgPack_BLAS_Cpp.hpp.

typedef FortranTypes::f_real BLAS_Cpp::f_real

Definition at line 55 of file DenseLinAlgPack_BLAS_Cpp.hpp.

typedef FortranTypes::f_dbl_prec BLAS_Cpp::f_dbl_prec

Definition at line 56 of file DenseLinAlgPack_BLAS_Cpp.hpp.

Function Documentation

void BLAS_Cpp::rotg ( f_dbl_prec *  a,
f_dbl_prec *  b,
f_dbl_prec *  c,
f_dbl_prec *  s 
)

Definition at line 260 of file DenseLinAlgPack_BLAS_Cpp.cpp.

void BLAS_Cpp::rot ( const f_int &  N,
f_dbl_prec *  X,
const f_int &  INCX,
f_dbl_prec *  Y,
const f_int &  INCY,
const f_dbl_prec &  C,
const f_dbl_prec &  S 
)

Definition at line 266 of file DenseLinAlgPack_BLAS_Cpp.cpp.

void BLAS_Cpp::swap ( const f_int &  N,
f_dbl_prec *  X,
const f_int &  INCX,
f_dbl_prec *  Y,
const f_int &  INCY 
)

Definition at line 274 of file DenseLinAlgPack_BLAS_Cpp.cpp.

void BLAS_Cpp::scal ( const f_int &  N,
const f_dbl_prec &  ALPHA,
f_dbl_prec *  X,
const f_int &  INCX 
)

Definition at line 281 of file DenseLinAlgPack_BLAS_Cpp.cpp.

void BLAS_Cpp::copy ( const f_int &  N,
const f_dbl_prec *  X,
const f_int &  INCX,
f_dbl_prec *  Y,
const f_int &  INCY 
)

Definition at line 288 of file DenseLinAlgPack_BLAS_Cpp.cpp.

void BLAS_Cpp::axpy ( const f_int &  N,
const f_dbl_prec &  A,
const f_dbl_prec *  X,
const f_int &  INCX,
f_dbl_prec *  Y,
const f_int &  INCY 
)

Definition at line 295 of file DenseLinAlgPack_BLAS_Cpp.cpp.

BLAS_Cpp::f_dbl_prec BLAS_Cpp::dot ( const f_int &  N,
const f_dbl_prec *  X,
const f_int &  INCX,
const f_dbl_prec *  Y,
const f_int &  INCY 
)

Definition at line 303 of file DenseLinAlgPack_BLAS_Cpp.cpp.

BLAS_Cpp::f_dbl_prec BLAS_Cpp::nrm2 ( const f_int &  N,
const f_dbl_prec *  X,
const f_int &  INCX 
)

Definition at line 310 of file DenseLinAlgPack_BLAS_Cpp.cpp.

BLAS_Cpp::f_dbl_prec BLAS_Cpp::asum ( const f_int &  N,
const f_dbl_prec *  X,
const f_int &  INCX 
)

Definition at line 317 of file DenseLinAlgPack_BLAS_Cpp.cpp.

BLAS_Cpp::f_dbl_prec BLAS_Cpp::iamax ( const f_int &  N,
const f_dbl_prec *  X,
const f_int &  INCX 
)

Definition at line 324 of file DenseLinAlgPack_BLAS_Cpp.cpp.

void BLAS_Cpp::gemv ( Transp  transa,
f_int  m,
f_int  n,
f_dbl_prec  alpha,
const f_dbl_prec *  pa,
f_int  lda,
const f_dbl_prec *  x,
f_int  incx,
f_dbl_prec  beta,
f_dbl_prec *  py,
f_int  incy 
)

Definition at line 333 of file DenseLinAlgPack_BLAS_Cpp.cpp.

void BLAS_Cpp::gbmv ( Transp  transa,
f_int  m,
f_int  n,
f_int  kl,
f_int  ku,
f_dbl_prec  alpha,
const f_dbl_prec *  pa,
f_int  lda,
const f_dbl_prec *  x,
f_int  incx,
f_dbl_prec  beta,
f_dbl_prec *  py,
f_int  incy 
)

Definition at line 341 of file DenseLinAlgPack_BLAS_Cpp.cpp.

void BLAS_Cpp::symv ( Uplo  uplo,
f_int  n,
f_dbl_prec  alpha,
const f_dbl_prec *  pa,
f_int  lda,
const f_dbl_prec *  x,
f_int  incx,
f_dbl_prec  beta,
f_dbl_prec *  py,
f_int  incy 
)

Definition at line 355 of file DenseLinAlgPack_BLAS_Cpp.cpp.

void BLAS_Cpp::sbmv ( Uplo  uplo,
f_int  n,
f_int  k,
f_dbl_prec  alpha,
const f_dbl_prec *  pa,
f_int  lda,
const f_dbl_prec *  x,
f_int  incx,
f_dbl_prec  beta,
f_dbl_prec *  py,
f_int  incy 
)

Definition at line 363 of file DenseLinAlgPack_BLAS_Cpp.cpp.

void BLAS_Cpp::spmv ( Uplo  uplo,
f_int  n,
f_dbl_prec  alpha,
const f_dbl_prec *  pap,
const f_dbl_prec *  x,
f_int  incx,
f_dbl_prec  beta,
f_dbl_prec *  py,
f_int  incy 
)

Definition at line 371 of file DenseLinAlgPack_BLAS_Cpp.cpp.

void BLAS_Cpp::trmv ( Uplo  uplo,
Transp  trans,
Diag  diag,
f_int  n,
const f_dbl_prec *  pa,
f_int  lda,
f_dbl_prec *  px,
f_int  incx 
)

Definition at line 379 of file DenseLinAlgPack_BLAS_Cpp.cpp.

void BLAS_Cpp::tbmv ( Uplo  uplo,
Transp  trans,
Diag  diag,
f_int  n,
f_int  k,
const f_dbl_prec *  pa,
f_int  lda,
f_dbl_prec *  px,
f_int  incx 
)

Definition at line 389 of file DenseLinAlgPack_BLAS_Cpp.cpp.

void BLAS_Cpp::tpmv ( Uplo  uplo,
Transp  trans,
Diag  diag,
f_int  n,
const f_dbl_prec *  pap,
f_dbl_prec *  px,
f_int  incx 
)

Definition at line 399 of file DenseLinAlgPack_BLAS_Cpp.cpp.

void BLAS_Cpp::trsv ( Uplo  uplo,
Transp  trans,
Diag  diag,
f_int  n,
const f_dbl_prec *  pa,
f_int  lda,
f_dbl_prec *  px,
f_int  incx 
)

Definition at line 409 of file DenseLinAlgPack_BLAS_Cpp.cpp.

void BLAS_Cpp::tbsv ( Uplo  uplo,
Transp  trans,
Diag  diag,
f_int  n,
f_int  k,
const f_dbl_prec *  pa,
f_int  lda,
f_dbl_prec *  px,
f_int  incx 
)

Definition at line 419 of file DenseLinAlgPack_BLAS_Cpp.cpp.

void BLAS_Cpp::tpsv ( Uplo  uplo,
Transp  trans,
Diag  diag,
f_int  n,
const f_dbl_prec *  pap,
f_dbl_prec *  px,
f_int  incx 
)

Definition at line 429 of file DenseLinAlgPack_BLAS_Cpp.cpp.

void BLAS_Cpp::ger ( f_int  m,
f_int  n,
f_dbl_prec  alpha,
const f_dbl_prec *  px,
f_int  incx,
const f_dbl_prec *  py,
f_int  incy,
f_dbl_prec *  pa,
f_int  lda 
)

Definition at line 439 of file DenseLinAlgPack_BLAS_Cpp.cpp.

void BLAS_Cpp::syr ( Uplo  uplo,
f_int  n,
f_dbl_prec  alpha,
const f_dbl_prec *  px,
f_int  incx,
f_dbl_prec *  pa,
f_int  lda 
)

Definition at line 455 of file DenseLinAlgPack_BLAS_Cpp.cpp.

void BLAS_Cpp::spr ( Uplo  uplo,
f_int  n,
f_dbl_prec  alpha,
const f_dbl_prec *  px,
f_int  incx,
f_dbl_prec *  pap 
)

Definition at line 463 of file DenseLinAlgPack_BLAS_Cpp.cpp.

void BLAS_Cpp::syr2 ( Uplo  uplo,
f_int  n,
f_dbl_prec  alpha,
const f_dbl_prec *  px,
f_int  incx,
const f_dbl_prec *  py,
f_int  incy,
f_dbl_prec *  pa,
f_int  lda 
)

Definition at line 471 of file DenseLinAlgPack_BLAS_Cpp.cpp.

void BLAS_Cpp::spr2 ( Uplo  uplo,
f_int  n,
f_dbl_prec  alpha,
const f_dbl_prec *  px,
f_int  incx,
const f_dbl_prec *  py,
f_int  incy,
f_dbl_prec *  pap 
)

Definition at line 479 of file DenseLinAlgPack_BLAS_Cpp.cpp.

void BLAS_Cpp::gemm ( Transp  transa,
Transp  transb,
f_int  m,
f_int  n,
f_int  k,
f_dbl_prec  alpha,
const f_dbl_prec *  pa,
f_int  lda,
const f_dbl_prec *  pb,
f_int  ldb,
f_dbl_prec  beta,
f_dbl_prec *  pc,
f_int  ldc 
)

Definition at line 489 of file DenseLinAlgPack_BLAS_Cpp.cpp.

void BLAS_Cpp::symm ( Side  side,
Uplo  uplo,
f_int  m,
f_int  n,
f_dbl_prec  alpha,
const f_dbl_prec *  pa,
f_int  lda,
const f_dbl_prec *  pb,
f_int  ldb,
f_dbl_prec  beta,
f_dbl_prec *  pc,
f_int  ldc 
)

Definition at line 499 of file DenseLinAlgPack_BLAS_Cpp.cpp.

void BLAS_Cpp::syrk ( Uplo  uplo,
Transp  trans,
f_int  n,
f_int  k,
f_dbl_prec  alpha,
const f_dbl_prec *  pa,
f_int  lda,
f_dbl_prec  beta,
f_dbl_prec *  pc,
f_int  ldc 
)

Definition at line 509 of file DenseLinAlgPack_BLAS_Cpp.cpp.

void BLAS_Cpp::syr2k ( Uplo  uplo,
Transp  trans,
f_int  n,
f_int  k,
f_dbl_prec  alpha,
const f_dbl_prec *  pa,
f_int  lda,
const f_dbl_prec *  pb,
f_int  ldb,
f_dbl_prec  beta,
f_dbl_prec *  pc,
f_int  ldc 
)

Definition at line 520 of file DenseLinAlgPack_BLAS_Cpp.cpp.

void BLAS_Cpp::trmm ( Side  side,
Uplo  uplo,
Transp  transa,
Diag  diag,
f_int  m,
f_int  n,
f_dbl_prec  alpha,
const f_dbl_prec *  pa,
f_int  lda,
f_dbl_prec *  pb,
f_int  ldb 
)

Definition at line 532 of file DenseLinAlgPack_BLAS_Cpp.cpp.

void BLAS_Cpp::trsm ( Side  side,
Uplo  uplo,
Transp  transa,
Diag  diag,
f_int  m,
f_int  n,
f_dbl_prec  alpha,
const f_dbl_prec *  pa,
f_int  lda,
f_dbl_prec *  pb,
f_int  ldb 
)

Definition at line 542 of file DenseLinAlgPack_BLAS_Cpp.cpp.

Variable Documentation

const char BLAS_Cpp::SideChar[] = {'L' , 'R' }

Definition at line 66 of file DenseLinAlgPack_BLAS_Cpp.hpp.

const char BLAS_Cpp::TransChar[] = {'N' , 'T' , 'C' }

Definition at line 68 of file DenseLinAlgPack_BLAS_Cpp.hpp.

const char BLAS_Cpp::UploChar[] = {'U' , 'L' }

Definition at line 70 of file DenseLinAlgPack_BLAS_Cpp.hpp.

const char BLAS_Cpp::DiagChar[] = {'U' , 'N' }

Definition at line 72 of file DenseLinAlgPack_BLAS_Cpp.hpp.