NAG C Library Function Document nag_anova_row_col (g04bcc)

Size: px
Start display at page:

Download "NAG C Library Function Document nag_anova_row_col (g04bcc)"

Transcription

1 1 Purpose NAG C Library Function Document nag_anova_row_col () nag_anova_row_col () computes the analysis of variance for a general row and column design together with the treatment means and standard errors. 2 Specification #include <nag.h> #include <nagg04.h> void nag_anova_row_col (Integer nrep, Integer nrow, Integer ncol, const double y[], Integer nt, const Integer it[], double *gmean, double tmean[], double table[], double c[], Integer tdc, Integer irep[], double rpmean[], double rmean[], double cmean[], double r[], double ef[], double tol, Integer irdf, NagError *fail) 3 Description In a row and column design the experimental material can be characterized by a two-way classification, nominally called rows and columns. Each experimental unit can be considered as being located in a particular row and column. It is assumed that all rows are of the same length and all columns are of the same length. Sets of equal numbers of rows and columns can be grouped together to form replicates, sometimes known as squares or rectangles, as appropriate. If for a replicate, the number of rows, the number of columns and the number of treatments are equal and every treatment occurs once in each row and each column then the design is a Latin square. If this is not the case the treatments will be non-orthogonal to rows and columns. For example in the case of a lattice square each treatment occurs only once in each square. For a row and column design, with t treatments in r rows and c columns and b replicates or squares with n ¼ brc observations, the linear model is: y ijkðlþ ¼ þ i þ j þ k þ l þ e ijk i ¼ 1; 2...;b; j ¼ 1; 2;...;r; k ¼ 1; 2...;c; l ¼ 1; 2;...;t, where i is the effect of the ith replicate, j is the effect of the jth row, k is the effect of the kth column and the ijkðlþ notation indicates that the lth treatment is applied to the unit in row j, column k of replicate i. To compute the analysis of variance for a row and column design the mean is computed and subtracted from the observations to give, y 0 ijkðlþ ¼ y ijkðlþ ^. Since the replicates, rows and columns are orthogonal the estimated effects, ignoring treatment effects, ^ i, ^ j, ^ k, can be computed using the appropriate means of the y 0 ijkðlþ, and the unadjusted sum of squares computed as the appropriate sum of squared totals for the y 0 ijkðlþ divided by number of units per total. The observations adjusted for replicates, rows and columns can then be computed by subtracting the estimated effects from y 0 ijkðlþ to give y00 ijkðlþ. In the case of a Latin square design the treatments are orthogonal to replicates, rows and columns and so the treatment effects, ^ l, can be estimated as the treatment means of the adjusted observations, y 00 ijkðlþ. The treatment sum of squares is computed as the sum of squared treatment totals of the y 00 ijðlþ divided by the number of times each treatment is replicated. Finally the residuals, and hence the residual sum of squares, are given by, r ijðlþ ¼ y 00 ijðlþ ^ l. For a design which is not orthogonal, for example a lattice square or an incomplete Latin square, the treatment effects adjusted for replicates, rows and columns need to be computed. The adjusted treatment effects are found as the solution to the equations: A^ ¼ðR N b N T b =ðrcþ N rn T r =ðbcþ N cn T c =ðbrþþ^ ¼ q.1

2 NAG C Library Manual where q is the vector of the treatment totals of the observations adjusted for replicates, rows and columns, y 00 ijkðlþ ; R is a diagonal matrix with R ll equal to the number of times the lth treatment is replicated, and N b is the t by b incidence matrix, with N l;i equal to the number of times treatment l occurs in replicate i, with N r and N c being similarly defined for rows and columns. The solution to the equations can be written as: ^ ¼ q where, is a generalized inverse of A. The solution is found from the eigenvalue decomposition of A. The residuals are first calculated by subtracting the estimated adjusted treatment effects from the adjusted observations to give r 0 ijðlþ ¼ y00 ijðlþ ^ l. However, since only the unadjusted replicate, row and column effects have been removed and they are not orthogonal to treatments, the replicate, row and column means of the r 0 ijðlþ have to be subtracted to give the correct residuals, r ijðlþ and residual sum of squares. Given the sums of squares, the mean squares are computed as the sums of squares divided by the degrees of freedom. The degrees of freedom for the unadjusted replicates, rows and columns are b 1, r 1 and c 1 respectively and for the Latin square designs the degrees of freedom for the treatments is t 1. In the general case the degrees of freedom for treatments is the rank of the matrix. The F-statistic given by the ratio of the treatment mean square to the residual mean square tests the hypothesis: H 0 : 1 ¼ 2 ¼...¼ t ¼ 0: The standard errors for the difference in treatment effects, or treatment means, for Latin square designs, are given by: p seð^ j ^ j Þ¼ ffiffiffiffiffiffiffiffiffiffiffiffiffiffiffiffi 2s 2 =ðbtþ where s 2 is the residual mean square. In the general case the variances of the treatment effects are given by: Varð^Þ ¼s 2 from which the appropriate standard errors of the difference between treatment effects or the difference between adjusted means can be calculated. The analysis of a row-column design can be considered as consisting of different strata: the replicate stratum, the rows within replicate and the columns within replicate strata and the units stratum. In the Latin square design all the information on the treatment effects is given at the units stratum. In other designs there may be a loss of information due to the non-orthogonality of treatments and replicates, rows and columns and information on treatments may be available in higher strata. The efficiency of the estimation at the units stratum is given by the (canonical) efficiency factors, these are the non-zero eigenvalues of the matrix, A, divided by the number of replicates in the case of equal replication, or by the mean of the number of replicates in the unequally replicated case, (see John (1987)). If more than one eigenvalue is zero then the design is said to be disconnected and information on some treatment comparisons can only be obtained from higher strata. 4 Parameters 1: nrep Integer Input On entry: the number of replicates, b. Constraint: nrep 1. 2: nrow Integer Input On entry: the number of rows per replicate, r. Constraint: nrow 2. 3: ncol Integer Input On entry: the number of columns per replicate, c. Constraint: ncol 2..2

