Package PathwaySeq. February 3, 2015

Size: px
Start display at page:

Download "Package PathwaySeq. February 3, 2015"

Transcription

1 Package PathwaySeq February 3, 2015 Type Package Title RNA-Seq pathway analysis Version 1.0 Date Imports PearsonDS, AnnotationDbi, quad, mcc, org.hs.eg.db, GO.db,KEGG.db Author Maintainer PathwaySeq gives accurate statistical pathway analysis of RNA-Seq data. The R package has automatic annotation for human, mouse and rat. Unique features of the package include data transformations to enhance power and computation of exact permutation moments of quadratic forms, for powerful testing while preserving type I error. License GPL (>= 2) LazyLoad yes R topics documented: PathwaySeq-package bp.anno.mm bp.anno.rat cc.anno.mm cc.anno.rat center centernorm data.anno data.test gender get.maxindex getanno getanno.mm getanno.rat getmomentk getp.mixture hammer

2 2 PathwaySeq-package kegg.mm kegg.rat loss match.table.mm match.table.rat mf.anno.mm mf.anno.rat momentqprimek PathwayAnalysis test.id treatdata Index 20 PathwaySeq-package Pathway analysis for RNA-Seq data A variety of pathway/gene-set approaches have been proposed to provide evidence of higher-level biological phenomena in the association of expression with experimental condition or clinical outcome. Among these approaches, it has been repeatedly shown that permutation or bootstrapping of samples is far preferable to approaches that implicitly assume independence of genes. However, few approaches have been optimized for the specific characteristics of RNA-Seq transcription data, in which mapped tags produce discrete counts, and for which library sizes or other normalization factors may vary across samples. Our package gives flexiable transformation of the dataset. The approach uses aggregated summaries of gene-specific score statistics, with competitive comparison of genes in the pathway to those in the complement. PathwaySeq controls type I error control without actual permutation and it is powerful in comparison to competing approaches, and provides a convenient integrated approach to RNA-Seq pathway analysis. Package: PathwaySeq Type: Package Version: 1.0 Date: License: GPL (>= 2) Maintainer: <yihui_zhou@ncsu.edu>

3 bp.anno.mm 3 bp.anno.mm GO BP annotation file for Mouse The GO BP annotation file for mouse contains gene annotation built from GO full database association table download released Genes annotated to a specific GO term include all genes annotated to the term itself and all of its children terms on the GO hierarchy. data(bp.anno.mm) This file is needed to generate the pathway indicator matrix bp.anno.rat GO BP annotation file for Rat GO BP annotation file for Rat contains gene annotation built from GO full database association table download released Genes annotated to a specific GO term include all genes annotated to the term itself and all of its children terms on the GO hierarchy. data(bp.anno.rat) This file is needed to generate the pathway indicator matrix

4 4 cc.anno.rat cc.anno.mm GO CC annotation file for Mouse GO CC annotation file for mouse contains gene annotation built from GO full database association table download released Genes annotated to a specific GO term include all genes annotated to the term itself and all of its children terms on the GO hierarchy. data(cc.anno.mm) This file is needed to generate the pathway indicator matrix cc.anno.rat GO CC annotation file for rat GO CC annotation file for rat contains gene annotation built from GO full database association table download released Genes annotated to a specific GO term include all genes annotated to the term itself and all of its children terms on the GO hierarchy. data(cc.anno.rat) This file is needed to generate the pathway indicator matrix

5 center 5 center The center information of the 448 samples in the Vignette This is the covariate variable center of the toy example in the Vignette. centernorm Centering and normalization of the data matrix Implements a preprocessing step of the data analysis. Given a data matrix, initial standardization is necessary so that inner products are score statistics. centernorm(oldmatrix,y, z=null) oldmatrix y z the input data matrix clinical/experimental vector covariate vector This function row-centers and scales a data matrix, within each stratum if covariate z is provided. Value newmatrix newy Alist S2 the data matrix after centering and scaling centered clinical/experimental data if we denote the input data matrix as X, Alist is X X Score statistics

6 6 gender See Also PathwayAnalysis data.anno The annotation file example The annotation file for the toy example in the Vignette. data.test The toy example raw count data in the Vignettee This toy data contains 1000 genes and 448 samples. gender The gender information of the 448 samples in the Vignette This is the experimental variable gender of the toy example in the Vignette.

7 get.maxindex 7 get.maxindex Choose the best η1 and η2 This function helps you to choose the best transformation parameters to reach the best power, when you run the Moment Corrected Correlation (mcc) Package for RNA-Seq data analysis get.maxindex(y, yvec, covariate) Y yvec covariate Input the count data matrix Clinical/experimental variables Covariate vector, i.e. z This function provides you the transformation parameters η 1 and η 2 before you run pathway analysis. Alternatively, you can select the default values η 1 = 1 and η 2 = 1. Value numgene index.max eta.1 eta.2 newmatrix the matrix of number of significant genes we can detect using different combination of η 1 and η 2 the index of the rows and columsn when you reach the maximum number of genes the suggested η 1 value. the suggested η 2 value. the transformed data matrix \ YH Zhou and FA Wright, 2014, Hypothesis testing at the extremes: fast and robust association for high-throughput data, submitted

8 8 getanno getanno This function is designed for human data. It gets the pathway indicator matrix and annotation files. This function will provide KEGG, GOBP, GOMF, GOCC pathway indicator matrix for human, as well as the corresponding annotation files. getanno(gene.name) gene.name A vector of Ensembl IDs This function is the main functioin to get all the pathway annotation files for human data Value kegg bp mf cc kegganno bpanno mfanno ccanno indication matrix Gene vs KEGG pathway indication matrix Gene vs GOBP pathway indication matrix Gene vs GOMF pathway indication matrix Gene vs GOCC pathway KEGG name GOBP name GOMF name GOCC name See Also PathwayAnalysis

