RNA SEQUENCING AND DATA ANALYSIS

Size: px
Start display at page:

Download "RNA SEQUENCING AND DATA ANALYSIS"

Transcription

1 RNA SEQUENCING AND DATA ANALYSIS

2 Length of mrna transcripts in the human genome 5,000 5,000 4,000 3,000 2,000 4,000 1, ,000 2,000 1, ,000 4,000 6,000 8,000 10,000

3 Length of mrna transcripts in the human genome 5,000 5,000 4,000 3,000 2,000 4,000 1, ,000 2,000 Insert size ~ 200bp 1, ,000 4,000 6,000 8,000 10,000

4 Overview of RNA sequencing protocol SEQUENCING Fwd read Reverse read Insert Read length: 48-76bp

5 Sequencing parameters Read Depth Minimum mapped reads: 10 million for quantitative analysis of mammalian transcriptome More reads needed for splicing variant discovery and differential comparison among samples Current output: million raw reads / lane Multiplex level: 4-12 libraries / lane recommended

6 All RNA is not the same Types of RNA:

7 All RNA is not the same Types of RNA: Messenger RNA Micro RNA Long non-coding RNA Ribosomal RNA

8 Methods for RNA enrichment prior to library construction Poly(A)-RNA selection By hybridization to oligo-dt beads mature mrna highly enriched efficient for quantification of gene expression level and so on limitation: 3 bias correlating with RNA degradation rrna depletion: by hybridization to bead-bound rrna probes rrna sequence-dependent and species-specific all non-rrna retained: premature mrna, long non-coding RNA Small RNA extraction: Specific kits required to retain small RNA Optional fine size-selection by gel or column

9 Different methods capture different types of RNA Messenger RNA Micro RNA Long non-coding RNA Ribosomal RNA Poly(A)-RNA selection rrna depletion Small RNA extraction

10 Different methods capture different types of RNA Poly(A)-RNA selection rrna depletion Messenger RNA X X Small RNA extraction Micro RNA X X Long non-coding RNA Ribosomal RNA X X

11 READ QUALITY Paraffin embedded vs fresh frozen Fresh Frozen

12 First step: alignment

13 Or: assembly, then alignment

14 Alignment versus assembly Assembly Trinity, Cufflinks, ABySS Particularly useful when no reference genome is available, like in bacterial transcriptomes Alignment Bowtie, BWA, Mosaic Maximum sensitivity, fewer false positives

15 RNA sequencing applications

16 RNA sequencing applications Quantification of transcript expression levels Detection of splice variation/different isoforms of the same gene Allele specific expression levels Strand specific expression levels Detection of fusion transcripts (such as BCR-ABL in CML) Detection of sequence variation (limited application) Validation of DNA sequence variants

17 RNA-seq expression levels are linear where microarrays get saturated or are insensitive Expression is measured as reads per kilobase per million (RPKM) or fragments per kilobase of exon per million fragments mapped (FPKM) to normalize for gene length and library size

18 In GBM, the gene EGFR is frequently targeted by intragenic deletions

19 viii deletion occurs in same domain as point mutations

20 Detecting EGFR transcript variants using RNA-seq data

21 SpliceSeq can detect splice variants

22 Allele-/Strand-specific RNA-seq Haplotype specific gene expression by computationally integrating RNAseq with DNA SNP data Strand-specific RNA-seq requires specific library preparation protocol Costs more Output more accurate, useful for analysis in absence of a reference genome

23 Identification of fusion transcripts Popular methods search for Read pairs that map to two different genes Need to correct for gene homology Reads that span fusion junction Split reads in half and align separate halfs Make a database of all possible fusion junctions and align full reads PRADA, MapSplice, TopHat

24 FGFR3-TACC3 fusion in GBM is the result of a local inversion FGFR3-TACC3

25 Fusion transcripts are often associated with copy number difference and genomic breakpoints FGFR3-TACC3 Copy number profile of two FGFR3-TACC3 cases in TCGA

26 6.4% of GBM harbors transcript fusions involving EGFR All fusions fall within the area of the EGFR amplification

27 Preprocessing.bam file [PAIRED END] INPUTS Fusion Module Config.txt.fastq files [YES NO ONLY] Discordant [location of read scripts and pair: reference files] Each end of the [END1 & END2] read pair maps uniquely to distinct Processing Module protein-coding genes. Expression & QC Module RNA-SeQC Fusion Module [YES NO ONLY] GUESS-ft [YES NO ONLY] -genea -geneb Read Alignment Remap alignments Combine two ends Quality Scores Recalibrate d OUTPUTS Fusion spanning reads: Chimeric read that maps a putative junction and the mate read maps to either GENE A or GENE B. RPKM & QC metrics Fusion Candidates Supervised search evidence Gene A Gene B

28 Structural transcript variants in low grade glioma RNA-seq data from 272 TCGA low grade glioma Fusion detection accuracy affected by: PRADA detected 1,843 fusion transcripts #mapped reads per sample Detected #fusion transcripts per sample

29 Validation of predicted transcript fusions Filtering out artifacts Homology E value larger than 0.01 (column Evalue) No mismatches in junction spanning reads 970/1,843 fusions filtered Count the number of partner genes for each individual gene Identify genes with fusions mapping to more than 10 different chromosome arms 509/970 fusions filtered

30 Define four tiers of fusion transcripts based on evidence Tier 1: At least 3 discordant read pairs (DSP), two perfect match junction spanning reads (JSR), and both partner genes only fused to one other partner gene in the same sample Tier 2: At least 2 DSP and 1 JSR, with a DNA breakpoint within 100kb window Use matching DNA copy number profile Tier 3: At least 2 DSP and 1 JSR, unique partner genes, with predicted junction consistent for all Tier 4: The rest

31 Validation of RNA fusions using output of BreakDancer BreakDancer detects DNA rearrangements in low pass sequencing data

32 Validation of RNA fusions using output of BreakDancer BreakDancer detects DNA rearrangements in low pass sequencing data

33 Variant detection From TCGA renal cell clear cell carcinoma project Approximately 30% of mutations are covered sufficiently to be detected at a validation rate of ~ 80%. Reverse transcriptase step to convert RNA to cdna complicates detection of RNA edits and mutations

34

35 RNA sequencing read alignment in PRADA Transcripts from same gene Reads are aligned to all possible transcripts Reads are also aligned to genome

36 RNA sequencing read alignment in PRADA Reads are aligned to all possible transcripts Reads are also aligned to genome Final and single placement for each read it determined by re-mapping

37 PRADA alignments advantages versus disadvantages Advantage: Alignment to DNA means mapping of unannotated transcripts Alignment to transcriptome means mapping across exon-exon junctions Disadvantage More conservative alignment than split-read

