Package MixGLasso. August 31, 2013

Size: px
Start display at page:

Download "Package MixGLasso. August 31, 2013"

Transcription

1 Package MixGLasso August 31, 2013 Type Package Title The MixGLasso-package is a powerful tool for clustering high-dimensional data. Version 1.0 Date Author Nicolas Staedler Maintainer Nicolas Staedler <staedler.n@gmail.com> The MixGLasso-package is a powerful tool for clustering high-dimensional data. It is based on a Gaussian mixture model. Each component is characterized by a mean vector an a covariance matrix. The inverse covariance matrices are sparse and represent a Gaussian graphical models (GGM). Estimation is performed using a novel penalized EM algorithm. Several strategies to select an optimal number of mixture components are implemented. Imports glasso, mclust, multicore, mvtnorm License GPL-2 Collate hmmgl_mixgl backup-mixglasso-only.r R topics documented: MixGLasso-package bwprun_mixglasso EXPStep.mix func.uinit glasso.invcor glasso.invcov glasso.parcor loglik_mix mixglasso mixglasso_init mixglasso_path MStepGlasso simmix

2 2 bwprun_mixglasso sparse_conc sumoffdiag symmkldist tr w.kldist Index 18 MixGLasso-package MixGLasso-package The MixGLasso-package is a powerful tool for clustering high-dimensional data. It is based on a Gaussian mixture model. Each component is characterized by a mean vector an a covariance matrix. The inverse covariance matrices are sparse and represent a Gaussian graphical models (GGM). Estimation is performed using a novel penalized EM algorithm. Several strategies to select an optimal number of mixture components are implemented. Details MixGLasso provides an optimal number of mixture components; optimal cluster assignments; Cluster-specific networks (sparse inverse covariance matrices); Cluster-specific means. References St\"adler, N. and Mukherjee, S. (2012). Penalized estimation in high-dimensional hidden Markov models with comp-specific graphical models. To appear in the Annals of Applied Statistics. http: //arxiv.org/abs/ bwprun_mixglasso bwprun_mixglasso Mixglasso with backward pruning bwprun_mixglasso(x, n.comp.min = 1, n.comp.max, lambda = sqrt(2 * nrow(x) * log(ncol(x)))/2, pen = "glasso.parcor", selection.crit = "mmdl", term = 10^{ -3 }, min.compsize = 5, init = "kmeans.hc", my.cl = NULL, modelname.hc = "VVV", nstart.kmeans = 1, iter.max.kmeans = 10, reinit.out = FALSE, reinit.in = FALSE, mer = TRUE, del = TRUE,...)

3 bwprun_mixglasso 3 x Input data matrix n.comp.min Minimum number of components. Take n.comp.min=1! n.comp.max lambda pen Maximum number of components Regularization parameter. Default=sqrt(2*n*log(p))/2 Determines form of penalty: glasso.parcor (default), glasso.invcov, glasso.invcor selection.crit Selection criterion. Default= mmdl term min.compsize init my.cl modelname.hc Termination criterion of EM algorithm. Default=10^-3 Stop EM if any(compsize)<min.compsize; Default=5 Initialization. Method used for initialization init= cl.init, r.means, random, kmeans, kmeans.hc, h Default= kmeans.hc Initial cluster assignments; need to be provided if init= cl.init (otherwise this param is ignored). Default=NULL Model class used in hc. Default="VVV" nstart.kmeans Number of random starts in kmeans; default=1 iter.max.kmeans Maximal number of iteration in kmeans; default=10 reinit.out Re-initialization if compsize<min.compsize (at the start of algorithm)? reinit.in mer del Details Re-initialization if compsize<min.compsize (at the bwprun-loop level of algorithm)? Merge closest comps for initialization Delete smallest comp for initialization... Other arguments. See mixglasso_init This function runs mixglasso with various number of mixture components: It starts with a too large number of components and iterates towards solutions with smaller number of components by initializing using previous solutions. list consisting of selcrit res.init comp.name Selcrit for all models with number of components between n.comp.min and n.comp.max Initialization for all components List of names of components. Indicates which states where merged/deleted during backward pruning re.init.in Logical vector indicating whether re-initialization was performed or not fit.mixgl.selcrit Results for model with optimal number of components. List see mixglasso_init

4 4 EXPStep.mix Examples ########################################### ##This an example of how to use MixGLasso## ########################################### rm(list=ls()) ##generate data n < K <- 3 p <- 10 mix.prob <- rep(1/k,k) SigInv <- sparse_conc(p,k,s=p,s.common=0,scale.parcor=true) Sig <- array(na,dim=c(p,p,k)) for (k in 1:K){ Sig[,,k] <- solve(siginv[[k]]) } Mu <- matrix(0,p,k) nonzero.mean <- split(sample(1:p),rep(1:k,length=p)) for(k in 1:K){ Mu[nonzero.mean[[k]],k] <- -2/sqrt(ceiling(p/K)) } dat <- simmix(n,k,mix.prob,mu,sig) ##run mixglasso fit1 <- mixglasso_path(dat$x,n.comp=1:6,save.allfits=false,show.trace=true) fit1$bic# fit2 <- mixglasso_path(dat$x,n.comp=6,save.allfits=false,show.trace=true) fit2$bic# fit3 <- mixglasso_path(dat$x,n.comp=1:6,lambda=0,save.allfits=false,show.trace=true) fit4 <- mixglasso_path(dat$x,n.comp=1:6,lambda=inf,save.allfits=false,show.trace=true) fit5 <- bwprun_mixglasso(dat$x,n.comp=1,n.comp.max=6,selection.crit= bic ) ##compare bic plot(fit1$bic,type= l,lty=1,ylim=range(c(fit1$bic,fit3$bic,fit4$bic)), ylab= bic,xlab= no components ) lines(fit3$bic,lty=2) lines(fit4$bic,lty=3) EXPStep.mix Performs EStep Performs EStep

