RNA Expression Time Course Analysis

Size: px
Start display at page:

Download "RNA Expression Time Course Analysis"

Transcription

1 RNA Expression Time Course Analysis April 23, 2014

2 Introduction The increased efficiency and reduced per-read cost of next generation sequencing (NGS) has opened new and exciting opportunities for data analysis. Rather than comparing the change in expression in a small number of samples, sometimes without replicates, the researchers now can effectively compare expression profiles of a large number of samples, complete with replicates. However, these types of comparisons are not trivial. They require utilization of fairly complex data management and data handling tools that can effectively transform the read-based data into a data matrix that can be analyzed using sophisticated data analysis algorithms. In this document we take a set of 12 NGS data sets from first 24 hours of Drosophila embryonic development and demonstrate how to conduct time course analysis using peer-reviewed statistical algorithms. Analysis Steps Any kind of expression analysis experiment using NGS data (time course is a kind of expression analysis) is done in 6 steps: 1. Quality check of the raw data delivered by core facilities or contract research organizations (CROs). 2. Mapping data to reference genome. 3. Quantification of gene expression. Also may include quantification of transcripts (isoforms) and other annotated genomic elements, possibly including non-coding RNAs. 4. Variance reduction (also called transformation) 5. Normalization 6. Differential expression analysis After step 3 the data have been converted from a list of reads found in raw data files into a table-like format with rows containing genomic elements (genes, transcripts, etc.) and columns samples. Individual cells in this table will contain a number that represents relative abundance of the particular element in a sample. For example, rows corresponding to genes polaa and pola B may look like Table 1. This kind of table is also called data matrix. 1

3 Tag SampleA Sample B Sample C Sample d polaa polab Table 1: Example Data Matrix After one or more intensity tables have been generated, the data must transformed and normalized so they have a distribution appropriate for statistical algorithms. Most of these algorithms are sensitive to the shape of the data, requiring the data to have Normal distribution. This requires steps 4, 5, and 6. In step 6 is where the appropriate statistical algorithms are finally applied. Experiment Drosophila melanogaster (common fruit fly) is one of the best studied and commonly used model organisms. They are easy to handle and breed, and large quantities of molecular information are readily available. The eggs are approximately 0.5 millimeter long and hatch after hours [1, 2]. The resulting larvae will grow for approximately 48 hours. The model organisms encyclopedia of DNA elements (modencode) project [3] has been created by National Human Genome Research Institute (NHGRI) to identify all sequence-based functional elements of C. elegans and Drosophila melanogaster. Project modencode generated 12 sets of Drosophila melanogaster embryonic development data by sequencing RNA collected every 2 hours over a 24 hour period. The data, produced using SOLiD 3 sequencing device, are fully accessible from DNA Data Bank of Japan (DDBJ) [4]. We downloaded the data in FASTQ files, each file containing roughly 5 gigabases in 50 nt reads, mapped them to Ensembl Drosophila genome using software for splice junction mapping, quantified gene expression and analyzed the data matrix using time course-specific algorithms. The results show that, in spite of the insufficient sequencing depth, our analysis was able to identify the probable hatching time as well as differentially expressed genes and non-coding elements. All analysis were performed using clouddeployed Lumenogix NGS. The data were mapped to Drosophila melanogaster genome release 5.25, published February 2010, which was downloaded from Ensembl [5]. Mapping was performed using Tophat [6] splice junction mapping software version 1.2 (Figures 2, 3). Internally, Tophat utilizes bowtie [7] version Since Tophat does not handle SOLiD colorspace 2

4 data, the files were converted to nucleotide format with standard quality encoding, using SOLiD2Std.pl script from Corona Lite toolkit distributed by Life Technologies. Gene expression quantification was performed using htseq-count [8] software. The resulting data matrix was transformed using variance reduction algorithm from Bioconductor [9] DESeq [10] then normalized using quantile normalization algorithm from Limma [11]. Following transformation and normalization, the data were analyzed using the Bioconductor Timecourse [12] package. Experimental Setup The first data analysis decisions must be made before any data are generated. The researchers must decide on the length of each read and whether the sequencing will be done in paired or single configurations. Clearly, generating longer reads and paired reads will provide more information. This, however, will need to be balanced with budgetary restrictions longer reads and paired reads will cost more. In some cases, it might come down to a choice of more replicates vs. longer and/or paired reads. As a rule, if the researcher is looking for gene expression analysis and is not particularly interested in alternative splicing, shorter single-read configuration should be adequate. However, if the experiment is done on well-annotated species (such as human or mouse) and the researcher is interested in evaluating expressions of individual isoforms, then longer paired-end reads will be preferred. In practice this means one of two possible configurations: 1. For gene expression analysis: 50 nucleotide single reads 2. For analysis of transcript isoforms: 100 nucleotides paired reads This decision must be made before libraries are prepared and will have a significant impact on all data analysis. Quality Check Data produced by NGS devices can be of varying quality depending on many factors, including quality of material used, library construction, as well as sequencing itself. While quality checks (QC) should be done at every step of this process, once the data have been delivered it is possible to evaluate each sample it also is possible to evaluate the quality of each sample using unbiased computational tools. Within Lumenogix NGS, we utilize FASTQC [8], a popular application that evaluates the quality of the data based on 3

5 Figure 1: Per base data quality multiple metrics. In case of poor quality data, e.g. Figure 1 two approaches could be taken: 1. Data could be filtered prior to analysis. This is the preferred approach when high data quality is required (SNP analysis and de-novo assembly). In this case, filtering means removal of low-quality reads from the data set. 2. Performing analysis with complete data sets. This is often the approach taken in most expression analysis experiments, especially when the data quality are consistent between samples. Mapping Reads to the Genome Several excellent tools exist for mapping RNA reads to genomes. A special feature of these aligners is the ability to handle splice junctions. Since we are mapping spliced RNA transcripts to genome, the algorithm must be aware and handle situations where a read is aligned to two (or more) locations with significant gaps in between. Within Lumenogix NGS we utilize TopHat [6], one of the popular algorithms for mapping RNASeq data. The algorithm 4

6 Figure 2: Lumenogix NGS TopHat submission screen requires the reference genome to be established and allows users to fine-tune parameters (Figure 2). Please note that in this example, we are handling single-end reads. After the mapping is complete, the algorithm will generate files that contain alignment information for each read. In most cases, these files will be in SAM or BAM format [13]. Please note that SAM is text-based, human readable, format while BAM is compressed binary representation of SAM. These files are very large, so in most cases only the BAM format is retained. This is acceptable since it is relatively easy to convert from BAM to SAM using Samtools [13]. After mapping additional statistical information will be obtained, including the count and percentage of reads that was successfully aligned. However, it should be stated that for TopHat, this statistic is inaccurate. This is a known TopHat issue. In addition to the alignment information for each read, TopHat also produces information on identified splice junctions (Figure 3). Both SAM/BAM as well as BED [14] format used to store splice junctions are well known and may be used in various tools. 5

