Individual diversity and variability is one of the most complex issues to deal within high-dimensional studies of large populations, as the ones currently performed in biomedical analyses using omic technologies. DECO is a method that combines two main computational procedures: (i) a Recurrent-sampling Differential Analysis (RDA) that performs combinatorial sampling without replacement to select multiple sample subsets followed by a differential analysis (LIMMA); and (ii) a Non-Symmetrical Correspondence Analysis (NSCA) on differential events, which would improve the characterization and assigment of features and samples in a common multidimensional space. This second step combines in a single statistic (h-statistic) both the feature-sample changes detected and the predictor-response information provided by NSCA.
The statistical procedure followed in both parts of the method are detailed in the original publication [1], but this brief vignette explains how to use DECO to analyze multidimensional datasets that may include heterogeneous samples. The aim is to improve characterization and stratification of complex sample series, mostly focusing on large patient cohorts, where the existence of outlier or mislabeled samples is quite possible.
Thus, DECO can reveal exclusive associations between features and samples based in specific differential signal and provide a better way for the stratifycation of populations using multidimensional large-scale data. The method could be applied to data derived from different omic technologies since LIMMA has been demonstrated to be applicable to non-transcriptomic data. Along the vignette, we used genome-wide expression data obtained with microarrays or with RNA-seq (either for genes, miRNAs, ncRNAs, etc).
Fig. 1 - Workflow of DECO algorithm.
The deco R source package can be downloaded from our lab website, directly from Bioconductor repository or GitHub repository. This R package contains a experimental dataset as example, two pre-run R objects and all functions needed to run a DECO analysis.
## From Bioconductor repository
if (!requireNamespace("BiocManager", quietly = TRUE)) {
      install.packages("BiocManager")
  }
