Skip to main content

Distance-based classifiers as potential diagnostic and prediction tools for human diseases

Abstract

Typically, gene expression biomarkers are being discovered in course of high-throughput experiments, for example, RNAseq or microarray profiling. Analytic pipelines that extract so-called signatures suffer from the "Dimensionality curse": the number of genes expressed exceeds the number of patients we can enroll in the study and use to train the discriminator algorithm. Hence, problems with the reproducibility of gene signatures are more common than not; when the algorithm is executed using a different training set, the resulting diagnostic signature may turn out to be completely different.

In this paper we propose an alternative novel approach which takes into account quantifiable expression levels of all genes assayed. In our analysis, the cumulative gene expression pattern of an individual patient is represented as a point in the multidimensional space formed by all gene expression profiles assayed in given system, where the clusters of "normal samples" and "affected samples" and defined. The degree of separation of the given sample from the space occupied by "normal samples" reflects the drift of the sample away from homeostasis in the course of development of the pathophysiological process that underly the disease. The outlined approach was validated using the publicly available glioma dataset deposited in Rembrandt and associated with survival data. Additionally, the applicability of the distance analysis to the classification of non-malignant sampled was tested using psoriatic lesions and non-lesional matched controls as a model.

Keywords: biomarkers; clustering; human diseases; RNA

Introduction

The typical application of gene expression signatures for diagnosis and prediction of the course of disease is based upon an oversimplified understanding of the pathology. According to this model, there is a gene or a set of genes (say, a "gene expression program") that is "responsible" for a pathophysiological process within certain tissue, or a cell type, that manifests itself on an organismal level as a disease. If we see this gene over- or underexpressed, or observe a set of concerted changes in expression of a set of genes, we can diagnose the disease. We can further use the respective levels of the over- or underexpression to predict the course of the disease.

While many diseases are well described by this model, some--like many cancers-- are not. Often we deal with a system-wide changes of entire gene expression profile that involve many cellular pathways and networks, some changes are being related to the pathogenesis, and some are of compensatory nature [1]. In the case of system- wide changes, the sheer number of the genes to be examined prevents unambiguous determination of a group of genes (using a more technical language, a linear combination of their expression levels) suitable as a diagnostic signature for the given disease. The problem is not with the procedure per se, but with a typically limited number of already diagnosed patients we could biopsy and enter into the analysis as a training data set. As shown by simulations in [2], the development of the robust gene signature require enrollment of thousands patients, which is not feasible (see also [3] for detailed discussion).

In a nutshell, the problem is that we are trying to profile many different genes simultaneously. In a typical high-throughput experiment assessing transcriptome, proteome or metabolome, the number of available tissue samples is much smaller than the number of variables [3]. This leads to a high probability of spurious correlations. Indeed, even if the probability for one gene expression level to show a spurious correlation with the disease within the given data set is as small as 10− 3, an analysis of data streaming from this experiment with 4 × 104 genes will almost certainly produce many false positives.

This problem is especially prominent in the analysis of mRNA microarray or the RNAseq experiments. When different groups extract diagnostic signatures for the same disease, the resultant sets of genes often have negligible overlap. For example, the tests [4] and [5] for breast carcinoma, having 76 genes and 70 genes correspondingly, have only 3 genes in common. Even starting from the same data set, one can get different "predictive" panels with minimal overlap [6]. The difference in gene sets extracted using different training sets is not limited to individual genes. The pathways and networks that can be built using independently obtained gene expression signatures are also quite different [7]. These observations cast substantial doubt at the biological relevance of the diagnostic approach that relies on gene signatures.

Expression levels for individual genes and other variables quantified in high- throughput biological experiments are commonly thought of as dimensions of the space on which we are collecting information. Thus the problem outlined above is known as the "curse of dimensionality" [8]. Briefly, in highly dimensional models, the number of parameters (dimensions) p is substantially larger than the sample size n. This property of biological datasets makes the task of distinguishing the noise from the true biological signal quite challenging, and it becomes close to impossible to obtain consistent estimator procedures [9, 10]. Hence there is a need to develop integrative approaches, capable of combining data from multiple high-throughput experiments to increase sample size [9, 10] or statistically sound and robust techniques to reduce the data to the most informative features. As an example of the latter approach, we can try to transform the entire dataset into a limited set of clusters using hierarchical clustering [11]: starting from the definition of a distance between two tissue samples, we proceed by regrouping individual expression profiles to obtain a branched cluster tree. Unfortunately, hierarchical clustering produces plausibly looking trees even when random data points are entered [12]. Hence, an extensive data perturbation by resampling is required for the validation of the obtained clustering [13]. Moreover, unsupervised classification techniques are far from being robust, as the inclusion of a new patient typically modifies original clustering.

