Package srap. November 25, 2017

Similar documents
srap: Simplified RNA-Seq Analysis Pipeline

Brain, a library for the OWL2 EL profile

Package ssizerna. January 9, 2017

version /1/2011 Source code Linux x86_64 binary Mac OS X x86_64 binary

Package twilight. August 3, 2013

NGS FASTQ file format

mrna-seq Basic processing Read mapping (shown here, but optional. May due if time allows) Gene expression estimation

David Crossman, Ph.D. UAB Heflin Center for Genomic Science. GCC2012 Wednesday, July 25, 2012

Services Performed. The following checklist confirms the steps of the RNA-Seq Service that were performed on your samples.

Package splinetimer. December 22, 2016

Automated Bioinformatics Analysis System on Chip ABASOC. version 1.1

How to use the DEGseq Package

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

FINDSITE-metal manual

Tutorial: RNA-Seq analysis part I: Getting started

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

EECS730: Introduction to Bioinformatics

Package NOISeq. R topics documented: August 3, Type Package. Title Exploratory analysis and differential expression for RNA-seq data

Package Linnorm. October 12, 2016

Package M3Drop. August 23, 2018

Anaquin - Vignette Ted Wong January 05, 2019

Package pcagopromoter

Package EMDomics. November 11, 2018

Sequence Analysis Pipeline

Package snm. July 20, 2018

Package svapls. February 20, 2015

SAM-GS. Significance Analysis of Microarray for Gene Sets

Package DNaseR. November 1, 2013

Package SC3. November 27, 2017

RDAVIDWebService: a versatile R interface to DAVID

Package geecc. October 9, 2015

A review of RNA-Seq normalization methods

From the Schnable Lab:

Package SC3. September 29, 2018

Package stattarget. December 5, 2017

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

ROTS: Reproducibility Optimized Test Statistic

Package GSCA. October 12, 2016

Package GSCA. April 12, 2018

Package anota2seq. January 30, 2018

Package RNASeqR. January 8, 2019

How to store and visualize RNA-seq data

Identifying differentially expressed genes with siggenes

Testing for Differential Expression

Drug versus Disease (DrugVsDisease) package

SIBER User Manual. Pan Tong and Kevin R Coombes. May 27, Introduction 1

SEEK User Manual. Introduction

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

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

Course on Microarray Gene Expression Analysis

Analyzing Gene Expression Data in Terms of Gene Sets: Gene Set Enrichment Analysis

Package OrderedList. December 31, 2017

Package dupradar. R topics documented: July 12, Type Package

EBSeq: An R package for differential expression analysis using RNA-seq data

RNA-seq. Manpreet S. Katari

RNA Sequencing with TopHat Alignment v1.0 and Cufflinks Assembly & DE v1.1 App Guide

Package SeqGSEA. October 10, 2018

THE MANUAL.

Package ffpe. October 1, 2018

RNA-Seq Analysis With the Tuxedo Suite

Package LncPath. May 16, 2016

Differential Expression Analysis at PATRIC

Visualization using CummeRbund 2014 Overview

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

All About PlexSet Technology Data Analysis in nsolver Software

Introduction to GE Microarray data analysis Practical Course MolBio 2012

Package stattarget. December 23, 2018

Package BgeeDB. January 5, 2019

Differential Expression

Package roar. August 31, 2018

Package RobustRankAggreg

T-IDBA: A de novo Iterative de Bruijn Graph Assembler for Transcriptome

A STUDY ON DYNAMIC CLUSTERING OF GENE EXPRESSION DATA

FANTOM: Functional and Taxonomic Analysis of Metagenomes

11/8/2017 Trinity De novo Transcriptome Assembly Workshop trinityrnaseq/rnaseq_trinity_tuxedo_workshop Wiki GitHub

Exercise 1 Review. --outfiltermismatchnmax : max number of mismatch (Default 10) --outreadsunmapped fastx: output unmapped reads

Windows. RNA-Seq Tutorial

Supplementary Figure 1. Fast read-mapping algorithm of BrowserGenome.

Gene Expression Data Analysis. Qin Ma, Ph.D. December 10, 2017

Package mirnapath. July 18, 2013

Package polyphemus. February 15, 2013

Quantification. Part I, using Excel

RNA-Seq analysis with Astrocyte Differential expression and transcriptome assembly

TECH NOTE Improving the Sensitivity of Ultra Low Input mrna Seq

Package genelistpie. February 19, 2015

Package ERSSA. November 4, 2018

