Package ENA. February 15, 2013

Size: px
Start display at page:

Download "Package ENA. February 15, 2013"

Transcription

1 Package ENA February 15, 2013 Type Package Title Ensemble Network Aggregation Version Date Author Maintainer Depends R (>= ), space (>= 0.1), WGCNA (>= 1.20), GeneNet(>= 1.2.5), parmigene (>= 1.0) Suggests snow (>= 0.3) Ensemble network aggregation is an approach which leverages the inverse-rank-product (IRP) method to combine networks. This package provides the capabilities to use IRP to bootstrap a dataset using a single method, to aggregate the networks produced by multiple methods, or to aggregate the networks produced on different datasets. License GPL (>= 2) LazyLoad yes Collate bootstrap.r buildaracne.r buildgenenet.r buildspace.r buildwgcna.r ena.r symmetricize.r gettableaddres NeedsCompilation no Repository CRAN Date/Publication :38:22 1

2 2 adj2mat R topics documented: adj2mat bootstrap buildaracne buildgenenet buildspace buildwgcna edgecutoff ena gettableaddressing mat2adj net net net net net net simulatenetwork symmetricize tri2mat Index 16 adj2mat Convert adjacency list into an adjacency matrix. Converts an adjacency-like list (which may or may not contain all the gene IDs in the network) into an adjacency matrix. adj2mat(adjlist, IDs = sort(union(adjlist[, 1], adjlist[, 2]))) adjlist IDs the adjacency list of the matrix you re looking to simulate. There should be two-three columns for source, target, and the (optional) regulation value. If the regulation value isn t specified, it s assumed to be 1. To avoid any confusion, we require that the columns be named exactly "Source", "Target", and "Regulation", where "Regulation" represents the strength or weight of the edge in the network. The set of genes in this network. By default, the set of all genes mentioned in the adjacency matrix. IDs can be provided if there are unconnected genes in the network which aren t mentioned in the adjacency list or when the ordering of the genes is important.

3 bootstrap 3 #Load in the sample Protein-Protein-Interaction data that comes with this package. #Simulate a dataset based on the 44-gene topology provided. sim <- simulatenetwork(net44) #Convert the true, underlying adjacency list to an adjacency matrix truemat <- adj2mat(net44) bootstrap Bootstrap the reconstruction of a network Randomly selects a subset of the avaialble samples and performs a network reconstruction using the selected technique. Aggregate all produced networks into a single network using the ena method. data bootstrap(data, fun, sample.percentage = 0.7, iterations = 150, cluster, truth) The dataset to reconstruct. Each column should contain one sample, and each row should contain one gene. fun The network reconstruction technique to employ while bootstrapping. Could be one of the provided methods such as buildspace or a custom function. Provide the name of the function in quotes. sample.percentage The percentage of samples to select for each iteration. iterations cluster truth The number of bootstrapping iterations to perform i.e. the number of networks to build Optionally provide an RMPI cluster (of class MPIcluster) to distribute the workload across. The true network structure. Typically not available, but useful in testing and debugging. A data.frame representing the adjacency list of the ENA-produced network.

4 4 buildaracne #Load in the sample Protein-Protein- Interaction data that comes with this package. set.seed(123) #Simulate a dataset based on the 44-gene topology provided. sim <- simulatenetwork(net44) boot <- bootstrap(sim, "buildgenenet",.9, 10, ) bootmat <- tri2mat(rownames(sim), boot[,3]) buildaracne Reconstruct network using Aracne Reconstructs a gene regulatory network using the Aracne algorithm buildaracne(mat) mat The matrix on which to reconstruct. The matrix should store one gene per row, and one sample per column. The adjacency matrix of the genes provided. #Load in the sample PPI data provided with this package #Simulate the network based on one of the adjacency lists just loaded. net <- simulatenetwork(net44) #Reconstruct the network using GeneNet, then grab the upper traingular portion # of the matrix ar <- abs(buildaracne(net)) ar <- ar[upper.tri(ar)]

5 buildgenenet 5 buildgenenet Reconstruct network using GeneNet Reconstructs a gene regulatory network using the GeneNet algorithm buildgenenet(data) data The matrix on which to reconstruct. The matrix should store one gene per row, and one sample per column. The adjacency matrix of the genes provided. #Load in the sample PPI data provided with this package #Simulate the network based on one of the adjacency lists just loaded. net <- simulatenetwork(net44) #Reconstruct the network using GeneNet, then grab the upper traingular portion # of the matrix gn <- abs(buildgenenet(net)) gn <- gn[upper.tri(gn)] buildspace Reconstruct network using SPACE Reconstructs a gene regulatory network using the SPACE algorithm buildspace(data)