Another popular solution to the dimensionality curse is to use a supervised approach that relies either on the pre-selection of the feature-limiting steps or on pre-filtering the data by the strength of an association of each variable with clinical outcome, or associations between variables [14, 15]. Unfortunately, a majority of biological data analysts try a variety of data processing techniques before arriving at the final one that seems to be suitable to the dataset in question. Therefore this kind of supervision is inherently biased.

In this paper we propose an alternative novel approach based on the "distances" in the multidimensional space of gene expression values. As a proof-of-principle, we show that this approach produces surprisingly good results in separation of normal and affected samples both for analysis of human malignancies and for chronic progressive conditions like psoriasis.

Multidimensional distances and clustering

A result of an expression experiment for a given sample is a (very long) vector that may be represented as a point in a multidimensional space. If we introduce a distance in this space, we can use the standard clustering techniques [16] to classify the points.

There are several ways to define the distance between two points, X = [ x 1 , x 2 , . . . ] and Y = [ y 1 , y 2 , . . . ] (see the discussion in [16]). The nai've Euclidean distance is defined as

D Euclidian 2 = ∑ i ( x i - y i ) 2
(1)

It takes all components of vectors equally and does not account for any correlations between them. We can normalize the sums in equation (1) on the average vector length

M i 2 = x i 2
(2)

where the averaging denoted by angular brackets is taken over all vectors in the dataset. Then the scaled distance is defined as

D scaled 2 = ∑ i ( x i - y i ) 2 M i 2
(3)

In the gene expression experiments the absolute values of the vectors are not relevant since the expressions are arbitrarily normalized. Therefore, using a distance that does not take these values into account is justified. A correlation distance, or Pearson distance, is the one that has this property. It is defined as

D Pearson =1- ∑ i x i y i ∑ i x i 2 ∑ j y j 2 =1- X ⋅ Y | X | | Y | =1-cos ( ∠ ( X , Y ) )
(4)

If we have enough data to calculate covariance matrix S with the elements obtaining by the averaging over all vectors in the dataset their covariances:

s i j = x i y j
(5)

them we can use Mahalanobis distance

D Mahalanobis 2 = ( X - Y ) T S - 1 ( X - Y )
(6)

This distance takes into account all correlations in the data. The problem with it is that to calculate correlation matrix and its inverse, many data points, i.e. many patients, are required.

Therefore, in the calculations below we use, as a rule, Pearson distance (4). Note that since all components of |X| and |Y| are non-negative, this distance is always between 0 and 1.

Methods

To test for the practical usefulness of the distance-based expression metrics we deployed the following strategy:

1 The datasets were selected from public MIAME-compliant GEO repository http://0-www-ncbi-nlm-nih-gov.brum.beds.ac.uk/geo/.

2 For each subset of the samples within data set (normal tissues, affected tissues, etc.) we calculated the coordinate for the center of the space defined by points of all the vectors as the simple arithmetic mean of all the samples in the subset.

3 For each point we calculated the distance to the centers of all subsets.

4 The distances to one center r1 vs. the distance to another center r2 were plotted.

In some datasets, three different subsets may be defined, instead of two. In these cases, each point was associated with three distances r1, r2 and r3, each plotted to the center of the corresponding subset. In these cases we used barycentric coordinates [17] in a equilateral triangle, with the distance d i from the vortex i proportional to

d i = r i r 1 + r 2 + r 3
(7)

Note that most programs dealing with barycentric coordinates (for example, the popular package [18]) use a different definition of the coordinate system, popular in the analysis of ternary mixtures. With this definition the distance to the vortex is proportional to D i = 1 − di. The transformation between these two definitions is trivial:

