NAG Library Function Document nag_complex_tridiag_lin_solve (f04ccc)

Size: px
Start display at page:

Download "NAG Library Function Document nag_complex_tridiag_lin_solve (f04ccc)"

Transcription

1 f04 Simultaneous Linear Equations f04ccc Purpose NAG Library Function Document nag_complex_tridiag_lin_solve (f04ccc) nag_complex_tridiag_lin_solve (f04ccc) computes the solution to a complex system of linear equations AX ¼ B, where A is an n by n tridiagonal matrix and X and B are n by r matrices. An estimate of the condition number of A and an error bound for the computed solution are also returned. 2 Specification #include <nag.h> #include <nagf04.h> void nag_complex_tridiag_lin_solve (Nag_OrderType order, Integer n, Integer nrhs, Complex dl[], Complex d[], Complex du[], Complex du2[], Integer ipiv[], Complex b[], Integer pdb, double *rcond, double *errbnd, NagError *fail) 3 Description The LU decomposition with partial pivoting and row interchanges is used to factor A as A ¼ PLU, where P is a permutation matrix, L is unit lower triangular with at most one nonzero subdiagonal element, and U is an upper triangular band matrix with two superdiagonals. The factored form of A is then used to solve the system of equations AX ¼ B. Note that the equations A T X ¼ B may be solved by interchanging the order of the arguments du and dl. 4 References Anderson E, Bai Z, Bischof C, Blackford S, Demmel J, Dongarra J J, Du Croz J J, Greenbaum A, Hammarling S, McKenney A and Sorensen D (999) LAPACK Users Guide (3rd Edition) SIAM, Philadelphiahttp:// Higham N J (2002) Accuracy and Stability of Numerical Algorithms (2nd Edition) SIAM, Philadelphia 5 Arguments : order Nag_OrderType Input On entry: the order argument specifies the two-dimensional storage scheme being used, i.e., rowmajor ordering or column-major ordering. C language defined storage is specified by order ¼ Nag_RowMajor. See Section in the Essential Introduction for a more detailed explanation of the use of this argument. Constraint: order ¼ Nag_RowMajor or Nag_ColMajor. 2: n Integer Input On entry: the number of linear equations n, i.e., the order of the matrix A. Constraint: n 0. 3: nrhs Integer Input On entry: the number of right-hand sides r, i.e., the number of columns of the matrix B. Constraint: nrhs 0. f04ccc.

2 f04ccc NAG Library Manual 4: dl½dimš Complex Input/Output Note: the dimension, dim, of the array dl must be at least maxð; n Þ. On entry: must contain the ðn Þ subdiagonal elements of the matrix A. On exit: iffail:code ¼ NE_NOERROR, dl is overwritten by the ðn Þ multipliers that define the matrix L from the LU factorization of A. 5: d½dimš Complex Input/Output Note: the dimension, dim, of the array d must be at least maxð; nþ. On entry: must contain the n diagonal elements of the matrix A. On exit: iffail:code ¼ NE_NOERROR, d is overwritten by the n diagonal elements of the upper triangular matrix U from the LU factorization of A. 6: du½dimš Complex Input/Output Note: the dimension, dim, of the array du must be at least maxð; n Þ. On entry: must contain the ðn Þ superdiagonal elements of the matrix A On exit: iffail:code ¼ NE_NOERROR, du is overwritten by the ðn Þ elements of the first superdiagonal of U. 7: du2½n 2Š Complex Output On exit: if fail:code ¼ NE_NOERROR, du2 returns the ðn 2Þ elements of the second superdiagonal of U. 8: ipiv½nš Integer Output On exit: iffail:code ¼ NE_NOERROR, the pivot indices that define the permutation matrix P; at the ith step row i of the matrix was interchanged with row ipiv½i Š. ipiv½i Š will always be either i or ði þ Þ; ipiv½i Š ¼i indicates a row interchange was not required. 9: b½dimš Complex Input/Output Note: the dimension, dim, of the array b must be at least maxð; pdb nrhsþ when order ¼ Nag_ColMajor; maxð; pdb nþ when order ¼ Nag_RowMajor. The ði; jþth element of the matrix B is stored in b½ðj Þpdb þ i Š when order ¼ Nag_ColMajor; b½ði Þ pdb þ j Š when order ¼ Nag_RowMajor. On entry: the n by r matrix of right-hand sides B. On exit: iffail:code ¼ NE_NOERROR or NE_RCOND, the n by r solution matrix X. 0: pdb Integer Input On entry: the stride separating matrix row or column elements (depending on the value of order) in b. Constraints: if order ¼ Nag_ColMajor, pdb maxð; nþ; if order ¼ Nag_RowMajor, pdb maxð; nrhsþ. : rcond double * Output On exit: if no constraints are violated, an estimate of the reciprocal of the condition number of the matrix A, computed as rcond ¼ = kak A. f04ccc.2

3 f04 Simultaneous Linear Equations f04ccc 2: errbnd double * Output On exit: iffail:code ¼ NE_NOERROR or NE_RCOND, an estimate of the forward error bound for a computed solution ^x, such that k^x xk = kxk errbnd, where ^x is a column of the computed solution returned in the array b and x is the corresponding column of the exact solution X. If rcond is less than machine precision, then errbnd is returned as unity. 3: fail NagError * Input/Output The NAG error argument (see Section 3.6 in the Essential Introduction). 6 Error Indicators and Warnings NE_ALLOC_FAIL Dynamic memory allocation failed. NE_BAD_PARAM On entry, argument NE_INT On entry, n ¼ hvaluei. Constraint: n 0. On entry, nrhs ¼ hvaluei. Constraint: nrhs 0. On entry, pdb ¼ hvaluei. Constraint: pdb > 0. hvaluei had an illegal value. NE_INT_2 On entry, pdb ¼ hvaluei, n ¼ hvaluei. Constraint: pdb maxð; nþ. NE_INTERNAL_ERROR An internal error has occurred in this function. Check the function call and any array sizes. If the call is correct then please consult NAG for assistance. An internal error has occurred in this function. Check the function call and any array sizes. If the call is correct then please contact NAG for assistance. NE_RCOND A solution has been computed, but rcond is less than machine precision so that the matrix A is numerically singular. NE_SINGULAR Diagonal element hvaluei of the upper triangular factor is zero. The factorization has been completed, but the solution could not be computed. 7 Accuracy The computed solution for a single right-hand side, ^x, satisfies an equation of the form ða þ EÞ^x ¼ b, where kek ¼ OðÞA k k and is the machine precision. An approximate error bound for the computed solution is given by f04ccc.3