6 6 buildwgcna data The matrix on which to reconstruct. The matrix should store one gene per row, and one sample per column. The adjacency matrix of the genes provided. #Load in the sample PPI data provided with this package #Simulate the network based on one of the adjacency lists just loaded. net <- simulatenetwork(net44) #Process with SPACE sp <- abs(buildspace(net)) sp <- sp[upper.tri(sp)] buildwgcna Reconstruct network using WGCNA Reconstructs a gene regulatory network using the WGCNA algorithm buildwgcna(mat) mat The matrix on which to reconstruct. The matrix should store one gene per row, and one sample per column. Note that this is the transpose of how WGCNA typically accepts their matrix. The adjacency matrix of the genes provided.

7 edgecutoff 7 #Load in the sample PPI data provided with this package #Simulate the network based on one of the adjacency lists just loaded. net <- simulatenetwork(net44) #Process with WGCNA wg <- abs(buildwgcna(net)) edgecutoff Compute a binary network from a continuous rank-product network. Compute a binary network from a continuous rank-product network. edgecutoff(rp, nnets, pfp = 0.05, nperm = 100) rp nnets pfp nperm The rank product of the network you wish to binarize. This can either be the adjacency matrix of the network, or just the upper triangle of that network, as could be computed by the ena function. The number of networks used to compute the given rank product The percentage of false positives to use as a cutoff The number of permutations to run when calculating the pfps of the network. The binarized network in which only edges surpassing the specified significance level are maintained. If rp was provided as a named matrix, the results will also be a matrix. If rp was a vector of the upper triangle, the result will also be a vector of the upper triangle. Note that an upper triangle can be converted back to an adjacency matrix using tri2mat. #Load in the sample PPI data provided with this package #Simulate the network based on one of the adjacency lists just loaded. net <- simulatenetwork(net44) #Reconstruct the network using GeneNet, then grab the upper traingular portion # of the matrix

8 8 ena gn <- abs(buildgenenet(net)) gn <- gn[upper.tri(gn)] #Process with WGCNA wg <- abs(buildwgcna(net)) wg <- wg[upper.tri(wg)] #Process with SPACE sp <- abs(buildspace(net)) sp <- sp[upper.tri(sp)] #Aggregate methods using ENA ena <- ena(cbind(gn, wg, sp)) #Convert from a triangular vector to a full matrix. enamat <- tri2mat(rownames(net), ena) #Extract only those edges in the graph which pass the cutoff binarized <- edgecutoff(enamat, 3) ena Perform ensemble network aggregation Manipulates adjacency-list-formatted networks into a single adjacency list ena(adjacencylist, method = c("rankprod")) adjacencylist method A data.frame in which each column represents the connection weights of a network. Each row represents a possible connection within the network. Currently only support (Inverse) Rank Product, specified by "RankProd" A single adjacency list representing the Inverse Rank Product of all connections in the provided networks.

9 gettableaddressing 9 #Load in the sample PPI data provided with this package #Simulate the network based on one of the adjacency lists just loaded. net <- simulatenetwork(net44) #Reconstruct the network using GeneNet, then grab the upper traingular portion # of the matrix gn <- abs(buildgenenet(net)) gn <- gn[upper.tri(gn)] #Process with WGCNA wg <- abs(buildwgcna(net)) wg <- wg[upper.tri(wg)] #Process with SPACE sp <- abs(buildspace(net)) sp <- sp[upper.tri(sp)] #Aggregate methods using ENA ena <- ena(cbind(gn, wg, sp)) #Convert from a triangular vector to a full matrix. enamat <- tri2mat(rownames(net), ena) gettableaddressing Get the adjacency list addressing template. Useful if you want to store the networks in their condensed upper-diagonal form while still having the benefit of convenient addressing and/or if you are using a simulated dataset in which you know the truth and want to store all the values in a single data.frame. gettableaddressing(variablenames, truth) variablenames truth the names of all genes to include in the adjacency list The true adjacency matrix. Often will not be available, but is useful for debugging and testing. Details Internal function used to get the addressing template for a data.frame to contain the adjacency list representation of a matrix.

