The dr Package. R topics documented: September 1, Version Date 2005/08/31. Title Methods for dimension reduction for regression

Size: px
Start display at page:

Download "The dr Package. R topics documented: September 1, Version Date 2005/08/31. Title Methods for dimension reduction for regression"

Transcription

1 The dr Package September 1, 2005 Version Date 2005/08/31 Title Methods for dimension reduction for regression Author Sanford Weisberg Maintainer Sanford Weisberg Functions, methods, and datasets for fitting dimension reduction regression, including phd and inverse regression methods SIR and SAVE. These methods are described, for example, in R. D. Cook (1998), Regression Graphics, Wiley, New York. Also included is code for computing permutation tests of dimension. Adding additional methods of estimating dimension is straightforward. One function depends on the lqs package. Minor revision to be compatible with R 2.0.0, and bug-fixes. For documentation, see License GPL version 2 or newer URL R topics documented: ais cosangle fullquad.fit dr.m dr dr.coplot dr.directions dr.fit dr.indep.test.phdres dr.permutation.test dr.persp dr.slices dr.test dr.weights dr.x dr.y givens.rotation markby mussels

2 2 cosangle rotplot wood.pvalue Index 22 ais Australian athletes data Format Data on 102 male and 100 female athletes collected at the Australian Institute of Sport, courtesy of Richard Telford and Ross Cunningham. This data frame contains the following columns: Sex (0 = male or 1 = female) Ht height (cm) Wt weight (kg) LBM lean body mass RCC red cell count WCC white cell count Hc Hematocrit Hg Hemoglobin Source R. D. Cook and S. Weisberg (1999). Applied Statistics Including Computing and Graphics. New York: Wiley. cosangle Compute the cosine of the angle between a vector and a subspace cosangle1 returns the cosine of the angle between a vector vecs and the subspace spanned by the columns of the matrix mat. For cosangle, vecs can be a matrix, in which case cosangle1 is called for each column in vecs. cosangle(mat, vecs) cosangle1(mat, vec)

3 fullquad.fit 3 mat vecs vec A matrix the provides the basis for a subspace A vector with the same number of rows as mat, or a matrix with the same number of rows as mat A vector with the same number of rows as mat cosangle1 computes the cosine of the angle between vec and the orthogonal projection of vec onto the column space of mat. cosangle repeats this computation for each column of vecs. cosangle1 returns a single value and cosangle returns a vector. Sanford Weisberg <sandy@stat.umn.edu> fullquad.fit Internal function This function recovers a linear predictor from a dr object, and then uses lm to fit a full quadratic regression fullquad.fit(object) object An object of type dr Returns an object of type lm. Sanford Weisberg

4 4 dr.m dr.m function to do... Compute the kernel matrix for a dr method dr.m(object,...) object An object of type dr.... Additional method-specific arguments; see description below This is a method-specific function to compute the kernel matrix M of a dimension reduction method. For sir, save, msir and save, the additional arguements are nslices, the number of slices to be used, and slice.info, which if present is the a list produced by dr.slices. For ols and the phd methods, no additional arguments are required. New dimension reduction methods can be added to dr by writing a new dr.m method. Returns a list with components M slice.info The kernel matrix Information about the slices, if used by the dr method.... Sanford Weisberg, sandy@stat.umn.edu objects to as dr, Examples ##---- Should be DIRECTLY executable!! ---- ##-- ==> Define data, use random, ##-- or do help(data=index) for the standard data sets. ## The function is currently defined as function(object,...){usemethod("dr.m")}

5 dr 5 dr Dimension reduction regression The function dr implements dimension reduction methods, including SIR, SAVE and phd. dr calls dr.compute, so only the former will be needed by most users. dr (formula, data, subset, na.action = na.fail, weights,...) dr.compute (x, y, weights, method = "sir",...) formula data subset weights na.action x y method a symbolic description of the model to be fit. The details of the model are the same as for lm. Although factors may not be appropriate for dr methods, they are permitted. Full rank models are recommended, although rank deficient models are permitted. an optional data frame containing the variables in the model. By default the variables are taken from the environment from which dr is called. an optional vector specifying a subset of observations to be used in the fitting process. an optional vector of weights to be used where appropriate. In the context of dimension reduction methods, weights are used to obtain elliptical symmetry, not constant variance; see dr.weights. a function which indicates what should happen when the data contain NA s. The default is na.fail, which will stop calculations. The option na.omit is also permitted, but it may not work correctly when weights are used. The design matrix The response vector or matrix This character string specifies the method of fitting. sir" specifies sliced inverse regression and save" specifies sliced average variance estimation. phdy" uses principal hessian directions using the response as suggested by Li, and phdres" uses the LS residuals as suggested by Cook. Other methods may be added.... For dr, arguments passed to dr.compute. For dr.compute, arguments required for particular dimension reduction method. nslices is the number of slices used by sir and save. numdir is the maximum number of directions to compute, with default equal to 4. other methods may have other defaults. The general regression problem studies F (y x), the conditional distribution of a response y given a set of predictors x. This function provides methods for estimating the dimension and central subspace of a general regression problem. That is, we want to find a p d matrix B such that F (y x) = F (y B x)

6 6 dr Both the dimension d and the subspace R(B) are unknown. These methods make few assumptions. All the methods available in this function estimate the unknowns by study of the inverse problem, F (x y). In each, a kernel matrix M is estimated such that the column space of M should be close to the central subspace. Eigenanalysis of M is then used to estimate the central subspace. Objects created using this function have appropriate print, summary and plot methods. Weights can be used, essentially to specify the relative frequency of each case in the data. Empirical weights that make the contours of the weighted sample closer to elliptical can be computed using dr.weights. This will usually result in zero weight for some cases. The function will set zero estimated weights to missing. Several functions are provided that require a dr object as input. dr.permutation.tests uses a permutation test to obtain significance levels for tests of dimension. dr.coplot allows visualizing the results using a coplot of either two selected directions conditioning on a third and using color to mark the response, or the resonse versus one direction, conditioning on a second direction. plot.dr provides the default plot method for dr objects, based on a scatterplot matrix. dr returns an object that inherits from dr (the name of the type is the value of the method argument), with attributes: x y The design matrix The response vector weights The weights used, normalized to add to n. qr QR factorization of x. cases call M evalues evectors numdir slice.info method Number of cases used. The initial call to dr. A matrix that depends on the method of computing. The column space of M should be close to the central subspace. The eigenvalues of M (or squared singular values if M is not symmetric). The eigenvectors of M (or of M M if M is not square and symmetric) ordered according to the eigenvalues. The maximum number of directions to be found. The output value of numdir may be smaller than the input value. output from sir.slice, used by sir and save. the dimension reduction method used. dr.weights returns a vector of weights estimated weights, scaled to add to the number of cases. Sanford Weisberg, sandy@stat.umn.edu For weights, see R. D. Cook and C. Nachtsheim (1994), Reweighting to achieve elliptically contoured predictors in regression. Journal of the American Statistical Association, 89, References The details of these methods are given by R. D. Cook (1998). Regression Graphics. New York: Wiley. Equivalent methods are also available in Arc, R. D. Cook and S. Weisberg (1999). Applied Regression Including Computing and Graphics, New York: Wiley,