4 f04ccc NAG Library Manual k^x xk A ð Þ kek, kxk kak where A ð Þ ¼ A kak, the condition number of A with respect to the solution of the linear equations. nag_complex_tridiag_lin_solve (f04ccc) uses the approximation kek ¼ A k k to estimate errbnd. See Section 4.4 of Anderson et al. (999) for further details. 8 Further Comments The total number of floating-point operations required to solve the equations AX ¼ B is proportional to nr. The condition number estimation typically requires between four and five solves and never more than eleven solves, following the factorization. In practice the condition number estimator is very reliable, but it can underestimate the true condition number; see Section 5.3 of Higham (2002) for further details. The real analogue of nag_complex_tridiag_lin_solve (f04ccc) is nag_real_tridiag_lin_solve (f04bcc). 9 Example This example solves the equations where A is the tridiagonal matrix 0 A ¼ and AX ¼ B, :3 þ :3i 2:0 :0i :0 2:0i :3 þ :3i 2:0 þ :0i :0 þ :0i :3 þ 3:3i :0 þ :0i :0 3:0i 0:3 þ 4:3i :0 :0i :0 þ :0i 3:3 þ :3i 0 2:4 5:0i 2:7 þ 6:9i 3:4 þ 8:2i 6:9 5:3i B ¼ 4:7 þ 9:7i 6:0 0:6i B 3:9 7:7i 3:9 þ 9:3i A. :0 þ :6i 3:0 þ 2:2i An estimate of the condition number of A and an approximate error bound for the computed solutions are also printed. 9. Program Text /* nag_complex_tridiag_lin_solve (f04ccc) Example Program. * * Copyright 2004 Numerical Algorithms Group. * * Mark 8, */ #include <stdio.h> #include <nag.h> #include <nag_stdlib.h> #include <nagf04.h> #include <nagx04.h> int main(int argc, char *argv[]) FILE *fpin, *fpout; char *outfile = 0; /* Scalars */ double errbnd, rcond; C A f04ccc.4

5 f04 Simultaneous Linear Equations f04ccc Integer exit_status, i, j, n, nrhs, pdb; /* Arrays */ char *clabs = 0, *rlabs = 0; Complex *b = 0, *d = 0, *dl = 0, *du = 0, *du2 = 0; Integer *ipiv = 0; /* Nag types */ NagError fail; Nag_OrderType order; #ifdef NAG_COLUMN_MAJOR #define B(I, J) b[(j-)*pdb + I - ] order = Nag_ColMajor; #else #define B(I, J) b[(i-)*pdb + J - ] order = Nag_RowMajor; #endif exit_status = 0; INIT_FAIL(fail); /* Check for command-line IO options */ fpin = nag_example_file_io(argc, argv, "-data", NULL); fpout = nag_example_file_io(argc, argv, "-results", NULL); (void) nag_example_file_io(argc, argv, "-nag_write", &outfile); "nag_complex_tridiag_lin_solve (f04ccc) Example Program Results\n\n"); /* Skip heading in data file */ fscanf(fpin, "%ld%ld%*[^\n] ", &n, &nrhs); if (n > 0 && nrhs > 0) /* Allocate memory */ if (!(clabs = NAG_ALLOC(2, char))!(rlabs = NAG_ALLOC(2, char))!(b = NAG_ALLOC(n*nrhs, Complex))!(d = NAG_ALLOC(n, Complex))!(dl = NAG_ALLOC(n-, Complex))!(du = NAG_ALLOC(n-, Complex))!(du2 = NAG_ALLOC(n-2, Complex))!(ipiv = NAG_ALLOC(n, Integer))) "Allocation failure\n"); exit_status = -; #ifdef NAG_COLUMN_MAJOR pdb = n; #else pdb = nrhs; #endif else "%s\n", "n and/or nrhs too small"); exit_status = ; return exit_status; /* Read A and B from data file */ for (i = ; i <= n - ; ++i) fscanf(fpin, " ( %lf, %lf )", &du[i - ].re, &du[i - ].im); for (i = ; i <= n; ++i) f04ccc.5

6 f04ccc NAG Library Manual fscanf(fpin, " ( %lf, %lf )", &d[i - ].re, &d[i - ].im); for (i = ; i <= n - ; ++i) fscanf(fpin, " ( %lf, %lf )", &dl[i - ].re, &dl[i - ].im); for (i = ; i <= n; ++i) for (j = ; j <= nrhs; ++j) fscanf(fpin, " ( %lf, %lf )", &B(i, j).re, &B(i, j).im); /* Solve the equations AX = B for X */ /* nag_complex_tridiag_lin_solve (f04ccc). * Computes the solution and error-bound to a complex * tridiagonal system of linear equations */ nag_complex_tridiag_lin_solve(order, n, nrhs, dl, d, du, du2, ipiv, b, pdb, &rcond, &errbnd, &fail); if (fail.code == NE_NOERROR) /* Print solution, estimate of condition number and approximate */ /* error bound */ /* nag_gen_complx_mat_print_comp (x04dbc). * Print complex general matrix (comprehensive) */ if (outfile) fclose(fpout); nag_gen_complx_mat_print_comp(order, Nag_GeneralMatrix, Nag_NonUnitDiag, n, nrhs, b, pdb, Nag_BracketForm, 0, "Solution", Nag_IntegerLabels, 0, Nag_IntegerLabels, 0, 80, 0, outfile, &fail); if (outfile &&!(fpout = fopen(outfile, "a"))) exit_status = 2; if (fail.code!= NE_NOERROR) "Error from nag_gen_complx_mat_print_comp (x04dbc).\n%s\n", fail.message); exit_status = ; "\n"); "%s\n%8s%0.e\n", "Estimate of condition number", "",.0/rcond); "\n\n"); "%s\n%8s%0.e\n\n", "Estimate of error bound for computed solutions", "", errbnd); else if (fail.code == NE_RCOND) /* Matrix A is numerically singular. Print estimate of */ /* reciprocal of condition number and solution */ "\n"); "%s\n%8s%0.e\n\n\n", "Estimate of reciprocal of condition number", "", rcond); /* nag_gen_complx_mat_print_comp (x04dbc), see above. */ if (outfile) fclose(fpout); f04ccc.6