5 func.uinit 5 EXPStep.mix(logphi, mix.prob) logphi mix.prob list consiting of u LL responsibilities loglikelihood func.uinit Initialization of MixGLasso Initialization of responsibilities func.uinit(x, n.comp, init = "kmeans", my.cl = NULL, nstart.kmeans = 1, iter.max.kmeans = 10, modelname.hc = "EII") x n.comp init my.cl Observed data Number of mixture components Method used for initialization init= cl.init, r.means, random, kmeans, kmeans.hc, hc Initial cluster assignments; need to be provided if init= cl.init (otherwise this param is ignored) Number of random starts in kmeans; default=1 nstart.kmeans iter.max.kmeans Maximal number of iteration in kmeans; default=10 modelname.hc Model class used in hc; default= EII a list consisting of u responsibilities

6 6 glasso.invcov glasso.invcor Graphical Lasso based on inverse covariance penalty Graphical Lasso based on inverse covariance penalty glasso.invcor(s, rho, penalize.diagonal, term = 10^{ -3 }) s rho penalize.diagonal term w; wi; iter glasso.invcov Graphical Lasso based on inverse correlation penalty Graphical Lasso based on inverse correlation penalty glasso.invcov(s, rho, penalize.diagonal, term = 10^{ -3 }) s rho penalize.diagonal term

7 glasso.parcor 7 w; wi; iter glasso.parcor Graphical Lasso based on partial correlation penalty Graphical Lasso based on partial correlation penalty glasso.parcor(s, rho, penalize.diagonal, maxiter = 1000, term = 10^{ -3 }) s rho penalize.diagonal maxiter term w; wi; iter loglik_mix Log-likelihood for mixture model Log-likelihood for mixture model loglik_mix(x, mix.prob, Mu, Sig)

8 8 mixglasso x mix.prob Mu Sig log-likelihood mixglasso mixglasso mixglasso x mixglasso(x, n.comp, lambda = sqrt(2 * nrow(x) * log(ncol(x)))/2, pen = "glasso.parcor", init = "kmeans.hc", my.cl = NULL, modelname.hc = "VVV", nstart.kmeans = 1, iter.max.kmeans = 10, term = 10^{ -3 }, min.compsize = 5,...) n.comp lambda pen init my.cl modelname.hc Input data matrix Number of mixture components Regularization parameter. Default=sqrt(2*n*log(p))/2 Determines form of penalty: glasso.parcor (default), glasso.invcov, glasso.invcor Initialization. Method used for initialization init= cl.init, r.means, random, kmeans, kmeans.hc, h Default= kmeans Initial cluster assignments; need to be provided if init= cl.init (otherwise this param is ignored). Default=NULL Model class used in hc. Default="VVV" nstart.kmeans Number of random starts in kmeans; default=1 iter.max.kmeans Maximal number of iteration in kmeans; default=10 term min.compsize Termination criterion of EM algorithm. Default=10^-3 Stop EM if any(compsize)<min.compsize; Default=5... Other arguments. See mixglasso_init

9 mixglasso_init 9 Details This function runs mixglasso see return mixglasso_init. list consisting of mix.prob Mu Sig SigInv iter loglik bic mmdl u comp compsize pi.comps warn -loglik+log(n)*df/2 -loglik+penmmdl/2 responsibilities component assignments size of components warnings during optimization mixglasso_init mixglasso_init mixglasso_init (initialization and lambda set by user) mixglasso_init(x, n.comp, lambda, u.init, mix.prob.init, gamma = 0.5, pen = "glasso.parcor", penalize.diagonal = FALSE, term = 10^{ -3 }, miniter = 5, maxiter = 1000, min.compsize = 5, show.trace = FALSE)

10 10 mixglasso_init x n.comp lambda u.init mix.prob.init gamma Input data matrix Number of mixture components Regularization parameter Initial responsibilities Initial component probablities Determines form of penalty pen Determines form of penalty: glasso.parcor (default), glasso.invcov, glasso.invcor penalize.diagonal Should the diagonal of the inverse covariance matrix be penalized? Default=FALSE (recommended) term miniter maxiter min.compsize show.trace Termination criterion of EM algorithm. Default=10^-3 Minimal number of EM iteration before stop EM if any(compsize)<min.compsize applies. Default=5 Maximal number of EM iteration. Default=1000 Stop EM if any(compsize)<min.compsize; Default=5 Should information during execution be printed? Default=FALSE Details This function runs mixglasso; requires initialization (u.init,mix.prob.init) list consisting of mix.prob Mu Sig SigInv iter loglik bic mmdl u comp compsize pi.comps warn Component probabilities Component specific mean vectors Component specific covariance matrices Component specific inverse covariance matrices Number of EM iterations Log-likelihood -loglik+log(n)*df/2 -loglik+penmmdl/2 Component responsibilities Component assignments Size of components Component probabilities Warnings during EM algorithm