D i = 1 2 1 - d i ∑ j = 1 3 d j
(8)

Results

Expression profiles of primary tumors and their metastases drift away from the homeostatic state

To test the hypothesis that the expression profiles of primary tumors and their metastases drift away from the healthy, homeostatic state, the RNAseq dataset with GEO Series accession number GSE46622 described in [19] was downloaded and reanalyzed. This dataset was generated using RNAseq profiling of matching normal, tumor and metastasis tissues from eight colorectal cancer patients. In the study, adaptor-clipped Illumina Genome Analyser IIx reads were mapped to the human genome version GRCh37 (hg19) using transcript models taken from Ensemble v64 with TopHat followed by determination of differential expression using the Cufflinks software bundle and the cuffdiff with upper quartile normalization [19].

Accordingly we had three different subsets and three different centers of clusters. These data may be presented either as the points within a 3d cube (Figure 1), or as barycentric diagram (Figure 2). Both diagrams show that normal samples are located relatively close to the normal center, while metastatic and cancer clusters are much less compact.

Figure 1
figure 1

Distances from cluster centers for colorectal cancer, 3D plot. Each sample is represented as a point in the three-dimensional space defined by the distances to the normal, cancer, and metastatic center.

Figure 2
figure 2

Distances from cluster centers for colorectal cancer, barycentric plot. Plot of the distances in barycentric coordinates.

In a practical sense, one may be interested in how far away given tumor sample departed from the center of the space occupied by normal samples. This approach allows one to draw a linear plot (Figure 3). Interestingly, not all normal samples are clustered tightly around the center of the normal space, at least one of them strays away into the space area that doubts its normal origin. This observation may be explained by the fact that in this particular dataset, all normal samples were derived from margins of the colon tumors, therefore, the sample in question may not be entirely normal. Of note, the distance-based spread in primary tumors was even large than that in metastasis derived from the same group of patients, supporting the "metastatic dormancy" theory posing that a disseminated tumor cell remains in a quiescent state at a remote organ for years before its reactivation in response to both an intrinsic program and a set of contextual cues [20]. Metastatic reactivation does not require the transcriptional profile be farther away from the normal center than that of respective primary tumor. However, the relative distance may be related to the total number of cell divisions passed from the onset of tumorigenesis; in the metastatic site that remained dormant for a long time, the number of cell divisions passed may be, in fact, lower than that in the site of the primary tumor.

Figure 3
figure 3

Distances from the normal center for colorectal cancer. Plot of the distance to normal center for colorectal cancer and different groups of samples.

The drifting distances of tumor samples reflect the degree of their relative malignancy

To prove this point, we downloaded data represented in publicly available Repository for Molecular Brain Neoplasia Data (Rembrandt) http://caintegrator.nci.nih.gov/rembrandt/, which included data on 21 normal samples, 221 glioblastoma multiforme (GBMs), 145 astrocytomas, 66 oligodendrogliomas and 11 tumors of mixed origin. The raw gene expression CEL files from Affymetrix HGU133 Plus 2.0 arrays were normalized using the robust multi-array average (RMA) method [10] with default parameters [21].

The plots reflecting the distances to the center of normal samples for all studied groups of samples are shown on Figures 4 and 5. Similarly to the the pattern observed using colorectal dataset normal samples were compacted close to the normal center, while the majority of tumor samples drifted away from norm. Glioblastoma multiforme samples were, on average, located further from the center of normal space than either astrocytomas (p = 3.1 × 10−6) or oligodendrogliomas (p = 0.0033). In both astrocytomas and oligodendrogliomas, the observed spreads of the distance values were quite large, possibly reflecting known heterogeneity of these tumors [22, 23].

Figure 4
figure 4

Distances from the center of normal samples for multiple cancers, part I. Boxes correspond to the second and third quartiles of the data.

Figure 5
figure 5

Distances from the center of normal samples for multiple cancers, part II. Points represent individual samples.