10 10 mat2adj A data.frame representing the adjacency list of the matrix provided. #Load in the sample Protein-Protein-Interaction data that comes with this package. #Simulate a dataset based on the 44-gene topology provided. sim <- simulatenetwork(net44) #Convert the true, underlying adjacency list to an adjacency matrix truemat <- adj2mat(net44) #Reconstruct using GeneNet gn <- abs(buildgenenet(sim)) gn <- gn[upper.tri(gn)] wg <- abs(buildwgcna(sim)) wg <- wg[upper.tri(wg)] #Aggregate all results into a single data.frame data <- gettableaddressing(rownames(sim), truemat) data <- cbind(data, gn, wg) mat2adj Convert a matrix to an adjacency list Takes a matrix and converts all non-zero elements to an adjacency list using the row/colnames as the names for this list. Currently, the matrix must be symmetric. mat2adj(adjmat) adjmat The symmetric adjacency matrix with rows and columns named.

11 net mat <- matrix(c(1,4,0,4,1,2,0,2,1), ncol=3) rownames(mat) <- colnames(mat) <- letters[1:3] mat2adj(mat) net1345 Sample network topology using 1345 genes with interactions based on observed protein-protein interaction networks. Sample network topology using 1345 genes with interactions based on observed protein-protein interaction networks. Guanghua Xiao net17 Sample network topology using 17 genes with interactions based on observed protein-protein interaction networks. Sample network topology using 17 genes with interactions based on observed protein-protein interaction networks. Guanghua Xiao net231 Sample network topology using 231 genes with interactions based on observed protein-protein interaction networks. Sample network topology using 231 genes with interactions based on observed protein-protein interaction networks. Guanghua Xiao

12 12 net83 net44 Sample network topology using 44 genes with interactions based on observed protein-protein interaction networks. Sample network topology using 44 genes with interactions based on observed protein-protein interaction networks. Guanghua Xiao net613 Sample network topology using 613 genes with interactions based on observed protein-protein interaction networks. Sample network topology using 613 genes with interactions based on observed protein-protein interaction networks. Guanghua Xiao net83 Sample network topology using 83 genes with interactions based on observed protein-protein interaction networks. Sample network topology using 83 genes with interactions based on observed protein-protein interaction networks. Guanghua Xiao

13 simulatenetwork 13 simulatenetwork Simulate a gene expression dataset. Simulates the observed gene expression levels in a dataset using the underlying truth network provided, allowing cusomtization of the number of samples and the noise levels in the dataset. simulatenetwork(adjlist, genes = sort(union(adjlist[, 1], adjlist[, 2])), samples = 100, noise = 1) adjlist genes samples noise the adjacency list of the matrix you re looking to simulate. The first column should be the source and the second column the target. To avoid any confusion, we require that the columns be named exactly "Source" and "Target". The list of all genes in the network. By default this is any gene mentioned in the adjacency list. The number of samples you wish to simulate the amount of noise present in the simulated expression levels. Guanghua Xiao <Guanghua.Xiao@UTSouthwestern.edu> #Load in the sample PPI data provided with this package #Simulate the network based on one of the adjacency lists just loaded. net <- simulatenetwork(net44) symmetricize Make a matrix symmetric Make the matrix symmetric by making all "mirrored" positions consistent. A variety of methods are provided to make the matrix symmetrical.

14 14 symmetricize symmetricize(matrix, method = c("max", "min", "avg", "ld", "ud"), adjacencylist = FALSE) matrix method The matrix to make symmatric The method to use to make the matrix symmetric. Default is to take the maximum. "max" For each position, m i,j, use the maxiumum of (m i,j, m j,i ) "min" For each position, m i,j, use the minimum of (m i,j, m j,i ) "avg" For each position, m i,j, use the mean: (m i,j + m j,i )/2 "ld" Copy the lower triangular portion of the matrix to the upper triangular portion. "ud" Copy the upper triangular portion of the matrix to the lower triangular portion. adjacencylist Logical. If false, returns the symmetric matrix (the same format as the input). If true, returns an adjacency list representing the upper triangular portion of the adjacency matrix with addressing based on the row.names of the matrix provided. The symmetric matrix #Create a sample 3x3 matrix mat <- matrix(1:9, ncol=3) #Copy the upper diagonal portion to the lower symmetricize(mat, "ud") #Take the average of each symmetric location symmetricize(mat, "avg")