9 getanno.mm 9 getanno.mm Get gene vs pathway indicator matrix and annotation files for mouse data This function will provide KEGG, GOBP, GOMF, GOCC pathway indication matrix for mouse as well as the corresponding annotation file. getanno.mm(bp.anno.mm, mf.anno.mm, cc.anno.mm, match.table.mm, id, kegg.mm, type, number = 5) bp.anno.mm mf.anno.mm cc.anno.mm GOBP pathway annotation file for mouse GOMF pathway annotation file for mouse GOMF pathway annotation file for mouse match.table.mm Ensemble ID vs Gene symbol table id kegg.mm list of Ensemble ID KEGG annotation file for mouse number The minimum number of genes in a pathway, the default is 5 type Value The ID can be Ensembl Transcript ID transcript or Ensembl Gene ID ensemblgene or Gene Symbol genesymbol This function is the main functioin to get all the pathway annotation files for mouse data bp bpanno mf mfanno cc ccanno kegg kegganno indication matrix Gene vs GOBP pathway GOBP name indication matrix Gene vs GOMF pathway GOMF name indication matrix Gene vs GOCC pathway GOCC name indication matrix Gene vs KEGG pathway KEGG name

10 10 getanno.rat See Also PathwayAnalysis getanno.rat Get gene vs pathway indication matrix and annotation files for rat data This function will provide KEGG, GOBP, GOMF, GOCC pathway indication matrix for rat as well as the corresponding annotation file. getanno.rat(bp.anno.rat, mf.anno.rat, cc.anno.rat, match.table.rat, id, kegg.rat, type, number = 5) bp.anno.rat mf.anno.rat GOBP pathway annotation file for rat GOMF pathway annotation file for rat cc.anno.rat GOCC pathway annotation file for rat match.table.rat Ensemble ID vs Gene symbol table id kegg.rat list of Ensemble ID KEGG annotation file for rat number The minimum number of genes in a pathway, the default is 5 type Value The ID can be Ensembl Transcript ID transcript or Ensembl Gene ID ensemblgene or Gene Symbol genesymbol This function is the main functioin to get all the pathway annotation files for rat data bp bpanno mf mfanno cc ccanno kegg kegganno indication matrix Gene vs GOBP pathway GOBP name indication matrix Gene vs GOMF pathway GOMF name indication matrix Gene vs GOCC pathway GOCC name indication matrix Gene vs KEGG pathway KEGG name

11 getmomentk 11 See Also PathwayAnalysis getmomentk Get the first four moments This function outputs the exact first four permutation moments of the quadratic form statistics getmomentk(yvec, A, mycoef) yvec A mycoef experimental/clinical variable symmetric contrast matrix in quadratic form statistics these are useful coefficients which help to calculate the four exact moments this function provides you the exact four moments of the quadratic form statistics Value m1 m2 m3 m4 mean variance skewness kurtosis the first moment of the quadratic form statistics the second moment of the quadratic form statistics the third moment of the quadratic form statistics the fourth moment of the quadratic form statistics mean of test statistics variance of teststatistics skewness of test statistics kurtosis of test statistics

12 12 hammer getp.mixture further correction for the p value Provides a mixture density fit to the permutation distribtion of Q, in rare instances in which the Pearson family density fit is poor. getp.mixture(d, mymoments) D mymoments statistics first four moments from getmomentk Uses the four moments to provide an alternative (not Pearson family) density fit, when no fourmoment Pearson approximation is possible. This option is invoked only rarely, and typically for small datasets. hammer Rat data This dataset came from Hammer et al. We filtered the data to keep the number of reads in each gene larger than 15 for all the 8 samples P Hammer et al. 2010, mrna-seq with agnostic splice site discovery for nervous system transcriptomics tested in chronic pain, Genome Research, 20:

13 kegg.mm 13 kegg.mm kegg annotation file for Mouse kegg annotation file for mouse contains KEGG pathway annotations parsed from NCBI Biosystems download released on data(kegg.mm) This file is needed to generate the pathway indicator matrix kegg.rat kegg annotation file for rat kegg annotation file for rat contains KEGG pathway annotations parsed from NCBI Biosystems download released on data(kegg.rat) This file is needed to generate the pathway indicator matrix

14 14 match.table.mm loss loss function This is a loss function, used in numeric fitting for getp.mixture loss(param, target) param target parameters of the fitting distribution parameter estimation of the fitting distribution Value Returns an error loss measuring how different the proposed parameters are from the target myloss The error returned by comparing the proposed parameter to the target value See Also getp.mixture match.table.mm the mouse database which match Ensemble ID and Gene symbol Cross-references between Ensembl gene and transcript IDs release 75 to associated gene symbols were downloaded from Ensembl BioMart web portal. this table is used to look up gene symbols corresponding to Ensembl IDs and vice versa.

15 match.table.rat 15 match.table.rat the rat database which match Ensemble ID and Gene symbol Cross-references between Ensembl gene and transcript IDs release 75 to associated gene symbols were downloaded from Ensembl BioMart web portal. this table is used to lookup gene symbols corresponding to Ensembl IDs and vice versa. mf.anno.mm GO MF annotation file for Mouse The GO MF annotation file for mouse contains gene annotation built from GO full database association table download released Genes annotated to a specific GO term include all genes annotated to the term itself and all of its children terms on the GO hierarchy. data(mf.anno.mm) We need this file to generate the indicatior matrix of pathway

16 16 momentqprimek mf.anno.rat GO MF annotation file for rat GO MF annotation file for Rat contains gene annotation built from GO full database association table download released Genes annotated to a specific GO term include all genes annotated to the term itself and all of its children terms on the GO hierarchy. data(mf.anno.rat) We need this file to generate the indicator matrix of pathway momentqprimek the moments This function is designed for the case when covariate z is provided, and is assumed to have several factor levels. momentqprimek(oldmatrix, index.pathway, prestep, mycoef, z) oldmatrix index.pathway prestep mycoef z the original data matrix the indicator vector for the current pathway, i.e. is 1 for each gene belonging to the pathway, and 0 otherwise the output from function centernorm coefficents which are necessary to calculate the exact four permutation moments of a quadratic form the covariate vector

17 momentqprimek 17 this function generates the first four moments of the test statistics when the covariate vector z has several factors Value mean variance skewness kurtosis center Alist mean.sc variance.sc skewness.sc kurtosis.sc center.sc Alistsc newy the mean value of the statistics for the competitive hypothesis considering different strata the variance of the statistics for the competitive hypothesis considering different strata the new skewness for the competitive hypothesis the new kurtosis for the competitive hypothesis the center for the new quadratic form which considers the strata effect of z for the competitive hypothesis the new symmetric contrast matrix A in the quadratic form considering the factors in z the mean value of the statistics for the self-contained hypothesis considering different strata the variance of the statistics for the self-contained hypothesis considering different strata the new skewness for the self-contained hypothesis the new kurtosis for the self-contained hypothesis the center for the new quadratic form which considers the strata effect of z for the self-contained hypothesis the new symmetric contrast matrix A in the quadratic form considering the factors in z for the self-contained hypothesis the new centered clinical variable See Also PathwayAnalysis