Interestingly, patients survival were found to be negatively correlated with the distance of the tumor expression profile to the center of normal samples: the farther was the expression profile from the homeostatic center defined by normal samples, the shorter was the survival length for the patient. The corresponding plot is shown on Figure 6 together with the linear fit. The fit results give p = 2 × 10 −9 and R2 = 0.09. This means that the dependence is statistically significant, but the degree of the drift away from the center of the normal space explains only 9% of the survival prognosis, while the remaining 91% is explained by other factors, most likely, particular chromosomal rearrangements and mutations observed within the tumor along with tumor location and other known determinants of glioma prognosis [24].

Figure 6
figure 6

Dependence of the post-diagnosis survival on the distance to then normal center for multiple cancer. The line corresponds to the fit y = 1.94 × 103 - 1.35 × 104x.

Distance analysis is applicable to classification of samples collected from patients with non-malignant chronic disease

To illustrate an applicability of the gene expression distance analysis to the classification of samples collected from patients with non-malignant chronic disease, we selected psoriasis, an autoimmune disease mainly diagnosed through the visual inspection of the lesion skin by experienced dermatologists. To analyze the properties of gene expression profiles of lesional and non-lesional psoriatic skin samples from the same patient, two datasets were downloaded from GEO, GSE6710 [25] (N of paired samples = 13) and GSE11903 [26] (N of paired samples = 15). Both datasets were created using Affymetrix Human Genome U133A Array platform. As could be seen on Figures 7 and 8, even without cross-normalization, the distance metrics were able to cluster together gene expression profiles obtained using two independent non-lesional sample sets, while gene expression profiles of lesion samples were somewhat removed from the center of space occupied by non-lesional skin samples.

Figure 7
figure 7

Distances from the cluster centers for psoriasis data. Unfilled blue symbols correspond to uninvolved skin, filled red symbols correspond to lesion skin.

Figure 8
figure 8

Distances from the uninvolved center for psoriasis data. Unfilled blue symbols correspond to uninvolved skin, filled red symbols correspond to lesion skin.

Discussion

To date, the quantification of the diagnostic and prognostic biomarker molecules in the human serum and tissues, including cancer specimens, remains the primary means of enhancing the clinician's ability to diagnose the chronic condition. Importantly, with innumerable molecular markers in development, the discovery of novel standalone biomarkers with acceptable sensitivity and specificity is an extremely rare event.

Here we challenge the biomarker paradigm by developing a distance measure that places each tissue sample by its entire tissue-wide transcriptome profiles within the space occupied by similarly obtained profiles of the samples collected from the same individual or from individuals that do not have given chronic condition. We hypothesize that as farther away individual sample drifts from its homeostatic state defined as center of the space occupied (defined) by a large number of reference (normal) samples, as farther away the respective tissue will be from the well maintained, healthy state. In our study, we used publicly available datasets, to develop easily interpretable, composite measure that capable of integrating high-throughput transcriptome profiles into comprehensive, holistic metric describing the molecular homeostasis within given sample.

The comprehensive distance measures account for the intrinsic heterogeneity of human tumors that plagues hight-throughput studies involving this type of the biological material [27] and even for a heterogeneity of the cell types that comprise given tissue [28]. In particular, the composite biomarker metric that we call a distance metric, was validated using well-known Rembrandt glioma dataset associated with survival outcomes.

Importantly, proposed composite biomarker may be suitable for a dynamic description of patients' condition. This novel concept allows one to depart from the classical two-bin prediction model (e.g. "bad prognosis/good prognosis") as it produces a continuous prognosis model, where each sample is located in the neighborhood of other samples analyzed post-hoc and associated with known survival. For each sample, this concept quantitatively describes the degree of "the drift" from the standardized phenotype that will reflect the departure of the body from homeostasis. In the concepts, the effects of each personalized intervention could be evaluated by comparing the distance metrics for samples collected before the treatment and at multiple time-points within the interventional treatment course.

If proven valid, this concept might be developed into a novel type of integrative tests for the monitoring of the disease progress and the prediction of disease outcomes. The proposed distance analysis has a potential to become versatile in its application as it is equally attributable to gene expression profiles collected both by microarrays and by RNA-seq platforms, as well as, possibly, to proteome and metabolome profiles.

There is no doubt that proposed computational approach requires further development and optimization, in particular, other types of correlation-based metrics have to be tested for various kinds of multiparametric datasets that comprise simultaneously measured analytes. Future studies should include an analysis of longitudinal experiments that involve either various time points in course of the therapeutic treatment that ultimately results in the normalization of the pathological condition, or gradual processes detrimental to experimental system, for example, a development of insulin resistance or an ageing.

