--- title: "Using singscore to predict mutation status in AML from transcriptomic signatures" author: - name: Dharmesh D Bhuva affiliation: - Bioinformatics Division, Walter and Eliza Hall Institute of Medical Research, Parkville, VIC 3052, Australia - School of Mathematics and Statistics, University of Melbourne, Parkville, VIC 3010, Australia email: bhuva.d@wehi.edu.au - name: Momeneh Foroutan affiliation: - Department of Clinical Pathology, The University of Melbourne Centre for Cancer Research, Victorian Comprehensive Cancer Centre, Melbourne, Victoria 3000, Australia email: momeneh.foroutan@unimelb.edu.au - name: Yi Xie affiliation: - Bioinformatics Division, Walter and Eliza Hall Institute of Medical Research, Parkville, VIC 3052, Australia email: xie.y@wehi.edu.au - name: Ruqian Lyu affiliation: - Bioinformatics Division, Walter and Eliza Hall Institute of Medical Research, Parkville, VIC 3052, Australia email: lyu.r@wehi.edu.au - name: Joseph Cursons affiliation: - Bioinformatics Division, Walter and Eliza Hall Institute of Medical Research, Parkville, VIC 3052, Australia - Department of Medical Biology, University of Melbourne, Parkville, VIC 3010, Australia email: cursons.j@wehi.edu.au - name: Melissa J Davis affiliation: - Bioinformatics Division, Walter and Eliza Hall Institute of Medical Research, Parkville, VIC 3052, Australia - Department of Medical Biology, University of Melbourne, Parkville, VIC 3010, Australia - Department of Biochemistry and Molecular Biology, Faculty of Medicine, Dentistry and Health Sciences, University of Melbourne, Parkville, VIC, 3010, Australia email: davis.m@wehi.edu.au date: "`r format(Sys.time(), '%b %Y')`" output: BiocStyle::html_document: toc_float: true fig_caption: true number_sections: true nocite: | @R-ggplot2, @R-plyr, @R-reshape2, @R-gridExtra, @R-BiocStyle, @R-knitr, @R-BiocWorkflowTools, @R-rmarkdown bibliography: [bibliography.bib, packages.bib] vignette: > %\VignetteIndexEntry{Using singscore to predict mutations in AML from transcriptomic signatures} %\VignetteEngine{knitr::rmarkdown} %\VignetteEncoding{UTF-8} keywords: single sample, gene set scoring, signature scoring, AML mutations, NPM1c mutation, mutation prediction, TCGA abstract: > Advances in RNA sequencing (RNA-seq) technologies that measure the transcriptome of biological samples have revolutionised our ability to understand transcriptional regulatory programs that underpin diseases such as cancer. We recently published singscore - a single-sample, rank-based gene set scoring method which quantifies how concordant the transcriptional profile of individual samples are relative to specific gene sets of interest. Here we demonstrate the application of singscore to investigate transcriptional profiles associated with specific mutations or genetic lesions in acute myeloid leukemia. Using matched genomic and transcriptomic data available through The Cancer Genome Atlas we show that scoring of appropriate signatures can distinguish samples with corresponding mutations, reflecting the ability of these mutations to drive aberrant transcriptional programs involved in leukemogenesis. We believe the singscore method is particularly useful for studying heterogeneity within a specific subsets of cancers, and as demonstrated, we show the ability of singscore to identify where alternative mutations appear to drive similar transcriptional programs. ---

**R version**: `r R.version.string`
**Bioconductor version**: `r BiocManager::version()`
**Package version**: `r packageVersion("SingscoreAMLMutations")`