7 Figure 3: Lumenogix NGS TopHat results screen Quantification Once the reads have been aligned to the reference genome, the information can be used to quantify expression of genes and transcripts. The most popular quantification approach is to use one of the normalizing quantification algorithms, such as Cufflinks [6]. Cufflinks is an extremely popular algorithm and was designed to be well integrated with TopHat. In this case, normalizing means that the intensity values will be scaled based on the length of transcript. This is done to adjust for the advantage that longer transcripts have over shorter transcripts. Quantification is done by counting the reads that aligned to a particular transcript. However, longer transcripts have an advantage there will be more reads aligning to longer transcripts than to shorter transcripts. Therefore, modern normalizing quantification algorithms produce intensity in Fragments Per Kilobase of exon per Million fragments mapped (FPKM) [6]. This is basically intensity normalized by transcript length. After computing intensity by transcript, the values are aggregated into gene-based intensity calculations. This is a very good way to quantify intensities when comparing expression of transcripts within samples. However, in our example we are comparing gene expressions in different samples. When comparing gene A in sample 6

8 Figure 4: Lumenogix NGS scatter plot of FPKM data Figure 5: Lumenogix NGS boxplot of intensities 1 to gene A in sample 2 (or transcript A.p1 in sample 1 to transcript A.p1 in sample 2), the lengths of these elements actually are the same. Furthermore, normalizing algorithms occasionally run into trouble when they are unable to unambiguously identify a transcript, resulting in lost data (Figure 4). Another way to do quantification is using the raw hit count approach, such as htseq-count [8]. This type of algorithm will not normalize the data based on transcript length and also will calculate gene expression directly (not by aggregating transcript expression). For maximum flexibility, Lumenogix NGS offers both normalizing and raw hit-count quantification algorithms. Once the quantification has been performed (using either method) a data matrix (meaning a table of intensities) can be constructed and the distribution (or shape) of data visualized using standard statistical tools (Figures 5 and 6). Variance Reduction The purpose of the variance reduction step (also called transformation or scaling) is to transform the data into form that can be used in statistical analysis, meaning into a Normal distribution. Different algorithms may be used, depending on how the data have been quantified. For FPKM (normalized) data, standard log base 2 (log2) transformation appears to work well. For counting data that were produced using raw hit-count quantification, a Bioconductor-based application called DESeq [10] provides a specialized variance reduction function (Figure 7). 7

9 Figure 6: Lumenogix NGS samples classification using unsupervised hierarchical clustering Figure 7: Lumenogix NGS samples counting data transformed using DESeq variance reduction algorithm Normalization Normalization algorithms remove differences between samples that are due to technical (not biological) variations. Many different algorithms are available, including for example a popular quantile algorithm implemented in Limma [11] package (Figure 8). The final shape of the data matrix prior to expression analysis should be a reasonable approximation of the Normal distribution (Figure 9). Expression Analysis Once the data matrix has been constructed, transformed and normalized it is ready for expression analysis. Specifically, the goals for the pre-processing are: 1. Convert NGS reads data into intensity data. 2. Transform the resulting data matrix to achieve some approximation of normal distribution. 3. Normalize the data to remove technical (but not biological) differences from the samples. Once all these goals have been achieved, the actual expression analysis is relatively simple. A large number of existing algorithms can handle the 8

10 Figure 8: Lumenogix NGS samples counting data normalized using quantile normalization algorithm Figure 9: Lumenogix NGS density plot of the data matrix after variance reduction and normalization constructed data matrix. In this experiment we applied Timecourse [12] algorithm from the Bioconductor package. The algorithm required us to classify the samples based on time points (Figure 10). The result of this analysis is a list of genes ranked based on Tau a calculated value that estimates the odds of differential expression (Figure 11). It is not entirely accurate to refer to the resulting grid as a gene grid. This analysis actually can detect any kind of transcribed, annotated genomic element, including non-coding RNA. In this particular example, one of the differentially expressed elements was a small nucleolar RNA Me28S-A992 (Figure 12). Conclusion Existing algorithms for analyzing microarray gene expression data are widely accepted. Here we applied the Bioconductor [9] Timecourse [12] algorithm to variance stabilized [10]and normalized [11] gene expression data to demonstrating that these tools can also be used for processing expression data derived from sequencing reads. This approach offers a standardized analysis pipeline for expression data generated by high speed sequencing technologies. 9

11 Figure 10: Lumenogix NGS time course sample classification Figure 11: Lumenogix NGS time course gene grid 10

12 Figure 12: Lumenogix NGS expression of snorna:me28s-a992 over time [1] M. Demerec, Biology of Drosophila. Wiley, [2] V. Hartenstein, Atlas of Drosophila Development. Cold Spring Harbor Laboratory Press, 1 edition ed., Jan [3] S. E. Celniker, L. A. L. Dillon, M. B. Gerstein, K. C. Gunsalus, S. Henikoff, G. H. Karpen, M. Kellis, E. C. Lai, J. D. Lieb, D. M. MacAlpine, G. Micklem, F. Piano, M. Snyder, L. Stein, K. P. White, R. H. Waterston, and modencode Consortium, Unlocking the secrets of the genome, Nature, vol. 459, pp , June PMID: PMCID: PMC [4] Y. Kodama, E. Kaminuma, S. Saruhashi, K. Ikeo, H. Sugawara, Y. Tateno, and Y. Nakamura, Biological databases at DNA data bank of japan in the era of next-generation sequencing technologies, Advances in experimental medicine and biology, vol. 680, pp , PMID: [5] T. J. P. Hubbard, B. L. Aken, S. Ayling, B. Ballester, K. Beal, E. Bragin, S. Brent, Y. Chen, P. Clapham, L. Clarke, G. Coates, S. Fairley, S. Fitzgerald, J. Fernandez-Banet, L. Gordon, S. Graf, S. Haider, 11