Conclusion

The distance analysis of molecular portraits is robust and versatile in its application as it is equally attributable to gene expression profiles collected by microarrays and by RNA-seq. The distance-based continuous predictive models depart from the classical two-bin prediction model (e.g. "bad prognosis/good prognosis") by placing each sample in the neighborhood of other samples analyzed post-hoc and associated with known survival.

References

  1. Gusev Y, Schmittgen TD, Lerner M, Postier R, Brackett D: Computational analysis of biological functions and pathways collectively targeted by co-expressed microRNAs in cancer. BMC Bioinformatics. 2007, 8 (Suppl 7): 16-10.1186/1471-2105-8-S7-S16.

    Article  Google Scholar 

  2. Ein-Dor L, Zuk O, Domany E: Thousands of samples are needed to generate a robust gene list for predicting outcome in cancer. PNAS. 2006, 103 (15): 5923-5928. 10.1073/pnas.0601231103.

    Article  PubMed  CAS  PubMed Central  Google Scholar 

  3. Veytsman B, Baranova A: High-throughput approaches to biomarker discovery and the challenges of subsequent validation. Biomarkers in Disease: Methods, Discoveries and Applications. Edited by: Preedy V. 2014, Springer, New York

    Google Scholar 

  4. Wang Y, Klijn JG, Zhang Y, Sieuwerts AM, Look MP, Yang F, Talantov D, Timmermans M, Meijer-van Gelder ME, Yu J, Jatkoe T, Berns EM, Atkins D, Foekens JA: Gene-expression profiles to predict distant metastasis of lymph-node-negative primary breast cancer. Lancet. 2005, 365 (9460): 671-679. 10.1016/S0140-6736(05)17947-1.

    Article  PubMed  CAS  Google Scholar 

  5. van't Veer LJ, Dai H, van de Vijver MJ, He YD, Hart AA, Mao M, Peterse HL, van der Kooy K, Marton MJ, Witteveen AT, Schreiber GJ, Kerkhoven RM, Roberts C, Linsley PS, Bernards R, Friend SH: Gene expression profiling predicts clinical outcome of breast cancer. Nature. 2002, 415 (6871): 530-536. 10.1038/415530a.

    Article  Google Scholar 

  6. Ein-Dor L, Kela I, Getz G, Givol D, Domany E: Outcome signature genes in breast cancer: Is there a unique set?. Bioinformatics. 2005, 21 (2): 171-178. 10.1093/bioinformatics/bth469.

    Article  PubMed  CAS  Google Scholar 

  7. Drier Y, Domany E: Do two machine-learning based prognostic signatures for breast cancer capture the same biological processes?. PLoS ONE. 2011, 6 (3): 17795-10.1371/journal.pone.0017795.

    Article  Google Scholar 

  8. Bellman RE: Adaptive Control Processes. A Guided Tour. 1961, Princeton University Press, Princeton, NJ

    Google Scholar 

  9. Waldron L, Coller HA, Huttenhower C: Integrative approaches for microarray data analysis. Methods Mol Biol. 2012, 802: 157-182. 10.1007/978-1-61779-400-1_11.

    Article  PubMed  CAS  Google Scholar 

  10. Michiels S, Kramar A, Koscielny S: Multidimensionality of microarrays: Statistical challenges and (im)possible solutions. Mol Oncol. 2011, 5 (2): 190-196. 10.1016/j.molonc.2011.01.002.

    Article  PubMed  CAS  Google Scholar 

  11. Brasier AR, Ju H: Analysis and predictive modeling of asthma phenotypes. Adv Exp Med Biol. 2014, 795: 273-288. 10.1007/978-1-4614-8603-9_17.

    Article  PubMed  Google Scholar 

  12. Miller LD, Long PM, Wong L, Mukherjee S, McShane LM, Liu ET: Optimal gene expression analysis by microarrays. Cancer Cell. 2002, 2 (5): 353-361. 10.1016/S1535-6108(02)00181-2.

    Article  PubMed  CAS  Google Scholar 

  13. Seiler M, Huang CC, Szalma S, Bhanot G: ConsensusCluster: A software tool for unsupervised cluster discovery in numerical data. OMICS. 2010, 14 (1): 109-113. 10.1089/omi.2009.0083.

    Article  PubMed  CAS  Google Scholar 

  14. Geraci J, Dharsee M, Nuin P, Haslehurst A, Koti M, Feilotter HE, Evans K: Exploring high dimensional data with Butterfly: A novel classification algorithm based on discrete dynamical systems. Bioinformatics. 2014, 30 (5): 712-718. 10.1093/bioinformatics/btt602.

    Article  PubMed  CAS  Google Scholar 

  15. Ma S, Dai Y: Principal component analysis based methods in bioinformatics studies. Brief Bioinform. 2011, 6-10.1093/bib/bbq090. 12

  16. Xu R, Wunsch DC II: Clustering. IEEE Series on Computational Intelligence. 2009, IEEE Press; John Wiley & Sons, Hoboken, New Jersey

    Google Scholar 

  17. Ungar AA: Barycentric Calculus in Euclidean and Hyperbolic Geometry: a Comparative Introduction. 2010, World Scientific, Singapore; Hackensack, NJ

    Google Scholar 

  18. Weihs C, Ligges U, Luebke K, Raabe N: klaR analyzing German business cycles. Data Analysis and Decision Support. Edited by: Baier D, Decker R, Schmidt-Thieme L. 2005, Springer, Berlin, 335-343.

    Chapter  Google Scholar 

  19. Röhr C, Kerick M, Fischer A, Kuhn A, Kashofer K, Timmermann B, Daskalaki A, Meinel T, Drichel D, Börno ST, Nowka A, Krobitsch S, McHardy AC, Kratsch C, Becker T, Wunderlich A, Barmeyer C, Viertler C, Zatloukal K, Wierling C, Lehrach H, Schweiger MR: High-throughput miRNA and mRNA sequencing of paired colorectal normal, tumor and metastasis tissues and bioinformatic modeling of miRNA-1 therapeutic applications. PLoS One. 2013, 8 (7): 67461-10.1371/journal.pone.0067461.

    Article  Google Scholar 

  20. Giancotti FG: Mechanisms governing metastatic dormancy and reactivation. Cell. 2013, 155 (4): 750-764. 10.1016/j.cell.2013.10.029.

    Article  PubMed  CAS  PubMed Central  Google Scholar 

  21. Irizarry RA, Hobbs B, Collin F, Beazer-Barclay YD, Antonellis KJ, Scherf U, Speed TP: Exploration, normalization, and summaries of high density oligonucleotide array probe level data. Biostatistics. 2003, 4 (2): 249-264. 10.1093/biostatistics/4.2.249.

    Article  PubMed  Google Scholar 

  22. Ducray F, Idbaih A, Wang XW, Cheneau C, Labussiere M, Sanson M: Predictive and prognostic factors for gliomas. Expert Rev Anticancer Ther. 2011, 11 (5): 781-789. 10.1586/era.10.202.

    Article  PubMed  CAS  Google Scholar 

  23. Kim Y-H, Nobusawa S, Mittelbronn M, Paulus W, Brokinkel B, Keyvani K, Sure U, Wrede K, Nakazato Y, Tanaka Y, Vital A, Mariani L, Stawski R, Watanabe T, De Girolami U, Kleihues P, Ohgaki H: Molecular classification of low-grade diffuse gliomas. Am J Pathol. 2010, 177 (6): 2708-2714. 10.2353/ajpath.2010.100680.

    Article  PubMed  CAS  PubMed Central  Google Scholar 

  24. Chaudhry NS, Shah AH, Ferraro N, Snelling BM, Bregy A, Madhavan K, Komotar RJ: Predictors of long-term survival in patients with glioblastoma multiforme: Advancements from the last quarter century. Cancer Invest. 2013, 31 (5): 287-308. 10.3109/07357907.2013.789899.

    Article  PubMed  Google Scholar 

  25. Reischl J, Schwenke S, Beekman JM, Mrowietz U, Störzebecher S, Heubach JF: Increased expression of Wnt5a in psoriatic plaques. J Investigative Dermatology. 2007, 127 (1): 163-169. 10.1038/sj.jid.5700488.

    Article  CAS  Google Scholar 

  26. Zaba LC, Suarez-Farinas M, Fuentes-Duculan J, Nograles KE, Guttman-Yassky E, Cardinale I, Lowes MA, Krueger JG: Effective treatment of psoriasis with etanercept is linked to suppression of IL-17 signaling, not immediate response TNF genes. J Allergy & Clinical Immunol. 2009, 124 (5): 1022-1030395. 10.1016/j.jaci.2009.08.046.

    Article  CAS  Google Scholar 

  27. Lähdesmäki H, llya Shmulevich Dunmire V, Yli-Harja O, Zhang W: In silico microdissection of microarray data from heterogeneous cell populations. BMC Bioinformatics. 2005, 6: 54-10.1186/1471-2105-6-54.

    Article  PubMed  PubMed Central  Google Scholar 

  28. Jochumsen KM, Tan Q, Hølund B, Kruse TA, Mogensen O: Gene expression in epithelial ovarian cancer: A study of intratumor heterogeneity. Int J Gynecol Cancer. 2007, 17 (5): 979-985. 10.1111/j.1525-1438.2007.00908.x.

    Article  PubMed  CAS  Google Scholar 