3 4: y[nrep*nrow*ncol] const double Input On entry: the n ¼ brc observations ordered by columns within rows within replicates. That is y[rcði 1Þþrðj 1Þþk 1] contains the observation from the k column of the jth row of the ith replicate, i ¼ 1; 2;...;b; j ¼ 1; 2...;r; k ¼ 1; 2;...;c. 5: nt Integer Input On entry: the number of treatments. If only replicates, rows and columns are required in the analysis then set nt ¼ 1. Constraint: nt 1. 6: it[dim1] const Integer Input Note: the dimension, dim1, of the array it must be at least nrepnrowncol if nt > 1, and 1 otherwise. On entry: if nt > 1, it½i 1Š indicates which of the nt treatments unit i received, i ¼ 1; 2;...;n.If nt ¼ 1, it is not referenced. Constraint: if nt 2, 1 it½i 1Š nt, for i ¼ 1; 2;...;n. 7: gmean double * Output On exit: the grand mean, ^. 8: tmean[nt] double Output On exit: if nt 2, tmean½l 1Š contains the (adjusted) mean for the lth treatment, ^ þ ^ l, l ¼ 1; 2;...;t, where ^ is the mean of the treatment adjusted observations y ijkðlþ ^ l. Otherwise tmean is not referenced. 9: table[6][5] double Output On exit: the analysis of variance table. Column 1 contains the degrees of freedom, column 2 the sum of squares, and where appropriate, column 3 the mean squares, column 4 the F-statistic and column 5 the significance level of the F-statistic. Row 1 is for replicates, row 2 for rows, row 3 for columns, row 4 for treatments (if nt > 1), row 5 for residual and row 6 for total. Mean squares are computed for all but the total row, F-statistics and significance are computed for treatments, replicates, rows and columns. Any unfilled cells are set to zero. 10: c[nt][tdc] double Output On exit: the upper triangular part of c contains the variance-covariance matrix of the treatment effects, the strictly lower triangular part contains the standard errors of the difference between two treatment effects (means), i.e., c½i 1Š½j 1Š contains the covariance of treatment i and j if j i and the standard error of the difference between treatment i and j if j < i, i ¼ 1; 2;...; t; j ¼ 1; 2;...;t. 11: tdc Integer Input On entry: the second dimension of the array c as declared in the function from which nag_anova_row_col is called. Constraint: tdc nt. 12: irep[nt] Integer Output On exit: if nt > 1, irep½l 1Š contains the treatment replications, R ll, l ¼ 1; 2;...;nt. Otherwise irep is not referenced. 13: rpmean[nrep] double Output On exit: if nrep > 1, rpmean½i 1Š contains the mean for the ith replicate, ^ þ ^ i, i ¼ 1; 2;...;b. Otherwise rpmean is not referenced..3