38 Preprocessing.bam file [PAIRED END].fastq files [END1 & END2] INPUTS Config.txt [location of scripts and reference files] Processing Module Expression & QC Module [YES NO ONLY] RNA-SeQC Fusion Module [YES NO ONLY] GUESS-ft [YES NO ONLY] -genea -geneb Read Alignment Remap alignments Combine two ends Quality Scores Recalibrate d OUTPUTS RPKM & QC metrics Fusion Candidates Supervised search evidence PRADA focuses on the analysis of paired-end RNA-sequencing data. Four modules: 1. Processing 2. Expression and Quality Control 3. Gene fusion 4. GUESS-ft: General User defined Supervised Search for fusion transcripts

39 Preprocessing.bam file [PAIRED END].fastq files [END1 & END2] INPUTS Config.txt [location of scripts and reference files] Processing Module Expression & QC Module [YES NO ONLY] RNA-SeQC Fusion Module GUESS-ft [YES NO ONLY] RNAseQC Process (java) [YES NO ONLY] -genea -geneb Read Alignment Remap alignments Combine two ends Quality Scores Recalibrate d Expression & QC Module OUTPUTS RNA-SeQC provides three types of quality control metrics: Read Counts Coverage Correlation RPKM Values at transcript level For longest transcript RPKM & QC metrics Fusion Candidates Supervised search evidence

40 Preprocessing.bam file [PAIRED END] INPUTS Fusion Module Config.txt.fastq files [YES NO ONLY] Discordant [location of read scripts and pair: reference files] Each end of the [END1 & END2] read pair maps uniquely to distinct Processing Module protein-coding genes. Expression & QC Module RNA-SeQC Fusion Module [YES NO ONLY] GUESS-ft [YES NO ONLY] -genea -geneb Read Alignment Remap alignments Combine two ends Quality Scores Recalibrate d OUTPUTS Fusion spanning reads: Chimeric read that maps a putative junction and the mate read maps to either GENE A or GENE B. RPKM & QC metrics Fusion Candidates Supervised search evidence Gene A Gene B

41 Preprocessing.bam file [PAIRED END].fastq files [END1 & END2] INPUTS Config.txt [location of scripts and reference files] Expression & QC Module [YES NO ONLY] Fusion Module [YES NO ONLY] GUESS-ft [YES NO ONLY] -genea -geneb Processing Module RNA-SeQC Read Alignment Remap alignments Combine two ends Quality Scores Recalibrate d OUTPUTS RPKM & QC metrics Fusion Candidates Supervised search evidence Implementation Results Samples processed >400 KIRC >170 GBM Works well in MDACC HPC* system PRADA-fusion module validation rate ~85 % (53 out of 62)

42 RNA sequencing in The Cancer Genome Atlas mrna: poly-a mrna purified from total RNA using poly-t oligo-attached magnetic beads mirna: Total RNA is mixed with oligo(dt) MicroBeads and loaded into MACS column, which is then placed on a MultiMACS separator. From the flow-through, small RNAs, including mirnas, are recovered by ethanol precipitation.

43 Detecting fusion transcripts in GBM

44 KIRC fusion results We analyzed 416 RNA-seq samples from clear cell renal carcinoma (ccrcc), available through TCGA. We identified 80 bona-fide fusion transcripts, 57 intrachromosomal 33 interchromosomal in 62 individual samples Recurrent fusions SFPQ-TFE3 (n=5, chr1-chrx) DHX33-NLRP1 (n=2, chr2) TRIP12-SLC16A14 (n=2, chr17) TFG-GRP128 (n=4, chr3)

45 KIRC fusion validation PRADA-fusion module validation rate (11 out of 13) ~85% RT-PCR and FISH assays TFE3-SFPQ was validated in three individual samples Sample ID 5 Gene 3 Gene Discordant Read Pairs Fusion Span Reads Fusion Junction (s) 5 Gene Chr 3 Gene Chr Validated? TCGA-AK A-02R TFE3 SFPQ chrx chr1 Yes TCGA-AK A-02R SFPQ TFE chr1 chrx Yes TCGA-A A-02R C6orf106 LRRC chr6 chr6 Yes TCGA-A A-02R CYP39A1 LEMD chr6 chr6 Yes TCGA-B A-02R FAM172A FHIT chr5 chr3 Yes TCGA-AK A-02R KIAA0802 LRRC chr18 chr1 Yes TCGA-B A-01R GORASP2 WIPF chr2 chr2 Yes TCGA-A A-02R ZNF193 MRPS18A chr6 chr6 Yes TCGA-A A-02R FTSJD2 GPX chr6 chr6 Yes TCGA-B A-01R KIAA0427 GRM chr18 chr6 No TCGA-B A-01R SLC36A1 TTC chr5 chr5 No

46 KIRC fusion validation: RT-PCR SFPQ-TFE3 (a) (b) Figure 2. RT-PCR results for TFE3 fusion validations for sample TCGA-AK (b) ions for sample TCGA-AK TFE3-SFPQ

47 KIRC fusion results We analyzed 416 RNA-seq samples from clear cell renal carcinoma (ccrcc), available through TCGA. We identified 80 bona-fide fusion transcripts, 57 intrachromosomal 33 interchromosomal in 62 individual samples Recurrent fusions SFPQ-TFE3 (n=5, chr1-chrx) DHX33-NLRP1 (n=2, chr2) TRIP12-SLC16A14 (n=2, chr17) TFG-GRP128 (n=4, chr3)

48 TFG-GRP128 has been reported in other cancers

49 TFG-GRP128 has been reported in other cancers

50 TFG-GRP128 has been reported in other cancers TCGA has 1,000s of RNA seq samples - how can we quickly scan many samples for the presence of this fusion?

51 Preprocessing.bam file [PAIRED END] INPUTS Supervised Search Module.fastq files Read Alignment Search Processing for fusion Module transcripts Remap alignments Config.txt [location of scripts and reference files] [END1 & END2] GUESS-ft: General User defined Supervised Use high quality mapping reads only, Checks read orientation fulfills fusion schema, allow up to one mismatch. Two read ends map to A and B respectively Summary report BAM Combine two ends GUESS-ft OUTPUTS Mapped to A or B Discordant reads A-B Quality Scores Recalibrate d Unmapped reads Junction DB Junction spanning reads Expression & QC Module [YES NO ONLY] RNA-SeQC Time consuming step Fusion Module [YES NO ONLY] RPKM & Fusion Parse QC metrics Candidates Unmapped reads with the other end mapping to A or B Map parsed reads to DB of all possible exon junctions List reads with one end map to junction, the other map to A or B GUESS-ft [YES NO ONLY] -genea -geneb Supervised search evidence