13 M. Hammond, R. Holland, K. Howe, A. Jenkinson, N. Johnson, A. Kahari, D. Keefe, S. Keenan, R. Kinsella, F. Kokocinski, E. Kulesha, D. Lawson, I. Longden, K. Megy, P. Meidl, B. Overduin, A. Parker, B. Pritchard, D. Rios, M. Schuster, G. Slater, D. Smedley, W. Spooner, G. Spudich, S. Trevanion, A. Vilella, J. Vogel, S. White, S. Wilder, A. Zadissa, E. Birney, F. Cunningham, V. Curwen, R. Durbin, X. M. Fernandez-Suarez, J. Herrero, A. Kasprzyk, G. Proctor, J. Smith, S. Searle, and P. Flicek, Ensembl 2009, Nucleic acids research, vol. 37, pp. D , Jan PMID: PMCID: PMC [6] C. Trapnell, L. Pachter, and S. L. Salzberg, TopHat: discovering splice junctions with RNA-Seq, Bioinformatics (Oxford, England), vol. 25, pp , May PMID: PMCID: PMC [7] B. Langmead, C. Trapnell, M. Pop, and S. L. Salzberg, Ultrafast and memory-efficient alignment of short DNA sequences to the human genome, Genome biology, vol. 10, no. 3, p. R25, PMID: PMCID: PMC [8] C. Popp, W. Dean, S. Feng, S. J. Cokus, S. Andrews, M. Pellegrini, S. E. Jacobsen, and W. Reik, Genome-wide erasure of DNA methylation in mouse primordial germ cells is affected by AID deficiency, Nature, vol. 463, pp , Feb PMID: PMCID: PMC [9] R. C. Gentleman, V. J. Carey, D. M. Bates, B. Bolstad, M. Dettling, S. Dudoit, B. Ellis, L. Gautier, Y. Ge, J. Gentry, K. Hornik, T. Hothorn, W. Huber, S. Iacus, R. Irizarry, F. Leisch, C. Li, M. Maechler, A. J. Rossini, G. Sawitzki, C. Smith, G. Smyth, L. Tierney, J. Y. H. Yang, and J. Zhang, Bioconductor: open software development for computational biology and bioinformatics, Genome biology, vol. 5, no. 10, p. R80, PMID: PMCID: PMC [10] S. Anders and W. Huber, Differential expression analysis for sequence count data, Genome biology, vol. 11, no. 10, p. R106, PMID: PMCID: PMC [11] G. K. Smyth, Linear models and empirical bayes methods for assessing differential expression in microarray experiments, Statistical applications in genetics and molecular biology, vol. 3, p. Article3, PMID:

14 [12] Y. C. Tai and T. P. Speed, On gene ranking using replicated microarray time course data, Biometrics, vol. 65, pp , Mar PMID: [13] H. Li, B. Handsaker, A. Wysoker, T. Fennell, J. Ruan, N. Homer, G. Marth, G. Abecasis, R. Durbin, and 1000 Genome Project Data Processing Subgroup, The sequence Alignment/Map format and SAMtools, Bioinformatics (Oxford, England), vol. 25, pp , Aug PMID: PMCID: PMC [14] A. R. Quinlan and I. M. Hall, BEDTools: a flexible suite of utilities for comparing genomic features, Bioinformatics (Oxford, England), vol. 26, pp , Mar PMID: PMCID: PMC

Browsing Genomes with Ensembl

Browsing Genomes with Ensembl April Feb 2006 2007 Browsing Genomes with Ensembl Joint project Ensembl - Project EMBL European Bioinformatics Institute (EBI) Wellcome Trust Sanger Institute Produce accurate, automatic genome annotation

More information

Analysis Datasheet Exosome RNA-seq Analysis

Analysis Datasheet Exosome RNA-seq Analysis Analysis Datasheet Exosome RNA-seq Analysis Overview RNA-seq is a high-throughput sequencing technology that provides a genome-wide assessment of the RNA content of an organism, tissue, or cell. Small

More information

CRAC: An integrated approach to analyse RNA-seq reads Additional File 4 Results on real RNA-seq data.

CRAC: An integrated approach to analyse RNA-seq reads Additional File 4 Results on real RNA-seq data. CRAC: An integrated approach to analyse RNA-seq reads Additional File 4 Results on real RNA-seq data. Nicolas Philippe and Mikael Salson and Thérèse Commes and Eric Rivals February 13, 2013 1 The real

More information

Applications of short-read

Applications of short-read Applications of short-read sequencing: RNA-Seq and ChIP-Seq BaRC Hot Topics March 2013 George Bell, Ph.D. http://jura.wi.mit.edu/bio/education/hot_topics/ Sequencing applications RNA-Seq includes experiments

More information

Sequencing applications. Today's outline. Hands-on exercises. Applications of short-read sequencing: RNA-Seq and ChIP-Seq

Sequencing applications. Today's outline. Hands-on exercises. Applications of short-read sequencing: RNA-Seq and ChIP-Seq Sequencing applications Applications of short-read sequencing: RNA-Seq and ChIP-Seq BaRC Hot Topics March 2013 George Bell, Ph.D. http://jura.wi.mit.edu/bio/education/hot_topics/ RNA-Seq includes experiments

More information

SAS Microarray Solution for the Analysis of Microarray Data. Susanne Schwenke, Schering AG Dr. Richardus Vonk, Schering AG

SAS Microarray Solution for the Analysis of Microarray Data. Susanne Schwenke, Schering AG Dr. Richardus Vonk, Schering AG for the Analysis of Microarray Data Susanne Schwenke, Schering AG Dr. Richardus Vonk, Schering AG Overview Challenges in Microarray Data Analysis Software for Microarray Data Analysis SAS Scientific Discovery

More information

Next Generation Sequencing

Next Generation Sequencing Next Generation Sequencing Complete Report Catalogue # and Service: IR16001 rrna depletion (human, mouse, or rat) IR11081 Total RNA Sequencing (80 million reads, 2x75 bp PE) Xxxxxxx - xxxxxxxxxxxxxxxxxxxxxx

More information

Analysis of RNA-seq Data. Feb 8, 2017 Peikai CHEN (PHD)

Analysis of RNA-seq Data. Feb 8, 2017 Peikai CHEN (PHD) Analysis of RNA-seq Data Feb 8, 2017 Peikai CHEN (PHD) Outline What is RNA-seq? What can RNA-seq do? How is RNA-seq measured? How to process RNA-seq data: the basics How to visualize and diagnose your

More information

Alignment & Variant Discovery. J Fass UCD Genome Center Bioinformatics Core Tuesday June 17, 2014

Alignment & Variant Discovery. J Fass UCD Genome Center Bioinformatics Core Tuesday June 17, 2014 Alignment & Variant Discovery J Fass UCD Genome Center Bioinformatics Core Tuesday June 17, 2014 From reads to molecules Why align? Individual A Individual B ATGATAGCATCGTCGGGTGTCTGCTCAATAATAGTGCCGTATCATGCTGGTGTTATAATCGCCGCATGACATGATCAATGG

More information