4 NAG C Library Manual 14: rmean[nrep*nrow] double Output On exit: rmean½j 1Š contains the mean for the jth row, ^ þ ^ i, j ¼ 1; 2;...;r. 15: cmean[nrep*ncol] double Output On exit: cmean½k 1Š contains the mean for the kth column, ^ þ ^ k, k ¼ 1; 2;...;c. 16: r[nrep*nrow*ncol] double Output On exit: r½i 1Š contains the residuals, r i, i ¼ 1; 2;...;n. 17: ef[nt] double Output On exit: if nt 2, the canonical efficiency factors. Otherwise ef is not referenced. 18: tol double Input On entry: the tolerance value used to check for zero eigenvalues of the matrix. Iftol ¼ 0.0 a default value of is used. Constraint: tol : irdf Integer Input On entry: an adjustment to the degrees of freedom for the residual and total. If irdf 1 the degrees of freedom for the total is set to n irdf and the residual degrees of freedom adjusted accordingly. If irdf ¼ 0, the total degrees of freedom for the total is set to n 1, as usual. Constraint: irdf 0. 20: fail NagError * Input/Output The NAG error parameter (see the Essential Introduction). 5 Error Indicators and Warnings NE_INT_ARG_LT On entry, nrep must not be less than 1: nrep ¼ <value>. On entry, nrow must not be less than 2: nrow ¼ <value>. On entry, ncol must not be less than 2: ncol ¼ <value>. On entry, nt must not be less than 1: nt ¼ <value>. On entry, irdf must not be less than 0: irdf ¼ <value>. NE_2_INT_ARG_LT On entry, tdc ¼ <value> while nt ¼ <value>. These parameters must satisfy tdc nt. NE_REAL_ARG_LT On entry, tol must not be less than 0.0: tol ¼ <value>. NE_ARRAY_CONS The contents of array it are not valid. Constraint: if nt 2, 1 it[i] nt, i ¼ 0; 1; 2;...;nrepnrowncol. The contents of array it are not valid. Constraint: some value of it ¼ j for all j ¼ 1,2,...,nt..4

5 NE_ALLOC_FAIL Memory allocation failed. NE_ARRAY_CONSTANT On entry, the elements of the array y are constant. NE_G04BC_ST_ERR A computed standard error is zero due to rounding errors, or the eigenvalue computation failed to converge. Both are unlikely errors. NE_G04BC_REPS The treatments are totally confounded with replicates, rows and columns, so the treatment sum of squares and degrees of freedom are zero. The analysis of variance table is not computed, except for replicate, row, column, total sum of squares and degrees of freedom. NE_G04BC_RESD The residual degrees of freedom or the residual sum of squares are zero, columns 3, 4 and 5 of the analysis of variance table will not be computed and the matrix of standard errors and covariances, c, will not be scaled. NE_G04BC_DISCON The design is disconnected, the standard errors may not be valid. The design may have a nested structure. 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. 6 Further Comments To estimate missing values the Healy and Westmacott procedure or its derivatives may be used (see John and Quenouille (1977)). This is an iterative procedure in which estimates of the missing values are adjusted by subtracting the corresponding values of the residuals. The new estimates are then used in the analysis of variance. This process is repeated until convergence. A suitable initial value may be the grand mean. When using this procedure irdf should be set to the number of missing values plus one to obtain the correct degrees of freedom for the residual sum of squares. For analysis of covariance the residuals are obtained from an analysis of variance of both the response variable and the covariates. The residuals from the response variable are then regressed on the residuals from the covariates using, say, nag_regress_confid_interval (g02cbc) or nag_regsn_mult_linear (g02dac). The results from those routines can be used to test for the significance of the covariates. To test the significance of the treatment effects after fitting the covariate, the residual sum of squares from the regression should be compared with the residual sum of squares obtained from the equivalent regression but using the residuals from fitting replicates, rows and columns only. 6.1 Accuracy The algorithm used in this routine, described in Section 3, achieves greater accuracy than the traditional algorithms based on the subtraction of sums of squares. 6.2 References Cochran W G and Cox G M (1957) Experimental Designs Wiley Davis O L (1978) The Design and Analysis of Industrial Experiments Longman John J A (1987) Cyclic Designs Chapman and Hall.5

6 NAG C Library Manual John J A and Quenouille M H (1977) Experiments: Design and Analysis Griffin Searle S R (1971) Linear Models Wiley 7 See Also nag_regress_confid_interval (g02cbc) nag_regsn_mult_linear (g02dac) 8 Example The data for a 5 5 Latin square is input and the ANOVA and treatment means computed and printed. Since the design is orthogonal only one standard error need be printed 8.1 Program Text /* nag_anova_row_col () Example Program. * * Copyright 2000 Numerical Algorithms Group. * * Mark 6, */ #include <stdio.h> #include <nag.h> #include <nag_stdlib.h> #include <nagg04.h> int main (void) { const char *fmt_99999[]={"%3.0f ", "%10.4f ", "%10.4f ", "%10.4f ", "%8.4f"}; double *c=0, c_b20=1e-5, *cmean=0, *ef=0, gmean, *r=0, *rmean=0, *rpmean=0; double *table=0, *tmean=0, *y=0; Integer c 0=0, i, *irep, *it, j, n, ncol, nrep, nrow, nt; Integer exit_status=0; NagError fail; #define TABLE(I,J) table[((i)-1)*5 + (J)-1] #define C(I,J) c[((i)-1)*nt + (J)-1] INIT_FAIL(fail); Vprintf(" Example Program Results\n"); /* Skip heading in data file */ Vscanf("%*[^\n]"); Vscanf("%ld %ld %ld %ld", &nrep, &nrow, &ncol, &nt); if (!(c = NAG_ALLOC(nt*nt, double))!(cmean = NAG_ALLOC(nrep*ncol, double))!(ef = NAG_ALLOC(nt, double))!(r = NAG_ALLOC(nrep*nrow*ncol, double))!(y = NAG_ALLOC(nrep*nrow*ncol, double))!(rmean = NAG_ALLOC(nrep*nrow, double))!(rpmean = NAG_ALLOC(nrep, double))!(tmean = NAG_ALLOC(nt, double))!(table = NAG_ALLOC(30, double))!(irep = NAG_ALLOC(nt, Integer)).6

