Nature Genetics: doi: /ng Supplementary Figure 1. Mutational signatures in BCC compared to melanoma.

Size: px
Start display at page:

Download "Nature Genetics: doi: /ng Supplementary Figure 1. Mutational signatures in BCC compared to melanoma."

Transcription

1 Supplementary Figure 1 Mutational signatures in BCC compared to melanoma. (a) The effect of transcription-coupled repair as a function of gene expression in BCC. Tumor type specific gene expression levels were used for BCC (this study) and cutaneous melanoma 21. Genes were grouped into five equally sized bins by their level of expression. 95% confidence intervals for the ratio between the two binomial distributions were calculated using the R function riskscoreci(). (b) Fraction of each nucleotide 5 to C>A mutations. 1

2 Supplementary Figure 2 Distribution of mutations in BCC driver genes. (a n) Distribution of mutations in the full sample set (293 BCC samples) along the FBXW7 (a), PPP6C (b), STK19 (c), CASP8 (d), RB1 (e), KNSTRN (f), ERBB2 (g), NOTCH2 (h), NOTCH1 (i), ARID1A (), SMO (k), TP53 (l), PTCH1 (m) and SUFU (n) protein diagrams. The orange lollipops represent truncating mutations, the purple lollipops represent missense mutations and the blue lollipops represent both truncating and missense events affecting the same amino acid. Protein functional domains are represented by colored boxes. The most recurrent events for each protein are labeled with the amino acid change. Protein diagrams were generated with cbioportal tools. 2

3 Supplementary Figure 3 SCNAs in BCC exomes. Top, overall profile of SCNAs in BCC. LOHs and cnlohs are on the top (dark blue); amplified regions are on the bottom (red). The positions of relevant genes are marked. Bottom, per-tumor SCNA profile. Each line represents a sample, and each column represents a chromosome. Loss of an allele (LOH) is depicted in blue, cnloh is indicated in black and copy number gain is indicated in yellow. Chromosomes X and Y have been excluded. 3

4 Supplementary Figure 4 LATS2 mutations in BCC. (a) Distribution of mutations (in the 136 sequenced exomes only) along the LATS2 protein schema. The purple lollipops represent missense mutations, and the orange lollipops represent truncating mutations. Protein functional domains are represented by green boxes. Events occurring two or more times are labeled with the amino acid change. (b) Kinase domain structure of LATS2 highlighting the position of residue Pro1004. The protein diagram was generated with cbioportal tools. 4

5 Supplementary Figure 5 Fraction of tumors with driver mutations per category. The bars represent the fraction of samples with driver mutations per BCC category indicated in the header (only non-clonal samples were used in this analysis). Vismo, vismodegib. Genes harboring driver mutations are labeled on the x axis. MYCN-p.44 is a subcategory containing only tumors with MYCN p.44 mutations; PTPN14-tr corresponds to PTPN14 truncating mutations. The fraction of tumors represented by the bars can be found at the left. 5

6 Supplementary Note Anomaly search for oncogenes in sequencing data using TumOnc The goal of the algorithm is to find genes with a specific mutation pattern, corresponding to high mutation rate in a nucleotide at a fixed position. This is the principal difference of the algorithm from the MutSigCV 1.4 of Lawrence et al. 1, where the overall mutation rate over a gene (taking into account mutation contexts) is analyzed. Since the mutation signal in a single nucleotide is smaller than over a full gene, TumOnc is less specific, but significantly more sensitive identifying oncogenes. The current version of the algorithm is written in python and is available upon request. The TumOnc algorithm consists of two maor steps: 1. Creation of the background probability model for the mutations. 2. Search for anomalously mutated genes. Here we describe these in order. Background model The background model is based on the observation by Lawrence et al. 1 that the mutation rate in the genes is significantly modulated by the values of the covariates of the genes, such as DNA replication time, expression level, and chromatin compartment. While in Lawrence et al. 1 the genes were categorized in groups ( bagels ) of adaptive size with similar covariates, we followed a different approach. We factorize the probability in factors dependent on the mutation context and a smooth function of the covariate values for the gene (which is chosen to be exponential ). To be precise, the mutation rate p cgp (or, probability that the given nucleotide is mutated in the given patient) is expressed as p cgp = f p f c p avg exp ( a i V i,g ) (1) where c is the context of the nucleotide in question, g gene, p patient. f c and f p are the context and patient specific factors (defined to have average equal to one), p avg is the average overall mutation rate, V i,g are the values of the covariates for the given gene (with I = 1, 2, 3 corresponding to logarithm of expression, replication time and chromatin compartment, respectively), and a I are the response coefficients. The context c in the calculations was chosen as three nucleotides around the nucleotide in question (always defined along the strand with C or T in the reference genome). It is possible to use a different context with minimal modification of the procedure, either by distinguishing some subclasses of the 3-nucleotide context (leading to larger, but rougher available statistics), or taking into account the type of mutation (the latter requires ust a slight modification taking into account multiple possible mutation outcomes, instead of binary mutation/no-mutation logic). Strictly speaking this is not a unique choice, but is a reasonable first guess based on the overall correlation of mutation probability and values of the covariates for the gene.

