Teuchos Package Browser (Single Doxygen Collection)  Version of the Day
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Groups Pages
Macros | Functions
Teuchos_BLAS_wrappers.hpp File Reference

The Templated BLAS wrappers. More...

#include "Teuchos_ConfigDefs.hpp"
Include dependency graph for Teuchos_BLAS_wrappers.hpp:
This graph shows which files directly or indirectly include this file:

Go to the source code of this file.

Macros

#define PREFIX
 
#define Teuchos_fcd   const char *
 
#define Teuchos_Complex_double_type_name   double _Complex
 
#define Teuchos_Complex_float_type_name   float _Complex
 
#define DROTG_F77   F77_BLAS_MANGLE(drotg,DROTG)
 
#define DROT_F77   F77_BLAS_MANGLE(drot,DROT)
 
#define DASUM_F77   F77_BLAS_MANGLE(dasum,DASUM)
 
#define DAXPY_F77   F77_BLAS_MANGLE(daxpy,DAXPY)
 
#define DCOPY_F77   F77_BLAS_MANGLE(dcopy,DCOPY)
 
#define DDOT_F77   F77_BLAS_MANGLE(ddot,DDOT)
 
#define DNRM2_F77   F77_BLAS_MANGLE(dnrm2,DNRM2)
 
#define DSCAL_F77   F77_BLAS_MANGLE(dscal,DSCAL)
 
#define IDAMAX_F77   F77_BLAS_MANGLE(idamax,IDAMAX)
 
#define DGEMV_F77   F77_BLAS_MANGLE(dgemv,DGEMV)
 
#define DGER_F77   F77_BLAS_MANGLE(dger,DGER)
 
#define DTRMV_F77   F77_BLAS_MANGLE(dtrmv,DTRMV)
 
#define DGEMM_F77   F77_BLAS_MANGLE(dgemm,DGEMM)
 
#define DSWAP_F77   F77_BLAS_MANGLE(dswap,DSWAP)
 
#define DSYMM_F77   F77_BLAS_MANGLE(dsymm,DSYMM)
 
#define DSYRK_F77   F77_BLAS_MANGLE(dsyrk,DSYRK)
 
#define DTRMM_F77   F77_BLAS_MANGLE(dtrmm,DTRMM)
 
#define DTRSM_F77   F77_BLAS_MANGLE(dtrsm,DTRSM)
 
#define SROTG_F77   F77_BLAS_MANGLE(srotg,SROTG)
 
#define SROT_F77   F77_BLAS_MANGLE(srot,SROT)
 
#define SSCAL_F77   F77_BLAS_MANGLE(sscal,SSCAL)
 
#define SCOPY_F77   F77_BLAS_MANGLE(scopy,SCOPY)
 
#define SAXPY_F77   F77_BLAS_MANGLE(saxpy,SAXPY)
 
#define SDOT_F77   F77_BLAS_MANGLE(sdot,SDOT)
 
#define SNRM2_F77   F77_BLAS_MANGLE(snrm2,SNRM2)
 
#define SASUM_F77   F77_BLAS_MANGLE(sasum,SASUM)
 
#define ISAMAX_F77   F77_BLAS_MANGLE(isamax,ISAMAX)
 
#define SGEMV_F77   F77_BLAS_MANGLE(sgemv,SGEMV)
 
#define SGER_F77   F77_BLAS_MANGLE(sger,SGER)
 
#define STRMV_F77   F77_BLAS_MANGLE(strmv,STRMV)
 
#define SGEMM_F77   F77_BLAS_MANGLE(sgemm,SGEMM)
 
#define SSWAP_F77   F77_BLAS_MANGLE(sswap,SSWAP)
 
#define SSYMM_F77   F77_BLAS_MANGLE(ssymm,SSYMM)
 
#define SSYRK_F77   F77_BLAS_MANGLE(ssyrk,SSYRK)
 
#define STRMM_F77   F77_BLAS_MANGLE(strmm,STRMM)
 
#define STRSM_F77   F77_BLAS_MANGLE(strsm,STRSM)
 

Functions

void PREFIX DROTG_F77 (double *da, double *db, double *c, double *s)
 
void PREFIX DROT_F77 (const int *n, double *dx, const int *incx, double *dy, const int *incy, double *c, double *s)
 
double PREFIX DASUM_F77 (const int *n, const double x[], const int *incx)
 
void PREFIX DAXPY_F77 (const int *n, const double *alpha, const double x[], const int *incx, double y[], const int *incy)
 
void PREFIX DCOPY_F77 (const int *n, const double *x, const int *incx, double *y, const int *incy)
 