7 !(it = NAG_ALLOC(nrep*nrow*ncol, Integer))) { Vprintf("Allocation failure\n"); exit_status = -1; goto END; } n = nrep * nrow * ncol; for (i = 1; i <= n; ++i) Vscanf("%lf", &y[i - 1]); for (i = 1; i <= n; ++i) Vscanf("%ld", &it[i - 1]); (nrep, nrow, ncol, y, nt, it, &gmean, tmean, table, c, nt, irep, rpmean, rmean, cmean, r, ef, c_b20, c 0, &fail); if (fail.code!= NE_NOERROR) { Vprintf("Error from.\n%s\n", fail.message); exit_status = 1; goto END; } Vprintf("\n"); Vprintf("%s\n"," ANOVA TABLE"); Vprintf("\n"); if (nrep > 1) { Vprintf("\n%s", " Reps "); for (j = 1; j <= 5; ++j) Vprintf(fmt_99999[j-1], TABLE(1,j)); } Vprintf("\n%s"," Rows "); for (j = 1; j <= 5; ++j) Vprintf(fmt_99999[j-1], TABLE(2,j)); Vprintf("\n%s", " Columns "); for (j = 1; j <= 5; ++j) Vprintf(fmt_99999[j-1], TABLE(3,j)); Vprintf("\n\n%s", " Treatments "); for (j = 1; j <= 5; ++j) Vprintf(fmt_99999[j-1], TABLE(4,j)); Vprintf("\n%s", " Residual "); for (j = 1; j <= 3; ++j) Vprintf(fmt_99999[j-1], TABLE(5,j)); Vprintf("\n%s", " Total "); for (j = 1; j <= 2; ++j) Vprintf(fmt_99999[j-1], TABLE(6,j)); Vprintf("\n%s\n\n", " Treatment means"); for (i = 1; i <= nt; ++i) Vprintf("%10.4f%s", tmean[i - 1], i%6?"":"\n"); Vprintf("\n\n%s%10.4f\n", " S.E. of difference (orthogonal design) = ", C(2,1)); END: if (c) NAG_FREE(c); if (cmean) NAG_FREE(cmean);.7

8 NAG C Library Manual if (ef) NAG_FREE(ef); if (r) NAG_FREE(r); if (y) NAG_FREE(y); if (rmean) NAG_FREE(rmean); if (rpmean) NAG_FREE(rpmean); if (tmean) NAG_FREE(tmean); if (table) NAG_FREE(table); if (irep) NAG_FREE(irep); if (it) NAG_FREE(it); return exit_status; } 8.2 Program Data Example Program Data Program Results Example Program Results ANOVA TABLE Rows Columns Treatments Residual Total Treatment means S.E. of difference (orthogonal design) =

9 .9 (last)

NAG Library Function Document nag_anova_random (g04bbc)

NAG Library Function Document nag_anova_random (g04bbc) 1 Purpose NAG Library Function Document nag_anova_random () nag_anova_random () computes the analysis of variance and treatment means and standard errors for a randomized block or completely randomized

More information

nag anova random (g04bbc)

nag anova random (g04bbc) g04 Analysis of Variance g04bbc 1. Purpose nag anova random (g04bbc) nag anova random (g04bbc) computes the analysis of variance and treatment means and standard errors for a randomized block or completely

More information

nag anova factorial (g04cac)

nag anova factorial (g04cac) g04 Analysis of Variance g04cac 1. Purpose nag anova factorial (g04cac) nag anova factorial (g04cac) computes an analysis of variance table and treatment means for a complete factorial design. 2. Specification

More information

NAG C Library Function Document nag_kruskal_wallis_test (g08afc)

NAG C Library Function Document nag_kruskal_wallis_test (g08afc) 1 Purpose NAG C 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 C Library Function Document nag_rank_regsn (g08rac)

NAG C Library Function Document nag_rank_regsn (g08rac) 1 Purpose NAG C Library Function Document nag_rank_regsn () nag_rank_regsn () calculates the parameter estimates, score statistics and their variance-covariance matrices for the linear model using a likelihood

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 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

NAG Library Function Document nag_regsn_mult_linear_upd_model (g02ddc)