7 Thus, the probability model (1) is parametrized by parameters f p, f c, p avg, and a i. The patient and context specific rates are defined to have an average value of one, f p = f c = 1. The observed mutations are given by the mutation counts n cgp, number of possible mutation sites for each gene-context pair N cg, and number of patients C in the dataset. For a given mutation set one can find the optimal values of f p, f c, p avg, and a i by the maximal likelihood method, i.e. by extremizing the log-likelihood function lnp = [n cgp log (f p f c p avg exp ( a i V i,g )) cgp i (2) +(CN cg n cgp )log (1 f p f c p avg exp ( a i V i,g ))] It is possible to find the generic exact minimum of this function, but it can be simplified by approximating the second logarithm as log(1 p) p, which is an excellent approximation given the smallness of the overall mutation rate, p 1. Another simplifying approximation used was to define the patient specific mutation rates as f p = C i cg n cgp (3) cgp n cgp This is an excellent approximation for low mutation rates. After these approximations, the values of f c p avg and a i are found by an exact analytic solution for the maximum of (2) and further numerical maximization of ln P over the parameters a i using the Newton-Raphson method. Note also that the whole set (synonymous and nonsynonymous) of single nucleotide mutations should be used to generate the background model. Using only a subset (only missense mutations, for example) would lead to underestimation of the mutation probability. The resulting background model (1) can be used as predicted mutation rate for each nucleotide in the target region. Due to statistics requirements, it is possible to obtain the background model on one set of data (e.g. whole exome sequencing of a smaller set of patients) and use it for a constrained set of data (e.g. Cancer Panel) from a separate set of patients. This approach maximizes the use of passenger mutations for the background model determination, as compared to using only mutations in the Cancer Panel genes. In the analysis presented in the manuscript, the background model was generated from the whole exome panel mutation rate, while the search for anomalously mutated genes (described in the next subsection) was performed over the Cancer Panel genes only, for performance reasons. Search for anomalous genes This step significantly differs from the MutSigCV 1.4 algorithm. TumOnc searches for individual significantly mutated nucleotides in the sample. This is done by a variation of the 2-dimensional reduction described in Lawrence et al. 1 for the search of significantly mutated genes. That is, for each nucleotide with mutations in several (more than 3 or 4 in the analysis) patients we test the hypothesis that this mutation could be produced due to the background probability. The critical statistics for such an event is constructed as a log-probability of the event with the expected mutations p cgp for the given nucelotide with context c and gene g (which still depends on the

8 patient). To reduce the amount of possible outcomes to analyze, we use a d-dimensional reduction all the patients were ordered by increasing probability, so that p 1 < p 2 <... < p C. Each possible mutation can then be labeled by the d numbers of the patients with this mutation in this order. For example, the event (0,0) would mean no mutations, event (0, n 1 ) would mean only one mutation for the patient n 1, while event (n 1, n 2 ) would mean three mutations with probabilities p n1 < p n2, and possibly more mutations with larger probabilities. The probability of such an event is P (n1, n 2 ) = n 1 1 C (1 p i ), for n 1 = n 2 = 0 i=1 n 2 1 (1 p i ) p n2, for n 1 = 0, n 2 > 0 i=0 (1 p i ) p n1 (1 p i ) p n2, for n 2 > n 1 > 0 { i=0 n 2 1 i=n 1 +1 It is easy to generalize this for d>2, i.e. for events described by a set (n 1, n 2, n 3 ) or longer. This probability was used to generate the critical statistics, so p-value for the hypothesis H (n1, n 2 ) that a given event (n 1, n 2 ) equals the background event is obtained by summation of the probabilities for all possible mutation events with smaller probability (one-sided test) P H(n 1,n2) = P (m 1, m 2 ) (m 1, m 2 );P (m 1,m2) <P (n1,n2) In practice, we were using 4-dimensional reduction for a sample set of about 60 patients. Unfortunately, the method quickly becomes time consuming with large number of patients (roughly as C d ), and a simplified approximate method should be used for larger datasets. P-values and q-values Finally the p-values obtained were converted to q-values using the Benamini Hochberg procedure with the total number of hypothesis taken as the whole number of nucleotides in the exome. (4) (5) SCNA detection with the HMM The regions of SCNAs in the tumor were probabilistically inferred using a twenty state hidden Markov model (HMM) approach fed by normalized coverage ratios for ordered exons and by germline heterozygous SNPs. Briefly each state is represented by the pair {C,P}: T C T N s log 2 1, absp (1) N P C

9 T N where represent the normalized coverage of the exon, N the percentage of reads C / covering the maor allele in the tumor normal and = 1- contamination due to normal cells. According to (1), the non redundant admissible states are given by the outer product of the vector C of possible coverages normalized with respect to a diploid genome [0,0.5,1,1.5,2] and the coverage fraction P of the maor allele [0,16.6,25,50]. We modeled the observed ~ s c ~, ~ p as 1 a pair independently Gaussian distributed random variables C,, P, 7. Accordingly, 2 c~ i C ~ we set the transition probabilities as pi P 1 pi erfc erfc where and C 2 C 2 p 2 7. P P T / Distribution of mutations in tumor suppressor genes The search for the anomalously mutated tumor suppressor genes was realized by a one-sided test calculating probability of appearing for two or more LOF mutations in the given gene in the observed sample, assuming the overall uniform distribution of LOF mutations. The P-value for observing the mutation for a given gene k 1 tumors with single LOF and k 2+ tumors with two or more LOF mutations is given by M ( ) ( k 1 + k 2+ ) ( n k 1 k 2+ 1 ) k P(k 1, k 2+ ) = 1 + k 2+ k 1 n k 1 2k 2+, M + n 1 ( ) n where M is the total number of tumors and n is the total number of LOF mutations in the exome in all the tumors. ( a ) represents the binomial coefficient. b 1. Lawrence, M.S. et al. Mutational heterogeneity in cancer and the search for new cancer-associated genes. Nature 499, (2013).

Supplementary Materials for

Supplementary Materials for www.sciencetranslationalmedicine.org/cgi/content/full/7/283/283ra54/dc1 Supplementary Materials for Clonal status of actionable driver events and the timing of mutational processes in cancer evolution

More information

OncoPPi Portal A Cancer Protein Interaction Network to Inform Therapeutic Strategies

OncoPPi Portal A Cancer Protein Interaction Network to Inform Therapeutic Strategies OncoPPi Portal A Cancer Protein Interaction Network to Inform Therapeutic Strategies 2017 Contents Datasets... 2 Protein-protein interaction dataset... 2 Set of known PPIs... 3 Domain-domain interactions...

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

Research Strategy: 1. Background and Significance

Research Strategy: 1. Background and Significance Research Strategy: 1. Background and Significance 1.1. Heterogeneity is a common feature of cancer. A better understanding of this heterogeneity may present therapeutic opportunities: Intratumor heterogeneity

More information

Supplementary Figure 1

Supplementary Figure 1 Supplementary Figure 1 Supplementary Fig. 1: Quality assessment of formalin-fixed paraffin-embedded (FFPE)-derived DNA and nuclei. (a) Multiplex PCR analysis of unrepaired and repaired bulk FFPE gdna from

More information

2013 Holiday Lectures on Science Medicine in the Genomic Era

2013 Holiday Lectures on Science Medicine in the Genomic Era INTRODUCTION You may have read articles that talk about cancer genes. But what exactly are cancer genes and what do they do? Cancer consists of a group of diseases caused by mutations in the DNA of cells.

More information

Relationship between genomic features and distributions of RS1 and RS3 rearrangements in breast cancer genomes.

Relationship between genomic features and distributions of RS1 and RS3 rearrangements in breast cancer genomes. Supplementary Figure 1 Relationship between genomic features and distributions of RS1 and RS3 rearrangements in breast cancer genomes. (a,b) Values of coefficients associated with genomic features, separately

More information

Supplementary Figure 1: Classification scheme for non-synonymous and nonsense germline MC1R variants. The common variants with previously established

Supplementary Figure 1: Classification scheme for non-synonymous and nonsense germline MC1R variants. The common variants with previously established Supplementary Figure 1: Classification scheme for nonsynonymous and nonsense germline MC1R variants. The common variants with previously established classifications 1 3 are shown. The effect of novel missense

More information

Plasma-Seq conducted with blood from male individuals without cancer.

Plasma-Seq conducted with blood from male individuals without cancer. Supplementary Figures Supplementary Figure 1 Plasma-Seq conducted with blood from male individuals without cancer. Copy number patterns established from plasma samples of male individuals without cancer

More information

Supplemental Figure legends

Supplemental Figure legends Supplemental Figure legends Supplemental Figure S1 Frequently mutated genes. Frequently mutated genes (mutated in at least four patients) with information about mutation frequency, RNA-expression and copy-number.

More information

LESSON 3.2 WORKBOOK. How do normal cells become cancer cells? Workbook Lesson 3.2

LESSON 3.2 WORKBOOK. How do normal cells become cancer cells? Workbook Lesson 3.2 For a complete list of defined terms, see the Glossary. Transformation the process by which a cell acquires characteristics of a tumor cell. LESSON 3.2 WORKBOOK How do normal cells become cancer cells?

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

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

Cancer Informatics Lecture

Cancer Informatics Lecture Cancer Informatics Lecture Mayo-UIUC Computational Genomics Course June 22, 2018 Krishna Rani Kalari Ph.D. Associate Professor 2017 MFMER 3702274-1 Outline The Cancer Genome Atlas (TCGA) Genomic Data Commons

More information

Tumor suppressor genes D R. S H O S S E I N I - A S L

Tumor suppressor genes D R. S H O S S E I N I - A S L Tumor suppressor genes 1 D R. S H O S S E I N I - A S L What is a Tumor Suppressor Gene? 2 A tumor suppressor gene is a type of cancer gene that is created by loss-of function mutations. In contrast to

More information

Identifying driver mutations in sequenced cancer genomes: computational approaches to enable precision medicine

Identifying driver mutations in sequenced cancer genomes: computational approaches to enable precision medicine Raphael et al. Genome Medicine 2014, 6:5 REVIEW Identifying driver mutations in sequenced cancer genomes: computational approaches to enable precision medicine Benjamin J Raphael 1,2*, Jason R Dobson 1,2,3,

More information

Nature Genetics: doi: /ng Supplementary Figure 1. Country distribution of GME samples and designation of geographical subregions.

Nature Genetics: doi: /ng Supplementary Figure 1. Country distribution of GME samples and designation of geographical subregions. Supplementary Figure 1 Country distribution of GME samples and designation of geographical subregions. GME samples collected across 20 countries and territories from the GME. Pie size corresponds to the

More information

Introduction to LOH and Allele Specific Copy Number User Forum

Introduction to LOH and Allele Specific Copy Number User Forum Introduction to LOH and Allele Specific Copy Number User Forum Jonathan Gerstenhaber Introduction to LOH and ASCN User Forum Contents 1. Loss of heterozygosity Analysis procedure Types of baselines 2.

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

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

Lentiviral Delivery of Combinatorial mirna Expression Constructs Provides Efficient Target Gene Repression.

Lentiviral Delivery of Combinatorial mirna Expression Constructs Provides Efficient Target Gene Repression. Supplementary Figure 1 Lentiviral Delivery of Combinatorial mirna Expression Constructs Provides Efficient Target Gene Repression. a, Design for lentiviral combinatorial mirna expression and sensor constructs.

More information

Nature Genetics: doi: /ng Supplementary Figure 1. Somatic coding mutations identified by WES/WGS for 83 ATL cases.

Nature Genetics: doi: /ng Supplementary Figure 1. Somatic coding mutations identified by WES/WGS for 83 ATL cases. Supplementary Figure 1 Somatic coding mutations identified by WES/WGS for 83 ATL cases. (a) The percentage of targeted bases covered by at least 2, 10, 20 and 30 sequencing reads (top) and average read

More information

SUPPLEMENTARY APPENDIX

SUPPLEMENTARY APPENDIX SUPPLEMENTARY APPENDIX 1) Supplemental Figure 1. Histopathologic Characteristics of the Tumors in the Discovery Cohort 2) Supplemental Figure 2. Incorporation of Normal Epidermal Melanocytic Signature