18 18 PathwayAnalysis PathwayAnalysis The main pathway analysis function This function returns the list of significant pathways and p-values, for pathways with q-values below a threshold PathwayAnalysis(annotation,input.data,Cmatrix,pheno,mycoef,cutpoint=0.05,z=NULL) annotation all the annotation files and indication matrices from getanno input.data the original data matrix Cmatrix the gene vs pathway indication matrix pheno the clinical/experimental vector mycoef mycoef are the quadratic form coefficients from the R package quad cutpoint The threshold for FDR correction. The default is 0.05 z the covariate vector This is the main function of PathwaySeq. It performs quadratic-form pathway analysis for RNA- Seq data, with proper control of type I error, and with high power. The output contains basic annotation for the pathways and the number of assigned genes in each pathway. The proportional contribution of the most important gene in each pathway is also provided. Value competitive SelfContained Outputs the significant pathways and related information for the competitive hypothesis testing. (1) pathway ID and name; (2) the number of genes in each pathway; (3) proportional contribution of the gene with greatest contribution. Outputs the significant pathways and related information for the self-contained hypothesis testing.

19 test.id 19 test.id Ensembl Gene ID for the toy human data A vector of Gene ID treatdata Updates result for a single pathway calculate the score statistics for a single pathway treatdata(oldmatrix, index.pathway, Alist, z) oldmatrix index.pathway Alist z the input data matrix the index for each pathway X X is the output from function centernorm covariate vector This function returns the appropriate contrast matrix for the pathway Value cat_new Alistpath Alistpathsc the particular pathway we are interested in the test statistics of that pathway the test statistics of the complementary sets of that pathway

20 Index Topic PathwayAnalysis PathwayAnalysis, 18 Topic PathwaySeq PathwaySeq-package, 2 Topic centernorm centernorm, 5 Topic datasets center, 5 data.anno, 6 data.test, 6 gender, 6 hammer, 12 match.table.mm, 14 match.table.rat, 15 test.id, 19 Topic get.maxindex get.maxindex, 7 Topic getanno.mm getanno.mm, 9 Topic getanno.rat getanno.rat, 10 Topic getanno getanno, 8 Topic getmomentk getmomentk, 11 Topic getp.mixture getp.mixture, 12 Topic loss loss, 14 Topic momentqprimek momentqprimek, 16 Topic treatdata treatdata, 19 gender, 6 get.maxindex, 7 getanno, 8 getanno.mm, 9 getanno.rat, 10 getmomentk, 11 getp.mixture, 12, 14 hammer, 12 kegg.mm, 13 kegg.rat, 13 loss, 14 match.table.mm, 14 match.table.rat, 15 mf.anno.mm, 15 mf.anno.rat, 16 momentqprimek, 16 PathwayAnalysis, 6, 8, 10, 11, 17, 18 PathwaySeq (PathwaySeq-package), 2 PathwaySeq-package, 2 test.id, 19 treatdata, 19 bp.anno.mm, 3 bp.anno.rat, 3 cc.anno.mm, 4 cc.anno.rat, 4 center, 5 centernorm, 5 data.anno, 6 data.test, 6 20

safe September 23, 2010

safe September 23, 2010 safe September 23, 2010 SAFE-class Class SAFE Slots The class SAFE is the output from the function safe. It is also the input to the plotting function safeplot. local: Object of class "character" describing

More information

Package MLP. February 12, 2018

Package MLP. February 12, 2018 Package MLP February 12, 2018 Maintainer Tobias Verbeke License GPL-3 Title MLP Type Package Author Nandini Raghavan, Tobias Verbeke, An De Bondt with contributions by

More information

ROTS: Reproducibility Optimized Test Statistic

ROTS: Reproducibility Optimized Test Statistic ROTS: Reproducibility Optimized Test Statistic Fatemeh Seyednasrollah, Tomi Suomi, Laura L. Elo fatsey (at) utu.fi March 3, 2016 Contents 1 Introduction 2 2 Algorithm overview 3 3 Input data 3 4 Preprocessing

More information

Pathway Analysis using Partek Genomics Suite 6.6 and Partek Pathway

Pathway Analysis using Partek Genomics Suite 6.6 and Partek Pathway Pathway Analysis using Partek Genomics Suite 6.6 and Partek Pathway Overview Partek Pathway provides a visualization tool for pathway enrichment spreadsheets, utilizing KEGG and/or Reactome databases for

More information

Package DriverNet. R topics documented: October 4, Type Package

Package DriverNet. R topics documented: October 4, Type Package Package DriverNet October 4, 2013 Type Package Title Drivernet: uncovering somatic driver mutations modulating transcriptional networks in cancer Version 1.0.0 Date 2012-03-21 Author Maintainer Jiarui

More information

Differential Expression Analysis at PATRIC

Differential Expression Analysis at PATRIC Differential Expression Analysis at PATRIC The following step- by- step workflow is intended to help users learn how to upload their differential gene expression data to their private workspace using Expression

More information

SEEK User Manual. Introduction

SEEK User Manual. Introduction SEEK User Manual Introduction SEEK is a computational gene co-expression search engine. It utilizes a vast human gene expression compendium to deliver fast, integrative, cross-platform co-expression analyses.

More information

Lecture 5. Functional Analysis with Blast2GO Enriched functions. Kegg Pathway Analysis Functional Similarities B2G-Far. FatiGO Babelomics.

Lecture 5. Functional Analysis with Blast2GO Enriched functions. Kegg Pathway Analysis Functional Similarities B2G-Far. FatiGO Babelomics. Lecture 5 Functional Analysis with Blast2GO Enriched functions FatiGO Babelomics FatiScan Kegg Pathway Analysis Functional Similarities B2G-Far 1 Fisher's Exact Test One Gene List (A) The other list (B)

More information

Package KEGGprofile. February 10, 2018

Package KEGGprofile. February 10, 2018 Type Package Package KEGGprofile February 10, 2018 Title An annotation and visualization package for multi-types and multi-groups expression data in KEGG pathway Version 1.20.0 Date 2017-10-30 Author Shilin

More information

Long Read RNA-seq Mapper