7 f04 Simultaneous Linear Equations f04ccc nag_gen_complx_mat_print_comp(order, Nag_GeneralMatrix, Nag_NonUnitDiag, n, nrhs, b, pdb, Nag_BracketForm, 0, "Solution", Nag_IntegerLabels, 0, Nag_IntegerLabels, 0, 80, 0, outfile, &fail); if (outfile &&!(fpout = fopen(outfile, "a"))) exit_status = 2; if (fail.code!= NE_NOERROR) "Error from nag_gen_complx_mat_print_comp (x04dbc).\n%s\n", fail.message); exit_status = ; else if (fail.code == NE_SINGULAR) /* The upper triangular matrix U is exactly singular. Print */ /* details of factorization */ "%s\n\n", "Details of factorization"); "%s", " Second super-diagonal of U"); "\n"); for (i = ; i <= n - 2; ++i) "(%7.4f, %7.4f)%s", du2[i - ].re, du2[i - ].im, i%4 == 0 i == n - 2?"\n":" "); "\n\n"); "%s\n", " First super-diagonal of U"); for (i = ; i <= n - ; ++i) "(%7.4f, %7.4f)%s", du[i - ].re, du[i - ].im, i%4 == 0 i == n -?"\n":" "); "\n\n"); "%s\n", " Main diagonal of U"); for (i = ; i <= n; ++i) "(%7.4f, %7.4f)%s", d[i - ].re, d[i - ].im, i%4 == 0 i == n?"\n":" "); "\n\n"); "%s\n", " Multipliers"); for (i = ; i <= n - ; ++i) "(%7.4f, %7.4f)%s", dl[i - ].re, dl[i - ].im, i%4 == 0 i == n -?"\n":" "); "\n\n"); "%s\n", " Vector of interchanges"); for (i = ; i <= n; ++i) "%9ld%s", ipiv[i - ], i%8 == 0 i == n?"\n":" "); "\n"); else f04ccc.7

8 f04ccc NAG Library Manual "Error from nag_complex_tridiag_lin_solve (f04ccc).\n%s\n", fail.message); exit_status = ; END: if (fpin!= stdin) fclose(fpin); if (fpout!= stdout) fclose(fpout); if (clabs) NAG_FREE(clabs); if (rlabs) NAG_FREE(rlabs); if (b) NAG_FREE(b); if (d) NAG_FREE(d); if (dl) NAG_FREE(dl); if (du) NAG_FREE(du); if (du2) NAG_FREE(du2); if (ipiv) NAG_FREE(ipiv); return exit_status; #undef B 9.2 Program Data nag_complex_tridiag_lin_solve (f04ccc) Example Program Data 5 2 :Values of N and NRHS ( 2.0, -.0) ( 2.0,.0) ( -.0,.0) (.0, -.0) :End of DU ( -.3,.3) ( -.3,.3) ( -.3, 3.3) ( -0.3, 4.3) ( -3.3,.3) :End of D (.0, -2.0) (.0,.0) ( 2.0, -3.0) (.0,.0) :End of DL ( 2.4, -5.0) ( 2.7, 6.9) ( 3.4, 8.2) ( -6.9, -5.3) (-4.7, 9.7) ( -6.0, -0.6) ( 3.9, -7.7) ( -3.9, 9.3) ( -.0,.6) ( -3.0, 2.2) :End of B 9.3 Program Results nag_complex_tridiag_lin_solve (f04ccc) Example Program Results Solution 2 (.0000,.0000) ( , ) 2 ( , ) (.0000, ) 3 ( , ) ( ,.0000) 4 ( , ) ( ,.0000) 5 (.0000, ) ( , ) Estimate of condition number.8e+02 Estimate of error bound for computed solutions 2.0e-4 f04ccc.8 (last)

NAG Library Function Document nag_complex_gen_lin_solve (f04cac)

NAG Library Function Document nag_complex_gen_lin_solve (f04cac) f04 Simultaneous Linear Equations f04cac Purpose NAG Library Function Document nag_complex_gen_lin_solve (f04cac) nag_complex_gen_lin_solve (f04cac) computes the solution to a complex system of linear

More information

NAG Library Function Document nag_herm_posdef_tridiag_lin_solve (f04cgc)

NAG Library Function Document nag_herm_posdef_tridiag_lin_solve (f04cgc) Purpose NAG Library Function Document nag_herm_posdef_tridiag_lin_solve () nag_herm_posdef_tridiag_lin_solve () computes the solution to a complex system of linear equations AX ¼ B, where A is an n by

More information

NAG Library Function Document nag_real_sym_posdef_tridiag_lin_solve (f04bgc)

NAG Library Function Document nag_real_sym_posdef_tridiag_lin_solve (f04bgc) Purpose NAG Library Function Document nag_real_sym_posdef_tridiag_lin_solve () nag_real_sym_posdef_tridiag_lin_solve () computes the solution to a real system of linear equations AX ¼ B, where A is an

More information

NAG Library Function Document nag_dgttrs (f07cec)

NAG Library Function Document nag_dgttrs (f07cec) NAG Library Function Document nag_dgttrs () Purpose nag_dgttrs () computes the solution to a real system of linear equations AX ¼ B or A T X ¼ B, where A is an n by n tridiagonal matrix and X and B are

More information

NAG Library Function Document nag_dgglse (f08zac)

NAG Library Function Document nag_dgglse (f08zac) 1 Purpose NAG Library Function Document nag_dgglse () nag_dgglse () solves a real linear equality-constrained least-squares problem. 2 Specification #include #include void nag_dgglse

More information

NAG Library Function Document nag_dgetri (f07ajc)

NAG Library Function Document nag_dgetri (f07ajc) 1 Purpose NAG Library Function Document nag_dgetri () nag_dgetri () computes the inverse of a real matrix A, where A has been factorized by nag_dgetrf (f07adc). 2 Specification #include #include

More information

NAG Library Function Document nag_dsytrf (f07mdc)

NAG Library Function Document nag_dsytrf (f07mdc) f07 Linear Equations (LAPACK) f07mdc 1 Purpose NAG Library Function Document nag_dsytrf (f07mdc) nag_dsytrf (f07mdc) computes the Bunch Kaufman factorization of a real symmetric indefinite matrix. 2 Specification

More information

NAG Library Function Document nag_dspsv (f07pac)

NAG Library Function Document nag_dspsv (f07pac) NAG Library Function Document nag_dspsv () 1 Purpose nag_dspsv () computes the solution to a real system of linear equations AX ¼ B; where A is an n by n symmetric matrix stored in packed format and X