11 mixglasso_path 11 mixglasso_path mixglasso_path mixglasso_path mixglasso_path(x, n.comp, lambda = sqrt(2 * nrow(x) * log(ncol(x)))/2, pen = "glasso.parcor", init = "kmeans.hc", my.cl = NULL, modelname.hc = "VVV", nstart.kmeans = 1, iter.max.kmeans = 10, term = 10^{ -3 }, min.compsize = 5, save.allfits = TRUE, filename = NULL, mc.set.seed = FALSE, mc.preschedule = FALSE,...) x n.comp lambda pen init my.cl modelname.hc Input data matrix Number of mixture components Regularization parameter. Default=sqrt(2*n*log(p))/2 Determines form of penalty: glasso.parcor (default), glasso.invcov, glasso.invcor Initialization. Method used for initialization init= cl.init, r.means, random, kmeans, kmeans.hc, h Default= kmeans Initial cluster assignments; need to be provided if init= cl.init (otherwise this param is ignored). Default=NULL Model class used in hc. Default="VVV" nstart.kmeans Number of random starts in kmeans; default=1 iter.max.kmeans Maximal number of iteration in kmeans; default=10 term min.compsize Termination criterion of EM algorithm. Default=10^-3 Stop EM if any(compsize)<min.compsize; Default=5 save.allfits Save output of mixglasso for all k s? filename mc.set.seed Output of mixglasso with filename_fit.mixgl_k.rda See mclapply. Default=FALSE mc.preschedule See mclapply. Default=FALSE... Other arguments. See mixglasso_init Details Runs mixglasso (in parallel) with various number of mixture components

12 12 mixglasso_path list consisting of bic comp iter warn Bic for all fits Components assignments for all fits Number of iteration of EM for all fits Warning infos for all fits Examples ########################################### ##This an example of how to use MixGLasso## ########################################### rm(list=ls()) ##generate data n < K <- 3 p <- 10 mix.prob <- rep(1/k,k) SigInv <- sparse_conc(p,k,s=p,s.common=0,scale.parcor=true) Sig <- array(na,dim=c(p,p,k)) for (k in 1:K){ Sig[,,k] <- solve(siginv[[k]]) } Mu <- matrix(0,p,k) nonzero.mean <- split(sample(1:p),rep(1:k,length=p)) for(k in 1:K){ Mu[nonzero.mean[[k]],k] <- -2/sqrt(ceiling(p/K)) } dat <- simmix(n,k,mix.prob,mu,sig) ##run mixglasso fit1 <- mixglasso_path(dat$x,n.comp=1:6,save.allfits=false,show.trace=true) fit1$bic# fit2 <- mixglasso_path(dat$x,n.comp=6,save.allfits=false,show.trace=true) fit2$bic# fit3 <- mixglasso_path(dat$x,n.comp=1:6,lambda=0,save.allfits=false,show.trace=true) fit4 <- mixglasso_path(dat$x,n.comp=1:6,lambda=inf,save.allfits=false,show.trace=true) fit5 <- bwprun_mixglasso(dat$x,n.comp=1,n.comp.max=6,selection.crit= bic ) ##compare bic plot(fit1$bic,type= l,lty=1,ylim=range(c(fit1$bic,fit3$bic,fit4$bic)),

13 MStepGlasso 13 ylab= bic,xlab= no components ) lines(fit3$bic,lty=2) lines(fit4$bic,lty=3) MStepGlasso MStep of MixGLasso MStep of MixGLasso MStepGlasso(x, chromosome = NULL, u, v = NULL, lambda, gamma, pen, penalize.diagonal, equal.prob.trans = NULL, term, model = "hmm") x chromosome u v lambda gamma pen penalize.diagonal equal.prob.trans term model list consisting of mix.prob, Mu, Sig, SigInv

14 14 sparse_conc simmix Simulate from mixture model with MVN components Simulate from mixture model with MVN components simmix(n, n.comp, mix.prob, Mu, Sig) n n.comp mix.prob Mu Sig sample size number of mixture components ("comps") mixing probablities matrix of component-specific mean vectors array of component-specific covariance matrices a list consisting of S X component assignments observed data matrix sparse_conc Generates sparse inverse covariance matrices Generates sparse inverse covariance matrices sparse_conc(p, K, s, s.common, magn.nz = 0.5, scale.parcor = TRUE) p Dimensionality of inverse covariance matrix K Number of inverse covariance matrices s Number of non-zero entries per inverse covariance matrix s.common Number of non-zero entries shared across different inverse covariance matrices magn.nz Magnitude of non-zero elements scale.parcor Should SigInv be scaled to have diagonal equal one, siginv=parcor?

15 sumoffdiag 15 SigInv: list of inverse covariance matrices sumoffdiag Sum of non-diag elements of a matrix Sum of non-diag elements of a matrix sumoffdiag(m) m Sum of non-diag elements symmkldist Compute symmetric kull-back leibler distance Compute symmetric kull-back leibler distance symmkldist(mu1, mu2, sig1, sig2) mu1 mu2 sig1 sig2

16 16 w.kldist symmetric kull-back leibler distance tr Compute trace of matrix Compute trace of matrix tr(m) m trace of matrix w.kldist Distance between comps based on symm. kl-distance Distance between comps based on symm. kl-distance w.kldist(mu, Sig) Mu Sig

17 w.kldist 17 list consisting of comp.kldist min.comp.kldist

18 Index bwprun_mixglasso, 2 EXPStep.mix, 4 func.uinit, 5 glasso.invcor, 6 glasso.invcov, 6 glasso.parcor, 7 loglik_mix, 7 mixglasso, 8 MixGLasso-package, 2 mixglasso_init, 9 mixglasso_path, 11 MStepGlasso, 13 simmix, 14 sparse_conc, 14 sumoffdiag, 15 symmkldist, 15 tr, 16 w.kldist, 16 18

Package scio. February 20, 2015

Package scio. February 20, 2015 Title Sparse Column-wise Inverse Operator Version 0.6.1 Author Xi (Rossi) LUO and Weidong Liu Package scio February 20, 2015 Maintainer Xi (Rossi) LUO Suggests clime, lorec, QUIC

More information