Download references

Acknowledgements

We are grateful to Dr. Ganiraju Manyam (MD Anderson Cancer Center, TX, USA) and Prof. Alessandro Giuliani (Istituto Superiori de Sanita, Italy) for the discussions that greatly contributed to initial stages of the development of the holistic analysis of gene expression and to the concept of distance metric.

Some calculations were run on ARGO, a research computing cluster provided by the Office of Research Computing at George Mason University, VA, USA.

This project was partially supported by "Human Proteome" program of the Ministry of Education and Science of the Russian Federation

Declarations

The publication charges were covered by Vavilov Institute of General Genetics RA.

This article has been published as part of BMC Genomics Volume 15 Supplement 12, 2014: Selected articles from the IX International Conference on the Bioinformatics of Genome Regulation and Structure\Systems Biology (BGRS\SB-2014): Genomics. The full contents of the supplement are available online at http://0-www-biomedcentral-com.brum.beds.ac.uk/bmcgenomics/supplements/15/S12.

Author information

Authors and Affiliations

Authors

Corresponding author

Correspondence to Ancha Baranova.

Additional information

Competing interests

The authors declare that they have no competing interests.

Authors' contributions

BV drafted the manuscript, provided insights concerning dimensionality curse and mathematical advice in the course of this study. AB conceived this study and developed the concept of distance metrics. LW and TC analyzed both cancer datasets and contributed to the draft of the manuscript. SB analyzed psoriasis dataset and contributed to the development of the concept of distance metrics.