More information

NAG Library Function Document nag_dtrsyl (f08qhc)

NAG Library Function Document nag_dtrsyl (f08qhc) 1 Purpose NAG Library Function Document nag_dtrsyl () nag_dtrsyl () solves the real quasi-triangular Sylvester matrix equation. 2 Specification #include #include void nag_dtrsyl (Nag_OrderType

More information

NAG Library Function Document nag_dtr_load (f16qgc)

NAG Library Function Document nag_dtr_load (f16qgc) 1 Purpose NAG Library Function Document nag_dtr_load () nag_dtr_load () initializes a real triangular matrix. 2 Specification #include #include void nag_dtr_load (Nag_OrderType order,

More information

NAG Library Function Document nag_ztzrzf (f08bvc)

NAG Library Function Document nag_ztzrzf (f08bvc) f08 Least-squares and Eigenvalue Problems (LAPACK) f08bvc NAG Library Function Document nag_ztzrzf (f08bvc) 1 Purpose nag_ztzrzf (f08bvc) reduces the m by n (m n) complex upper trapezoidal matrix A to

More information

NAG Library Function Document nag_ztbcon (f07vuc)

NAG Library Function Document nag_ztbcon (f07vuc) f07 Linear Equations (LAPACK) f07vuc Purpose NAG Library Function Document nag_ztbcon (f07vuc) nag_ztbcon (f07vuc) estimates the condition number of a complex triangular band matrix. 2 Specification #include

More information

NAG Library Function Document nag_zgelsy (f08bnc)

NAG Library Function Document nag_zgelsy (f08bnc) NAG Library Function Document nag_zgelsy () 1 Purpose nag_zgelsy () computes the minimum norm solution to a complex linear least squares problem minkb Axk 2 x using a complete orthogonal factorization

More information

NAG Library Function Document nag_dtrmv (f16pfc)

NAG Library Function Document nag_dtrmv (f16pfc) f16 NAG Interface to BLAS 1 Purpose NAG Library Function Document nag_dtrmv () nag_dtrmv () performs matrix-vector multiplication for a real triangular matrix. 2 Specification #include #include

More information

NAG Library Function Document nag_zgelss (f08knc)

NAG Library Function Document nag_zgelss (f08knc) NAG Library Function Document nag_zgelss () 1 Purpose nag_zgelss () computes the minimum norm solution to a complex linear least squares problem minkb Axk 2 : 2 Specification x #include #include

More information

NAG Library Function Document nag_dgelsd (f08kcc)

NAG Library Function Document nag_dgelsd (f08kcc) NAG Library Function Document nag_dgelsd () 1 Purpose nag_dgelsd () computes the minimum norm solution to a real linear least squares problem 2 Specification minkb Axk 2 : x #include #include

More information

NAG Library Function Document nag_dstev (f08jac)

NAG Library Function Document nag_dstev (f08jac) f08 Least-squares and Eigenvalue Problems (LAPACK) f08jac NAG Library Function Document nag_dstev (f08jac) 1 Purpose nag_dstev (f08jac) computes all the eigenvalues and, optionally, all the eigenvectors

More information

NAG Library Function Document nag_zhpr2 (f16ssc)

NAG Library Function Document nag_zhpr2 (f16ssc) f16 NAG Interface to BLAS f16ssc 1 Purpose NAG Library Function Document nag_zhpr2 (f16ssc) nag_zhpr2 (f16ssc) performs a Hermitian rank-2 update on a complex Hermitian matrix stored in packed form. 2

More information

NAG Library Function Document nag_dpbtrf (f07hdc)

NAG Library Function Document nag_dpbtrf (f07hdc) 1 Purpose NAG Library Function Document nag_dpbtrf () nag_dpbtrf () computes the Cholesky factorization of a real symmetric positive-definite band matrix. 2 Specification #include #include

More information

NAG Library Function Document nag_zhpev (f08gnc)

NAG Library Function Document nag_zhpev (f08gnc) f08 Least-squares and Eigenvalue Problems (LAPACK) NAG Library Function Document nag_zhpev () 1 Purpose nag_zhpev () computes all the eigenvalues and, optionally, all the eigenvectors of a complex n by

More information

NAG Library Function Document nag_dsymv (f16pcc)

NAG Library Function Document nag_dsymv (f16pcc) f16 NAG Interface to BLAS f16pcc 1 Purpose NAG Library Function Document nag_dsymv (f16pcc) nag_dsymv (f16pcc) performs matrix-vector multiplication for a real symmetric matrix. 2 Specification #include

More information

NAG C Library Function Document nag_dgbtrs (f07bec)

NAG C Library Function Document nag_dgbtrs (f07bec) f07 Linear Equations (LAPACK) f07bec 1 Purpose NAG C Library Function Document nag_dgbtrs (f07bec) nag_dgbtrs (f07bec) solves a real band system of linear equations with multiple right-hand sides, AX ¼

More information

NAG C Library Function Document nag_zsytri (f07nwc)

NAG C Library Function Document nag_zsytri (f07nwc) 1 Purpose NAG C Library Function Document nag_zsytri () nag_zsytri () computes the inverse of a complex symmetric matrix A, where A has been factorized by nag_zsytrf (f07nrc). 2 Specification void nag_zsytri

More information

NAG Library Function Document nag_dgetrf (f07adc)

NAG Library Function Document nag_dgetrf (f07adc) f07 Linear Equations (LAPACK) f07adc NAG Library Function Document nag_dgetrf (f07adc) 1 Purpose nag_dgetrf (f07adc) computes the LU factorization of a real m by n matrix. 2 Specification #include

More information

NAG Library Function Document nag_ztrttf (f01vfc)

NAG Library Function Document nag_ztrttf (f01vfc) f01 Matrix Factorizations f01vfc NAG Library Function Document nag_ztrttf (f01vfc) 1 Purpose nag_ztrttf (f01vfc) copies a complex triangular matrix, stored in a full format array, to a Rectangular Full

More information

NAG Fortran Library Routine Document F04CAF.1

NAG Fortran Library Routine Document F04CAF.1 F04 Simultaneous Linear Equations NAG Fortran Library Routine Document Note: before using this routine, please read the Users Note for your implementation to check the interpretation of bold italicised

More information

NAG Library Function Document nag_dsbev (f08hac)