Package EMMIX. November 8, 2013

Package EMMIX. November 8, 2013 Title The EM Algorithm and Mixture Models Package EMMIX November 8, 2013 Description Fit multivariate mixture models via the EM Algorithm. Multivariate distributions include Normal distribution, t-distribution,

More information

Package mixture. R topics documented: February 13, 2018

Package mixture. R topics documented: February 13, 2018 Package mixture February 13, 2018 Type Package Title Finite Gaussian Mixture Models for Clustering and Classification Version 1.5 Date 2018-02-13 Author Ryan P. Browne, Aisha ElSherbiny and Paul D. McNicholas

More information

Package spcov. R topics documented: February 20, 2015

Package spcov. R topics documented: February 20, 2015 Package spcov February 20, 2015 Type Package Title Sparse Estimation of a Covariance Matrix Version 1.01 Date 2012-03-04 Author Jacob Bien and Rob Tibshirani Maintainer Jacob Bien Description

More information

Package varband. November 7, 2016

Package varband. November 7, 2016 Type Package Package varband November 7, 2016 Title Variable Banding of Large Precision Matrices Version 0.9.0 Implementation of the variable banding procedure for modeling local dependence and estimating

More information

Package sgpca. R topics documented: July 6, Type Package. Title Sparse Generalized Principal Component Analysis. Version 1.0.

Package sgpca. R topics documented: July 6, Type Package. Title Sparse Generalized Principal Component Analysis. Version 1.0. Package sgpca July 6, 2013 Type Package Title Sparse Generalized Principal Component Analysis Version 1.0 Date 2012-07-05 Author Frederick Campbell Maintainer Frederick Campbell

More information

Package LCAextend. August 29, 2013

Package LCAextend. August 29, 2013 Type Package Package LCAextend August 29, 2013 Title Latent Class Analysis (LCA) with familial dependence in extended pedigrees Version 1.2 Date 2012-03-15 Author Arafat TAYEB ,

More information

Package penmsm. R topics documented: February 20, Type Package

Package penmsm. R topics documented: February 20, Type Package Type Package Package penmsm February 20, 2015 Title Estimating Regularized Multi-state Models Using L1 Penalties Version 0.99 Date 2015-01-12 Author Maintainer Structured fusion

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

arxiv: v2 [stat.me] 8 Jan 2014

arxiv: v2 [stat.me] 8 Jan 2014 The Annals of Applied Statistics 2013, Vol. 7, No. 4, 2157 2179 DOI: 10.1214/13-AOAS662 c Institute of Mathematical Statistics, 2013 arxiv:1208.4989v2 [stat.me] 8 Jan 2014 PENALIZED ESTIMATION IN HIGH-DIMENSIONAL

More information

Package Grace. R topics documented: April 9, Type Package

Package Grace. R topics documented: April 9, Type Package Type Package Package Grace April 9, 2017 Title Graph-Constrained Estimation and Hypothesis Tests Version 0.5.3 Date 2017-4-8 Author Sen Zhao Maintainer Sen Zhao Description Use

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 flexcwm. R topics documented: July 11, Type Package. Title Flexible Cluster-Weighted Modeling. Version 1.0.

Package flexcwm. R topics documented: July 11, Type Package. Title Flexible Cluster-Weighted Modeling. Version 1.0. Package flexcwm July 11, 2013 Type Package Title Flexible Cluster-Weighted Modeling Version 1.0 Date 2013-02-17 Author Incarbone G., Mazza A., Punzo A., Ingrassia S. Maintainer Angelo Mazza

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

Package flexcwm. R topics documented: July 2, Type Package. Title Flexible Cluster-Weighted Modeling. Version 1.1.

Package flexcwm. R topics documented: July 2, Type Package. Title Flexible Cluster-Weighted Modeling. Version 1.1. Package flexcwm July 2, 2014 Type Package Title Flexible Cluster-Weighted Modeling Version 1.1 Date 2013-11-03 Author Mazza A., Punzo A., Ingrassia S. Maintainer Angelo Mazza Description

More information

Package esaddle. R topics documented: January 9, 2017

Package esaddle. R topics documented: January 9, 2017 Package esaddle January 9, 2017 Type Package Title Extended Empirical Saddlepoint Density Approximation Version 0.0.3 Date 2017-01-07 Author Matteo Fasiolo and Simon Wood Maintainer Matteo Fasiolo

More information

Package darts. February 19, 2015

Package darts. February 19, 2015 Type Package Package darts February 19, 2015 Title Statistical Tools to Analyze Your Darts Game Version 1.0 Date 2011-01-17 Author Maintainer Are you aiming at the right spot in darts?

More information

A Gentle Tutorial of the EM Algorithm and its Application to Parameter Estimation for Gaussian Mixture and Hidden Markov Models

A Gentle Tutorial of the EM Algorithm and its Application to Parameter Estimation for Gaussian Mixture and Hidden Markov Models A Gentle Tutorial of the EM Algorithm and its Application to Parameter Estimation for Gaussian Mixture and Hidden Markov Models Jeff A. Bilmes (bilmes@cs.berkeley.edu) International Computer Science Institute

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

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 mhsmm. January 15, 2017

Package mhsmm. January 15, 2017 Type Package Package mhsmm January 15, 2017 Title Inference for Hidden Markov and Semi-Markov Models Version 0.4.16 Date 2017-01-15 Author Jared O'Connell , SÃ ren HÃ jsgaard

More information

Package EMMIXmfa. October 18, Index 15

Package EMMIXmfa. October 18, Index 15 Type Package Package EMMIXmfa October 18, 2017 Title Mixture models with component-wise factor analyzers Version 1.3.9 Date 2017-10-18 Author Suren Rathnayake, Geoff McLachlan, Jungsun Baek Maintainer