Long Read RNA-seq Mapper UNIVERSITY OF ZAGREB FACULTY OF ELECTRICAL ENGENEERING AND COMPUTING MASTER THESIS no. 1005 Long Read RNA-seq Mapper Josip Marić Zagreb, February 2015. Table of Contents 1. Introduction... 1 2. RNA Sequencing...

More information

User s Guide. Using the R-Peridot Graphical User Interface (GUI) on Windows and GNU/Linux Systems

User s Guide. Using the R-Peridot Graphical User Interface (GUI) on Windows and GNU/Linux Systems User s Guide Using the R-Peridot Graphical User Interface (GUI) on Windows and GNU/Linux Systems Pitágoras Alves 01/06/2018 Natal-RN, Brazil Index 1. The R Environment Manager...

More information

Introduction to GE Microarray data analysis Practical Course MolBio 2012

Introduction to GE Microarray data analysis Practical Course MolBio 2012 Introduction to GE Microarray data analysis Practical Course MolBio 2012 Claudia Pommerenke Nov-2012 Transkriptomanalyselabor TAL Microarray and Deep Sequencing Core Facility Göttingen University Medical

More information

Quantification. Part I, using Excel

Quantification. Part I, using Excel Quantification In this exercise we will work with RNA-seq data from a study by Serin et al (2017). RNA-seq was performed on Arabidopsis seeds matured at standard temperature (ST, 22 C day/18 C night) or

More information

Package clusterseq. R topics documented: June 13, Type Package

Package clusterseq. R topics documented: June 13, Type Package Type Package Package clusterseq June 13, 2018 Title Clustering of high-throughput sequencing data by identifying co-expression patterns Version 1.4.0 Depends R (>= 3.0.0), methods, BiocParallel, bayseq,

More information

Package geecc. October 9, 2015

Package geecc. October 9, 2015 Type Package Package geecc October 9, 2015 Title Gene set Enrichment analysis Extended to Contingency Cubes Version 1.2.0 Date 2014-12-31 Author Markus Boenn Maintainer Markus Boenn

More information

mirnet Tutorial Starting with expression data

mirnet Tutorial Starting with expression data mirnet Tutorial Starting with expression data Computer and Browser Requirements A modern web browser with Java Script enabled Chrome, Safari, Firefox, and Internet Explorer 9+ For best performance and

More information

Advanced RNA-Seq 1.5. User manual for. Windows, Mac OS X and Linux. November 2, 2016 This software is for research purposes only.

Advanced RNA-Seq 1.5. User manual for. Windows, Mac OS X and Linux. November 2, 2016 This software is for research purposes only. User manual for Advanced RNA-Seq 1.5 Windows, Mac OS X and Linux November 2, 2016 This software is for research purposes only. QIAGEN Aarhus Silkeborgvej 2 Prismet DK-8000 Aarhus C Denmark Contents 1 Introduction

More information

Package GCAI.bias. February 19, 2015

Package GCAI.bias. February 19, 2015 Type Package Package GCAI.bias February 19, 2015 Title Guided Correction Approach for Inherited bias (GCAI.bias) Version 1.0 Date 2014-07-14 Author Guoshuai Cai Maintainer Guoshuai Cai

More information

Wilson Leung 05/27/2008 A Simple Introduction to NCBI BLAST

Wilson Leung 05/27/2008 A Simple Introduction to NCBI BLAST A Simple Introduction to NCBI BLAST Prerequisites: Detecting and Interpreting Genetic Homology: Lecture Notes on Alignment Resources: The BLAST web server is available at http://www.ncbi.nih.gov/blast/

More information

Step-by-Step Guide to Advanced Genetic Analysis

Step-by-Step Guide to Advanced Genetic Analysis Step-by-Step Guide to Advanced Genetic Analysis Page 1 Introduction In the previous document, 1 we covered the standard genetic analyses available in JMP Genomics. Here, we cover the more advanced options

More information

Package SCAN.UPC. July 17, 2018

Package SCAN.UPC. July 17, 2018 Type Package Package SCAN.UPC July 17, 2018 Title Single-channel array normalization (SCAN) and Universal expression Codes (UPC) Version 2.22.0 Author and Andrea H. Bild and W. Evan Johnson Maintainer

More information

ChIPXpress: enhanced ChIP-seq and ChIP-chip target gene identification using publicly available gene expression data

ChIPXpress: enhanced ChIP-seq and ChIP-chip target gene identification using publicly available gene expression data ChIPXpress: enhanced ChIP-seq and ChIP-chip target gene identification using publicly available gene expression data George Wu, Hongkai Ji December 22, 2017 1 Introduction ChIPx (i.e., ChIP-seq and ChIP-chip)

More information

Package ChIPXpress. October 4, 2013

Package ChIPXpress. October 4, 2013 Package ChIPXpress October 4, 2013 Type Package Title ChIPXpress: enhanced transcription factor target gene identification from ChIP-seq and ChIP-chip data using publicly available gene expression profiles

More information

Package ssizerna. January 9, 2017

Package ssizerna. January 9, 2017 Type Package Package ssizerna January 9, 2017 Title Sample Size Calculation for RNA-Seq Experimental Design Version 1.2.9 Date 2017-01-05 Maintainer Ran Bi We propose a procedure for

More information

ygs98.db December 22,

ygs98.db December 22, ygs98.db December 22, 2018 ygs98alias Map Open Reading Frame (ORF) Identifiers to Alias Gene Names A set of gene names may have been used to report yeast genes represented by ORF identifiers. One of these

More information

Package geecc. R topics documented: December 7, Type Package

Package geecc. R topics documented: December 7, Type Package Type Package Package geecc December 7, 2018 Title Gene Set Enrichment Analysis Extended to Contingency Cubes Version 1.16.0 Date 2016-09-19 Author Markus Boenn Maintainer Markus Boenn

More information

Package sigqc. June 13, 2018

Package sigqc. June 13, 2018 Title Quality Control Metrics for Gene Signatures Version 0.1.20 Package sigqc June 13, 2018 Description Provides gene signature quality control metrics in publication ready plots. Namely, enables the

More information

Tutorial: Jump Start on the Human Epigenome Browser at Washington University

Tutorial: Jump Start on the Human Epigenome Browser at Washington University Tutorial: Jump Start on the Human Epigenome Browser at Washington University This brief tutorial aims to introduce some of the basic features of the Human Epigenome Browser, allowing users to navigate

More information

Package pcagopromoter