SCALABLE, REPRODUCIBLE RNA-Seq

SCALABLE, REPRODUCIBLE RNA-Seq SCALABLE, REPRODUCIBLE RNA-Seq SCALABLE, REPRODUCIBLE RNA-Seq Advances in the RNA sequencing workflow, from sample preparation through data analysis, are enabling deeper and more accurate exploration

More information

Alignment. J Fass UCD Genome Center Bioinformatics Core Wednesday December 17, 2014

Alignment. J Fass UCD Genome Center Bioinformatics Core Wednesday December 17, 2014 Alignment J Fass UCD Genome Center Bioinformatics Core Wednesday December 17, 2014 From reads to molecules Why align? Individual A Individual B ATGATAGCATCGTCGGGTGTCTGCTCAATAATAGTGCCGTATCATGCTGGTGTTATAATCGCCGCATGACATGATCAATGG

More information

Introduction of RNA-Seq Analysis

Introduction of RNA-Seq Analysis Introduction of RNA-Seq Analysis Jiang Li, MS Bioinformatics System Engineer I Center for Quantitative Sciences(CQS) Vanderbilt University September 21, 2012 Goal of this talk 1. Act as a practical resource

More information

Genomes with Ensembl. Dr. Giulietta Spudich CNIO, of 21

Genomes with Ensembl. Dr. Giulietta Spudich CNIO, of 21 Genomes with Ensembl Dr. Giulietta Spudich CNIO, 2008 1 of 21 Overview of the day Introduction and website walk-through Hands on exercises (the browser) Introduction to BioMart (data mining) Variations

More information

Course Presentation. Ignacio Medina Presentation

Course Presentation. Ignacio Medina Presentation Course Index Introduction Agenda Analysis pipeline Some considerations Introduction Who we are Teachers: Marta Bleda: Computational Biologist and Data Analyst at Department of Medicine, Addenbrooke's Hospital

More information

RNA-Seq Analysis. Simon Andrews, Laura v