double PREFIX DDOT_F77 (const int *n, const double x[], const int *incx, const double y[], const int *incy)
 
double PREFIX DNRM2_F77 (const int *n, const double x[], const int *incx)
 
void PREFIX DSCAL_F77 (const int *n, const double *alpha, double *x, const int *incx)
 
void PREFIX DSWAP_F77 (const int *const n, double *const x, const int *const incx, double *const y, const int *const incy)
 
int PREFIX IDAMAX_F77 (const int *n, const double *x, const int *incx)
 
void PREFIX SROTG_F77 (float *da, float *db, float *c, float *s)
 
void PREFIX SROT_F77 (const int *n, float *dx, const int *incx, float *dy, const int *incy, float *c, float *s)
 
void PREFIX SAXPY_F77 (const int *n, const float *alpha, const float x[], const int *incx, float y[], const int *incy)
 
void PREFIX SCOPY_F77 (const int *n, const float *x, const int *incx, float *y, const int *incy)
 
void PREFIX SSCAL_F77 (const int *n, const float *alpha, float *x, const int *incx)
 
void PREFIX SSWAP_F77 (const int *const n, float *const x, const int *const incx, float *const y, const int *const incy)
 
int PREFIX ISAMAX_F77 (const int *n, const float *x, const int *incx)
 
void PREFIX DGEMV_F77 (Teuchos_fcd, const int *m, const int *n, const double *alpha, const double A[], const int *lda, const double x[], const int *incx, const double *beta, double y[], const int *incy)
 
void PREFIX DTRMV_F77 (Teuchos_fcd, Teuchos_fcd, Teuchos_fcd, const int *n, const double *a, const int *lda, double *x, const int *incx)
 
void PREFIX DGER_F77 (const int *m, const int *n, const double *alpha, const double *x, const int *incx, const double *y, const int *incy, double *a, const int *lda)
 
void PREFIX SGEMV_F77 (Teuchos_fcd, const int *m, const int *n, const float *alpha, const float A[], const int *lda, const float x[], const int *incx, const float *beta, float y[], const int *incy)
 
void PREFIX STRMV_F77 (Teuchos_fcd, Teuchos_fcd, Teuchos_fcd, const int *n, const float *a, const int *lda, float *x, const int *incx)
 
void PREFIX SGER_F77 (const int *m, const int *n, const float *alpha, const float *x, const int *incx, const float *y, const int *incy, float *a, const int *lda)
 
void PREFIX DGEMM_F77 (Teuchos_fcd, Teuchos_fcd, const int *m, const int *n, const int *k, const double *alpha, const double *a, const int *lda, const double *b, const int *ldb, const double *beta, double *c, const int *ldc)
 
void PREFIX DSYMM_F77 (Teuchos_fcd, Teuchos_fcd, const int *m, const int *n, const double *alpha, const double *a, const int *lda, const double *b, const int *ldb, const double *beta, double *c, const int *ldc)
 
void PREFIX DSYRK_F77 (Teuchos_fcd, Teuchos_fcd, const int *n, const int *k, const double *alpha, const double *a, const int *lda, const double *beta, double *c, const int *ldc)
 
void PREFIX DTRMM_F77 (Teuchos_fcd, Teuchos_fcd, Teuchos_fcd, Teuchos_fcd, const int *m, const int *n, const double *alpha, const double *a, const int *lda, double *b, const int *ldb)
 
void PREFIX DTRSM_F77 (Teuchos_fcd, Teuchos_fcd, Teuchos_fcd, Teuchos_fcd, const int *m, const int *n, const double *alpha, const double *a, const int *lda, double *b, const int *ldb)
 
void PREFIX SGEMM_F77 (Teuchos_fcd, Teuchos_fcd, const int *m, const int *n, const int *k, const float *alpha, const float *a, const int *lda, const float *b, const int *ldb, const float *beta, float *c, const int *ldc)
 
void PREFIX SSYMM_F77 (Teuchos_fcd, Teuchos_fcd, const int *m, const int *n, const float *alpha, const float *a, const int *lda, const float *b, const int *ldb, const float *beta, float *c, const int *ldc)
 
void PREFIX SSYRK_F77 (Teuchos_fcd, Teuchos_fcd, const int *n, const int *k, const float *alpha, const float *a, const int *lda, const float *beta, float *c, const int *ldc)
 
void PREFIX STRMM_F77 (Teuchos_fcd, Teuchos_fcd, Teuchos_fcd, Teuchos_fcd, const int *m, const int *n, const float *alpha, const float *a, const int *lda, float *b, const int *ldb)
 