Package pcagopromoter Version 1.26.0 Date 2012-03-16 Package pcagopromoter November 13, 2018 Title pcagopromoter is used to analyze DNA micro array data Author Morten Hansen, Jorgen Olsen Maintainer Morten Hansen

More information

Tutorial: RNA-Seq Analysis Part II (Tracks): Non-Specific Matches, Mapping Modes and Expression measures

Tutorial: RNA-Seq Analysis Part II (Tracks): Non-Specific Matches, Mapping Modes and Expression measures : RNA-Seq Analysis Part II (Tracks): Non-Specific Matches, Mapping Modes and February 24, 2014 Sample to Insight : RNA-Seq Analysis Part II (Tracks): Non-Specific Matches, Mapping Modes and : RNA-Seq Analysis

More information

Package GOFunction. April 13, 2019

Package GOFunction. April 13, 2019 Type Package Package GOFunction April 13, 2019 Title GO-function: deriving biologcially relevant functions from statistically significant functions Version 1.30.0 Date 2013-10-03 Author

More information

CLC Server. End User USER MANUAL

CLC Server. End User USER MANUAL CLC Server End User USER MANUAL Manual for CLC Server 10.0.1 Windows, macos and Linux March 8, 2018 This software is for research purposes only. QIAGEN Aarhus Silkeborgvej 2 Prismet DK-8000 Aarhus C Denmark

More information

Anaquin - Vignette Ted Wong January 05, 2019

Anaquin - Vignette Ted Wong January 05, 2019 Anaquin - Vignette Ted Wong (t.wong@garvan.org.au) January 5, 219 Citation [1] Representing genetic variation with synthetic DNA standards. Nature Methods, 217 [2] Spliced synthetic genes as internal controls

More information

The Allen Human Brain Atlas offers three types of searches to allow a user to: (1) obtain gene expression data for specific genes (or probes) of

The Allen Human Brain Atlas offers three types of searches to allow a user to: (1) obtain gene expression data for specific genes (or probes) of Microarray Data MICROARRAY DATA Gene Search Boolean Syntax Differential Search Mouse Differential Search Search Results Gene Classification Correlative Search Download Search Results Data Visualization

More information

Package PCGSE. March 31, 2017

Package PCGSE. March 31, 2017 Type Package Title Principal Component Gene Set Enrichment Version 0.4 Date 2017-03-31 Author H. Robert Frost Package PCGSE March 31, 2017 Maintainer H. Robert Frost Description

More information

Package EMDomics. November 11, 2018

Package EMDomics. November 11, 2018 Package EMDomics November 11, 2018 Title Earth Mover's Distance for Differential Analysis of Genomics Data The EMDomics algorithm is used to perform a supervised multi-class analysis to measure the magnitude

More information

Expression Analysis with the Advanced RNA-Seq Plugin

Expression Analysis with the Advanced RNA-Seq Plugin Expression Analysis with the Advanced RNA-Seq Plugin May 24, 2016 Sample to Insight CLC bio, a QIAGEN Company Silkeborgvej 2 Prismet 8000 Aarhus C Denmark Telephone: +45 70 22 32 44 www.clcbio.com support-clcbio@qiagen.com

More information

Statistical Analysis of Metabolomics Data. Xiuxia Du Department of Bioinformatics & Genomics University of North Carolina at Charlotte

Statistical Analysis of Metabolomics Data. Xiuxia Du Department of Bioinformatics & Genomics University of North Carolina at Charlotte Statistical Analysis of Metabolomics Data Xiuxia Du Department of Bioinformatics & Genomics University of North Carolina at Charlotte Outline Introduction Data pre-treatment 1. Normalization 2. Centering,

More information

subseq Package Vignette (Version )

subseq Package Vignette (Version ) subseq Package Vignette (Version 0.99.0) David G. Robinson July 26, 2014 Contents 1 Introduction 1 2 Quick Start Guide 2 2.1 The subsamples object....................... 3 2.2 Summarizing Output by Depth...................

More information

Package genelistpie. February 19, 2015

Package genelistpie. February 19, 2015 Type Package Package genelistpie February 19, 2015 Title Profiling a gene list into GOslim or KEGG function pie Version 1.0 Date 2009-10-06 Author Xutao Deng Maintainer Xutao Deng

More information

Package methylgsa. March 7, 2019

Package methylgsa. March 7, 2019 Package methylgsa March 7, 2019 Type Package Title Gene Set Analysis Using the Outcome of Differential Methylation Version 1.1.3 The main functions for methylgsa are methylglm and methylrra. methylgsa

More information

Application of Hierarchical Clustering to Find Expression Modules in Cancer

Application of Hierarchical Clustering to Find Expression Modules in Cancer Application of Hierarchical Clustering to Find Expression Modules in Cancer T. M. Murali August 18, 2008 Innovative Application of Hierarchical Clustering A module map showing conditional activity of expression

More information

How to store and visualize RNA-seq data

How to store and visualize RNA-seq data How to store and visualize RNA-seq data Gabriella Rustici Functional Genomics Group gabry@ebi.ac.uk EBI is an Outstation of the European Molecular Biology Laboratory. Talk summary How do we archive RNA-seq

More information

Expander Online Documentation

Expander Online Documentation Expander Online Documentation Table of Contents Introduction...1 Starting EXPANDER...2 Input Data...4 Preprocessing GE Data...8 Viewing Data Plots...12 Clustering GE Data...14 Biclustering GE Data...17

More information

Package LncPath. May 16, 2016

Package LncPath. May 16, 2016 Type Package Package LncPath May 16, 2016 Title Identifying the Pathways Regulated by LncRNA Sets of Interest Version 1.0 Date 2016-04-27 Author Junwei Han, Zeguo Sun Maintainer Junwei Han

More information

Automated Bioinformatics Analysis System on Chip ABASOC. version 1.1

Automated Bioinformatics Analysis System on Chip ABASOC. version 1.1 Automated Bioinformatics Analysis System on Chip ABASOC version 1.1 Phillip Winston Miller, Priyam Patel, Daniel L. Johnson, PhD. University of Tennessee Health Science Center Office of Research Molecular

More information

Wilson Leung 01/03/2018 An Introduction to NCBI BLAST. Prerequisites: Detecting and Interpreting Genetic Homology: Lecture Notes on Alignment

Wilson Leung 01/03/2018 An Introduction to NCBI BLAST. Prerequisites: Detecting and Interpreting Genetic Homology: Lecture Notes on Alignment An Introduction to NCBI BLAST Prerequisites: Detecting and Interpreting Genetic Homology: Lecture Notes on Alignment Resources: The BLAST web server is available at https://blast.ncbi.nlm.nih.gov/blast.cgi