More information

Package gma. September 19, 2017

Package gma. September 19, 2017 Type Package Title Granger Mediation Analysis Version 1.0 Date 2018-08-23 Package gma September 19, 2017 Author Yi Zhao , Xi Luo Maintainer Yi Zhao

More information

10708 Graphical Models: Homework 2

10708 Graphical Models: Homework 2 10708 Graphical Models: Homework 2 Due Monday, March 18, beginning of class Feburary 27, 2013 Instructions: There are five questions (one for extra credit) on this assignment. There is a problem involves

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

Package rarhsmm. March 20, 2018

Package rarhsmm. March 20, 2018 Type Package Package rarhsmm March 20, 2018 Title Regularized Autoregressive Hidden Semi Markov Model Version 1.0.7 Date 2018-03-19 Author Zekun (Jack) Xu, Ye Liu Maintainer Zekun Xu

More information

Package threeboost. February 20, 2015

Package threeboost. February 20, 2015 Type Package Package threeboost February 20, 2015 Title Thresholded variable selection and prediction based on estimating equations Version 1.1 Date 2014-08-09 Author Julian Wolfson and Christopher Miller

More information

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

Package condmixt. R topics documented: February 19, Type Package Type Package Package condmixt February 19, 2015 Title Conditional Density Estimation with Neural Network Conditional Mixtures Version 1.0 Date 2012-04-06 Author Maintainer

More information

Package EMMIXskew. February 13, 2018

Package EMMIXskew. February 13, 2018 Package EMMIXskew February 13, 2018 Title The EM Algorithm and Skew Mixture Distribution EM algorithm for Fitting Mixture of Multivariate Skew Normal and Skew t Distributions. An implementation of the

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

CS Homework 3. October 15, 2009

CS Homework 3. October 15, 2009 CS 294 - Homework 3 October 15, 2009 If you have questions, contact Alexandre Bouchard (bouchard@cs.berkeley.edu) for part 1 and Alex Simma (asimma@eecs.berkeley.edu) for part 2. Also check the class website

More information

Package EMMIXmcfa. October 18, 2017

Package EMMIXmcfa. October 18, 2017 Package EMMIXmcfa October 18, 2017 Type Package Title Mixture of Factor Analyzers with Common Factor Loadings Version 2.0.8 Date 2017-10-18 Author Suren Rathnayake, Geoff McLachlan, Jungsun Baek Maintainer

More information

Package SpatialVS. R topics documented: November 10, Title Spatial Variable Selection Version 1.1

Package SpatialVS. R topics documented: November 10, Title Spatial Variable Selection Version 1.1 Title Spatial Variable Selection Version 1.1 Package SpatialVS November 10, 2018 Author Yili Hong, Li Xu, Yimeng Xie, and Zhongnan Jin Maintainer Yili Hong Perform variable selection

More information

Learning Multiple Tasks with a Sparse Matrix-Normal Penalty

Learning Multiple Tasks with a Sparse Matrix-Normal Penalty Learning Multiple Tasks with a Sparse Matrix-Normal Penalty Yi Zhang and Jeff Schneider NIPS 2010 Presented by Esther Salazar Duke University March 25, 2011 E. Salazar (Reading group) March 25, 2011 1

More information

Package basad. November 20, 2017

Package basad. November 20, 2017 Package basad November 20, 2017 Type Package Title Bayesian Variable Selection with Shrinking and Diffusing Priors Version 0.2.0 Date 2017-11-15 Author Qingyan Xiang , Naveen Narisetty

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

Package pendensity. March 13, 2016

Package pendensity. March 13, 2016 Type Package Package pendensity March 13, 2016 Title Density Estimation with a Penalized Mixture Approach Version 0.2.10 Date 2016-03-13 Depends R (>= 2.15.1), lattice, fda Author Christian Schellhase

More information

Package CEC. R topics documented: August 29, Title Cross-Entropy Clustering Version Date

Package CEC. R topics documented: August 29, Title Cross-Entropy Clustering Version Date Title Cross-Entropy Clustering Version 0.9.4 Date 2016-04-23 Package CEC August 29, 2016 Author Konrad Kamieniecki [aut, cre], Przemyslaw Spurek [ctb] Maintainer Konrad Kamieniecki

More information

Package RRR. April 12, 2013

Package RRR. April 12, 2013 Package RRR April 12, 2013 Type Package Title Reduced Rank Regression Methods Version 1.0 Date 2013-04-12 Author Maintainer Several reduced rank methods for conducting multivariate

More information

Computational Statistics with Application to Bioinformatics. Unit 11: Gaussian Mixture Models and EM Methods

Computational Statistics with Application to Bioinformatics. Unit 11: Gaussian Mixture Models and EM Methods Computational Statistics with Application to Bioinformatics Prof. William H. Press Spring Term, 2008 The University of Texas at Austin Unit 11: Gaussian Mixture Models and EM Methods The University of

More information

The sbgcop Package. March 9, 2007

The sbgcop Package. March 9, 2007 The sbgcop Package March 9, 2007 Title Semiparametric Bayesian Gaussian copula estimation Version 0.95 Date 2007-03-09 Author Maintainer This package estimates parameters of

More information

Package pearson7. June 22, 2016

Package pearson7. June 22, 2016 Version 1.0-2 Date 2016-06-21 Package pearson7 June 22, 2016 Title Maximum Likelihood Inference for the Pearson VII Distribution with Shape Parameter 3/2 Author John Hughes Maintainer John Hughes

More information

