本文整理汇总了C++中LAPACKE_d_nancheck函数的典型用法代码示例。如果您正苦于以下问题:C++ LAPACKE_d_nancheck函数的具体用法?C++ LAPACKE_d_nancheck怎么用?C++ LAPACKE_d_nancheck使用的例子?那么恭喜您, 这里精选的函数代码示例或许可以为您提供帮助。
在下文中一共展示了LAPACKE_d_nancheck函数的15个代码示例,这些例子默认根据受欢迎程度排序。您可以为喜欢或者感觉有用的代码点赞,您的评价将有助于系统推荐出更棒的C++代码示例。
示例1: LAPACKE_dstedc
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;
}
示例2: LAPACKE_dsfrk
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 );
}
示例3: LAPACKE_zptcon
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;
}
示例4: LAPACKE_dggbak
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 );
}
示例5: LAPACKE_dst_nancheck
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 );
}
示例6: LAPACKE_dsbevx
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;
}
示例7: LAPACKE_dbdsdc
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;
}
示例8: LAPACKE_dgt_nancheck
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 );
}
示例9: LAPACKE_dbdsqr
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;
}
示例10: LAPACKE_dgglse
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;
}
示例11: LAPACKE_dlarfg
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 );
}
示例12: LAPACKE_dlartgp
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 );
}
示例13: LAPACKE_dptrfs
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;
}
示例14: LAPACKE_dgtcon
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;
}
示例15: LAPACKE_zstein
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;
}