15 tri2mat 15 tri2mat Convert triangular elements to full matrix. Converts the upper or lower-triangular portion of a matrix back to the complete 2D matrix using the gene names provided. The matrix is assumed to be symmetrical. tri2mat(genes, tri, diag = 1, upper = TRUE) genes tri diag upper The names of the genes to use as row and column names. Note that these must be in the original order as was used when the traingular portion was extracted from the matrix. Otherwise, the matrix will not be constructed correctly. The triangular elements of the matrix. Could be extracted using a command like mat[upper.tri(mat)] The value to use for the diagonal elements in the matrix. TRUE if tri represents the upper triangular portion of a matrix, FALSE if the lower. upper.tri and lower.tri extract the elements in a different order. the complete 2D matrix represented by the traingular portion provided. #Load in the sample PPI data provided with this package #Simulate the network based on one of the adjacency lists just loaded. net <- simulatenetwork(net44) #Reconstruct the network using GeneNet, then grab the upper traingular portion # of the matrix gn <- abs(buildgenenet(net)) gn <- gn[upper.tri(gn)] #Convert from a triangular vector to a full matrix. gnmat <- tri2mat(rownames(net), gn)

16 Index Topic datasets net1345, 11 net17, 11 net231, 11 net44, 12 net613, 12 net83, 12 adj2mat, 2 bootstrap, 3 buildaracne, 4 buildgenenet, 5 buildspace, 5 buildwgcna, 6 edgecutoff, 7 ena, 7, 8 gettableaddressing, 9 lower.tri, 15 mat2adj, 10 net1345, 11 net17, 11 net231, 11 net44, 12 net613, 12 net83, 12 simulatenetwork, 13 symmetricize, 13 tri2mat, 7, 15 upper.tri, 15 16

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

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

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 geigen. August 22, 2017

Package geigen. August 22, 2017 Version 2.1 Package geigen ugust 22, 2017 Title Calculate Generalized Eigenvalues, the Generalized Schur Decomposition and the Generalized Singular Value Decomposition of a Matrix Pair with Lapack Date

More information

Package noise. July 29, 2016

Package noise. July 29, 2016 Type Package Package noise July 29, 2016 Title Estimation of Intrinsic and Extrinsic Noise from Single-Cell Data Version 1.0 Date 2016-07-28 Author Audrey Qiuyan Fu and Lior Pachter Maintainer Audrey Q.

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 SEMModComp. R topics documented: February 19, Type Package Title Model Comparisons for SEM Version 1.0 Date Author Roy Levy

Package SEMModComp. R topics documented: February 19, Type Package Title Model Comparisons for SEM Version 1.0 Date Author Roy Levy Type Package Title Model Comparisons for SEM Version 1.0 Date 2009-02-23 Author Roy Levy Package SEMModComp Maintainer Roy Levy February 19, 2015 Conduct tests of difference in fit for

More information

Package MultisiteMediation

Package MultisiteMediation Version 0.0.1 Date 2017-02-25 Package MultisiteMediation February 26, 2017 Title Causal Mediation Analysis in Multisite Trials Author Xu Qin, Guanglei Hong Maintainer Xu Qin Depends

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 RI2by2. October 21, 2016

Package RI2by2. October 21, 2016 Package RI2by2 October 21, 2016 Type Package Title Randomization Inference for Treatment Effects on a Binary Outcome Version 1.3 Author Joseph Rigdon, Wen Wei Loh, Michael G. Hudgens Maintainer Wen Wei

More information

Package bmem. February 15, 2013

Package bmem. February 15, 2013 Package bmem February 15, 2013 Type Package Title Mediation analysis with missing data using bootstrap Version 1.3 Date 2011-01-04 Author Maintainer Zhiyong Zhang Depends R (>= 1.7),

More information

Package gtheory. October 30, 2016

Package gtheory. October 30, 2016 Package gtheory October 30, 2016 Version 0.1.2 Date 2016-10-22 Title Apply Generalizability Theory with R Depends lme4 Estimates variance components, generalizability coefficients, universe scores, and

More information

Package unbalhaar. February 20, 2015

Package unbalhaar. February 20, 2015 Type Package Package unbalhaar February 20, 2015 Title Function estimation via Unbalanced Haar wavelets Version 2.0 Date 2010-08-09 Author Maintainer The package implements top-down

More information