Package GMCM. R topics documented: July 2, Type Package. Title Fast estimation of Gaussian Mixture Copula Models. Version

Package GMCM. R topics documented: July 2, Type Package. Title Fast estimation of Gaussian Mixture Copula Models. Version Package GMCM July 2, 2014 Type Package Title Fast estimation of Gaussian Mixture Copula Models Version 1.0.1 Date 2014-01-30 Author Anders Ellern Bilgrau, Martin Boegsted, Poul Svante Eriksen Maintainer

More information

Package CoxRidge. February 27, 2015

Package CoxRidge. February 27, 2015 Type Package Title Cox Models with Dynamic Ridge Penalties Version 0.9.2 Date 2015-02-12 Package CoxRidge February 27, 2015 Author Aris Perperoglou Maintainer Aris Perperoglou

More information

Package alabama. March 6, 2015

Package alabama. March 6, 2015 Package alabama March 6, 2015 Type Package Title Constrained Nonlinear Optimization Description Augmented Lagrangian Adaptive Barrier Minimization Algorithm for optimizing smooth nonlinear objective functions

More information

Journal of Statistical Software

Journal of Statistical Software JSS Journal of Statistical Software January 2012, Volume 46, Issue 6. http://www.jstatsoft.org/ HDclassif: An R Package for Model-Based Clustering and Discriminant Analysis of High-Dimensional Data Laurent

More information

Package CopulaRegression

Package CopulaRegression Type Package Package CopulaRegression Title Bivariate Copula Based Regression Models Version 0.1-5 Depends R (>= 2.11.0), MASS, VineCopula Date 2014-09-04 Author, Daniel Silvestrini February 19, 2015 Maintainer

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

The mclust Package. January 18, Author C. Fraley and A.E. Raftery, Dept. of Statistics, University of Washington.

The mclust Package. January 18, Author C. Fraley and A.E. Raftery, Dept. of Statistics, University of Washington. The mclust Package January 18, 2005 Version 2.1-8 Author C. Fraley and A.E. Raftery, Dept. of Statistics, University of Washington. Title Model-based cluster analysis Model-based cluster analysis: the

More information

Package penalized. February 21, 2018

Package penalized. February 21, 2018 Version 0.9-50 Date 2017-02-01 Package penalized February 21, 2018 Title L1 (Lasso and Fused Lasso) and L2 (Ridge) Penalized Estimation in GLMs and in the Cox Model Author Jelle Goeman, Rosa Meijer, Nimisha

More information

Package covsep. May 6, 2018

Package covsep. May 6, 2018 Package covsep May 6, 2018 Title Tests for Determining if the Covariance Structure of 2-Dimensional Data is Separable Version 1.1.0 Author Shahin Tavakoli [aut, cre], Davide Pigoli [ctb], John Aston [ctb]

More information

Package abundant. January 1, 2017

Package abundant. January 1, 2017 Type Package Package abundant January 1, 2017 Title High-Dimensional Principal Fitted Components and Abundant Regression Version 1.1 Date 2017-01-01 Author Adam J. Rothman Maintainer Adam J. Rothman

More information

Statistics 202: Data Mining. c Jonathan Taylor. Model-based clustering Based in part on slides from textbook, slides of Susan Holmes.

Statistics 202: Data Mining. c Jonathan Taylor. Model-based clustering Based in part on slides from textbook, slides of Susan Holmes. Model-based clustering Based in part on slides from textbook, slides of Susan Holmes December 2, 2012 1 / 1 Model-based clustering General approach Choose a type of mixture model (e.g. multivariate Normal)

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

UNIVERSITY of PENNSYLVANIA CIS 520: Machine Learning Final, Fall 2013

UNIVERSITY of PENNSYLVANIA CIS 520: Machine Learning Final, Fall 2013 UNIVERSITY of PENNSYLVANIA CIS 520: Machine Learning Final, Fall 2013 Exam policy: This exam allows two one-page, two-sided cheat sheets; No other materials. Time: 2 hours. Be sure to write your name and

More information

-A wild house sparrow population case study

-A wild house sparrow population case study Bayesian animal model using Integrated Nested Laplace Approximations -A wild house sparrow population case study Anna M. Holand Ingelin Steinsland Animal model workshop with application to ecology at Oulu

More information

Package netcoh. May 2, 2016

Package netcoh. May 2, 2016 Type Package Title Statistical Modeling with Network Cohesion Version 0.2 Date 2016-04-29 Author Tianxi Li, Elizaveta Levina, Ji Zhu Maintainer Tianxi Li Package netcoh May 2, 2016

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 sbgcop. May 29, 2018

Package sbgcop. May 29, 2018 Package sbgcop May 29, 2018 Title Semiparametric Bayesian Gaussian Copula Estimation and Imputation Version 0.980 Date 2018-05-25 Author Maintainer Estimation and inference for parameters

More information

Package MACAU2. R topics documented: April 8, Type Package. Title MACAU 2.0: Efficient Mixed Model Analysis of Count Data. Version 1.

Package MACAU2. R topics documented: April 8, Type Package. Title MACAU 2.0: Efficient Mixed Model Analysis of Count Data. Version 1. Package MACAU2 April 8, 2017 Type Package Title MACAU 2.0: Efficient Mixed Model Analysis of Count Data Version 1.10 Date 2017-03-31 Author Shiquan Sun, Jiaqiang Zhu, Xiang Zhou Maintainer Shiquan Sun

More information

Package MiRKATS. May 30, 2016

Package MiRKATS. May 30, 2016 Type Package Package MiRKATS May 30, 2016 Title Microbiome Regression-based Kernal Association Test for Survival (MiRKAT-S) Version 1.0 Date 2016-04-22 Author Anna Plantinga , Michael