52 Identification of TFG-GRP128 fusion All available normal samples in cghub Subset of tumor samples selected based on RPKM expression pattern Table. Samples across cancer types Cancer Type # of normal samples # of tumor samples Bladder Urothelial Carcinoma [BLCA] 0 (0%) 2 (3.6%) Breast invasive carcinoma [BRCA] 1 (0.94%) 13 (1.6%) Head and Neck squamous cell carcinoma [HNSC] 0 (0%) 6 (2.3%) Kidney renal clear cell carcinoma [KIRC] 1 (1.5%) 5 (1.2%) Kidney renal papillary cell carcinoma [KIRP] 0 (0%) 1 (5.9%) Liver hepatocellular carcinoma [LIHC] 0 (0%) 1 (5.9%) Lung adenocarcinoma [LUAD] 0 (0%) 1 (0.79%) Lung squamous cell carcinoma [LUSC] 0 (0%) 9 (4%) Prostate adenocarcinoma [PRAD] 1 (14.3) 2 (1.9%) Thyroid carcinoma [THCA] 0 (0%) 2 (0.89%) * All performed by PRADA fusion module.

53 Tumors with the fusion have higher GPR128 expression levels RPKM expression pattern seen in KIRC tumors Fusion sample(s) Higher expression of GPR128 (activation) TCGA-B w/ 1 discordant read pair in tumor sample w/ 33 discordant read pair in matched normal

54 Thanks.

RNA SEQUENCING AND DATA ANALYSIS

RNA SEQUENCING AND DATA ANALYSIS RNA SEQUENCING AND DATA ANALYSIS Download slides and package http://odin.mdacc.tmc.edu/~rverhaak/package.zip http://odin.mdacc.tmc.edu/~rverhaak/rna-seqlecture.zip Overview Introduction into the topic

More information

genomics for systems biology / ISB2020 RNA sequencing (RNA-seq)

genomics for systems biology / ISB2020 RNA sequencing (RNA-seq) RNA sequencing (RNA-seq) Module Outline MO 13-Mar-2017 RNA sequencing: Introduction 1 WE 15-Mar-2017 RNA sequencing: Introduction 2 MO 20-Mar-2017 Paper: PMID 25954002: Human genomics. The human transcriptome

More information

Machine-Learning on Prediction of Inherited Genomic Susceptibility for 20 Major Cancers

Machine-Learning on Prediction of Inherited Genomic Susceptibility for 20 Major Cancers Machine-Learning on Prediction of Inherited Genomic Susceptibility for 20 Major Cancers Sung-Hou Kim University of California Berkeley, CA Global Bio Conference 2017 MFDS, Seoul, Korea June 28, 2017 Cancer

More information

Analysis of Massively Parallel Sequencing Data Application of Illumina Sequencing to the Genetics of Human Cancers

Analysis of Massively Parallel Sequencing Data Application of Illumina Sequencing to the Genetics of Human Cancers Analysis of Massively Parallel Sequencing Data Application of Illumina Sequencing to the Genetics of Human Cancers Gordon Blackshields Senior Bioinformatician Source BioScience 1 To Cancer Genetics Studies

More information

BWA alignment to reference transcriptome and genome. Convert transcriptome mappings back to genome space

BWA alignment to reference transcriptome and genome. Convert transcriptome mappings back to genome space Whole genome sequencing Whole exome sequencing BWA alignment to reference transcriptome and genome Convert transcriptome mappings back to genome space genomes Filter on MQ, distance, Cigar string Annotate

More information

Iso-Seq Method Updates and Target Enrichment Without Amplification for SMRT Sequencing

Iso-Seq Method Updates and Target Enrichment Without Amplification for SMRT Sequencing Iso-Seq Method Updates and Target Enrichment Without Amplification for SMRT Sequencing PacBio Americas User Group Meeting Sample Prep Workshop June.27.2017 Tyson Clark, Ph.D. For Research Use Only. Not

More information

Selective depletion of abundant RNAs to enable transcriptome analysis of lowinput and highly-degraded RNA from FFPE breast cancer samples

Selective depletion of abundant RNAs to enable transcriptome analysis of lowinput and highly-degraded RNA from FFPE breast cancer samples DNA CLONING DNA AMPLIFICATION & PCR EPIGENETICS RNA ANALYSIS Selective depletion of abundant RNAs to enable transcriptome analysis of lowinput and highly-degraded RNA from FFPE breast cancer samples LIBRARY

More information

Exploring TCGA Pan-Cancer Data at the UCSC Cancer Genomics Browser

Exploring TCGA Pan-Cancer Data at the UCSC Cancer Genomics Browser Exploring TCGA Pan-Cancer Data at the UCSC Cancer Genomics Browser Melissa S. Cline 1*, Brian Craft 1, Teresa Swatloski 1, Mary Goldman 1, Singer Ma 1, David Haussler 1, Jingchun Zhu 1 1 Center for Biomolecular

More information

Transcriptome Analysis

Transcriptome Analysis Transcriptome Analysis Data Preprocessing Sample Preparation Illumina Sequencing Demultiplexing Raw FastQ Reference Genome (fasta) Reference Annotation (GTF) Reference Genome Analysis Tophat Accepted hits

More information

Supplementary Figures

Supplementary Figures Supplementary Figures Supplementary Figure 1. Pan-cancer analysis of global and local DNA methylation variation a) Variations in global DNA methylation are shown as measured by averaging the genome-wide

More information

SUPPLEMENTARY INFORMATION

SUPPLEMENTARY INFORMATION doi: 1.138/nature8645 Physical coverage (x haploid genomes) 11 6.4 4.9 6.9 6.7 4.4 5.9 9.1 7.6 125 Neither end mapped One end mapped Chimaeras Correct Reads (million ns) 1 75 5 25 HCC1187 HCC1395 HCC1599

More information

Transcript reconstruction

Transcript reconstruction Transcript reconstruction Summary I Data types, file formats and utilities Annotation: Genomic regions Genes Peaks bedtools Alignment: Map reads BAM/SAM Samtools Aggregation: Summary files Wig (UCSC) TDF

More information

Nature Genetics: doi: /ng Supplementary Figure 1. Workflow of CDR3 sequence assembly from RNA-seq data.

Nature Genetics: doi: /ng Supplementary Figure 1. Workflow of CDR3 sequence assembly from RNA-seq data. Supplementary Figure 1 Workflow of CDR3 sequence assembly from RNA-seq data. Paired-end short-read RNA-seq data were mapped to human reference genome hg19, and unmapped reads in the TCR regions were extracted

More information

AVENIO family of NGS oncology assays ctdna and Tumor Tissue Analysis Kits