NAG Library Function Document nag_dsbev (f08hac) f08 Least-squares and Eigenvalue Problems (LAPACK) f08hac NAG Library Function Document nag_dsbev (f08hac) 1 Purpose nag_dsbev (f08hac) computes all the eigenvalues and, optionally, all the eigenvectors

More information

NAG Library Function Document nag_zheevx (f08fpc)

NAG Library Function Document nag_zheevx (f08fpc) f08 Least-squares and Eigenvalue Problems (LAPACK) NAG Library Function Document nag_zheevx () 1 Purpose nag_zheevx () computes selected eigenvalues and, optionally, eigenvectors of a complex n by n Hermitian

More information

NAG C Library Function Document nag_zger (f16smc)

NAG C Library Function Document nag_zger (f16smc) f16 NAG Interface to BLAS f16smc 1 Purpose NAG C Library Function Document nag_zger (f16smc) nag_zger (f16smc) performs a rank-1 update on a complex general matrix. 2 Specification #include #include

More information

NAG Library Function Document nag_dsygv (f08sac)

NAG Library Function Document nag_dsygv (f08sac) NAG Library Function Document nag_dsygv () 1 Purpose nag_dsygv () computes all the eigenvalues and, optionally, the eigenvectors of a real generalized symmetric-definite eigenproblem, of the form Az ¼

More information

NAG Library Function Document nag_all_regsn (g02eac)

NAG Library Function Document nag_all_regsn (g02eac) g02 Correlation and Regression Analysis g02eac 1 Purpose NAG Library Function Document nag_all_regsn (g02eac) nag_all_regsn (g02eac) calculates the residual sums of squares for all possible linear regressions

More information

NAG Library Function Document nag_zpbequ (f07htc)

NAG Library Function Document nag_zpbequ (f07htc) NAG Library Function Document nag_zpbequ () 1 Purpose nag_zpbequ () computes a diagonal scaling matrix S intended to equilibrate a complex n by n Hermitian positive definite band matrix A, with bandwidth

More information

NAG Fortran Library Routine Document F04CJF.1

NAG Fortran Library Routine Document F04CJF.1 F04 Simultaneous Linear Equations NAG Fortran Library Routine Document Note: before using this routine, please read the Users Note for your implementation to check the interpretation of bold italicised

More information

NAG Library Function Document nag_zhbevx (f08hpc)

NAG Library Function Document nag_zhbevx (f08hpc) NAG Library Function Document nag_zhbevx () 1 Purpose nag_zhbevx () computes selected eigenvalues and, optionally, eigenvectors of a complex n by n Hermitian band matrix A of bandwidth ð2k d þ 1Þ. Eigenvalues

More information

NAG Library Function Document nag_ztfttp (f01vmc)

NAG Library Function Document nag_ztfttp (f01vmc) f01 Matrix Factorizations f01vmc NAG Library Function Document nag_ztfttp (f01vmc) 1 Purpose nag_ztfttp (f01vmc) copies a complex triangular matrix, stored in a Rectangular Full Packed (RFP) format array,

More information

NAG Library Function Document nag_asian_geom_price (s30sac)

NAG Library Function Document nag_asian_geom_price (s30sac) s Approximations of Special Functions s30sac 1 Purpose NAG Library Function Document nag_asian_geom_price (s30sac) nag_asian_geom_price (s30sac) computes the Asian geometric continuous average-rate option

More information

NAG Fortran Library Routine Document F04BGF.1

NAG Fortran Library Routine Document F04BGF.1 NAG Fortran Library Routine Document Note: before using this routine, please read the Users Note for your implementation to check the interpretation of bold italicised terms and other implementation-dependent

More information

NAG Library Function Document nag_real_gen_matrix_exp (f01ecc)

NAG Library Function Document nag_real_gen_matrix_exp (f01ecc) NAG Library Function Document nag_real_gen_matrix_exp () 1 Purpose nag_real_gen_matrix_exp () computes the matrix exponential, e A,ofarealn by n matrix A. 2 Specification #include #include

More information

NAG Fortran Library Routine Document F04DHF.1

NAG Fortran Library Routine Document F04DHF.1 F04 Simultaneous Linear Equations NAG Fortran Library Routine Document Note: before using this routine, please read the Users Note for your implementation to check the interpretation of bold italicised

More information

NAG Fortran Library Routine Document F04BJF.1

NAG Fortran Library Routine Document F04BJF.1 F04 Simultaneous Linear Equations NAG Fortran Library Routine Document Note: before using this routine, please read the Users Note for your implementation to check the interpretation of bold italicised

More information

NAG Library Function Document nag_rgsn_matrix_multi_normal (g05lyc)

NAG Library Function Document nag_rgsn_matrix_multi_normal (g05lyc) 1 Purpose NAG Library Function Document nag_rgsn_matrix_multi_normal () nag_rgsn_matrix_multi_normal () sets up a reference vector and generates an array of pseudorandom numbers from a multivariate Normal

More information

NAG Library Function Document nag_dtpttr (f01vcc)

NAG Library Function Document nag_dtpttr (f01vcc) NAG Library Function Document nag_dtpttr () 1 Purpose nag_dtpttr () unpacks a real triangular matrix, stored in a standard packed format array, to a full format array. 2 Specification #include

More information

NAG Library Function Document nag_dtrttf (f01vec)

NAG Library Function Document nag_dtrttf (f01vec) f01 Matrix Factorizations f01vec NAG Library Function Document nag_dtrttf (f01vec) 1 Purpose nag_dtrttf (f01vec) copies a real triangular matrix, stored in a full format array, to a Rectangular Full Packed

More information

NAG Library Routine Document F04BEF.1

NAG Library Routine Document F04BEF.1 F04 Simultaneous Linear Equations NAG Library Routine Document Note: before using this routine, please read the Users Note for your implementation to check the interpretation of bold italicised terms and

More information

NAG Library Function Document nag_real_cholesky_skyline_solve (f04mcc)

NAG Library Function Document nag_real_cholesky_skyline_solve (f04mcc) f04 Simultaneous Linear Equations 1 Purpose NAG Library Function Document nag_real_cholesky_skyline_solve () nag_real_cholesky_skyline_solve () computes the approximate solution of a system of real linear

More information

NAG Library Function Document nag_rngs_varma_time_series (g05pcc)

NAG Library Function Document nag_rngs_varma_time_series (g05pcc) g05 Random Number Generators g05pcc 1 Purpose NAG Library Function Document nag_rngs_varma_time_series (g05pcc) nag_rngs_varma_time_series (g05pcc) generates a realization of a multivariate time series