Package OrdNor. February 28, 2019

Package OrdNor. February 28, 2019 Type Package Package OrdNor February 28, 2019 Title Concurrent Generation of Ordinal and Normal Data with Given Correlation Matrix and Marginal Distributions Version 2.2 Date 2019-02-24 Author Anup Amatya,

More information

Package CPE. R topics documented: February 19, 2015

Package CPE. R topics documented: February 19, 2015 Package CPE February 19, 2015 Title Concordance Probability Estimates in Survival Analysis Version 1.4.4 Depends R (>= 2.10.0),survival,rms Author Qianxing Mo, Mithat Gonen and Glenn Heller Maintainer

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 Rarity. December 23, 2016

Package Rarity. December 23, 2016 Type Package Package Rarity December 23, 2016 Title Calculation of Rarity Indices for Species and Assemblages of Species Version 1.3-6 Date 2016-12-23 Author Boris Leroy Maintainer Boris Leroy

More information

Package CMC. R topics documented: February 19, 2015

Package CMC. R topics documented: February 19, 2015 Type Package Title Cronbach-Mesbah Curve Version 1.0 Date 2010-03-13 Author Michela Cameletti and Valeria Caviezel Package CMC February 19, 2015 Maintainer Michela Cameletti

More information

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 dhga. September 6, 2016

Package dhga. September 6, 2016 Type Package Title Differential Hub Gene Analysis Version 0.1 Date 2016-08-31 Package dhga September 6, 2016 Author Samarendra Das and Baidya Nath Mandal

More information

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

Package mmm. R topics documented: February 20, Type Package Package mmm February 20, 2015 Type Package Title an R package for analyzing multivariate longitudinal data with multivariate marginal models Version 1.4 Date 2014-01-01 Author Ozgur Asar, Ozlem Ilk Depends

More information

Package GeneExpressionSignature

Package GeneExpressionSignature Package GeneExpressionSignature September 6, 2018 Title Gene Expression Signature based Similarity Metric Version 1.26.0 Date 2012-10-24 Author Yang Cao Maintainer Yang Cao , Fei

More information

Package mirlastic. November 12, 2015

Package mirlastic. November 12, 2015 Type Package Title mirlastic Version 1.0 Date 2012-03-27 Author Steffen Sass, Nikola Mueller Package mirlastic November 12, 2015 Maintainer Steffen Sass mirlastic is

More information

Package funrar. March 5, 2018

Package funrar. March 5, 2018 Title Functional Rarity Indices Computation Version 1.2.2 Package funrar March 5, 2018 Computes functional rarity indices as proposed by Violle et al. (2017) . Various indices

More information

Package monmlp. R topics documented: December 5, Type Package

Package monmlp. R topics documented: December 5, Type Package Type Package Package monmlp December 5, 2017 Title Multi-Layer Perceptron Neural Network with Optional Monotonicity Constraints Version 1.1.5 Author Ale J. Cannon Maintainer Ale J. Cannon

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 gwqs. R topics documented: May 7, Type Package. Title Generalized Weighted Quantile Sum Regression. Version 1.1.0

Package gwqs. R topics documented: May 7, Type Package. Title Generalized Weighted Quantile Sum Regression. Version 1.1.0 Package gwqs May 7, 2018 Type Package Title Generalized Weighted Quantile Sum Regression Version 1.1.0 Author Stefano Renzetti, Paul Curtin, Allan C Just, Ghalib Bello, Chris Gennings Maintainer Stefano

More information

Package R1magic. April 9, 2013

Package R1magic. April 9, 2013 Package R1magic April 9, 2013 Type Package Title Compressive Sampling: Sparse signal recovery utilities Version 0.2 Date 2013-04-09 Author Maintainer Depends stats, utils Provides

More information

Package Perc. R topics documented: December 5, Type Package

Package Perc. R topics documented: December 5, Type Package Type Package Package Perc December 5, 2016 Title Using Percolation and Conductance to Find Information Flow Certainty in a Direct Network Version 0.1.2 Date 2016-05-04 To find the certainty of dominance

More information

Package RootsExtremaInflections

Package RootsExtremaInflections Type Package Package RootsExtremaInflections May 10, 2017 Title Finds Roots, Extrema and Inflection Points of a Curve Version 1.1 Date 2017-05-10 Author Demetris T. Christopoulos Maintainer Demetris T.

More information

Package ChIPtest. July 20, 2016