More information

Package horseshoe. November 8, 2016

Package horseshoe. November 8, 2016 Title Implementation of the Horseshoe Prior Version 0.1.0 Package horseshoe November 8, 2016 Description Contains functions for applying the horseshoe prior to highdimensional linear regression, yielding

More information

Package clogitboost. R topics documented: December 21, 2015

Package clogitboost. R topics documented: December 21, 2015 Package December 21, 2015 Type Package Title Boosting Conditional Logit Model Version 1.1 Date 2015-12-09 Author Haolun Shi and Guosheng Yin Maintainer A set of functions to fit a boosting conditional

More information

Introduction to Machine Learning Midterm, Tues April 8

Introduction to Machine Learning Midterm, Tues April 8 Introduction to Machine Learning 10-701 Midterm, Tues April 8 [1 point] Name: Andrew ID: Instructions: You are allowed a (two-sided) sheet of notes. Exam ends at 2:45pm Take a deep breath and don t spend

More information

Package IsingFit. September 7, 2016

Package IsingFit. September 7, 2016 Type Package Package IsingFit September 7, 2016 Title Fitting Ising Models Using the ELasso Method Version 0.3.1 Date 2016-9-6 Depends R (>= 3.0.0) Imports qgraph, Matrix, glmnet Suggests IsingSampler

More information

APPENDIX A. Examples of R code

APPENDIX A. Examples of R code APPENDIX A Examples of R code In this Appendix we give examples of the R code used to perform the analyses presented in the book. We do not provide complete coverage of what we have done; only the case

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

Regularized Parameter Estimation in High-Dimensional Gaussian Mixture Models

Regularized Parameter Estimation in High-Dimensional Gaussian Mixture Models LETTER Communicated by Clifford Lam Regularized Parameter Estimation in High-Dimensional Gaussian Mixture Models Lingyan Ruan lruan@gatech.edu Ming Yuan ming.yuan@isye.gatech.edu School of Industrial and

More information

Package factorqr. R topics documented: February 19, 2015

Package factorqr. R topics documented: February 19, 2015 Package factorqr February 19, 2015 Version 0.1-4 Date 2010-09-28 Title Bayesian quantile regression factor models Author Lane Burgette , Maintainer Lane Burgette

More information

Package BNN. February 2, 2018

Package BNN. February 2, 2018 Type Package Package BNN February 2, 2018 Title Bayesian Neural Network for High-Dimensional Nonlinear Variable Selection Version 1.0.2 Date 2018-02-02 Depends R (>= 3.0.2) Imports mvtnorm Perform Bayesian

More information

Package elhmc. R topics documented: July 4, Type Package

Package elhmc. R topics documented: July 4, Type Package Package elhmc July 4, 2017 Type Package Title Sampling from a Empirical Likelihood Bayesian Posterior of Parameters Using Hamiltonian Monte Carlo Version 1.1.0 Date 2017-07-03 Author Dang Trung Kien ,

More information

Package covtest. R topics documented:

Package covtest. R topics documented: Package covtest February 19, 2015 Title Computes covariance test for adaptive linear modelling Version 1.02 Depends lars,glmnet,glmpath (>= 0.97),MASS Author Richard Lockhart, Jon Taylor, Ryan Tibshirani,

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 HIMA. November 8, 2017

Package HIMA. November 8, 2017 Type Package Title High-Dimensional Mediation Analysis Version 1.0.5 Date 2017-11-05 Package HIMA November 8, 2017 Description Allows to estimate and test high-dimensional mediation effects based on sure

More information

Package robustrao. August 14, 2017

Package robustrao. August 14, 2017 Type Package Package robustrao August 14, 2017 Title An Extended Rao-Stirling Diversity Index to Handle Missing Data Version 1.0-3 Date 2016-01-31 Author María del Carmen Calatrava Moreno [aut, cre], Thomas

More information

Package ShrinkCovMat

Package ShrinkCovMat Type Package Package ShrinkCovMat Title Shrinkage Covariance Matrix Estimators Version 1.2.0 Author July 11, 2017 Maintainer Provides nonparametric Steinian shrinkage estimators

More information

Human Mobility Pattern Prediction Algorithm using Mobile Device Location and Time Data

Human Mobility Pattern Prediction Algorithm using Mobile Device Location and Time Data Human Mobility Pattern Prediction Algorithm using Mobile Device Location and Time Data 0. Notations Myungjun Choi, Yonghyun Ro, Han Lee N = number of states in the model T = length of observation sequence

More information

Package EMVS. April 24, 2018

Package EMVS. April 24, 2018 Type Package Package EMVS April 24, 2018 Title The Expectation-Maximization Approach to Bayesian Variable Selection Version 1.0 Date 2018-04-23 Author Veronika Rockova [aut,cre], Gemma Moran [aut] Maintainer

More information

Package JointModel. R topics documented: June 9, Title Semiparametric Joint Models for Longitudinal and Counting Processes Version 1.

Package JointModel. R topics documented: June 9, Title Semiparametric Joint Models for Longitudinal and Counting Processes Version 1. Package JointModel June 9, 2016 Title Semiparametric Joint Models for Longitudinal and Counting Processes Version 1.0 Date 2016-06-01 Author Sehee Kim Maintainer Sehee Kim

More information

CPSC 540: Machine Learning

CPSC 540: Machine Learning CPSC 540: Machine Learning Multivariate Gaussians Mark Schmidt University of British Columbia Winter 2019 Last Time: Multivariate Gaussian http://personal.kenyon.edu/hartlaub/mellonproject/bivariate2.html

More information

Package TwoStepCLogit