More information

Supplemental Information For: The genetics of splicing in neuroblastoma

Supplemental Information For: The genetics of splicing in neuroblastoma Supplemental Information For: The genetics of splicing in neuroblastoma Justin Chen, Christopher S. Hackett, Shile Zhang, Young K. Song, Robert J.A. Bell, Annette M. Molinaro, David A. Quigley, Allan Balmain,

More information

Nature Genetics: doi: /ng Supplementary Figure 1. Rates of different mutation types in CRC.

Nature Genetics: doi: /ng Supplementary Figure 1. Rates of different mutation types in CRC. Supplementary Figure 1 Rates of different mutation types in CRC. (a) Stratification by mutation type indicates that C>T mutations occur at a significantly greater rate than other types. (b) As for the

More information

underlying metastasis and recurrence in HNSCC, we analyzed two groups of patients. The

underlying metastasis and recurrence in HNSCC, we analyzed two groups of patients. The Supplementary Figures Figure S1. Patient cohorts and study design. To define and interrogate the genetic alterations underlying metastasis and recurrence in HNSCC, we analyzed two groups of patients. The

More information

Supplementary Figure 1. Experimental paradigm. A combination of genome and exome sequencing coupled with array-comparative genome hybridization was

Supplementary Figure 1. Experimental paradigm. A combination of genome and exome sequencing coupled with array-comparative genome hybridization was Supplementary Figure 1. Experimental paradigm. A combination of genome and exome sequencing coupled with array-comparative genome hybridization was performed on a total of 85 SS patients. Data filtration