Package ChIPtest. July 20, 2016 Type Package Package ChIPtest July 20, 2016 Title Nonparametric Methods for Identifying Differential Enrichment Regions with ChIP-Seq Data Version 1.0 Date 2017-07-07 Author Vicky Qian Wu ; Kyoung-Jae

More information

Package locfdr. July 15, Index 5

Package locfdr. July 15, Index 5 Version 1.1-8 Title Computes Local False Discovery Rates Package locfdr July 15, 2015 Maintainer Balasubramanian Narasimhan License GPL-2 Imports stats, splines, graphics Computation

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 Tcomp. June 6, 2018

Package Tcomp. June 6, 2018 Package Tcomp June 6, 2018 Title Data from the 2010 Tourism Forecasting Competition Version 1.0.1 The 1311 time series from the tourism forecasting competition conducted in 2010 and described in Athanasopoulos

More information

Package RTransferEntropy

Package RTransferEntropy Type Package Package RTransferEntropy March 12, 2019 Title Measuring Information Flow Between Time Series with Shannon and Renyi Transfer Entropy Version 0.2.8 Measuring information flow between time series

More information

Package RcppSMC. March 18, 2018

Package RcppSMC. March 18, 2018 Type Package Title Rcpp Bindings for Sequential Monte Carlo Version 0.2.1 Date 2018-03-18 Package RcppSMC March 18, 2018 Author Dirk Eddelbuettel, Adam M. Johansen and Leah F. South Maintainer Dirk Eddelbuettel

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

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

Package sindyr. September 10, 2018

Package sindyr. September 10, 2018 Type Package Title Sparse Identification of Nonlinear Dynamics Version 0.2.1 Date 2018-09-10 Author Maintainer Rick Dale Package sindyr September 10, 2018 This implements the Brunton

More information

Package polypoly. R topics documented: May 27, 2017

Package polypoly. R topics documented: May 27, 2017 Package polypoly May 27, 2017 Title Helper Functions for Orthogonal Polynomials Version 0.0.2 Tools for reshaping, plotting, and manipulating matrices of orthogonal polynomials. Depends R (>= 3.3.3) License

More information

Package magma. February 15, 2013

Package magma. February 15, 2013 Package magma February 15, 2013 Title Matrix Algebra on GPU and Multicore Architectures Version 0.2.2-1 Date 2010-08-27 Author Brian J Smith Maintainer Brian J Smith

More information

Package idmtpreg. February 27, 2018

Package idmtpreg. February 27, 2018 Type Package Package idmtpreg February 27, 2018 Title Regression Model for Progressive Illness Death Data Version 1.1 Date 2018-02-23 Author Leyla Azarang and Manuel Oviedo de la Fuente Maintainer Leyla

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

Package hierdiversity

Package hierdiversity Version 0.1 Date 2015-03-11 Package hierdiversity March 20, 2015 Title Hierarchical Multiplicative Partitioning of Complex Phenotypes Author Zachary Marion, James Fordyce, and Benjamin Fitzpatrick 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

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 rela. R topics documented: February 20, Version 4.1 Date Title Item Analysis Package with Standard Errors

Package rela. R topics documented: February 20, Version 4.1 Date Title Item Analysis Package with Standard Errors Version 4.1 Date 2009-10-25 Title Item Analysis Package with Standard Errors Package rela February 20, 2015 Author Michael Chajewski Maintainer Michael Chajewski

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

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

Package denseflmm. R topics documented: March 17, 2017

Package denseflmm. R topics documented: March 17, 2017 Package denseflmm March 17, 2017 Type Package Title Functional Linear Mixed Models for Densely Sampled Data Version 0.1.0 Author Sonja Greven, Jona Cederbaum Maintainer Jona Cederbaum

More information

Package beam. May 3, 2018

Package beam. May 3, 2018 Type Package Package beam May 3, 2018 Title Fast Bayesian Inference in Large Gaussian Graphical Models Version 1.0.2 Date 2018-05-03 Author Gwenael G.R. Leday [cre, aut], Ilaria Speranza [aut], Harry Gray

More information

Package LOST. April 20, 2017

Package LOST. April 20, 2017 Version 1.3 Date 2017-04-19 Package LOST April 20, 2017 Title Missing Morphometric Data Simulation and Estimation Author J. Arbour, C. Brown Maintainer J. Arbour Imports gdata, shapes,