Rights and permissions

Open Access  This article is licensed under a Creative Commons Attribution 4.0 International License, which permits use, sharing, adaptation, distribution and reproduction in any medium or format, as long as you give appropriate credit to the original author(s) and the source, provide a link to the Creative Commons licence, and indicate if changes were made.

The images or other third party material in this article are included in the article’s Creative Commons licence, unless indicated otherwise in a credit line to the material. If material is not included in the article’s Creative Commons licence and your intended use is not permitted by statutory regulation or exceeds the permitted use, you will need to obtain permission directly from the copyright holder.

To view a copy of this licence, visit https://creativecommons.org/licenses/by/4.0/.

The Creative Commons Public Domain Dedication waiver (https://creativecommons.org/publicdomain/zero/1.0/) applies to the data made available in this article, unless otherwise stated in a credit line to the data.

Reprints and permissions

About this article

Check for updates. Verify currency and authenticity via CrossMark

Cite this article

Veytsman, B., Wang, L., Cui, T. et al. Distance-based classifiers as potential diagnostic and prediction tools for human diseases. BMC Genomics 15 (Suppl 12), S10 (2014). https://0-doi-org.brum.beds.ac.uk/10.1186/1471-2164-15-S12-S10

Download citation

  • Published:

  • DOI: https://0-doi-org.brum.beds.ac.uk/10.1186/1471-2164-15-S12-S10

Keywords