More information

Nature Structural & Molecular Biology: doi: /nsmb.2419

Nature Structural & Molecular Biology: doi: /nsmb.2419 Supplementary Figure 1 Mapped sequence reads and nucleosome occupancies. (a) Distribution of sequencing reads on the mouse reference genome for chromosome 14 as an example. The number of reads in a 1 Mb

More information

Supplementary Figure 1

Supplementary Figure 1 Supplementary Figure 1 Asymmetrical function of 5p and 3p arms of mir-181 and mir-30 families and mir-142 and mir-154. (a) Control experiments using mirna sensor vector and empty pri-mirna overexpression

More information

MSI positive MSI negative

MSI positive MSI negative Pritchard et al. 2014 Supplementary Figure 1 MSI positive MSI negative Hypermutated Median: 673 Average: 659.2 Non-Hypermutated Median: 37.5 Average: 43.6 Supplementary Figure 1: Somatic Mutation Burden

More information

Nature Neuroscience: doi: /nn Supplementary Figure 1. Behavioral training.

Nature Neuroscience: doi: /nn Supplementary Figure 1. Behavioral training. Supplementary Figure 1 Behavioral training. a, Mazes used for behavioral training. Asterisks indicate reward location. Only some example mazes are shown (for example, right choice and not left choice maze

More information

UNIT 3 GENETICS LESSON #30: TRAITS, GENES, & ALLELES. Many things come in many forms. Give me an example of something that comes in many forms.

UNIT 3 GENETICS LESSON #30: TRAITS, GENES, & ALLELES. Many things come in many forms. Give me an example of something that comes in many forms. UNIT 3 GENETICS LESSON #30: TRAITS, GENES, & ALLELES Many things come in many forms. Give me an example of something that comes in many forms. Genes, too, come in many forms. Main Idea #1 The same gene

More information

Nature Getetics: doi: /ng.3471

Nature Getetics: doi: /ng.3471 Supplementary Figure 1 Summary of exome sequencing data. ( a ) Exome tumor normal sample sizes for bladder cancer (BLCA), breast cancer (BRCA), carcinoid (CARC), chronic lymphocytic leukemia (CLLX), colorectal

More information

IPA Advanced Training Course

IPA Advanced Training Course IPA Advanced Training Course October 2013 Academia sinica Gene (Kuan Wen Chen) IPA Certified Analyst Agenda I. Data Upload and How to Run a Core Analysis II. Functional Interpretation in IPA Hands-on Exercises

More information

Supplementary Figure 1

Supplementary Figure 1 Count Count Supplementary Figure 1 Coverage per amplicon for error-corrected sequencing experiments. Errorcorrected consensus sequence (ECCS) coverage was calculated for each of the 568 amplicons in the

More information

Supplementary Figure 1. Schematic diagram of o2n-seq. Double-stranded DNA was sheared, end-repaired, and underwent A-tailing by standard protocols.

Supplementary Figure 1. Schematic diagram of o2n-seq. Double-stranded DNA was sheared, end-repaired, and underwent A-tailing by standard protocols. Supplementary Figure 1. Schematic diagram of o2n-seq. Double-stranded DNA was sheared, end-repaired, and underwent A-tailing by standard protocols. A-tailed DNA was ligated to T-tailed dutp adapters, circularized

More information

NGS in tissue and liquid biopsy

NGS in tissue and liquid biopsy NGS in tissue and liquid biopsy Ana Vivancos, PhD Referencias So, why NGS in the clinics? 2000 Sanger Sequencing (1977-) 2016 NGS (2006-) ABIPrism (Applied Biosystems) Up to 2304 per day (96 sequences

More information

Genome-Wide Localization of Protein-DNA Binding and Histone Modification by a Bayesian Change-Point Method with ChIP-seq Data

Genome-Wide Localization of Protein-DNA Binding and Histone Modification by a Bayesian Change-Point Method with ChIP-seq Data Genome-Wide Localization of Protein-DNA Binding and Histone Modification by a Bayesian Change-Point Method with ChIP-seq Data Haipeng Xing, Yifan Mo, Will Liao, Michael Q. Zhang Clayton Davis and Geoffrey

More information

Rational targeting of very high-risk medulloblastoma of childhood - 1 st progress report

Rational targeting of very high-risk medulloblastoma of childhood - 1 st progress report Rational targeting of very high-risk medulloblastoma of childhood - 1 st progress report year Purpose of the research Medulloblastoma is the most common malignant brain tumor of childhood and treatments

More information

Supplementary Figure 1. Estimation of tumour content

Supplementary Figure 1. Estimation of tumour content Supplementary Figure 1. Estimation of tumour content a, Approach used to estimate the tumour content in S13T1/T2, S6T1/T2, S3T1/T2 and S12T1/T2. Tissue and tumour areas were evaluated by two independent

More information

Nature Neuroscience: doi: /nn Supplementary Figure 1. Missense damaging predictions as a function of allele frequency

Nature Neuroscience: doi: /nn Supplementary Figure 1. Missense damaging predictions as a function of allele frequency Supplementary Figure 1 Missense damaging predictions as a function of allele frequency Percentage of missense variants classified as damaging by eight different classifiers and a classifier consisting

More information

ARTICLE RESEARCH. Macmillan Publishers Limited. All rights reserved

ARTICLE RESEARCH. Macmillan Publishers Limited. All rights reserved Extended Data Figure 6 Annotation of drivers based on clinical characteristics and co-occurrence patterns. a, Putative drivers affecting greater than 10 patients were assessed for enrichment in IGHV mutated

More information

Integration of Cancer Genome into GECCO- Genetics and Epidemiology of Colorectal Cancer Consortium

Integration of Cancer Genome into GECCO- Genetics and Epidemiology of Colorectal Cancer Consortium Integration of Cancer Genome into GECCO- Genetics and Epidemiology of Colorectal Cancer Consortium Ulrike Peters Fred Hutchinson Cancer Research Center University of Washington U01-CA137088-05, PI: Peters

More information

Genomic Medicine: What every pathologist needs to know

Genomic Medicine: What every pathologist needs to know Genomic Medicine: What every pathologist needs to know Stephen P. Ethier, Ph.D. Professor, Department of Pathology and Laboratory Medicine, MUSC Director, MUSC Center for Genomic Medicine Genomics and

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

Nature Genetics: doi: /ng Supplementary Figure 1. HOX fusions enhance self-renewal capacity.

Nature Genetics: doi: /ng Supplementary Figure 1. HOX fusions enhance self-renewal capacity. Supplementary Figure 1 HOX fusions enhance self-renewal capacity. Mouse bone marrow was transduced with a retrovirus carrying one of three HOX fusion genes or the empty mcherry reporter construct as described

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

SUPPLEMENTARY INFORMATION

SUPPLEMENTARY INFORMATION doi:10.1038/nature12213 Figure S1: Simplified illustration of the problem of mutational heterogeneity Figure S1. Effect of heterogeneity in background mutation frequency on detection of significantly mutated

More information

Fluxion Biosciences and Swift Biosciences Somatic variant detection from liquid biopsy samples using targeted NGS

Fluxion Biosciences and Swift Biosciences Somatic variant detection from liquid biopsy samples using targeted NGS APPLICATION NOTE Fluxion Biosciences and Swift Biosciences OVERVIEW This application note describes a robust method for detecting somatic mutations from liquid biopsy samples by combining circulating tumor

More information

Protein Domain-Centric Approach to Study Cancer Somatic Mutations from High-throughput Sequencing Studies

Protein Domain-Centric Approach to Study Cancer Somatic Mutations from High-throughput Sequencing Studies Protein Domain-Centric Approach to Study Cancer Somatic Mutations from High-throughput Sequencing Studies Dr. Maricel G. Kann Assistant Professor Dept of Biological Sciences UMBC 2 The term protein domain

More information

p.r623c p.p976l p.d2847fs p.t2671 p.d2847fs p.r2922w p.r2370h p.c1201y p.a868v p.s952* RING_C BP PHD Cbp HAT_KAT11

p.r623c p.p976l p.d2847fs p.t2671 p.d2847fs p.r2922w p.r2370h p.c1201y p.a868v p.s952* RING_C BP PHD Cbp HAT_KAT11 ARID2 p.r623c KMT2D p.v650fs p.p976l p.r2922w p.l1212r p.d1400h DNA binding RFX DNA binding Zinc finger KMT2C p.a51s p.d372v p.c1103* p.d2847fs p.t2671 p.d2847fs p.r4586h PHD/ RING DHHC/ PHD PHD FYR N

More information

Insights from Sequencing the Melanoma Exome

Insights from Sequencing the Melanoma Exome Insights from Sequencing the Melanoma Exome Michael Krauthammer, MD PhD, December 2 2015 Yale University School Yof Medicine 1 2012 Exome Screens and Results Exome Sequencing of 108 sun-exposed melanomas

More information

A general framework for analyzing tumor subclonality using SNP array and DNA sequencing data

A general framework for analyzing tumor subclonality using SNP array and DNA sequencing data Li and Li Genome Biology 2014, 15:473 METHOD A general framework for analyzing tumor subclonality using SNP array and DNA sequencing data Bo Li 1 and Jun Z Li 2 Open Access Abstract Intra-tumor heterogeneity

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

Numerical Integration of Bivariate Gaussian Distribution

Numerical Integration of Bivariate Gaussian Distribution Numerical Integration of Bivariate Gaussian Distribution S. H. Derakhshan and C. V. Deutsch The bivariate normal distribution arises in many geostatistical applications as most geostatistical techniques

More information

The Center for PERSONALIZED DIAGNOSTICS

The Center for PERSONALIZED DIAGNOSTICS The Center for PERSONALIZED DIAGNOSTICS Precision Diagnostics for Personalized Medicine A joint initiative between The Department of Pathology and Laboratory Medicine & The Abramson Cancer Center The (CPD)

More information

Nature Methods: doi: /nmeth.3115

Nature Methods: doi: /nmeth.3115 Supplementary Figure 1 Analysis of DNA methylation in a cancer cohort based on Infinium 450K data. RnBeads was used to rediscover a clinically distinct subgroup of glioblastoma patients characterized by

More information

NEXT GENERATION SEQUENCING. R. Piazza (MD, PhD) Dept. of Medicine and Surgery, University of Milano-Bicocca

NEXT GENERATION SEQUENCING. R. Piazza (MD, PhD) Dept. of Medicine and Surgery, University of Milano-Bicocca NEXT GENERATION SEQUENCING R. Piazza (MD, PhD) Dept. of Medicine and Surgery, University of Milano-Bicocca SANGER SEQUENCING 5 3 3 5 + Capillary Electrophoresis DNA NEXT GENERATION SEQUENCING SOLEXA-ILLUMINA

More information

Introduction to Cancer Bioinformatics and cancer biology. Anthony Gitter Cancer Bioinformatics (BMI 826/CS 838) January 20, 2015

Introduction to Cancer Bioinformatics and cancer biology. Anthony Gitter Cancer Bioinformatics (BMI 826/CS 838) January 20, 2015 Introduction to Cancer Bioinformatics and cancer biology Anthony Gitter Cancer Bioinformatics (BMI 826/CS 838) January 20, 2015 Why cancer bioinformatics? Devastating disease, no cure on the horizon Major

More information

Supplemental Figure 1. Genes showing ectopic H3K9 dimethylation in this study are DNA hypermethylated in Lister et al. study.

Supplemental Figure 1. Genes showing ectopic H3K9 dimethylation in this study are DNA hypermethylated in Lister et al. study. mc mc mc mc SUP mc mc Supplemental Figure. Genes showing ectopic HK9 dimethylation in this study are DNA hypermethylated in Lister et al. study. Representative views of genes that gain HK9m marks in their

More information

Nature Immunology: doi: /ni Supplementary Figure 1

Nature Immunology: doi: /ni Supplementary Figure 1 Supplementary Figure 1 A β-strand positions consistently places the residues at CDR3β P6 and P7 within human and mouse TCR-peptide-MHC interfaces. (a) E8 TCR containing V β 13*06 carrying with an 11mer

More information

Genome 371, Autumn 2018 Quiz Section 9: Genetics of Cancer Worksheet

Genome 371, Autumn 2018 Quiz Section 9: Genetics of Cancer Worksheet Genome 371, Autumn 2018 Quiz Section 9: Genetics of Cancer Worksheet All cancer is due to genetic mutations. However, in cancer that clusters in families (familial cancer) at least one of these mutations

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

Supplementary Figure 1: Attenuation of association signals after conditioning for the lead SNP. a) attenuation of association signal at the 9p22.

Supplementary Figure 1: Attenuation of association signals after conditioning for the lead SNP. a) attenuation of association signal at the 9p22. Supplementary Figure 1: Attenuation of association signals after conditioning for the lead SNP. a) attenuation of association signal at the 9p22.32 PCOS locus after conditioning for the lead SNP rs10993397;