More information

Package LIStest. February 19, 2015

Package LIStest. February 19, 2015 Type Package Package LIStest February 19, 2015 Title Tests of independence based on the Longest Increasing Subsequence Version 2.1 Date 2014-03-12 Author J. E. Garcia and V. A. Gonzalez-Lopez Maintainer

More information

Package ESPRESSO. August 29, 2013

Package ESPRESSO. August 29, 2013 Package ESPRESSO August 29, 2013 Type Package Title Power Analysis and Sample Size Calculation Version 1.1 Date 2011-04-01 Author Amadou Gaye, Paul Burton Maintainer Amadou Gaye The package

More information

Package NlinTS. September 10, 2018

Package NlinTS. September 10, 2018 Type Package Title Non Linear Time Series Analysis Version 1.3.5 Date 2018-09-05 Package NlinTS September 10, 2018 Maintainer Youssef Hmamouche Models for time series forecasting

More information

Package R1magic. August 29, 2016

Package R1magic. August 29, 2016 Type Package Package R1magic August 29, 2016 Title Compressive Sampling: Sparse Signal Recovery Utilities Version 0.3.2 Date 2015-04-19 Maintainer Depends stats, utils Utilities

More information

Package velociraptr. February 15, 2017

Package velociraptr. February 15, 2017 Type Package Title Fossil Analysis Version 1.0 Author Package velociraptr February 15, 2017 Maintainer Andrew A Zaffos Functions for downloading, reshaping, culling, cleaning, and analyzing

More information

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

Package symmoments. R topics documented: February 20, Type Package Type Package Package symmoments February 20, 2015 Title Symbolic central and noncentral moments of the multivariate normal distribution Version 1.2 Date 2014-05-21 Author Kem Phillips Depends mvtnorm,

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 aspi. R topics documented: September 20, 2016

Package aspi. R topics documented: September 20, 2016 Type Package Title Analysis of Symmetry of Parasitic Infections Version 0.2.0 Date 2016-09-18 Author Matt Wayland Maintainer Matt Wayland Package aspi September 20, 2016 Tools for the

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 crossdes. February 19, 2015

Package crossdes. February 19, 2015 Date 2013-03-18 Title Construction of Crossover Designs Version 1.1-1 Author Martin Depends AlgDesign, gtools Package crossdes February 19, 2015 Contains functions for the construction of carryover balanced

More information

Package IUPS. February 19, 2015

Package IUPS. February 19, 2015 Package IUPS February 19, 2015 Type Package Title Incorporating Uncertainties in Propensity Scores Version 1.0 Date 2013-6-5 Author Weihua An, Huizi Xu, and Zhida Zheng, Indiana University Bloomington

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

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 SCEPtERbinary

Package SCEPtERbinary Package SCEPtERbinary February 19, 2015 Title Stellar CharactEristics Pisa Estimation grid for Binary Systems Version 0.1-1 Date 2014-04-12 SCEPtER pipeline for estimating the stellar age for double-lined

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 SPreFuGED. July 29, 2016

Package SPreFuGED. July 29, 2016 Type Package Package SPreFuGED July 29, 2016 Title Selecting a Predictive Function for a Given Gene Expression Data Version 1.0 Date 2016-07-27 Author Victor L Jong, Kit CB Roes & Marinus JC Eijkemans

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 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 weightquant. R topics documented: December 30, Type Package

Package weightquant. R topics documented: December 30, Type Package Type Package Package weightquant December 30, 2018 Title Weights for Incomplete Longitudinal Data and Quantile Regression Version 1.0 Date 2018-12-18 Author Viviane Philipps Maintainer Viviane Philipps

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

Package spthin. February 20, 2015

Package spthin. February 20, 2015 Type Package Package spthin February 20, 2015 Title Functions for Spatial Thinning of Species Occurrence Records for Use in Ecological Models Version 0.1.0 Date 2014-11-16 Author Matthew E. Aiello-Lammens,

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

Statistical Programming with R

Statistical Programming with R Statistical Programming with R Lecture 3: Matrices Bisher M. Iqelan biqelan@iugaza.edu.ps Department of Mathematics, Faculty of Science, The Islamic University of Gaza 2017-2018, Semester 1 Matrices A

More information

Package sgr. February 20, 2015