RNA-Seq Analysis. Simon Andrews, Laura v RNA-Seq Analysis Simon Andrews, Laura Biggins simon.andrews@babraham.ac.uk @simon_andrews v2018-10 RNA-Seq Libraries rrna depleted mrna Fragment u u u u NNNN Random prime + RT 2 nd strand synthesis (+

More information

Background Wikipedia Lee and Mahadavan, JCB, 2009 History (Platform Comparison) P Park, Nature Review Genetics, 2009 P Park, Nature Reviews Genetics, 2009 Rozowsky et al., Nature Biotechnology, 2009

More information

Analysis of data from high-throughput molecular biology experiments Lecture 6 (F6, RNA-seq ),

Analysis of data from high-throughput molecular biology experiments Lecture 6 (F6, RNA-seq ), Analysis of data from high-throughput molecular biology experiments Lecture 6 (F6, RNA-seq ), 2012-01-26 What is a gene What is a transcriptome History of gene expression assessment RNA-seq RNA-seq analysis

More information

RNAseq Differential Gene Expression Analysis Report

RNAseq Differential Gene Expression Analysis Report RNAseq Differential Gene Expression Analysis Report Customer Name: Institute/Company: Project: NGS Data: Bioinformatics Service: IlluminaHiSeq2500 2x126bp PE Differential gene expression analysis Sample

More information

Introduction to RNAseq Analysis. Milena Kraus Apr 18, 2016

Introduction to RNAseq Analysis. Milena Kraus Apr 18, 2016 Introduction to RNAseq Analysis Milena Kraus Apr 18, 2016 Agenda What is RNA sequencing used for? 1. Biological background 2. From wet lab sample to transcriptome a. Experimental procedure b. Raw data

More information

RNA-sequencing. Next Generation sequencing analysis Anne-Mette Bjerregaard. Center for biological sequence analysis (CBS)

RNA-sequencing. Next Generation sequencing analysis Anne-Mette Bjerregaard. Center for biological sequence analysis (CBS) RNA-sequencing Next Generation sequencing analysis 2016 Anne-Mette Bjerregaard Center for biological sequence analysis (CBS) Terms and definitions TRANSCRIPTOME The full set of RNA transcripts and their

More information

Analysis of RNA-seq Data. Bernard Pereira

Analysis of RNA-seq Data. Bernard Pereira Analysis of RNA-seq Data Bernard Pereira The many faces of RNA-seq Applications Discovery Find new transcripts Find transcript boundaries Find splice junctions Comparison Given samples from different experimental

More information

Standard Data Analysis Report Agilent Gene Expression Service

Standard Data Analysis Report Agilent Gene Expression Service Standard Data Analysis Report Agilent Gene Expression Service Experiment: S534662 Date: 2011-01-01 Prepared for: Dr. Researcher Genomic Sciences Lab Prepared by S534662 Standard Data Analysis Report 2011-01-01

More information

Quantifying gene expression

Quantifying gene expression Quantifying gene expression Genome GTF (annotation)? Sequence reads FASTQ FASTQ (+reference transcriptome index) Quality control FASTQ Alignment to Genome: HISAT2, STAR (+reference genome index) (known

More information

Introduction to NGS analyses

Introduction to NGS analyses Introduction to NGS analyses Giorgio L Papadopoulos Institute of Molecular Biology and Biotechnology Bioinformatics Support Group 04/12/2015 Papadopoulos GL (IMBB, FORTH) IMBB NGS Seminar 04/12/2015 1

More information

Mapping Next Generation Sequence Reads. Bingbing Yuan Dec. 2, 2010

Mapping Next Generation Sequence Reads. Bingbing Yuan Dec. 2, 2010 Mapping Next Generation Sequence Reads Bingbing Yuan Dec. 2, 2010 1 What happen if reads are not mapped properly? Some data won t be used, thus fewer reads would be aligned. Reads are mapped to the wrong

More information

Sanger vs Next-Gen Sequencing

Sanger vs Next-Gen Sequencing Tools and Algorithms in Bioinformatics GCBA815/MCGB815/BMI815, Fall 2017 Week-8: Next-Gen Sequencing RNA-seq Data Analysis Babu Guda, Ph.D. Professor, Genetics, Cell Biology & Anatomy Director, Bioinformatics

More information

Introduction to RNA-Seq. David Wood Winter School in Mathematics and Computational Biology July 1, 2013

Introduction to RNA-Seq. David Wood Winter School in Mathematics and Computational Biology July 1, 2013 Introduction to RNA-Seq David Wood Winter School in Mathematics and Computational Biology July 1, 2013 Abundance RNA is... Diverse Dynamic Central DNA rrna Epigenetics trna RNA mrna Time Protein Abundance

More information

Introduction to Short Read Alignment. UCD Genome Center Bioinformatics Core Tuesday 14 June 2016

Introduction to Short Read Alignment. UCD Genome Center Bioinformatics Core Tuesday 14 June 2016 Introduction to Short Read Alignment UCD Genome Center Bioinformatics Core Tuesday 14 June 2016 From reads to molecules Why align? Individual A Individual B ATGATAGCATCGTCGGGTGTCTGCTCAATAATAGTGCCGTATCATGCTGGTGTTATAATCGCCGCATGACATGATCAATGG

More information

Long and short/small RNA-seq data analysis

Long and short/small RNA-seq data analysis Long and short/small RNA-seq data analysis GEF5, 4.9.2015 Sami Heikkinen, PhD, Dos. Topics 1. RNA-seq in a nutshell 2. Long vs short/small RNA-seq 3. Bioinformatic analysis work flows GEF5 / Heikkinen

More information

Transcriptomics analysis with RNA seq: an overview Frederik Coppens

Transcriptomics analysis with RNA seq: an overview Frederik Coppens Transcriptomics analysis with RNA seq: an overview Frederik Coppens Platforms Applications Analysis Quantification RNA content Platforms Platforms Short (few hundred bases) Long reads (multiple kilobases)

More information

10/06/2014. RNA-Seq analysis. With reference assembly. Cormier Alexandre, PhD student UMR8227, Algal Genetics Group

10/06/2014. RNA-Seq analysis. With reference assembly. Cormier Alexandre, PhD student UMR8227, Algal Genetics Group RNA-Seq analysis With reference assembly Cormier Alexandre, PhD student UMR8227, Algal Genetics Group Summary 2 Typical RNA-seq workflow Introduction Reference genome Reference transcriptome Reference

More information

Bioinformatics in next generation sequencing projects

Bioinformatics in next generation sequencing projects Bioinformatics in next generation sequencing projects Rickard Sandberg Assistant Professor Department of Cell and Molecular Biology Karolinska Institutet May 2013 Standard sequence library generation Illumina

More information

From reads to results: differential. Alicia Oshlack Head of Bioinformatics

From reads to results: differential. Alicia Oshlack Head of Bioinformatics From reads to results: differential expression analysis with ihrna seq Alicia Oshlack Head of Bioinformatics Murdoch Childrens Research Institute Benefits and opportunities ii of RNA seq All transcripts

More information

Benchmarking of RNA-seq data processing pipelines using whole transcriptome qpcr expression data

Benchmarking of RNA-seq data processing pipelines using whole transcriptome qpcr expression data Benchmarking of RNA-seq data processing pipelines using whole transcriptome qpcr expression data Jan Hellemans 7th international qpcr & NGS Event - Freising March 24 th, 2015 Therapeutics lncrna oncology

More information

Whole Transcriptome Analysis of Illumina RNA- Seq Data. Ryan Peters Field Application Specialist

Whole Transcriptome Analysis of Illumina RNA- Seq Data. Ryan Peters Field Application Specialist Whole Transcriptome Analysis of Illumina RNA- Seq Data Ryan Peters Field Application Specialist Partek GS in your NGS Pipeline Your Start-to-Finish Solution for Analysis of Next Generation Sequencing Data

More information

Statistical Genomics and Bioinformatics Workshop. Genetic Association and RNA-Seq Studies

Statistical Genomics and Bioinformatics Workshop. Genetic Association and RNA-Seq Studies Statistical Genomics and Bioinformatics Workshop: Genetic Association and RNA-Seq Studies RNA Seq and Differential Expression Analysis Brooke L. Fridley, PhD University of Kansas Medical Center 1 Next-generation

More information

VM origin. Okeanos: Image Trinity_U16 (upgrade to Ubuntu16.04, thanks to Alexandros Dimopoulos) X2go: LXDE

VM origin. Okeanos: Image Trinity_U16 (upgrade to Ubuntu16.04, thanks to Alexandros Dimopoulos) X2go: LXDE VM origin Okeanos: Image Trinity_U16 (upgrade to Ubuntu16.04, thanks to Alexandros Dimopoulos) X2go: LXDE NGS intro + Genome-Based Transcript Reconstruction and Analysis Using RNA-Seq Data Based on material

More information

RNA

RNA RNA sequencing Michael Inouye Baker Heart and Diabetes Institute Univ of Melbourne / Monash Univ Summer Institute in Statistical Genetics 2017 Integrative Genomics Module Seattle @minouye271 www.inouyelab.org

More information

RNA-Sequencing analysis

RNA-Sequencing analysis RNA-Sequencing analysis Markus Kreuz 25. 04. 2012 Institut für Medizinische Informatik, Statistik und Epidemiologie Content: Biological background Overview transcriptomics RNA-Seq RNA-Seq technology Challenges

More information

measuring gene expression December 5, 2017

measuring gene expression December 5, 2017 measuring gene expression December 5, 2017 transcription a usually short-lived RNA copy of the DNA is created through transcription RNA is exported to the cytoplasm to encode proteins some types of RNA

More information

ChIP-seq and RNA-seq

ChIP-seq and RNA-seq ChIP-seq and RNA-seq Biological Goals Learn how genomes encode the diverse patterns of gene expression that define each cell type and state. Protein-DNA interactions (ChIPchromatin immunoprecipitation)

More information

Optimal Calculation of RNA-Seq Fold-Change Values

Optimal Calculation of RNA-Seq Fold-Change Values International Journal of Computational Bioinformatics and In Silico Modeling Vol. 2, No. 6 (2013): 285-292 Research Article Open Access ISSN: 2320-0634 Optimal Calculation of RNA-Seq Fold-Change Values

More information

Galaxy Platform For NGS Data Analyses

Galaxy Platform For NGS Data Analyses Galaxy Platform For NGS Data Analyses Weihong Yan wyan@chem.ucla.edu Collaboratory Web Site http://qcb.ucla.edu/collaboratory http://collaboratory.lifesci.ucla.edu Workshop Outline ü Day 1 UCLA galaxy

More information

RNA-Seq Module 2 From QC to differential gene expression.

RNA-Seq Module 2 From QC to differential gene expression. RNA-Seq Module 2 From QC to differential gene expression. Ying Zhang Ph.D, Informatics Analyst Research Informatics Support System (RISS) MSI Apr. 24, 2012 RNA-Seq Tutorials Tutorial 1: Introductory (Mar.

More information

High performance sequencing and gene expression quantification

High performance sequencing and gene expression quantification High performance sequencing and gene expression quantification Ana Conesa Genomics of Gene Expression Lab Centro de Investigaciones Príncipe Felipe Valencia aconesa@cipf.es Next Generation Sequencing NGS

More information

BST 226 Statistical Methods for Bioinformatics David M. Rocke. March 10, 2014 BST 226 Statistical Methods for Bioinformatics 1

BST 226 Statistical Methods for Bioinformatics David M. Rocke. March 10, 2014 BST 226 Statistical Methods for Bioinformatics 1 BST 226 Statistical Methods for Bioinformatics David M. Rocke March 10, 2014 BST 226 Statistical Methods for Bioinformatics 1 NGS Technologies Illumina Sequencing HiSeq 2500 & MiSeq PacBio Sequencing PacBio

More information

Galaxy for Next Generation Sequencing 初探次世代序列分析平台 蘇聖堯 2013/9/12

Galaxy for Next Generation Sequencing 初探次世代序列分析平台 蘇聖堯 2013/9/12 Galaxy for Next Generation Sequencing 初探次世代序列分析平台 蘇聖堯 2013/9/12 What s Galaxy? Bringing Developers And Biologists Together. Reproducible Science Is Our Goal An open, web-based platform for data intensive

More information

RNA-seq Data Analysis

RNA-seq Data Analysis Lecture 3. Clustering; Function/Pathway Enrichment analysis RNA-seq Data Analysis Qi Sun Bioinformatics Facility Biotechnology Resource Center Cornell University Lecture 1. Map RNA-seq read to genome Lecture

More information

Sequence Analysis 2RNA-Seq

Sequence Analysis 2RNA-Seq Sequence Analysis 2RNA-Seq Lecture 10 2/21/2018 Instructor : Kritika Karri kkarri@bu.edu Transcriptome Entire set of RNA transcripts in a given cell for a specific developmental stage or physiological

More information

Introduction to RNA-Seq in GeneSpring NGS Software

Introduction to RNA-Seq in GeneSpring NGS Software Introduction to RNA-Seq in GeneSpring NGS Software Dipa Roy Choudhury, Ph.D. Strand Scientific Intelligence and Agilent Technologies Learn more at www.genespring.com Introduction to RNA-Seq In a few years,

More information

SCIENCE CHINA Life Sciences. Comparative analysis of de novo transcriptome assembly

SCIENCE CHINA Life Sciences. Comparative analysis of de novo transcriptome assembly SCIENCE CHINA Life Sciences SPECIAL TOPIC February 2013 Vol.56 No.2: 156 162 RESEARCH PAPER doi: 10.1007/s11427-013-4444-x Comparative analysis of de novo transcriptome assembly CLARKE Kaitlin 1, YANG

More information

RNA-Seq with the Tuxedo Suite

RNA-Seq with the Tuxedo Suite RNA-Seq with the Tuxedo Suite Monica Britton, Ph.D. Sr. Bioinformatics Analyst September 2015 Workshop The Basic Tuxedo Suite References Trapnell C, et al. 2009 TopHat: discovering splice junctions with

More information

A pipeline for ChIP-seq data analysis (Prot 56)

A pipeline for ChIP-seq data analysis (Prot 56) A pipeline for ChIP-seq data analysis (Prot 56) Ruhi Ali 1, Florence M.G. Cavalli 1, Juan M. Vaquerizas 1 and Nicholas M. Luscombe 2,3,4. 1. European Bioinformatics Institute. Wellcome Trust Genome Campus,

More information

Eucalyptus gene assembly

Eucalyptus gene assembly Eucalyptus gene assembly ACGT Plant Biotechnology meeting Charles Hefer Bioinformatics and Computational Biology Unit University of Pretoria October 2011 About Eucalyptus Most valuable and widely planted

More information

Positive Selection of Tyrosine Loss in Metazoan Evolution

Positive Selection of Tyrosine Loss in Metazoan Evolution www.sciencemag.org/cgi/content/full/1174301/dc1 Supporting Online Material for Positive Selection of Tyrosine Loss in Metazoan Evolution Chris Soon Heng Tan, Adrian Pasculescu, Wendell A. Lim, Tony Pawson,*

More information

Transcriptome analysis

Transcriptome analysis Statistical Bioinformatics: Transcriptome analysis Stefan Seemann seemann@rth.dk University of Copenhagen April 11th 2018 Outline: a) How to assess the quality of sequencing reads? b) How to normalize

More information

ChIP-seq and RNA-seq. Farhat Habib

ChIP-seq and RNA-seq. Farhat Habib ChIP-seq and RNA-seq Farhat Habib fhabib@iiserpune.ac.in Biological Goals Learn how genomes encode the diverse patterns of gene expression that define each cell type and state. Protein-DNA interactions

More information

Differential expression analysis for sequencing count data. Simon Anders

Differential expression analysis for sequencing count data. Simon Anders Differential expression analysis for sequencing count data Simon Anders Two applications of RNA-Seq Discovery find new transcripts find transcript boundaries find splice junctions Comparison Given samples

More information

NGS Data Analysis and Galaxy

NGS Data Analysis and Galaxy NGS Data Analysis and Galaxy University of Pretoria Pretoria, South Africa 14-18 October 2013 Dave Clements, Emory University http://galaxyproject.org/ Fourie Joubert, Burger van Jaarsveld Bioinformatics

More information

RNA Seq: Methods and Applica6ons. Prat Thiru

RNA Seq: Methods and Applica6ons. Prat Thiru RNA Seq: Methods and Applica6ons Prat Thiru 1 Outline Intro to RNA Seq Biological Ques6ons Comparison with Other Methods RNA Seq Protocol RNA Seq Applica6ons Annota6on Quan6fica6on Other Applica6ons Expression

More information

RNAseq Applications in Genome Studies. Alexander Kanapin, PhD Wellcome Trust Centre for Human Genetics, University of Oxford

RNAseq Applications in Genome Studies. Alexander Kanapin, PhD Wellcome Trust Centre for Human Genetics, University of Oxford RNAseq Applications in Genome Studies Alexander Kanapin, PhD Wellcome Trust Centre for Human Genetics, University of Oxford RNAseq Protocols Next generation sequencing protocol cdna, not RNA sequencing

More information

De novo assembly in RNA-seq analysis.

De novo assembly in RNA-seq analysis. De novo assembly in RNA-seq analysis. Joachim Bargsten Wageningen UR/PRI/Plant Breeding October 2012 Motivation Transcriptome sequencing (RNA-seq) Gene expression / differential expression Reconstruct

More information

Analysis of RNA-seq Data

Analysis of RNA-seq Data Analysis of RNA-seq Data A physicist and an engineer are in a hot-air balloon. Soon, they find themselves lost in a canyon somewhere. They yell out for help: "Helllloooooo! Where are we?" 15 minutes later,

More information

measuring gene expression December 11, 2018

measuring gene expression December 11, 2018 measuring gene expression December 11, 2018 Intervening Sequences (introns): how does the cell get rid of them? Splicing!!! Highly conserved ribonucleoprotein complex recognizes intron/exon junctions and

More information

less sensitive than RNA-seq but more robust analysis pipelines expensive but quantitiatve standard but typically not high throughput

less sensitive than RNA-seq but more robust analysis pipelines expensive but quantitiatve standard but typically not high throughput Chapter 11: Gene Expression The availability of an annotated genome sequence enables massively parallel analysis of gene expression. The expression of all genes in an organism can be measured in one experiment.

More information

RNA-SEQUENCING ANALYSIS

RNA-SEQUENCING ANALYSIS RNA-SEQUENCING ANALYSIS Joseph Powell SISG- 2018 CONTENTS Introduction to RNA sequencing Data structure Analyses Transcript counting Alternative splicing Allele specific expression Discovery APPLICATIONS

More information

Bioinformatics for Biologists

Bioinformatics for Biologists Bioinformatics for Biologists Microarray Data Analysis. Lecture 1. Fran Lewitter, Ph.D. Director Bioinformatics and Research Computing Whitehead Institute Outline Introduction Working with microarray data

More information

Session 8. Differential gene expression analysis using RNAseq data

Session 8. Differential gene expression analysis using RNAseq data Functional and Comparative Genomics 2018 Session 8. Differential gene expression analysis using RNAseq data Tutors: Hrant Hovhannisyan, PhD student, email: grant.hovhannisyan@gmail.com Uciel Chorostecki,

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 five Alternative splicing Assembly RNA edits Alternative splicing

More information

1. Introduction Gene regulation Genomics and genome analyses

1. Introduction Gene regulation Genomics and genome analyses 1. Introduction Gene regulation Genomics and genome analyses 2. Gene regulation tools and methods Regulatory sequences and motif discovery TF binding sites Databases 3. Technologies Microarrays Deep sequencing

More information

GeneScissors: a comprehensive approach to detecting and correcting spurious transcriptome inference owing to RNA-seq reads misalignment

GeneScissors: a comprehensive approach to detecting and correcting spurious transcriptome inference owing to RNA-seq reads misalignment GeneScissors: a comprehensive approach to detecting and correcting spurious transcriptome inference owing to RNA-seq reads misalignment Zhaojun Zhang, Shunping Huang, Jack Wang, Xiang Zhang, Fernando Pardo

More information

Introduction to RNA sequencing

Introduction to RNA sequencing Introduction to RNA sequencing Bioinformatics perspective Olga Dethlefsen NBIS, National Bioinformatics Infrastructure Sweden November 2017 Olga (NBIS) RNA-seq November 2017 1 / 49 Outline Why sequence

More information

How to deal with your RNA-seq data?

How to deal with your RNA-seq data? How to deal with your RNA-seq data? Rachel Legendre, Thibault Dayris, Adrien Pain, Claire Toffano-Nioche, Hugo Varet École de bioinformatique AVIESAN-IFB 2017 1 Rachel Legendre Bioinformatics 27/11/2018

More information

Short Read Alignment to a Reference Genome

Short Read Alignment to a Reference Genome Short Read Alignment to a Reference Genome Shamith Samarajiwa CRUK Summer School in Bioinformatics Cambridge, September 2018 Aligning to a reference genome BWA Bowtie2 STAR GEM Pseudo Aligners for RNA-seq

More information

RNA-seq differential expression analysis. bioconnector.org/workshops

RNA-seq differential expression analysis. bioconnector.org/workshops RNA-seq differential expression analysis bioconnector.org/workshops Agenda Our data: source, pre-processing, structure Importing & exploring data Processing and analysis with DESeq2 - Structuring the count

More information

C3BI. VARIANTS CALLING November Pierre Lechat Stéphane Descorps-Declère

C3BI. VARIANTS CALLING November Pierre Lechat Stéphane Descorps-Declère C3BI VARIANTS CALLING November 2016 Pierre Lechat Stéphane Descorps-Declère General Workflow (GATK) software websites software bwa picard samtools GATK IGV tablet vcftools website http://bio-bwa.sourceforge.net/

More information

RNA-Seq data analysis course September 7-9, 2015

RNA-Seq data analysis course September 7-9, 2015 RNA-Seq data analysis course September 7-9, 2015 Peter-Bram t Hoen (LUMC) Jan Oosting (LUMC) Celia van Gelder, Jacintha Valk (BioSB) Anita Remmelzwaal (LUMC) Expression profiling DNA mrna protein Comprehensive

More information

Experimental Design. Sequencing. Data Quality Control. Read mapping. Differential Expression analysis

Experimental Design. Sequencing. Data Quality Control. Read mapping. Differential Expression analysis -Seq Analysis Quality Control checks Reproducibility Reliability -seq vs Microarray Higher sensitivity and dynamic range Lower technical variation Available for all species Novel transcript identification

More information

RNA-Seq analysis using R: Differential expression and transcriptome assembly

RNA-Seq analysis using R: Differential expression and transcriptome assembly RNA-Seq analysis using R: Differential expression and transcriptome assembly Beibei Chen Ph.D BICF 12/7/2016 Agenda Brief about RNA-seq and experiment design Gene oriented analysis Gene quantification

More information

Biology 644: Bioinformatics

Biology 644: Bioinformatics Processes Activation Repression Initiation Elongation.... Processes Splicing Editing Degradation Translation.... Transcription Translation DNA Regulators DNA-Binding Transcription Factors Chromatin Remodelers....

More information

RNA Sequencing Analyses & Mapping Uncertainty

RNA Sequencing Analyses & Mapping Uncertainty RNA Sequencing Analyses & Mapping Uncertainty Adam McDermaid 1/26 RNA-seq Pipelines Collection of tools for analyzing raw RNA-seq data Tier 1 Quality Check Data Trimming Tier 2 Read Alignment Assembly

More information

Parts of a standard FastQC report

Parts of a standard FastQC report FastQC FastQC, written by Simon Andrews of Babraham Bioinformatics, is a very popular tool used to provide an overview of basic quality control metrics for raw next generation sequencing data. There are

More information

oqtans A Galaxy-Integrated Workflow for Quantitative Transcriptome Analysis from NGS Data

oqtans A Galaxy-Integrated Workflow for Quantitative Transcriptome Analysis from NGS Data oqtans A Galaxy-Integrated Workflow for Quantitative Transcriptome Analysis from NGS Data Géraldine Jean Sebastian J. Schultheiss Machine Learning in Biology, Rätsch

More information

Integrative Genomics 1a. Introduction

Integrative Genomics 1a. Introduction 2016 Course Outline Integrative Genomics 1a. Introduction ggibson.gt@gmail.com http://www.cig.gatech.edu 1a. Experimental Design and Hypothesis Testing (GG) 1b. Normalization (GG) 2a. RNASeq (MI) 2b. Clustering

More information

Bioinformatics. Microarrays: designing chips, clustering methods. Fran Lewitter, Ph.D. Head, Biocomputing Whitehead Institute

Bioinformatics. Microarrays: designing chips, clustering methods. Fran Lewitter, Ph.D. Head, Biocomputing Whitehead Institute Bioinformatics Microarrays: designing chips, clustering methods Fran Lewitter, Ph.D. Head, Biocomputing Whitehead Institute Course Syllabus Jan 7 Jan 14 Jan 21 Jan 28 Feb 4 Feb 11 Feb 18 Feb 25 Sequence

More information

RNA-Seq Workshop AChemS Sunil K Sukumaran Monell Chemical Senses Center Philadelphia

RNA-Seq Workshop AChemS Sunil K Sukumaran Monell Chemical Senses Center Philadelphia RNA-Seq Workshop AChemS 2017 Sunil K Sukumaran Monell Chemical Senses Center Philadelphia Benefits & downsides of RNA-Seq Benefits: High resolution, sensitivity and large dynamic range Independent of prior

More information

A normalization method based on variance and median adjustment for massive mrna polyadenylation data

A normalization method based on variance and median adjustment for massive mrna polyadenylation data ISSN : 0974-7435 Volume 8 Issue 4 A normalization method based on variance and median adjustment for massive mrna polyadenylation data Guoli Ji, Ying Wang, Mingchen Wu, Yangzi Zhang, Xiaohui Wu* Department

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, August 2017 Friederike Dündar with Luce Skrabanek & Ceyda Durmaz Day 3 QC of aligned reads

More information

NEXT GENERATION SEQUENCING. Farhat Habib

NEXT GENERATION SEQUENCING. Farhat Habib NEXT GENERATION SEQUENCING HISTORY HISTORY Sanger Dominant for last ~30 years 1000bp longest read Based on primers so not good for repetitive or SNPs sites HISTORY Sanger Dominant for last ~30 years 1000bp

More information

NGS in Pathology Webinar

NGS in Pathology Webinar NGS in Pathology Webinar NGS Data Analysis March 10 2016 1 Topics for today s presentation 2 Introduction Next Generation Sequencing (NGS) is becoming a common and versatile tool for biological and medical

More information

Introduction to Bioinformatics and Gene Expression Technologies

Introduction to Bioinformatics and Gene Expression Technologies Introduction to Bioinformatics and Gene Expression Technologies Utah State University Fall 2017 Statistical Bioinformatics (Biomedical Big Data) Notes 1 1 Vocabulary Gene: hereditary DNA sequence at a

More information

Introduction to Bioinformatics and Gene Expression Technologies

Introduction to Bioinformatics and Gene Expression Technologies Vocabulary Introduction to Bioinformatics and Gene Expression Technologies Utah State University Fall 2017 Statistical Bioinformatics (Biomedical Big Data) Notes 1 Gene: Genetics: Genome: Genomics: hereditary

More information

Fully Automated Genome Annotation with Deep RNA Sequencing

Fully Automated Genome Annotation with Deep RNA Sequencing Fully Automated Genome Annotation with Deep RNA Sequencing Gunnar Rätsch Friedrich Miescher Laboratory of the Max Planck Society Tübingen, Germany Friedrich Miescher Laboratory of the Max Planck Society

More information

NGS Approaches to Epigenomics

NGS Approaches to Epigenomics I519 Introduction to Bioinformatics, 2013 NGS Approaches to Epigenomics Yuzhen Ye (yye@indiana.edu) School of Informatics & Computing, IUB Contents Background: chromatin structure & DNA methylation Epigenomic

More information

Bioinformatics Monthly Workshop Series. Speaker: Fan Gao, Ph.D Bioinformatics Resource Office The Picower Institute for Learning and Memory

Bioinformatics Monthly Workshop Series. Speaker: Fan Gao, Ph.D Bioinformatics Resource Office The Picower Institute for Learning and Memory Bioinformatics Monthly Workshop Series Speaker: Fan Gao, Ph.D Bioinformatics Resource Office The Picower Institute for Learning and Memory Schedule for Fall, 2015 PILM Bioinformatics Web Server (09/21/2015)

More information

RNA Sequencing: Experimental Planning and Data Analysis. Nadia Atallah September 12, 2018

RNA Sequencing: Experimental Planning and Data Analysis. Nadia Atallah September 12, 2018 RNA Sequencing: Experimental Planning and Data Analysis Nadia Atallah September 12, 2018 A Next Generation Sequencing (NGS) Refresher Became commercially available in 2005 Construction of a sequencing

More information

Top 5 Lessons Learned From MAQC III/SEQC

Top 5 Lessons Learned From MAQC III/SEQC Top 5 Lessons Learned From MAQC III/SEQC Weida Tong, Ph.D Division of Bioinformatics and Biostatistics, NCTR/FDA Weida.tong@fda.hhs.gov; 870 543 7142 1 MicroArray Quality Control (MAQC) An FDA led community

More information

Normalization. Getting the numbers comparable. DNA Microarray Bioinformatics - #27612

Normalization. Getting the numbers comparable. DNA Microarray Bioinformatics - #27612 Normalization Getting the numbers comparable The DNA Array Analysis Pipeline Question Experimental Design Array design Probe design Sample Preparation Hybridization Buy Chip/Array Image analysis Expression

More information

Collect, analyze and synthesize. Annotation. Annotation for D. virilis. Evidence Based Annotation. GEP goals: Evidence for Gene Models 08/22/2017

Collect, analyze and synthesize. Annotation. Annotation for D. virilis. Evidence Based Annotation. GEP goals: Evidence for Gene Models 08/22/2017 Annotation Annotation for D. virilis Chris Shaffer July 2012 l Big Picture of annotation and then one practical example l This technique may not be the best with other projects (e.g. corn, bacteria) l

More information

Exploring and Understanding ChIP-Seq data. Simon v

Exploring and Understanding ChIP-Seq data. Simon v Exploring and Understanding ChIP-Seq data Simon Andrews simon.andrews@babraham.ac.uk @simon_andrews v2018-03-02 Data Creation and Processing Starting DNA Fragmented DNA ChIPped DNA Mapped BAM File FastQ

More information