More information

Supplementary Figure 1: Features of IGLL5 Mutations in CLL: a) Representative IGV screenshot of first

Supplementary Figure 1: Features of IGLL5 Mutations in CLL: a) Representative IGV screenshot of first Supplementary Figure 1: Features of IGLL5 Mutations in CLL: a) Representative IGV screenshot of first intron IGLL5 mutation depicting biallelic mutations. Red arrows highlight the presence of out of phase

More information

SUPPLEMENTARY INFORMATION. Intron retention is a widespread mechanism of tumor suppressor inactivation.

SUPPLEMENTARY INFORMATION. Intron retention is a widespread mechanism of tumor suppressor inactivation. SUPPLEMENTARY INFORMATION Intron retention is a widespread mechanism of tumor suppressor inactivation. Hyunchul Jung 1,2,3, Donghoon Lee 1,4, Jongkeun Lee 1,5, Donghyun Park 2,6, Yeon Jeong Kim 2,6, Woong-Yang

More information

Table S1. Relative abundance of AGO1/4 proteins in different organs. Table S2. Summary of smrna datasets from various samples.

Table S1. Relative abundance of AGO1/4 proteins in different organs. Table S2. Summary of smrna datasets from various samples. Supplementary files Table S1. Relative abundance of AGO1/4 proteins in different organs. Table S2. Summary of smrna datasets from various samples. Table S3. Specificity of AGO1- and AGO4-preferred 24-nt