7 dr.coplot 7 dr.permutation.test,dr.x,dr.y, dr.direction,dr.coplot,dr.weights Examples library(dr) data(ais) attach(ais) # the Australian athletes data #fit dimension reduction using sir m1 <- dr(lbm~wt+ht+rcc+wcc, method="sir", nslices = 8) summary(m1) # repeat, using save: m2 <- update(m1,method="save") summary(m2) # repeat, using phd: m3 <- update(m2, method="phdres") summary(m3) # repeat, using weights: w1 <- dr.weights(lbm~wt+ht+rcc+wcc, covmethod="mve") m4 <- dr(lbm~wt+ht+rcc+wcc, method="sir", nslices = 8, weights=w1) dr.coplot Visualize dimension reduction regression using a coplot This function produces a coplot of the response versus specified directions in dimension reduction regression. dr.coplot(object, which=1:object$numdir, mark.by.y=false,...) object which mark.by.y a dr object specify the indices of the directions to be plotted if FALSE, plot the response versus the first specified direction conditioning on the second specified direction. If TRUE, plot first direction versus second direction conditioning on the third direction, using the response as a marking variable to color the points.... other arguments passed to coplot The function dr.permutation.test.statistic is not to be called by the user, but it computes the test statistic for each different type of dr object. A coplot.

8 8 dr.directions Sanford Weisberg dr dr.directions Directions selected by dimension reduction regressiosn Dimension reduction regression returns a set of p orthogonal direction vectors each of length p, the first d of which are estimates a basis of a d dimensional central subspace. The function returns the estimated directions in the original n dimensional space for plotting. dr.direction(object, which, norm, x) dr.directions(object, which, norm, x) dr.direction.default(object, which=1:object$numdir,norm=false,x=dr.x(object)) object which norm x a dimension reduction regression object select the directions wanted, default is all directions if TRUE, direction vectors are normalized to length 1, otherwise their length is arbitrary select the X matrix, the default is dr.x(object)... additional arguments are passed to dr.direction.default Dimension reduction regression is used to estimate a basis of the central subspace of a regression. If there are p predictors, the dimension reduction regression object includes a p by p matrix of C of eigenvectors. This method returns (X-m1 )C where m is the vector of column means of X. If X is equal to the original matrix of predictors given by dr.x(object), then this gives the directions in the coordinates of the orginal n dimensional space. These directions are used in graphical methods and elsewhere. Returns a matrix. The same function has two names. Sanford Weisberg <sandy@stat.umn.edu> References See R. D. Cook (1998). Regression Graphics. New York: Wiley.

9 dr.fit 9 dr Examples library(dr) data(ais) attach(ais) # the Australian athletes data #fit dimension reduction using sir m1 <- dr(lbm~wt+ht+rcc+wcc, method="sir", nslices = 8) summary(m1) dr.directions(m1) dr.fit Fit dimension reduction regression Internal generic function that estimates the central subspace. dr.fit(object, numdir=4,...) object numdir tol dimension reduction regression object maximum number of dimensions to consider tolerance passed to singular value decomposition... other arguments passed to dr.fit.m These functions will not typically be called directly by the user. At present, the same dr.fit method works for all dimension reduction methods implemented in this package, but one could potentially write a special dr.fit method if needed. The general outline of this method is as follows. (1) A matrix M is computed by a call to dr.fit.m(object,...), such that the columns of M are estimated to fall in the subspace of interest (either the central subspace or the central mean subspace). (2) If M is square, its eigenvalues and eigenvectors are computed; if M is not square, the eigenvalues of M M are computed. (3) M was computed with scaled and centered predictors. The eigenvectors are backtransformed to the original scale. evectors evalues numdir ordered eigenvectors that describe the estimates of the dimension reduction subspace ordered eigenvalues number of eigenvalues raw.evectors eigenvectors of the rotated data M The kernel matrix.

10 10 dr.indep.test.phdres Sanford Weisberg dr dr.indep.test.phdres Test of independence for phd based on residuals Compute the p-value for the hypothesis that the central subspace for OLS residuals has dimension 0 against the alternative that it is greater than zero. This is an internal method not usually needed by the user. dr.indep.test.phdres(object, stat) object stat phdres object value of the test statistic Sanford Weisberg <sandy@stat.umn.edu> References R. D. Cook (1998) Regression Graphics, New York: Wiley. dr