AVENIO family of NGS oncology assays ctdna and Tumor Tissue Analysis Kits AVENIO family of NGS oncology assays ctdna and Tumor Tissue Analysis Kits Accelerating clinical research Next-generation sequencing (NGS) has the ability to interrogate many different genes and detect

More information

File Name: Supplementary Information Description: Supplementary Figures and Supplementary Tables. File Name: Peer Review File Description:

File Name: Supplementary Information Description: Supplementary Figures and Supplementary Tables. File Name: Peer Review File Description: File Name: Supplementary Information Description: Supplementary Figures and Supplementary Tables File Name: Peer Review File Description: Primer Name Sequence (5'-3') AT ( C) RT-PCR USP21 F 5'-TTCCCATGGCTCCTTCCACATGAT-3'

More information

RNA-seq Introduction

RNA-seq Introduction RNA-seq Introduction DNA is the same in all cells but which RNAs that is present is different in all cells There is a wide variety of different functional RNAs Which RNAs (and sometimes then translated

More information

Session 4 Rebecca Poulos

Session 4 Rebecca Poulos The Cancer Genome Atlas (TCGA) & International Cancer Genome Consortium (ICGC) Session 4 Rebecca Poulos Prince of Wales Clinical School Introductory bioinformatics for human genomics workshop, UNSW 20

More information

Session 4 Rebecca Poulos

Session 4 Rebecca Poulos The Cancer Genome Atlas (TCGA) & International Cancer Genome Consortium (ICGC) Session 4 Rebecca Poulos Prince of Wales Clinical School Introductory bioinformatics for human genomics workshop, UNSW 28

More information

ncounter Assay Automated Process Immobilize and align reporter for image collecting and barcode counting ncounter Prep Station

ncounter Assay Automated Process Immobilize and align reporter for image collecting and barcode counting ncounter Prep Station ncounter Assay ncounter Prep Station Automated Process Hybridize Reporter to RNA Remove excess reporters Bind reporter to surface Immobilize and align reporter Image surface Count codes Immobilize and

More information

Ambient temperature regulated flowering time

Ambient temperature regulated flowering time Ambient temperature regulated flowering time Applications of RNAseq RNA- seq course: The power of RNA-seq June 7 th, 2013; Richard Immink Overview Introduction: Biological research question/hypothesis

More information

BIMM 143. RNA sequencing overview. Genome Informatics II. Barry Grant. Lecture In vivo. In vitro.

BIMM 143. RNA sequencing overview. Genome Informatics II. Barry Grant. Lecture In vivo. In vitro. RNA sequencing overview BIMM 143 Genome Informatics II Lecture 14 Barry Grant http://thegrantlab.org/bimm143 In vivo In vitro In silico ( control) Goal: RNA quantification, transcript discovery, variant

More information

Aliccia Bollig-Fischer, PhD Department of Oncology, Wayne State University Associate Director Genomics Core Molecular Therapeutics Program Karmanos

Aliccia Bollig-Fischer, PhD Department of Oncology, Wayne State University Associate Director Genomics Core Molecular Therapeutics Program Karmanos Aliccia Bollig-Fischer, PhD Department of Oncology, Wayne State University Associate Director Genomics Core Molecular Therapeutics Program Karmanos Cancer Institute Development of a multiplexed assay to

More information

ncounter Assay Automated Process Capture & Reporter Probes Bind reporter to surface Remove excess reporters Hybridize CodeSet to RNA

ncounter Assay Automated Process Capture & Reporter Probes Bind reporter to surface Remove excess reporters Hybridize CodeSet to RNA ncounter Assay Automated Process Hybridize CodeSet to RNA Remove excess reporters Bind reporter to surface Immobilize and align reporter Image surface Count codes mrna Capture & Reporter Probes slides

More information

MODULE 4: SPLICING. Removal of introns from messenger RNA by splicing

MODULE 4: SPLICING. Removal of introns from messenger RNA by splicing Last update: 05/10/2017 MODULE 4: SPLICING Lesson Plan: Title MEG LAAKSO Removal of introns from messenger RNA by splicing Objectives Identify splice donor and acceptor sites that are best supported by

More information

Supplementary Tables. Supplementary Figures

Supplementary Tables. Supplementary Figures Supplementary Files for Zehir, Benayed et al. Mutational Landscape of Metastatic Cancer Revealed from Prospective Clinical Sequencing of 10,000 Patients Supplementary Tables Supplementary Table 1: Sample

More information

Simple, rapid, and reliable RNA sequencing

Simple, rapid, and reliable RNA sequencing Simple, rapid, and reliable RNA sequencing RNA sequencing applications RNA sequencing provides fundamental insights into how genomes are organized and regulated, giving us valuable information about the

More information

TCGA. The Cancer Genome Atlas

TCGA. The Cancer Genome Atlas TCGA The Cancer Genome Atlas TCGA: History and Goal History: Started in 2005 by the National Cancer Institute (NCI) and the National Human Genome Research Institute (NHGRI) with $110 Million to catalogue

More information

Supplementary note: Comparison of deletion variants identified in this study and four earlier studies

Supplementary note: Comparison of deletion variants identified in this study and four earlier studies Supplementary note: Comparison of deletion variants identified in this study and four earlier studies Here we compare the results of this study to potentially overlapping results from four earlier studies

More information

Supplementary Figure 1: LUMP Leukocytes unmethylabon to infer tumor purity

Supplementary Figure 1: LUMP Leukocytes unmethylabon to infer tumor purity Supplementary Figure 1: LUMP Leukocytes unmethylabon to infer tumor purity A Consistently unmethylated sites (30%) in 21 cancer types 174,696

More information

Breast and ovarian cancer in Serbia: the importance of mutation detection in hereditary predisposition genes using NGS

Breast and ovarian cancer in Serbia: the importance of mutation detection in hereditary predisposition genes using NGS Breast and ovarian cancer in Serbia: the importance of mutation detection in hereditary predisposition genes using NGS dr sc. Ana Krivokuća Laboratory for molecular genetics Institute for Oncology and

More information

The Cancer Genome Atlas & International Cancer Genome Consortium

The Cancer Genome Atlas & International Cancer Genome Consortium The Cancer Genome Atlas & International Cancer Genome Consortium Session 3 Dr Jason Wong Prince of Wales Clinical School Introductory bioinformatics for human genomics workshop, UNSW 31 st July 2014 1

More information

PSSV User Manual (V2.1)

PSSV User Manual (V2.1) PSSV User Manual (V2.1) 1. Introduction A novel pattern-based probabilistic approach, PSSV, is developed to identify somatic structural variations from WGS data. Specifically, discordant and concordant

More information

DNA-seq Bioinformatics Analysis: Copy Number Variation

DNA-seq Bioinformatics Analysis: Copy Number Variation DNA-seq Bioinformatics Analysis: Copy Number Variation Elodie Girard elodie.girard@curie.fr U900 institut Curie, INSERM, Mines ParisTech, PSL Research University Paris, France NGS Applications 5C HiC DNA-seq

More information

Mutation Detection and CNV Analysis for Illumina Sequencing data from HaloPlex Target Enrichment Panels using NextGENe Software for Clinical Research

Mutation Detection and CNV Analysis for Illumina Sequencing data from HaloPlex Target Enrichment Panels using NextGENe Software for Clinical Research Mutation Detection and CNV Analysis for Illumina Sequencing data from HaloPlex Target Enrichment Panels using NextGENe Software for Clinical Research Application Note Authors John McGuigan, Megan Manion,

More information

The Cancer Genome Atlas

The Cancer Genome Atlas The Cancer Genome Atlas July 14, 2011 Kenna M. Shaw, Ph.D. Deputy Director The Cancer Genome Atlas Program TCGA: Core Objectives Launched in 2006 as a pilot and expanded in 2009, the goals of TCGA are

More information

Cytogenetics 101: Clinical Research and Molecular Genetic Technologies

Cytogenetics 101: Clinical Research and Molecular Genetic Technologies Cytogenetics 101: Clinical Research and Molecular Genetic Technologies Topics for Today s Presentation 1 Classical vs Molecular Cytogenetics 2 What acgh? 3 What is FISH? 4 What is NGS? 5 How can these

More information

Elevated RNA Editing Activity Is a Major Contributor to Transcriptomic Diversity in Tumors

Elevated RNA Editing Activity Is a Major Contributor to Transcriptomic Diversity in Tumors Cell Reports Supplemental Information Elevated RNA Editing Activity Is a Major Contributor to Transcriptomic Diversity in s Nurit Paz-Yaacov, Lily Bazak, Ilana Buchumenski, Hagit T. Porath, Miri Danan-Gotthold,

More information

Genomic structural variation

Genomic structural variation Genomic structural variation Mario Cáceres The new genomic variation DNA sequence differs across individuals much more than researchers had suspected through structural changes A huge amount of structural

More information

RASA: Robust Alternative Splicing Analysis for Human Transcriptome Arrays

RASA: Robust Alternative Splicing Analysis for Human Transcriptome Arrays Supplementary Materials RASA: Robust Alternative Splicing Analysis for Human Transcriptome Arrays Junhee Seok 1*, Weihong Xu 2, Ronald W. Davis 2, Wenzhong Xiao 2,3* 1 School of Electrical Engineering,

More information

Trinity: Transcriptome Assembly for Genetic and Functional Analysis of Cancer [U24]

Trinity: Transcriptome Assembly for Genetic and Functional Analysis of Cancer [U24] Trinity: Transcriptome Assembly for Genetic and Functional Analysis of Cancer [U24] ITCR meeting, June 2016 The Cancer Transcriptome A window into the (expressed) genetic and epigenetic state of a tumor

More information

Advance Your Genomic Research Using Targeted Resequencing with SeqCap EZ Library

Advance Your Genomic Research Using Targeted Resequencing with SeqCap EZ Library Advance Your Genomic Research Using Targeted Resequencing with SeqCap EZ Library Marilou Wijdicks International Product Manager Research For Life Science Research Only. Not for Use in Diagnostic Procedures.

More information

Data mining with Ensembl Biomart. Stéphanie Le Gras

Data mining with Ensembl Biomart. Stéphanie Le Gras Data mining with Ensembl Biomart Stéphanie Le Gras (slegras@igbmc.fr) Guidelines Genome data Genome browsers Getting access to genomic data: Ensembl/BioMart 2 Genome Sequencing Example: Human genome 2000:

More information

Accessing and Using ENCODE Data Dr. Peggy J. Farnham

Accessing and Using ENCODE Data Dr. Peggy J. Farnham 1 William M Keck Professor of Biochemistry Keck School of Medicine University of Southern California How many human genes are encoded in our 3x10 9 bp? C. elegans (worm) 959 cells and 1x10 8 bp 20,000

More information

Introduction to Systems Biology of Cancer Lecture 2

Introduction to Systems Biology of Cancer Lecture 2 Introduction to Systems Biology of Cancer Lecture 2 Gustavo Stolovitzky IBM Research Icahn School of Medicine at Mt Sinai DREAM Challenges High throughput measurements: The age of omics Systems Biology

More information

Computational Analysis of UHT Sequences Histone modifications, CAGE, RNA-Seq

Computational Analysis of UHT Sequences Histone modifications, CAGE, RNA-Seq Computational Analysis of UHT Sequences Histone modifications, CAGE, RNA-Seq Philipp Bucher Wednesday January 21, 2009 SIB graduate school course EPFL, Lausanne ChIP-seq against histone variants: Biological

More information

Inference of Isoforms from Short Sequence Reads

Inference of Isoforms from Short Sequence Reads Inference of Isoforms from Short Sequence Reads Tao Jiang Department of Computer Science and Engineering University of California, Riverside Tsinghua University Joint work with Jianxing Feng and Wei Li

More information

Supplemental Methods RNA sequencing experiment

Supplemental Methods RNA sequencing experiment Supplemental Methods RNA sequencing experiment Mice were euthanized as described in the Methods and the right lung was removed, placed in a sterile eppendorf tube, and snap frozen in liquid nitrogen. RNA

More information

Variant Classification. Author: Mike Thiesen, Golden Helix, Inc.

Variant Classification. Author: Mike Thiesen, Golden Helix, Inc. Variant Classification Author: Mike Thiesen, Golden Helix, Inc. Overview Sequencing pipelines are able to identify rare variants not found in catalogs such as dbsnp. As a result, variants in these datasets

More information

Abstract. Optimization strategy of Copy Number Variant calling using Multiplicom solutions APPLICATION NOTE. Introduction

Abstract. Optimization strategy of Copy Number Variant calling using Multiplicom solutions APPLICATION NOTE. Introduction Optimization strategy of Copy Number Variant calling using Multiplicom solutions Michael Vyverman, PhD; Laura Standaert, PhD and Wouter Bossuyt, PhD Abstract Copy number variations (CNVs) represent a significant

More information

ChIP-seq hands-on. Iros Barozzi, Campus IFOM-IEO (Milan) Saverio Minucci, Gioacchino Natoli Labs

ChIP-seq hands-on. Iros Barozzi, Campus IFOM-IEO (Milan) Saverio Minucci, Gioacchino Natoli Labs ChIP-seq hands-on Iros Barozzi, Campus IFOM-IEO (Milan) Saverio Minucci, Gioacchino Natoli Labs Main goals Becoming familiar with essential tools and formats Visualizing and contextualizing raw data Understand

More information

Deploying the full transcriptome using RNA sequencing. Jo Vandesompele, CSO and co-founder The Non-Coding Genome May 12, 2016, Leuven

Deploying the full transcriptome using RNA sequencing. Jo Vandesompele, CSO and co-founder The Non-Coding Genome May 12, 2016, Leuven Deploying the full transcriptome using RNA sequencing Jo Vandesompele, CSO and co-founder The Non-Coding Genome May 12, 2016, Leuven Roadmap Biogazelle the power of RNA reasons to study non-coding RNA

More information

RNA- seq Introduc1on. Promises and pi7alls

RNA- seq Introduc1on. Promises and pi7alls RNA- seq Introduc1on Promises and pi7alls DNA is the same in all cells but which RNAs that is present is different in all cells There is a wide variety of different func1onal RNAs Which RNAs (and some1mes

More information

Computer Science, Biology, and Biomedical Informatics (CoSBBI) Outline. Molecular Biology of Cancer AND. Goals/Expectations. David Boone 7/1/2015

Computer Science, Biology, and Biomedical Informatics (CoSBBI) Outline. Molecular Biology of Cancer AND. Goals/Expectations. David Boone 7/1/2015 Goals/Expectations Computer Science, Biology, and Biomedical (CoSBBI) We want to excite you about the world of computer science, biology, and biomedical informatics. Experience what it is like to be a

More information

Circular RNAs (circrnas) act a stable mirna sponges

Circular RNAs (circrnas) act a stable mirna sponges Circular RNAs (circrnas) act a stable mirna sponges cernas compete for mirnas Ancestal mrna (+3 UTR) Pseudogene RNA (+3 UTR homolgy region) The model holds true for all RNAs that share a mirna binding

More information

Breast cancer. Risk factors you cannot change include: Treatment Plan Selection. Inferring Transcriptional Module from Breast Cancer Profile Data

Breast cancer. Risk factors you cannot change include: Treatment Plan Selection. Inferring Transcriptional Module from Breast Cancer Profile Data Breast cancer Inferring Transcriptional Module from Breast Cancer Profile Data Breast Cancer and Targeted Therapy Microarray Profile Data Inferring Transcriptional Module Methods CSC 177 Data Warehousing

More information

PSSV User Manual (V1.0)

PSSV User Manual (V1.0) PSSV User Manual (V1.0) 1. Introduction A novel pattern-based probabilistic approach, PSSV, is developed to identify somatic structural variations from WGS data. Specifically, discordant and concordant

More information

CRISPR/Cas9 Enrichment and Long-read WGS for Structural Variant Discovery

CRISPR/Cas9 Enrichment and Long-read WGS for Structural Variant Discovery CRISPR/Cas9 Enrichment and Long-read WGS for Structural Variant Discovery PacBio CoLab Session October 20, 2017 For Research Use Only. Not for use in diagnostics procedures. Copyright 2017 by Pacific Biosciences

More information

Hands-On Ten The BRCA1 Gene and Protein

Hands-On Ten The BRCA1 Gene and Protein Hands-On Ten The BRCA1 Gene and Protein Objective: To review transcription, translation, reading frames, mutations, and reading files from GenBank, and to review some of the bioinformatics tools, such

More information

Fusion Analysis of Solid Tumors Reveals Novel Rearrangements in Breast Carcinomas

Fusion Analysis of Solid Tumors Reveals Novel Rearrangements in Breast Carcinomas Fusion Analysis of Solid Tumors Reveals Novel Rearrangements in Breast Carcinomas Igor Astsaturov Philip Ellis Jeff Swensen Zoran Gatalica David Arguello Sandeep Reddy Wafik El-Deiry Disclaimers Dr. Igor

More information

Supplementary Figures

Supplementary Figures Supplementary Figures Supplementary Figure 1. Heatmap of GO terms for differentially expressed genes. The terms were hierarchically clustered using the GO term enrichment beta. Darker red, higher positive

More information

CONTRACTING ORGANIZATION: Johns Hopkins University, Baltimore, MD

CONTRACTING ORGANIZATION: Johns Hopkins University, Baltimore, MD AD Award Number: W81XWH-12-1-0480 TITLE: Molecular Characterization of Indolent Prostate Cancer PRINCIPAL INVESTIGATOR: Jun Luo, Ph.D. CONTRACTING ORGANIZATION: Johns Hopkins University, Baltimore, MD

More information

Structural Variation and Medical Genomics

Structural Variation and Medical Genomics Structural Variation and Medical Genomics Andrew King Department of Biomedical Informatics July 8, 2014 You already know about small scale genetic mutations Single nucleotide polymorphism (SNPs) Deletions,

More information

Lecture 8 Understanding Transcription RNA-seq analysis. Foundations of Computational Systems Biology David K. Gifford

Lecture 8 Understanding Transcription RNA-seq analysis. Foundations of Computational Systems Biology David K. Gifford Lecture 8 Understanding Transcription RNA-seq analysis Foundations of Computational Systems Biology David K. Gifford 1 Lecture 8 RNA-seq Analysis RNA-seq principles How can we characterize mrna isoform

More information

Nature Genetics: doi: /ng Supplementary Figure 1. SEER data for male and female cancer incidence from

Nature Genetics: doi: /ng Supplementary Figure 1. SEER data for male and female cancer incidence from Supplementary Figure 1 SEER data for male and female cancer incidence from 1975 2013. (a,b) Incidence rates of oral cavity and pharynx cancer (a) and leukemia (b) are plotted, grouped by males (blue),

More information

ACE ImmunoID Biomarker Discovery Solutions ACE ImmunoID Platform for Tumor Immunogenomics

ACE ImmunoID Biomarker Discovery Solutions ACE ImmunoID Platform for Tumor Immunogenomics ACE ImmunoID Biomarker Discovery Solutions ACE ImmunoID Platform for Tumor Immunogenomics Precision Genomics for Immuno-Oncology Personalis, Inc. ACE ImmunoID When one biomarker doesn t tell the whole

More information

Lectures 13: High throughput sequencing: Beyond the genome. Spring 2017 March 28, 2017

Lectures 13: High throughput sequencing: Beyond the genome. Spring 2017 March 28, 2017 Lectures 13: High throughput sequencing: Beyond the genome Spring 2017 March 28, 2017 h@p://www.fejes.ca/2009/06/science- cartoons- 5- rna- seq.html Omics Transcriptome - the set of all mrnas present in

More information

Role of FISH in Hematological Cancers

Role of FISH in Hematological Cancers Role of FISH in Hematological Cancers Thomas S.K. Wan PhD,FRCPath,FFSc(RCPA) Honorary Professor, Department of Pathology & Clinical Biochemistry, Queen Mary Hospital, University of Hong Kong. e-mail: wantsk@hku.hk

More information

A Statistical Framework for Classification of Tumor Type from microrna Data

A Statistical Framework for Classification of Tumor Type from microrna Data DEGREE PROJECT IN MATHEMATICS, SECOND CYCLE, 30 CREDITS STOCKHOLM, SWEDEN 2016 A Statistical Framework for Classification of Tumor Type from microrna Data JOSEFINE RÖHSS KTH ROYAL INSTITUTE OF TECHNOLOGY

More information

A complete next-generation sequencing workfl ow for circulating cell-free DNA isolation and analysis

A complete next-generation sequencing workfl ow for circulating cell-free DNA isolation and analysis APPLICATION NOTE Cell-Free DNA Isolation Kit A complete next-generation sequencing workfl ow for circulating cell-free DNA isolation and analysis Abstract Circulating cell-free DNA (cfdna) has been shown

More information

Generating Spontaneous Copy Number Variants (CNVs) Jennifer Freeman Assistant Professor of Toxicology School of Health Sciences Purdue University

Generating Spontaneous Copy Number Variants (CNVs) Jennifer Freeman Assistant Professor of Toxicology School of Health Sciences Purdue University Role of Chemical lexposure in Generating Spontaneous Copy Number Variants (CNVs) Jennifer Freeman Assistant Professor of Toxicology School of Health Sciences Purdue University CNV Discovery Reference Genetic

More information

DOES THE BRCAX GENE EXIST? FUTURE OUTLOOK

DOES THE BRCAX GENE EXIST? FUTURE OUTLOOK CHAPTER 6 DOES THE BRCAX GENE EXIST? FUTURE OUTLOOK Genetic research aimed at the identification of new breast cancer susceptibility genes is at an interesting crossroad. On the one hand, the existence

More information

P. Tang ( 鄧致剛 ); PJ Huang ( 黄栢榕 ) g( ); g ( ) Bioinformatics Center, Chang Gung University.

P. Tang ( 鄧致剛 ); PJ Huang ( 黄栢榕 ) g( ); g ( ) Bioinformatics Center, Chang Gung University. Databases and Tools for High Throughput Sequencing Analysis P. Tang ( 鄧致剛 ); PJ Huang ( 黄栢榕 ) g( ); g ( ) Bioinformatics Center, Chang Gung University. HTseq Platforms Applications on Biomedical Sciences

More information

Using the Bravo Liquid-Handling System for Next Generation Sequencing Sample Prep

Using the Bravo Liquid-Handling System for Next Generation Sequencing Sample Prep Using the Bravo Liquid-Handling System for Next Generation Sequencing Sample Prep Tom Walsh, PhD Division of Medical Genetics University of Washington Next generation sequencing Sanger sequencing gold

More information

Module 3: Pathway and Drug Development

Module 3: Pathway and Drug Development Module 3: Pathway and Drug Development Table of Contents 1.1 Getting Started... 6 1.2 Identifying a Dasatinib sensitive cancer signature... 7 1.2.1 Identifying and validating a Dasatinib Signature... 7

More information

ChIP-seq data analysis

ChIP-seq data analysis ChIP-seq data analysis Harri Lähdesmäki Department of Computer Science Aalto University November 24, 2017 Contents Background ChIP-seq protocol ChIP-seq data analysis Transcriptional regulation Transcriptional

More information

Multiplex target enrichment using DNA indexing for ultra-high throughput variant detection

Multiplex target enrichment using DNA indexing for ultra-high throughput variant detection Multiplex target enrichment using DNA indexing for ultra-high throughput variant detection Dr Elaine Kenny Neuropsychiatric Genetics Research Group Institute of Molecular Medicine Trinity College Dublin

More information

RNA-Seq Preparation Comparision Summary: Lexogen, Standard, NEB

RNA-Seq Preparation Comparision Summary: Lexogen, Standard, NEB RNA-Seq Preparation Comparision Summary: Lexogen, Standard, NEB CSF-NGS January 22, 214 Contents 1 Introduction 1 2 Experimental Details 1 3 Results And Discussion 1 3.1 ERCC spike ins............................................

More information

Solving Problems of Clustering and Classification of Cancer Diseases Based on DNA Methylation Data 1,2

Solving Problems of Clustering and Classification of Cancer Diseases Based on DNA Methylation Data 1,2 APPLIED PROBLEMS Solving Problems of Clustering and Classification of Cancer Diseases Based on DNA Methylation Data 1,2 A. N. Polovinkin a, I. B. Krylov a, P. N. Druzhkov a, M. V. Ivanchenko a, I. B. Meyerov

More information

AVENIO ctdna Analysis Kits The complete NGS liquid biopsy solution EMPOWER YOUR LAB

AVENIO ctdna Analysis Kits The complete NGS liquid biopsy solution EMPOWER YOUR LAB Analysis Kits The complete NGS liquid biopsy solution EMPOWER YOUR LAB Analysis Kits Next-generation performance in liquid biopsies 2 Accelerating clinical research From liquid biopsy to next-generation

More information

Copy number and somatic mutations drive tumors

Copy number and somatic mutations drive tumors Detection of copy number alterations, ploidy and loss of heterozygosity across the genome in FFPE specimens Utility for diagnosis and treatment with comparison to FISH-based and as a complement to sequencing

More information

The Cancer Genome Atlas Pan-cancer analysis Katherine A. Hoadley

The Cancer Genome Atlas Pan-cancer analysis Katherine A. Hoadley The Cancer Genome Atlas Pan-cancer analysis Katherine A. Hoadley Department of Genetics Lineberger Comprehensive Cancer Center The University of North Carolina at Chapel Hill What is TCGA? The Cancer Genome

More information

A Practical Guide to Integrative Genomics by RNA-seq and ChIP-seq Analysis

A Practical Guide to Integrative Genomics by RNA-seq and ChIP-seq Analysis A Practical Guide to Integrative Genomics by RNA-seq and ChIP-seq Analysis Jian Xu, Ph.D. Children s Research Institute, UTSW Introduction Outline Overview of genomic and next-gen sequencing technologies

More information

Supplemental Materials and Methods Plasmids and viruses Quantitative Reverse Transcription PCR Generation of molecular standard for quantitative PCR

Supplemental Materials and Methods Plasmids and viruses Quantitative Reverse Transcription PCR Generation of molecular standard for quantitative PCR Supplemental Materials and Methods Plasmids and viruses To generate pseudotyped viruses, the previously described recombinant plasmids pnl4-3-δnef-gfp or pnl4-3-δ6-drgfp and a vector expressing HIV-1 X4

More information

NGS in Cancer Pathology After the Microscope: From Nucleic Acid to Interpretation

NGS in Cancer Pathology After the Microscope: From Nucleic Acid to Interpretation NGS in Cancer Pathology After the Microscope: From Nucleic Acid to Interpretation Michael R. Rossi, PhD, FACMG Assistant Professor Division of Cancer Biology, Department of Radiation Oncology Department

More information

EPIGENOMICS PROFILING SERVICES

EPIGENOMICS PROFILING SERVICES EPIGENOMICS PROFILING SERVICES Chromatin analysis DNA methylation analysis RNA-seq analysis Diagenode helps you uncover the mysteries of epigenetics PAGE 3 Integrative epigenomics analysis DNA methylation

More information

MODULE 3: TRANSCRIPTION PART II

MODULE 3: TRANSCRIPTION PART II MODULE 3: TRANSCRIPTION PART II Lesson Plan: Title S. CATHERINE SILVER KEY, CHIYEDZA SMALL Transcription Part II: What happens to the initial (premrna) transcript made by RNA pol II? Objectives Explain

More information

Supplementary Figure 1. Copy Number Alterations TP53 Mutation Type. C-class TP53 WT. TP53 mut. Nature Genetics: doi: /ng.

Supplementary Figure 1. Copy Number Alterations TP53 Mutation Type. C-class TP53 WT. TP53 mut. Nature Genetics: doi: /ng. Supplementary Figure a Copy Number Alterations in M-class b TP53 Mutation Type Recurrent Copy Number Alterations 8 6 4 2 TP53 WT TP53 mut TP53-mutated samples (%) 7 6 5 4 3 2 Missense Truncating M-class

More information

Supplementary Figure 1. Spitzoid Melanoma with PPFIBP1-MET fusion. (a) Histopathology (4x) shows a domed papule with melanocytes extending into the

Supplementary Figure 1. Spitzoid Melanoma with PPFIBP1-MET fusion. (a) Histopathology (4x) shows a domed papule with melanocytes extending into the Supplementary Figure 1. Spitzoid Melanoma with PPFIBP1-MET fusion. (a) Histopathology (4x) shows a domed papule with melanocytes extending into the deep dermis. (b) The melanocytes demonstrate abundant

More information

Genetic alterations of histone lysine methyltransferases and their significance in breast cancer

Genetic alterations of histone lysine methyltransferases and their significance in breast cancer Genetic alterations of histone lysine methyltransferases and their significance in breast cancer Supplementary Materials and Methods Phylogenetic tree of the HMT superfamily The phylogeny outlined in the

More information

Performance Characteristics BRCA MASTR Plus Dx

Performance Characteristics BRCA MASTR Plus Dx Performance Characteristics BRCA MASTR Plus Dx with drmid Dx for Illumina NGS systems Manufacturer Multiplicom N.V. Galileïlaan 18 2845 Niel Belgium Table of Contents 1. Workflow... 4 2. Performance Characteristics

More information

Colorspace & Matching

Colorspace & Matching Colorspace & Matching Outline Color space and 2-base-encoding Quality Values and filtering Mapping algorithm and considerations Estimate accuracy Coverage 2 2008 Applied Biosystems Color Space Properties

More information

Metabolomic and Proteomics Solutions for Integrated Biology. Christine Miller Omics Market Manager ASMS 2015

Metabolomic and Proteomics Solutions for Integrated Biology. Christine Miller Omics Market Manager ASMS 2015 Metabolomic and Proteomics Solutions for Integrated Biology Christine Miller Omics Market Manager ASMS 2015 Integrating Biological Analysis Using Pathways Protein A R HO R Protein B Protein X Identifies

More information

Obstacles and challenges in the analysis of microrna sequencing data

Obstacles and challenges in the analysis of microrna sequencing data Obstacles and challenges in the analysis of microrna sequencing data (mirna-seq) David Humphreys Genomics core Dr Victor Chang AC 1936-1991, Pioneering Cardiothoracic Surgeon and Humanitarian The ABCs

More information

Supplementary Online Content

Supplementary Online Content Supplementary Online Content Fumagalli D, Venet D, Ignatiadis M, et al. RNA Sequencing to predict response to neoadjuvant anti-her2 therapy: a secondary analysis of the NeoALTTO randomized clinical trial.

More information

Characterisation of structural variation in breast. cancer genomes using paired-end sequencing on. the Illumina Genome Analyser

Characterisation of structural variation in breast. cancer genomes using paired-end sequencing on. the Illumina Genome Analyser Characterisation of structural variation in breast cancer genomes using paired-end sequencing on the Illumina Genome Analyser Phil Stephens Cancer Genome Project Why is it important to study cancer? Why

More information

Patnaik SK, et al. MicroRNAs to accurately histotype NSCLC biopsies

Patnaik SK, et al. MicroRNAs to accurately histotype NSCLC biopsies Patnaik SK, et al. MicroRNAs to accurately histotype NSCLC biopsies. 2014. Supplemental Digital Content 1. Appendix 1. External data-sets used for associating microrna expression with lung squamous cell

More information

ACE ImmunoID. ACE ImmunoID. Precision immunogenomics. Precision Genomics for Immuno-Oncology

ACE ImmunoID. ACE ImmunoID. Precision immunogenomics. Precision Genomics for Immuno-Oncology ACE ImmunoID ACE ImmunoID Precision immunogenomics Precision Genomics for Immuno-Oncology Personalis, Inc. A universal biomarker platform for immuno-oncology Patient response to cancer immunotherapies

More information

Transform genomic data into real-life results

Transform genomic data into real-life results CLINICAL SUMMARY Transform genomic data into real-life results Biomarker testing and targeted therapies can drive improved outcomes in clinical practice New FDA-Approved Broad Companion Diagnostic for

More information

User s Manual Version 1.0

User s Manual Version 1.0 User s Manual Version 1.0 #639 Longmian Avenue, Jiangning District, Nanjing,211198,P.R.China. http://tcoa.cpu.edu.cn/ Contact us at xiaosheng.wang@cpu.edu.cn for technical issue and questions Catalogue

More information

of TERT, MLL4, CCNE1, SENP5, and ROCK1 on tumor development were discussed.

of TERT, MLL4, CCNE1, SENP5, and ROCK1 on tumor development were discussed. Supplementary Note The potential association and implications of HBV integration at known and putative cancer genes of TERT, MLL4, CCNE1, SENP5, and ROCK1 on tumor development were discussed. Human telomerase

More information