More information

stepwisecm: Stepwise Classification of Cancer Samples using High-dimensional Data Sets

stepwisecm: Stepwise Classification of Cancer Samples using High-dimensional Data Sets stepwisecm: Stepwise Classification of Cancer Samples using High-dimensional Data Sets Askar Obulkasim Department of Epidemiology and Biostatistics, VU University Medical Center P.O. Box 7075, 1007 MB

More information

Analyzing Genomic Data with NOJAH

Analyzing Genomic Data with NOJAH Analyzing Genomic Data with NOJAH TAB A) GENOME WIDE ANALYSIS Step 1: Select the example dataset or upload your own. Two example datasets are available. Genome-Wide TCGA-BRCA Expression datasets and CoMMpass

More information

Supplementary text S6 Comparison studies on simulated data

Supplementary text S6 Comparison studies on simulated data Supplementary text S Comparison studies on simulated data Peter Langfelder, Rui Luo, Michael C. Oldham, and Steve Horvath Corresponding author: shorvath@mednet.ucla.edu Overview In this document we illustrate

More information

Package SCAN.UPC. October 9, Type Package. Title Single-channel array normalization (SCAN) and University Probability of expression Codes (UPC)

Package SCAN.UPC. October 9, Type Package. Title Single-channel array normalization (SCAN) and University Probability of expression Codes (UPC) Package SCAN.UPC October 9, 2013 Type Package Title Single-channel array normalization (SCAN) and University Probability of expression Codes (UPC) Version 2.0.2 Author Stephen R. Piccolo and W. Evan Johnson

More information

Supplementary Materials for. A gene ontology inferred from molecular networks

Supplementary Materials for. A gene ontology inferred from molecular networks Supplementary Materials for A gene ontology inferred from molecular networks Janusz Dutkowski, Michael Kramer, Michal A Surma, Rama Balakrishnan, J Michael Cherry, Nevan J Krogan & Trey Ideker 1. Supplementary

More information

ANNOUNCING THE RELEASE OF LISREL VERSION BACKGROUND 2 COMBINING LISREL AND PRELIS FUNCTIONALITY 2 FIML FOR ORDINAL AND CONTINUOUS VARIABLES 3

ANNOUNCING THE RELEASE OF LISREL VERSION BACKGROUND 2 COMBINING LISREL AND PRELIS FUNCTIONALITY 2 FIML FOR ORDINAL AND CONTINUOUS VARIABLES 3 ANNOUNCING THE RELEASE OF LISREL VERSION 9.1 2 BACKGROUND 2 COMBINING LISREL AND PRELIS FUNCTIONALITY 2 FIML FOR ORDINAL AND CONTINUOUS VARIABLES 3 THREE-LEVEL MULTILEVEL GENERALIZED LINEAR MODELS 3 FOUR

More information

- with application to cluster and significance analysis

- with application to cluster and significance analysis Selection via - with application to cluster and significance of gene expression Rebecka Jörnsten Department of Statistics, Rutgers University rebecka@stat.rutgers.edu, http://www.stat.rutgers.edu/ rebecka

More information

Introduction to Cancer Genomics

Introduction to Cancer Genomics Introduction to Cancer Genomics Gene expression data analysis part I David Gfeller Computational Cancer Biology Ludwig Center for Cancer research david.gfeller@unil.ch 1 Overview 1. Basic understanding

More information

Exploring Data. This guide describes the facilities in SPM to gain initial insights about a dataset by viewing and generating descriptive statistics.

Exploring Data. This guide describes the facilities in SPM to gain initial insights about a dataset by viewing and generating descriptive statistics. This guide describes the facilities in SPM to gain initial insights about a dataset by viewing and generating descriptive statistics. 2018 by Minitab Inc. All rights reserved. Minitab, SPM, SPM Salford

More information

Package anota2seq. January 30, 2018

Package anota2seq. January 30, 2018 Version 1.1.0 Package anota2seq January 30, 2018 Title Generally applicable transcriptome-wide analysis of translational efficiency using anota2seq Author Christian Oertlin , Julie

More information

Big Data Methods. Chapter 5: Machine learning. Big Data Methods, Chapter 5, Slide 1

Big Data Methods. Chapter 5: Machine learning. Big Data Methods, Chapter 5, Slide 1 Big Data Methods Chapter 5: Machine learning Big Data Methods, Chapter 5, Slide 1 5.1 Introduction to machine learning What is machine learning? Concerned with the study and development of algorithms that

More information

Package enrich. September 3, 2013

Package enrich. September 3, 2013 Package enrich September 3, 2013 Type Package Title An R package for the analysis of multiple ChIP-seq data Version 2.0 Date 2013-09-01 Author Yanchun Bao , Veronica Vinciotti

More information

Computational Genomics and Molecular Biology, Fall

Computational Genomics and Molecular Biology, Fall Computational Genomics and Molecular Biology, Fall 2015 1 Sequence Alignment Dannie Durand Pairwise Sequence Alignment The goal of pairwise sequence alignment is to establish a correspondence between the

More information

Package twilight. August 3, 2013

Package twilight. August 3, 2013 Package twilight August 3, 2013 Version 1.37.0 Title Estimation of local false discovery rate Author Stefanie Scheid In a typical microarray setting with gene expression data observed

More information

Package BEARscc. May 2, 2018

Package BEARscc. May 2, 2018 Type Package Package BEARscc May 2, 2018 Title BEARscc (Bayesian ERCC Assesstment of Robustness of Single Cell Clusters) Version 1.0.0 Author David T. Severson Maintainer

More information

Colorado State University Bioinformatics Algorithms Assignment 6: Analysis of High- Throughput Biological Data Hamidreza Chitsaz, Ali Sharifi- Zarchi

Colorado State University Bioinformatics Algorithms Assignment 6: Analysis of High- Throughput Biological Data Hamidreza Chitsaz, Ali Sharifi- Zarchi Colorado State University Bioinformatics Algorithms Assignment 6: Analysis of High- Throughput Biological Data Hamidreza Chitsaz, Ali Sharifi- Zarchi Although a little- bit long, this is an easy exercise

More information

Release Notes. JMP Genomics. Version 4.0