NAG Library Function Document nag_regsn_mult_linear_upd_model (g02ddc) NAG Library Function Document nag_regsn_mult_linear_upd_model () 1 Purpose nag_regsn_mult_linear_upd_model () calculates the regression arguments for a general linear regression model. It is intended to

More information

NAG Library Function Document nag_dummy_vars (g04eac)

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

More information

NAG C Library Function Document nag_cp_stat (g02ecc)

NAG C Library Function Document nag_cp_stat (g02ecc) g02 Correlation and Regression Analysis NAG C Library Function Document nag_cp_stat () 1 Purpose nag_cp_stat () calculates R 2 and C p -values from the residual sums of squares for a series of linear regression

More information

nag regsn mult linear upd model (g02ddc)

nag regsn mult linear upd model (g02ddc) 1. Purpose nag regsn mult linear upd model () nag regsn mult linear upd model () calculates the regression parameters for a general linear regression model. It is intended to be called after nag regsn

More information

NAG Library Function Document nag_regsn_mult_linear_delete_var (g02dfc)

NAG Library Function Document nag_regsn_mult_linear_delete_var (g02dfc) NAG Library Function Document nag_regsn_mult_linear_delete_var () 1 Purpose nag_regsn_mult_linear_delete_var () deletes an independent variable from a general linear regression model. 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 C Library Function Document nag_tsa_multi_part_lag_corr (g13dnc)

NAG C Library Function Document nag_tsa_multi_part_lag_corr (g13dnc) 1 Purpose NAG C 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

More information

NAG Library Function Document nag_durbin_watson_stat (g02fcc)

NAG Library Function Document nag_durbin_watson_stat (g02fcc) NAG Library Function Document nag_durbin_watson_stat () 1 Purpose nag_durbin_watson_stat () calculates the Durbin Watson statistic, for a set of residuals, and the upper and lower bounds for its significance.

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_regsn_mult_linear_addrem_obs (g02dcc)

NAG Library Function Document nag_regsn_mult_linear_addrem_obs (g02dcc) NAG Library Function Document nag_regsn_mult_linear_addrem_obs () 1 Purpose nag_regsn_mult_linear_addrem_obs () adds or deletes an observation from a general regression model fitted by nag_regsn_mult_linear

More information

NAG C Library Function Document nag_tsa_multi_auto_corr_part (g13dbc)

NAG C Library Function Document nag_tsa_multi_auto_corr_part (g13dbc) g13 Time Series Analysis g13dbc 1 Purpose NAG C Library Function Document nag_tsa_multi_auto_corr_part (g13dbc) nag_tsa_multi_auto_corr_part (g13dbc) calculates the multivariate partial autocorrelation

More information

NAG C Library Function Document nag_tsa_multi_cross_corr (g13dmc)

NAG C Library Function Document nag_tsa_multi_cross_corr (g13dmc) g13 Time Series Analysis g13dmc 1 Purpose NAG C Library Function Document nag_tsa_multi_cross_corr (g13dmc) nag_tsa_multi_cross_corr (g13dmc) calculates the sample cross-correlation (or cross-covariance)

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_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_mv_discrim (g03dac)

NAG Library Function Document nag_mv_discrim (g03dac) g03 Multivariate Methods g03dac NAG Library Function Document nag_mv_discrim (g03dac) 1 Purpose nag_mv_discrim (g03dac) computes a test statistic for the equality of within-group covariance matrices and

More information

NAG Library Function Document nag_friedman_test (g08aec)

NAG Library Function Document nag_friedman_test (g08aec) NAG Library Function Document nag_friedman_test () 1 Purpose nag_friedman_test () performs the Friedman two-way analysis of variance by ranks on k related samples of size n. 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_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_smooth_spline_fit (g10abc)

NAG Library Function Document nag_smooth_spline_fit (g10abc) 1 Purpose NAG Library Function Document nag_smooth_spline_fit () nag_smooth_spline_fit () fits a cubic smoothing spline for a given smoothing parameter. 2 Specification #include #include

More information

nag glm est func (g02gnc)

nag glm est func (g02gnc) g02 Regression Analysis g02gnc 1. Purpose nag glm est func (g02gnc) nag glm est func (g02gnc) gives the estimate of an estimable function along with its standard error from the results from fitting a generalized

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_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 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_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 Library Function Document nag_kruskal_wallis_test (g08afc)

NAG Library Function Document nag_kruskal_wallis_test (g08afc) NAG Library Function Document nag_kruskal_wallis_test () 1 Purpose 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 regsn mult linear add var (g02dec)

nag regsn mult linear add var (g02dec) g02 Regression Analysis g02dec nag regsn mult linear add var (g02dec) 1. Purpose nag regsn mult linear add var (g02dec) adds a new independent variable to a general linear regression model. 2. Specification

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_outlier_peirce (g07gac)