More information

Advanced IPD meta-analysis methods for observational studies

Advanced IPD meta-analysis methods for observational studies Advanced IPD meta-analysis methods for observational studies Simon Thompson University of Cambridge, UK Part 4 IBC Victoria, July 2016 1 Outline of talk Usual measures of association (e.g. hazard ratios)

More information

DNA is the genetic material that provides instructions for what our bodies look like and how they function. DNA is packaged into structures called

DNA is the genetic material that provides instructions for what our bodies look like and how they function. DNA is packaged into structures called DNA is the genetic material that provides instructions for what our bodies look like and how they function. DNA is packaged into structures called chromosomes. We have 23 pairs of chromosomes (for a total

More information

Transient β-hairpin Formation in α-synuclein Monomer Revealed by Coarse-grained Molecular Dynamics Simulation

Transient β-hairpin Formation in α-synuclein Monomer Revealed by Coarse-grained Molecular Dynamics Simulation Transient β-hairpin Formation in α-synuclein Monomer Revealed by Coarse-grained Molecular Dynamics Simulation Hang Yu, 1, 2, a) Wei Han, 1, 3, b) Wen Ma, 1, 2 1, 2, 3, c) and Klaus Schulten 1) Beckman

More information

Nature Genetics: doi: /ng Supplementary Figure 1