void PREFIX STRSM_F77 (Teuchos_fcd, Teuchos_fcd, Teuchos_fcd, Teuchos_fcd, const int *m, const int *n, const float *alpha, const float *a, const int *lda, float *b, const int *ldb)
 

Detailed Description

The Templated BLAS wrappers.

Definition in file Teuchos_BLAS_wrappers.hpp.

Macro Definition Documentation

#define PREFIX

Definition at line 67 of file Teuchos_BLAS_wrappers.hpp.

#define Teuchos_fcd   const char *

Definition at line 68 of file Teuchos_BLAS_wrappers.hpp.

#define Teuchos_Complex_double_type_name   double _Complex

Definition at line 78 of file Teuchos_BLAS_wrappers.hpp.

#define Teuchos_Complex_float_type_name   float _Complex

Definition at line 79 of file Teuchos_BLAS_wrappers.hpp.

#define DROTG_F77   F77_BLAS_MANGLE(drotg,DROTG)

Definition at line 86 of file Teuchos_BLAS_wrappers.hpp.

#define DROT_F77   F77_BLAS_MANGLE(drot,DROT)

Definition at line 87 of file Teuchos_BLAS_wrappers.hpp.

#define DASUM_F77   F77_BLAS_MANGLE(dasum,DASUM)

Definition at line 88 of file Teuchos_BLAS_wrappers.hpp.

#define DAXPY_F77   F77_BLAS_MANGLE(daxpy,DAXPY)

Definition at line 89 of file Teuchos_BLAS_wrappers.hpp.

#define DCOPY_F77   F77_BLAS_MANGLE(dcopy,DCOPY)

Definition at line 90 of file Teuchos_BLAS_wrappers.hpp.

#define DDOT_F77   F77_BLAS_MANGLE(ddot,DDOT)

Definition at line 91 of file Teuchos_BLAS_wrappers.hpp.

#define DNRM2_F77   F77_BLAS_MANGLE(dnrm2,DNRM2)

Definition at line 92 of file Teuchos_BLAS_wrappers.hpp.

#define DSCAL_F77   F77_BLAS_MANGLE(dscal,DSCAL)

Definition at line 93 of file Teuchos_BLAS_wrappers.hpp.

#define IDAMAX_F77   F77_BLAS_MANGLE(idamax,IDAMAX)

Definition at line 94 of file Teuchos_BLAS_wrappers.hpp.

#define DGEMV_F77   F77_BLAS_MANGLE(dgemv,DGEMV)

Definition at line 95 of file Teuchos_BLAS_wrappers.hpp.

#define DGER_F77   F77_BLAS_MANGLE(dger,DGER)

Definition at line 96 of file Teuchos_BLAS_wrappers.hpp.

#define DTRMV_F77   F77_BLAS_MANGLE(dtrmv,DTRMV)

Definition at line 97 of file Teuchos_BLAS_wrappers.hpp.

#define DGEMM_F77   F77_BLAS_MANGLE(dgemm,DGEMM)

Definition at line 98 of file Teuchos_BLAS_wrappers.hpp.

#define DSWAP_F77   F77_BLAS_MANGLE(dswap,DSWAP)

Definition at line 99 of file Teuchos_BLAS_wrappers.hpp.

#define DSYMM_F77   F77_BLAS_MANGLE(dsymm,DSYMM)

Definition at line 100 of file Teuchos_BLAS_wrappers.hpp.

#define DSYRK_F77   F77_BLAS_MANGLE(dsyrk,DSYRK)

Definition at line 101 of file Teuchos_BLAS_wrappers.hpp.

#define DTRMM_F77   F77_BLAS_MANGLE(dtrmm,DTRMM)

Definition at line 102 of file Teuchos_BLAS_wrappers.hpp.

#define DTRSM_F77   F77_BLAS_MANGLE(dtrsm,DTRSM)

Definition at line 103 of file Teuchos_BLAS_wrappers.hpp.

#define SROTG_F77   F77_BLAS_MANGLE(srotg,SROTG)

Definition at line 129 of file Teuchos_BLAS_wrappers.hpp.

#define SROT_F77   F77_BLAS_MANGLE(srot,SROT)

Definition at line 130 of file Teuchos_BLAS_wrappers.hpp.

#define SSCAL_F77   F77_BLAS_MANGLE(sscal,SSCAL)

Definition at line 131 of file Teuchos_BLAS_wrappers.hpp.

#define SCOPY_F77   F77_BLAS_MANGLE(scopy,SCOPY)

