C I J P S

C

CUBLAS_STATUS_ALLOC_FAILED - Static variable in class jcuda.jcublas.cublasStatus
Resource allocation failed
CUBLAS_STATUS_ARCH_MISMATCH - Static variable in class jcuda.jcublas.cublasStatus
Function requires an architectural feature absent from the architecture of the device
CUBLAS_STATUS_EXECUTION_FAILED - Static variable in class jcuda.jcublas.cublasStatus
GPU program failed to execute
CUBLAS_STATUS_INTERNAL_ERROR - Static variable in class jcuda.jcublas.cublasStatus
An internal CUBLAS operation failed
CUBLAS_STATUS_INVALID_VALUE - Static variable in class jcuda.jcublas.cublasStatus
Unsupported numerical value was passed to function
CUBLAS_STATUS_MAPPING_ERROR - Static variable in class jcuda.jcublas.cublasStatus
Access to GPU memory space failed
CUBLAS_STATUS_NOT_INITIALIZED - Static variable in class jcuda.jcublas.cublasStatus
Library not initialized
CUBLAS_STATUS_SUCCESS - Static variable in class jcuda.jcublas.cublasStatus
Operation completed successfully
cublasAlloc(int, int, Pointer) - Static method in class jcuda.jcublas.JCublas
Wrapper for CUBLAS function.
cublasCaxpy(int, cuComplex, Pointer, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasCaxpy (int n, cuComplex alpha, const cuComplex *x, int incx, cuComplex *y, int incy) multiplies single-complex vector x by single-complex scalar alpha and adds the result to single-complex vector y; that is, it overwrites single-complex y with single-complex alpha * x + y.
cublasCcopy(int, Pointer, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasCcopy (int n, const cuComplex *x, int incx, cuComplex *y, int incy) copies the single-complex vector x to the single-complex vector y.
cublasCgbmv(char, int, int, int, int, cuComplex, Pointer, int, Pointer, int, cuComplex, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasCgbmv (char trans, int m, int n, int kl, int ku, cuComplex alpha, const cuComplex *A, int lda, const cuComplex *x, int incx, cuComplex beta, cuComplex *y, int incy); performs one of the matrix-vector operations y = alpha*op(A)*x + beta*y, op(A)=A or op(A) = transpose(A) alpha and beta are single precision complex scalars. x and y are single precision complex vectors.
cublasCgemm(char, char, int, int, int, cuComplex, Pointer, int, Pointer, int, cuComplex, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasCgemm (char transa, char transb, int m, int n, int k, cuComplex alpha, const cuComplex *A, int lda, const cuComplex *B, int ldb, cuComplex beta, cuComplex *C, int ldc) performs one of the matrix-matrix operations C = alpha * op(A) * op(B) + beta*C, where op(X) is one of op(X) = X or op(X) = transpose or op(X) = conjg(transpose(X)) alpha and beta are single-complex scalars, and A, B and C are matrices consisting of single-complex elements, with op(A) an m x k matrix, op(B) a k x n matrix and C an m x n matrix.
cublasCgemv(char, int, int, cuComplex, Pointer, int, Pointer, int, cuComplex, Pointer, int) - Static method in class jcuda.jcublas.JCublas
cublasCgemv (char trans, int m, int n, cuComplex alpha, const cuComplex *A, int lda, const cuComplex *x, int incx, cuComplex beta, cuComplex *y, int incy) performs one of the matrix-vector operations y = alpha * op(A) * x + beta * y, where op(A) is one of op(A) = A or op(A) = transpose(A) or op(A) = conjugate(transpose(A)) where alpha and beta are single precision scalars, x and y are single precision vectors, and A is an m x n matrix consisting of single precision elements.
cublasCgerc(int, int, cuComplex, Pointer, int, Pointer, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
cublasCgerc (int m, int n, cuComplex alpha, const cuComplex *x, int incx, const cuComplex *y, int incy, cuComplex *A, int lda) performs the symmetric rank 1 operation A = alpha * x * conjugate(transpose(y)) + A, where alpha is a single precision complex scalar, x is an m element single precision complex vector, y is an n element single precision complex vector, and A is an m by n matrix consisting of single precision complex elements.
cublasCgeru(int, int, cuComplex, Pointer, int, Pointer, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
cublasCgeru (int m, int n, cuComplex alpha, const cuComplex *x, int incx, const cuComplex *y, int incy, cuComplex *A, int lda) performs the symmetric rank 1 operation A = alpha * x * transpose(y) + A, where alpha is a single precision complex scalar, x is an m element single precision complex vector, y is an n element single precision complex vector, and A is an m by n matrix consisting of single precision complex elements.
cublasChbmv(char, int, int, cuComplex, Pointer, int, Pointer, int, cuComplex, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasChbmv (char uplo, int n, int k, cuComplex alpha, const cuComplex *A, int lda, const cuComplex *x, int incx, cuComplex beta, cuComplex *y, int incy) performs the matrix-vector operation y := alpha*A*x + beta*y alpha and beta are single precision complex scalars. x and y are single precision complex vectors with n elements.
cublasChemm(char, char, int, int, cuComplex, Pointer, int, Pointer, int, cuComplex, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasChemm (char side, char uplo, int m, int n, cuComplex alpha, const cuComplex *A, int lda, const cuComplex *B, int ldb, cuComplex beta, cuComplex *C, int ldc); performs one of the matrix-matrix operations C = alpha * A * B + beta * C, or C = alpha * B * A + beta * C, where alpha and beta are single precision complex scalars, A is a hermitian matrix consisting of single precision complex elements and stored in either lower or upper storage mode, and B and C are m x n matrices consisting of single precision complex elements.
cublasChemv(char, int, cuComplex, Pointer, int, Pointer, int, cuComplex, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasChemv (char uplo, int n, cuComplex alpha, const cuComplex *A, int lda, const cuComplex *x, int incx, cuComplex beta, cuComplex *y, int incy) performs the matrix-vector operation y = alpha*A*x + beta*y Alpha and beta are single precision complex scalars, and x and y are single precision complex vectors, each with n elements.
cublasCher(char, int, float, Pointer, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasCher (char uplo, int n, float alpha, const cuComplex *x, int incx, cuComplex *A, int lda) performs the hermitian rank 1 operation A = alpha * x * conjugate(transpose(x)) + A, where alpha is a single precision real scalar, x is an n element single precision complex vector and A is an n x n hermitian matrix consisting of single precision complex elements.
cublasCher2(char, int, cuComplex, Pointer, int, Pointer, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasCher2 (char uplo, int n, cuComplex alpha, const cuComplex *x, int incx, const cuComplex *y, int incy, cuComplex *A, int lda) performs the hermitian rank 2 operation A = alpha*x*conjugate(transpose(y)) + conjugate(alpha)*y*conjugate(transpose(x)) + A, where alpha is a single precision complex scalar, x and y are n element single precision complex vector and A is an n by n hermitian matrix consisting of single precision complex elements.
cublasCher2k(char, char, int, int, cuComplex, Pointer, int, Pointer, int, float, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasCher2k (char uplo, char trans, int n, int k, cuComplex alpha, const cuComplex *A, int lda, const cuComplex *B, int ldb, float beta, cuComplex *C, int ldc) performs one of the hermitian rank 2k operations C = alpha * A * conjugate(transpose(B)) + conjugate(alpha) * B * conjugate(transpose(A)) + beta * C , or C = alpha * conjugate(transpose(A)) * B + conjugate(alpha) * conjugate(transpose(B)) * A + beta * C.
cublasCherk(char, char, int, int, float, Pointer, int, float, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasCherk (char uplo, char trans, int n, int k, float alpha, const cuComplex *A, int lda, float beta, cuComplex *C, int ldc) performs one of the hermitian rank k operations C = alpha * A * conjugate(transpose(A)) + beta * C, or C = alpha * conjugate(transpose(A)) * A + beta * C.
cublasChpr(char, int, float, Pointer, int, Pointer) - Static method in class jcuda.jcublas.JCublas
void cublasChpr (char uplo, int n, float alpha, const cuComplex *x, int incx, cuComplex *AP) performs the hermitian rank 1 operation A = alpha * x * conjugate(transpose(x)) + A, where alpha is a single precision real scalar and x is an n element single precision complex vector.
cublasChpr2(char, int, cuComplex, Pointer, int, Pointer, int, Pointer) - Static method in class jcuda.jcublas.JCublas
void cublasChpr2 (char uplo, int n, cuComplex alpha, const cuComplex *x, int incx, const cuComplex *y, int incy, cuComplex *AP) performs the hermitian rank 2 operation A = alpha*x*conjugate(transpose(y)) + conjugate(alpha)*y*conjugate(transpose(x)) + A, where alpha is a single precision complex scalar, and x and y are n element single precision complex vectors.
cublasCrot(int, Pointer, int, Pointer, int, float, cuComplex) - Static method in class jcuda.jcublas.JCublas
void cublasCrot (int n, cuComplex *x, int incx, cuComplex *y, int incy, float sc, cuComplex cs) multiplies a 2x2 matrix ( sc cs) with the 2xn matrix ( transpose(x) ) (-conj(cs) sc) ( transpose(y) ) The elements of x are in x[lx + i * incx], i = 0 ... n - 1, where lx = 1 if incx >= 0, else lx = 1 + (1 - n) * incx, and similarly for y using ly and incy.
cublasCrotg(Pointer, cuComplex, Pointer, Pointer) - Static method in class jcuda.jcublas.JCublas
void cublasCrotg (cuComplex *host_ca, cuComplex cb, float *host_sc, cuComplex *host_cs) constructs the complex Givens tranformation ( sc cs ) G = ( ) , sc^2 + cabs(cs)^2 = 1, (-cs sc ) which zeros the second entry of the complex 2-vector transpose(ca, cb).
cublasCscal(int, cuComplex, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasCscal (int n, cuComplex alpha, cuComplex *x, int incx) replaces single-complex vector x with single-complex alpha * x.
cublasCsrot(int, Pointer, int, Pointer, int, float, float) - Static method in class jcuda.jcublas.JCublas
void csrot (int n, cuComplex *x, int incx, cuCumplex *y, int incy, float c, float s) multiplies a 2x2 rotation matrix ( c s) with a 2xn matrix ( transpose(x) ) (-s c) ( transpose(y) ) The elements of x are in x[lx + i * incx], i = 0 ... n - 1, where lx = 1 if incx >= 0, else lx = 1 + (1 - n) * incx, and similarly for y using ly and incy.
cublasCsscal(int, float, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasCsscal (int n, float alpha, cuComplex *x, int incx) replaces single-complex vector x with single-complex alpha * x.
cublasCswap(int, Pointer, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasCswap (int n, const cuComplex *x, int incx, cuComplex *y, int incy) interchanges the single-complex vector x with the single-complex vector y.
cublasCsymm(char, char, int, int, cuComplex, Pointer, int, Pointer, int, cuComplex, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasCsymm (char side, char uplo, int m, int n, cuComplex alpha, const cuComplex *A, int lda, const cuComplex *B, int ldb, cuComplex beta, cuComplex *C, int ldc); performs one of the matrix-matrix operations C = alpha * A * B + beta * C, or C = alpha * B * A + beta * C, where alpha and beta are single precision complex scalars, A is a symmetric matrix consisting of single precision complex elements and stored in either lower or upper storage mode, and B and C are m x n matrices consisting of single precision complex elements.
cublasCsyr2k(char, char, int, int, cuComplex, Pointer, int, Pointer, int, cuComplex, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasCsyr2k (char uplo, char trans, int n, int k, cuComplex alpha, const cuComplex *A, int lda, const cuComplex *B, int ldb, cuComplex beta, cuComplex *C, int ldc) performs one of the symmetric rank 2k operations C = alpha * A * transpose(B) + alpha * B * transpose(A) + beta * C, or C = alpha * transpose(A) * B + alpha * transpose(B) * A + beta * C.
cublasCsyrk(char, char, int, int, cuComplex, Pointer, int, cuComplex, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasCsyrk (char uplo, char trans, int n, int k, cuComplex alpha, const cuComplex *A, int lda, cuComplex beta, cuComplex *C, int ldc) performs one of the symmetric rank k operations C = alpha * A * transpose(A) + beta * C, or C = alpha * transpose(A) * A + beta * C.
cublasCtbmv(char, char, char, int, int, Pointer, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasCtbmv (char uplo, char trans, char diag, int n, int k, const cuComplex *A, int lda, cuComplex *x, int incx) performs one of the matrix-vector operations x = op(A) * x, where op(A) = A, op(A) = transpose(A) or op(A) = conjugate(transpose(A)). x is an n-element single precision complex vector, and A is an n x n, unit or non-unit, upper or lower triangular band matrix composed of single precision complex elements.
cublasCtbsv(char, char, char, int, int, Pointer, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasCtbsv (char uplo, char trans, char diag, int n, int k, const cuComplex *A, int lda, cuComplex *X, int incx) solves one of the systems of equations op(A)*x = b, where op(A) is either op(A) = A , op(A) = transpose(A) or op(A) = conjugate(transpose(A)).
cublasCtpmv(char, char, char, int, Pointer, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasCtpmv (char uplo, char trans, char diag, int n, const cuComplex *AP, cuComplex *x, int incx); performs one of the matrix-vector operations x = op(A) * x, where op(A) = A, op(A) = transpose(A) or op(A) = conjugate(transpose(A)) . x is an n element single precision complex vector, and A is an n x n, unit or non-unit, upper or lower triangular matrix composed of single precision complex elements.
cublasCtpsv(char, char, char, int, Pointer, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasCtpsv (char uplo, char trans, char diag, int n, const cuComplex *AP, cuComplex *X, int incx) solves one of the systems of equations op(A)*x = b, where op(A) is either op(A) = A , op(A) = transpose(A) or op(A) = conjugate(transpose)). b and x are n element complex vectors, and A is an n x n unit or non-unit, upper or lower triangular matrix.
cublasCtrmm(char, char, char, char, int, int, cuComplex, Pointer, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasCtrmm (char side, char uplo, char transa, char diag, int m, int n, cuComplex alpha, const cuComplex *A, int lda, const cuComplex *B, int ldb) performs one of the matrix-matrix operations B = alpha * op(A) * B, or B = alpha * B * op(A) where alpha is a single-precision complex scalar, B is an m x n matrix composed of single precision complex elements, and A is a unit or non-unit, upper or lower, triangular matrix composed of single precision complex elements. op(A) is one of op(A) = A , op(A) = transpose(A) or op(A) = conjugate(transpose(A)) Matrices A and B are stored in column major format, and lda and ldb are the leading dimensions of the two-dimensonials arrays that contain A and B, respectively.
cublasCtrmv(char, char, char, int, Pointer, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
cublasCtrmv (char uplo, char trans, char diag, int n, const cuComplex *A, int lda, cuComplex *x, int incx); performs one of the matrix-vector operations x = op(A) * x, where op(A) = A, or op(A) = transpose(A) or op(A) = conjugate(transpose(A)).
cublasCtrsm(char, char, char, char, int, int, cuComplex, Pointer, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasCtrsm (char side, char uplo, char transa, char diag, int m, int n, cuComplex alpha, const cuComplex *A, int lda, cuComplex *B, int ldb) solves one of the matrix equations op(A) * X = alpha * B, or X * op(A) = alpha * B, where alpha is a single precision complex scalar, and X and B are m x n matrices that are composed of single precision complex elements.
cublasCtrsv(char, char, char, int, Pointer, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasCtrsv (char uplo, char trans, char diag, int n, const cuComplex *A, int lda, cuComplex *x, int incx) solves a system of equations op(A) * x = b, where op(A) is either A, transpose(A) or conjugate(transpose(A)). b and x are single precision complex vectors consisting of n elements, and A is an n x n matrix composed of a unit or non-unit, upper or lower triangular matrix.
cublasDasum(int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
double cublasDasum (int n, const double *x, int incx) computes the sum of the absolute values of the elements of double precision vector x; that is, the result is the sum from i = 0 to n - 1 of abs(x[1 + i * incx]).
cublasDaxpy(int, double, Pointer, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasDaxpy (int n, double alpha, const double *x, int incx, double *y, int incy) multiplies double-precision vector x by double-precision scalar alpha and adds the result to double-precision vector y; that is, it overwrites double-precision y with double-precision alpha * x + y.
cublasDcopy(int, Pointer, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasDcopy (int n, const double *x, int incx, double *y, int incy) copies the double-precision vector x to the double-precision vector y.
cublasDdot(int, Pointer, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
double cublasDdot (int n, const double *x, int incx, const double *y, int incy) computes the dot product of two double-precision vectors.
cublasDgbmv(char, int, int, int, int, double, Pointer, int, Pointer, int, double, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasDgbmv (char trans, int m, int n, int kl, int ku, double alpha, const double *A, int lda, const double *x, int incx, double beta, double *y, int incy); performs one of the matrix-vector operations y = alpha*op(A)*x + beta*y, op(A)=A or op(A) = transpose(A) alpha and beta are double precision scalars. x and y are double precision vectors.
cublasDgemm(char, char, int, int, int, double, Pointer, int, Pointer, int, double, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasDgemm (char transa, char transb, int m, int n, int k, double alpha, const double *A, int lda, const double *B, int ldb, double beta, double *C, int ldc) computes the product of matrix A and matrix B, multiplies the result by scalar alpha, and adds the sum to the product of matrix C and scalar beta.
cublasDgemv(char, int, int, double, Pointer, int, Pointer, int, double, Pointer, int) - Static method in class jcuda.jcublas.JCublas
cublasDgemv (char trans, int m, int n, double alpha, const double *A, int lda, const double *x, int incx, double beta, double *y, int incy) performs one of the matrix-vector operations y = alpha * op(A) * x + beta * y, where op(A) is one of op(A) = A or op(A) = transpose(A) where alpha and beta are double precision scalars, x and y are double precision vectors, and A is an m x n matrix consisting of double precision elements.
cublasDger(int, int, double, Pointer, int, Pointer, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
cublasDger (int m, int n, double alpha, const double *x, int incx, const double *y, int incy, double *A, int lda) performs the symmetric rank 1 operation A = alpha * x * transpose(y) + A, where alpha is a double precision scalar, x is an m element double precision vector, y is an n element double precision vector, and A is an m by n matrix consisting of double precision elements.
cublasDnrm2(int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
double dnrm2 (int n, const double *x, int incx) computes the Euclidean norm of the double-precision n-vector x (with storage increment incx).
cublasDrot(int, Pointer, int, Pointer, int, double, double) - Static method in class jcuda.jcublas.JCublas
void cublasDrot (int n, double *x, int incx, double *y, int incy, double sc, double ss) multiplies a 2x2 matrix ( sc ss) with the 2xn matrix ( transpose(x) ) (-ss sc) ( transpose(y) ) The elements of x are in x[lx + i * incx], i = 0 ... n - 1, where lx = 1 if incx >= 0, else lx = 1 + (1 - n) * incx, and similarly for y using ly and incy.
cublasDrotg(Pointer, Pointer, Pointer, Pointer) - Static method in class jcuda.jcublas.JCublas
void cublasDrotg (double *host_sa, double *host_sb, double *host_sc, double *host_ss) constructs the Givens tranformation ( sc ss ) G = ( ) , sc^2 + ss^2 = 1, (-ss sc ) which zeros the second entry of the 2-vector transpose(sa, sb).
cublasDrotm(int, Pointer, int, Pointer, int, double[]) - Static method in class jcuda.jcublas.JCublas
Wrapper for CUBLAS function.
cublasDrotmg(double[], double[], double[], double, double[]) - Static method in class jcuda.jcublas.JCublas
Wrapper for CUBLAS function.
cublasDsbmv(char, int, int, double, Pointer, int, Pointer, int, double, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasDsbmv (char uplo, int n, int k, double alpha, const double *A, int lda, const double *x, int incx, double beta, double *y, int incy) performs the matrix-vector operation y := alpha*A*x + beta*y alpha and beta are double precision scalars. x and y are double precision vectors with n elements.
cublasDscal(int, double, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasDscal (int n, double alpha, double *x, int incx) replaces double-precision vector x with double-precision alpha * x.
cublasDspmv(char, int, double, Pointer, Pointer, int, double, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasDspmv (char uplo, int n, double alpha, const double *AP, const double *x, int incx, double beta, double *y, int incy) performs the matrix-vector operation y = alpha * A * x + beta * y Alpha and beta are double precision scalars, and x and y are double precision vectors with n elements.
cublasDspr(char, int, double, Pointer, int, Pointer) - Static method in class jcuda.jcublas.JCublas
void cublasDspr (char uplo, int n, double alpha, const double *x, int incx, double *AP) performs the symmetric rank 1 operation A = alpha * x * transpose(x) + A, where alpha is a double precision scalar and x is an n element double precision vector.
cublasDspr2(char, int, double, Pointer, int, Pointer, int, Pointer) - Static method in class jcuda.jcublas.JCublas
void cublasDspr2 (char uplo, int n, double alpha, const double *x, int incx, const double *y, int incy, double *AP) performs the symmetric rank 2 operation A = alpha*x*transpose(y) + alpha*y*transpose(x) + A, where alpha is a double precision scalar, and x and y are n element double precision vectors.
cublasDswap(int, Pointer, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasDswap (int n, double *x, int incx, double *y, int incy) replaces double-precision vector x with double-precision alpha * x.
cublasDsymm(char, char, int, int, double, Pointer, int, Pointer, int, double, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasDsymm (char side, char uplo, int m, int n, double alpha, const double *A, int lda, const double *B, int ldb, double beta, double *C, int ldc); performs one of the matrix-matrix operations C = alpha * A * B + beta * C, or C = alpha * B * A + beta * C, where alpha and beta are double precision scalars, A is a symmetric matrix consisting of double precision elements and stored in either lower or upper storage mode, and B and C are m x n matrices consisting of double precision elements.
cublasDsymv(char, int, double, Pointer, int, Pointer, int, double, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasDsymv (char uplo, int n, double alpha, const double *A, int lda, const double *x, int incx, double beta, double *y, int incy) performs the matrix-vector operation y = alpha*A*x + beta*y Alpha and beta are double precision scalars, and x and y are double precision vectors, each with n elements.
cublasDsyr(char, int, double, Pointer, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasDsyr (char uplo, int n, double alpha, const double *x, int incx, double *A, int lda) performs the symmetric rank 1 operation A = alpha * x * transpose(x) + A, where alpha is a double precision scalar, x is an n element double precision vector and A is an n x n symmetric matrix consisting of double precision elements.
cublasDsyr2(char, int, double, Pointer, int, Pointer, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasDsyr2 (char uplo, int n, double alpha, const double *x, int incx, const double *y, int incy, double *A, int lda) performs the symmetric rank 2 operation A = alpha*x*transpose(y) + alpha*y*transpose(x) + A, where alpha is a double precision scalar, x and y are n element double precision vector and A is an n by n symmetric matrix consisting of double precision elements.
cublasDsyr2k(char, char, int, int, double, Pointer, int, Pointer, int, double, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasDsyr2k (char uplo, char trans, int n, int k, double alpha, const double *A, int lda, const double *B, int ldb, double beta, double *C, int ldc) performs one of the symmetric rank 2k operations C = alpha * A * transpose(B) + alpha * B * transpose(A) + beta * C, or C = alpha * transpose(A) * B + alpha * transpose(B) * A + beta * C.
cublasDsyrk(char, char, int, int, double, Pointer, int, double, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasDsyrk (char uplo, char trans, int n, int k, double alpha, const double *A, int lda, double beta, double *C, int ldc) performs one of the symmetric rank k operations C = alpha * A * transpose(A) + beta * C, or C = alpha * transpose(A) * A + beta * C.
cublasDtbmv(char, char, char, int, int, Pointer, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasDtbmv (char uplo, char trans, char diag, int n, int k, const double *A, int lda, double *x, int incx) performs one of the matrix-vector operations x = op(A) * x, where op(A) = A, or op(A) = transpose(A). x is an n-element double precision vector, and A is an n x n, unit or non-unit, upper or lower triangular band matrix composed of double precision elements.
cublasDtbsv(char, char, char, int, int, Pointer, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasDtbsv (char uplo, char trans, char diag, int n, int k, const double *A, int lda, double *X, int incx) solves one of the systems of equations op(A)*x = b, where op(A) is either op(A) = A or op(A) = transpose(A). b and x are n element vectors, and A is an n x n unit or non-unit, upper or lower triangular band matrix with k + 1 diagonals.
cublasDtpmv(char, char, char, int, Pointer, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasDtpmv (char uplo, char trans, char diag, int n, const double *AP, double *x, int incx); performs one of the matrix-vector operations x = op(A) * x, where op(A) = A, or op(A) = transpose(A). x is an n element double precision vector, and A is an n x n, unit or non-unit, upper or lower triangular matrix composed of double precision elements.
cublasDtpsv(char, char, char, int, Pointer, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasDtpsv (char uplo, char trans, char diag, int n, const double *AP, double *X, int incx) solves one of the systems of equations op(A)*x = b, where op(A) is either op(A) = A or op(A) = transpose(A). b and x are n element vectors, and A is an n x n unit or non-unit, upper or lower triangular matrix.
cublasDtrmm(char, char, char, char, int, int, double, Pointer, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasDtrmm (char side, char uplo, char transa, char diag, int m, int n, double alpha, const double *A, int lda, const double *B, int ldb) performs one of the matrix-matrix operations B = alpha * op(A) * B, or B = alpha * B * op(A) where alpha is a double-precision scalar, B is an m x n matrix composed of double precision elements, and A is a unit or non-unit, upper or lower, triangular matrix composed of double precision elements. op(A) is one of op(A) = A or op(A) = transpose(A) Matrices A and B are stored in column major format, and lda and ldb are the leading dimensions of the two-dimensonials arrays that contain A and B, respectively.
cublasDtrmv(char, char, char, int, Pointer, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasDtrmv (char uplo, char trans, char diag, int n, const double *A, int lda, double *x, int incx); performs one of the matrix-vector operations x = op(A) * x, where op(A) = = A, or op(A) = transpose(A). x is an n-element single precision vector, and A is an n x n, unit or non-unit, upper or lower, triangular matrix composed of single precision elements.
cublasDtrsm(char, char, char, char, int, int, double, Pointer, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasDtrsm (char side, char uplo, char transa, char diag, int m, int n, double alpha, const double *A, int lda, double *B, int ldb) solves one of the matrix equations op(A) * X = alpha * B, or X * op(A) = alpha * B, where alpha is a double precision scalar, and X and B are m x n matrices that are composed of double precision elements.
cublasDtrsv(char, char, char, int, Pointer, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasDtrsv (char uplo, char trans, char diag, int n, const double *A, int lda, double *x, int incx) solves a system of equations op(A) * x = b, where op(A) is either A or transpose(A). b and x are double precision vectors consisting of n elements, and A is an n x n matrix composed of a unit or non-unit, upper or lower triangular matrix.
cublasDzasum(int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
double cublasDzasum (int n, const cuDoubleComplex *x, int incx) takes the sum of the absolute values of a complex vector and returns a double precision result.
cublasDznrm2(int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
double cublasDznrm2 (int n, const cuDoubleComplex *x, int incx) computes the Euclidean norm of the double precision complex n-vector x.
cublasFree(Pointer) - Static method in class jcuda.jcublas.JCublas
Wrapper for CUBLAS function.
cublasGetError() - Static method in class jcuda.jcublas.JCublas
Wrapper for CUBLAS function.
cublasGetMatrix(int, int, int, Pointer, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
Wrapper for CUBLAS function.
cublasGetMatrix(int, int, Pointer, int, cuComplex[], int, int) - Static method in class jcuda.jcublas.JCublas
Extended wrapper for arrays of cuComplex values.
cublasGetMatrix(int, int, Pointer, int, cuDoubleComplex[], int, int) - Static method in class jcuda.jcublas.JCublas
Extended wrapper for arrays of cuDoubleComplex values.
cublasGetMatrixAsync(int, int, int, Pointer, int, Pointer, int, cudaStream_t) - Static method in class jcuda.jcublas.JCublas
 
cublasGetVector(int, int, Pointer, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
Wrapper for CUBLAS function.
cublasGetVector(int, Pointer, int, cuComplex[], int, int) - Static method in class jcuda.jcublas.JCublas
Extended wrapper for arrays of cuComplex values.
cublasGetVector(int, Pointer, int, cuDoubleComplex[], int, int) - Static method in class jcuda.jcublas.JCublas
Extended wrapper for arrays of cuDoubleComplex values.
cublasGetVectorAsync(int, int, Pointer, int, Pointer, int, cudaStream_t) - Static method in class jcuda.jcublas.JCublas
 
cublasIcamax(int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
int cublasIcamax (int n, const float *x, int incx) finds the smallest index of the element having maximum absolute value in single-complex vector x; that is, the result is the first i, i = 0 to n - 1 that maximizes abs(real(x[1+i*incx]))+abs(imag(x[1 + i * incx])).
cublasIcamin(int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
int cublasIcamin (int n, const float *x, int incx) finds the smallest index of the element having minimum absolute value in single-complex vector x; that is, the result is the first i, i = 0 to n - 1 that minimizes abs(real(x[1+i*incx]))+abs(imag(x[1 + i * incx])).
cublasIdamax(int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
int idamax (int n, const double *x, int incx) finds the smallest index of the maximum magnitude element of double- precision vector x; that is, the result is the first i, i = 0 to n - 1, that maximizes abs(x[1 + i * incx])).
cublasIdamin(int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
int idamin (int n, const double *x, int incx) finds the smallest index of the minimum magnitude element of double- precision vector x; that is, the result is the first i, i = 0 to n - 1, that minimizes abs(x[1 + i * incx])).
cublasInit() - Static method in class jcuda.jcublas.JCublas
Wrapper for CUBLAS function.
cublasIsamax(int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
int cublasIsamax (int n, const float *x, int incx) finds the smallest index of the maximum magnitude element of single precision vector x; that is, the result is the first i, i = 0 to n - 1, that maximizes abs(x[1 + i * incx])).
cublasIsamin(int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
int cublasIsamin (int n, const float *x, int incx) finds the smallest index of the minimum magnitude element of single precision vector x; that is, the result is the first i, i = 0 to n - 1, that minimizes abs(x[1 + i * incx])).
cublasIzamax(int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
int cublasIzamax (int n, const double *x, int incx) finds the smallest index of the element having maximum absolute value in double-complex vector x; that is, the result is the first i, i = 0 to n - 1 that maximizes abs(real(x[1+i*incx]))+abs(imag(x[1 + i * incx])).
cublasIzamin(int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
int cublasIzamin (int n, const cuDoubleComplex *x, int incx) finds the smallest index of the element having minimum absolute value in double-complex vector x; that is, the result is the first i, i = 0 to n - 1 that minimizes abs(real(x[1+i*incx]))+abs(imag(x[1 + i * incx])).
cublasSasum(int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
float cublasSasum (int n, const float *x, int incx) computes the sum of the absolute values of the elements of single precision vector x; that is, the result is the sum from i = 0 to n - 1 of abs(x[1 + i * incx]).
cublasSaxpy(int, float, Pointer, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasSaxpy (int n, float alpha, const float *x, int incx, float *y, int incy) multiplies single precision vector x by single precision scalar alpha and adds the result to single precision vector y; that is, it overwrites single precision y with single precision alpha * x + y.
cublasScasum(int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
float cublasScasum (int n, const cuDouble *x, int incx) takes the sum of the absolute values of a complex vector and returns a single precision result.
cublasScnrm2(int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
float cublasScnrm2 (int n, const cuComplex *x, int incx) computes the Euclidean norm of the single-complex n-vector x.
cublasScopy(int, Pointer, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasScopy (int n, const float *x, int incx, float *y, int incy) copies the single precision vector x to the single precision vector y.
cublasSdot(int, Pointer, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
float cublasSdot (int n, const float *x, int incx, const float *y, int incy) computes the dot product of two single precision vectors.
cublasSetKernelStream(cudaStream_t) - Static method in class jcuda.jcublas.JCublas
 
cublasSetMatrix(int, int, int, Pointer, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
Wrapper for CUBLAS function.
cublasSetMatrix(int, int, cuComplex[], int, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
Extended wrapper for arrays of cuComplex values.
cublasSetMatrix(int, int, cuDoubleComplex[], int, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
Extended wrapper for arrays of cuDoubleComplex values.
cublasSetMatrixAsync(int, int, int, Pointer, int, Pointer, int, cudaStream_t) - Static method in class jcuda.jcublas.JCublas
 
cublasSetVector(int, int, Pointer, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
Wrapper for CUBLAS function.
cublasSetVector(int, cuComplex[], int, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
Extended wrapper for arrays of cuComplex values.
cublasSetVector(int, cuDoubleComplex[], int, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
Extended wrapper for arrays of cuDoubleComplex values.
cublasSetVectorAsync(int, int, Pointer, int, Pointer, int, cudaStream_t) - Static method in class jcuda.jcublas.JCublas
 
cublasSgbmv(char, int, int, int, int, float, Pointer, int, Pointer, int, float, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasSgbmv (char trans, int m, int n, int kl, int ku, float alpha, const float *A, int lda, const float *x, int incx, float beta, float *y, int incy) performs one of the matrix-vector operations y = alpha*op(A)*x + beta*y, op(A)=A or op(A) = transpose(A) alpha and beta are single precision scalars. x and y are single precision vectors.
cublasSgemm(char, char, int, int, int, float, Pointer, int, Pointer, int, float, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasSgemm (char transa, char transb, int m, int n, int k, float alpha, const float *A, int lda, const float *B, int ldb, float beta, float *C, int ldc) computes the product of matrix A and matrix B, multiplies the result by a scalar alpha, and adds the sum to the product of matrix C and scalar beta. sgemm() performs one of the matrix-matrix operations: C = alpha * op(A) * op(B) + beta * C, where op(X) is one of op(X) = X or op(X) = transpose(X) alpha and beta are single precision scalars, and A, B and C are matrices consisting of single precision elements, with op(A) an m x k matrix, op(B) a k x n matrix, and C an m x n matrix.
cublasSgemv(char, int, int, float, Pointer, int, Pointer, int, float, Pointer, int) - Static method in class jcuda.jcublas.JCublas
cublasSgemv (char trans, int m, int n, float alpha, const float *A, int lda, const float *x, int incx, float beta, float *y, int incy) performs one of the matrix-vector operations y = alpha * op(A) * x + beta * y, where op(A) is one of op(A) = A or op(A) = transpose(A) where alpha and beta are single precision scalars, x and y are single precision vectors, and A is an m x n matrix consisting of single precision elements.
cublasSger(int, int, float, Pointer, int, Pointer, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
cublasSger (int m, int n, float alpha, const float *x, int incx, const float *y, int incy, float *A, int lda) performs the symmetric rank 1 operation A = alpha * x * transpose(y) + A, where alpha is a single precision scalar, x is an m element single precision vector, y is an n element single precision vector, and A is an m by n matrix consisting of single precision elements.
cublasShutdown() - Static method in class jcuda.jcublas.JCublas
Wrapper for CUBLAS function.
cublasSnrm2(int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
float cublasSnrm2 (int n, const float *x, int incx) computes the Euclidean norm of the single precision n-vector x (with storage increment incx).
cublasSrot(int, Pointer, int, Pointer, int, float, float) - Static method in class jcuda.jcublas.JCublas
void cublasSrot (int n, float *x, int incx, float *y, int incy, float sc, float ss) multiplies a 2x2 matrix ( sc ss) with the 2xn matrix ( transpose(x) ) (-ss sc) ( transpose(y) ) The elements of x are in x[lx + i * incx], i = 0 ... n - 1, where lx = 1 if incx >= 0, else lx = 1 + (1 - n) * incx, and similarly for y using ly and incy.
cublasSrotg(Pointer, Pointer, Pointer, Pointer) - Static method in class jcuda.jcublas.JCublas
void cublasSrotg (float *host_sa, float *host_sb, float *host_sc, float *host_ss) constructs the Givens tranformation ( sc ss ) G = ( ) , sc^2 + ss^2 = 1, (-ss sc ) which zeros the second entry of the 2-vector transpose(sa, sb).
cublasSrotm(int, Pointer, int, Pointer, int, float[]) - Static method in class jcuda.jcublas.JCublas
Wrapper for CUBLAS function.
cublasSrotmg(float[], float[], float[], float, float[]) - Static method in class jcuda.jcublas.JCublas
Wrapper for CUBLAS function.
cublasSsbmv(char, int, int, float, Pointer, int, Pointer, int, float, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasSsbmv (char uplo, int n, int k, float alpha, const float *A, int lda, const float *x, int incx, float beta, float *y, int incy) performs the matrix-vector operation y := alpha*A*x + beta*y alpha and beta are single precision scalars. x and y are single precision vectors with n elements.
cublasSscal(int, float, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void sscal (int n, float alpha, float *x, int incx) replaces single precision vector x with single precision alpha * x.
cublasSspmv(char, int, float, Pointer, Pointer, int, float, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasSspmv (char uplo, int n, float alpha, const float *AP, const float *x, int incx, float beta, float *y, int incy) performs the matrix-vector operation y = alpha * A * x + beta * y Alpha and beta are single precision scalars, and x and y are single precision vectors with n elements.
cublasSspr(char, int, float, Pointer, int, Pointer) - Static method in class jcuda.jcublas.JCublas
void cublasSspr (char uplo, int n, float alpha, const float *x, int incx, float *AP) performs the symmetric rank 1 operation A = alpha * x * transpose(x) + A, where alpha is a single precision scalar and x is an n element single precision vector.
cublasSspr2(char, int, float, Pointer, int, Pointer, int, Pointer) - Static method in class jcuda.jcublas.JCublas
void cublasSspr2 (char uplo, int n, float alpha, const float *x, int incx, const float *y, int incy, float *AP) performs the symmetric rank 2 operation A = alpha*x*transpose(y) + alpha*y*transpose(x) + A, where alpha is a single precision scalar, and x and y are n element single precision vectors.
cublasSswap(int, Pointer, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasSswap (int n, float *x, int incx, float *y, int incy) replaces single precision vector x with single precision alpha * x.
cublasSsymm(char, char, int, int, float, Pointer, int, Pointer, int, float, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasSsymm (char side, char uplo, int m, int n, float alpha, const float *A, int lda, const float *B, int ldb, float beta, float *C, int ldc); performs one of the matrix-matrix operations C = alpha * A * B + beta * C, or C = alpha * B * A + beta * C, where alpha and beta are single precision scalars, A is a symmetric matrix consisting of single precision elements and stored in either lower or upper storage mode, and B and C are m x n matrices consisting of single precision elements.
cublasSsymv(char, int, float, Pointer, int, Pointer, int, float, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasSsymv (char uplo, int n, float alpha, const float *A, int lda, const float *x, int incx, float beta, float *y, int incy) performs the matrix-vector operation y = alpha*A*x + beta*y Alpha and beta are single precision scalars, and x and y are single precision vectors, each with n elements.
cublasSsyr(char, int, float, Pointer, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasSsyr (char uplo, int n, float alpha, const float *x, int incx, float *A, int lda) performs the symmetric rank 1 operation A = alpha * x * transpose(x) + A, where alpha is a single precision scalar, x is an n element single precision vector and A is an n x n symmetric matrix consisting of single precision elements.
cublasSsyr2(char, int, float, Pointer, int, Pointer, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasSsyr2 (char uplo, int n, float alpha, const float *x, int incx, const float *y, int incy, float *A, int lda) performs the symmetric rank 2 operation A = alpha*x*transpose(y) + alpha*y*transpose(x) + A, where alpha is a single precision scalar, x and y are n element single precision vector and A is an n by n symmetric matrix consisting of single precision elements.
cublasSsyr2k(char, char, int, int, float, Pointer, int, Pointer, int, float, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasSsyr2k (char uplo, char trans, int n, int k, float alpha, const float *A, int lda, const float *B, int ldb, float beta, float *C, int ldc) performs one of the symmetric rank 2k operations C = alpha * A * transpose(B) + alpha * B * transpose(A) + beta * C, or C = alpha * transpose(A) * B + alpha * transpose(B) * A + beta * C.
cublasSsyrk(char, char, int, int, float, Pointer, int, float, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasSsyrk (char uplo, char trans, int n, int k, float alpha, const float *A, int lda, float beta, float *C, int ldc) performs one of the symmetric rank k operations C = alpha * A * transpose(A) + beta * C, or C = alpha * transpose(A) * A + beta * C.
cublasStatus - Class in jcuda.jcublas
JCublas status return values.
cublasStbmv(char, char, char, int, int, Pointer, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasStbmv (char uplo, char trans, char diag, int n, int k, const float *A, int lda, float *x, int incx) performs one of the matrix-vector operations x = op(A) * x, where op(A) = A or op(A) = transpose(A). x is an n-element single precision vector, and A is an n x n, unit or non-unit upper or lower triangular band matrix consisting of single precision elements.
cublasStbsv(char, char, char, int, int, Pointer, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasStbsv (char uplo, char trans, char diag, int n, int k, const float *A, int lda, float *X, int incx) solves one of the systems of equations op(A)*x = b, where op(A) is either op(A) = A or op(A) = transpose(A). b and x are n-element vectors, and A is an n x n unit or non-unit, upper or lower triangular band matrix with k + 1 diagonals.
cublasStpmv(char, char, char, int, Pointer, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasStpmv (char uplo, char trans, char diag, int n, const float *AP, float *x, int incx); performs one of the matrix-vector operations x = op(A) * x, where op(A) = A, or op(A) = transpose(A). x is an n element single precision vector, and A is an n x n, unit or non-unit, upper or lower triangular matrix composed of single precision elements.
cublasStpsv(char, char, char, int, Pointer, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasStpsv (char uplo, char trans, char diag, int n, const float *AP, float *X, int incx) solves one of the systems of equations op(A)*x = b, where op(A) is either op(A) = A or op(A) = transpose(A). b and x are n element vectors, and A is an n x n unit or non-unit, upper or lower triangular matrix.
cublasStrmm(char, char, char, char, int, int, float, Pointer, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasStrmm (char side, char uplo, char transa, char diag, int m, int n, float alpha, const float *A, int lda, const float *B, int ldb) performs one of the matrix-matrix operations B = alpha * op(A) * B, or B = alpha * B * op(A) where alpha is a single-precision scalar, B is an m x n matrix composed of single precision elements, and A is a unit or non-unit, upper or lower, triangular matrix composed of single precision elements. op(A) is one of op(A) = A or op(A) = transpose(A) Matrices A and B are stored in column major format, and lda and ldb are the leading dimensions of the two-dimensonials arrays that contain A and B, respectively.
cublasStrmv(char, char, char, int, Pointer, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasStrmv (char uplo, char trans, char diag, int n, const float *A, int lda, float *x, int incx); performs one of the matrix-vector operations x = op(A) * x, where op(A) = = A, or op(A) = transpose(A). x is an n-element single precision vector, and A is an n x n, unit or non-unit, upper or lower, triangular matrix composed of single precision elements.
cublasStrsm(char, char, char, char, int, int, float, Pointer, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasStrsm (char side, char uplo, char transa, char diag, int m, int n, float alpha, const float *A, int lda, float *B, int ldb) solves one of the matrix equations op(A) * X = alpha * B, or X * op(A) = alpha * B, where alpha is a single precision scalar, and X and B are m x n matrices that are composed of single precision elements.
cublasStrsv(char, char, char, int, Pointer, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasStrsv (char uplo, char trans, char diag, int n, const float *A, int lda, float *x, int incx) solves a system of equations op(A) * x = b, where op(A) is either A or transpose(A). b and x are single precision vectors consisting of n elements, and A is an n x n matrix composed of a unit or non-unit, upper or lower triangular matrix.
cublasZaxpy(int, cuDoubleComplex, Pointer, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasZaxpy (int n, cuDoubleComplex alpha, const cuDoubleComplex *x, int incx, cuDoubleComplex *y, int incy) multiplies double-complex vector x by double-complex scalar alpha and adds the result to double-complex vector y; that is, it overwrites double-complex y with double-complex alpha * x + y.
cublasZcopy(int, Pointer, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasZcopy (int n, const cuDoubleComplex *x, int incx, cuDoubleComplex *y, int incy) copies the double-complex vector x to the double-complex vector y.
cublasZdrot(int, Pointer, int, Pointer, int, double, double) - Static method in class jcuda.jcublas.JCublas
void zdrot (int n, cuDoubleComplex *x, int incx, cuCumplex *y, int incy, double c, double s) multiplies a 2x2 matrix ( c s) with the 2xn matrix ( transpose(x) ) (-s c) ( transpose(y) ) The elements of x are in x[lx + i * incx], i = 0 ... n - 1, where lx = 1 if incx >= 0, else lx = 1 + (1 - n) * incx, and similarly for y using ly and incy.
cublasZdscal(int, double, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasZdscal (int n, double alpha, cuDoubleComplex *x, int incx) replaces double-complex vector x with double-complex alpha * x.
cublasZgbmv(char, int, int, int, int, cuDoubleComplex, Pointer, int, Pointer, int, cuDoubleComplex, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasZgbmv (char trans, int m, int n, int kl, int ku, cuDoubleComplex alpha, const cuDoubleComplex *A, int lda, const cuDoubleComplex *x, int incx, cuDoubleComplex beta, cuDoubleComplex *y, int incy); performs one of the matrix-vector operations y = alpha*op(A)*x + beta*y, op(A)=A or op(A) = transpose(A) alpha and beta are double precision complex scalars. x and y are double precision complex vectors.
cublasZgemm(char, char, int, int, int, cuDoubleComplex, Pointer, int, Pointer, int, cuDoubleComplex, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasZgemm (char transa, char transb, int m, int n, int k, cuDoubleComplex alpha, const cuDoubleComplex *A, int lda, const cuDoubleComplex *B, int ldb, cuDoubleComplex beta, cuDoubleComplex *C, int ldc) zgemm performs one of the matrix-matrix operations C = alpha * op(A) * op(B) + beta*C, where op(X) is one of op(X) = X or op(X) = transpose or op(X) = conjg(transpose(X)) alpha and beta are double-complex scalars, and A, B and C are matrices consisting of double-complex elements, with op(A) an m x k matrix, op(B) a k x n matrix and C an m x n matrix.
cublasZgemv(char, int, int, cuDoubleComplex, Pointer, int, Pointer, int, cuDoubleComplex, Pointer, int) - Static method in class jcuda.jcublas.JCublas
cublasZgemv (char trans, int m, int n, cuDoubleComplex alpha, const cuDoubleComplex *A, int lda, const cuDoubleComplex *x, int incx, cuDoubleComplex beta, cuDoubleComplex *y, int incy) performs one of the matrix-vector operations y = alpha * op(A) * x + beta * y, where op(A) is one of op(A) = A or op(A) = transpose(A) where alpha and beta are double precision scalars, x and y are double precision vectors, and A is an m x n matrix consisting of double precision elements.
cublasZgerc(int, int, cuDoubleComplex, Pointer, int, Pointer, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
cublasZgerc (int m, int n, cuDoubleComplex alpha, const cuDoubleComplex *x, int incx, const cuDoubleComplex *y, int incy, cuDoubleComplex *A, int lda) performs the symmetric rank 1 operation A = alpha * x * conjugate(transpose(y)) + A, where alpha is a double precision complex scalar, x is an m element double precision complex vector, y is an n element double precision complex vector, and A is an m by n matrix consisting of double precision complex elements.
cublasZgeru(int, int, cuDoubleComplex, Pointer, int, Pointer, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
cublasZgeru (int m, int n, cuDoubleComplex alpha, const cuDoubleComplex *x, int incx, const cuDoubleComplex *y, int incy, cuDoubleComplex *A, int lda) performs the symmetric rank 1 operation A = alpha * x * transpose(y) + A, where alpha is a double precision complex scalar, x is an m element double precision complex vector, y is an n element double precision complex vector, and A is an m by n matrix consisting of double precision complex elements.
cublasZhbmv(char, int, int, cuDoubleComplex, Pointer, int, Pointer, int, cuDoubleComplex, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasZhbmv (char uplo, int n, int k, cuDoubleComplex alpha, const cuDoubleComplex *A, int lda, const cuDoubleComplex *x, int incx, cuDoubleComplex beta, cuDoubleComplex *y, int incy) performs the matrix-vector operation y := alpha*A*x + beta*y alpha and beta are double precision complex scalars. x and y are double precision complex vectors with n elements.
cublasZhemm(char, char, int, int, cuDoubleComplex, Pointer, int, Pointer, int, cuDoubleComplex, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasZhemm (char side, char uplo, int m, int n, cuDoubleComplex alpha, const cuDoubleComplex *A, int lda, const cuDoubleComplex *B, int ldb, cuDoubleComplex beta, cuDoubleComplex *C, int ldc); performs one of the matrix-matrix operations C = alpha * A * B + beta * C, or C = alpha * B * A + beta * C, where alpha and beta are double precision complex scalars, A is a hermitian matrix consisting of double precision complex elements and stored in either lower or upper storage mode, and B and C are m x n matrices consisting of double precision complex elements.
cublasZhemv(char, int, cuDoubleComplex, Pointer, int, Pointer, int, cuDoubleComplex, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasZhemv (char uplo, int n, cuDoubleComplex alpha, const cuDoubleComplex *A, int lda, const cuDoubleComplex *x, int incx, cuDoubleComplex beta, cuDoubleComplex *y, int incy) performs the matrix-vector operation y = alpha*A*x + beta*y Alpha and beta are double precision complex scalars, and x and y are double precision complex vectors, each with n elements.
cublasZher(char, int, double, Pointer, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasZher (char uplo, int n, double alpha, const cuDoubleComplex *x, int incx, cuDoubleComplex *A, int lda) performs the hermitian rank 1 operation A = alpha * x * conjugate(transpose(x)) + A, where alpha is a double precision real scalar, x is an n element double precision complex vector and A is an n x n hermitian matrix consisting of double precision complex elements.
cublasZher2(char, int, cuDoubleComplex, Pointer, int, Pointer, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasZher2 (char uplo, int n, cuDoubleComplex alpha, const cuDoubleComplex *x, int incx, const cuDoubleComplex *y, int incy, cuDoubleComplex *A, int lda) performs the hermitian rank 2 operation A = alpha*x*conjugate(transpose(y)) + conjugate(alpha)*y*conjugate(transpose(x)) + A, where alpha is a double precision complex scalar, x and y are n element double precision complex vector and A is an n by n hermitian matrix consisting of double precision complex elements.
cublasZher2k(char, char, int, int, cuDoubleComplex, Pointer, int, Pointer, int, double, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasZher2k (char uplo, char trans, int n, int k, cuDoubleComplex alpha, const cuDoubleComplex *A, int lda, const cuDoubleComplex *B, int ldb, double beta, cuDoubleComplex *C, int ldc) performs one of the hermitian rank 2k operations C = alpha * A * conjugate(transpose(B)) + conjugate(alpha) * B * conjugate(transpose(A)) + beta * C , or C = alpha * conjugate(transpose(A)) * B + conjugate(alpha) * conjugate(transpose(B)) * A + beta * C.
cublasZherk(char, char, int, int, double, Pointer, int, double, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasZherk (char uplo, char trans, int n, int k, double alpha, const cuDoubleComplex *A, int lda, double beta, cuDoubleComplex *C, int ldc) performs one of the hermitian rank k operations C = alpha * A * conjugate(transpose(A)) + beta * C, or C = alpha * conjugate(transpose(A)) * A + beta * C.
cublasZhpmv(char, int, cuDoubleComplex, Pointer, Pointer, int, cuDoubleComplex, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasZhpmv (char uplo, int n, cuDoubleComplex alpha, const cuDoubleComplex *AP, const cuDoubleComplex *x, int incx, cuDoubleComplex beta, cuDoubleComplex *y, int incy) performs the matrix-vector operation y = alpha * A * x + beta * y Alpha and beta are double precision complex scalars, and x and y are double precision complex vectors with n elements.
cublasZhpr(char, int, double, Pointer, int, Pointer) - Static method in class jcuda.jcublas.JCublas
void cublasZhpr (char uplo, int n, double alpha, const cuDoubleComplex *x, int incx, cuDoubleComplex *AP) performs the hermitian rank 1 operation A = alpha * x * conjugate(transpose(x)) + A, where alpha is a double precision real scalar and x is an n element double precision complex vector.
cublasZhpr2(char, int, cuDoubleComplex, Pointer, int, Pointer, int, Pointer) - Static method in class jcuda.jcublas.JCublas
void cublasZhpr2 (char uplo, int n, cuDoubleComplex alpha, const cuDoubleComplex *x, int incx, const cuDoubleComplex *y, int incy, cuDoubleComplex *AP) performs the hermitian rank 2 operation A = alpha*x*conjugate(transpose(y)) + conjugate(alpha)*y*conjugate(transpose(x)) + A, where alpha is a double precision complex scalar, and x and y are n element double precision complex vectors.
cublasZrot(int, Pointer, int, Pointer, int, double, cuDoubleComplex) - Static method in class jcuda.jcublas.JCublas
cublasZrot (int n, cuDoubleComplex *x, int incx, cuDoubleComplex *y, int incy, double sc, cuDoubleComplex cs) multiplies a 2x2 matrix ( sc cs) with the 2xn matrix ( transpose(x) ) (-conj(cs) sc) ( transpose(y) ) The elements of x are in x[lx + i * incx], i = 0 ... n - 1, where lx = 1 if incx >= 0, else lx = 1 + (1 - n) * incx, and similarly for y using ly and incy.
cublasZrotg(Pointer, cuDoubleComplex, Pointer, Pointer) - Static method in class jcuda.jcublas.JCublas
void cublasZrotg (cuDoubleComplex *host_ca, cuDoubleComplex cb, double *host_sc, double *host_cs) constructs the complex Givens tranformation ( sc cs ) G = ( ) , sc^2 + cabs(cs)^2 = 1, (-cs sc ) which zeros the second entry of the complex 2-vector transpose(ca, cb).
cublasZscal(int, cuDoubleComplex, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasZscal (int n, cuComplex alpha, cuComplex *x, int incx) replaces double-complex vector x with double-complex alpha * x.
cublasZswap(int, Pointer, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasZswap (int n, const cuDoubleComplex *x, int incx, cuDoubleComplex *y, int incy) interchanges the double-complex vector x with the double-complex vector y.
cublasZsymm(char, char, int, int, cuDoubleComplex, Pointer, int, Pointer, int, cuDoubleComplex, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasZsymm (char side, char uplo, int m, int n, cuDoubleComplex alpha, const cuDoubleComplex *A, int lda, const cuDoubleComplex *B, int ldb, cuDoubleComplex beta, cuDoubleComplex *C, int ldc); performs one of the matrix-matrix operations C = alpha * A * B + beta * C, or C = alpha * B * A + beta * C, where alpha and beta are double precision complex scalars, A is a symmetric matrix consisting of double precision complex elements and stored in either lower or upper storage mode, and B and C are m x n matrices consisting of double precision complex elements.
cublasZsyr2k(char, char, int, int, cuDoubleComplex, Pointer, int, Pointer, int, cuDoubleComplex, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasZsyr2k (char uplo, char trans, int n, int k, cuDoubleComplex alpha, const cuDoubleComplex *A, int lda, const cuDoubleComplex *B, int ldb, cuDoubleComplex beta, cuDoubleComplex *C, int ldc) performs one of the symmetric rank 2k operations C = alpha * A * transpose(B) + alpha * B * transpose(A) + beta * C, or C = alpha * transpose(A) * B + alpha * transpose(B) * A + beta * C.
cublasZsyrk(char, char, int, int, cuDoubleComplex, Pointer, int, cuDoubleComplex, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasZsyrk (char uplo, char trans, int n, int k, cuDoubleComplex alpha, const cuDoubleComplex *A, int lda, cuDoubleComplex beta, cuDoubleComplex *C, int ldc) performs one of the symmetric rank k operations C = alpha * A * transpose(A) + beta * C, or C = alpha * transpose(A) * A + beta * C.
cublasZtbmv(char, char, char, int, int, Pointer, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasZtbmv (char uplo, char trans, char diag, int n, int k, const cuDoubleComplex *A, int lda, cuDoubleComplex *x, int incx) performs one of the matrix-vector operations x = op(A) * x, where op(A) = A, op(A) = transpose(A) or op(A) = conjugate(transpose(A)). x is an n-element double precision complex vector, and A is an n x n, unit or non-unit, upper or lower triangular band matrix composed of double precision complex elements.
cublasZtbsv(char, char, char, int, int, Pointer, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasZtbsv (char uplo, char trans, char diag, int n, int k, const cuDoubleComplex *A, int lda, cuDoubleComplex *X, int incx) solves one of the systems of equations op(A)*x = b, where op(A) is either op(A) = A , op(A) = transpose(A) or op(A) = conjugate(transpose(A)).
cublasZtpmv(char, char, char, int, Pointer, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasZtpmv (char uplo, char trans, char diag, int n, const cuDoubleComplex *AP, cuDoubleComplex *x, int incx); performs one of the matrix-vector operations x = op(A) * x, where op(A) = A, op(A) = transpose(A) or op(A) = conjugate(transpose(A)) . x is an n element double precision complex vector, and A is an n x n, unit or non-unit, upper or lower triangular matrix composed of double precision complex elements.
cublasZtpsv(char, char, char, int, Pointer, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasZtpsv (char uplo, char trans, char diag, int n, const cuDoubleComplex *AP, cuDoubleComplex *X, int incx) solves one of the systems of equations op(A)*x = b, where op(A) is either op(A) = A , op(A) = transpose(A) or op(A) = conjugate(transpose)). b and x are n element complex vectors, and A is an n x n unit or non-unit, upper or lower triangular matrix.
cublasZtrmm(char, char, char, char, int, int, cuDoubleComplex, Pointer, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasZtrmm (char side, char uplo, char transa, char diag, int m, int n, cuDoubleComplex alpha, const cuDoubleComplex *A, int lda, const cuDoubleComplex *B, int ldb) performs one of the matrix-matrix operations B = alpha * op(A) * B, or B = alpha * B * op(A) where alpha is a double-precision complex scalar, B is an m x n matrix composed of double precision complex elements, and A is a unit or non-unit, upper or lower, triangular matrix composed of double precision complex elements. op(A) is one of op(A) = A , op(A) = transpose(A) or op(A) = conjugate(transpose(A)) Matrices A and B are stored in column major format, and lda and ldb are the leading dimensions of the two-dimensonials arrays that contain A and B, respectively.
cublasZtrmv(char, char, char, int, Pointer, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasZtrmv (char uplo, char trans, char diag, int n, const cuDoubleComplex *A, int lda, cuDoubleComplex *x, int incx); performs one of the matrix-vector operations x = op(A) * x, where op(A) = A, or op(A) = transpose(A) or op(A) = conjugate(transpose(A)).
cublasZtrsm(char, char, char, char, int, int, cuDoubleComplex, Pointer, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasZtrsm (char side, char uplo, char transa, char diag, int m, int n, cuDoubleComplex alpha, const cuDoubleComplex *A, int lda, cuDoubleComplex *B, int ldb) solves one of the matrix equations op(A) * X = alpha * B, or X * op(A) = alpha * B, where alpha is a double precision complex scalar, and X and B are m x n matrices that are composed of double precision complex elements.
cublasZtrsv(char, char, char, int, Pointer, int, Pointer, int) - Static method in class jcuda.jcublas.JCublas
void cublasZtrsv (char uplo, char trans, char diag, int n, const cuDoubleComplex *A, int lda, cuDoubleComplex *x, int incx) solves a system of equations op(A) * x = b, where op(A) is either A, transpose(A) or conjugate(transpose(A)). b and x are double precision complex vectors consisting of n elements, and A is an n x n matrix composed of a unit or non-unit, upper or lower triangular matrix.

C I J P S