NAG Library Function Document nag_outlier_peirce (g07gac) g07 Univariate Estimation g07gac NAG Library Function Document nag_outlier_peirce (g07gac) 1 Purpose nag_outlier_peirce (g07gac) identifies outlying values using Peirce s criterion. 2 Specification #include

More information

NAG Library Function Document nag_mv_prin_comp (g03aac)

NAG Library Function Document nag_mv_prin_comp (g03aac) g03 Multivariate Methods g03aac NAG Library Function Document nag_mv_prin_comp (g03aac) 1 Purpose nag_mv_prin_comp (g03aac) performs a principal component analysis on a data matrix; both the principal

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_tsa_dickey_fuller_unit (g13awc)

NAG Library Function Document nag_tsa_dickey_fuller_unit (g13awc) NAG Library Function Document nag_tsa_dickey_fuller_unit () 1 Purpose nag_tsa_dickey_fuller_unit () returns the (augmented) Dickey Fuller unit root test. 2 Specification #include #include

More information

NAG Library Function Document nag_chi_sq_2_way_table (g11aac)

NAG Library Function Document nag_chi_sq_2_way_table (g11aac) NAG Library Function Document nag_chi_sq_2_way_table () 1 Purpose nag_chi_sq_2_way_table () computes 2 statistics for a two-way contingency table For a 2 2 table with a small number of observations exact

More information

NAG Library Function Document nag_regress_confid_interval (g02cbc)

NAG Library Function Document nag_regress_confid_interval (g02cbc) NAG Library Function Document nag_regress_confid_interval () 1 urpose nag_regress_confid_interval () performs a simple linear regression with or without a constant term. The data is optionally weighted,

More information

NAG Library Function Document nag_smooth_spline_fit (g10abc)

NAG Library Function Document nag_smooth_spline_fit (g10abc) g10 Smoothing in Statistics g10abc NAG Library Function Document nag_smooth_spline_fit (g10abc) 1 Purpose nag_smooth_spline_fit (g10abc) fits a cubic smoothing spline for a given smoothing parameter. 2

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 Library Function Document nag_prob_durbin_watson (g01epc)

NAG Library Function Document nag_prob_durbin_watson (g01epc) NAG Library Function Document nag_prob_durbin_watson () 1 Purpose nag_prob_durbin_watson () calculates upper and lower bounds for the significance of a Durbin Watson statistic. 2 Specification #include

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_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 regsn mult linear est func (g02dnc)

nag regsn mult linear est func (g02dnc) 1. Purpose nag regsn mult linear est func () nag regsn mult linear est func () gives the estimate of an estimable function along with its standard error. 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_ode_bvp_fd_lin_gen (d02gbc)

NAG Library Function Document nag_ode_bvp_fd_lin_gen (d02gbc) NAG Library Function Document nag_ode_bvp_fd_lin_gen () 1 Purpose nag_ode_bvp_fd_lin_gen () solves a general linear two-point boundary value problem for a system of ordinary differential equations using

More information

NAG Library Function Document nag_kalman_sqrt_filt_info_var (g13ecc)

NAG Library Function Document nag_kalman_sqrt_filt_info_var (g13ecc) g13 Time Series Analysis g13ecc NAG Library Function Document nag_kalman_sqrt_filt_info_var (g13ecc) 1 Purpose nag_kalman_sqrt_filt_info_var (g13ecc) performs a combined measurement and time update of

More information

NAG Library Function Document nag_corr_cov (g02bxc)

NAG Library Function Document nag_corr_cov (g02bxc) NAG Library Function Document nag_corr_cov () 1 Purpose 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 Library Function Document nag_ode_bvp_fd_nonlin_fixedbc (d02gac)

NAG Library Function Document nag_ode_bvp_fd_nonlin_fixedbc (d02gac) NAG Library Function Document nag_ode_bvp_fd_nonlin_fixedbc () 1 Purpose nag_ode_bvp_fd_nonlin_fixedbc () solves the two-point boundary value problem with assigned boundary values for a system of ordinary

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_tsa_cross_spectrum_bivar (g13cec)

NAG Library Function Document nag_tsa_cross_spectrum_bivar (g13cec) g13 Time Series Analysis g13cec 1 Purpose NAG Library Function Document nag_tsa_cross_spectrum_bivar (g13cec) For a bivariate time series, nag_tsa_cross_spectrum_bivar (g13cec) calculates the cross amplitude

More information

NAG Library Function Document nag_rand_2_way_table (g05pzc)

NAG Library Function Document nag_rand_2_way_table (g05pzc) g05 Random Number Generators g05pzc 1 Purpose NAG Library Function Document nag_rand_2_way_table (g05pzc) nag_rand_2_way_table (g05pzc) generates a random two-way table. 2 Specification #include

More information

nag mv orthomax (g03bac)

