Epetra Package Browser (Single Doxygen Collection)  Development
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Groups Pages
Macros | Functions
Epetra_BLAS_wrappers.h File Reference
#include "Epetra_ConfigDefs.h"
Include dependency graph for Epetra_BLAS_wrappers.h:
This graph shows which files directly or indirectly include this file:

Go to the source code of this file.

Macros

#define PREFIX
 
#define Epetra_fcd   const char *
 
#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 DSYMM_F77   F77_BLAS_MANGLE(dsymm,DSYMM)
 
#define DTRMM_F77   F77_BLAS_MANGLE(dtrmm,DTRMM)
 
#define DTRSM_F77   F77_BLAS_MANGLE(dtrsm,DTRSM)
 
#define DSYRK_F77   F77_BLAS_MANGLE(dsyrk,DSYRK)
 
#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 SSYMM_F77   F77_BLAS_MANGLE(ssymm,SSYMM)
 
#define STRMM_F77   F77_BLAS_MANGLE(strmm,STRMM)
 
#define STRSM_F77   F77_BLAS_MANGLE(strsm,STRSM)
 
#define SSYRK_F77   F77_BLAS_MANGLE(ssyrk,SSYRK)
 

Functions

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)
 
int PREFIX IDAMAX_F77 (const int *n, const double *x, const int *incx)
 
float PREFIX SASUM_F77 (const int *n, const float x[], const int *incx)
 
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)
 
float PREFIX SDOT_F77 (const int *n, const float x[], const int *incx, const float y[], const int *incy)
 
float PREFIX SNRM2_F77 (const int *n, const float x[], const int *incx)
 
void PREFIX SSCAL_F77 (const int *n, const float *alpha, float *x, const int *incx)
 
int PREFIX ISAMAX_F77 (const int *n, const float *x, const int *incx)
 