Nature Genetics: doi: /ng Supplementary Figure 1 Supplementary Figure 1 Expression deviation of the genes mapped to gene-wise recurrent mutations in the TCGA breast cancer cohort (top) and the TCGA lung cancer cohort (bottom). For each gene (each pair

More information

The feasibility of circulating tumour DNA as an alternative to biopsy for mutational characterization in Stage III melanoma patients

The feasibility of circulating tumour DNA as an alternative to biopsy for mutational characterization in Stage III melanoma patients The feasibility of circulating tumour DNA as an alternative to biopsy for mutational characterization in Stage III melanoma patients ASSC Scientific Meeting 13 th October 2016 Prof Andrew Barbour UQ SOM

More information

Copyright The McGraw-Hill Companies, Inc. Permission required for reproduction or display. Chapter 6 Patterns of Inheritance

Copyright The McGraw-Hill Companies, Inc. Permission required for reproduction or display. Chapter 6 Patterns of Inheritance Chapter 6 Patterns of Inheritance Genetics Explains and Predicts Inheritance Patterns Genetics can explain how these poodles look different. Section 10.1 Genetics Explains and Predicts Inheritance Patterns

More information

S1 Appendix: Figs A G and Table A. b Normal Generalized Fraction 0.075

S1 Appendix: Figs A G and Table A. b Normal Generalized Fraction 0.075 Aiello & Alter (216) PLoS One vol. 11 no. 1 e164546 S1 Appendix A-1 S1 Appendix: Figs A G and Table A a Tumor Generalized Fraction b Normal Generalized Fraction.25.5.75.25.5.75 1 53 4 59 2 58 8 57 3 48

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

Statistical Analysis of Single Nucleotide Polymorphism Microarrays in Cancer Studies

Statistical Analysis of Single Nucleotide Polymorphism Microarrays in Cancer Studies Statistical Analysis of Single Nucleotide Polymorphism Microarrays in Cancer Studies Stanford Biostatistics Workshop Pierre Neuvial with Henrik Bengtsson and Terry Speed Department of Statistics, UC Berkeley

More information

Whole Genome and Transcriptome Analysis of Anaplastic Meningioma. Patrick Tarpey Cancer Genome Project Wellcome Trust Sanger Institute

Whole Genome and Transcriptome Analysis of Anaplastic Meningioma. Patrick Tarpey Cancer Genome Project Wellcome Trust Sanger Institute Whole Genome and Transcriptome Analysis of Anaplastic Meningioma Patrick Tarpey Cancer Genome Project Wellcome Trust Sanger Institute Outline Anaplastic meningioma compared to other cancers Whole genomes

More information

Reviewers' comments: Reviewer #1 (Remarks to the Author):

Reviewers' comments: Reviewer #1 (Remarks to the Author): Reviewers' comments: Reviewer #1 (Remarks to the Author): In this study the authors analysed 18 deep penetrating nevi for oncogenic genomic changes (single nucleotide variations, insertions/deletions,

More information

Supplementary information to:

Supplementary information to: Supplementary information to: Digital Sorting of Pure Cell Populations Enables Unambiguous Genetic Analysis of Heterogeneous Formalin-Fixed Paraffin Embedded Tumors by Next Generation Sequencing Authors

More information

EXAMPLE. - Potentially responsive to PI3K/mTOR and MEK combination therapy or mtor/mek and PKC combination therapy. ratio (%)

EXAMPLE. - Potentially responsive to PI3K/mTOR and MEK combination therapy or mtor/mek and PKC combination therapy. ratio (%) Dr Kate Goodhealth Goodhealth Medical Clinic 123 Address Road SUBURBTOWN NSW 2000 Melanie Citizen Referring Doctor Your ref Address Dr John Medico 123 Main Street, SUBURBTOWN NSW 2000 Phone 02 9999 9999

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

Cancer Genomes How to Analyze Your Own Genome

Cancer Genomes How to Analyze Your Own Genome Cancer Genomes 02-223 How to Analyze Your Own Genome Cancer vs. Heritable Diseases So far, we mostly discussed heritable diseases, where the disease causing mutaaons are inherited from one individual to

More information

Variant interpretation exercise. ACGS Somatic Variant Interpretation Workshop Joanne Mason 21/09/18

Variant interpretation exercise. ACGS Somatic Variant Interpretation Workshop Joanne Mason 21/09/18 Variant interpretation exercise ACGS Somatic Variant Interpretation Workshop Joanne Mason 21/09/18 Format of exercise Compile a list of tricky variants across solid cancer and haematological malignancy.

More information

HHS Public Access Author manuscript J Invest Dermatol. Author manuscript; available in PMC 2016 February 01.

HHS Public Access Author manuscript J Invest Dermatol. Author manuscript; available in PMC 2016 February 01. Rolling the genetic dice: neutral and deleterious Smoothened mutations in drug-resistant basal cell carcinoma Scott X. Atwood 1, Kavita Y. Sarin 1, Jiang R. Li 1, Catherine Yao 1, Nicole M. Urman 1, Anne

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

Supplemental Information. Genomic Characterization of Murine. Monocytes Reveals C/EBPb Transcription. Factor Dependence of Ly6C Cells

Supplemental Information. Genomic Characterization of Murine. Monocytes Reveals C/EBPb Transcription. Factor Dependence of Ly6C Cells Immunity, Volume 46 Supplemental Information Genomic Characterization of Murine Monocytes Reveals C/EBPb Transcription Factor Dependence of Ly6C Cells Alexander Mildner, Jörg Schönheit, Amir Giladi, Eyal

More information

Clustered mutations of oncogenes and tumor suppressors.

Clustered mutations of oncogenes and tumor suppressors. Supplementary Figure 1 Clustered mutations of oncogenes and tumor suppressors. For each oncogene (red dots) and tumor suppressor (blue dots), the number of mutations found in an intramolecular cluster

More information

Bioinformatics Laboratory Exercise

Bioinformatics Laboratory Exercise Bioinformatics Laboratory Exercise Biology is in the midst of the genomics revolution, the application of robotic technology to generate huge amounts of molecular biology data. Genomics has led to an explosion

More information

Supplementary Figures

Supplementary Figures Supplementary Figures Supplementary Fig 1. Comparison of sub-samples on the first two principal components of genetic variation. TheBritishsampleisplottedwithredpoints.The sub-samples of the diverse sample

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

Broad H3K4me3 is associated with increased transcription elongation and enhancer activity at tumor suppressor genes

Broad H3K4me3 is associated with increased transcription elongation and enhancer activity at tumor suppressor genes Broad H3K4me3 is associated with increased transcription elongation and enhancer activity at tumor suppressor genes Kaifu Chen 1,2,3,4,5,10, Zhong Chen 6,10, Dayong Wu 6, Lili Zhang 7, Xueqiu Lin 1,2,8,

More information

(a) Schematic diagram of the FS mutation of UVRAG in exon 8 containing the highly instable

(a) Schematic diagram of the FS mutation of UVRAG in exon 8 containing the highly instable Supplementary Figure 1. Frameshift (FS) mutation in UVRAG. (a) Schematic diagram of the FS mutation of UVRAG in exon 8 containing the highly instable A 10 DNA repeat, generating a premature stop codon

More information

Expanded View Figures

Expanded View Figures Solip Park & Ben Lehner Epistasis is cancer type specific Molecular Systems Biology Expanded View Figures A B G C D E F H Figure EV1. Epistatic interactions detected in a pan-cancer analysis and saturation

More information

High-order chromatin architecture determines the landscape of chromosomal alterations in cancer

High-order chromatin architecture determines the landscape of chromosomal alterations in cancer High-order chromatin architecture determines the landscape of chromosomal alterations in cancer 9/6/11 Geoff Fudenberg 1, Gad Getz 2, Matthew Meyerson 2,3,4,5, Leonid Mirny 6,7 Author Affiliations: 1 Harvard

More information

ACTIVITY 2: EXAMINING CANCER PATIENT DATA

ACTIVITY 2: EXAMINING CANCER PATIENT DATA OVERVIEW Refer to the Overview of Cancer Discovery Activities for Key Concepts and Learning Objectives, Curriculum Connections, and Prior Knowledge, as well as background information, references, and additional

More information

Nature Genetics: doi: /ng Supplementary Figure 1. Clinical timeline for the discovery WES cases.

Nature Genetics: doi: /ng Supplementary Figure 1. Clinical timeline for the discovery WES cases. Supplementary Figure 1 Clinical timeline for the discovery WES cases. This illustrates the timeline of the disease events during the clinical course of each patient s disease, further indicating the available

More information

Journal: Nature Methods

Journal: Nature Methods Journal: Nature Methods Article Title: Network-based stratification of tumor mutations Corresponding Author: Trey Ideker Supplementary Item Supplementary Figure 1 Supplementary Figure 2 Supplementary Figure

More information

Epigenetics. Jenny van Dongen Vrije Universiteit (VU) Amsterdam Boulder, Friday march 10, 2017

Epigenetics. Jenny van Dongen Vrije Universiteit (VU) Amsterdam Boulder, Friday march 10, 2017 Epigenetics Jenny van Dongen Vrije Universiteit (VU) Amsterdam j.van.dongen@vu.nl Boulder, Friday march 10, 2017 Epigenetics Epigenetics= The study of molecular mechanisms that influence the activity of

More information

Computational Systems Biology: Biology X

Computational Systems Biology: Biology X Bud Mishra Room 1002, 715 Broadway, Courant Institute, NYU, New York, USA L#4:(October-0-4-2010) Cancer and Signals 1 2 1 2 Evidence in Favor Somatic mutations, Aneuploidy, Copy-number changes and LOH

More information

Genome-wide copy-number calling (CNAs not CNVs!) Dr Geoff Macintyre

Genome-wide copy-number calling (CNAs not CNVs!) Dr Geoff Macintyre Genome-wide copy-number calling (CNAs not CNVs!) Dr Geoff Macintyre Structural variation (SVs) Copy-number variations C Deletion A B C Balanced rearrangements A B A B C B A C Duplication Inversion Causes

More information