More information

NAG C Library Function Document nag_zspcon (f07quc)

NAG C Library Function Document nag_zspcon (f07quc) 1 Purpose NAG C Library Function Document nag_zspcon () nag_zspcon () estimates the condition number of a complex symmetric matrix A, where A has been factorized by nag_zsptrf (f07qrc), using packed storage.

More information

NAG Library Function Document nag_dtfttp (f01vlc)

NAG Library Function Document nag_dtfttp (f01vlc) f01 Matrix Factorizations f01vlc NAG Library Function Document nag_dtfttp (f01vlc) 1 Purpose nag_dtfttp (f01vlc) copies a real triangular matrix, stored in a Rectangular Full Packed (RFP) format array,

More information

NAG C Library Function Document nag_zgemv (f16sac)

NAG C Library Function Document nag_zgemv (f16sac) f16 NAG Interface to BLAS f16sac 1 Purpose NAG C Library Function Document nag_zgemv (f16sac) nag_zgemv (f16sac) performs matrix-vector multiplication for a complex general matrix. 2 Specification #include

More information

NAG C Library Function Document nag_binary_factor_service (g11sbc)

NAG C Library Function Document nag_binary_factor_service (g11sbc) 1 Purpose NAG C Library Function Document nag_binary_factor_service () nag_binary_factor_service () is a service routine which may be used prior to calling nag_binary_factor (g11sac) to calculate the frequency

More information

NAG Library Function Document nag_rngs_copula_students_t (g05rbc)

NAG Library Function Document nag_rngs_copula_students_t (g05rbc) g05 Random Number Generators g05rbc 1 Purpose NAG Library Function Document nag_rngs_copula_students_t (g05rbc) nag_rngs_copula_students_t (g05rbc) sets up a reference vector and generates an array of

More information

NAG Library Function Document nag_ztgsen (f08yuc)

NAG Library Function Document nag_ztgsen (f08yuc) NAG Library Function Document nag_ztgsen () 1 Purpose nag_ztgsen () reorders the generalized Schur factorization of a complex matrix pair in generalized Schur form, so that a selected cluster of eigenvalues

More information

NAG Library Function Document nag_superlu_diagnostic_lu (f11mmc)

NAG Library Function Document nag_superlu_diagnostic_lu (f11mmc) f Large Scale Linear Systems fmmc Purpose NAG Library Function Document nag_superlu_diagnostic_lu (fmmc) nag_superlu_diagnostic_lu (fmmc) computes the reciprocal pivot growth factor of an LU factorization

More information

NAG C Library Function Document nag_dgemv (f16pac)

NAG C Library Function Document nag_dgemv (f16pac) f16 NAG Interface to BLAS f16pac 1 Purpose NAG C Library Function Document nag_dgemv (f16pac) nag_dgemv (f16pac) performs matrix-vector multiplication for a real general matrix. 2 Specification #include

More information

NAG Library Function Document nag_zggesx (f08xpc)

NAG Library Function Document nag_zggesx (f08xpc) NAG Library Function Document nag_zggesx () 1 Purpose nag_zggesx () computes the generalized eigenvalues, the generalized Schur form ðs; TÞ and, optionally, the left and/or right generalized Schur vectors

More information

NAG C Library Function Document nag_zhemv (f16scc)

NAG C Library Function Document nag_zhemv (f16scc) f16 NAG Interface to BLAS f16scc 1 Purpose NAG C Library Function Document nag_zhemv (f16scc) nag_zhemv (f16scc) performs matrix-vector multiplication for a complex Hermitian matrix. 2 Specification #include

More information

NAG C Library Function Document nag_dspcon (f07pgc)

NAG C Library Function Document nag_dspcon (f07pgc) 1 Purpose NAG C Library Function Document nag_dspcon () nag_dspcon () estimates the condition number of a real symmetric indefinite matrix A, where A has been factorized by nag_dsptrf (f07pdc), using packed

More information

NAG C Library Function Document nag_zhbmv (f16sdc)

NAG C Library Function Document nag_zhbmv (f16sdc) f16 NAG Interface to BLAS f16sdc 1 Purpose NAG C Library Function Document nag_zhbmv (f16sdc) nag_zhbmv (f16sdc) performs matrix-vector multiplication for a complex Hermitian band matrix. 2 Specification

More information

NAG Library Function Document nag_dger (f16pmc)

NAG Library Function Document nag_dger (f16pmc) f16 NAG Interface to BLAS f16pmc NAG Library Function Document nag_dger (f16pmc) 1 Purpose nag_dger (f16pmc) performs a rank-1 update on a real general matrix. 2 Specification #include #include

More information

NAG Library Function Document nag_zsymv (f16tac)

NAG Library Function Document nag_zsymv (f16tac) NAG Library Function Document nag_zsymv () 1 Purpose nag_zsymv () performs matrix-vector multiplication for a complex symmetric matrix. 2 Specification #include #include void nag_zsymv

More information

NAG Library Function Document nag_matop_complex_gen_matrix_cond_sqrt (f01kdc)

NAG Library Function Document nag_matop_complex_gen_matrix_cond_sqrt (f01kdc) f01 Matrix Factorizations f01kdc NAG Library Function Document nag_matop_complex_gen_matrix_cond_sqrt (f01kdc) 1 Purpose nag_matop_complex_gen_matrix_cond_sqrt (f01kdc) computes an estimate of the relative

More information

NAG Library Function Document nag_zhpr2 (f16ssc)

NAG Library Function Document nag_zhpr2 (f16ssc) NAG Library Function Document nag_zhpr2 () 1 Purpose nag_zhpr2 () performs a Hermitian rank-2 update on a complex Hermitian matrix stored in packed form. 2 Specification #include #include

More information

NAG Library Function Document nag_prob_lin_non_central_chi_sq (g01jcc)

NAG Library Function Document nag_prob_lin_non_central_chi_sq (g01jcc) 1 Purpose NAG Library Function Document nag_prob_lin_non_central_chi_sq () nag_prob_lin_non_central_chi_sq () returns the lower tail probability of a distribution of a positive linear combination of 2

More information

NAG C Library Function Document nag_dgbmv (f16pbc)

NAG C Library Function Document nag_dgbmv (f16pbc) f16 NAG Interface to BLAS f16pbc 1 Purpose NAG C Library Function Document nag_dgbmv (f16pbc) nag_dgbmv (f16pbc) performs matrix-vector multiplication for a real band matrix. 2 Specification #include