nag mv orthomax (g03bac) 1. Purpose nag mv orthomax () nag mv orthomax () computes orthogonal rotations for a matrix of loadings using a generalized orthomax criterion. 2. Specification #include #include void

More information

NAG C Library Function Document nag_tsa_spectrum_univar_cov (g13cac)

NAG C Library Function Document nag_tsa_spectrum_univar_cov (g13cac) g13 Time Series Analysis g13cac 1 Purpose NAG C Library Function Document nag_tsa_spectrum_univar_cov (g13cac) nag_tsa_spectrum_univar_cov (g13cac) calculates the smoothed sample spectrum of a univariate

More information

NAG Library Function Document nag_tsa_noise_spectrum_bivar (g13cgc)

NAG Library Function Document nag_tsa_noise_spectrum_bivar (g13cgc) g13 Time Series Analysis g13cgc NAG Library Function Document nag_tsa_noise_spectrum_bivar (g13cgc) 1 Purpose For a bivariate time series, nag_tsa_noise_spectrum_bivar (g13cgc) calculates the noise spectrum

More information

NAG Library Function Document nag_robust_m_corr_user_fn_no_derr (g02hmc)

NAG Library Function Document nag_robust_m_corr_user_fn_no_derr (g02hmc) NAG Library Function Document nag_robust_m_corr_user_fn_no_derr () 1 Purpose nag_robust_m_corr_user_fn_no_derr () computes a robust estimate of the covariance matrix for user-supplied weight functions.

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_robust_m_corr_user_fn (g02hlc)

NAG Library Function Document nag_robust_m_corr_user_fn (g02hlc) NAG Library Function Document nag_robust_m_corr_user_fn () Purpose nag_robust_m_corr_user_fn () calculates a robust estimate of the covariance matrix for usersupplied weight functions and their derivatives.

More information

NAG Library Function Document nag_tsa_exp_smooth (g13amc)

NAG Library Function Document nag_tsa_exp_smooth (g13amc) NAG Library Function Document nag_tsa_exp_smooth () 1 Purpose nag_tsa_exp_smooth () performs exponential smoothing using either single exponential, double exponential or a Holt Winters method. 2 Specification

More information

NAG Library Function Document nag_sum_sqs_update (g02btc)

NAG Library Function Document nag_sum_sqs_update (g02btc) g02 Correlation and Regression Analysis NAG Library Function Document nag_sum_sqs_update () 1 Purpose nag_sum_sqs_update () updates the sample means and sums of squares and cross-products, or sums of squares

More information

nag regsn mult linear delete var (g02dfc)

nag regsn mult linear delete var (g02dfc) nag regsn mult linear delete var () 1. Purpose nag regsn mult linear delete var () deletes an independent variable from a general linear regression model. 2. Specification #include #include

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_full_step_regsn (g02efc)

NAG Library Function Document nag_full_step_regsn (g02efc) NAG Library Function Document nag_full_step_regsn () 1 Purpose nag_full_step_regsn () calculates a full stepwise selection from p variables by using Clarke's sweep algorithm on the correlation matrix of

More information

NAG Library Function Document nag_rand_copula_normal (g05rdc)

NAG Library Function Document nag_rand_copula_normal (g05rdc) NAG Library Function Document nag_rand_copula_normal () 1 Purpose nag_rand_copula_normal () sets up a reference vector and generates an array of pseudorandom numbers from a Normal (Gaussian) copula with

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 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_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 C Library Function Document nag_multid_quad_monte_carlo_1 (d01xbc)

NAG C Library Function Document nag_multid_quad_monte_carlo_1 (d01xbc) d1 Quadrature d1xbc 1 Purpose NAG C Library Function Document nag_multid_quad_monte_carlo_1 (d1xbc) nag_multid_quad_monte_carlo_1 (d1xbc) evaluates an approximation to the integral of a function over a

More information

NAG C Library Function Document. nag_real_sparse_eigensystem_iter (f12abc),

NAG C Library Function Document. nag_real_sparse_eigensystem_iter (f12abc), f12 Large Scale Eigenproblems f12aac 1 Purpose NAG C Library Function Document nag_real_sparse_eigensystem_init (f12aac) nag_real_sparse_eigensystem_init (f12aac) is a setup function in a suite of functions

More information

NAG Library Function Document nag_prob_non_central_f_dist (g01gdc)

NAG Library Function Document nag_prob_non_central_f_dist (g01gdc) NAG Library Function Document nag_prob_non_central_f_dist () 1 Purpose nag_prob_non_central_f_dist () returns the probability associated with the lower tail of the noncentral F or variance-ratio distribution.

More information

NAG Library Function Document nag_tsa_cp_binary (g13ndc)