11 dr.permutation.test 11 dr.permutation.test Dimension Reduction Regression Functions These functions require a dimension reduction regression object as input to produce output of various types. dr.permutation.test(object, npermute=50,numdir=object$numdir,permute.weights=tru object a dimension reduction regression object created by dr npermute number of permutations to compute, default is 50 numdir maximum permitted value of the dimension, with the default from the object permute.weights If TRUE, permute weights as well as data in the permutation test. If FALSE, do not permute the weights. Approximates significance levels for tests of dimension using a permutation test. Returns an object of type dr.permutation.test that can be printed or summarized to give the summary of the test. Sanford Weisberg, sandy@stat.umn.edu References See and then select the article on dimension reduction regression or inverse regression. dr

12 12 dr.persp Examples data(ais) attach(ais) # the Australian athletes data #fit dimension reduction regression using sir m1 <- dr(lbm~wt+ht+rcc+wcc, method="sir", nslices = 8) summary(m1) dr.permutation.test(m1,npermute=100) plot(m1) dr.coplot(m1) dr.persp Produce a perspective plot of dimension reduction regression objects. This function uses the sm library to draw a perspective 3D plot of two of the directions obtained by dimension reduction regression versus the response. dr.persp(object, which=1:2, h=c(0.1, 0.1),...) object a dimension reduction regression object which a vector of two directions to use h bandwidths for smoothing passed to sm... graphical parameters passed to sm Returns a perspective plot Sanford Weisberg <sandy@stat.umn.edu> dr, sm

13 dr.slices 13 dr.slices Divide a vector into slices of approximately equal size Divides a vector into slices of approximately equal size. dr.slices(y, nslices) y nslices a vector of length n or an n by p matrix the number of slices, no larger than n, or a vector of p numbers giving the number of slices in each direction. If y has p columns and nslices is a number, then the number of slices in each direction is the smallest integer greater than the p-th root of nslices. If y is an n-vector, order y. The goal for the number of observations per slice is m, the smallest integer in nslices/n. Allocate the first m observations to slice 1. If there are duplicates in y, keep adding observations to the first slice until the next value of y is not equal to the largest value in the first slice. Allocate the next m values to the next slice, and again check for ties. Continue until all values are allocated to a slice. This does not guarantee that nslices will be obtained, nor does it guarantee an equal number of observations per slice. This method of choosing slices is invariant under rescaling, but not under multiplication by -1, so the slices of y will not be the same as the slices of -y. If y is a matrix of p columns, slice the first column as described above. Then, within each of the slices determined for the first column, slice based on the second column, so that each of the "cells" has approximately the same number of observations. Continue through all the columns. This method is not invariant under reordering of the columns, or under multiplication by -1. slice.sizes slice.indicator nslices gives the actual number of slices produced Sanford Weisberg, <sandy@stat.umn.edu> References This function produces the same slice indicators as does the equivalent function in Arc, Cook and Weisberg (1999), Applied Regression Including Computing and Graphics, New York: Wiley.

14 14 dr.test dr dr.test Dimension reduction regression tests This method computes tests of dimension in dimension reduction regression. A separate method is needed for each dimension reduction regression method. Called by the dr function, and not usually accessed directly by the user. dr.test(object, nd) dr.test.default(object, nd) object nd dimension reduction regresion object Maximum number of dimensions to test Returns test statistics and significance levels in a data frame. Sanford Weisberg, <sandy@stat.umn.edu> References R. C. Cook (1998). Regression Graphics. New York: Wiley. dr

15 dr.weights 15 dr.weights Estimate weighting for elliptical symmetry This function estimate weights to apply to the rows of a data matrix to make the resulting weighted matrix as close to multivariate normality as possible. This method is usually not called directly by the user. dr.weights(formula, data = list(), subset, na.action = na.fail, covmethod = "mve", sigma=1, nsamples=null,...) robust.center.scale(x, method,... ) formula data subset na.action covmethod nsamples sigma x method A one-sided or two-sided formula. The right hand side is used to define the design matrix. An optional data frame. A list of cases to be used in computing the weights. The default is na.fail, to prohibit computations. If set to na.omit, the function will return a list of weights of the wrong length for use with dr. covmethod is passed as the argument method to the function cov.rob in the required package lqs. The choices are "classical", "mve" and "mcd". are different with S-Plus. If classical is selected, the usual estimate of the covariance matrix is used, but the center is the medians, not the means. The weights are determined by random sampling from a data-determined normal distribution. This controls the number of samples. The default is 10 times the number of cases. Scale factor, set to one by default An n p data matrix with no missing values see covmethod above... Additional args are passed to cov.rob The basic outline is: (1) Estimate a mean m and covariance matrix S using a possibly robust method; (2) For each iteration, obtain a random vector from N(m,sigma*S). Add 1 to a counter for observation i if the i-th row of the data matrix is closest to the random vector; (3) return as weights the sample faction allocated to each observation. If you set the keyword weights.only to T on the call to dr, then only the list of weights will be returned. Returns a list of n weights, some of which may be zero.

16 16 dr.x Sanford Weisberg, References R. D. Cook and C. Nachtsheim (1994), Reweighting to achieve elliptically contoured predictors in regression. Journal of the American Statistical Association, 89, dr, lqs Examples data(ais) w1 <- dr.weights(~ Ht +Wt +RCC, data = ais) m1 <- dr(lbm~ht+wt+rcc,data=ais,weights=w1) dr.x Accessor functions for dr. objects A concise (1-5 lines) description of what the function does. dr.x(object) dr.wts(object) dr.qr(object) dr.q(object) dr.r(object) dr.z(object) dr.y.name(object) object An object that inherits from dr. Returns a component of a dr object. For example, dr.qr returns object$qr, dr.wts returns object$weights, dr.q returns the Q component of object$qr, dr.z returns the scaled and centered design matrix. Sanford Weisberg, sandy@stat.umn.edu objects to as dr.

17 dr.y 17 Examples ##---- Should be DIRECTLY executable!! ---- ##-- ==> Define data, use random, ##-- or do help(data=index) for the standard data sets. ## The function is currently defined as function(object) {object$x} dr.y function to do... Generic function to return the response for a dr fit. dr.y(object) object A dr object This returns the response variable for a dr fit. For most, dr methods, this is just the response as specified in the call to dr. For phd and phdres, this returns the residuals from the OLS regression of the original response on the design matrix. For phdy, it returns the response minus its mean. A vector. Sanford Weisberg, sandy@stat.umn.edu objects to as dr. Examples ##---- Should be DIRECTLY executable!! ---- ##-- ==> Define data, use random, ##-- or do help(data=index) for the standard data sets. ## The function is currently defined as function(object) {UseMethod("dr.y")}

18 18 markby givens.rotation Create givens rotation matrix For a given angle theta, returns a p by p Givens rotation matrix. givens.rotation(theta, p=2, which=c(1, 2)) theta p which an angle in radians the dimension of the matrix to be produced two numbers between 1 and p giving the columns/rows for the nonzero elements of the result. Returns a p by p matrix z of all zeroes, except z[which,which] has elements cos(theta), -sin(theta), sin(theta) and cos(theta), in column order. sandy@stat.umn.edu References Gene H. Golub and Charles F. Van Loan (1989). Matrix Computations, Second Edition. Baltimore: Johns Hopkins Press, p Examples givens.rotation(1,4,c(1,3)) markby Produce a vector of colors/symbols to mark points This function creates marking of points by color or symbol for use in graphs. markby(z, use="color", values=null, color.fn=rainbow, na.action="na.use")

19 mussels 19 z use values color.fn na.action a variable with a few distict values that will define the groups for marking. if equal to "color", will returna list of colors. If anything else, it will return a list of symbols for marking. a list with as many values as unique values of z that determine the colors or symbols. If this is not set, then the function rainbow is used for colors and 1:length(unique(z)) is used for symbols. By default, missing values (NAs) are treated as another category in the color marking. Setting this argument to anything else will return NA for the missing category names. This will cause an error in R graphics routines, but see below for usage of this options. Returns length(z) values that specify the color or symbol for each point. Sanford Weisberg, <sandy@stat.umn.edu> References This function is to help users familiar with Arc, as discussed in R. D. Cook and S. Weisberg (1999). Applied Regression Including Computing and Graphics, New York: Wiley. Examples x <- rnorm(100) y <- rnorm(100) z <- cut(rnorm(100),3) # Scatterplot, mark using color with groups determined by Status plot(x,y,col=markby(z)) # Scatterplot, mark using symbols with groups determined by Status plot(x,y,pch=markby(z,use="symbols")) # handing of missing values: z[1:10] <- NA # set to missing marks <- markby(z,na.action="omit") sel <-!is.na(marks) plot(x[sel],y[sel],col=marks[sel]) mussels Mussels muscles data Data were furnished by Mike Camden, Wellington Polytechnic, Wellington, New Zealand. Horse mussels, (Atrinia), were sampled from the Marlborough Sounds. The response is the mussels Muscle Mass.

20 20 rotplot Format This data frame contains the following columns: H Shell height in mm L Shell length in mm M Muscle mass in g S Shell mass in g W Shell width in mm Source R. D. Cook and S. Weisberg (1999). Applied Statistics Including Computing and Graphics. New York: Wiley. rotplot draw many 2D projections of a 3D plot This function draws several 2D views of a 3D plot, sort of like a spinning plot. rotplot(x, y, number=9, theta=seq(0, pi/2, length = number),...) x a matrix with 2 columns giving the horizontal axes of the full 3D plot. y the vertical axis of the 3D plot. number Number of 2D views of the 3D plot. theta a list of rotation angles... additional arguments passed to coplot For each value of theta, draw the plot of cos(theta)*x[,1]+sin(theta)*x[,2] versus y. returns a graph object. Sanford Weisberg, sandy@stat.umn.edu

21 wood.pvalue 21 Examples data(ais) attach(ais) m1 <- dr(lbm ~ Ht + Wt + WCC) rotplot(dr.direction(m1,which=1:2),dr.y(m1),col=markby(sex)) wood.pvalue Chi-square approximation to a sum of Chi-squares Returns an approximation to P(coef X > f) for X=(X1,...,Xk), a vector of iid one df chi-squared rvs. coef is a list of positive coefficients. tol is used to check for near-zero conditions. wood.pvalue(coef, f, tol=0, print=false) coef f tol print Vector of positive numbers, usually from the eigenvalues of a random matrix observed value of statistic A small number for tolerance If TRUE, print the output; if FALSE return the pvalue Following Wood (1989), use either a Saterthwaite-Welsh, inverse gamma or three-parameter Pearson Type IV approximation, depending on the values of the coefficients. Returns the tail area probability. Sanford Weisberg <sandy@stat.umn.edu>. Arc version by Dennis Cook. References See Wood (1989), Communications in Statistics, Simulation Translated from Arc function wood-pvalue. dr

22 Index Topic datasets ais, 1 mussels, 19 Topic internal dr.fit, 9 dr.m, 3 dr.x, 16 dr.y, 17 fullquad.fit, 3 Topic regression cosangle, 2 dr, 4 dr.coplot, 7 dr.directions, 8 dr.fit, 9 dr.indep.test.phdres, 10 dr.permutation.test, 11 dr.persp, 12 dr.slices, 13 dr.test, 14 dr.weights, 15 givens.rotation, 18 markby, 18 rotplot, 20 wood.pvalue, 21 AIS (ais), 1 ais, 1 cosangle, 2 cosangle1 (cosangle), 2 cov.ew.matrix (dr.indep.test.phdres), 10 dr, 4, 4, 7, 8, 10 12, 14, 16, 17, 21 dr.coplot, 6, 7 dr.direction, 6 dr.direction (dr.directions), 8 dr.directions, 8 dr.fit, 9 dr.indep.test.phdres, 10 dr.m, 3 dr.permutation.test, 6, 11 dr.permutation.test.statistic.default (dr.permutation.test), 11 dr.permutation.test.statistic.phd (dr.permutation.test), 11 dr.permutation.test.statistic.phdres (dr.permutation.test), 11 dr.permutation.test.statistic.phdy (dr.permutation.test), 11 dr.persp, 12 dr.q (dr.x), 16 dr.qr (dr.x), 16 dr.r (dr.x), 16 dr.slice.1d (dr.slices), 13 dr.slice1 (dr.slices), 13 dr.slice2 (dr.slices), 13 dr.slices, 3, 13 dr.test, 14 dr.test2.phdres (dr.test), 14 dr.weights, 5, 6, 15 dr.wts (dr.x), 16 dr.x, 6, 16 dr.y, 6, 17 dr.y.name (dr.x), 16 dr.z (dr.x), 16 fullquad.fit, 3 givens.rotation, 18 lqs, 16 markby, 18 mussels, 19 plot.dr (dr), 4 print.dr (dr), 4 print.dr.permutation.test (dr.permutation.test), 11 print.summary.dr (dr), 4 robust.center.scale (dr.weights), 15 rotplot, 20 sm, 12 22

23 INDEX 23 summary.dr (dr), 4 summary.dr.permutation.test (dr.permutation.test), 11 wood.pvalue, 21

Dimension Reduction Regression in R

Dimension Reduction Regression in R Dimension Reduction Regression in R Sanford Weisberg School of Statistics, University of Minnesota, St. Paul, MN 5518-642. Supported by National Science Foundation Grant DUE 19756. January 1, 22 Abstract

More information

Package msir. R topics documented: April 7, Type Package Version Date Title Model-Based Sliced Inverse Regression

Package msir. R topics documented: April 7, Type Package Version Date Title Model-Based Sliced Inverse Regression Type Package Version 1.3.1 Date 2016-04-07 Title Model-Based Sliced Inverse Regression Package April 7, 2016 An R package for dimension reduction based on finite Gaussian mixture modeling of inverse regression.

More information

Package misctools. November 25, 2016

Package misctools. November 25, 2016 Version 0.6-22 Date 2016-11-25 Title Miscellaneous Tools and Utilities Author, Ott Toomet Package misctools November 25, 2016 Maintainer Depends R (>= 2.14.0) Suggests Ecdat

More information

Package CovSel. September 25, 2013

Package CovSel. September 25, 2013 Type Package Title Model-Free Covariate Selection Version 1.0 Date 2013-06-24 Author Jenny Häggström, Emma Persson, Package CovSel September 25, 2013 Maintainer Jenny Häggström

More information

Regression Graphics. 1 Introduction. 2 The Central Subspace. R. D. Cook Department of Applied Statistics University of Minnesota St.

Regression Graphics. 1 Introduction. 2 The Central Subspace. R. D. Cook Department of Applied Statistics University of Minnesota St. Regression Graphics R. D. Cook Department of Applied Statistics University of Minnesota St. Paul, MN 55108 Abstract This article, which is based on an Interface tutorial, presents an overview of regression

More information

Variable Selection and Regularization

Variable Selection and Regularization Variable Selection and Regularization Sanford Weisberg October 15, 2012 Variable Selection In a regression problem with p predictors, we can reduce the dimension of the regression problem in two general

More information

The SpatialNP Package

The SpatialNP Package The SpatialNP Package September 4, 2007 Type Package Title Multivariate nonparametric methods based on spatial signs and ranks Version 0.9 Date 2007-08-30 Author Seija Sirkia, Jaakko Nevalainen, Klaus

More information

The nltm Package. July 24, 2006

The nltm Package. July 24, 2006 The nltm Package July 24, 2006 Version 1.2 Date 2006-07-17 Title Non-linear Transformation Models Author Gilda Garibotti, Alexander Tsodikov Maintainer Gilda Garibotti Depends

More information

Lab 12: Dimension reduction in R

Lab 12: Dimension reduction in R Lab : Dimension reduction in R June 6, 00 In this lab, we present some dimension reduction algorithms that are available in R and that are useful for classification of microarray data. The first example

More information

Estimability Tools for Package Developers by Russell V. Lenth

Estimability Tools for Package Developers by Russell V. Lenth CONTRIBUTED RESEARCH ARTICLES 195 Estimability Tools for Package Developers by Russell V. Lenth Abstract When a linear model is rank-deficient, then predictions based on that model become questionable

More information

Package MonoPoly. December 20, 2017

Package MonoPoly. December 20, 2017 Type Package Title Functions to Fit Monotone Polynomials Version 0.3-9 Date 2017-12-20 Package MonoPoly December 20, 2017 Functions for fitting monotone polynomials to data. Detailed discussion of the

More information

Package rnmf. February 20, 2015

Package rnmf. February 20, 2015 Type Package Title Robust Nonnegative Matrix Factorization Package rnmf February 20, 2015 An implementation of robust nonnegative matrix factorization (rnmf). The rnmf algorithm decomposes a nonnegative

More information

Package sscor. January 28, 2016

Package sscor. January 28, 2016 Type Package Package sscor January 28, 2016 Title Robust Correlation Estimation and Testing Based on Spatial Signs Version 0.2 Date 2016-01-19 Depends pcapp, robustbase, mvtnorm Provides the spatial sign

More information

Package rarpack. August 29, 2016

Package rarpack. August 29, 2016 Type Package Package rarpack August 29, 2016 Title Solvers for Large Scale Eigenvalue and SVD Problems Version 0.11-0 Date 2016-03-07 Author Yixuan Qiu, Jiali Mei and authors of the ARPACK library. See

More information

Regression Graphics. R. D. Cook Department of Applied Statistics University of Minnesota St. Paul, MN 55108

Regression Graphics. R. D. Cook Department of Applied Statistics University of Minnesota St. Paul, MN 55108 Regression Graphics R. D. Cook Department of Applied Statistics University of Minnesota St. Paul, MN 55108 Abstract This article, which is based on an Interface tutorial, presents an overview of regression

More information

Interaction effects for continuous predictors in regression modeling

Interaction effects for continuous predictors in regression modeling Interaction effects for continuous predictors in regression modeling Testing for interactions The linear regression model is undoubtedly the most commonly-used statistical model, and has the advantage

More information

series. Utilize the methods of calculus to solve applied problems that require computational or algebraic techniques..

series. Utilize the methods of calculus to solve applied problems that require computational or algebraic techniques.. 1 Use computational techniques and algebraic skills essential for success in an academic, personal, or workplace setting. (Computational and Algebraic Skills) MAT 203 MAT 204 MAT 205 MAT 206 Calculus I

More information

Multivariate Statistical Analysis

Multivariate Statistical Analysis Multivariate Statistical Analysis Fall 2011 C. L. Williams, Ph.D. Lecture 4 for Applied Multivariate Analysis Outline 1 Eigen values and eigen vectors Characteristic equation Some properties of eigendecompositions

More information

Generalized Linear Models

Generalized Linear Models York SPIDA John Fox Notes Generalized Linear Models Copyright 2010 by John Fox Generalized Linear Models 1 1. Topics I The structure of generalized linear models I Poisson and other generalized linear

More information

Package covrna. R topics documented: September 7, Type Package

Package covrna. R topics documented: September 7, Type Package Type Package Package covrna September 7, 2018 Title Multivariate Analysis of Transcriptomic Data Version 1.6.0 Author Maintainer This package provides

More information

Package SpatialNP. June 5, 2018

Package SpatialNP. June 5, 2018 Type Package Package SpatialNP June 5, 2018 Title Multivariate Nonparametric Methods Based on Spatial Signs and Ranks Version 1.1-3 Date 2018-06-05 Author Seija Sirkia, Jari Miettinen, Klaus Nordhausen,

More information

Nonlinear Regression. Summary. Sample StatFolio: nonlinear reg.sgp

Nonlinear Regression. Summary. Sample StatFolio: nonlinear reg.sgp Nonlinear Regression Summary... 1 Analysis Summary... 4 Plot of Fitted Model... 6 Response Surface Plots... 7 Analysis Options... 10 Reports... 11 Correlation Matrix... 12 Observed versus Predicted...

More information

Package plw. R topics documented: May 7, Type Package

Package plw. R topics documented: May 7, Type Package Type Package Package plw May 7, 2018 Title Probe level Locally moderated Weighted t-tests. Version 1.40.0 Date 2009-07-22 Author Magnus Astrand Maintainer Magnus Astrand

More information

Package NonpModelCheck

Package NonpModelCheck Type Package Package NonpModelCheck April 27, 2017 Title Model Checking and Variable Selection in Nonparametric Regression Version 3.0 Date 2017-04-27 Author Adriano Zanin Zambom Maintainer Adriano Zanin

More information

15 Singular Value Decomposition

15 Singular Value Decomposition 15 Singular Value Decomposition For any high-dimensional data analysis, one s first thought should often be: can I use an SVD? The singular value decomposition is an invaluable analysis tool for dealing

More information

Least squares and Eigenvalues

Least squares and Eigenvalues Lab 1 Least squares and Eigenvalues Lab Objective: Use least squares to fit curves to data and use QR decomposition to find eigenvalues. Least Squares A linear system Ax = b is overdetermined if it has

More information

Package ARCensReg. September 11, 2016

Package ARCensReg. September 11, 2016 Type Package Package ARCensReg September 11, 2016 Title Fitting Univariate Censored Linear Regression Model with Autoregressive Errors Version 2.1 Date 2016-09-10 Author Fernanda L. Schumacher, Victor

More information

Package EDR. September 14, 2016

Package EDR. September 14, 2016 Version 0.6-6 Date 2016-09-06 Package EDR September 14, 2016 Title Estimation of the Effective Dimension Reduction ('EDR') Space Author Joerg Polzehl Maintainer Joerg Polzehl

More information

A Note on Visualizing Response Transformations in Regression

A Note on Visualizing Response Transformations in Regression Southern Illinois University Carbondale OpenSIUC Articles and Preprints Department of Mathematics 11-2001 A Note on Visualizing Response Transformations in Regression R. Dennis Cook University of Minnesota

More information

Experimental Design and Data Analysis for Biologists

Experimental Design and Data Analysis for Biologists Experimental Design and Data Analysis for Biologists Gerry P. Quinn Monash University Michael J. Keough University of Melbourne CAMBRIDGE UNIVERSITY PRESS Contents Preface page xv I I Introduction 1 1.1

More information

Package RATest. November 30, Type Package Title Randomization Tests

Package RATest. November 30, Type Package Title Randomization Tests Type Package Title Randomization Tests Package RATest November 30, 2018 A collection of randomization tests, data sets and examples. The current version focuses on three testing problems and their implementation

More information

Machine learning for pervasive systems Classification in high-dimensional spaces

Machine learning for pervasive systems Classification in high-dimensional spaces Machine learning for pervasive systems Classification in high-dimensional spaces Department of Communications and Networking Aalto University, School of Electrical Engineering stephan.sigg@aalto.fi Version

More information

Chapter 3 Transformations

Chapter 3 Transformations Chapter 3 Transformations An Introduction to Optimization Spring, 2014 Wei-Ta Chu 1 Linear Transformations A function is called a linear transformation if 1. for every and 2. for every If we fix the bases

More information

Introduction to Linear regression analysis. Part 2. Model comparisons

Introduction to Linear regression analysis. Part 2. Model comparisons Introduction to Linear regression analysis Part Model comparisons 1 ANOVA for regression Total variation in Y SS Total = Variation explained by regression with X SS Regression + Residual variation SS Residual

More information

14 Singular Value Decomposition

14 Singular Value Decomposition 14 Singular Value Decomposition For any high-dimensional data analysis, one s first thought should often be: can I use an SVD? The singular value decomposition is an invaluable analysis tool for dealing

More information

Outline. Linear OLS Models vs: Linear Marginal Models Linear Conditional Models. Random Intercepts Random Intercepts & Slopes

Outline. Linear OLS Models vs: Linear Marginal Models Linear Conditional Models. Random Intercepts Random Intercepts & Slopes Lecture 2.1 Basic Linear LDA 1 Outline Linear OLS Models vs: Linear Marginal Models Linear Conditional Models Random Intercepts Random Intercepts & Slopes Cond l & Marginal Connections Empirical Bayes

More information

Business Analytics and Data Mining Modeling Using R Prof. Gaurav Dixit Department of Management Studies Indian Institute of Technology, Roorkee

Business Analytics and Data Mining Modeling Using R Prof. Gaurav Dixit Department of Management Studies Indian Institute of Technology, Roorkee Business Analytics and Data Mining Modeling Using R Prof. Gaurav Dixit Department of Management Studies Indian Institute of Technology, Roorkee Lecture - 04 Basic Statistics Part-1 (Refer Slide Time: 00:33)

More information

DS-GA 1002 Lecture notes 0 Fall Linear Algebra. These notes provide a review of basic concepts in linear algebra.

DS-GA 1002 Lecture notes 0 Fall Linear Algebra. These notes provide a review of basic concepts in linear algebra. DS-GA 1002 Lecture notes 0 Fall 2016 Linear Algebra These notes provide a review of basic concepts in linear algebra. 1 Vector spaces You are no doubt familiar with vectors in R 2 or R 3, i.e. [ ] 1.1

More information

Regression Analysis in R

Regression Analysis in R Regression Analysis in R 1 Purpose The purpose of this activity is to provide you with an understanding of regression analysis and to both develop and apply that knowledge to the use of the R statistical

More information

This manual is Copyright 1997 Gary W. Oehlert and Christopher Bingham, all rights reserved.

This manual is Copyright 1997 Gary W. Oehlert and Christopher Bingham, all rights reserved. This file consists of Chapter 4 of MacAnova User s Guide by Gary W. Oehlert and Christopher Bingham, issued as Technical Report Number 617, School of Statistics, University of Minnesota, March 1997, describing

More information

The cramer Package. June 19, cramer.test Index 5

The cramer Package. June 19, cramer.test Index 5 The cramer Package June 19, 2006 Version 0.8-1 Date 2006/06/18 Title Multivariate nonparametric Cramer-Test for the two-sample-problem Author Carsten Franz Maintainer

More information

Statistics: A review. Why statistics?

Statistics: A review. Why statistics? Statistics: A review Why statistics? What statistical concepts should we know? Why statistics? To summarize, to explore, to look for relations, to predict What kinds of data exist? Nominal, Ordinal, Interval

More information

Package multivariance

Package multivariance Package multivariance January 10, 2018 Title Measuring Multivariate Dependence Using Distance Multivariance Version 1.1.0 Date 2018-01-09 Distance multivariance is a measure of dependence which can be

More information

4 ORTHOGONALITY ORTHOGONALITY OF THE FOUR SUBSPACES 4.1

4 ORTHOGONALITY ORTHOGONALITY OF THE FOUR SUBSPACES 4.1 4 ORTHOGONALITY ORTHOGONALITY OF THE FOUR SUBSPACES 4.1 Two vectors are orthogonal when their dot product is zero: v w = orv T w =. This chapter moves up a level, from orthogonal vectors to orthogonal

More information

Package pfa. July 4, 2016

Package pfa. July 4, 2016 Type Package Package pfa July 4, 2016 Title Estimates False Discovery Proportion Under Arbitrary Covariance Dependence Version 1.1 Date 2016-06-24 Author Jianqing Fan, Tracy Ke, Sydney Li and Lucy Xia

More information

Package ltsbase. R topics documented: February 20, 2015

Package ltsbase. R topics documented: February 20, 2015 Package ltsbase February 20, 2015 Type Package Title Ridge and Liu Estimates based on LTS (Least Trimmed Squares) Method Version 1.0.1 Date 2013-08-02 Author Betul Kan Kilinc [aut, cre], Ozlem Alpu [aut,

More information

The panel Package. June 10, Description Functions and datasets for fitting models to Panel data. dclike.panel

The panel Package. June 10, Description Functions and datasets for fitting models to Panel data. dclike.panel The panel Package June 10, 2006 Version 1.0.6 Author Robert Gentleman Maintainer Robert Gentleman Functions and datasets for fitting models to Panel

More information

Multiple Variable Analysis

Multiple Variable Analysis Multiple Variable Analysis Revised: 10/11/2017 Summary... 1 Data Input... 3 Analysis Summary... 3 Analysis Options... 4 Scatterplot Matrix... 4 Summary Statistics... 6 Confidence Intervals... 7 Correlations...

More information

Chapter 3 Examining Data

Chapter 3 Examining Data Chapter 3 Examining Data This chapter discusses methods of displaying quantitative data with the objective of understanding the distribution of the data. Example During childhood and adolescence, bone

More information

The ICS Package. May 4, 2007

The ICS Package. May 4, 2007 Type Package The ICS Package May 4, 2007 Title ICS / ICA Computation Based on two Scatter Matrices Version 1.0-0 Date 2007-05-04 Author Klaus Nordhausen, Hannu Oja, Dave Tyler Maintainer Klaus Nordhausen

More information

Data Mining and Analysis: Fundamental Concepts and Algorithms

Data Mining and Analysis: Fundamental Concepts and Algorithms Data Mining and Analysis: Fundamental Concepts and Algorithms dataminingbook.info Mohammed J. Zaki 1 Wagner Meira Jr. 2 1 Department of Computer Science Rensselaer Polytechnic Institute, Troy, NY, USA

More information

Package leiv. R topics documented: February 20, Version Type Package

Package leiv. R topics documented: February 20, Version Type Package Version 2.0-7 Type Package Package leiv February 20, 2015 Title Bivariate Linear Errors-In-Variables Estimation Date 2015-01-11 Maintainer David Leonard Depends R (>= 2.9.0)

More information

401 Review. 6. Power analysis for one/two-sample hypothesis tests and for correlation analysis.

401 Review. 6. Power analysis for one/two-sample hypothesis tests and for correlation analysis. 401 Review Major topics of the course 1. Univariate analysis 2. Bivariate analysis 3. Simple linear regression 4. Linear algebra 5. Multiple regression analysis Major analysis methods 1. Graphical analysis

More information

Introduction to the R Statistical Computing Environment

Introduction to the R Statistical Computing Environment Introduction to the R Statistical Computing Environment John Fox McMaster University ICPSR 2012 John Fox (McMaster University) Introduction to R ICPSR 2012 1 / 34 Outline Getting Started with R Statistical

More information

Package paramap. R topics documented: September 20, 2017

Package paramap. R topics documented: September 20, 2017 Package paramap September 20, 2017 Type Package Title paramap Version 1.4 Date 2017-09-20 Author Brian P. O'Connor Maintainer Brian P. O'Connor Depends R(>= 1.9.0), psych, polycor

More information

Measuring relationships among multiple responses

Measuring relationships among multiple responses Measuring relationships among multiple responses Linear association (correlation, relatedness, shared information) between pair-wise responses is an important property used in almost all multivariate analyses.

More information

Package jmcm. November 25, 2017

Package jmcm. November 25, 2017 Type Package Package jmcm November 25, 2017 Title Joint Mean-Covariance Models using 'Armadillo' and S4 Version 0.1.8.0 Maintainer Jianxin Pan Fit joint mean-covariance models

More information

Package rbvs. R topics documented: August 29, Type Package Title Ranking-Based Variable Selection Version 1.0.

Package rbvs. R topics documented: August 29, Type Package Title Ranking-Based Variable Selection Version 1.0. Type Package Title Ranking-Based Variable Selection Version 1.0.2 Date 2015-12-08 Package rbvs August 29, 2016 Author Rafal Baranowski, Patrick Breheny, Isaac Turner Maintainer Rafal Baranowski

More information

Bivariate data analysis

Bivariate data analysis Bivariate data analysis Categorical data - creating data set Upload the following data set to R Commander sex female male male male male female female male female female eye black black blue green green

More information

Data Analyses in Multivariate Regression Chii-Dean Joey Lin, SDSU, San Diego, CA

Data Analyses in Multivariate Regression Chii-Dean Joey Lin, SDSU, San Diego, CA Data Analyses in Multivariate Regression Chii-Dean Joey Lin, SDSU, San Diego, CA ABSTRACT Regression analysis is one of the most used statistical methodologies. It can be used to describe or predict causal

More information

Package dhsic. R topics documented: July 27, 2017

Package dhsic. R topics documented: July 27, 2017 Package dhsic July 27, 2017 Type Package Title Independence Testing via Hilbert Schmidt Independence Criterion Version 2.0 Date 2017-07-24 Author Niklas Pfister and Jonas Peters Maintainer Niklas Pfister

More information

Multivariable Fractional Polynomials

Multivariable Fractional Polynomials Multivariable Fractional Polynomials Axel Benner May 17, 2007 Contents 1 Introduction 1 2 Inventory of functions 1 3 Usage in R 2 3.1 Model selection........................................ 3 4 Example

More information

AMS526: Numerical Analysis I (Numerical Linear Algebra)

AMS526: Numerical Analysis I (Numerical Linear Algebra) AMS526: Numerical Analysis I (Numerical Linear Algebra) Lecture 1: Course Overview & Matrix-Vector Multiplication Xiangmin Jiao SUNY Stony Brook Xiangmin Jiao Numerical Analysis I 1 / 20 Outline 1 Course

More information

Package mistwosources

Package mistwosources Type Package Package mistwosources November 4, 2016 Title Probit models with two misclassified responses Version 1.0 Date 2016-10-07 Author Scott J. Cook, Betsabe Blas, Raymond J. Carroll and Samiran Sinha

More information

Linear Algebra Massoud Malek

Linear Algebra Massoud Malek CSUEB Linear Algebra Massoud Malek Inner Product and Normed Space In all that follows, the n n identity matrix is denoted by I n, the n n zero matrix by Z n, and the zero vector by θ n An inner product

More information

The Model Building Process Part I: Checking Model Assumptions Best Practice

The Model Building Process Part I: Checking Model Assumptions Best Practice The Model Building Process Part I: Checking Model Assumptions Best Practice Authored by: Sarah Burke, PhD 31 July 2017 The goal of the STAT T&E COE is to assist in developing rigorous, defensible test

More information

HOSTOS COMMUNITY COLLEGE DEPARTMENT OF MATHEMATICS

HOSTOS COMMUNITY COLLEGE DEPARTMENT OF MATHEMATICS HOSTOS COMMUNITY COLLEGE DEPARTMENT OF MATHEMATICS MAT 217 Linear Algebra CREDIT HOURS: 4.0 EQUATED HOURS: 4.0 CLASS HOURS: 4.0 PREREQUISITE: PRE/COREQUISITE: MAT 210 Calculus I MAT 220 Calculus II RECOMMENDED

More information

Simulation study on using moment functions for sufficient dimension reduction

Simulation study on using moment functions for sufficient dimension reduction Michigan Technological University Digital Commons @ Michigan Tech Dissertations, Master's Theses and Master's Reports - Open Dissertations, Master's Theses and Master's Reports 2012 Simulation study on

More information

A User's Guide To Principal Components

A User's Guide To Principal Components A User's Guide To Principal Components J. EDWARD JACKSON A Wiley-Interscience Publication JOHN WILEY & SONS, INC. New York Chichester Brisbane Toronto Singapore Contents Preface Introduction 1. Getting

More information

[k,g,gfin] = hinfsyn(p,nmeas,ncon,gmin,gmax,tol)

[k,g,gfin] = hinfsyn(p,nmeas,ncon,gmin,gmax,tol) 8 H Controller Synthesis: hinfsyn The command syntax is k,g,gfin = hinfsyn(p,nmeas,ncon,gmin,gmax,tol) associated with the general feedback diagram below. e y P d u e G = F L (P, K) d K hinfsyn calculates

More information

ESCONDIDO UNION HIGH SCHOOL DISTRICT COURSE OF STUDY OUTLINE AND INSTRUCTIONAL OBJECTIVES

ESCONDIDO UNION HIGH SCHOOL DISTRICT COURSE OF STUDY OUTLINE AND INSTRUCTIONAL OBJECTIVES ESCONDIDO UNION HIGH SCHOOL DISTRICT COURSE OF STUDY OUTLINE AND INSTRUCTIONAL OBJECTIVES COURSE TITLE: Algebra II A/B COURSE NUMBERS: (P) 7241 / 2381 (H) 3902 / 3903 (Basic) 0336 / 0337 (SE) 5685/5686

More information

Using Arc for Dimension Reduction and Graphical Exploration in Regression

Using Arc for Dimension Reduction and Graphical Exploration in Regression Using Arc for Dimension Reduction and Graphical Exploration in Regression R. Dennis Cook June 15, 2000 Abstract here Abstract Key Words: Central subspaces, Dimension reduction; Principal Hessian Directions;

More information

Visualizing the Multivariate Normal, Lecture 9

Visualizing the Multivariate Normal, Lecture 9 Visualizing the Multivariate Normal, Lecture 9 Rebecca C. Steorts September 15, 2015 Last class Class was done on the board get notes if you missed lecture. Make sure to go through the Markdown example

More information

The Model Building Process Part I: Checking Model Assumptions Best Practice (Version 1.1)

The Model Building Process Part I: Checking Model Assumptions Best Practice (Version 1.1) The Model Building Process Part I: Checking Model Assumptions Best Practice (Version 1.1) Authored by: Sarah Burke, PhD Version 1: 31 July 2017 Version 1.1: 24 October 2017 The goal of the STAT T&E COE

More information

Package metansue. July 11, 2018

Package metansue. July 11, 2018 Type Package Package metansue July 11, 2018 Title Meta-Analysis of Studies with Non Statistically-Significant Unreported Effects Version 2.2 Date 2018-07-11 Author Joaquim Radua Maintainer Joaquim Radua

More information

Linear, Generalized Linear, and Mixed-Effects Models in R. Linear and Generalized Linear Models in R Topics

Linear, Generalized Linear, and Mixed-Effects Models in R. Linear and Generalized Linear Models in R Topics Linear, Generalized Linear, and Mixed-Effects Models in R John Fox McMaster University ICPSR 2018 John Fox (McMaster University) Statistical Models in R ICPSR 2018 1 / 19 Linear and Generalized Linear

More information

Package clustergeneration

Package clustergeneration Version 1.3.4 Date 2015-02-18 Package clustergeneration February 19, 2015 Title Random Cluster Generation (with Specified Degree of Separation) Author Weiliang Qiu , Harry Joe

More information

Package matrixnormal

Package matrixnormal Version 0.0.0 Date 2018-10-26 Type Package Title The Matrix Normal Distribution Depends R (>= 3.5.0) Imports mvtnorm (>= 1.0.8), utils (>= 3.5.0) Package matrixnormal October 30, 2018 Suggests datasets

More information

Package breakaway. R topics documented: March 30, 2016

Package breakaway. R topics documented: March 30, 2016 Title Species Richness Estimation and Modeling Version 3.0 Date 2016-03-29 Author and John Bunge Maintainer Package breakaway March 30, 2016 Species richness estimation is an important

More information

PRINCIPAL COMPONENTS ANALYSIS

PRINCIPAL COMPONENTS ANALYSIS 121 CHAPTER 11 PRINCIPAL COMPONENTS ANALYSIS We now have the tools necessary to discuss one of the most important concepts in mathematical statistics: Principal Components Analysis (PCA). PCA involves

More information

Lecture 5 Singular value decomposition

Lecture 5 Singular value decomposition Lecture 5 Singular value decomposition Weinan E 1,2 and Tiejun Li 2 1 Department of Mathematics, Princeton University, weinan@princeton.edu 2 School of Mathematical Sciences, Peking University, tieli@pku.edu.cn

More information

Package mctest. February 26, 2018

Package mctest. February 26, 2018 Type Package Title Multicollinearity Diagnostic Measures Version 1.2 Date 2018-02-24 Package mctest February 26, 2018 Author Dr. Muhammad Imdad Ullah and Dr. Muhammad Aslam Maintainer Dr. Muhammad Imdad

More information

Package bayeslm. R topics documented: June 18, Type Package

Package bayeslm. R topics documented: June 18, Type Package Type Package Package bayeslm June 18, 2018 Title Efficient Sampling for Gaussian Linear Regression with Arbitrary Priors Version 0.8.0 Date 2018-6-17 Author P. Richard Hahn, Jingyu He, Hedibert Lopes Maintainer

More information

Package ebal. R topics documented: February 19, Type Package

Package ebal. R topics documented: February 19, Type Package Type Package Package ebal February 19, 2015 Title Entropy reweighting to create balanced samples Version 0.1-6 Date 2014-01-25 Author Maintainer Package implements entropy balancing,

More information

Sufficient Dimension Reduction using Support Vector Machine and it s variants

Sufficient Dimension Reduction using Support Vector Machine and it s variants Sufficient Dimension Reduction using Support Vector Machine and it s variants Andreas Artemiou School of Mathematics, Cardiff University @AG DANK/BCS Meeting 2013 SDR PSVM Real Data Current Research and

More information

Final Exam, Linear Algebra, Fall, 2003, W. Stephen Wilson

Final Exam, Linear Algebra, Fall, 2003, W. Stephen Wilson Final Exam, Linear Algebra, Fall, 2003, W. Stephen Wilson Name: TA Name and section: NO CALCULATORS, SHOW ALL WORK, NO OTHER PAPERS ON DESK. There is very little actual work to be done on this exam if

More information

Lecture 13. Principal Component Analysis. Brett Bernstein. April 25, CDS at NYU. Brett Bernstein (CDS at NYU) Lecture 13 April 25, / 26

Lecture 13. Principal Component Analysis. Brett Bernstein. April 25, CDS at NYU. Brett Bernstein (CDS at NYU) Lecture 13 April 25, / 26 Principal Component Analysis Brett Bernstein CDS at NYU April 25, 2017 Brett Bernstein (CDS at NYU) Lecture 13 April 25, 2017 1 / 26 Initial Question Intro Question Question Let S R n n be symmetric. 1

More information

Matrix Factorizations

Matrix Factorizations 1 Stat 540, Matrix Factorizations Matrix Factorizations LU Factorization Definition... Given a square k k matrix S, the LU factorization (or decomposition) represents S as the product of two triangular

More information

SPSS LAB FILE 1

SPSS LAB FILE  1 SPSS LAB FILE www.mcdtu.wordpress.com 1 www.mcdtu.wordpress.com 2 www.mcdtu.wordpress.com 3 OBJECTIVE 1: Transporation of Data Set to SPSS Editor INPUTS: Files: group1.xlsx, group1.txt PROCEDURE FOLLOWED:

More information

Invariant coordinate selection for multivariate data analysis - the package ICS

Invariant coordinate selection for multivariate data analysis - the package ICS Invariant coordinate selection for multivariate data analysis - the package ICS Klaus Nordhausen 1 Hannu Oja 1 David E. Tyler 2 1 Tampere School of Public Health University of Tampere 2 Department of Statistics

More information

Introduction and Single Predictor Regression. Correlation

Introduction and Single Predictor Regression. Correlation Introduction and Single Predictor Regression Dr. J. Kyle Roberts Southern Methodist University Simmons School of Education and Human Development Department of Teaching and Learning Correlation A correlation

More information

Package anoint. July 19, 2015

Package anoint. July 19, 2015 Type Package Title Analysis of Interactions Version 1.4 Date 2015-07-10 Package anoint July 19, 2015 Author Ravi Varadhan and Stephanie Kovalchik Maintainer Stephanie Kovalchik

More information

Package KRLS. July 10, 2017

Package KRLS. July 10, 2017 Type Package Title Kernel-Based Regularized Least Squares Version 1.0-0 Date 2017-07-08 Package KRLS July 10, 2017 Author Jens Hainmueller (Stanford) Chad Hazlett (UCLA) Maintainer Jens Hainmueller

More information

Package depth.plot. December 20, 2015

Package depth.plot. December 20, 2015 Package depth.plot December 20, 2015 Type Package Title Multivariate Analogy of Quantiles Version 0.1 Date 2015-12-19 Maintainer Could be used to obtain spatial depths, spatial ranks and outliers of multivariate

More information

Package blme. August 29, 2016

Package blme. August 29, 2016 Version 1.0-4 Date 2015-06-13 Title Bayesian Linear Mixed-Effects Models Author Vincent Dorie Maintainer Vincent Dorie Package blme August 29, 2016 Description Maximum a posteriori

More information

SUPPLEMENTAL NOTES FOR ROBUST REGULARIZED SINGULAR VALUE DECOMPOSITION WITH APPLICATION TO MORTALITY DATA

SUPPLEMENTAL NOTES FOR ROBUST REGULARIZED SINGULAR VALUE DECOMPOSITION WITH APPLICATION TO MORTALITY DATA SUPPLEMENTAL NOTES FOR ROBUST REGULARIZED SINGULAR VALUE DECOMPOSITION WITH APPLICATION TO MORTALITY DATA By Lingsong Zhang, Haipeng Shen and Jianhua Z. Huang Purdue University, University of North Carolina,

More information

Package MAVE. May 20, 2018

Package MAVE. May 20, 2018 Type Package Title Methods for Dimension Reduction Version 1.3.8 Date 2018-05-18 Package MAVE May 20, 2018 Author Hang Weiqiang, Xia Yingcun Maintainer Hang Weiqiang

More information

EE731 Lecture Notes: Matrix Computations for Signal Processing

EE731 Lecture Notes: Matrix Computations for Signal Processing EE731 Lecture Notes: Matrix Computations for Signal Processing James P. Reilly c Department of Electrical and Computer Engineering McMaster University October 17, 005 Lecture 3 3 he Singular Value Decomposition

More information

The entire data set consists of n = 32 widgets, 8 of which were made from each of q = 4 different materials.

The entire data set consists of n = 32 widgets, 8 of which were made from each of q = 4 different materials. One-Way ANOVA Summary The One-Way ANOVA procedure is designed to construct a statistical model describing the impact of a single categorical factor X on a dependent variable Y. Tests are run to determine

More information

Statistics for Python

Statistics for Python Statistics for Python An extension module for the Python scripting language Michiel de Hoon, Columbia University 2 September 2010 Statistics for Python, an extension module for the Python scripting language.

More information