More information

NAG C Library Function Document nag_linf_fit (e02gcc)

NAG C Library Function Document nag_linf_fit (e02gcc) e02 Curve and Surface Fitting e02gcc 1 Purpose NAG C Library Function Document nag_linf_fit (e02gcc) nag_linf_fit (e02gcc) calculates an l 1 solution to an over-determined system of linear equations. 2

More information

NAG Library Function Document nag_superlu_lu_factorize (f11mec)

NAG Library Function Document nag_superlu_lu_factorize (f11mec) NAG Library Function Document nag_superlu_lu_factorize () 1 Purpose nag_superlu_lu_factorize () computes the LU factorization of a real sparse matrix in compressed column (Harwell Boeing), column-permuted

More information

NAG C Library Function Document nag_zhpmv (f16sec)

NAG C Library Function Document nag_zhpmv (f16sec) f16 NAG Interface to BLAS f16sec 1 Purpose NAG C Library Function Document nag_zhpmv (f16sec) nag_zhpmv (f16sec) performs matrix-vector multiplication for a complex Hermitian matrix stored in packed form.

More information

NAG Library Function Document nag_dgges (f08xac)

NAG Library Function Document nag_dgges (f08xac) f08 Least-squares and Eigenvalue Problems (LAPACK) NAG Library Function Document nag_dgges () 1 Purpose nag_dgges () computes the generalized eigenvalues, the generalized real Schur form ðs;tþ and, optionally,

More information

NAG C Library Function Document nag_dsbmv (f16pdc)

NAG C Library Function Document nag_dsbmv (f16pdc) f16 NAG Interface to BLAS f16pdc 1 Purpose NAG C Library Function Document nag_dsbmv (f16pdc) nag_dsbmv (f16pdc) performs matrix-vector multiplication for a real symmetric band matrix. 2 Specification

More information

NAG Library Function Document nag_dspr (f16pqc)

NAG Library Function Document nag_dspr (f16pqc) f16 NAG Interface to BLAS NAG Library Function Document nag_dspr () 1 Purpose nag_dspr () performs a rank-1 update on a real symmetric matrix stored in packed form. 2 Specification #include #include

More information

NAG Library Function Document nag_mv_ordinal_multidimscale (g03fcc)

NAG Library Function Document nag_mv_ordinal_multidimscale (g03fcc) g03 Multivariate Methods g03fcc 1 Purpose NAG Library Function Document nag_mv_ordinal_multidimscale (g03fcc) nag_mv_ordinal_multidimscale (g03fcc) performs non-metric (ordinal) multidimensional scaling.

More information

NAG Library Function Document nag_matop_complex_gen_matrix_fun_num (f01flc)

NAG Library Function Document nag_matop_complex_gen_matrix_fun_num (f01flc) NAG Library Function Document nag_matop_complex_gen_matrix_fun_num () 1 Purpose nag_matop_complex_gen_matrix_fun_num () computes the matrix function, fa ð Þ, of a complex n by n matrix A. Numerical differentiation

More information

NAG Fortran Library Routine Document F07AAF (DGESV).1

NAG Fortran Library Routine Document F07AAF (DGESV).1 NAG Fortran Library Routine Document Note: before using this routine, please read the Users Note for your implementation to check the interpretation of bold italicised terms and other implementation-dependent

More information

NAG Library Function Document nag_kruskal_wallis_test (g08afc)

NAG Library Function Document nag_kruskal_wallis_test (g08afc) 1 Purpose NAG Library Function Document nag_kruskal_wallis_test () nag_kruskal_wallis_test () performs the Kruskal Wallis one-way analysis of variance by ranks on k independent samples of possibly unequal

More information

NAG Library Function Document nag_dtpsv (f16plc)

NAG Library Function Document nag_dtpsv (f16plc) NAG Library Function Document nag_dtpsv () 1 Purpose nag_dtpsv () solves a system of equations given as a real triangular matrix stored in packed form. 2 Specification #include #include

More information

NAG Library Function Document nag_1d_cheb_fit_constr (e02agc)

NAG Library Function Document nag_1d_cheb_fit_constr (e02agc) 1 Purpose NAG Library Function Document nag_1d_cheb_fit_constr () nag_1d_cheb_fit_constr () computes constrained weighted least-squares polynomial approximations in Chebyshev series form to an arbitrary

More information

NAG Library Function Document nag_rand_copula_clayton (g05rhc)

NAG Library Function Document nag_rand_copula_clayton (g05rhc) 1 Purpose NAG Library Function Document nag_rand_copula_clayton () nag_rand_copula_clayton () generates pseudorandom uniform variates with joint distribution of a Clayton/Cook Johnson Archimedean copula.

More information

NAG Library Function Document nag_real_symm_sparse_eigensystem_sol (f12fcc)

NAG Library Function Document nag_real_symm_sparse_eigensystem_sol (f12fcc) NAG Library Function Document nag_real_symm_sparse_eigensystem_sol () Note: this function uses optional arguments to define choices in the problem specification. If you wish to use default settings for

More information

NAG Library Function Document nag_dgb_norm (f16rbc)

NAG Library Function Document nag_dgb_norm (f16rbc) f16 NAG Interface to BLAS f16rbc NAG Library Function Document nag_dgb_norm (f16rbc) 1 Purpose nag_dgb_norm (f16rbc) calculates the value of the 1-norm, the 1-norm, the Frobenius norm or the maximum absolute

More information

NAG Library Function Document nag_mv_distance_mat (g03eac)

NAG Library Function Document nag_mv_distance_mat (g03eac) g03 Multivariate Methods g03eac 1 Purpose NAG Library Function Document nag_mv_distance_mat (g03eac) nag_mv_distance_mat (g03eac) computes a distance (dissimilarity) matrix. 2 Specification #include

More information

NAG Library Function Document nag_asian_geom_greeks (s30sbc)

NAG Library Function Document nag_asian_geom_greeks (s30sbc) 1 Purpose NAG Library Function Document nag_asian_geom_greeks () nag_asian_geom_greeks () computes the Asian geometric continuous average-rate option price together with its sensitivities (Greeks). 2 Specification

More information

NAG Library Function Document. nag_matop_complex_gen_matrix_cond_num

NAG Library Function Document. nag_matop_complex_gen_matrix_cond_num NAG Library Function Document nag_matop_complex_gen_matrix_cond_num () 1 Purpose nag_matop_complex_gen_matrix_cond_num () computes an estimate of the absolute condition number of a matrix function f of