Definition at line 132 of file Teuchos_BLAS_wrappers.hpp.

#define SAXPY_F77   F77_BLAS_MANGLE(saxpy,SAXPY)

Definition at line 133 of file Teuchos_BLAS_wrappers.hpp.

#define SDOT_F77   F77_BLAS_MANGLE(sdot,SDOT)

Definition at line 134 of file Teuchos_BLAS_wrappers.hpp.

#define SNRM2_F77   F77_BLAS_MANGLE(snrm2,SNRM2)

Definition at line 135 of file Teuchos_BLAS_wrappers.hpp.

#define SASUM_F77   F77_BLAS_MANGLE(sasum,SASUM)

Definition at line 136 of file Teuchos_BLAS_wrappers.hpp.

#define ISAMAX_F77   F77_BLAS_MANGLE(isamax,ISAMAX)

Definition at line 137 of file Teuchos_BLAS_wrappers.hpp.

#define SGEMV_F77   F77_BLAS_MANGLE(sgemv,SGEMV)

Definition at line 138 of file Teuchos_BLAS_wrappers.hpp.

#define SGER_F77   F77_BLAS_MANGLE(sger,SGER)

Definition at line 139 of file Teuchos_BLAS_wrappers.hpp.

#define STRMV_F77   F77_BLAS_MANGLE(strmv,STRMV)

Definition at line 140 of file Teuchos_BLAS_wrappers.hpp.

#define SGEMM_F77   F77_BLAS_MANGLE(sgemm,SGEMM)

Definition at line 141 of file Teuchos_BLAS_wrappers.hpp.

#define SSWAP_F77   F77_BLAS_MANGLE(sswap,SSWAP)

Definition at line 142 of file Teuchos_BLAS_wrappers.hpp.

#define SSYMM_F77   F77_BLAS_MANGLE(ssymm,SSYMM)

Definition at line 143 of file Teuchos_BLAS_wrappers.hpp.

#define SSYRK_F77   F77_BLAS_MANGLE(ssyrk,SSYRK)

Definition at line 144 of file Teuchos_BLAS_wrappers.hpp.

#define STRMM_F77   F77_BLAS_MANGLE(strmm,STRMM)

Definition at line 145 of file Teuchos_BLAS_wrappers.hpp.

#define STRSM_F77   F77_BLAS_MANGLE(strsm,STRSM)

Definition at line 146 of file Teuchos_BLAS_wrappers.hpp.

Function Documentation