Package sgr. February 20, 2015 Type Package Title Sample Generation by Replacement Version 1.3 Date 2014-11-30 Author Massimiliano Pastore & Luigi Lombardi Depends MASS Suggests polycor Package sgr February 20, 2015 Maintainer Massimiliano

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 mpmcorrelogram

Package mpmcorrelogram Type Package Package mpmcorrelogram Title Multivariate Partial Mantel Correlogram Version 0.1-4 Depends vegan Date 2017-11-17 Author Marcelino de la Cruz November 17, 2017 Maintainer Marcelino de la Cruz

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

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 CCP. R topics documented: December 17, Type Package. Title Significance Tests for Canonical Correlation Analysis (CCA) Version 0.

Package CCP. R topics documented: December 17, Type Package. Title Significance Tests for Canonical Correlation Analysis (CCA) Version 0. Package CCP December 17, 2009 Type Package Title Significance Tests for Canonical Correlation Analysis (CCA) Version 0.1 Date 2009-12-14 Author Uwe Menzel Maintainer Uwe Menzel to

More information

Package p2distance. February 20, 2015

Package p2distance. February 20, 2015 Package p2distance February 20, 2015 Type Package Title Welfare's Synthetic Indicator Version 1.0.1 Date 2012-05-2 Author A.J. Perez-Luque; R. Moreno; R. Perez-Perez and F.J. Bonet Maintainer R. Perez-Perez

More information

Package icmm. October 12, 2017

Package icmm. October 12, 2017 Type Package Package icmm October 12, 2017 Title Empirical Bayes Variable Selection via ICM/M Algorithm Version 1.1 Author Vitara Pungpapong [aut, cre], Min Zhang [aut], Dabao Zhang [aut] Maintainer Vitara

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 EnergyOnlineCPM

Package EnergyOnlineCPM Type Package Package EnergyOnlineCPM October 2, 2017 Title Distribution Free Multivariate Control Chart Based on Energy Test Version 1.0 Date 2017-09-30 Author Yafei Xu Maintainer Yafei Xu

More information

Package KMgene. November 22, 2017

Package KMgene. November 22, 2017 Type Package Package KMgene November 22, 2017 Title Gene-Based Association Analysis for Complex Traits Version 1.2 Author Qi Yan Maintainer Qi Yan Gene based association test between a

More information

Package AMA. October 27, 2010

Package AMA. October 27, 2010 Package AMA October 27, 2010 Type Package Title Anderson-Moore Algorithm Version 1.0.8 Depends rjava Date 2010-10-13 Author Gary Anderson, Aneesh Raghunandan Maintainer Gary Anderson

More information

Package DTK. February 15, Type Package

Package DTK. February 15, Type Package Package DTK February 15, 2013 Type Package Title Dunnett-Tukey-Kramer Pairwise Multiple Comparison Test Adjusted for Unequal Variances and Unequal Sample Sizes Version 3.1 Date 2011-03-17 Author Matthew

More information

Package plspolychaos

Package plspolychaos Version 1.1-1 Date 2017-03-01 Package plspolychaos June 9, 2018 Title Sensitivity Indexes from Polynomial Chaos Expansions and PLS Author A. Bouvier [aut], J.-P. Gauchi [cre], A. Bensadoun [ctb] Maintainer

More information

Package HDtest. R topics documented: September 13, Type Package

Package HDtest. R topics documented: September 13, Type Package Type Package Package HDtest September 13, 2018 Title High Dimensional Hypothesis Testing for Mean Vectors, Covariance Matrices, and White Noise of Vector Time Series Version 2.1 Date 2018-9-10 Author Meng

More information

Package clonotyper. October 11, 2018

Package clonotyper. October 11, 2018 Type Package Package clonotyper October 11, 2018 Title High throughput analysis of T cell antigen receptor sequences Version 1.18.0 Date 2016-10-13 Author Charles Plessy Maintainer Charles

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

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 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 crrsc. R topics documented: February 19, 2015

Package crrsc. R topics documented: February 19, 2015 Package crrsc February 19, 2015 Title Competing risks regression for Stratified and Clustered data Version 1.1 Author Bingqing Zhou and Aurelien Latouche Extension of cmprsk to Stratified and Clustered

More information

Package SHIP. February 19, 2015

Package SHIP. February 19, 2015 Type Package Package SHIP February 19, 2015 Title SHrinkage covariance Incorporating Prior knowledge Version 1.0.2 Author Maintainer Vincent Guillemot The SHIP-package allows

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