More information

NAG Library Function Document nag_mv_discrim (g03dac)

NAG Library Function Document nag_mv_discrim (g03dac) 1 Purpose NAG Library Function Document nag_mv_discrim () nag_mv_discrim () computes a test statistic for the equality of within-group covariance matrices and also computes matrices for use in discriminant

More information

NAG Library Function Document nag_zhfrk (f16zqc)

NAG Library Function Document nag_zhfrk (f16zqc) NAG Library Function Document nag_zhfrk () 1 Purpose nag_zhfrk () performs one of the Hermitian rank-k update operations C AA H þ C or C A H A þ C; where A is a complex matrix, C is an n by n complex Hermitian

More information

NAG Library Function Document nag_bsm_greeks (s30abc)

NAG Library Function Document nag_bsm_greeks (s30abc) s Approximations of Special Functions s30abc 1 Purpose NAG Library Function Document nag_bsm_greeks (s30abc) nag_bsm_greeks (s30abc) computes the European option price given by the Black Scholes Merton

More information

NAG Library Function Document nag_dgbmv (f16pbc)

NAG Library Function Document nag_dgbmv (f16pbc) NAG Library Function Document nag_dgbmv () 1 Purpose nag_dgbmv () performs matrix-vector multiplication for a real band matrix. 2 Specification #include #include void nag_dgbmv (Nag_OrderType

More information

NAG Library Function Document nag_rand_bivariate_copula_frank (g05rfc)

NAG Library Function Document nag_rand_bivariate_copula_frank (g05rfc) 1 Purpose NAG Library Function Document nag_rand_bivariate_copula_frank () nag_rand_bivariate_copula_frank () generates pseudorandom uniform bivariates with joint distribution of a Frank Archimedean copula.

More information

NAG Library Function Document. nag_matop_real_gen_matrix_cond_num

NAG Library Function Document. nag_matop_real_gen_matrix_cond_num NAG Library Function Document nag_matop_real_gen_matrix_cond_num () 1 Purpose nag_matop_real_gen_matrix_cond_num () computes an estimate of the absolute condition number of a matrix function f at a real

More information

NAG Library Routine Document F07MAF (DSYSV).1

NAG Library Routine Document F07MAF (DSYSV).1 NAG Library Routine Document Note: before using this routine, please read the Users Note for your implementation to check the interpretation of bold italicised terms and other implementation-dependent

More information

NAG Library Function Document nag_matop_real_gen_matrix_fun_num (f01elc)

NAG Library Function Document nag_matop_real_gen_matrix_fun_num (f01elc) NAG Library Function Document nag_matop_real_gen_matrix_fun_num () 1 Purpose nag_matop_real_gen_matrix_fun_num () computes the matrix function, fa ð Þ,ofarealnby n matrix A. Numerical differentiation is

More information

NAG Library Function Document nag_partial_corr (g02byc)

NAG Library Function Document nag_partial_corr (g02byc) g02 Correlation and Regression Analysis g02byc 1 Purpose NAG Library Function Document nag_partial_corr (g02byc) nag_partial_corr (g02byc) computes a partial correlation/variance-covariance matrix from

More information

NAG Library Function Document nag_mesh2d_inc (d06aac)

NAG Library Function Document nag_mesh2d_inc (d06aac) NAG Library Function Document nag_mesh2d_inc () 1 Purpose nag_mesh2d_inc () generates a triangular mesh of a closed polygonal region in IR 2, given a mesh of its boundary It uses a simple incremental method

More information

NAG Library Function Document nag_1d_cheb_intg (e02ajc)

NAG Library Function Document nag_1d_cheb_intg (e02ajc) 1 Purpose NAG Library Function Document nag_1d_cheb_intg () nag_1d_cheb_intg () determines the coefficients in the Chebyshev series representation of the indefinite integral of a polynomial given in Chebyshev

More information

NAG Library Function Document nag_real_symm_sparse_eigensystem_init (f12fac)

NAG Library Function Document nag_real_symm_sparse_eigensystem_init (f12fac) 1 Purpose NAG Library Function Document nag_real_symm_sparse_eigensystem_init () nag_real_symm_sparse_eigensystem_init () is a setup function in a suite of functions consisting of nag_real_symm_sparse_eigensystem_init

More information

NAG C Library Function Document nag_rngs_varma_time_series (g05pcc)

NAG C Library Function Document nag_rngs_varma_time_series (g05pcc) g05 Random Number Generators g05pcc 1 Purpose NAG C Library Function Document nag_rngs_varma_time_series (g05pcc) nag_rngs_varma_time_series (g05pcc) generates a realisation of a multivariate time series

More information

NAG Library Function Document nag_glm_tran_model (g02gkc)

NAG Library Function Document nag_glm_tran_model (g02gkc) 1 Purpose NAG Library Function Document nag_glm_tran_model () nag_glm_tran_model () calculates the estimates of the arguments of a generalized linear model for given constraints from the singular value

More information

NAG Library Function Document nag_tsa_multi_part_lag_corr (g13dnc)

NAG Library Function Document nag_tsa_multi_part_lag_corr (g13dnc) 1 Purpose NAG Library Function Document nag_tsa_multi_part_lag_corr () nag_tsa_multi_part_lag_corr () calculates the sample partial lag correlation matrices of a multivariate time series. A set of 2 -statistics

More information

NAG Library Function Document nag_dummy_vars (g04eac)

NAG Library Function Document nag_dummy_vars (g04eac) 1 Purpose NAG Library Function Document nag_dummy_vars () nag_dummy_vars () computes orthogonal polynomial or dummy variables for a factor or classification variable. 2 Specification #include #include

More information

NAG Library Function Document nag_corr_cov (g02bxc)

NAG Library Function Document nag_corr_cov (g02bxc) 1 Purpose NAG Library Function Document nag_corr_cov () nag_corr_cov () calculates the Pearson product-moment correlation coefficients and the variancecovariance matrix for a set of data. Weights may be

More information

NAG C Library Function Document nag_surviv_risk_sets (g12zac)

NAG C Library Function Document nag_surviv_risk_sets (g12zac) g12 Survival Analysis g12zac 1 Purpose NAG C Library Function Document nag_surviv_risk_sets (g12zac) nag_surviv_risk_sets (g12zac) creates the risk sets associated with the Cox proportional hazards model

More information