Release Notes. JMP Genomics. Version 4.0 JMP Genomics Version 4.0 Release Notes Creativity involves breaking out of established patterns in order to look at things in a different way. Edward de Bono JMP. A Business Unit of SAS SAS Campus Drive

More information

Tutorial for the Exon Ontology website

Tutorial for the Exon Ontology website Tutorial for the Exon Ontology website Table of content Outline Step-by-step Guide 1. Preparation of the test-list 2. First analysis step (without statistical analysis) 2.1. The output page is composed

More information

The clusterrepro Package

The clusterrepro Package The clusterrepro Package February 22, 2006 Version 0.5-1 Date 2006-01-06 Title Reproducibility of gene expression clusters Author Amy Kapp and Rob Tibshirani

More information

Transcript quantification using Salmon and differential expression analysis using bayseq

Transcript quantification using Salmon and differential expression analysis using bayseq Introduction to expression analysis (RNA-seq) Transcript quantification using Salmon and differential expression analysis using bayseq Philippine Genome Center University of the Philippines Prepared by

More information

As of August 15, 2008, GenBank contained bases from reported sequences. The search procedure should be

As of August 15, 2008, GenBank contained bases from reported sequences. The search procedure should be 48 Bioinformatics I, WS 09-10, S. Henz (script by D. Huson) November 26, 2009 4 BLAST and BLAT Outline of the chapter: 1. Heuristics for the pairwise local alignment of two sequences 2. BLAST: search and

More information

Package TANOVA. R topics documented: February 19, Version Date

Package TANOVA. R topics documented: February 19, Version Date Version 1.0.0 Date 2010-05-05 Package TANOVA February 19, 2015 Title Time Course Analysis of Variance for Microarray Depends R (>= 2.3.0), MASS, splines Author Baiyu Zhou and Weihong

More information

EBSeqHMM: An R package for identifying gene-expression changes in ordered RNA-seq experiments

EBSeqHMM: An R package for identifying gene-expression changes in ordered RNA-seq experiments EBSeqHMM: An R package for identifying gene-expression changes in ordered RNA-seq experiments Ning Leng and Christina Kendziorski April 30, 2018 Contents 1 Introduction 1 2 The model 2 2.1 EBSeqHMM model..........................................

More information

Genomics - Problem Set 2 Part 1 due Friday, 1/26/2018 by 9:00am Part 2 due Friday, 2/2/2018 by 9:00am

Genomics - Problem Set 2 Part 1 due Friday, 1/26/2018 by 9:00am Part 2 due Friday, 2/2/2018 by 9:00am Genomics - Part 1 due Friday, 1/26/2018 by 9:00am Part 2 due Friday, 2/2/2018 by 9:00am One major aspect of functional genomics is measuring the transcript abundance of all genes simultaneously. This was

More information

Getting Started. April Strand Life Sciences, Inc All rights reserved.

Getting Started. April Strand Life Sciences, Inc All rights reserved. Getting Started April 2015 Strand Life Sciences, Inc. 2015. All rights reserved. Contents Aim... 3 Demo Project and User Interface... 3 Downloading Annotations... 4 Project and Experiment Creation... 6

More information

Differential gene expression analysis using RNA-seq

Differential gene expression analysis using RNA-seq https://abc.med.cornell.edu/ Differential gene expression analysis using RNA-seq Applied Bioinformatics Core, September/October 2018 Friederike Dündar with Luce Skrabanek & Paul Zumbo Day 3: Counting reads

More information

STEM. Short Time-series Expression Miner (v1.1) User Manual

STEM. Short Time-series Expression Miner (v1.1) User Manual STEM Short Time-series Expression Miner (v1.1) User Manual Jason Ernst (jernst@cs.cmu.edu) Ziv Bar-Joseph Center for Automated Learning and Discovery School of Computer Science Carnegie Mellon University

More information

Expander 7.2 Online Documentation

Expander 7.2 Online Documentation Expander 7.2 Online Documentation Introduction... 2 Starting EXPANDER... 2 Input Data... 3 Tabular Data File... 4 CEL Files... 6 Working on similarity data no associated expression data... 9 Working on

More information

RNA-Seq analysis with Astrocyte Differential expression and transcriptome assembly

RNA-Seq analysis with Astrocyte Differential expression and transcriptome assembly RNA-Seq analysis with Astrocyte Differential expression and transcriptome assembly Beibei Chen Ph.D BICF 9/28/2016 Agenda Launch Workflows using Astrocyte BICF Workflows BICF RNA-seq Workflow Experimental

More information

mgu74a.db November 2, 2013 Map Manufacturer identifiers to Accession Numbers

mgu74a.db November 2, 2013 Map Manufacturer identifiers to Accession Numbers mgu74a.db November 2, 2013 mgu74aaccnum Map Manufacturer identifiers to Accession Numbers mgu74aaccnum is an R object that contains mappings between a manufacturer s identifiers and manufacturers accessions.

More information

Package igc. February 10, 2018

Package igc. February 10, 2018 Type Package Package igc February 10, 2018 Title An integrated analysis package of Gene expression and Copy number alteration Version 1.8.0 This package is intended to identify differentially expressed

More information

Our typical RNA quantification pipeline

Our typical RNA quantification pipeline RNA-Seq primer Our typical RNA quantification pipeline Upload your sequence data (fastq) Align to the ribosome (Bow>e) Align remaining reads to genome (TopHat) or transcriptome (RSEM) Make report of quality

More information

Package PAPi. August 3, 2013

Package PAPi. August 3, 2013 Package PAPi August 3, 2013 Type Package Title Predict metabolic pathway activity based on metabolomics data Version 1.1.0 Date 2013-03-27 Author Raphael Aggio Maintainer Raphael Aggio

More information

How to use the DEGseq Package

How to use the DEGseq Package How to use the DEGseq Package Likun Wang 1,2 and Xi Wang 1. October 30, 2018 1 MOE Key Laboratory of Bioinformatics and Bioinformatics Division, TNLIST /Department of Automation, Tsinghua University. 2

More information

Gene signature selection to predict survival benefits from adjuvant chemotherapy in NSCLC patients

Gene signature selection to predict survival benefits from adjuvant chemotherapy in NSCLC patients 1 Gene signature selection to predict survival benefits from adjuvant chemotherapy in NSCLC patients 1,2 Keyue Ding, Ph.D. Nov. 8, 2014 1 NCIC Clinical Trials Group, Kingston, Ontario, Canada 2 Dept. Public

More information

Clustering. RNA-seq: What is it good for? Finding Similarly Expressed Genes. Data... And Lots of It!