void PREFIX DROTG_F77 ( double *  da,
double *  db,
double *  c,
double *  s 
)
void PREFIX DROT_F77 ( const int *  n,
double *  dx,
const int *  incx,
double *  dy,
const int *  incy,
double *  c,
double *  s 
)
double PREFIX DASUM_F77 ( const int *  n,
const double  x[],
const int *  incx 
)
void PREFIX DAXPY_F77 ( const int *  n,
const double *  alpha,
const double  x[],
const int *  incx,
double  y[],
const int *  incy 
)
void PREFIX DCOPY_F77 ( const int *  n,
const double *  x,
const int *  incx,
double *  y,
const int *  incy 
)
double PREFIX DDOT_F77 ( const int *  n,
const double  x[],
const int *  incx,
const double  y[],
const int *  incy 
)
double PREFIX DNRM2_F77 ( const int *  n,
const double  x[],
const int *  incx 
)
void PREFIX DSCAL_F77 ( const int *  n,
const double *  alpha,
double *  x,
const int *  incx 
)
void PREFIX DSWAP_F77 ( const int *const  n,
double *const  x,
const int *const  incx,
double *const  y,
const int *const  incy 
)
int PREFIX IDAMAX_F77 ( const int *  n,
const double *  x,
const int *  incx 
)
void PREFIX SROTG_F77 ( float *  da,
float *  db,
float *  c,
float *  s 
)
void PREFIX SROT_F77 ( const int *  n,
float *  dx,
const int *  incx,
float *  dy,
const int *  incy,
float *  c,
float *  s 
)
void PREFIX SAXPY_F77 ( const int *  n,
const float *  alpha,
const float  x[],
const int *  incx,
float  y[],
const int *  incy 
)
void PREFIX SCOPY_F77 ( const int *  n,
const float *  x,
const int *  incx,
float *  y,
const int *  incy 
)
void PREFIX SSCAL_F77 ( const int *  n,
const float *  alpha,
float *  x,
const int *  incx 
)
void PREFIX SSWAP_F77 ( const int *const  n,
float *const  x,
const int *const  incx,
float *const  y,
const int *const  incy 
)
int PREFIX ISAMAX_F77 ( const int *  n,
const float *  x,
const int *  incx 
)
void PREFIX DGEMV_F77 ( Teuchos_fcd  ,
const int *  m,
const int *  n,
const double *  alpha,
const double  A[],
const int *  lda,
const double  x[],
const int *  incx,
const double *  beta,
double  y[],
const int *  incy 
)
void PREFIX DTRMV_F77 ( Teuchos_fcd  ,
Teuchos_fcd  ,
Teuchos_fcd  ,
const int *  n,
const double *  a,
const int *  lda,
double *  x,
const int *  incx 
)
void PREFIX DGER_F77 ( const int *  m,
const int *  n,
const double *  alpha,
const double *  x,
const int *  incx,
const double *  y,
const int *  incy,
double *  a,
const int *  lda 
)
void PREFIX SGEMV_F77 ( Teuchos_fcd  ,
const int *  m,
const int *  n,
const float *  alpha,
const float  A[],
const int *  lda,
const float  x[],
const int *  incx,
const float *  beta,
float  y[],
const int *  incy 
)
void PREFIX STRMV_F77 ( Teuchos_fcd  ,
Teuchos_fcd  ,
Teuchos_fcd  ,
const int *  n,
const float *  a,
const int *  lda,
float *  x,
const int *  incx 
)
void PREFIX SGER_F77 ( const int *  m,
const int *  n,
const float *  alpha,
const float *  x,
const int *  incx,
const float *  y,
const int *  incy,
float *  a,
const int *  lda 
)
void PREFIX DGEMM_F77 ( Teuchos_fcd  ,
Teuchos_fcd  ,
const int *  m,
const int *  n,
const int *  k,
const double *  alpha,
const double *  a,
const int *  lda,
const double *  b,
const int *  ldb,
const double *  beta,
double *  c,
const int *  ldc 
)
void PREFIX DSYMM_F77 ( Teuchos_fcd  ,
Teuchos_fcd  ,
const int *  m,
const int *  n,
const double *  alpha,
const double *  a,
const int *  lda,
const double *  b,
const int *  ldb,
const double *  beta,
double *  c,
const int *  ldc 
)
void PREFIX DSYRK_F77 ( Teuchos_fcd  ,
Teuchos_fcd  ,
const int *  n,
const int *  k,
const double *  alpha,
const double *  a,
const int *  lda,
const double *  beta,
double *  c,
const int *  ldc 
)
void PREFIX DTRMM_F77 ( Teuchos_fcd  ,
Teuchos_fcd  ,
Teuchos_fcd  ,
Teuchos_fcd  ,
const int *  m,
const int *  n,
const double *  alpha,
const double *  a,
const int *  lda,
double *  b,
const int *  ldb 
)
void PREFIX DTRSM_F77 ( Teuchos_fcd  ,
Teuchos_fcd  ,
Teuchos_fcd  ,
Teuchos_fcd  ,
const int *  m,
const int *  n,
const double *  alpha,
const double *  a,
const int *  lda,
double *  b,
const int *  ldb 
)
void PREFIX SGEMM_F77 ( Teuchos_fcd  ,
Teuchos_fcd  ,
const int *  m,
const int *  n,
const int *  k,
const float *  alpha,
const float *  a,
const int *  lda,
const float *  b,
const int *  ldb,
const float *  beta,
float *  c,
const int *  ldc 
)
void PREFIX SSYMM_F77 ( Teuchos_fcd  ,
Teuchos_fcd  ,
const int *  m,
const int *  n,
const float *  alpha,
const float *  a,
const int *  lda,
const float *  b,
const int *  ldb,
const float *  beta,
float *  c,
const int *  ldc 
)
void PREFIX SSYRK_F77 ( Teuchos_fcd  ,
Teuchos_fcd  ,
const int *  n,
const int *  k,
const float *  alpha,
const float *  a,
const int *  lda,
const float *  beta,
float *  c,
const int *  ldc 
)
void PREFIX STRMM_F77 ( Teuchos_fcd  ,
Teuchos_fcd  ,
Teuchos_fcd  ,
Teuchos_fcd  ,
const int *  m,
const int *  n,
const float *  alpha,
const float *  a,
const int *  lda,
float *  b,
const int *  ldb 
)
void PREFIX STRSM_F77 ( Teuchos_fcd  ,
Teuchos_fcd  ,
Teuchos_fcd  ,
Teuchos_fcd  ,
const int *  m,
const int *  n,
const float *  alpha,
const float *  a,
const int *  lda,
float *  b,
const int *  ldb 
)