Software PLAN: a web platform for automating high-throughput BLAST searches and for managing and mining results Ji He, Xinbin Dai and Xuechun Zhao*

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

Goal: Learn how to use various tool to extract information from RNAseq reads. 4.1 Mapping RNAseq Reads to a Genome Assembly

Workflows for RNAseq analyses (polysomes or hippocamal/ca1 dissec=on experiment) Cufflinks 1.3 output (unfiltered) to normalized, filtered expression

Package NOISeq. September 26, 2018

Package MethylSeekR. January 26, 2019

safe September 23, 2010

RNA- SeQC Documentation

Tutorial 1: Using Excel to find unique values in a list

Package SeqGSEA. October 4, 2013

Package GOTHiC. November 22, 2017

Package Director. October 15, 2018

Package tatest. July 18, 2018

Introduction to Cancer Genomics

Transcription:

Type Package Title Simplified RNA-Seq Analysis Pipeline Version 1.18.0 Date 2013-08-21 Author Charles Warden Package srap November 25, 2017 Maintainer Charles Warden <cwarden45@gmail.com> Depends WriteXLS Imports gplots, pls, ROCR, qvalue This package provides a pipeline for gene expression analysis (primarily for RNA- Seq data). The normalization function is specific for RNA-Seq analysis, but all other functions (Quality Control Figures, Differential Expression and Visualization, and Functional Enrichment via BD-Func) will work with any type of gene expression data. License GPL-3 LazyLoad yes biocviews GeneExpression, RNAseq, Microarray, Preprocessing, QualityControl, Statistics, DifferentialExpression, Visualization, GeneSetEnrichment, GO NeedsCompilation no R topics documented: bdfunc.enrichment.human................................. 2 bdfunc.enrichment.mouse.................................. 2 RNA.bdfunc.fc....................................... 3 RNA.bdfunc.signal..................................... 5 RNA.deg.......................................... 6 RNA.norm.......................................... 8 RNA.prepare.input..................................... 9 RNA.qc........................................... 11 Index 12 1

2 bdfunc.enrichment.mouse bdfunc.enrichment.human BD-Func Enrichment File for Human Gene Symbols Source Contains genes lists of paired up-regulated and down-regulated genes. Gene Lists come from Gene Ontology (GO [1]) and MSigDB [2]. BD-Func [3] will compare the expression patterns for the up-regulated genes to the down-regulated genes. data(bdfunc.enrichment.human) GO Gene Lists: http://www.geneontology.org/go.downloads.annotations.shtml MSigDB Gene Lists: http://www.broadinstitute.org/gsea/downloads.jsp [1] Ashburner M, Ball CA, Blake JA, Botstein D, Butler H, Cherry JM, Davis AP, Dolinski K, Dwight SS, Eppig JT, Harris MA, Hill DP, Issel-Tarver L, Kasarskis A, Lewis S, Matese JC, Richardson JE, Ringwald M, Rubin GM, and Sherlock G.(2000). Gene Ontology: tool for the unification of biology Nat Genet, 25:25-29 [2] Liberzon A, Subramanian A, Pinchback R, Thorvaldsdottir H, Tamayo P, and Mesirov JP.(2011). Molecular signatures database (MSigDB) 3.0. Bioinformatics, 27:1739-1740. [3] Warden CD, Kanaya N, Chen S, and Yuan Y-C. (2013). BD-Func: A Streamlined Algorithm for Predicting Activation and Inhibition of Pathways. peerj, 1:e159 bdfunc.enrichment.mouse BD-Func Enrichment File for Mouse Gene Symbols Source Contains genes lists of paired up-regulated and down-regulated genes. Gene Lists come from Gene Ontology (GO [1]). BD-Func [2] will compare the expression patterns for the up-regulated genes to the down-regulated genes. data(bdfunc.enrichment.mouse) GO Gene Lists: http://www.geneontology.org/go.downloads.annotations.shtml