BiocManager::install("deco")
## Or from GitHub repository using devtools
BiocManager::install("devtools")
devtools::install_github("fjcamlab/deco")At present, the method directly supports two types of data from transcriptomic technologies: microarrays and RNA-seq platforms. In case of microarrays, robust normalization of raw signal is needed for correct application of eBayes method (done for example with the RMA method or with normalizeBetweenArrays method from LIMMA package [2]). Notwithstanding, RNA-seq read counts matrix (genes or transcripts as rows and samples as columns) can be the input; and in this case then user should apply voom normalization method [2]. Below, we show two different examples of both types of datasets obtained with such platforms.
Here, a normalized microarray gene expression matrix from clinical samples is used as example taken from Scarfo et al.[3]. Anaplastic Large Cell Lymphoma (ALCL) is an heterogeneous disease with two well differentiated forms based on ALK gene expression: ALK(-) and ALK(+). The dataset, obtained in GSE65823 from GEO database, corresponds to genome-wide expression profiles of human T-cell samples hybridizated on Affymetrix HGU133Plus2.0 platform, which were mapped to ENSEMBL genes with genemapperhgu133plus2cdf CDF package from GATExplorer [4]. The mapping from Affymetrix probes to genes can be also done using BrainArray CDF packages.
The main interest to include this dataset, to be analysed with DECO, is because using this sample set Scarfo et al. [3] identified of a subset of patients within the ALK(-) class discovering high ectopic expression of several gene markers. To do so, the authors applied one of the most used methods for detection of outliers and heterogeneous behavior, called COPA [5]. Further comparisons between COPA and other related methods can be found in our paper about DECO [1]. The phenotypic information about this sample set provided by GEO database were included in an SummarizedExperiment object. This R object called ALCLdata could be directly loaded as follows:
## Loading the R package
library(deco)
# Loading ALCL dataset and example R objects
data(ALCLdata)
# to see the SummarizedExperiment object
ALCL## class: SummarizedExperiment 
## dim: 1000 31 
## metadata(0):
## assays(1): counts
## rownames(1000): ENSG00000118971 ENSG00000171094 ... ENSG00000111249
##   ENSG00000108309
## rowData names(0):
## colnames(31): GSM1607007 GSM1607008 ... GSM1607036 GSM1607037
## colData names(10): Group Accession ... Type Blood.paper# to see the phenotypic information
head(colData(ALCL))## DataFrame with 6 rows and 10 columns
##               Group  Accession                Title
##            <factor>   <factor>             <factor>
## GSM1607007        - GSM1607007 PTCL, nos - sample 1
## GSM1607008        - GSM1607008 PTCL, nos - sample 2
## GSM1607009        - GSM1607009 PTCL, nos - sample 3
## GSM1607010        - GSM1607010 PTCL, nos - sample 4
## GSM1607011        - GSM1607011 PTCL, nos - sample 5
## GSM1607012        - GSM1607012 PTCL, nos - sample 6
##                               Source.name                Cell.type
##                                  <factor>                 <factor>
## GSM1607007 Human peripheral blood T cells peripheral blood T cells
## GSM1607008 Human peripheral blood T cells peripheral blood T cells
## GSM1607009 Human peripheral blood T cells peripheral blood T cells
## GSM1607010 Human peripheral blood T cells peripheral blood T cells
## GSM1607011 Human peripheral blood T cells peripheral blood T cells
## GSM1607012 Human peripheral blood T cells peripheral blood T cells
##                               Sample.origin        Original.name Alk.positivity
##                                    <factor>             <factor>       <factor>
## GSM1607007 University of Wuerzburg, Germany 10 - 5450-02 12-4-7             neg
## GSM1607008 University of Wuerzburg, Germany 11 - 11242-02 12-4-7            neg
## GSM1607009 University of Wuerzburg, Germany 12 - 1413-95 18-4-7             neg
## GSM1607010 University of Wuerzburg, Germany 16 - 10649-01 18-4-7            neg
## GSM1607011 University of Wuerzburg, Germany 17 - 16643-01 18-4-7            neg
## GSM1607012 University of Wuerzburg, Germany 37 - 17602-93 8-5-7             neg
##                Type Blood.paper
##            <factor>    <factor>
## GSM1607007     PTCL          No
## GSM1607008     PTCL          No
## GSM1607009     PTCL          No
## GSM1607010     PTCL          No
## GSM1607011     PTCL          No
## GSM1607012     PTCL          NoClasses vector to run a supervised analysis (explained in following section) to compare both ALCL classes positiveALK and negativeALK, or to compare three classes also considering PTCL samples.
## Group-vs-group comparison
classes.ALCL <- colData(ALCL)[, "Alk.positivity"]
names(classes.ALCL) <- colnames(ALCL)
## Multiclass comparison
multiclasses.ALCL <- factor(apply(
    as.data.frame(colData(ALCL)[, c("Alk.positivity", "Type")]), 1,
    function(x) paste(x, collapse = ".")
))Here, we show a RNAseq dataset analysed using DECO, downloaded from The Cancer Genome Atlas (TCGA). It is composed by 1212 clinical samples from patients with different subtypes of Breast Cancer [6], which includes standard histological subtypes (given by markers ESR1, PGR and HER2) and two classes associated to the cell-type, called: Invasive Ductal Carcinoma (IDC) and Invasive Lobular Carcinoma (ILC). The genes of the dataset are mapped to HGNC symbol IDs and the dataset can be loaded directly in R or downlad from the TCGA data portal:
# Loading library
library(curatedTCGAData)
library(MultiAssayExperiment)
# Download counts from RNAseq data
BRCA_dataset_counts <- curatedTCGAData(
    diseaseCode = "BRCA",
    assays = "RNASeqGene", dry.run = FALSE
)
# or download normalized RNAseq data
BRCA_dataset_norm <- curatedTCGAData(
    diseaseCode = "BRCA",
    assays = "RNASeq2GeneNorm", dry.run = FALSE
)
# Extract the matrix
BRCA_counts <- assay(BRCA_dataset_counts)
BRCA_norm <- assay(BRCA_dataset_norm)
dim(BRCA_counts)
dim(BRCA_norm)
# Apply log-scale and normalization if needed...
BRCA_exp <- limma::voom(BRCA_counts)$E # logCPMs
BRCA_exp <- log2(BRCA_norm + 1) #logRPKMsThen, user can run voom normalization method provided in LIMMA R package to calculates matrix of logCPMs. Further information about voom normalization and its properties can be found in LIMMA R package [2]. The normalized matrix is then analysed using the RDA method of DECO. DECO is also able to analyse other RNAseq data types (RPKMs, FPKMs or TPMs values). These data are usually log-scaled.
Together with RNA-seq or microarray platforms, DECO algorithm can be applied to datasets obtained with other omic platforms (as far as a correct normalization of the data per sample can be achieved). In order to provide an example of other platform, we show an example of a miRNAs dataset from same TCGA library used above:
# Download counts from RNAseq data of miRNAs
BRCA_dataset_counts_mirna <- curatedTCGAData(
    diseaseCode = "BRCA",
    assays = "miRNASeqGene", dry.run = FALSE
)
# Extract the matrix
BRCA_counts_mirna <- assay(BRCA_dataset_counts_mirna)
dim(BRCA_counts_mirna)
# Apply log-scale and normalization if needed...
BRCA_exp_mirna <- limma::voom(BRCA_counts_mirna)$E # logCPMsAdditionally, more information about different omic platforms and sample information is available on curatedTCGA or MultiAssayExperiment R package vignettes. Despite the sample information, we could design group-vs-group (binary), multiclass or unsupervised comparisons in TCGA datasets using deco and curatedTCGA R packages.
BiocParallelThe computational cost of DECO algorithm is depending on the size of our omic matrix: number of features, number of samples, number of categories, etc. For this reason, the deco R package includes intern parallelization based on BiocParallel R package:
SnowParam() for computing in distributed memory
MulticoreParam() for computing in shared memory
BatchJobsParam() for computing with cluster schedulers
DoparParam() for computing with foreach
SerialParam() for non-parallel evaluation
Before running the main functions decoRDA() or decoNSCA() R functions, the user can set up the number of cpus following the procedures described in the BiocParallel vignette:
library(BiocParallel)
# Non-parallel computing
bpparam <- SerialParam()
# Computing in shared memory
bpparam <- MulticoreParam()We proposed a exhaustive subsampling strategy which selects subsets of samples (from the different classes) and compares all against all (in an exhaustive search). When the number of combinations is very large a random selection of all possible subsets is done. In order to obtain the best possible results, three parameters should be taken into consideration before running the analysis: (i) the subsampling size called r (DECO method calculates an optimal size of subsampling subsets if the user does not define it); (ii) number of subsets or combinations, called iterations, to compare in this subsampling step; and (iii) a p-value threshold for the differential tests or contrasts, called q.val and computed using eBayes from LIMMA [2].
Aiming to summarize all positive differential events (DE) for each feature (combinations with a lower p-value than threshold), Fisher’s combined probability test is applied to each final feature vector of p-values to obtain a Standard.Chi.Square, which will is not affected by type of analysis (supervised or unsupervised) because it only takes into account number of positive DE events.
Depending on classes input vector, a supervised or binary analysis compares just two types of samples (i.e. healthy donors versus patients in a typical biomedical study). The decoRDA() RDA function will adjust the optimal subsampling size r (that the user can modify) to explore all DE signal, and UP and DOWN events will be taken into account for posterior NSCA. Here, an example of decoRDA function using ALCLdata dataset:
## if gene annotation was required (annot = TRUE or rm.xy = TRUE)
library(Homo.sapiens)## number of samples per category
table(classes.ALCL)
# classes.ALCL
#   neg   pos
#    20    11
## example of SUPERVISED or BINARY design with Affymetrix microarrays data
# set annot = TRUE if annotation is required and corresponding library was loaded
sub_binary <- decoRDA(
    data = assay(ALCL), classes = classes.ALCL, q.val = 0.01,
    iterations = 1000, rm.xy = FALSE, r = NULL, 
    control = "pos", annot = FALSE, bpparam = bpparam,
    id.type = "ENSEMBL", pack.db = "Homo.sapiens"
)This RDA procedure generates an incidenceMatrix which counts differential events per gene (feature) per sample. Thus, this matrix would contain just differential genes as rows and samples as columns with one differential event at least.
dim(sub_binary$incidenceMatrix)## [1] 1358   31The incidenceMatrix produced after the RDA, can reveal the important changes that mark an entire subclass (grey boxes in Figure 1), as well as specific signal changes that mark a subclass of samples (red boxes in Figure 1). As we can see in a simple example (Figure 1), both Gene 1 and Gene 2 seem to mark two subclasses (or subtypes) inside each compared class, while Gene 3 and Gene 4 reflect the behaviour of control and case classes respectively. Following the RDA step, the NSCA step analyses the numbers of the incidenceMatrix. The NSCA analysis is also done splitting UP and DOWN changes when the algorithm is run in supervised mode.
Fig. 2 - Illustrative example of an “incidence matrix” obtained after RDA for a SUPERVISED analysis
If classes input vector is empty, a unsupervised analysis is run comparing all against all samples taking different subsets (each combination of samples is unique) and looking for UP events. Then, those samples which show any differential change with statistical significance will be counted. In order to clarify final results of NSCA analysis, it is important to underline that just UP regulated events will be assigned to samples, while both UP and DOWN regulation events are counted in the supervised analyisis explain above.
# if gene annotation will be required (annot = TRUE or rm.xy = TRUE)
# library(Homo.sapiens)
# example of UNSUPERVISED design with RNA-seq data (log2[RPKM])
sub_uns <- decoRDA(
    data = assay(ALCL), q.val = 0.05, r = NULL,
    iterations = 1000, annot = FALSE, rm.xy = FALSE,
    bpparam = bpparam, id.type = "ENSEMBL", 
    pack.db = "Homo.sapiens"
)In this case, the RDA procedure will generate an incidenceMatrix which counts just UP events per gene per sample.
Fig. 3 - Illustrative example of an “incidence matrix” obtained after RDA for a UNSUPERVISED analysis
Together with supervised or unsupervised analyses, the method can be run for multiclass comparison, taking subsets of samples from several classes identified a priori and forcing them to be compared. Then, we would count differential events per feature per sample but there will not be mix between different classes. Here, we show an example of a breast cancer dataset (from Ciriello et al. [6], log2(RPKM+1) scaled) that uses the well-defined PAM50 classes:
# number of samples per category
table(multiclasses.ALCL)
# multiclasses.ALCL
# neg.ALCL neg.PTCL pos.ALCL
#       12        8       11
# example of MULTICLASS design with RNA-seq data (log2[RPKM])
sub_multiclass <- decoRDA(
    data = assay(ALCL), classes = multiclasses.ALCL, q.val = 0.05,
    r = NULL, iterations = 1000, annot = FALSE, 
    bpparam = bpparam, rm.xy = FALSE,
    id.type = "ENSEMBL", pack.db = "Homo.sapiens"
)decoRDA()This vignette presented some examples of decoRDA() subsampling function for supervised, multiclass and unsupervised analyses. Now, the details about all the input parameters which control the RDA procedure are indicated:
data input corresponds to our expression matrix with features as rows and samples as columns.
q.val is the threshold imposed to the adjusted.p.value from LIMMA method in each iteration.
r is the resampling size.
temp.path defines a location in your computer where decoRDA() would save temporary results.
classes is a character vector or factor indicating to which class each sample belongs.
control is a character indicating which label has to be set as control class in a supervised analysis.
rm.xy is a logical indicating if genes/proteins/features placed on X or Y chromosomes should be removed before run RDA (it requires id.type and annot inputs). We recommended to set TRUE if genre unbalance is present in the dataset.
annot logical indicating if feature annotation is required.
id.type is a character describing the type of id corresponding to the rownames of data input. These types can be found:`
# load the annotation package
library(Homo.sapiens) # for human
AnnotationDbi::columns(Homo.sapiens)##  [1] "ACCNUM"       "ALIAS"        "CDSCHROM"     "CDSEND"       "CDSID"       
##  [6] "CDSNAME"      "CDSSTART"     "CDSSTRAND"    "DEFINITION"   "ENSEMBL"     
## [11] "ENSEMBLPROT"  "ENSEMBLTRANS" "ENTREZID"     "ENZYME"       "EVIDENCE"    
## [16] "EVIDENCEALL"  "EXONCHROM"    "EXONEND"      "EXONID"       "EXONNAME"    
## [21] "EXONRANK"     "EXONSTART"    "EXONSTRAND"   "GENEID"       "GENENAME"    
## [26] "GENETYPE"     "GO"           "GOALL"        "GOID"         "IPI"         
## [31] "MAP"          "OMIM"         "ONTOLOGY"     "ONTOLOGYALL"  "PATH"        
## [36] "PFAM"         "PMID"         "PROSITE"      "REFSEQ"       "SYMBOL"      
## [41] "TERM"         "TXCHROM"      "TXEND"        "TXID"         "TXNAME"      
## [46] "TXSTART"      "TXSTRAND"     "TXTYPE"       "UCSCKG"       "UNIPROT"pack.db is a character corresponding to the annotation library (by default Homo.sapiens).Once the frequency matrix of DE events or incidenceMatrix has been produced, DECO follows applying a NSCA [7] procedure. NSCA allows analyse all dependencies and covariances between differential features and samples placing them in the same relational space. Further information can be found in a more detailed vignette included in the DECO R package and also in our original publication [1].
As a measure of this significant association, NSCA function returns a inner product matrix relating feature-sample dependencies in the differential context. After the inner product matrix is generated, samples with similar profiles (using all the genes that gave DE events over a threshold: pos.rep) are grouped together using a hierarchical clustering based on Pearson correlation distances between samples: \(dist_{ij} = 1 - corr(p_i,p_j)\).
Additionally, all different agglomeration methods to creates a dendrogram (see further information in hclust R function) are assessed looking for the method that shows highest cophenetic correlation [8]. Thus, we identify the best clustering procedure to make subclasses, choosing an optimal number of subclasses depending on the best Hubber’s Pearson \(\gamma\) cutting this dendrogram.
decoNSCA()Here, we show an example (based on group-vs-group comparison using ALCLdata) of how user can run the second step of DECO:
# It can be applied to any subsampling design (BINARY, MULTICLASS, or UNSUPERVISED)
deco_results <- decoNSCA(
    sub = sub_binary, v = 80, method = "ward.D", bpparam = bpparam,
    k.control = 3, k.case = 3, samp.perc = 0.05, rep.thr = 1
)
deco_results_multiclass <- decoNSCA(
    sub = sub_multiclass, v = 80, method = "ward.D", bpparam = bpparam,
    k.control = 3, k.case = 3, samp.perc = 0.05, rep.thr = 1
)
deco_results_uns <- decoNSCA(
    sub = sub_uns, v = 80, method = "ward.D", bpparam = bpparam,
    k.control = 3, k.case = 3, samp.perc = 0.05, rep.thr = 1
)Several important input parameters of this decoNSCA() function can be set up by user. Further information could be found in ?decoNSCA help page. Finally, this function will return an output R object deco that is described in the following section.
slotNames(deco_results)##  [1] "featureTable"     "NSCAcluster"      "incidenceMatrix"  "classes"         
##  [5] "pos.iter"         "control"          "q.val"            "rep.thr"         
##  [9] "samp.perc"        "subsampling.call" "nsca.call"After running NSCA function decoNSCA, the method produces an R object of deco class. The main slots with relevant information inside this object are:
featureTable is the main output table with the feature statistics and rankings. We can extract it using featureTable() function on a deco R object.
NSCAcluster contains the NSCA information and sample subclasses. It will be duplicated if a supervised analysis is run. We can extract it using NSCAcluster() function on a deco R object.
incidenceMatrix is the Absolute frequency matrix with DE events per sample used in the NSCA.
Vector of classes with labels per sample. For unsupervised analysis it will be NA.
Label set as control.
q.val is the adjusted.p.val threshold previously defined.
subsampling.call and nsca.call correspond to both decoRDA and decoNSCA function calls.
The main output table with relevant feature information from RDA, NSCA and subclasses searching corresponds to featureTable.
resultsTable <- featureTable(deco_results)
dim(resultsTable)## [1] 679  25# Statistics of top-10 features
resultsTable[1:10, ]##                              ID UpDw  Profile overlap.Ctrl.Case Repeats
## ENSG00000171094 ENSG00000171094 DOWN Complete      5.451283e-08     230
## ENSG00000138772 ENSG00000138772 DOWN Complete      1.000293e-01     101
## ENSG00000196083 ENSG00000196083 DOWN Complete      1.529265e-01      87
## ENSG00000180644 ENSG00000180644 DOWN Complete      5.880961e-02      70
## ENSG00000138759 ENSG00000138759 DOWN Complete      1.476604e-01      68
## ENSG00000007402 ENSG00000007402 DOWN Complete      1.743213e-01      70
## ENSG00000133101 ENSG00000133101 DOWN Complete      1.504523e-01      46
## ENSG00000180447 ENSG00000180447 DOWN Complete      1.798106e-01      40
## ENSG00000165152 ENSG00000165152 DOWN Complete      1.948644e-01      30
## ENSG00000141401 ENSG00000141401 DOWN Complete      1.236376e-01      31
##                 Repeats.index FR.Repeats delta.signal Avrg.logFC
## ENSG00000171094     100.00000      0.230    -4.666557  -4.976979
## ENSG00000138772      93.54839      0.101    -4.563095  -5.645493
## ENSG00000196083      83.87097      0.087    -2.858660  -3.905929
## ENSG00000180644      77.41935      0.070    -2.969732  -4.047822
## ENSG00000138759      83.87097      0.068    -2.577806  -3.610739
## ENSG00000007402      83.87097      0.070    -2.384917  -3.531150
## ENSG00000133101      80.64516      0.046    -4.178878  -5.233160
## ENSG00000180447      83.87097      0.040    -2.716558  -3.886126
## ENSG00000165152      87.09677      0.030    -1.743867  -2.570749
## ENSG00000141401      74.19355      0.031    -2.008419  -2.764633
##                 Standard.Chi.Square P.Val.ChiSq ChiSq.adj.P.Val.FDR   sd.Ctrl
## ENSG00000171094           154.37592           0                   0 1.0131133
## ENSG00000138772            94.63646           0                   0 1.1892142
## ENSG00000196083            88.38703           0                   0 0.9912834
## ENSG00000180644            77.05761           0                   0 0.2169039
## ENSG00000138759            73.35828           0                   0 1.0094577
## ENSG00000007402            72.15669           0                   0 1.5057927
## ENSG00000133101            59.64972           0                   0 1.4359084
## ENSG00000180447            51.55916           0                   0 0.8549899
## ENSG00000165152            44.16130           0                   0 1.0964131
## ENSG00000141401            43.68566           0                   0 0.6110073
##                 Tau.feature.Ctrl Dendrogram.group.Ctrl h.Best.Ctrl h.Range.Ctrl
## ENSG00000171094     3.809282e-05                     7  -8.3551287    15.906177
## ENSG00000138772     2.281650e-05                     7   8.6154581    15.324512
## ENSG00000196083     2.440286e-05                     9   6.2632436     9.864115
## ENSG00000180644     1.133430e-05                     7  -0.7795343     1.296333
## ENSG00000138759     4.050589e-05                     7   1.2140186     1.998242
## ENSG00000007402     2.554907e-05                     8   8.0373312    13.010125
## ENSG00000133101     2.482327e-05                     8   9.0395618    16.247408
## ENSG00000180447     4.801814e-06                     9   4.8145750     7.472268
## ENSG00000165152     9.265625e-06                     7   7.9097434    11.686904
## ENSG00000141401     1.089102e-06                     8   4.0180674     6.674263
##                   sd.Case Tau.feature.Case Dendrogram.group.Case h.Best.Case
## ENSG00000171094 0.2711583     1.018749e-03                    10   2.6876822
## ENSG00000138772 1.8266852     8.917672e-05                     9 -10.0200212
## ENSG00000196083 1.0495756     5.787316e-05                     9  -6.6466813
## ENSG00000180644 1.6079529     7.442000e-05                     9 -15.1827085
## ENSG00000138759 1.4140179     3.589903e-05                     9  -4.6797095
## ENSG00000007402 0.9836528     2.947525e-05                     9  -3.6572908
## ENSG00000133101 1.8010516     2.329720e-05                     8   5.9931348
## ENSG00000180447 1.5352325     9.840279e-06                     9 -13.8670187
## ENSG00000165152 0.1738017     9.771020e-06                    10  -0.5027845
## ENSG00000141401 0.7465750     3.635391e-06                     7  -3.1167712
##                 h.Range.Case Best.adj.P.Val RF.Positive.Repeats Chi.Square
## ENSG00000171094    3.2715469    0.007849210          0.59431525  5142.4536
## ENSG00000138772   12.8323091    0.007849210          0.26098191  2104.1693
## ENSG00000196083    8.8965603    0.003636411          0.22480620  1822.8387
## ENSG00000180644   17.0281027    0.005885590          0.18087855  1429.4205
## ENSG00000138759    6.9952244    0.004522273          0.17571059  1345.8557
## ENSG00000007402    5.7787902    0.004052757          0.18087855  1347.4123
## ENSG00000133101    9.2111101    0.004281206          0.11886305   901.1282
## ENSG00000180447   18.1416012    0.009285948          0.10335917   732.1775
## ENSG00000165152    0.9821661    0.007718417          0.07751938   543.7628
## ENSG00000141401    5.4981438    0.002019297          0.08010336   548.4629The most relevant statistic derived from RDA technique is the Standard.Chi.Square. The amount of differential events or Repeats that each gene (each feature) appears differentially changed among classes or samples is also very important, and it is summarized in Standard.Chi.Square since this parameter weights the significance of the DE. Genes with similar Repeats values which correspond to lower P.value resemble higher Standard.Chi.Square values, meanwhile genes with higher P.value, or near q.val threshold imposed by user, give lower Standard.Chi.Square values.
| IDs | Standard.Chi.Square | Repeats | P.values | h.Range | Dendrogram.group | 
|---|---|---|---|---|---|
| DE feature 1 | 250 | 100 | ~ 0.01 | 3.26 | 2 | 
| DE feature 2 | 150 | 100 | ~ 0.05 | 12.65 | 5 | 
Moreover, for supervised analysis the exprsUpDw character indicates if case class shows UP or DOWN regulation of each feature. In some cases, several genes could follow deregulation in both classes for some subgroup of samples, which we called change-type MIXED. This kind of change pattern could explain some hidden characteristic of the samples and allows finding outliers: a subgroup of samples that only change in a subset of genes. In this cases there are not differences between the mean or median for the whole classes, and so classical methods like SAM or LIMMA do not find these patterns.
After RDA and NSCA analysis, the statistics referred to sample subclasses found is used to rank DE features properly. In this way, \(h\) statistic obtained per feature is used to determine how each feature discriminates each subclass found. As we mentioned above, this statistic combines both the DE changes and the predictor-response relationship between features and samples, so it refers to feature’s discriminant ability. Furthermore, Dendrogram.group helps to identify to which pattern belongs each feature and each sample within the \(h\) statistic heatmap (decoReport() PDF report).
To see how samples are grouped into different subclasses within class:
# If SUPERVISED analysis
sampleSubclass <- rbind(
    NSCAcluster(deco_results)$Control$samplesSubclass,
    NSCAcluster(deco_results)$Case$samplesSubclass
)
# If UNSUPERVISED analysis
sampleSubclass <- NSCAcluster(deco_results_uns)$All$samplesSubclass
## Sample subclass membership
head(sampleSubclass)##            Subclass    
## GSM1607007 "Subclass 1"
## GSM1607008 "Subclass 1"
## GSM1607009 "Subclass 1"
## GSM1607010 "Subclass 1"
## GSM1607011 "Subclass 1"
## GSM1607012 "Subclass 1"Additionally, we can print a brief summary of DECO analysis using summary or show native R functions.
## Example of summary of a 'deco' R object (ALCL supervised/binary example)
summary(deco_results)
# Decomposing Heterogeneous Cohorts from Omic profiling: DECO
# Summary:
# Analysis design: Supervised
# Classes compared:
# neg pos
#  20  11
#            RDA.q.value Minimum.repeats Percentage.of.affected.samples NSCA.variability
# Thresholds        0.01          10.00                            5.00               86
# Number of features out of thresholds: 297
# Feature profile table:
# Complete Majority Minority    Mixed
#       12       87      197        1
# Number of samples affected: 31
# Number of positive RDA comparisons: 1999
# Number of total RDA comparisons: 10000An extended report (as PDF file) including more detailed information of the analysis and several plots illustrating all the results (as the bi-clustering approach to h statistic matrix) can be also produced with the decoReport() R function. Information about the extended report is included in longer and more detailed vignette in the DECO R package.
DECO R package implements an additional function to help users to view and analyse the output results. It contains a detailed representation of main results (subclasses found, main biomarkers, \(h\) statistic heatmap, best feature profiles, feature’s overlapping signal…). Here, we briefly describe how to run decoReport() R function:
### Example of decoReport using microarray dataset
decoReport(deco_results, sub_binary,
    pdf.file = "Report.pdf",
    info.sample = as.data.frame(colData(ALCL))[, c(
        "Type", "Blood.paper"
    ), drop = FALSE],
    cex.names = 0.3, print.annot = TRUE
)A main result of DECO analysis is the \(h-statistic\) matrix (H) derived from both combination of RDA and NSCA information, which is described in the original publication [1]. The decoReport() function generates the heatmap representation of this \(h-statistic\) matrix that includes a double correlation analysis between samples and between features and two derived clustering dendrograms.
# Extracting the h-statistic matrix used for
# the stratification and the feature profile's plot
# All samples if 'multiclass' or 'unsupervised' comparison
hMatrix <- NSCAcluster(deco_results_uns)$All$NSCA$h
# Control categories if 'binary' comparison
hMatrix <- NSCAcluster(deco_results)$Control$NSCA$h
# Case categories if 'binary' comparison
hMatrix <- NSCAcluster(deco_results)$Case$NSCA$h
dim(hMatrix)The heatmap reveals subclasses of samples and feature patterns, using the h-statistic as basis for this biclustering approach. This heatmap could be visualized within the PDF report or using the specific function plotHeatmapH() to represent it in a separate PDF.
## Opening a new PDF file
pdf("HeatmapH_example.pdf", width = 16, height = 12)
## Heatmap with h-statistic matrix and biclustering of features-samples.
plotHeatmapH(
  deco = deco_results, 
  info.sample = as.data.frame(colData(ALCL))[, c(9, 8, 10)], 
  cex.names = 0.3, print.annot = FALSE
)
## Closing the PDF file
dev.off()Fig. 4 - Heatmap of h statistic values from DECO, included in PDF generated by decoReport() function.
DECO is intended to provide sample subclasses, grouping by similar profiles of h-statistic. The plotAssociationH() function returns several simple plots, showing the association between a phenotype characteristic with every subclass found by DECO.
## Association plot between phenotype and DECO subclasses
plotAssociationH(
    deco = deco_results, 
    info.sample = multiclasses.ALCL
)Specifically:
Violin plot: distribution of average h-statistic values along samples (per feature) within the newly provided categories of samples (phenotype), grouping all features according to their corresponding DECO subclass.
Left-heatmap: frequency table of among DECO subclasses and newly provided sample categories (phenotype).
Right-heatmap: frequency table of among DECO subclasses and newly provided sample categories (phenotype).
The plotDECOProfile() R function provides a way to visualize a single feature profile. Here, we show the examples for two genes discovered by Scarfo et al. [3] in the analysis of the ALCL samples: (i) ALK, that is the key gene-marker used by doctors to separate the two major subtypes of Anaplastic Large Cell Lymphomas (in the analysis done with DECO, this gene shows a change-profile Complete which supports the value of the gene to separate the ALCL samples); (ii) ERBB4, that was reported by authors as biomarker of a new subclass found inside the negative ALCL samples (in the analysis done with DECO, this gene shows a change-profile Minority indicating the existence of a subset of negative ALCL samples that are separated from the rest).
DECO uses the \(h-statistic\) values for ordering samples along every single feature profile, providing a lecture of how samples are grouped by this new statistic. This order will differ from raw omic values because it also weights the predictor/response relationship between sample/feature (given by NSCA), highlighting the most relevant substructures found in our omic dataset.
## ALK and ERBB4 feature profiles
# ALK: ENSG00000171094
# ERBB4: ENSG00000178568
plotDECOProfile(
    deco = deco_results, id = c("ENSG00000171094", "ENSG00000178568"),
    data = assay(ALCL), pdf.file = "ALCL_profiles.pdf",
    cex.samples = 2, info.sample = as.data.frame(colData(ALCL))[, c(9, 8, 10)]
)Figure 5 corresponds to ALK gene profile, including a plot of its raw expression along samples and a plot of the h statistic of this gene per subclass. This gene shows a change type COMPLETE. The h-statistics per subclass found are large for the controls (“positive” ALCLs), and constant and close to 0 for the “negative” ALCLs.
Fig. 5 - Search for the specific patterns for a feature within the profiles obtained with DECO.
As mentioned before, the h-statistic is intended to integrate both omic dispersion and response-predictor information among features and samples (given by NSCA). For this reason, there might be a gaining in sample stratification from original omic profile to h-statistic profile, given the same feature (see original publication).
Given a feature, the plotGainingH() function returns three simple plots correlating both omic profile and h-statistic profile to see if the discrimination of categories has been improved. Noteworthy, since binary or supervised comparisons between two classes generates two different NSCA analyses, h-statistic of DECO subclasses must be contextualized in the same original sample groups.
## Feature to represent
id <- featureTable(deco_results)[1, "ID"]
#### Comparing DECO subclasses against source of samples.
plotGainingH(
  deco_results, data = assay(ALCL), ids = id, 
  print.annot = FALSE, orig.classes = FALSE
)Thus, three plots are returned:
Boxplot: distribution of omic data and h-statistic values per DECO subclass.
Top-left: parametric correlation between omic data and h-statistic per sample.
Top-right: non-parametric correlation (ranking) between omic data and h-statistic per sample.
1: F J Campos-Laborie, A Risueño, M Ortiz-Estévez, B Rosón-Burgo, C Droste, C Fontanillo, R Loos, J M Sánchez-Santos, M W Trotter, J De Las Rivas (2019). DECO: decompose heterogeneous population cohorts for patient stratification and discovery of sample biomarkers using omic data profiling. Bioinformatics, btz148, .
2: Ritchie ME, Phipson B, Wu D, Hu Y, Law CW, Shi W and Smyth GK (2015). limma powers differential expression analyses for RNA-sequencing and microarray studies. Nucleic Acids Res., 43:e47. .
3: Scarfo I, Pellegrino E, Mereu E, Kwee I, Agnelli L, Bergaggio E, Garaffo G, Vitale N, Caputo M, Machiorlatti R, Circosta P, Abate F, Barreca A, Novero D, Mathew S, Rinaldi A, Tiacci E, Serra S, Deaglio S, Neri A, Falini B, Rabadan R, Bertoni F, Inghirami G, Piva R; European T-Cell Lymphoma Study Group (2016). Identification of a new subclass of ALK-negative ALCL expressing aberrant levels of ERBB4 transcripts. Blood, 127:221-232. .
4: Risueño A, Fontanillo C, Dinger ME, De Las Rivas J (2010). GATExplorer: genomic and transcriptomic explorer; mapping expression probes to gene loci, transcripts, exons and ncRNAs. BMC Bioinformatics, 11:221. .
5: MacDonald JW and Ghosh D (2006). COPA–Cancer Outlier Profile Analysis. Bioinformatics, 22:2950-2951. .
6: Ciriello G, Gatza ML, Beck AH, Wilkerson MD, Rhie SK, Pastore A, Zhang H, McLellan M, Yau C, Kandoth C, Bowlby R, Shen H, Hayat S, Fieldhouse R, Lester SC, Tse GM, Factor RE, Collins LC, Allison KH, Chen YY, Jensen K, Johnson NB, Oesterreich S, Mills GB, Cherniack AD, Robertson G, Benz C, Sander C, Laird PW, Hoadley KA, King TA; TCGA Research Network., Perou CM (2015). Comprehensive molecular portraits of invasive lobular breast cancer. Cell, 163:505-519. .
7: Lauro N and D’Ambra L (1984). L’analyse non symetrique des correspondances. In: Data Analysis and Informatics III, (Diday E, Jambu M, Lebart L, Pages J and Tomassone R Eds.). North Holland, Amsterdam, p.433-446.
8: Sokal RR and Rohlf FJ (1962). The comparison of dendrograms by objective methods. Taxon, 11, 33.