void PREFIX DGEMV_F77 (Epetra_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 (Epetra_fcd, Epetra_fcd, Epetra_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 (Epetra_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 (Epetra_fcd, Epetra_fcd, Epetra_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 (Epetra_fcd, Epetra_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 (Epetra_fcd, Epetra_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 DTRMM_F77 (Epetra_fcd, Epetra_fcd, Epetra_fcd, Epetra_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 (Epetra_fcd, Epetra_fcd, Epetra_fcd, Epetra_fcd, const int *m, const int *n, const double *alpha, const double *a, const int *lda, double *b, const int *ldb)
 
void PREFIX EPETRA_DCRSMV_F77 (const int *, const int *, const int *, const double *, const int *, const int *, double *, double *)
 
void PREFIX EPETRA_DCRSMM_F77 (const int *, const int *, const int *, const double *, const int *, const int *, double *, int *, double *, int *, int *)
 
void PREFIX EPETRA_DCRSSV_F77 (const int *, const int *, const int *, const int *, const int *, const int *, const double *, const int *, const int *, double *, double *, const int *)
 
void PREFIX EPETRA_DCRSSM_F77 (const int *, const int *, const int *, const int *, const int *, const int *, const double *, const int *, const int *, double *, const int *, double *, const int *, const int *, const int *)
 
void PREFIX DSYRK_F77 (Epetra_fcd uplo, Epetra_fcd trans, 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 SGEMM_F77 (Epetra_fcd, Epetra_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 (Epetra_fcd, Epetra_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 STRMM_F77 (Epetra_fcd, Epetra_fcd, Epetra_fcd, Epetra_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 (Epetra_fcd, Epetra_fcd, Epetra_fcd, Epetra_fcd, const int *m, const int *n, const float *alpha, const float *a, const int *lda, float *b, const int *ldb)
 
void PREFIX XERBLA_F77 (Epetra_fcd, int *info)
 
void PREFIX SSYRK_F77 (Epetra_fcd uplo, Epetra_fcd trans, const int *n, const int *k, const float *alpha, const float *a, const int *lda, const float *beta, float *c, const int *ldc)
 

Macro Definition Documentation

#define PREFIX

Definition at line 117 of file Epetra_BLAS_wrappers.h.

#define Epetra_fcd   const char *

Definition at line 118 of file Epetra_BLAS_wrappers.h.

#define DASUM_F77   F77_BLAS_MANGLE(dasum,DASUM)

Definition at line 151 of file Epetra_BLAS_wrappers.h.

#define DAXPY_F77   F77_BLAS_MANGLE(daxpy,DAXPY)

Definition at line 152 of file Epetra_BLAS_wrappers.h.

#define DCOPY_F77   F77_BLAS_MANGLE(dcopy,DCOPY)

Definition at line 153 of file Epetra_BLAS_wrappers.h.

#define DDOT_F77   F77_BLAS_MANGLE(ddot,DDOT)

Definition at line 154 of file Epetra_BLAS_wrappers.h.

#define DNRM2_F77   F77_BLAS_MANGLE(dnrm2,DNRM2)

Definition at line 155 of file Epetra_BLAS_wrappers.h.

#define DSCAL_F77   F77_BLAS_MANGLE(dscal,DSCAL)

Definition at line 156 of file Epetra_BLAS_wrappers.h.

#define IDAMAX_F77   F77_BLAS_MANGLE(idamax,IDAMAX)

Definition at line 157 of file Epetra_BLAS_wrappers.h.

#define DGEMV_F77   F77_BLAS_MANGLE(dgemv,DGEMV)

Definition at line 158 of file Epetra_BLAS_wrappers.h.

#define DGER_F77   F77_BLAS_MANGLE(dger,DGER)

Definition at line 159 of file Epetra_BLAS_wrappers.h.

#define DTRMV_F77   F77_BLAS_MANGLE(dtrmv,DTRMV)

Definition at line 160 of file Epetra_BLAS_wrappers.h.

#define DGEMM_F77   F77_BLAS_MANGLE(dgemm,DGEMM)

Definition at line 161 of file Epetra_BLAS_wrappers.h.

#define DSYMM_F77   F77_BLAS_MANGLE(dsymm,DSYMM)

Definition at line 162 of file Epetra_BLAS_wrappers.h.

#define DTRMM_F77   F77_BLAS_MANGLE(dtrmm,DTRMM)

Definition at line 163 of file Epetra_BLAS_wrappers.h.

#define DTRSM_F77   F77_BLAS_MANGLE(dtrsm,DTRSM)

Definition at line 164 of file Epetra_BLAS_wrappers.h.

#define DSYRK_F77   F77_BLAS_MANGLE(dsyrk,DSYRK)

Definition at line 165 of file Epetra_BLAS_wrappers.h.

#define SSCAL_F77   F77_BLAS_MANGLE(sscal,SSCAL)

Definition at line 194 of file Epetra_BLAS_wrappers.h.

#define SCOPY_F77   F77_BLAS_MANGLE(scopy,SCOPY)

Definition at line 195 of file Epetra_BLAS_wrappers.h.

#define SAXPY_F77   F77_BLAS_MANGLE(saxpy,SAXPY)

Definition at line 196 of file Epetra_BLAS_wrappers.h.

#define SDOT_F77   F77_BLAS_MANGLE(sdot,SDOT)

Definition at line 197 of file Epetra_BLAS_wrappers.h.

#define SNRM2_F77   F77_BLAS_MANGLE(snrm2,SNRM2)

Definition at line 198 of file Epetra_BLAS_wrappers.h.

#define SASUM_F77   F77_BLAS_MANGLE(sasum,SASUM)

Definition at line 199 of file Epetra_BLAS_wrappers.h.

#define ISAMAX_F77   F77_BLAS_MANGLE(isamax,ISAMAX)

Definition at line 200 of file Epetra_BLAS_wrappers.h.

#define SGEMV_F77   F77_BLAS_MANGLE(sgemv,SGEMV)

Definition at line 202 of file Epetra_BLAS_wrappers.h.

#define SGER_F77   F77_BLAS_MANGLE(sger,SGER)

Definition at line 203 of file Epetra_BLAS_wrappers.h.

#define STRMV_F77   F77_BLAS_MANGLE(strmv,STRMV)

Definition at line 204 of file Epetra_BLAS_wrappers.h.

#define SGEMM_F77   F77_BLAS_MANGLE(sgemm,SGEMM)

Definition at line 205 of file Epetra_BLAS_wrappers.h.

#define SSYMM_F77   F77_BLAS_MANGLE(ssymm,SSYMM)

Definition at line 206 of file Epetra_BLAS_wrappers.h.

#define STRMM_F77   F77_BLAS_MANGLE(strmm,STRMM)

Definition at line 207 of file Epetra_BLAS_wrappers.h.

#define STRSM_F77   F77_BLAS_MANGLE(strsm,STRSM)

Definition at line 208 of file Epetra_BLAS_wrappers.h.

#define SSYRK_F77   F77_BLAS_MANGLE(ssyrk,SSYRK)

Definition at line 209 of file Epetra_BLAS_wrappers.h.

Function Documentation

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 
)
int PREFIX IDAMAX_F77 ( const int *  n,
const double *  x,
const int *  incx 
)
float PREFIX SASUM_F77 ( const int *  n,
const float  x[],
const int *  incx 
)
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 
)
float PREFIX SDOT_F77 ( const int *  n,
const float  x[],
const int *  incx,
const float  y[],
const int *  incy 
)
float PREFIX SNRM2_F77 ( const int *  n,
const float  x[],
const int *  incx 
)
void PREFIX SSCAL_F77 ( const int *  n,
const float *  alpha,
float *  x,
const int *  incx 
)
int PREFIX ISAMAX_F77 ( const int *  n,
const float *  x,
const int *  incx 
)
void PREFIX DGEMV_F77 ( Epetra_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 ( Epetra_fcd  ,
Epetra_fcd  ,
Epetra_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 ( Epetra_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 ( Epetra_fcd  ,
Epetra_fcd  ,
Epetra_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 ( Epetra_fcd  ,
Epetra_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 ( Epetra_fcd  ,
Epetra_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 DTRMM_F77 ( Epetra_fcd  ,
Epetra_fcd  ,
Epetra_fcd  ,
Epetra_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 ( Epetra_fcd  ,
Epetra_fcd  ,
Epetra_fcd  ,
Epetra_fcd  ,
const int *  m,
const int *  n,
const double *  alpha,
const double *  a,
const int *  lda,
double *  b,
const int *  ldb 
)
void PREFIX EPETRA_DCRSMV_F77 ( const int *  ,
const int *  ,
const int *  ,
const double *  ,
const int *  ,
const int *  ,
double *  ,
double *   
)
void PREFIX EPETRA_DCRSMM_F77 ( const int *  ,
const int *  ,
const int *  ,
const double *  ,
const int *  ,
const int *  ,
double *  ,
int *  ,
double *  ,
int *  ,
int *   
)
void PREFIX EPETRA_DCRSSV_F77 ( const int *  ,
const int *  ,
const int *  ,
const int *  ,
const int *  ,
const int *  ,
const double *  ,
const int *  ,
const int *  ,
double *  ,
double *  ,
const int *   
)
void PREFIX EPETRA_DCRSSM_F77 ( const int *  ,
const int *  ,
const int *  ,
const int *  ,
const int *  ,
const int *  ,
const double *  ,
const int *  ,
const int *  ,
double *  ,
const int *  ,
double *  ,
const int *  ,
const int *  ,
const int *   
)
void PREFIX DSYRK_F77 ( Epetra_fcd  uplo,
Epetra_fcd  trans,
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 SGEMM_F77 ( Epetra_fcd  ,
Epetra_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 ( Epetra_fcd  ,
Epetra_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 STRMM_F77 ( Epetra_fcd  ,
Epetra_fcd  ,
Epetra_fcd  ,
Epetra_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 ( Epetra_fcd  ,
Epetra_fcd  ,
Epetra_fcd  ,
Epetra_fcd  ,
const int *  m,
const int *  n,
const float *  alpha,
const float *  a,
const int *  lda,
float *  b,
const int *  ldb 
)
void PREFIX XERBLA_F77 ( Epetra_fcd  ,
int *  info 
)
void PREFIX SSYRK_F77 ( Epetra_fcd  uplo,
Epetra_fcd  trans,
const int *  n,
const int *  k,
const float *  alpha,
const float *  a,
const int *  lda,
const float *  beta,
float *  c,
const int *  ldc 
)