RNA.bdfunc.fc 3 [1] Ashburner M, Ball CA, Blake JA, Botstein D, Butler H, Cherry JM, Davis AP, Dolinski K, Dwight SS, Eppig JT, Harris MA, Hill DP, Issel-Tarver L, Kasarskis A, Lewis S, Matese JC, Richardson JE, Ringwald M, Rubin GM, and Sherlock G.(2000). Gene Ontology: tool for the unification of biology Nat Genet, 25:25-29 [2] Warden CD, Kanaya N, Chen S, and Yuan Y-C. (2013). BD-Func: A Streamlined Algorithm for Predicting Activation and Inhibition of Pathways. peerj, 1:e159 RNA.bdfunc.fc Functional Enrichment for a Table of Fold-Change Values Bi-Directional FUNCtional enrichment [1] compares expression values for up- and down-regulated genes are compared for at least one gene set, using fold-change valuesvalues. Gene sets are already defined for human and mouse gene symbols. All other gene sets must be specified by the user. The user can optionally output density plots to visualze enrichment scores across samples in different groups. RNA.bdfunc.fc(stat.table, project.name, project.folder, species = NULL, enrichment.file = NULL, p. Arguments stat.table project.name Table of fold-change values. This assumes that the variable hypothesized to control gene expression can be defined as two groups, with a specified reference group. Gene symbols are in the first column. Fold-change values are in the second column. This file is automatically created by the RNA.deg function. Name for srap project. This determines the names for output files. project.folder Folder for srap output files species Name for species used for analysis. If species is set to "human" or "mouse," then pre-defined gene lists provided by the srap package are used. The default human gene list is created from gene ontology [2] and MSigDB [3] databases. The default mouse gene list is created from the gene ontology [2] database. enrichment.file Table of gene lists including up- and down-regulated genes. This is only necessary when defining a custom species. This parameter is ignored when the species is set to "human" or "mouse" p.method Method for calculating p-values "t-test" (Default) = t-test between up-regulated and down-regualted genes "mannwhitney" = Non-parametric Mann-Whitney U test between up-and down-regulated genes "ks" = Kolmogorov-Smirnov test between up- and down-regulated genes

4 RNA.bdfunc.fc p.adjust.method Method for calculating false discovery rate (FDR): plot.flag "fdr" (Default)= B-H "Step-Up" FDR [4] "q-value" = Storey q-value [5] "none" = use unadjusted p-value without multiple hypothesis correction Logical value: Should density plots be created for all gene sets? Author(s) Charles Warden <cwarden45@gmail.com> [1] Warden CD, Kanaya N, Chen S, and Yuan Y-C. (2013). BD-Func: A Streamlined Algorithm for Predicting Activation and Inhibition of Pathways. peerj, 1:e159 [2] Ashburner M, Ball CA, Blake JA, Botstein D, Butler H, Cherry JM, Davis AP, Dolinski K, Dwight SS, Eppig JT, Harris MA, Hill DP, Issel-Tarver L, Kasarskis A, Lewis S, Matese JC, Richardson JE, Ringwald M, Rubin GM, and Sherlock G.(2000). Gene Ontology: tool for the unification of biology Nat Genet, 25:25-29 [3] Liberzon A, Subramanian A, Pinchback R, Thorvaldsdottir H, Tamayo P, and Mesirov JP.(2011). Molecular signatures database (MSigDB) 3.0. Bioinformatics, 27:1739-1740. [4] Benjamini Y, and Hochberg Y.(1995). Controlling the False Discovery Rate: A Practical and Powerful Approach to Multiple Testing. Journal of the Royal Statistical Society Series B, 57:289-300. [5] Storey JD, and Tibshirani R. (2003). Statistical significance for genomewide studies. Proceedings of the National Academy of Sciences, 100:9440-9445. See Also srap goes through an entire analysis for an example dataset provided with the srap package. Please post questions on the srap discussion group: http://sourceforge.net/p/bdfunc/discussion/srap/ Examples library("srap") dir <- system.file("extdata", package="srap") expression.table <- file.path(dir,"miseq_cufflinks_genes_truncate.txt") sample.table <- file.path(dir,"miseq_sample_.txt") project.folder <- getwd() project.name <- "MiSeq" expression.mat <- RNA.norm(expression.table, project.name, project.folder) stat.table <- RNA.deg(sample.table, expression.mat, project.name, project.folder, box.plot=false, ref.group= RNA.bdfunc.fc(stat.table, project.name, plot.flag=false, project.folder, species="human")

RNA.bdfunc.signal 5 RNA.bdfunc.signal Functional Enrichment for a Table of Normalized Gene Expression Values Bi-Directional FUNCtional enrichment [1] compares expression values for up- and down-regulated genes are compared for at least one gene set, using normalized expression values. Gene sets are already defined for human and mouse gene symbols. All other gene sets must be specified by the user. The user can optionally output box-plots to visualze enrichment scores across samples in different groups. RNA.bdfunc.signal(expression.table, sample.file, project.name, project.folder, species = NULL, enr Arguments expression.table Data frame with genes in columns and samples in rows. Data should be log2 transformed. The RNA.norm function automatically creates this file. sample.file project.name Tab-delimited text file providing group attributions for all samples considered for analysis. Name for srap project. This determines the names for output files. project.folder Folder for srap output files species Name for species used for analysis. If species is set to "human" or "mouse," then pre-defined gene lists provided by the srap package are used. The default human gene list is created from gene ontology [2] and MSigDB [3] databases. The default mouse gene list is created from the gene ontology [2] database. enrichment.file Table of gene lists including up- and down-regulated genes. This is only necessary when defining a custom species. This parameter is ignored when the species is set to "human" or "mouse". p.method Method for calculating p-values "t-test" (Default) = t-test between up-regulated and down-regualted genes "mannwhitney" = Non-parametric Mann-Whitney U test between up-and down-regulated genes "ks" = Kolmogorov-Smirnov test between up- and down-regulated genes p.adjust.method Method for calculating false discovery rate (FDR): "fdr" (Default)= B-H "Step-Up" FDR [4] "q-value" = Storey q-value [5] "none" = use unadjusted p-value without multiple hypothesis correction plot.flag color.palette Logical value: Should box-plots be created for all gene sets? If primary variable is two groups called "positive" and "negative", this value also determines if ROC plot will be created. Colors for primary variable (specified in the second column of the sample file). If method is set to "t-test," this variable is ignored. In this special case, groups with an average t-test statistic above 2 are colored red, groups with an average t-test statistic below -2 are colored green, and all other groups are colored grey.

6 RNA.deg Author(s) Charles Warden <cwarden45@gmail.com> [1] Warden CD, Kanaya N, Chen S, and Yuan Y-C. (2013). BD-Func: A Streamlined Algorithm for Predicting Activation and Inhibition of Pathways. peerj, 1:e159 [2] Ashburner M, Ball CA, Blake JA, Botstein D, Butler H, Cherry JM, Davis AP, Dolinski K, Dwight SS, Eppig JT, Harris MA, Hill DP, Issel-Tarver L, Kasarskis A, Lewis S, Matese JC, Richardson JE, Ringwald M, Rubin GM, and Sherlock G.(2000). Gene Ontology: tool for the unification of biology Nat Genet, 25:25-29 [3] Liberzon A, Subramanian A, Pinchback R, Thorvaldsdottir H, Tamayo P, and Mesirov JP.(2011). Molecular signatures database (MSigDB) 3.0. Bioinformatics, 27:1739-1740. [4] Benjamini Y, and Hochberg Y.(1995). Controlling the False Discovery Rate: A Practical and Powerful Approach to Multiple Testing. Journal of the Royal Statistical Society Series B, 57:289-300. [5] Storey JD, and Tibshirani R. (2003). Statistical significance for genomewide studies. Proceedings of the National Academy of Sciences, 100:9440-9445. See Also srap goes through an entire analysis for an example dataset provided with the srap package. Please post questions on the srap discussion group: http://sourceforge.net/p/bdfunc/discussion/srap/ Examples library("srap") dir <- system.file("extdata", package="srap") expression.table <- file.path(dir,"miseq_cufflinks_genes_truncate.txt") sample.table <- file.path(dir,"miseq_sample_.txt") project.folder <- getwd() project.name <- "MiSeq" expression.mat <- RNA.norm(expression.table, project.name, project.folder) stat.table <- RNA.deg(sample.table, expression.mat, project.name, project.folder, box.plot=false, ref.group= RNA.bdfunc.signal(expression.mat, sample.table, plot.flag=false, project.name, project.folder, species="huma RNA.deg Differential Expression Statistics Provides a table of differenitally expressed genes (in.xlsx format) as well as differential expression statistics for all genes (in.xlsx format as well as returned data frame). Function automatically creates a heatmap for differentially expressed genes and user can optionally also create box-plots for each individual differentially expressed gene. The efficacy of this protocol is described in [1]. Output files will be created in the "DEG" and "Raw_Data" subfolders.

RNA.deg 7 RNA.deg(sample.file, expression.table, project.name, project.folder, log2.fc.cutoff = 0.58, pvalue Arguments sample.file Tab-delimited text file providing group attributions for all samples considered for analysis. expression.table Data frame with genes in columns and samples in rows. Data should be log2 transformed. The RNA.norm function automatically creates this file. project.name Name for srap project. This determines the names for output files. project.folder Folder for srap output files log2.fc.cutoff If the primary variable contains two groups with a specified reference, this is the cut-off to define differentially expressed genes (default = 1.5, on a linear scale). Otherwise, this variable is ignored pvalue.cutoff fdr.cutoff box.plot ref.group ref method color.palette legend.status Minimum p-value to define differentially expressed genes Minimum false discovery rate (FDR) to define differentially expressed genes. A logical value: Should box-plots be created for all differenitally expressed genes? If TRUE, then box-plots will be created in a separate subfolder. A logical value: Is the primary variable 2 groups, with a reference group? If the primary variable contains two groups (indicated by ref.group = FALSE), this is the reference used to calculate fold-change values (so, the mean expression for the reference group is substracted from the treatment group). Otherwise, this variable is ignored Method for calculating p-values: "lm" (Default) = linear regression "aov" = ANOVA Colors for primary variable (specified in the second column of the sample file). If the primary variable is a continuous variable, this parameter is ignored. Logical value. Should legend be added to heatmap? Value Data frame containing differential expression statistics. First column contains gene name. If the primary variable contains two groups (with a specified reference), then fold-change values are provided in the second column. P-values and FDR values are provided for each variable in subsequent columns, starting with the primary variable. Author(s) Charles Warden <cwarden45@gmail.com> [1] Warden CD, Yuan Y-C, and Wu X. (2013). Optimal Calculation of RNA-Seq Fold-Change Values. Int J Comput Bioinfo In Silico Model, 2(6): 285-292

8 RNA.norm See Also srap goes through an entire analysis for an example dataset provided with the srap package. Please post questions on the srap discussion group: http://sourceforge.net/p/bdfunc/discussion/srap/ Examples library("srap") dir <- system.file("extdata", package="srap") expression.table <- file.path(dir,"miseq_cufflinks_genes_truncate.txt") sample.table <- file.path(dir,"miseq_sample_.txt") project.folder <- getwd() project.name <- "MiSeq_DEG" expression.mat <- RNA.norm(expression.table, project.name, project.folder) stat.table <- RNA.deg(sample.table, expression.mat, project.name, project.folder, box.plot=false, ref.group= #stat.table <- RNA.deg(sample.table, expression.mat, project.name, project.folder, box.plot=false, #ref.grou RNA.norm Normalization for RNA-Seq Data Takes a table of RPKM (Read Per Kilobase per Million reads [1]) gene expression values. Rounds RPKM values based upon RPKM.cutoff(to avoid bias from low-coverage genes), and then performs a log2 transformation of the data (so that the data more closely follows a normal distribution). The efficacy of this protocol is described in [2]. Output files will be created in the "Raw_Data" subfolder. RNA.norm(input.file, project.name, project.folder, RPKM.cutoff = 0.1) Arguments Value input.file project.name Table of RPKM expression values. Genes are represented in columns. Samples are represented in rows. Name for srap project. This determines the names for output files. project.folder Folder for srap output files RPKM.cutoff Cut-off for rounding RKPM expression values. If the default of 0.1 is used, genes with expression values consistently below 0.1 will essentially be ignored. Data frame of normalized expression values on a log2 scale. Just like the input table, genes are represented on columns, samples are represented in rows. This data frame is used for quality control and differential expression analysis.

RNA.prepare.input 9 Author(s) Charles Warden <cwarden45@gmail.com> [1] Mortazavi A, Williams BA, McCue K, Schaeffer L, and Wold B. (2008). Mapping and quantifying mammalian transcriptomes by RNA-Seq. Nat Meth, 5:621-628. [2] Warden CD, Yuan Y-C, and Wu X. (2013). Optimal Calculation of RNA-Seq Fold-Change Values. Int J Comput Bioinfo In Silico Model, 2(6): 285-292 See Also srap goes through an entire analysis for an example dataset provided with the srap package. Please post questions on the srap discussion group: http://sourceforge.net/p/bdfunc/discussion/srap/ Examples library("srap") dir <- system.file("extdata", package="srap") expression.table <- file.path(dir,"miseq_cufflinks_genes_truncate.txt") sample.table <- file.path(dir,"miseq_sample_.txt") project.folder <- getwd() project.name <- "MiSeq" expression.mat <- RNA.norm(expression.table, project.name, project.folder) RNA.prepare.input Prepare srap InputFile Reads a table of samples containing RPKM (Read Per Kilobase per Million reads [1]) gene expression values and tabules results into a single table that can be read by RNA.norm(). Please note: 1) The default settings are designed for cufflinks [2].fpkm_tracking files 2) The first file determines the set of geneids to be defined in the final table. If this first file is missing RPKM/FPKM values for any genes, those genes will be ignored in all subsequent samples. RNA.prepare.input(sample.list, output.file, gene.index=1, rpkm.index=10) Arguments sample.list output.file Table of samples RPKM expression values. Sample ID (used in sample description file) should be in the first column. Complete path to file should be in second column. Table should have column headers Table of RPKM/FPKM values for all samples. Genes are defined in columns, samples are defined in rows.

10 RNA.prepare.input gene.index rpkm.index 1-based index for gene ID in files described in sample.list. Default setting assumes use of cufflinks to define FPKM values. 1-based index for RPKM/FPKM values in files described in sample.list. Default setting assumes use of cufflinks to define FPKM values. Value Tab-delimited text file to be used for subsequent RNA.norm() step. Author(s) Charles Warden <cwarden45@gmail.com> [1] Mortazavi A, Williams BA, McCue K, Schaeffer L, and Wold B. (2008). Mapping and quantifying mammalian transcriptomes by RNA-Seq. Nat Meth, 5:621-628. [2] Trapnell C, Williams BA, Pertea G, Mortazavi A, Kwan G, van Baren MJ, Salzberg SL, Wold BJ, Pachter L. (2010). Transcript assembly and quantification by RNA-Seq reveals unannotated transcripts and isoform switching during cell differentiation. Nat Biotechnol, 28(5):511-5. See Also Please post questions on the srap discussion group: http://sourceforge.net/p/bdfunc/discussion/srap/ Examples library("srap") dir <- system.file("extdata", package="srap") cufflinks.folder <- file.path(dir,"cufflinks") sample.table <- file.path(dir,"miseq_sample_.txt") samples <- c("srr493372", "SRR493373","SRR493374","SRR493375","SRR493376","SRR493377") cufflinks.files <- paste(samples,"_truncated.fpkm_tracking",sep="") cufflinks.files <- file.path(cufflinks.folder, cufflinks.files) project.folder <- getwd() sample.mat <- data.frame(sample=samples, file=cufflinks.files) sample.list <- file.path(project.folder, "cufflinks_files.txt") write.table(sample.mat, file = sample.list, sep="\t", quote=false, row.names=false) #You can view the "sample.list" file to see what it looks like #For example, this sort of file can be created using Excel rpkm.file <- file.path(project.folder, "srap_input.txt") RNA.prepare.input(sample.list, rpkm.file)

RNA.qc 11 RNA.qc Gene Expression Quality Control Statistics Provides descriptive statistics (median, top/bottom quartiles, mininum,maximum), sample histograms and box-plot, sample dendrogram, principal component analysis plot. Output files will be created in the "QC" subfolder. RNA.qc(sample.file, expression.table, project.name, project.folder, plot.legend = TRUE, color.pale Arguments sample.file Tab-delimited text file providing group attributions for all samples considered for analysis. expression.table Data frame with genes in columns and samples in rows. Data should be log2 transformed. The RNA.norm function automatically creates this file. project.name Name for srap project. This determines the names for output files. project.folder Folder for srap output files plot.legend color.palette Author(s) See Also A logical value: Should legend be plotted within QC figures? Colors for primary variable (specified in the second column of the sample file). If the primary variable is a continuous variable, this parameter is ignored. Charles Warden <cwarden45@gmail.com> srap goes through an entire analysis for an example dataset provided with the srap package. Please post questions on the srap discussion group: http://sourceforge.net/p/bdfunc/discussion/srap/ Examples library("srap") library("writexls") dir <- system.file("extdata", package="srap") expression.table <- file.path(dir,"miseq_cufflinks_genes_truncate.txt") sample.table <- file.path(dir,"miseq_sample_.txt") project.folder <- getwd() project.name <- "MiSeq" expression.mat <- RNA.norm(expression.table, project.name, project.folder) RNA.qc(sample.table, expression.mat, project.name, project.folder, plot.legend=false, color.palette=c("green

Index Topic datasets bdfunc.enrichment.human, 2 bdfunc.enrichment.mouse, 2 bdfunc.enrichment.human, 2 bdfunc.enrichment.mouse, 2 RNA.bdfunc.fc, 3 RNA.bdfunc.signal, 5 RNA.deg, 6 RNA.norm, 8 RNA.prepare.input, 9 RNA.qc, 11 12