Clustering. RNA-seq: What is it good for? Finding Similarly Expressed Genes. Data... And Lots of It! RNA-seq: What is it good for? Clustering High-throughput RNA sequencing experiments (RNA-seq) offer the ability to measure simultaneously the expression level of thousands of genes in a single experiment!

More information

Tutorial - Analysis of Microarray Data. Microarray Core E Consortium for Functional Glycomics Funded by the NIGMS

Tutorial - Analysis of Microarray Data. Microarray Core E Consortium for Functional Glycomics Funded by the NIGMS Tutorial - Analysis of Microarray Data Microarray Core E Consortium for Functional Glycomics Funded by the NIGMS Data Analysis introduction Warning: Microarray data analysis is a constantly evolving science.

More information

Identifying differentially expressed genes with siggenes

Identifying differentially expressed genes with siggenes Identifying differentially expressed genes with siggenes Holger Schwender holger.schw@gmx.de Abstract In this vignette, we show how the functions contained in the R package siggenes can be used to perform

More information

SUGEN 8.6 Overview. Misa Graff, July 2017

SUGEN 8.6 Overview. Misa Graff, July 2017 SUGEN 8.6 Overview Misa Graff, July 2017 General Information By Ran Tao, https://sites.google.com/site/dragontaoran/home Website: http://dlin.web.unc.edu/software/sugen/ Standalone command-line software

More information

Tutorial. RNA-Seq Analysis of Breast Cancer Data. Sample to Insight. November 21, 2017

Tutorial. RNA-Seq Analysis of Breast Cancer Data. Sample to Insight. November 21, 2017 RNA-Seq Analysis of Breast Cancer Data November 21, 2017 Sample to Insight QIAGEN Aarhus Silkeborgvej 2 Prismet 8000 Aarhus C Denmark Telephone: +45 70 22 32 44 www.qiagenbioinformatics.com AdvancedGenomicsSupport@qiagen.com

More information

Supplemental Material to Hyatt et al, Gene-expression microarrays: glimpses at the immunological genome

Supplemental Material to Hyatt et al, Gene-expression microarrays: glimpses at the immunological genome Supplemental Material to Hyatt et al, Gene-expression microarrays: glimpses at the immunological genome A. Description and Use of the ImmGen Website. The ImmGen website (http://immgen.org) can be accessed

More information

Data Processing and Analysis in Systems Medicine. Milena Kraus Data Management for Digital Health Summer 2017

Data Processing and Analysis in Systems Medicine. Milena Kraus Data Management for Digital Health Summer 2017 Milena Kraus Digital Health Summer Agenda Real-world Use Cases Oncology Nephrology Heart Insufficiency Additional Topics Data Management & Foundations Biology Recap Data Sources Data Formats Business Processes

More information

Dr. Gabriela Salinas Dr. Orr Shomroni Kaamini Rhaithata

Dr. Gabriela Salinas Dr. Orr Shomroni Kaamini Rhaithata Analysis of RNA sequencing data sets using the Galaxy environment Dr. Gabriela Salinas Dr. Orr Shomroni Kaamini Rhaithata Microarray and Deep-sequencing core facility 30.10.2017 RNA-seq workflow I Hypothesis

More information

Package EFS. R topics documented:

Package EFS. R topics documented: Package EFS July 24, 2017 Title Tool for Ensemble Feature Selection Description Provides a function to check the importance of a feature based on a dependent classification variable. An ensemble of feature

More information

Network Enrichment Analysis using neagui Package

Network Enrichment Analysis using neagui Package Network Enrichment Analysis using neagui Package Setia Pramana, Woojoo Lee, Andrey Alexeyenko, Yudi Pawitan April 2, 2013 1 Introduction After discovering list of differentially expressed genes, the next

More information

ECLT 5810 Data Preprocessing. Prof. Wai Lam

ECLT 5810 Data Preprocessing. Prof. Wai Lam ECLT 5810 Data Preprocessing Prof. Wai Lam Why Data Preprocessing? Data in the real world is imperfect incomplete: lacking attribute values, lacking certain attributes of interest, or containing only aggregate

More information

RNA-Seq. Joshua Ainsley, PhD Postdoctoral Researcher Lab of Leon Reijmers Neuroscience Department Tufts University

RNA-Seq. Joshua Ainsley, PhD Postdoctoral Researcher Lab of Leon Reijmers Neuroscience Department Tufts University RNA-Seq Joshua Ainsley, PhD Postdoctoral Researcher Lab of Leon Reijmers Neuroscience Department Tufts University joshua.ainsley@tufts.edu Day four Quantifying expression Intro to R Differential expression

More information

Supplementary Material

Supplementary Material Supplementary Material Figure 1S: Scree plot of the 400 dimensional data. The Figure shows the 20 largest eigenvalues of the (normalized) correlation matrix sorted in decreasing order; the insert shows

More information

Analyzing ICAT Data. Analyzing ICAT Data

Analyzing ICAT Data. Analyzing ICAT Data Analyzing ICAT Data Gary Van Domselaar University of Alberta Analyzing ICAT Data ICAT: Isotope Coded Affinity Tag Introduced in 1999 by Ruedi Aebersold as a method for quantitative analysis of complex

More information

m6aviewer Version Documentation

m6aviewer Version Documentation m6aviewer Version 1.6.0 Documentation Contents 1. About 2. Requirements 3. Launching m6aviewer 4. Running Time Estimates 5. Basic Peak Calling 6. Running Modes 7. Multiple Samples/Sample Replicates 8.

More information

DREM. Dynamic Regulatory Events Miner (v1.0.9b) User Manual

DREM. Dynamic Regulatory Events Miner (v1.0.9b) User Manual DREM Dynamic Regulatory Events Miner (v1.0.9b) User Manual Jason Ernst (jernst@cs.cmu.edu) Ziv Bar-Joseph Machine Learning Department School of Computer Science Carnegie Mellon University Contents 1 Introduction

More information

More about liquid association

More about liquid association More about liquid association Liquid Association (LA) LA is a generalized notion of association for describing certain kind of ternary relationship between variables in a system. (Li 2002 PNAS) low (-)

More information

Package clusterrepro

Package clusterrepro Version 0.9 Date 2018-10-10 Package clusterrepro Title Reproducibility of Gene Expression Clusters October 15, 2018 Author Amy Kapp and Rob Tibshirani Maintainer

More information