```{r setup, include=FALSE} #set knitr chunk options knitr::opts_chunk$set(warning = FALSE, message = FALSE) #load packages to avoid startup messages later in the code suppressPackageStartupMessages({library(SingscoreAMLMutations)}) library(ggplot2) library(TCGAbiolinks) library(SummarizedExperiment) library(edgeR) library(rtracklayer) library(plyr) library(org.Hs.eg.db) library(GSEABase) library(singscore) library(reshape2) library(gridExtra) library(dcanr) #ggplot theme rl = 1.2 current_theme = theme_minimal() + theme( panel.border = element_rect(colour = 'black', fill = NA), panel.grid.minor = element_blank(), axis.title = element_text(size = rel(rl) * 1.1), axis.text = element_text(size = rel(rl)), plot.title = element_text(size = rel(rl)), strip.background = element_rect(fill = NA, colour = 'black'), strip.text = element_text(size = rel(rl)), legend.text = element_text(size = rel(rl)), legend.title = element_text(size = rel(rl), face = 'italic'), legend.position = 'bottom', legend.direction = 'horizontal' ) #automatically create a bib database for R packages knitr::write_bib(c( .packages(), 'knitr', 'rmarkdown', 'BiocStyle' ), 'packages.bib') ``` Introduction {#intro} ============ The development of microarrays and more recently the rapid uptake of RNA-sequencing technologies have provided a platform to examine the transcriptional profile (or transcriptome) of biological samples [@cieslik18]. Transcriptomic analyses have traditionally focused on 'differential expression' of genes between sets of samples, however with the rapid growth of publicly available RNA data there has been increasing usage of 'relative approaches', which quantify the relative concordance of a sample or samples with a specific gene signature [@cieslik18]. While sequencing of genomic mutations has been important for classifying different tumour subsets based upon the presence of mutations or fusion genes, and identifying genetic lesions which may act as drivers of cancer progression, transcriptomic profiling can provide further information on the state or phenotype of cells carrying these mutations. Cancers are a heterogeneous set of diseases with a number of clinical and pathological subtypes. In diseases such as breast cancer the primary clinical classifications relate to the expression of hormone receptors (estrogen receptor: ER; and progesterone receptor: PR) or the overexpression of Erb-B2 receptor tyrosine kinase (*HER2*), as these features can be directly targeted with therapeutic agents. A common example of transcriptomic or gene expression data informing clinical practice is the use of prediction analysis of microarray 50 (PAM50) signatures for distinguishing the intrinsic breast cancer subtypes [@parker09, @cieslik18]. For many other cancers, subtype classification has largely relied upon identifying sets of recurrent mutations across large patient cohorts, with whole genome or whole exome sequencing studies helping to resolve the clinically significant subtypes [@cancer13, @papaemmanuil16]. Perhaps the most well-known 'relative approach' is single-sample gene set enrichment analysis (ssGSEA) [@barbie09], often used through the [GenePattern web-tool](http://software.broadinstitute.org/cancer/software/genepattern/modules/docs/ssGSEAProjection/4). Another common approach is [gene set variation analysis (GSVA)](https://bioconductor.org/packages/release/bioc/html/GSVA.html) [@hanzelmann13] which is available as an R/Bioconductor package that also includes functionality for ssGSEA, an alternative approach known as PLAGE [@tomfohr05], and a z-score based approach [@lee08]. Both ssGSEA and GSVA use a Kolmogorov-Smirnov like random-walk statistic to convert normalised gene ranks to the resulting score, however this normalisation procedure means that the scores are not truly 'single-sample', and variations in the overall sample composition for a study (e.g. variations in the presence or relative frequency of different cancer subtypes) can lead to unexpected changes in sample scores. Furthermore, the resultant scores from these methods can vary in their range and absolute value, making them difficult to interpret without further processing. To overcome this, we have developed a single-sample gene set scoring method [singscore]() [@foroutan18] which simply uses the ranks of genes within a given set, normalised relative to the maximum and minimum theoretical scores for a gene set of a given size. Through large scale efforts such as The Cancer Genome Atlas (TCGA), transcriptomic data are available for thousands of clinical samples, often together with corresponding genomic or epigenomic (often DNA methylation) data. These transcriptomic data can help to characterise the functional effects of corresponding mutations, and provide a window to study the heterogeneity which arises within different subtypes of cancer due to epigenetic and transcriptional regulatory programs which can also influence cell behaviour. Here, we demonstrate that the single-sample gene set scoring method singscore [@foroutan18] can be used to classify TCGA AML samples using transcriptional 'gene signatures' for the NPM1c mutation, *KMT2A* (*MLL*) gene fusions, and *PML-RARA* gene fusions that were derived from independent studies. Without any need for parameter fitting or estimation, we show that gene set scoring with singscore can distinguish samples carrying these mutations. The case studies we present demonstrate the application of gene set scoring to examine not only the differences, but also the relative similarities between established subtypes of AML that impact clinical outcome. Description of the biological problem {#biol-problem} ===================================== As with most cancers, acute myeloid leukemia (AML) is a heterogeneous disease with a number of classified subtypes. Analysis of TCGA AML genomic data identified a number of subtypes based upon the presence or absence of specific 'driver mutations'; recapitulating and expanding upon previously identified clinical subsets [@cancer13]. A more recent study which focused primarily on genomic data has further refined the clinically significant AML subtypes [@papaemmanuil16], highlighting a number of co-occurring as well as mutually exclusive mutations. Of note for this work, one of the most common mutations in clinical AML samples is a frameshift mutation within exon 12 of the nucleophosmin (*NPM1*) gene [@papaemmanuil16]. This mutation leads to aberrant localisation of nucleophosmin with cytoplasmic accumulation rather than localising to the nucleolus, and accordingly this mutation is often referred to as the NPM1c mutation [@brunetti18]. As noted by @verhaak05, the NPM1c mutation is associated with dysregulated activity of the homeobox domain (Hox) family of transcription factors which are essential for developmental patterning. The effects of this mutation in disease progression have been further demonstrated in recent work which showed that loss of NPM1c leads to differentiation of AML cells [@brunetti18]. Further recurrent genetic lesions in AML relevant for this work include lysine methyl transferase 2A (*KMT2A*; previously known as *MLL*) fusion genes, partial tandem duplications within *KMT2A* (*KMT2A*-PTD), and fusion genes between promyelocytic leukemia and retinoic acid receptor alpha (*PML-RARA*). Given the role of NPM1c in dysregulating the Hox gene family, it is interesting to note that AML samples with MLL fusion genes also show dysregulated expression of Hox family genes [@hess04, @ross04]; however, samples with *MLL*-PTD appear to show a relatively distinct phenotype from MLL-fusion samples [@ross04]. While there is good evidence demonstrating the role of NPM1c mutations and other genetic lesions in blocking AML cell differentiation, the *PML-RARA* fusion subset is diagnostic for a specific subset of AML known as acute promyelocytic leukemia (APL). This clinically distinct subtype of AML is associated with a specific morphology under the French-American-British (FAB) classification of AML, FAB-M3, with cells showing a distinct morphology due to a differentiation block at the promyelocyte stage [@dethe91]. In this workflow we demonstrate the ability of the singscore method for single sample gene set scoring [@foroutan18] to classify tumour 'driver mutations' from transcriptomic data. We use a previously identified gene signature for the NPM1c mutation [@verhaak05]. We also use signatures for *PML-RARA* gene fusions and MLL-fusions that were derived using pediatric AML samples but shown to work well for classifying adult AML samples with similar lesions [@ross04], although we note that there is evidence of relatively large differences in the mutational profiles of adult and pediatric cancers [@ma18]. Using these signatures, which are included within the molecular signatures database (MSigDB) [@liberzon15], we demonstrate that a bi-directional scoring approach can classify TCGA AML samples with corresponding mutations with a good precision and recall. A particularly useful feature of gene set scoring is the ability to project samples onto 2D or higher-order landscapes defined by corresponding phenotypic signatures. Accordingly, by comparing scores for both the NPM1c and *KMT2A*-/*MLL*-fusion signatures, we show that this classification likely arises through the shared downstream biological effects of Hox family dysregulation. We also compare the NPM1c mutation signature to the *PML-RARA* signature and show a clear separation of these subtypes reflecting their divergent phenotypes and the mutually exclusive nature of these mutations. Downloading and preparing the data {#download-and-prepare} ================================== Data from TCGA project is made available through the Genomic Data Commons (GDC). Open access data from the project can be accessed in multiple pre-processed formats. Transcriptomic data can be downloaded either at the count level or as FPKM transformed abundance, before or after upper quantile normalisation. Other pre-processed version can be found from sources such as the [cBioPortal](http://www.cbioportal.org/) and [FireBrowse](http://firebrowse.org). The GDC data used STAR to perform a two-pass alignment followed by quantification using HTSeq. Data from the GDC can be downloaded using the [GDC data transfer tool](https://gdc.cancer.gov/access-data/gdc-data-transfer-tool) which allows users to select the specific files of interest using the GDC portal. These files then have to be read, merged, annotated and processed into a data structure that simplifies downstream analysis. Alternatively, all the above mentioned steps, including the download, can be performed using the R package [`TCGAbiolinks`](http://bioconductor.org/packages/release/bioc/html/TCGAbiolinks.html) [@colaprico15, @R-TCGAbiolinks]. The package supports data download using the GDC API and the GDC client. We will use the TCGAbiolinks package to download, annotate and process the data into a SummarizedExperiment R object. The following steps need to be performed to prepare the data: 1. Create a query to select the files to download 2. Execute the query and download the data 3. Read the data into R 4. Filter out genes with low expression 5. Normalise the data for compositional bias and transform to account for gene-length biases as outlined in the singscore manuscript [@foroutan18] Querying the GDC database {#gdc-query} ------------------------- The first step in any analysis should be to determine and report the data version and the service used to download the data. The `getGDCInfo()` function returns the release date of all data on the GDC along with a version. ```{r gdc_query} library(SingscoreAMLMutations) library(TCGAbiolinks) #get GDC version information gdc_info = getGDCInfo() gdc_info ``` A query then needs to be run, using the GDC to identify the specific files for download. This step is similar to generating a *MANIFEST* file using the GDC portal. The first parameter of the query specifies the project - available projects can be accessed using `getGDCprojects()` or from . The TCGA acute myeloid leukemia data is part of the TCGA-LAML project. Following this, the data category, data type and workflow type need to be specified. The query formed below selects files containing the count level transcriptomic measurements. Values for different parameters of the query can be identified from "searching arguments" section of the "query" vignette: `vignette("query", package = "TCGAbiolinks")`. The result of this query will be a dataframe containing filenames and additional annotations related to the files. Read count level data are selected instead of the processed FPKM data as one of the downstream pre-processing analysis results in filtering out of genes. A general recommendation is to compute FPKM values after filtering genes out so as to ensure counts are normalised by the corresponding library sizes. In cases where count-level data is not available, filtering can be performed directly on FPKM values, provided that the library size is large enough. ```{r gdc_results} #form a query for the RNAseq data query_rna = GDCquery( #getGDCprojects() project = 'TCGA-LAML', #TCGAbiolinks:::getProjectSummary('TCGA-LAML') data.category = 'Transcriptome Profiling', data.type = 'Gene Expression Quantification', workflow.type = 'HTSeq - Counts' ) #extract results of the query rnaseq_res = getResults(query_rna) dim(rnaseq_res) colnames(rnaseq_res) ``` Downloading the TCGA AML RNA-seq read counts {#download-data} -------------------------------------------- The `GDCdownload` function then executes the query on the GDC database and begins downloading the data using the GDC API. The download method should be changed to "client", if the size of the data is expected to be large, e.g for RNA-seq read data or methylation data. It is good practice to specify the directory for data storage - we store all the data in the "GDCdata" directory in the temporary directory. Users should store their data in a permanent storage to retain the data. The function downloads the data and organises it into the folder based on parameters specified in the query. This allows multiple different levels and types of data to be stored in the same directory structure. Files with counts are stored at *TEMPDIR/GDCdata/TCGA-LAML/harmonized/Transcriptome_Profiling/Gene_Expression_Quantification/*. ```{r gdc_download, results='hide'} datapath = file.path(tempdir(), 'GDCdata') GDCdownload(query_rna, directory = datapath) #(size: 39MB) ``` Reading count-level data into R {#read-data} ------------------------------- The `GDCprepare` function reads and processes the downloaded data into a `RangedSummarizedExperiment` object from the `SummarizedExperiment` package [@R-SummarizedExperiment] which allows patient annotations, gene annotations and count data to be stored in one object. Patient annotations are downloaded upon calling this function and subsequently mapped and attached to the resulting object. A RangedSummarizedExperiment object is similar to an ExpressionSet object but provides added functionality such as indexing with genomic coordinates and storing multiple data matrices with the same structure. Feature annotations used to annotate the data are stored in an RDA/RDATA file. ```{r gdc_prepare, results='hide'} aml_se = GDCprepare(query_rna, directory = datapath) ``` The object contains data for 56,925 features and 151 samples. The original data files contain 60,483 features, some of which (3,881) could not be mapped to ENSEMBL GRCh38.p12. Feature and sample annotations can be accessed using `rowData(se)` and `colData(se)`, respectively, and the counts data can be accessed using `assay(se)`. TCGA data usually contains some formalin-fixed paraffin-embedded (FFPE) samples which should be discarded from the analysis as the protocol introduces biological artefacts. This procedure is only performed on solid tumours and not leukemias, therefore, no filtering is required for this data set. ```{r show_se} aml_se ``` Filter out genes with low counts {#filter-data} -------------------------------- The `edgeR` package [@R-edgeR] contains methods that assist in the data normalisation and transformation required for filtering and subsequent steps. The methods require a DGEList object therefore we begin by creating a DGEList for the AML data from the SummarizedExperiment. ```{r remove_dups} library(SummarizedExperiment) library(edgeR) aml_dge = DGEList(counts = assay(aml_se), genes = rowData(aml_se)) ``` Genes with low counts across most samples are discarded from the analysis. This is a standard step in differential expression analysis as inclusion of such genes in the analysis could skew estimates of dispersion. It is also motivated in rank-based analysis, such as with singscore, to avoid rank duplication. Rank duplication reduces the discriminant power of scores as the number of unique ranks is reduced. A commonly used filter is to select only those genes that have CPMs above a certain threshold across a proportion of samples. Filtering is performed on the CPMs rather than raw counts as the former accounts for variation in library sizes, therefore, is unbiased. For instance, a CPM of 1 would equate to read counts between 19 and 50 for samples in the AML data where library sizes vary between 18.6 and 49.7 million reads. Here, we retain genes that have a CPM > 1 across more than 50% of the samples. Other methods to filter out genes with low counts exist and may be preferable in specific applications. @chen16 and @law16 filter genes based on the experimental design whereby the proportion of samples with enough read counts are evaluated per experimental group. As the AML data have many samples, filtering is performed across all samples rather than within sub-groups. Group specific filtering would be recommended for the study of rare groups. The distribution of logCPMs is much closer to the expected log-normal distribution after filtering out genes with low counts as seen in Figure \@ref(fig:plot-hist-filtering). ```{r plot-hist-filtering, fig.wide=TRUE, fig.cap="Histogram of logCPM values for the AML data before and after filtering. Filtering results in fewer zeros in the data. Most genes with CPM less than 1, logCPM < 0; (red line) across the majority of samples get discarded, resulting in an approximately log-normal distribution."} prop_expressed = rowMeans(cpm(aml_dge) > 1) keep = prop_expressed > 0.5 op = par(no.readonly = TRUE) par(mfrow = c(1, 2)) hist(cpm(aml_dge, log = TRUE), main = 'Unfiltered', xlab = 'logCPM') abline(v = log(1), lty = 2, col = 2) hist(cpm(aml_dge[keep, ], log = TRUE), main = 'Filtered', xlab = 'logCPM') abline(v = log(1), lty = 2, col = 2) par(op) ``` ```{r remove_low_counts} #subset the data aml_dge = aml_dge[keep, , keep.lib.sizes = FALSE] aml_se = aml_se[keep, ] ``` Transformation to FPKM values and normalisation {#calc-fpkm} ----------------------------------------------- Singscore requires gene expression measurements to be comparable between genes within a sample, therefore, correction for gene length bias needs to be performed [@oshlack09]. Transformations such as transcripts per million (TPM) and reads/fragments per kilobase per million (RPKM/FPKM), that normalise by gene length, may be used. Both- TPM and RPKM/FPKM values should produce similar results when applying singscore provided that the library size is large enough, which they are here. RPKM values are generally computed after correcting for compositional biases. The `calcNormFactors` function in edgeR provides three methods to do so, TMM normalisation being the default. @chen16 and @law16 discuss the implications of normalisation prior to down-stream processing such as differential expression analysis. Normlisation is generally performed for cross-sample analysis where samples need to be comparable. Singscores are invariant to data normalisation as the analysis is contained within the sample of interest. The idea extends to any transformation that preserves the relative ranks of genes within a sample such as a log transformation. Here, we use TMM normalisation solely for visualisation purposes. Data transformation to TPM or RPKM/FPKM requires the lengths for all genes to be calculated. Gene lengths need to be computed based on the alignment and quantification parameters. The TCGA transcriptomic data has been aligned using STAR and quantified using HTSeq (details of the pipeline available at ). HTSeq quantifies reads mapping to the exons of each gene, therefore, effective gene lengths can be calculated as the sum of all exons spanning the gene. The GENCODE v22 annotation file was used for quantification therefore the same file needs to be used to compute gene lengths. ```{r download_gencode, results='hide'} #download v22 of the GENCODE annotation gencode_file = 'gencode.v22.annotation.gtf.gz' gencode_link = paste( 'ftp://ftp.ebi.ac.uk/pub/databases/gencode/Gencode_human/release_22', gencode_file, sep = '/' ) download.file(gencode_link, gencode_file, method = 'libcurl') #(size: 39MB) ``` The `rtracklayer` R package [@R-rtracklayer] provides functions to help parse GTF files. ```{r compute_gene_lengths} library(rtracklayer) library(plyr) gtf = import.gff(gencode_file, format = 'gtf', genome = 'GRCm38.71', feature.type = 'exon') #split records by gene to group exons of the same gene grl = reduce(split(gtf, elementMetadata(gtf)$gene_id)) gene_lengths = ldply(grl, function(x) { #sum up the length of individual exons return(c('gene_length' = sum(width(x)))) }, .id = 'ensembl_gene_id') ``` Genes are also annotated with their biotype for further analysis. The annotation file uses Ensembl IDs with versions as keys to records, which then need to be converted to Ensembl IDs. This is simply achieved by truncating the trailing version number. ```{r add_biotype} #extract information on gene biotype genetype = unique(elementMetadata(gtf)[, c('gene_id', 'gene_type')]) colnames(genetype)[1] = 'ensembl_gene_id' gene_lengths = merge(genetype, gene_lengths) #remove ENSEMBL ID version numbers gene_lengths$ensembl_gene_id = gsub('\\.[0-9]*', '', gene_lengths$ensembl_gene_id) saveRDS(gene_lengths, file = 'gene_lengths_HTSeq_gencodev22.rds') gene_lengths ``` The SummarizedExperiment object allows feature annotations to be stored, therefore, information on gene length and biotypes should be added to the existing annotations. Similarly, annotations need to be added to the DGEList object. The column containing lengths should include "length" in its name. ```{r add_length_annotation} #allocate rownames for ease of indexing rownames(gene_lengths) = gene_lengths$ensembl_gene_id rowData(aml_se)$gene_length = gene_lengths[rownames(aml_se), 'gene_length'] rowData(aml_se)$gene_biotype = gene_lengths[rownames(aml_se), 'gene_type'] #annotate gene lengths for the DGE object aml_dge$genes$length = gene_lengths[rownames(aml_dge), 'gene_length'] ``` RPKM/FPKM values can now be calculated with the computed gene lengths after computing the normalisation factors. The SummarizedExperiment object can store multiple levels of the data simultaneously, provided that the number of features and samples remains the same across measurements. As such, FPKM values are appended to the existing object. ```{r compute_fpkm} aml_dge_tmm = calcNormFactors(aml_dge, method = 'TMM') #compute FPKM values and append to assays assay(aml_se, 'logFPKM_TMM') = rpkm(aml_dge_tmm, log = TRUE) aml_se ``` Annotate samples with mutation data {#annotate-mutations} ----------------------------------- For this analysis we have used the curated mutation list from the original TCGA AML publication [@cancer13] (Supplemental Table 01 at ) rather than variant calls from the standard TCGA pipeline (available through the [National Cancer Institute Genomic Data Commons](https://gdc.cancer.gov/)) and readers should note that there are some discrepancies between these. For genetic lesions of interest (NPM1c, *KMT2A-MLL*, *KMT2A*-PTD and *PML-RARA*), patients were identified by the following criteria: * **Patient ID**: The 'TCGA Patient ID' column was extracted directly * **NPM1c**: TRUE if the 'NPM1' column contains the strings 'p.W287fs' or 'p.W288fs' * **KMT2A-fusion**: TRUE if the 'MLL-partner' column contains the string 'MLL-' or '-MLL' (note that the official gene symbol for *MLL* is now *KMT2A*) * **KMT2A-PTD**: TRUE if the 'MLL-PTD' column contains the string 'exons' * **PML-RARA**: TRUE if the 'PML-RARA' column contains the string 'PML-RARA' ```{r preproc_mutations, eval=FALSE, include=FALSE} #preprocessing - read tsv (Joe's version) and convert save as RDS mut_info = read.csv('PatientMutations.tsv', sep = '\t', colClasses = c('character', rep('logical', 4))) rownames(mut_info) = mut_info$Barcode mut_info = mut_info[, -1] patients = mut_info[substring(colnames(aml_se), 1, 12), ] rownames(patients) = colnames(aml_se) saveRDS(patients, file = 'AMLPatientMutationsTCGA.rds') ``` ```{r annotate_mutations} data(AMLPatientMutationsTCGA) patient_mutations = AMLPatientMutationsTCGA patient_mutations = patient_mutations[colnames(aml_se), ] # order samples aml_mutations = colnames(patient_mutations) # get mutation labels colData(aml_se) = cbind(colData(aml_se), patient_mutations) colData(aml_se)[, aml_mutations] ``` Map Ensembl IDs to Entrez IDs {#map-gene-ids} ----------------------------- Ensembl annotations (Ensembl IDs) have higher coverage of the genome which may be useful in applications such as variant calling and similar exploratory analysis [@zhao15]. However, RefSeq annotations (Entrez IDs) may be better suited to RNA-seq analyses which require a stable reference annotation for comparison [@wu13]. As such, we choose to map Ensembl IDs to Entrez IDs and discard any unmapped features. Mapping can be performed using the Ensembl Biomart service, which can be queried using the biomaRt bioconductor package. This would provide the most up to date annotations. Alternatively, mapping could be performed with the bi-annually updated `org.Hs.eg.db` annotation R package [@R-org.Hs.eg.db] which provides a stable set of annotations, thereby enhancing reproducibility. Mapping is performed with the `mapIds` function in the `AnnotationDbi` R package [@R-AnnotationDbi]. ```{r map_ensembl_entrez} library(org.Hs.eg.db) rowData(aml_se)$entrezgene = mapIds( org.Hs.eg.db, keys = rownames(aml_se), keytype = 'ENSEMBL', column = 'ENTREZID', multiVals = 'asNA' ) gene_annot = rowData(aml_se) ``` Multimapped Ensembl IDs are replaced by `NAs`, then discarded to enforce unique mapping. Similarly, Entrez IDs that map to multiple Ensembl IDs are identified from the mapping, and discarded. Only features with unique Ensembl ID to Entrez ID mappings remain. ```{r discard_multimapped_genes} #select genes with mapped Entrez IDs keep = !is.na(gene_annot$entrezgene) #select genes with unique Entrez IDs dup_entrez = gene_annot$entrezgene[duplicated(gene_annot$entrezgene)] keep = keep & !gene_annot$entrezgene %in% dup_entrez #Biotype of discarded genes (due to non-unique mapping) head(sort(table(gene_annot[!keep, 'gene_biotype']), decreasing = TRUE), n = 10) #subset the data aml_se = aml_se[keep, ] ``` Transcriptional signatures to predict mutation status {#transcriptional-mut-sig} ===================================================== The signature by @verhaak05 is now used to predict the mutation status of the NPM1c mutation. This is done by quantifying the concordance of genes in the signature with their expression in each sample. As such, high expression of up-regulated genes and low expression of down-regulated genes would result in higher scores. This single value can then be used to predict the mutation status of individual samples if these data were unavailable. The signatures of interest are first downloaded from the MSigDB and read into `GeneSet` objects from the `GSEABase` R package [@R-GSEABase]. We then use the `singscore` R/Bioconductor package to quantify each sample for the Verhaak signature. Some of the visualisation and diagnostic tools within the `singscore` package are used to interpret the signatures and scores. Finally, we use a simple logistic regression model on the scores to predict the mutation status. Download signature and load into R {#prepare-signature} ---------------------------------- The @verhaak05 signature is composed of an up-regulated and a down-regulated gene set. Many signatures are developed in such a manner to improve discrimination of samples. MSigDB stores such signatures using names with suffixes "_UP" and "_DN" representing the independent components of the signature. Here, we form the download links for the signature with the base name "VERHAAK_AML_WITH_NPM1_MUTATED". ```{r signature_names} #create signature names verhaak_names = paste('VERHAAK_AML_WITH_NPM1_MUTATED', c('UP', 'DN'), sep = '_') verhaak_names ``` The signatures are then downloaded using the links, resulting in an XML file for each component of the signature. The `mapply` function is used to run the download function on all pairs of link-output arguments. ```{r download_signatures, results='hide'} #generate URLs verhaak_links = paste0( 'http://software.broadinstitute.org/gsea/msigdb/download_geneset.jsp?geneSetName=', verhaak_names, '&fileType=xml' ) #download files verhaak_files = paste0(verhaak_names, '.xml') mapply(download.file, verhaak_links, verhaak_files, method = 'libcurl') ``` Functions in the `GSEABase` package help with reading, parsing and processing the signatures. Signatures from an MSigDB XML file can be read using the `getBroadSets` function which results in a `GeneSet` object. Gene symbols, Entrez IDs and affymetrix chip IDs from the original experiment (HG-U133A in this case) are stored in the XML file. Entrez IDs are read from the file as these can be mapped directly to our data. Conversions to other identifiers can be achieved using the `mapIdentifiers` function from `GSEABase` and an annotation package that contains the mappings. The advantage of using this function instead of the `mapIds` function from the `AnnotationDbi` package is that the former retains the `GeneSet` object after conversion of IDs. ```{r read_signatures} library(GSEABase) verhaak_sigs = getBroadSets(verhaak_files, membersId = 'MEMBERS_EZID') verhaak_sigs ``` To make data indexing easier during signature scoring, row names of the `SummarisedExperiment` object are changed to Entrez IDs which are already part of the row annotations. ```{r rows_to_entrez} rownames(aml_se) = rowData(aml_se)$entrezgene ``` Score TCGA AML samples using the Verhaak signature {#score-samples} -------------------------------------------------- Singscore is a rank based metric of gene set enrichment in single samples. Scores for multiple signatures make use of the same ranked expression per sample. As such, it makes sense to compute the ranks only once and re-use them for scoring different signatures. The implementation separates these two phases of the analysis to reduce the computational cost of scoring. The `rankGenes` function will compute ranks from expression data in the form of either a numeric matrix, numeric data frame, ExpressionSet object, DGEList object or a SummarizedExperiment object. Users also have to specify what method should be used to break ties. The default is 'min' and we recommend this be used for RNA-seq data which may have many genes with zero counts. This will reduce the effect of zeros in the scores, however, appropriate pre-filtering of genes with low counts will still be required. ```{r compute_ranks_aml} library(singscore) #apply the rankGenes method to each version of the dataset, excluding counts aml_ranked = rankGenes(assay(aml_se, 'logFPKM_TMM')) ``` Singscores can be computed using three modes, depending on the properties of the gene signature. The first mode of operation is applied when two directed gene sets (expected up- and down-regulated gene sets) form the transcriptomic signature. Many signatures in the MSigDB, including the @verhaak05 signature come in such pairs. This mode can be invoked by passing the up- and down-regulated gene sets to the arguments `upSet` and `downSet` respectively. In some cases, only one set of genes forms the signature. If all genes in the gene set are up-regulated or all down-regulated, the second mode of operation applies and is invoked by passing the gene set to the `upSet` argument. For sets of down-regulated genes, the score would simply be inverted (-score if scores are centered, 1 - score otherwise). Finally, if the user is unsure of the composition of genes in the gene-set, such that, the gene set may contain both up- and down- regulated genes, the final mode of singscore applies. The gene set is passed to the `upSet` argument similar to the previous mode with the additional argument `knownDirection` set to `FALSE`. By default, singscores are centered such that the range of scores is $[-1, 1]$ and $[-0.5, 0.5]$ for the first two modes respectively. Negative scores indicate an inverse enrichment of signatures, that is, expected up-regulated genes are in fact down-regulated and vice-versa. Scores from the last mode can not be centered and have the range $[0, 1]$. In this mode, high scores are obtained when ranks of genes are distant from the median and low scores obtained when ranks converge to the median rank. If scores are centered in this scenario, it would lead to the conclusion that a negative score shows inverted enrichment, which is not the case. Score centering only serves the purpose of easing interpretation for users, a simple linear transformation is applied to achieve it. Scores for the NPM1c mutation signature are computed using the default settings, with the first mode of operation being used due to the presence of an up- and down- regulated gene set. The function returns a data frame reporting the score and dispersion of ranks for the up-regulated gene set, down-regulated gene set and the combination of both. Dispersion of the combined gene set in this mode is simply the mean of the independent dispersion estimates. If any gene names/IDs are present in the signature but missing in the expression data, a warning will be reported. ```{r compute_scores_verhaak, warning=TRUE} #apply the scoring function verhaak_scores = simpleScore(aml_ranked, upSet = verhaak_sigs[[1]], downSet = verhaak_sigs[[2]]) ``` It should be noted that singscores are composed of two components, an enrichment score and a dispersion estimate of ranks. The quantity of interest in gene set enrichment is the distribution of the expression or ranks of genes in the signature. In an ideal scenario, all expected up-regulated genes would have high expression therefore higher values of ranks. As such, ranks would be distributed on the higher end of the entire rank spectrum. Singscore aims to quantify this distribution of ranks, therefore, computes and reports the average and dispersion of ranks of genes in the signature relative to all other genes. The first quantity is similar to scores computed from all other single sample scoring methods. We determined a two component score to be a more appropriate and accurate representation of the distribution of ranks of signature genes. The default and recommended measure of dispersion is the median absolute deviation (MAD) due to its non-parametric property. Other appropriate measure of dispersion could be the inter-quartile range (IQR) and can be used by passing the `IQR` function as an argument to the `dispersionFun` argument. ```{r} head(verhaak_scores) ``` Diagnostics of the Verhaak signature {#diagnostics-verhaak} ------------------------------------ The `singscore` package provides a set of visualisation tools that enable diagnostics of the gene signature. For instance, these tools may be used to determine the importance of each component for a bidirectional signature (up- and down-regulated gene sets) to the total score, determine the importance of each gene of a signature in discriminating between the classes of interest, and to investigate the relationship between the final score and the dispersion of signature gene ranks. Annotations of interest can be overlayed on each plot. Singscore supports both continuous and categorical annotations, which can either be input as a vector, or as a string specifying a column within the score data frame. We begin by investigating the relationship between the score and dispersion of ranks for the up-regulated gene signature, down-regulated gene signature and the full signature. The `plotDispersion` functions generates a diagnostic plot with annotations overlaid. Annotations can be discrete or continuous, and can be passed as independent variables, or as a column name when the data is appended to the score data frame. It should be noted that all plotting functions in `singscore` can be made interactive by setting the `isInteractive` argument to `TRUE`. ```{r plot-dispersion, fig.wide=TRUE, fig.height=4, fig.cap="NPM1c signature scores from the up- and down-regulated gene sets, both combined (Total) and independently, can separate samples with NPM1c mutations or MLL fusions/PTDs from samples not bearing these genomic lesions. Scores are plotted against the median absolute deviation (MAD) of the ranks of genes in each gene set forming the NPM1c signature. The plots also reveal that scores close to 0 result in higher MADs."} #relative size of text in the figure relSize = 1.2 #create annotation mutated_gene = rep('Other', ncol(aml_se)) mutated_gene[aml_se$NPM1c.Mut] = 'NPM1c Mut' mutated_gene[aml_se$KMT2A.Fusion | aml_se$KMT2A.PTD] = 'MLL Fusion/PTD' p1 = plotDispersion(verhaak_scores, annot = mutated_gene, textSize = relSize) p1 ``` Figure \@ref(fig:plot-dispersion) shows that the set of down-regulated genes has more discriminant power in separating NPM1c mutated samples from those those without. Moreover, the signature is able to discriminate *MLL* (*KMT2A*) fusions and PTDs from the other samples. NPM1c mutations produce higher scores for the down-regulated gene set while *MLL* fusions and PTDs produce moderate scores. Similar trends are observed with the set of up-regulated genes; however, despite the range of scores increasing, the discriminant power drops moderately. In fact, the signature of up-regulated genes is able to discriminate samples without the genomic changes of interest ('Other') better by producing negative scores for most of these samples. Negative scores for the expected up-regulated gene set indicate that these genes are expressed below median expression, therefore, likely down-regulated within corresponding samples. Another observation from these plots is based on the trend of the dispersion (MAD). The dispersion is generally expected to be higher for scores close to zero. Zero scores are achieved in three possible scenarios: when genes are expressed at median expression level; when genes are evenly distributed at both ends of the expression spectrum; or, the more likely scenario whereby the rank of expression of all genes are uniformly distributed. The last two scenarios would result in a high dispersion. To explain these ideas, we select 3 samples and plot the ranks of genes in both signatures. The sample with the highest total score, lowest total score and highest dispersion are chosen. ```{r plot-rank-density, fig.wide=TRUE, fig.height=4, fig.cap="Rank distribution of genes reveals that expected up-regulated genes are up-regulated in high scoring samples and down-regulated in low-scoring samples with a similar, but inverse, observation for the expected down-regulated genes. Samples with the highest score, lowest score and highest dispersion (MAD) are show from left to right. The barcode plot for ranks of genes in each signature along with the density of the ranks is shown in each plot. Up-regulated genes are represented in green and down-regulated genes in purple. Gaussian distributions are observed at the extremes for the lowest and highest scores. High dispersion results in scores close to 0 because all genes are either evenly distributed (down-regulated gene set) or bi-modally distributed at the extrema (up-regulated gene set)"} library(gridExtra) #select samples with the properties required select_samples = c( 'Max Total Score' = which.max(verhaak_scores$TotalScore), 'Min Total Score' = which.min(verhaak_scores$TotalScore), 'Max Dispersion' = which.max(verhaak_scores$TotalDispersion) ) #plotRankDensity applied to each sample rank_plots = lapply(names(select_samples), function(x) { #get the sample index aml_sample = select_samples[x] #drop = FALSE is required to ensure the data.frame is intact p1 = plotRankDensity(rankData = aml_ranked[, aml_sample, drop = FALSE], upSet = verhaak_sigs[[1]], downSet = verhaak_sigs[[2]], textSize = relSize) #overwrite title of the plot with the description of the sample #this is possible because singscore uses ggplot2 p1 = p1 + ggtitle(paste(x, mutated_gene[aml_sample], sep = '\n')) + guides(colour = guide_legend(ncol = 1)) return(p1) }) #create a multipanel plot grid.arrange(grobs = rank_plots, nrow = 1) ``` Figure \@ref(fig:plot-rank-density) shows that both the up- and down-regulated gene sets contribute to the score of the top scoring sample as these genes are at the extremes ends of the rank spectrum. Similarly, the lowest scoring sample has the ranks of genes in each set inverted. As observed in the previous plot, the up-regulated genes improve discrimination between NPM1c mutated samples and other samples and may be a stronger indicator of wild-type NPM1c samples than the down-regulated genes. Finally, the sample with the maximum dispersion exhibits uniformly distributed down-regulated gene ranks and a bimodal distribution of the up-regulated gene ranks with the modes at the extremes of the spectrum. Combined, these plots show that both the up- and down-regulated genes play an important role in discriminating between NPM1c mutated (and *MLL* fusion/PTD samples), and wild-type samples. These diagnostic plots help in determining the importance of genes in signatures with respect to the samples of interest and should be used prior to application of signatures. In some cases, signatures may have been developed in specific contexts due to inherent biases in datasets and yet, described or applied in a generalised setting. These diagnostic plots may help in validating their application in specific contexts and possibly assist in characterising the contexts of all existing signatures. Predicting NPM1c mutation status using the Verhaak signature {#predict-verhaak} ------------------------------------------------------------ Mutation status can be predicted from singscores using a logistic regression model with a "logit" link function. The benefits of this model over one where each gene in the signature is used as a term in the model is the simplicity of the model. The @verhaak05 signature consists of 429 genes which would result in a regression model with 429 predictors. As there are fewer samples than the predictors, some feature selection method would be required which may result in the loss of information. Moreover, automating model development on a larger selection of gene signatures would be limited with gene-level models. Additionally, models trained using singscore would inherit its non-parametric properties to some extent. For instance, such models would be invariant to all data transformations that retain within sample ranks of genes. The main limitation of such models would be the loss of accuracy due to summarisation of the data (information on 429 genes is summarised into a two-component score). In any case, our aim here is not to discuss the various models that can be used to predict mutation status, but to exhibit the discriminant power of singscore and transcriptomic signatures. consequently, the data used to train the model are used to evaluate the basic performance properties. We begin by combining the scores with mutation annotations. ```{r create_plotdf_boxplot} #create a dataframe with the data required: scores and mutations scoredf = as.data.frame(colData(aml_se)[, aml_mutations]) scoredf$Score = verhaak_scores$TotalScore scoredf$Dispersion = verhaak_scores$TotalDispersion ``` Before training a model, we can visualise how well scores resulting from the @verhaak05 signature separates the mutants from wild-type samples for some genes of interest. Figure \@ref(fig:plot-boxplot-mutscores) shows that NPM1c signature scores can discriminate between NPM1c wild-type and mutants. Similar observations are made for *MLL* (*KMT2A*) fusions and *PML-RARA* fusions. ```{r plot-boxplot-mutscores, fig.height=5, fig.cap="NPM1c signature scores are able to separate mutants from wild-types. Boxplot of scores from the NPM1c signature split by different types of mutations."} #restructure the data for ploting plotdf = melt( scoredf, id.var = c('Score', 'Dispersion'), variable.name = 'Mutation', value.name = 'Status' ) #convert TRUE-FALSE values to Mut-WT plotdf$Status = factor(plotdf$Status, labels = c('WT', 'Mut')) p1 = ggplot(plotdf, aes(Mutation, Score, fill = Status)) + geom_boxplot(position = 'dodge', alpha = 0.6) + scale_fill_brewer(palette = 'Set2') + current_theme + theme(axis.text.x = element_text(angle = 45, vjust = 0.5)) p1 ``` To quantify the above observations, we fit logistic regression models with each genomic lesion as the response variable and the score as the predictor. Coefficient estimates, standard errors, z-statistics, and $p$-values of each model are listed below. ```{r predict_mutation_glm} #fit GLMs to each mutation glms = lapply(aml_mutations, function(x) { #generate a formula for the fit form = as.formula(paste0(x, ' ~ Score')) glm1 = glm(form, data = scoredf, family = binomial(link = 'logit')) return(glm1) }) names(glms) = aml_mutations #extract coefficients coefs = lapply(glms, function(x) coef(summary(x))) ldply(coefs, function(x) x[2, ], .id = 'Mutation') ``` NPM1c mutations are significantly associated with the score. Samples carrying a *MLL* gene fusion are also associated with the score reflecting their shared effects on Hox gene dysregulation, although with a lower significance. Interestingly the *PML-RARA* fusion carries a negative coefficient, likely reflecting the distinct cellular morphology/phenotype of acute promyelocytic leukemia relative to other subsets of AML, as noted above. Evaluate prediction model performance {#prediction-performance} ------------------------------------- The above statistics give insight on the models trained but not on their performance. Precision and recall provide insight on a models predictive performance. The `dcanr` package [@R-dcanr] provides functions to compute these metrics along with other measures of performance. ```{r eval_prediction_performance} library(dcanr) #assess sensitivity and specificity prec_rec = ldply(glms, function(glm1) { #predict mutations for the data used in training and convert to binary format prediction = as.numeric(predict(glm1) > 0) observed = glm1$y prec = performanceMeasure(prediction, observed, 'precision') recall = performanceMeasure(prediction, observed, 'recall') f1 = performanceMeasure(prediction, observed) return(c('Precision' = prec, 'Recall' = recall, 'F1' = f1)) }, .id = 'Mutation') prec_rec ``` Precision for predictions of all genomic changes other than NPM1c is undefined because all samples are predicted to be wild-types. Consequently, their recall is zero. Precision, recall and the F1 score of the NPM1c mutation model are high as expected. As singscores are two-components scores, performance may be further improved by including the dispersion of ranks. This is observed in Figure \@ref(fig:plot-dispersion). As observed from the model below, using both components of singscores significantly improves the predictive performance. ```{r predict_with_mads} #include dispersion in the model glm_npm1c = glm('NPM1c.Mut ~ Score + Dispersion', data = scoredf, family = binomial(link = 'logit')) #evaluate performance of the new model prediction = as.numeric(predict(glm_npm1c) > 0) observed = glm_npm1c$y c( 'Precision' = performanceMeasure(prediction, observed, 'precision'), 'Recall' = performanceMeasure(prediction, observed, 'recall'), 'F1' = performanceMeasure(prediction, observed) ) ``` Signature landscapes with multiple signatures {#signature-landscape} ============================================= Often, we are interested in the relationship between two dependent or independent phenotypes, for instance, the epithelial and mesenchymal phenotypes. The role of most signatures is to estimate an unobservable molecular phenotype so they may be considered as proxies of phenotypes. As such, we could investigate the relationship between two phenotypes using corresponding signatures. @foroutan17 first introduced the idea of molecular signature landscapes to investigate the relationship between signatures related to the epithelial-mesenchymal transition (EMT) and TGF$\beta$-induced EMT. Subsequently, @cursons18 computed epithelial and mesenchymal phenotype signature singscores and demonstrated an epithelial phenotype shift following miR-200c transfection into a mesenchymal cell line using a signature landscape. @foroutan18 used signature landscapes to stratify breast cancer subtypes along the epithelial-mesenchymal axis and included it as part of the `singscore` package. Here, we show how such landscapes can be used beyond the current application of the epithelial-mesenchymal axis. We demonstrate how transcriptomic signatures of different mutations can be used to stratify AML samples. Ross MLL fusion signature vs. Verhaak signature landscape {#sig-landscape-mll} --------------------------------------------------------- We now use the @ross04 MLL-fusion signatures to score the TCGA AML samples. Unlike the NPM1c signature, this signature is composed of genes that discriminate samples with MLL-fusion genes. We download and parse the signature as demonstrated with the NPM1c signature. ```{r process_rossmll_sigs} #create signature names rossmll_name = 'ROSS_AML_WITH_MLL_FUSIONS' #generate URLs rossmll_link = paste0( 'http://software.broadinstitute.org/gsea/msigdb/download_geneset.jsp?geneSetName=', rossmll_name, '&fileType=xml' ) #download files rossmll_file = paste0(rossmll_name, '.xml') download.file(rossmll_link, rossmll_file, method = 'libcurl') rossmll_sig = getBroadSets(rossmll_file, membersId = 'MEMBERS_EZID') rossmll_sig ``` The gene set is a composition of both up- and down-regulated genes as genes were selected based on their ability to discriminate mutants from wild-types. We use the third mode of singscore, which does not require the direction of genes in the gene set to be known. The `knownDirection` parameter of the `simpleScore` function is set to `FALSE` to induce this mode. Ranks computed previously can be reused to compute scores with the new signature. ```{r score_rossmll} rossmll_scores = simpleScore(aml_ranked, rossmll_sig[[1]], knownDirection = FALSE) ``` The `plotScoreLandscape` function plots a hexbin plot to visualise the two-dimensional distribution of scores. Scores computed using the @verhaak05 signature and the @ross04 *MLL*-fusions signature are passed as arguments. Both scores should have been computed on the same samples with the order of samples retained. Names of the scores should be passed as arguments to the `scorenames` argument. The `textSize` argument can be used to specify the size of all text relative to the plot size. This may prove useful when plots are being generated for scientific posters, publications and presentations, all of which require different image sizes. ```{r plot-signature-landscape, fig.height=7, fig.width=7, fig.cap="Signature landscape between the MLL fusion and NPM1c signatures. A positive association is revealed between the two signatures in AML."} p_mll_npm1c = plotScoreLandscape( verhaak_scores, rossmll_scores, scorenames = c('VERHAAK_AML_WITH_NPM1_MUTATED', 'ROSS_AML_WITH_MLL_FUSIONS'), textSize = relSize ) p_mll_npm1c ``` Figure \@ref(fig:plot-signature-landscape) shows a strong positive association between scores from the two signatures (Spearman's $\rho$ = `r round(cor(verhaak_scores$TotalScore, rossmll_scores$TotalScore, method = 'spearman'), digits = 3)`) despite only 16 genes being shared across the two signatures (signature sizes are 78 and 429 genes). In such an analysis, we may be interested in projecting new data points onto the landscape as done by @cursons18. Alternatively, we may want to overlay some existing data points to investigate sample stratification using scores. Here, we overlay *MLL* fusions, *MLL* PTDs, *PML-RARA* fusions and NPM1c mutations onto the landscape. First, we build the annotation vector. ```{r new_annotations} #new annotation - modify previously used annotations mutated_gene[aml_se$KMT2A.Fusion] = 'MLL Fusion' mutated_gene[aml_se$KMT2A.PTD] = 'MLL PTD' mutated_gene[aml_se$PML.RARA] = 'PML-RARA' ``` Points are projected onto an existing landscape using the `projectScoreLandscape` function. This functions uses the `p_mll_npm1c` plot generated using the `plotScoreLandscape` and overlays new data points onto it. Scores for the new data must be computed with the same signatures that were used to compute the landscape. As we are using existing data, scores computed in earlier sections are re-used. The `subSamples` can be used to select a subset of samples to project. Here, we select samples with the mutations we are interested in annotating. ```{r plot-project-mll, fig.height=7.5, fig.width=7, fig.cap="The landscape reveals a distinction between the MLL fusions and PTDs as previously reported. Different mutations occupy different regions of the landscape, possessing different types of molecular traits."} select_aml = !mutated_gene %in% 'Other' #project above mutations onto the landscape p1 = projectScoreLandscape(p_mll_npm1c, verhaak_scores, rossmll_scores, subSamples = select_aml, annot = mutated_gene[select_aml]) p1 + theme(legend.box = 'vertical') ``` Figure \@ref(fig:plot-project-mll) shows that the *MLL* fusions and *MLL* PTDs exhibit variation across different axes. *MLL* PTDs have a lower score than MLL fusions for the *MLL* fusion signature as expected. These sets of samples do not cluster along the two axes, consistent with observations by @ross04. Overlaying samples annotations onto the plot assists in interpreting different regions of the landscape. Ross PML-RARA fusion signature vs. Verhaak signature landscape {#sig-landscape-pmlrara} -------------------------------------------------------------- It is evident from the previous analysis that *PML-RARA* samples differ from all other samples examined here. We repeat the analysis with the *PML-RARA* signature from @ross04 to verify this distinction. The signature is available on the MSigDB and is named "ROSS_AML_WITH_PML_RARA_FUSION". We download and parse the signature, score all samples against it, plot a landscape with scores from the @verhaak05 signature, and finally, project samples onto the plot. The signature was constructed in a similar manner to the *MLL* fusions signature, therefore, samples are scored using the same settings. ```{r plot-project-pmlrara, fig.height=7.5, fig.width=7, echo=FALSE, fig.cap="The PML-RARA signature is independent from the NPM1c signature in AML. The L-shaped landscape suggests the molecular mechanisms underlying these mutations are mutually exclusive."} newsig_name = 'ROSS_AML_WITH_PML_RARA_FUSION' #generate URL newsig_link = paste0( 'http://software.broadinstitute.org/gsea/msigdb/download_geneset.jsp?geneSetName=', newsig_name, '&fileType=xml' ) #download files newsig_file = paste0(newsig_name, '.xml') download.file(newsig_link, newsig_file, method = 'libcurl') newsig_sig = getBroadSets(newsig_file, membersId = 'MEMBERS_EZID') #score newsig_scores = simpleScore(aml_ranked, newsig_sig[[1]], knownDirection = FALSE) #plot and project p1 = plotScoreLandscape( verhaak_scores, newsig_scores, scorenames = c('VERHAAK_AML_WITH_NPM1_MUTATED', newsig_name), textSize = relSize ) #project NPM1 mutations onto the landscape mutated_gene = rep('Other', ncol(aml_se)) mutated_gene[aml_se$NPM1c.Mut] = 'NPM1c Mut' mutated_gene[aml_se$KMT2A.Fusion] = 'MLL Fusion' mutated_gene[aml_se$KMT2A.PTD] = 'MLL PTD' mutated_gene[aml_se$PML.RARA] = 'PML-RARA' select_aml = !mutated_gene %in% 'Other' p2 = projectScoreLandscape(p1, verhaak_scores[, 1:2], newsig_scores, subSamples = select_aml, annot = as.factor(mutated_gene[select_aml])) p2 + theme(legend.box = 'vertical') ``` Figure \@ref(fig:plot-project-pmlrara) shows a completely different landscape from what was observed with the *MLL* fusion signature. The *PML-RARA* signature forms a clear separation between the *PML-RARA* and NPM1c samples such that *PML-RARA* samples are the only ones with a high score for this signature. Moreover, no association is observed between the two signatures. As discussed above (Description of the biological problem) the *PML-RARA* fusion is diagnostic of a specific subtype of AML known as acute promyelocytic leukemia, with a highly distinct cell phenotype reflecting a block on differentiation at the promyelocyte stage [@dethe91]. The distinct features of this subtype are correspondingly reflected in the L-shaped landscape for these two signatures and the different mechanisms by which these lesions drive leukemogenesis. Summary ======= The singscore package provides an easy interface to apply gene set scoring methods within the R/Bioconductor environment. The TCGAbiolinks package allows relatively easy access to large clinically relevant data sets such as TCGA, together with appropriate annotation functions for interpreting biological data. Diagnostic and plotting functions included with singscore allow the user to investigate gene sets of interest to determine their power for distinguishing differences between samples. Different gene signatures can then be combined to explore how different cellular phenotypes are associated across a large cohort of cancer samples. As demonstrated, when appropriate gene set signatures are used, metrics calculated by singscore can be used for sample classification and this may be useful for further interrogation of large transcriptomic data sets where no genomic data are available Packages used {.unnumbered} ============= This workflow depends on various packages from version `r BiocManager::version()` of the Bioconductor project, running on `r version$version.string` or higher. The complete list of the packages used for this workflow are shown below: ```{r session_info} sessionInfo() ``` Acknowledgments {.unnumbered} =============== The results shown here are in whole or part based upon data generated by the TCGA Research Network: . Thanks to Christoffer Flensburg of the Walter and Eliza Hall Institute for advice on the TCGA AML mutation data. References {.unnumbered} ==========