Package TwoStepCLogit Package TwoStepCLogit March 21, 2016 Type Package Title Conditional Logistic Regression: A Two-Step Estimation Method Version 1.2.5 Date 2016-03-19 Author Radu V. Craiu, Thierry Duchesne, Daniel Fortin

More information

Mixtures of Gaussians with Sparse Structure

Mixtures of Gaussians with Sparse Structure Mixtures of Gaussians with Sparse Structure Costas Boulis 1 Abstract When fitting a mixture of Gaussians to training data there are usually two choices for the type of Gaussians used. Either diagonal or

More information

Pattern Recognition and Machine Learning

Pattern Recognition and Machine Learning Christopher M. Bishop Pattern Recognition and Machine Learning ÖSpri inger Contents Preface Mathematical notation Contents vii xi xiii 1 Introduction 1 1.1 Example: Polynomial Curve Fitting 4 1.2 Probability

More information

The evdbayes Package

The evdbayes Package The evdbayes Package April 19, 2006 Version 1.0-5 Date 2006-18-04 Title Bayesian Analysis in Extreme Theory Author Alec Stephenson and Mathieu Ribatet. Maintainer Mathieu Ribatet

More information

Machine Learning and Bayesian Inference. Unsupervised learning. Can we find regularity in data without the aid of labels?

Machine Learning and Bayesian Inference. Unsupervised learning. Can we find regularity in data without the aid of labels? Machine Learning and Bayesian Inference Dr Sean Holden Computer Laboratory, Room FC6 Telephone extension 6372 Email: sbh11@cl.cam.ac.uk www.cl.cam.ac.uk/ sbh11/ Unsupervised learning Can we find regularity

More information

Package EstACEwErrorinX

Package EstACEwErrorinX Package EstACEwErrorin November 24, 2014 Tpe Package Title Average Causal Effect (ACE) Estimation with Covariate Measurement Error Version 1.1 Date 2014-11-15 Author Andrew M. Raim, iaou Dong, Yi Huang

More information

Package metafuse. October 17, 2016

Package metafuse. October 17, 2016 Package metafuse October 17, 2016 Type Package Title Fused Lasso Approach in Regression Coefficient Clustering Version 2.0-1 Date 2016-10-16 Author Lu Tang, Ling Zhou, Peter X.K. Song Maintainer Lu Tang

More information

The lmm Package. May 9, Description Some improved procedures for linear mixed models

The lmm Package. May 9, Description Some improved procedures for linear mixed models The lmm Package May 9, 2005 Version 0.3-4 Date 2005-5-9 Title Linear mixed models Author Original by Joseph L. Schafer . Maintainer Jing hua Zhao Description Some improved

More information

Package lmm. R topics documented: March 19, Version 0.4. Date Title Linear mixed models. Author Joseph L. Schafer

Package lmm. R topics documented: March 19, Version 0.4. Date Title Linear mixed models. Author Joseph L. Schafer Package lmm March 19, 2012 Version 0.4 Date 2012-3-19 Title Linear mixed models Author Joseph L. Schafer Maintainer Jing hua Zhao Depends R (>= 2.0.0) Description Some

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

Package BayesNI. February 19, 2015

Package BayesNI. February 19, 2015 Package BayesNI February 19, 2015 Type Package Title BayesNI: Bayesian Testing Procedure for Noninferiority with Binary Endpoints Version 0.1 Date 2011-11-11 Author Sujit K Ghosh, Muhtarjan Osman Maintainer

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 LBLGXE. R topics documented: July 20, Type Package

Package LBLGXE. R topics documented: July 20, Type Package Type Package Package LBLGXE July 20, 2015 Title Bayesian Lasso for detecting Rare (or Common) Haplotype Association and their interactions with Environmental Covariates Version 1.2 Date 2015-07-09 Author

More information

Package GPfit. R topics documented: April 2, Title Gaussian Processes Modeling Version Date

Package GPfit. R topics documented: April 2, Title Gaussian Processes Modeling Version Date Title Gaussian Processes Modeling Version 1.0-0 Date 2015-04-01 Package GPfit April 2, 2015 Author Blake MacDoanld, Hugh Chipman, Pritam Ranjan Maintainer Hugh Chipman Description

More information

Covariance Estimation for High Dimensional Data Vectors

Covariance Estimation for High Dimensional Data Vectors Covariance Estimation for High Dimensional Data Vectors Charles A. Bouman Purdue University School of Electrical and Computer Engineering Co-authored with: Guangzhi Cao and Leonardo R Bachega Covariance

More information

Mixtures of Gaussians with Sparse Regression Matrices. Constantinos Boulis, Jeffrey Bilmes

Mixtures of Gaussians with Sparse Regression Matrices. Constantinos Boulis, Jeffrey Bilmes Mixtures of Gaussians with Sparse Regression Matrices Constantinos Boulis, Jeffrey Bilmes {boulis,bilmes}@ee.washington.edu Dept of EE, University of Washington Seattle WA, 98195-2500 UW Electrical Engineering

More information

Mixtures and Hidden Markov Models for analyzing genomic data

Mixtures and Hidden Markov Models for analyzing genomic data Mixtures and Hidden Markov Models for analyzing genomic data Marie-Laure Martin-Magniette UMR AgroParisTech/INRA Mathématique et Informatique Appliquées, Paris UMR INRA/UEVE ERL CNRS Unité de Recherche

More information

Package effectfusion

Package effectfusion Package November 29, 2016 Title Bayesian Effect Fusion for Categorical Predictors Version 1.0 Date 2016-11-21 Author Daniela Pauger [aut, cre], Helga Wagner [aut], Gertraud Malsiner-Walli [aut] Maintainer

More information