NAG Library Function Document nag_tsa_cp_binary (g13ndc) NAG Library Function Document nag_tsa_cp_binary () 1 Purpose nag_tsa_cp_binary () detects change points in a univariate time series, that is, the time points at which some feature of the data, for example

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 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 Library Function Document nag_zero_nonlin_eqns_deriv_1 (c05ubc)

NAG Library Function Document nag_zero_nonlin_eqns_deriv_1 (c05ubc) c05 Roots of One or More Transcendental Equations c05ubc 1 Purpose NAG Library Function Document nag_zero_nonlin_eqns_deriv_1 (c05ubc) nag_zero_nonlin_eqns_deriv_1 (c05ubc) finds a solution of a system

More information

NAG Library Function Document nag_2d_spline_eval (e02dec)

NAG Library Function Document nag_2d_spline_eval (e02dec) e02 Curve and Surface Fitting NAG Library Function Document nag_2d_spline_eval () 1 Purpose nag_2d_spline_eval () calculates values of a bicubic spline from its B-spline representation. 2 Specification

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_wfilt (c09aac)

NAG Library Function Document nag_wfilt (c09aac) NAG Library Function Document nag_wfilt () 1 Purpose nag_wfilt () returns the details of the chosen one-dimensional discrete wavelet filter. For a chosen mother wavelet, discrete wavelet transform type

More information

NAG Library Function Document nag_1d_spline_interpolant (e01bac)

NAG Library Function Document nag_1d_spline_interpolant (e01bac) NAG Library Function Document nag_1d_spline_interpolant () 1 Purpose nag_1d_spline_interpolant () determines a cubic spline interpolant to a given set of data. 2 Specification #include #include

More information

NAG Library Function Document nag_tsa_cp_pelt_user (g13nbc)

NAG Library Function Document nag_tsa_cp_pelt_user (g13nbc) g13 Time Series Analysis g13nbc NAG Library Function Document nag_tsa_cp_pelt_user (g13nbc) 1 Purpose nag_tsa_cp_pelt_user (g13nbc) detects change points in a univariate time series, that is, the time

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 C Library Function Document nag_mesh2d_delaunay (d06abc)

NAG C Library Function Document nag_mesh2d_delaunay (d06abc) d06 Mesh Generation d06abc NAG C Library Function Document nag_mesh2d_delaunay (d06abc) 1 Purpose nag_mesh2d_delaunay (d06abc) generates a triangular mesh of a closed polygonal region in IR 2, given a

More information

NAG C Library Function Document nag_superlu_condition_number_lu (f11mgc)

NAG C Library Function Document nag_superlu_condition_number_lu (f11mgc) f Large Scale Linear Systems fmgc Purpose NAG C Library Function Document nag_superlu_condition_number_lu (fmgc) nag_superlu_condition_number_lu (fmgc) computes an estimate of the reciprocal of the condition

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_2d_spline_eval (e02dec)

NAG Library Function Document nag_2d_spline_eval (e02dec) 1 Purpose NAG Library Function Document nag_2d_spline_eval () nag_2d_spline_eval () calculates values of a bicubic spline from its B-spline representation. 2 Specification #include #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 Library Function Document nag_zero_nonlin_eqns_rcomm (c05qdc)

NAG Library Function Document nag_zero_nonlin_eqns_rcomm (c05qdc) c05 Roots of One or More Transcendental Equations c05qdc NAG Library Function Document nag_zero_nonlin_eqns_rcomm (c05qdc) 1 Purpose nag_zero_nonlin_eqns_rcomm (c05qdc) is a comprehensive reverse communication

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_sum_fft_real_3d (c06pyc)

NAG Library Function Document nag_sum_fft_real_3d (c06pyc) NAG Library Function Document nag_sum_fft_real_3d () 1 Purpose nag_sum_fft_real_3d () computes the three-dimensional discrete Fourier transform of a trivariate sequence of real data values. 2 Specification

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_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 C Library Function Document nag_pde_parab_1d_euler_hll (d03pwc)

NAG C Library Function Document nag_pde_parab_1d_euler_hll (d03pwc) 1 Purpose NAG C Library Function Document nag_pde_parab_1d_euler_hll () nag_pde_parab_1d_euler_hll () calculates a numerical flux function using a modified HLL (Harten- Lax-van Leer) Approximate Riemann

More information

NAG Library Function Document nag_2d_panel_sort (e02zac)

NAG Library Function Document nag_2d_panel_sort (e02zac) NAG Library Function Document nag_2d_panel_sort () 1 Purpose nag_2d_panel_sort () sorts two-dimensional data into rectangular panels. 2 Specification #include #include void nag_2d_panel_sort

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_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_mv_promax (g03bdc)

NAG Library Function Document nag_mv_promax (g03bdc) g03 Multivariate Methods g03bdc NAG Library Function Document nag_mv_promax (g03bdc) 1 Purpose nag_mv_promax (g03bdc) calculates a ProMax rotation, given information following an orthogonal rotation. 2

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 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_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