lapack_int LAPACKE_dstedc( int matrix_order, char compz, lapack_int n, double* d, double* e, double* z, lapack_int ldz ) { lapack_int info = 0; lapack_int liwork = -1; lapack_int lwork = -1; lapack_int* iwork = NULL; double* work = NULL; lapack_int iwork_query; double work_query; if( matrix_order != LAPACK_COL_MAJOR && matrix_order != LAPACK_ROW_MAJOR ) { LAPACKE_xerbla( "LAPACKE_dstedc", -1 ); return -1; } #ifndef LAPACK_DISABLE_NAN_CHECK /* Optionally check input matrices for NaNs */ if( LAPACKE_d_nancheck( n, d, 1 ) ) { return -4; } if( LAPACKE_d_nancheck( n-1, e, 1 ) ) { return -5; } if( LAPACKE_lsame( compz, 'i' ) || LAPACKE_lsame( compz, 'v' ) ) { if( LAPACKE_dge_nancheck( matrix_order, n, n, z, ldz ) ) { return -6; } } #endif /* Query optimal working array(s) size */ info = LAPACKE_dstedc_work( matrix_order, compz, n, d, e, z, ldz, &work_query, lwork, &iwork_query, liwork ); if( info != 0 ) { goto exit_level_0; } liwork = (lapack_int)iwork_query; lwork = (lapack_int)work_query; /* Allocate memory for work arrays */ iwork = (lapack_int*)LAPACKE_malloc( sizeof(lapack_int) * liwork ); if( iwork == NULL ) { info = LAPACK_WORK_MEMORY_ERROR; goto exit_level_0; } work = (double*)LAPACKE_malloc( sizeof(double) * lwork ); if( work == NULL ) { info = LAPACK_WORK_MEMORY_ERROR; goto exit_level_1; } /* Call middle-level interface */ info = LAPACKE_dstedc_work( matrix_order, compz, n, d, e, z, ldz, work, lwork, iwork, liwork ); /* Release memory and exit */ LAPACKE_free( work ); exit_level_1: LAPACKE_free( iwork ); exit_level_0: if( info == LAPACK_WORK_MEMORY_ERROR ) { LAPACKE_xerbla( "LAPACKE_dstedc", info ); } return info; }
lapack_int LAPACKE_dsfrk( int matrix_layout, char transr, char uplo, char trans, lapack_int n, lapack_int k, double alpha, const double* a, lapack_int lda, double beta, double* c ) { lapack_int ka, na; if( matrix_layout != LAPACK_COL_MAJOR && matrix_layout != LAPACK_ROW_MAJOR ) { LAPACKE_xerbla( "LAPACKE_dsfrk", -1 ); return -1; } #ifndef LAPACK_DISABLE_NAN_CHECK /* Optionally check input matrices for NaNs */ ka = LAPACKE_lsame( trans, 'n' ) ? k : n; na = LAPACKE_lsame( trans, 'n' ) ? n : k; if( LAPACKE_dge_nancheck( matrix_layout, na, ka, a, lda ) ) { return -8; } if( LAPACKE_d_nancheck( 1, &alpha, 1 ) ) { return -7; } if( LAPACKE_d_nancheck( 1, &beta, 1 ) ) { return -10; } if( LAPACKE_dpf_nancheck( n, c ) ) { return -11; } #endif return LAPACKE_dsfrk_work( matrix_layout, transr, uplo, trans, n, k, alpha, a, lda, beta, c ); }
lapack_int LAPACKE_zptcon( lapack_int n, const double* d, const lapack_complex_double* e, double anorm, double* rcond ) { lapack_int info = 0; double* work = NULL; #ifndef LAPACK_DISABLE_NAN_CHECK /* Optionally check input matrices for NaNs */ if( LAPACKE_d_nancheck( 1, &anorm, 1 ) ) { return -4; } if( LAPACKE_d_nancheck( n, d, 1 ) ) { return -2; } if( LAPACKE_z_nancheck( n-1, e, 1 ) ) { return -3; } #endif /* Allocate memory for working array(s) */ work = (double*)LAPACKE_malloc( sizeof(double) * MAX(1,n) ); if( work == NULL ) { info = LAPACK_WORK_MEMORY_ERROR; goto exit_level_0; } /* Call middle-level interface */ info = LAPACKE_zptcon_work( n, d, e, anorm, rcond, work ); /* Release memory and exit */ LAPACKE_free( work ); exit_level_0: if( info == LAPACK_WORK_MEMORY_ERROR ) { LAPACKE_xerbla( "LAPACKE_zptcon", info ); } return info; }
lapack_int LAPACKE_dggbak( int matrix_layout, char job, char side, lapack_int n, lapack_int ilo, lapack_int ihi, const double* lscale, const double* rscale, lapack_int m, double* v, lapack_int ldv ) { if( matrix_layout != LAPACK_COL_MAJOR && matrix_layout != LAPACK_ROW_MAJOR ) { LAPACKE_xerbla( "LAPACKE_dggbak", -1 ); return -1; } #ifndef LAPACK_DISABLE_NAN_CHECK if( LAPACKE_get_nancheck() ) { /* Optionally check input matrices for NaNs */ if( LAPACKE_d_nancheck( n, lscale, 1 ) ) { return -7; } if( LAPACKE_d_nancheck( n, rscale, 1 ) ) { return -8; } if( LAPACKE_dge_nancheck( matrix_layout, n, m, v, ldv ) ) { return -10; } } #endif return LAPACKE_dggbak_work( matrix_layout, job, side, n, ilo, ihi, lscale, rscale, m, v, ldv ); }
lapack_logical LAPACKE_dst_nancheck( lapack_int n, const double *d, const double *e ) { return LAPACKE_d_nancheck( n, d, 1 ) || LAPACKE_d_nancheck( n-1, e, 1 ); }
lapack_int LAPACKE_dsbevx( int matrix_layout, char jobz, char range, char uplo, lapack_int n, lapack_int kd, double* ab, lapack_int ldab, double* q, lapack_int ldq, double vl, double vu, lapack_int il, lapack_int iu, double abstol, lapack_int* m, double* w, double* z, lapack_int ldz, lapack_int* ifail ) { lapack_int info = 0; lapack_int* iwork = NULL; double* work = NULL; if( matrix_layout != LAPACK_COL_MAJOR && matrix_layout != LAPACK_ROW_MAJOR ) { LAPACKE_xerbla( "LAPACKE_dsbevx", -1 ); return -1; } #ifndef LAPACK_DISABLE_NAN_CHECK /* Optionally check input matrices for NaNs */ if( LAPACKE_dsb_nancheck( matrix_layout, uplo, n, kd, ab, ldab ) ) { return -7; } if( LAPACKE_d_nancheck( 1, &abstol, 1 ) ) { return -15; } if( LAPACKE_lsame( range, 'v' ) ) { if( LAPACKE_d_nancheck( 1, &vl, 1 ) ) { return -11; } } if( LAPACKE_lsame( range, 'v' ) ) { if( LAPACKE_d_nancheck( 1, &vu, 1 ) ) { return -12; } } #endif /* Allocate memory for working array(s) */ iwork = (lapack_int*)LAPACKE_malloc( sizeof(lapack_int) * MAX(1,5*n) ); if( iwork == NULL ) { info = LAPACK_WORK_MEMORY_ERROR; goto exit_level_0; } work = (double*)LAPACKE_malloc( sizeof(double) * MAX(1,7*n) ); if( work == NULL ) { info = LAPACK_WORK_MEMORY_ERROR; goto exit_level_1; } /* Call middle-level interface */ info = LAPACKE_dsbevx_work( matrix_layout, jobz, range, uplo, n, kd, ab, ldab, q, ldq, vl, vu, il, iu, abstol, m, w, z, ldz, work, iwork, ifail ); /* Release memory and exit */ LAPACKE_free( work ); exit_level_1: LAPACKE_free( iwork ); exit_level_0: if( info == LAPACK_WORK_MEMORY_ERROR ) { LAPACKE_xerbla( "LAPACKE_dsbevx", info ); } return info; }
lapack_int LAPACKE_dbdsdc( int matrix_layout, char uplo, char compq, lapack_int n, double* d, double* e, double* u, lapack_int ldu, double* vt, lapack_int ldvt, double* q, lapack_int* iq ) { lapack_int info = 0; /* Additional scalars declarations for work arrays */ size_t lwork; lapack_int* iwork = NULL; double* work = NULL; if( matrix_layout != LAPACK_COL_MAJOR && matrix_layout != LAPACK_ROW_MAJOR ) { LAPACKE_xerbla( "LAPACKE_dbdsdc", -1 ); return -1; } #ifndef LAPACK_DISABLE_NAN_CHECK /* Optionally check input matrices for NaNs */ if( LAPACKE_d_nancheck( n, d, 1 ) ) { return -5; } if( LAPACKE_d_nancheck( n, e, 1 ) ) { return -6; } #endif /* Additional scalars initializations for work arrays */ if( LAPACKE_lsame( compq, 'i' ) ) { lwork = (size_t)3*MAX(1,n)*MAX(1,n)+4*MAX(1,n); } else if( LAPACKE_lsame( compq, 'p' ) ) { lwork = MAX(1,6*n); } else if( LAPACKE_lsame( compq, 'n' ) ) { lwork = MAX(1,4*n); } else { lwork = 1; /* Any value */ } /* Allocate memory for working array(s) */ iwork = (lapack_int*)LAPACKE_malloc( sizeof(lapack_int) * MAX(1,8*n) ); if( iwork == NULL ) { info = LAPACK_WORK_MEMORY_ERROR; goto exit_level_0; } work = (double*)LAPACKE_malloc( sizeof(double) * lwork ); if( work == NULL ) { info = LAPACK_WORK_MEMORY_ERROR; goto exit_level_1; } /* Call middle-level interface */ info = LAPACKE_dbdsdc_work( matrix_layout, uplo, compq, n, d, e, u, ldu, vt, ldvt, q, iq, work, iwork ); /* Release memory and exit */ LAPACKE_free( work ); exit_level_1: LAPACKE_free( iwork ); exit_level_0: if( info == LAPACK_WORK_MEMORY_ERROR ) { LAPACKE_xerbla( "LAPACKE_dbdsdc", info ); } return info; }
lapack_logical LAPACKE_dgt_nancheck( lapack_int n, const double *dl, const double *d, const double *du ) { return LAPACKE_d_nancheck( n-1, dl, 1 ) || LAPACKE_d_nancheck( n , d, 1 ) || LAPACKE_d_nancheck( n-1, du, 1 ); }
lapack_int LAPACKE_dbdsqr( int matrix_layout, char uplo, lapack_int n, lapack_int ncvt, lapack_int nru, lapack_int ncc, double* d, double* e, double* vt, lapack_int ldvt, double* u, lapack_int ldu, double* c, lapack_int ldc ) { lapack_int info = 0; double* work = NULL; if( matrix_layout != LAPACK_COL_MAJOR && matrix_layout != LAPACK_ROW_MAJOR ) { LAPACKE_xerbla( "LAPACKE_dbdsqr", -1 ); return -1; } #ifndef LAPACK_DISABLE_NAN_CHECK /* Optionally check input matrices for NaNs */ if( ncc != 0 ) { if( LAPACKE_dge_nancheck( matrix_layout, n, ncc, c, ldc ) ) { return -13; } } if( LAPACKE_d_nancheck( n, d, 1 ) ) { return -7; } if( LAPACKE_d_nancheck( n-1, e, 1 ) ) { return -8; } if( nru != 0 ) { if( LAPACKE_dge_nancheck( matrix_layout, nru, n, u, ldu ) ) { return -11; } } if( ncvt != 0 ) { if( LAPACKE_dge_nancheck( matrix_layout, n, ncvt, vt, ldvt ) ) { return -9; } } #endif /* Allocate memory for working array(s) */ work = (double*)LAPACKE_malloc( sizeof(double) * MAX(1,4*n) ); if( work == NULL ) { info = LAPACK_WORK_MEMORY_ERROR; goto exit_level_0; } /* Call middle-level interface */ info = LAPACKE_dbdsqr_work( matrix_layout, uplo, n, ncvt, nru, ncc, d, e, vt, ldvt, u, ldu, c, ldc, work ); /* Release memory and exit */ LAPACKE_free( work ); exit_level_0: if( info == LAPACK_WORK_MEMORY_ERROR ) { LAPACKE_xerbla( "LAPACKE_dbdsqr", info ); } return info; }
lapack_int LAPACKE_dgglse( int matrix_order, lapack_int m, lapack_int n, lapack_int p, double* a, lapack_int lda, double* b, lapack_int ldb, double* c, double* d, double* x ) { lapack_int info = 0; lapack_int lwork = -1; double* work = NULL; double work_query; if( matrix_order != LAPACK_COL_MAJOR && matrix_order != LAPACK_ROW_MAJOR ) { LAPACKE_xerbla( "LAPACKE_dgglse", -1 ); return -1; } #ifndef LAPACK_DISABLE_NAN_CHECK /* Optionally check input matrices for NaNs */ if( LAPACKE_dge_nancheck( matrix_order, m, n, a, lda ) ) { return -5; } if( LAPACKE_dge_nancheck( matrix_order, p, n, b, ldb ) ) { return -7; } if( LAPACKE_d_nancheck( m, c, 1 ) ) { return -9; } if( LAPACKE_d_nancheck( p, d, 1 ) ) { return -10; } #endif /* Query optimal working array(s) size */ info = LAPACKE_dgglse_work( matrix_order, m, n, p, a, lda, b, ldb, c, d, x, &work_query, lwork ); if( info != 0 ) { goto exit_level_0; } lwork = (lapack_int)work_query; /* Allocate memory for work arrays */ work = (double*)LAPACKE_malloc( sizeof(double) * lwork ); if( work == NULL ) { info = LAPACK_WORK_MEMORY_ERROR; goto exit_level_0; } /* Call middle-level interface */ info = LAPACKE_dgglse_work( matrix_order, m, n, p, a, lda, b, ldb, c, d, x, work, lwork ); /* Release memory and exit */ LAPACKE_free( work ); exit_level_0: if( info == LAPACK_WORK_MEMORY_ERROR ) { LAPACKE_xerbla( "LAPACKE_dgglse", info ); } return info; }
lapack_int LAPACKE_dlarfg( lapack_int n, double* alpha, double* x, lapack_int incx, double* tau ) { #ifndef LAPACK_DISABLE_NAN_CHECK /* Optionally check input matrices for NaNs */ if( LAPACKE_d_nancheck( 1, alpha, 1 ) ) { return -2; } if( LAPACKE_d_nancheck( 1+(n-2)*ABS(incx), x, incx ) ) { return -3; } #endif return LAPACKE_dlarfg_work( n, alpha, x, incx, tau ); }
lapack_int LAPACKE_dlartgp( double f, double g, double* cs, double* sn, double* r ) { #ifndef LAPACK_DISABLE_NAN_CHECK /* Optionally check input matrices for NaNs */ if( LAPACKE_d_nancheck( 1, &f, 1 ) ) { return -1; } if( LAPACKE_d_nancheck( 1, &g, 1 ) ) { return -2; } #endif return LAPACKE_dlartgp_work( f, g, cs, sn, r ); }
lapack_int LAPACKE_dptrfs( int matrix_order, lapack_int n, lapack_int nrhs, const double* d, const double* e, const double* df, const double* ef, const double* b, lapack_int ldb, double* x, lapack_int ldx, double* ferr, double* berr ) { lapack_int info = 0; double* work = NULL; if( matrix_order != LAPACK_COL_MAJOR && matrix_order != LAPACK_ROW_MAJOR ) { LAPACKE_xerbla( "LAPACKE_dptrfs", -1 ); return -1; } #ifndef LAPACK_DISABLE_NAN_CHECK /* Optionally check input matrices for NaNs */ if( LAPACKE_dge_nancheck( matrix_order, n, nrhs, b, ldb ) ) { return -8; } if( LAPACKE_d_nancheck( n, d, 1 ) ) { return -4; } if( LAPACKE_d_nancheck( n, df, 1 ) ) { return -6; } if( LAPACKE_d_nancheck( n-1, e, 1 ) ) { return -5; } if( LAPACKE_d_nancheck( n-1, ef, 1 ) ) { return -7; } if( LAPACKE_dge_nancheck( matrix_order, n, nrhs, x, ldx ) ) { return -10; } #endif /* Allocate memory for working array(s) */ work = (double*)LAPACKE_malloc( sizeof(double) * MAX(1,2*n) ); if( work == NULL ) { info = LAPACK_WORK_MEMORY_ERROR; goto exit_level_0; } /* Call middle-level interface */ info = LAPACKE_dptrfs_work( matrix_order, n, nrhs, d, e, df, ef, b, ldb, x, ldx, ferr, berr, work ); /* Release memory and exit */ LAPACKE_free( work ); exit_level_0: if( info == LAPACK_WORK_MEMORY_ERROR ) { LAPACKE_xerbla( "LAPACKE_dptrfs", info ); } return info; }
lapack_int LAPACKE_dgtcon( char norm, lapack_int n, const double* dl, const double* d, const double* du, const double* du2, const lapack_int* ipiv, double anorm, double* rcond ) { lapack_int info = 0; lapack_int* iwork = NULL; double* work = NULL; #ifndef LAPACK_DISABLE_NAN_CHECK /* Optionally check input matrices for NaNs */ if( LAPACKE_d_nancheck( 1, &anorm, 1 ) ) { return -8; } if( LAPACKE_d_nancheck( n, d, 1 ) ) { return -4; } if( LAPACKE_d_nancheck( n-1, dl, 1 ) ) { return -3; } if( LAPACKE_d_nancheck( n-1, du, 1 ) ) { return -5; } if( LAPACKE_d_nancheck( n-2, du2, 1 ) ) { return -6; } #endif /* Allocate memory for working array(s) */ iwork = (lapack_int*)LAPACKE_malloc( sizeof(lapack_int) * MAX(1,n) ); if( iwork == NULL ) { info = LAPACK_WORK_MEMORY_ERROR; goto exit_level_0; } work = (double*)LAPACKE_malloc( sizeof(double) * MAX(1,2*n) ); if( work == NULL ) { info = LAPACK_WORK_MEMORY_ERROR; goto exit_level_1; } /* Call middle-level interface */ info = LAPACKE_dgtcon_work( norm, n, dl, d, du, du2, ipiv, anorm, rcond, work, iwork ); /* Release memory and exit */ LAPACKE_free( work ); exit_level_1: LAPACKE_free( iwork ); exit_level_0: if( info == LAPACK_WORK_MEMORY_ERROR ) { LAPACKE_xerbla( "LAPACKE_dgtcon", info ); } return info; }
lapack_int LAPACKE_zstein( int matrix_order, lapack_int n, const double* d, const double* e, lapack_int m, const double* w, const lapack_int* iblock, const lapack_int* isplit, lapack_complex_double* z, lapack_int ldz, lapack_int* ifailv ) { lapack_int info = 0; lapack_int* iwork = NULL; double* work = NULL; if( matrix_order != LAPACK_COL_MAJOR && matrix_order != LAPACK_ROW_MAJOR ) { LAPACKE_xerbla( "LAPACKE_zstein", -1 ); return -1; } #ifndef LAPACK_DISABLE_NAN_CHECK /* Optionally check input matrices for NaNs */ if( LAPACKE_d_nancheck( n, d, 1 ) ) { return -3; } if( LAPACKE_d_nancheck( n, e, 1 ) ) { return -4; } if( LAPACKE_d_nancheck( n, w, 1 ) ) { return -6; } #endif /* Allocate memory for working array(s) */ iwork = (lapack_int*)LAPACKE_malloc( sizeof(lapack_int) * MAX(1,n) ); if( iwork == NULL ) { info = LAPACK_WORK_MEMORY_ERROR; goto exit_level_0; } work = (double*)LAPACKE_malloc( sizeof(double) * MAX(1,5*n) ); if( work == NULL ) { info = LAPACK_WORK_MEMORY_ERROR; goto exit_level_1; } /* Call middle-level interface */ info = LAPACKE_zstein_work( matrix_order, n, d, e, m, w, iblock, isplit, z, ldz, work, iwork, ifailv ); /* Release memory and exit */ LAPACKE_free( work ); exit_level_1: LAPACKE_free( iwork ); exit_level_0: if( info == LAPACK_WORK_MEMORY_ERROR ) { LAPACKE_xerbla( "LAPACKE_zstein", info ); } return info; }
double LAPACKE_dlapy2( double x, double y ) { #ifndef LAPACK_DISABLE_NAN_CHECK if( LAPACKE_get_nancheck() ) { /* Optionally check input matrices for NaNs */ if( LAPACKE_d_nancheck( 1, &x, 1 ) ) { return -1; } if( LAPACKE_d_nancheck( 1, &y, 1 ) ) { return -2; } } #endif return LAPACKE_dlapy2_work( x, y ); }
lapack_int LAPACKE_zpteqr( int matrix_order, char compz, lapack_int n, double* d, double* e, lapack_complex_double* z, lapack_int ldz ) { lapack_int info = 0; /* Additional scalars declarations for work arrays */ lapack_int lwork; double* work = NULL; if( matrix_order != LAPACK_COL_MAJOR && matrix_order != LAPACK_ROW_MAJOR ) { LAPACKE_xerbla( "LAPACKE_zpteqr", -1 ); return -1; } #ifndef LAPACK_DISABLE_NAN_CHECK /* Optionally check input matrices for NaNs */ if( LAPACKE_d_nancheck( n, d, 1 ) ) { return -4; } if( LAPACKE_d_nancheck( n-1, e, 1 ) ) { return -5; } if( LAPACKE_lsame( compz, 'v' ) ) { if( LAPACKE_zge_nancheck( matrix_order, n, n, z, ldz ) ) { return -6; } } #endif /* Additional scalars initializations for work arrays */ if( LAPACKE_lsame( compz, 'n' ) ) { lwork = 1; } else { lwork = MAX(1,4*n-4); } /* Allocate memory for working array(s) */ work = (double*)LAPACKE_malloc( sizeof(double) * lwork ); if( work == NULL ) { info = LAPACK_WORK_MEMORY_ERROR; goto exit_level_0; } /* Call middle-level interface */ info = LAPACKE_zpteqr_work( matrix_order, compz, n, d, e, z, ldz, work ); /* Release memory and exit */ LAPACKE_free( work ); exit_level_0: if( info == LAPACK_WORK_MEMORY_ERROR ) { LAPACKE_xerbla( "LAPACKE_zpteqr", info ); } return info; }
lapack_int LAPACKE_dtfsm( int matrix_layout, char transr, char side, char uplo, char trans, char diag, lapack_int m, lapack_int n, double alpha, const double* a, double* b, lapack_int ldb ) { if( matrix_layout != LAPACK_COL_MAJOR && matrix_layout != LAPACK_ROW_MAJOR ) { LAPACKE_xerbla( "LAPACKE_dtfsm", -1 ); return -1; } #ifndef LAPACK_DISABLE_NAN_CHECK /* Optionally check input matrices for NaNs */ if( IS_D_NONZERO(alpha) ) { if( LAPACKE_dtf_nancheck( matrix_layout, transr, uplo, diag, n, a ) ) { return -10; } } if( LAPACKE_d_nancheck( 1, &alpha, 1 ) ) { return -9; } if( IS_D_NONZERO(alpha) ) { if( LAPACKE_dge_nancheck( matrix_layout, m, n, b, ldb ) ) { return -11; } } #endif return LAPACKE_dtfsm_work( matrix_layout, transr, side, uplo, trans, diag, m, n, alpha, a, b, ldb ); }
lapack_int LAPACKE_zposvx( int matrix_order, char fact, char uplo, lapack_int n, lapack_int nrhs, lapack_complex_double* a, lapack_int lda, lapack_complex_double* af, lapack_int ldaf, char* equed, double* s, lapack_complex_double* b, lapack_int ldb, lapack_complex_double* x, lapack_int ldx, double* rcond, double* ferr, double* berr ) { lapack_int info = 0; double* rwork = NULL; lapack_complex_double* work = NULL; if( matrix_order != LAPACK_COL_MAJOR && matrix_order != LAPACK_ROW_MAJOR ) { LAPACKE_xerbla( "LAPACKE_zposvx", -1 ); return -1; } #ifndef LAPACK_DISABLE_NAN_CHECK /* Optionally check input matrices for NaNs */ if( LAPACKE_zpo_nancheck( matrix_order, uplo, n, a, lda ) ) { return -6; } if( LAPACKE_lsame( fact, 'f' ) ) { if( LAPACKE_zpo_nancheck( matrix_order, uplo, n, af, ldaf ) ) { return -8; } } if( LAPACKE_zge_nancheck( matrix_order, n, nrhs, b, ldb ) ) { return -12; } if( LAPACKE_lsame( fact, 'f' ) && LAPACKE_lsame( *equed, 'y' ) ) { if( LAPACKE_d_nancheck( n, s, 1 ) ) { return -11; } } #endif /* Allocate memory for working array(s) */ rwork = (double*)LAPACKE_malloc( sizeof(double) * MAX(1,n) ); if( rwork == NULL ) { info = LAPACK_WORK_MEMORY_ERROR; goto exit_level_0; } work = (lapack_complex_double*) LAPACKE_malloc( sizeof(lapack_complex_double) * MAX(1,2*n) ); if( work == NULL ) { info = LAPACK_WORK_MEMORY_ERROR; goto exit_level_1; } /* Call middle-level interface */ info = LAPACKE_zposvx_work( matrix_order, fact, uplo, n, nrhs, a, lda, af, ldaf, equed, s, b, ldb, x, ldx, rcond, ferr, berr, work, rwork ); /* Release memory and exit */ LAPACKE_free( work ); exit_level_1: LAPACKE_free( rwork ); exit_level_0: if( info == LAPACK_WORK_MEMORY_ERROR ) { LAPACKE_xerbla( "LAPACKE_zposvx", info ); } return info; }
lapack_int LAPACKE_dpbsvx( int matrix_layout, char fact, char uplo, lapack_int n, lapack_int kd, lapack_int nrhs, double* ab, lapack_int ldab, double* afb, lapack_int ldafb, char* equed, double* s, double* b, lapack_int ldb, double* x, lapack_int ldx, double* rcond, double* ferr, double* berr ) { lapack_int info = 0; lapack_int* iwork = NULL; double* work = NULL; if( matrix_layout != LAPACK_COL_MAJOR && matrix_layout != LAPACK_ROW_MAJOR ) { LAPACKE_xerbla( "LAPACKE_dpbsvx", -1 ); return -1; } #ifndef LAPACK_DISABLE_NAN_CHECK if( LAPACKE_get_nancheck() ) { /* Optionally check input matrices for NaNs */ if( LAPACKE_dpb_nancheck( matrix_layout, uplo, n, kd, ab, ldab ) ) { return -7; } if( LAPACKE_lsame( fact, 'f' ) ) { if( LAPACKE_dpb_nancheck( matrix_layout, uplo, n, kd, afb, ldafb ) ) { return -9; } } if( LAPACKE_dge_nancheck( matrix_layout, n, nrhs, b, ldb ) ) { return -13; } if( LAPACKE_lsame( fact, 'f' ) && LAPACKE_lsame( *equed, 'y' ) ) { if( LAPACKE_d_nancheck( n, s, 1 ) ) { return -12; } } } #endif /* Allocate memory for working array(s) */ iwork = (lapack_int*)LAPACKE_malloc( sizeof(lapack_int) * MAX(1,n) ); if( iwork == NULL ) { info = LAPACK_WORK_MEMORY_ERROR; goto exit_level_0; } work = (double*)LAPACKE_malloc( sizeof(double) * MAX(1,3*n) ); if( work == NULL ) { info = LAPACK_WORK_MEMORY_ERROR; goto exit_level_1; } /* Call middle-level interface */ info = LAPACKE_dpbsvx_work( matrix_layout, fact, uplo, n, kd, nrhs, ab, ldab, afb, ldafb, equed, s, b, ldb, x, ldx, rcond, ferr, berr, work, iwork ); /* Release memory and exit */ LAPACKE_free( work ); exit_level_1: LAPACKE_free( iwork ); exit_level_0: if( info == LAPACK_WORK_MEMORY_ERROR ) { LAPACKE_xerbla( "LAPACKE_dpbsvx", info ); } return info; }
lapack_int LAPACKE_zgelss( int matrix_order, lapack_int m, lapack_int n, lapack_int nrhs, lapack_complex_double* a, lapack_int lda, lapack_complex_double* b, lapack_int ldb, double* s, double rcond, lapack_int* rank ) { lapack_int info = 0; lapack_int lwork = -1; double* rwork = NULL; lapack_complex_double* work = NULL; lapack_complex_double work_query; if( matrix_order != LAPACK_COL_MAJOR && matrix_order != LAPACK_ROW_MAJOR ) { LAPACKE_xerbla( "LAPACKE_zgelss", -1 ); return -1; } #ifndef LAPACK_DISABLE_NAN_CHECK /* Optionally check input matrices for NaNs */ if( LAPACKE_zge_nancheck( matrix_order, m, n, a, lda ) ) { return -5; } if( LAPACKE_zge_nancheck( matrix_order, MAX(m,n), nrhs, b, ldb ) ) { return -7; } if( LAPACKE_d_nancheck( 1, &rcond, 1 ) ) { return -10; } #endif /* Allocate memory for working array(s) */ rwork = (double*)LAPACKE_malloc( sizeof(double) * MAX(1,5*MIN(m,n)) ); if( rwork == NULL ) { info = LAPACK_WORK_MEMORY_ERROR; goto exit_level_0; } /* Query optimal working array(s) size */ info = LAPACKE_zgelss_work( matrix_order, m, n, nrhs, a, lda, b, ldb, s, rcond, rank, &work_query, lwork, rwork ); if( info != 0 ) { goto exit_level_1; } lwork = LAPACK_Z2INT( work_query ); /* Allocate memory for work arrays */ work = (lapack_complex_double*) LAPACKE_malloc( sizeof(lapack_complex_double) * lwork ); if( work == NULL ) { info = LAPACK_WORK_MEMORY_ERROR; goto exit_level_1; } /* Call middle-level interface */ info = LAPACKE_zgelss_work( matrix_order, m, n, nrhs, a, lda, b, ldb, s, rcond, rank, work, lwork, rwork ); /* Release memory and exit */ LAPACKE_free( work ); exit_level_1: LAPACKE_free( rwork ); exit_level_0: if( info == LAPACK_WORK_MEMORY_ERROR ) { LAPACKE_xerbla( "LAPACKE_zgelss", info ); } return info; }
lapack_int LAPACKE_dlarft( int matrix_order, char direct, char storev, lapack_int n, lapack_int k, const double* v, lapack_int ldv, const double* tau, double* t, lapack_int ldt ) { if( matrix_order != LAPACK_COL_MAJOR && matrix_order != LAPACK_ROW_MAJOR ) { LAPACKE_xerbla( "LAPACKE_dlarft", -1 ); return -1; } #ifndef LAPACK_DISABLE_NAN_CHECK /* Optionally check input matrices for NaNs */ lapack_int ncols_v = LAPACKE_lsame( storev, 'c' ) ? k : ( LAPACKE_lsame( storev, 'r' ) ? n : 1); lapack_int nrows_v = LAPACKE_lsame( storev, 'c' ) ? n : ( LAPACKE_lsame( storev, 'r' ) ? k : 1); if( LAPACKE_d_nancheck( k, tau, 1 ) ) { return -8; } if( LAPACKE_dge_nancheck( matrix_order, nrows_v, ncols_v, v, ldv ) ) { return -6; } #endif return LAPACKE_dlarft_work( matrix_order, direct, storev, n, k, v, ldv, tau, t, ldt ); }
lapack_int LAPACKE_dlagsy( int matrix_layout, lapack_int n, lapack_int k, const double* d, double* a, lapack_int lda, lapack_int* iseed ) { lapack_int info = 0; double* work = NULL; if( matrix_layout != LAPACK_COL_MAJOR && matrix_layout != LAPACK_ROW_MAJOR ) { LAPACKE_xerbla( "LAPACKE_dlagsy", -1 ); return -1; } #ifndef LAPACK_DISABLE_NAN_CHECK if( LAPACKE_get_nancheck() ) { /* Optionally check input matrices for NaNs */ if( LAPACKE_d_nancheck( n, d, 1 ) ) { return -4; } } #endif /* Allocate memory for working array(s) */ work = (double*)LAPACKE_malloc( sizeof(double) * MAX(1,2*n) ); if( work == NULL ) { info = LAPACK_WORK_MEMORY_ERROR; goto exit_level_0; } /* Call middle-level interface */ info = LAPACKE_dlagsy_work( matrix_layout, n, k, d, a, lda, iseed, work ); /* Release memory and exit */ LAPACKE_free( work ); exit_level_0: if( info == LAPACK_WORK_MEMORY_ERROR ) { LAPACKE_xerbla( "LAPACKE_dlagsy", info ); } return info; }
lapack_int LAPACKE_dlartgs( double x, double y, double sigma, double* cs, double* sn ) { #ifndef LAPACK_DISABLE_NAN_CHECK /* Optionally check input matrices for NaNs */ if( LAPACKE_d_nancheck( 1, &sigma, 1 ) ) { return -3; } if( LAPACKE_d_nancheck( 1, &x, 1 ) ) { return -1; } if( LAPACKE_d_nancheck( 1, &y, 1 ) ) { return -2; } #endif return LAPACKE_dlartgs_work( x, y, sigma, cs, sn ); }
lapack_int LAPACKE_dlassq( lapack_int n, double* x, lapack_int incx, double* scale, double* sumsq ) { #ifndef LAPACK_DISABLE_NAN_CHECK if( LAPACKE_get_nancheck() ) { /* Optionally check input vector `x` and in/out scalars `scale` and `sumsq` for NaNs */ if( LAPACKE_d_nancheck( n, x, incx ) ) { return -2; } if( LAPACKE_d_nancheck( 1, scale, 1 ) ) { return -4; } if( LAPACKE_d_nancheck( 1, sumsq, 1 ) ) { return -5; } } #endif return LAPACKE_dlassq_work( n, x, incx, scale, sumsq ); }
lapack_int LAPACKE_dlatms( int matrix_layout, lapack_int m, lapack_int n, char dist, lapack_int* iseed, char sym, double* d, lapack_int mode, double cond, double dmax, lapack_int kl, lapack_int ku, char pack, double* a, lapack_int lda ) { lapack_int info = 0; double* work = NULL; if( matrix_layout != LAPACK_COL_MAJOR && matrix_layout != LAPACK_ROW_MAJOR ) { LAPACKE_xerbla( "LAPACKE_dlatms", -1 ); return -1; } #ifndef LAPACK_DISABLE_NAN_CHECK /* Optionally check input matrices for NaNs */ if( LAPACKE_dge_nancheck( matrix_layout, m, n, a, lda ) ) { return -14; } if( LAPACKE_d_nancheck( 1, &cond, 1 ) ) { return -9; } if( LAPACKE_d_nancheck( MIN(n,m), d, 1 ) ) { return -7; } if( LAPACKE_d_nancheck( 1, &dmax, 1 ) ) { return -10; } #endif /* Allocate memory for working array(s) */ work = (double*)LAPACKE_malloc( sizeof(double) * MAX(1,3*(MAX(n,m))) ); if( work == NULL ) { info = LAPACK_WORK_MEMORY_ERROR; goto exit_level_0; } /* Call middle-level interface */ info = LAPACKE_dlatms_work( matrix_layout, m, n, dist, iseed, sym, d, mode, cond, dmax, kl, ku, pack, a, lda, work ); /* Release memory and exit */ LAPACKE_free( work ); exit_level_0: if( info == LAPACK_WORK_MEMORY_ERROR ) { LAPACKE_xerbla( "LAPACKE_dlatms", info ); } return info; }
lapack_int LAPACKE_dgttrf( lapack_int n, double* dl, double* d, double* du, double* du2, lapack_int* ipiv ) { #ifndef LAPACK_DISABLE_NAN_CHECK if( LAPACKE_get_nancheck() ) { /* Optionally check input matrices for NaNs */ if( LAPACKE_d_nancheck( n, d, 1 ) ) { return -3; } if( LAPACKE_d_nancheck( n-1, dl, 1 ) ) { return -2; } if( LAPACKE_d_nancheck( n-1, du, 1 ) ) { return -4; } } #endif return LAPACKE_dgttrf_work( n, dl, d, du, du2, ipiv ); }
lapack_int LAPACKE_dormbr( int matrix_layout, char vect, char side, char trans, lapack_int m, lapack_int n, lapack_int k, const double* a, lapack_int lda, const double* tau, double* c, lapack_int ldc ) { lapack_int info = 0; lapack_int lwork = -1; double* work = NULL; double work_query; lapack_int nq, ar, ac; if( matrix_layout != LAPACK_COL_MAJOR && matrix_layout != LAPACK_ROW_MAJOR ) { LAPACKE_xerbla( "LAPACKE_dormbr", -1 ); return -1; } #ifndef LAPACK_DISABLE_NAN_CHECK if( LAPACKE_get_nancheck() ) { /* Optionally check input matrices for NaNs */ nq = LAPACKE_lsame( side, 'l' ) ? m : n; ar = LAPACKE_lsame( vect, 'q' ) ? nq : MIN(nq,k); ac = LAPACKE_lsame( vect, 'q' ) ? MIN(nq,k) : nq; if( LAPACKE_dge_nancheck( matrix_layout, ar, ac, a, lda ) ) { return -8; } if( LAPACKE_dge_nancheck( matrix_layout, m, n, c, ldc ) ) { return -11; } if( LAPACKE_d_nancheck( MIN(nq,k), tau, 1 ) ) { return -10; } } #endif /* Query optimal working array(s) size */ info = LAPACKE_dormbr_work( matrix_layout, vect, side, trans, m, n, k, a, lda, tau, c, ldc, &work_query, lwork ); if( info != 0 ) { goto exit_level_0; } lwork = (lapack_int)work_query; /* Allocate memory for work arrays */ work = (double*)LAPACKE_malloc( sizeof(double) * lwork ); if( work == NULL ) { info = LAPACK_WORK_MEMORY_ERROR; goto exit_level_0; } /* Call middle-level interface */ info = LAPACKE_dormbr_work( matrix_layout, vect, side, trans, m, n, k, a, lda, tau, c, ldc, work, lwork ); /* Release memory and exit */ LAPACKE_free( work ); exit_level_0: if( info == LAPACK_WORK_MEMORY_ERROR ) { LAPACKE_xerbla( "LAPACKE_dormbr", info ); } return info; }
lapack_int LAPACKE_dgemlq( int matrix_layout, char side, char trans, lapack_int m, lapack_int n, lapack_int k, const double* a, lapack_int lda, const double* t, lapack_int tsize, double* c, lapack_int ldc ) { lapack_int info = 0; lapack_int lwork = -1; double* work = NULL; double work_query; if( matrix_layout != LAPACK_COL_MAJOR && matrix_layout != LAPACK_ROW_MAJOR ) { LAPACKE_xerbla( "LAPACKE_dgemlq", -1 ); return -1; } #ifndef LAPACK_DISABLE_NAN_CHECK if( LAPACKE_get_nancheck() ) { /* Optionally check input matrices for NaNs */ if( LAPACKE_dge_nancheck( matrix_layout, k, m, a, lda ) ) { return -7; } if( LAPACKE_dge_nancheck( matrix_layout, m, n, c, ldc ) ) { return -10; } if( LAPACKE_d_nancheck( tsize, t, 1 ) ) { return -9; } } #endif /* Query optimal working array(s) size */ info = LAPACKE_dgemlq_work( matrix_layout, side, trans, m, n, k, a, lda, t, tsize, c, ldc, &work_query, lwork ); if( info != 0 ) { goto exit_level_0; } lwork = (lapack_int)work_query; /* Allocate memory for work arrays */ work = (double*)LAPACKE_malloc( sizeof(double) * lwork ); if( work == NULL ) { info = LAPACK_WORK_MEMORY_ERROR; goto exit_level_0; } /* Call middle-level interface */ info = LAPACKE_dgemlq_work( matrix_layout, side, trans, m, n, k, a, lda, t, tsize, c, ldc, work, lwork ); /* Release memory and exit */ LAPACKE_free( work ); exit_level_0: if( info == LAPACK_WORK_MEMORY_ERROR ) { LAPACKE_xerbla( "LAPACKE_dgemlq", info ); } return info; }
lapack_int LAPACKE_dstev( int matrix_order, char jobz, lapack_int n, double* d, double* e, double* z, lapack_int ldz ) { lapack_int info = 0; double* work = NULL; if( matrix_order != LAPACK_COL_MAJOR && matrix_order != LAPACK_ROW_MAJOR ) { LAPACKE_xerbla( "LAPACKE_dstev", -1 ); return -1; } #ifndef LAPACK_DISABLE_NAN_CHECK /* Optionally check input matrices for NaNs */ if( LAPACKE_d_nancheck( n, d, 1 ) ) { return -4; } if( LAPACKE_d_nancheck( n, e, 1 ) ) { return -5; } #endif /* Allocate memory for working array(s) */ if( LAPACKE_lsame( jobz, 'v' ) ) { work = (double*)LAPACKE_malloc( sizeof(double) * MAX(1,2*n-2) ); if( work == NULL ) { info = LAPACK_WORK_MEMORY_ERROR; goto exit_level_0; } } /* Call middle-level interface */ info = LAPACKE_dstev_work( matrix_order, jobz, n, d, e, z, ldz, work ); /* Release memory and exit */ if( LAPACKE_lsame( jobz, 'v' ) ) { LAPACKE_free( work ); } exit_level_0: if( info == LAPACK_WORK_MEMORY_ERROR ) { LAPACKE_xerbla( "LAPACKE_dstev", info ); } return info; }