Skip to main content

Identification of genetic markers with synergistic survival effect in cancer

Abstract

Background

Cancers are complex diseases arising from accumulated genetic mutations that disrupt intracellular signaling networks. While several predisposing genetic mutations have been found, these individual mutations account only for a small fraction of cancer incidence and mortality. With large-scale measurement technologies, such as single nucleotide polymorphism (SNP) microarrays, it is now possible to identify combinatorial effects that have significant impact on cancer patient survival.

Results

The identification of synergetic functioning SNPs on genome-scale is a computationally daunting task and requires advanced algorithms. We introduce a novel algorithm, Geninter, to identify SNPs that have synergetic effect on survival of cancer patients. Using a large breast cancer cohort we generate a simulator that allows assessing reliability and accuracy of Geninter and logrank test, which is a standard statistical method to integrate genetic and survival data.

Conclusions

Our results show that Geninter outperforms the logrank test and is able to identify SNP-pairs with synergetic impact on survival.

Introduction

Cancer is a complex disease that develops from accumulated genetic mutations that impair cellular processes responsible for maintaining homeostasis. For instance, inherited breast cancer predisposition is currently thought to result from rare high penetrance mutations in high risk families, or multiplicative effects of moderate penetrance variants or common low risk variants in the population [1, 2]. So far, over 20 low penetrance variants, such as single nucleotide polymorphisms (SNPs), have been identified but they only explain approximately 8% of the familial risk of breast cancer, with the high and moderate penetrance genes explaining roughly 25% [3, 4]. Combinatorial effects of large numbers of putative risk alleles are likely to be important in further explaining the genetic risk for breast cancer [5]. Increasing evidence suggests that not only breast cancer risk but also prognosis is inherited, and germline variants have been found to associate with survival of cancer patients [6]. Furthermore, interactive survival effects of genetic variants from cancer pathways have also been implicated [7], and survival effects detected for specific genotype carriers after defined chemotherapy treatment indicate treatment resistance conferred by inherited genetic variation [8]. However, few studies up to now have analyzed genome-wide the combinatorial survival effects of polymorphisms interacting with each other or with clinical features [7, 9, 10]. The large-scale analysis of interactive effects between genetic markers, or between genetic markers and clinical variables, will be important in increasing our understanding of diseases like cancer [11]. Uncovering these combinatorial survival effects will provide new markers for clinical decision making and personalized treatment of cancer patients [5].

Identification of markers that have combinatorial survival effect requires an iterative systems biology approach with efficient computational methodology which can be executed on high-performance computing clusters [12]. Here we introduce a novel algorithm, Geninter, for discovering interacting SNPs with combinatorial survival effect, i.e., SNPs that individually have no survival effect but together contribute significantly to survival. Previous efforts in discovering specific combinatorial genotypes have focused on small, highly selected groups of SNPs [9, 10], and to our knowledge Geninter is the first algorithm that is able to systematically integrate SNP-pairs with survival data on a genome-wide scale.

Methods

Genome-wide analysis of pair-wise SNPs brings forward two major challenges. First, the combination of multiple marker genotypes increases the number of groups in the survival analysis. The major consequences of the increased number of groups are that (i) the number of samples should be relatively high in order to ensure stable estimates in the subgroups, and (ii) the increase in the number of survival curves leads to more intersections of the curves, which renders the logrank statistic less reliable [13]. This issue is exacerbated by the tendency of the logrank test to overestimate large cohorts to have significant survival differences even when the difference is only slight. Second, SNP microarrays produce states for hundreds of thousands or millions of markers making evaluation of all the pairs computationally intensive [11]. Geninter addresses the computational challenges with optimized code and distributed programming. The overall outline of Geninter is given in Figure 1. Here we provide details on how each step in Geninter is executed. First, an attribute matrix containing genotypes and a matrix of survival times are given as an input to Geninter. The analysis is divided into three steps: (1) determining the distance matrix based on the genotype combination specific Kaplan-Meier curves; (2) using hierarchical clustering to determine the underlying relative structure of the curves; and (3) computing the rank. If the rank of a SNP-pair exceeds a chosen threshold, the pair is considered as a putative survival affecting combination and stored. The user can define the threshold parameter based on the number of SNP-pairs or p-value cutoff. We have implemented Geninter so that it can be run as an individual program but also on Anduril bioinformatics workflow engine that allows advanced processing of the Geninter results, such as automated annotation (e.g., linkage disequilibrium (LD) mapping) from bio-databases [14].

Figure 1
figure 1

The outline of the Geninter analysis workflow. First, an attribute matrix containing genotypes and a matrix of survival times are given as an input to Geninter. The analysis is divided into three steps. The results (sorted list of SNP-pairs) can then be 12 annotated, for instance, using the Ensembl database and filtered to exclude markers that are in linkage disequilibrium (LD). The output contains the marker pairs, their ranks and p-values.

Determining the distance matrix

The first stage of Geninter is the calculation of a distance matrix D for a family of Kaplan-Meier survival curves. A family of curves is the set of curves for which one instance of the statistic is calculated. The Kaplan-Meier estimate for surviving to at least time t j is equal to the conditional probability of surviving beyond t j multiplied by the estimate at the previous time point t j−1 . At time 0, all patients are alive. The area between curves was chosen as the distance metric because it is (1) robust to possible erratic behavior of curve functions, and (2) computationally simple. Let C = {c1, c2, ..., c m } be a set of m survival curves. For example, for a SNP-pair, m ∈ [1,9] since there are three alleles for each SNP (e.g., AA, AB and BB) and thus 9 possible combinations of alleles. Let c j and c k be survival curves and c j , c k ∈ C. For every time point t i , where i ∈ [2, n] and n is the total number of time points available in follow-up, we calculate the distance between the survival curves as

D ( c j , c k ) = ∑ i = 2 n ( t i - t i - 1 ) | S c j ( i ) - S c k ( i ) | ,
(1)

where S c j ( i ) = c j ( t i - 1 ) and S c k ( i ) = c k ( t i - 1 ) denote the survival rates of the curves c j and c k at the given time point. To determine the distance matrix for a family of survival curves, all pairwise distances D (c j , c k ) are calculated to form the distance matrix D. D can be thought to correspond to the sum of areas of rectangles

( t i , S c j ( i ) ) , ( t i , S c j ( i ) ) , ( t i - 1 , S c k ( i ) ) , ( t i - 1 , S c k ( i ) ) , ∀ i ∈ [ 2 , n ] .

Hierarchical clustering

In the second stage, curves in a family are clustered by complete linkage agglomerative hierarchical clustering using D as the distance matrix. The main benefit of the hierarchical clustering is a dendrogram in which leafs are clusters, the leafs contain biological information which can be taken advantage of, and the clusters represent survival curves (Figure 2). In the complete linkage the distances between two clusters are calculated as the maximum distance between any object in the first and any object in the second cluster. We chose complete linkage clustering over single or average linkage because it more effectively distinguishes curves that are farthest away from one another. However, Geninter allows its user to define any alternative method supported by the underlying clustering library.

Figure 2
figure 2

Cluster tree dendrogram for a family of curves and the distance of two alleles. The features (alleles) circled in blue satisfy the equivalence relation. The allele combinations circled in green and red have a distance of |H max − H2|. The height of each leaf node is the height of its parent. This is marked with the blue dashed lines for the circled leafs.

Cluster tree distance

Curves in a curve family correspond to unique combinations of features (e.g., alleles). Each combination of features contains e features constrained by e domains respectively (e.g., SNP markers). Formally, a curve c j corresponds to a tuple of features (a j,1 , a j,2 , . . . , a j,e ) over the cartesian product of the feature domains A1 × A2 × . . . × A e . For the set of curves C = {c1, c2, . . . , c m } and its corresponding feature combinations we define its attributes M j , 1 ≤ j ≤ e as vectors such that M j = (a1,j, a2,j, . . . , a m,j ). In other words, for each domain A j we define its attribute M j which represents features from the domain A j corresponding to all the curves from C.

For example, let us have two SNP markers such that SNP1 has one allele BB and SNP2 has two alleles AA and AB. Thus, we have two domains A1 = {BB} and A2 = {AA, AB}. We can have the following SNP-pair combinations

SNP 1 ( M 1 ) SNP 2 ( M 2 ) ¯ c 1 B B c 2 B B A A A B
(2)

In this way, for SNP1 we have attribute M1 = (BB, BB) and for SNP2 we have attribute M2 = (AA, AB).

In general, we can represent combinations of e features corresponding to m curves as a matrix:

M = a 1 , 1 a 1 , 2 ⋯ a 1 , e a 2 , 1 a 2 , 2 ⋯ a 2 , e ⋮ ⋮ ⋱ ⋮ a m , 1 a m , 2 ⋯ a m , e = M 1 T M 2 T ⋯ M e T ,

For each attribute M k , 1 ≤ k ≤ e we establish the equivalence relation between curves c j 1 , c j 2 ∈C as follows: c j 1 ≡ M k c j 2 if and only if a j 1 k= a j 2 k. For example, the two allele combinations (BB, AA) and (BB, AB) share the feature BB in their attribute M1 for which we can define the equivalence relation c 1 ≡ M 1 c 2 (see Figures 3 and 2). Let E M j be a set of equivalence classes for ≡ M j and let E M j have l j equivalence classes { E 1 , j , E 2 , j , ⋯ , E l , j } (note that l j ≤ m). We can define the distance within an equivalence class with the cluster dendrogram.

Figure 3
figure 3

Combinatorial genotypic survival effect. Combination of two markers reveals synergetic effect on survival. The panel inside each figure contains the genotypes and sample sizes. In the right hand survival image, the curve furthest apart (BB, BB) from the rest is for the first marker most distant from curve (BB, AA) and for the second marker from curve (AB, BB).

Let H1 be the height in the dendrogram tree of the cluster nearest to c j 1 and H2 similarly for c j 2 . H max is defined as the height in the dendrogram of the smallest cluster (last common ancestor) into which both c j 1 and c j 2 belong. Then, provided that c j 1 , c j 2 ∈C and c j 1 ≡ M j c j 2 , the distance between two curves in the cluster tree is

d ( c j 1 , c j 2 ) = | H m a x - H 1 - H 2 | if  H m a x ≠ H 1 , H m a x ≠ H 2 | H m a x - H 1 | if  H m a x = H 2 | H m a x - H 2 | if  H m a x = H 1 0 if  H m a x = H 1 = H 2
(3)

One possible distance d that satisfies the equivalence relation is shown in Figure 2. The distance d in the family of survival curves does not exceed the maximum survival rate 1.0 multiplied by the last time point, i.e., 0 ≤ d ≤ t n .

Now, we can define the maximal distance between two curves in the equivalence class E k , j

d E k , j = max c j 1 , c j 2 ∈ E k , j ( d ( c j 1 , c j 2 ) ) .
(4)

Rank calculation

Every curve depicts the survival of a group sharing a combination of attributes. For example, the SNP-combinations (BB, AA) and (BB, AB) contain the attributes (BB, BB) and (BB, AB) as depicted in Matrix 2. The rank of a single attribute is the maximum of its cluster tree distances that satisfy the equivalence relation. In the final step, we calculate one rank for each attribute, sum the attribute ranks, and compute the final rank as the average of these partial ranks.

The partial rank corresponding to an attribute (i.e., the rank of a single marker or other attribute) over all curves is defined by the maximum distance of all the different equivalence classes

R M j = max E k , j ∈ E M j ( d E k , j ) .
(5)

Given the last time point t n , the rank of the family of survival curves is the sum of all the partial ranks

R ¯ = ∑ j = 1 e R M j e t n .
(6)

For example, the rank of two markers SNP1 and SNP2 is

R ¯ = ( R S N P 1 + R S N P 2 ) 2 t n .

This formulation of the rank allows us to extend the algorithm to multiple combinations of attributes. Moreover, the attributes are not constrained to be SNP-markers or clinical variables but can be anything for which we can define an equivalence relation.

Rank distribution

In order to study the properties of the Geninter rank distribution, we generated a data set with 1,000 patients, 140 markers, and uniformly distributed survival times. Under the null hypothesis of "no survival effect", we observed that the density function of the rank distribution could be approximated by a gamma distribution. We tested altogether 18 statistical distributions including Gaussian, log-normal and binomial. The best fitting distribution using log-likelihood was the three-parameters generalized extreme value distribution followed by the two-parameter gamma distribution. As the gamma distribution consisted of only two parameters, we chose that to represent the data. The gamma distribution approximation enables us to compute p-values in constant time for every rank statistic.

Assume that the rank R ¯ is a Gamma distributed random variable. Then R ¯ ~Γ ( k , θ ) , where k and θ are the shape and scale, respectively. Let μ ^ be the sample mean of the distribution and σ ^ 2 the sample variance. Since the maximum likelihood estimator for the scale parameter is θ ^ = μ ^ k , and it is known that σ ^ 2 =k θ ^ 2 =k ( μ ^ k ) 2 = μ ^ 2 k , it follows that

k = μ ^ 2 σ ^ 2 , θ ^ = μ ^ σ ^ 2 .

The rank distribution is sensitive to the population size. Therefore, we suggest that the scale and shape parameters are calibrated in respect to the population size. The calibration can be achieved by recalculating θ ^ and k for the new null rank distribution.

Implementation

We have implemented Geninter in the R statistical language, and in Fortran using the Message Passing Interface (MPI) for parallelization [15]. The Fortran/MPI implementation was developed and tested with a HP CP4000 BL ProLiant cluster system of CSC - IT Center for Science Ltd. utilizing the IMSL Fortran Math library for survival computations. Both implementations of the algorithm are freely available at the project website http://csbi.ltdk.helsinki.fi/pub/geninter.

Breast cancer data description

Genotype data were obtained on Finnish breast cancer patients genotyped as described previously [16]. Briefly, the patient set comprised two series of unselected breast cancer patients and additional familial cases diagnosed at the Helsinki University Central Hospital (HUCH).The first patient set was collected in 1997-1998 and 2000 and covers 79% of all consecutive, newly diagnosed cases during the collection periods [17, 18]. The second set, containing newly diagnosed patients, was gathered in 2001-2004 and covers 87% of all breast cancer patients treated at HUCH during the collection period [8]. Additional familial cases were collected as described in [19].

Results

Cancer genotype-survival simulator

To assess whether Geninter is able to detect true and false positive SNP-pairs we generated a simulator based on 1,000 breast cancer samples chosen from a cohort of breast cancer patients and controls genotyped on the HumanHap550 SNP microarrays [16]. We estimated the genotype frequencies using these 1,000 samples and randomly chosen 150 SNPs. We limited our analysis to those markers where the minor allele frequency exceeded 5%. This resulted in 139 qualifying markers whose genotype frequencies exceeded the threshold. The qualifying genotype frequencies were used as probabilities when generating the simulated markers.

We assumed that under the null hypothesis the survival times are uniformly distributed with the maximum survival of 360 months and the mean survival of 180 months. This assumption gives results in survival curve families with a ten year survival of approximately 75%, which is similar to the ten year overall survival of patients diagnosed with breast cancer in the Nordic countries [20].

In order to introduce predetermined survival effects into the survival times, we randomly chose two markers. Then, samples with the combination of rare homozygotes from both markers were assigned survival times from a logarithmic distribution with a mean of log 360 16 . This was then repeated for a different pair of markers in order to create affected marker pairs as defined by the user. A marker could only appear in one affected marker pair in the data generation process. In order to simulate censoring, which is present in all cancer cohorts, we generated random censoring events by choosing events to occur in 80% and censoring in 20% of the samples.

Analysis and comparison of the simulated data

Logrank test is a well-established statistical method to associate a SNP to survival. We tested both Geninter and logrank test with the simulated data in which the ground truth is known. Based on simulations on the effect of of population size on rank distribution (Figure 4), we estimated the background rank distribution from a simulated cohort of 1,000 samples and used the estimated distribution to compute p-values for the ranks. We applied the false discovery rate (FDR) procedure for the multiple hypothesis correction of the p-values [21]. We verified that the simulated distribution is similar to one calculated from a larger run with real data (data not shown). We further varied the size of our marker set between 40 and 140 markers. The number of marker combinations in the simulation was restricted to 140 because the analysis of 10,000 combinations 140 2 = 9730 does not yet require a high-performance cluster. Our simulator allows controlling the true positives, i.e., the marker pairs whose survival times were drawn from the logarithmic distribution.

Figure 4
figure 4

Effect of population size on rank distribution. 780 marker combinations have been evaluated for each distribution. The black dashed curve is the hypothetical null distribution. The boxes on the right of each set of curves indicate the ratio of affected and non-affected markers for each curve. If the ratio is 0.5, every marker combination has some induced survival effect. In the left panel population size is 10,000, in the middle panel 1,000, and in the right panel 100.

In order to study the effect of the number of affected markers on the rank statistic, we varied the fraction of affected markers from 1% to 50% of the total marker population. Figure 4 shows how increasing the ratio of affected markers to non-affected markers shifts the rank distribution to the right. With low numbers of affected markers the rank distribution is nearly identical to the background distribution. The 50% fraction represents a pathological case where half of the marker population has some induced survival effect and therefore every marker pair has at least one marker with a survival effect.

We applied the Geninter and logrank methods to analyze all the combinatorial SNP-SNP survival effects in simulated data. Additionally, we calculated the single SNP survival effects with the logrank test. Evinced in Figure 3, a combination acquires the rank of > 0.5 (FDR corrected p < 5.99× 10−8) even when neither marker alone exhibits noticeable survival effect (FDR corrected p < 0.01). In order to assess the relative performance of the Geninter and logrank statistic, we calculated the false positive and true positive rates for both methods when the number of affected marker pairs was varied. The false positive rate is the number of false positives divided by the sum of false positives and true negatives. The true positive rate is the number of true positives divided by the sum of true positives and false negatives. Based on the true and false positives, we calculated the receiver operating characteristic (ROC) curves for both algorithms [22]. ROC curves enable a direct comparison of true and false positive rates while varying the threshold. We analyzed the behavior of the true positive and false positive rates with independent, simulated test data. For each of the rank vectors in Figure 5, we executed the analysis with both algorithms. We increased the number of affected marker pairs and recorded the changes in true and false positives. Furthermore, we repeated each simulation 20 times for each affected marker pair number, and averaged the rates over these repetitions to account for simulation variance. Both statistics were able to identify affected marker pairs correctly. However, the false positive rate of both methods increase along with the number of affected markers (Figure 5). Furthermore, the logrank statistic has a substantially worse false positive rate indicating that most of its findings are false positives even at very low p-value thresholds. The sharp, smooth form of the logrank ROC curves in Figure 5 reflects the rise of the false positive rate of the logrank test even at p-value thresholds near zero. The p-value threshold of significance for Geninter decreases when the proportion of affected to non-affected markers increases. For a low ratio (less than10%) of affected marker pairs to non-affected marker pairs, less than 10% false positive rate and over 99% true positive rate are achieved with the nominal p-value < 0.01.

Figure 5
figure 5

Average ROC curves for different statistics when the number of affected pairs increases. Solid lines are computed from the Geninter rank p-values, dashed from the logrank test p-values. Results from simulations with different numbers of affected marker pairs are drawn with different colors. Each curve is an average (averaged over 20 repetitions) of an analysis of a cohort of 10,000 samples with the number of affected marker combinations varying between 1 and 20.

Conclusions

We have designed and implemented a novel algorithm, Geninter, to identify SNP-pairs with combinatorial survival effect. Our results with simulated data, which is based on SNP data from 1,000 breast cancer patients, demonstrate Geninter to be both accurate and reliable. Geninter outperforms the logrank test, which is a widely used test for uncovering significant differences in survival data. Additionally, simulations where the number of samples was varied, indicate that Geninter results in a good balance of true and false positives with1,000 samples, and it is applicable to cohorts with more than 500 samples (data not shown). Given the current large-scale cancer data collection efforts, such as The Cancer Genome Atlas [23], many cancer types with thousands of samples with SNP and clinical data will be soon available and Geninter can be directly applied to such data sets.

In order to be able to analyze the billions of putative SNP combinations in the large-scale data sets, we have developed two implementations of Geninter. The R implementation allows testing and running a relatively small number of SNPs. For instance, a run with 140 markers and 1,000 samples takes approximately five hours with a standard laptop. As there are 1010 SNP-SNP combinations to be computed for approximately 550k SNPs, we provide a Fortran implementation with the Message Passing Interface (MPI) that can be run on a high-performance computer cluster. We have tested the Fortran implementation of Geninter on a high-performance computer cluster at CSC-IT Center for Science. Our analysis indicates that a genome-wide analysis of all pairwise combinations of 550k markers takes approximately 1,500 hours with 256 computing nodes. The astronomical number of tests emerging from a genome-wide pair-wise analysis basically renders the FDR correction unpractical and useless. Thus, p-values are used only to sort the Geninter computed ranks. We note that Geninter is not restricted to pair-wise analysis but is applicable to any number of combinations. Obviously, higher order combinations require prior selection of attributes or other pre-processing methods to reduce the search space.

The Geninter algorithm is particularly useful in situations where the number of groups or population size is high. We have demonstrated that Geninter is able to integrate SNP-pairs to survival data. The approach, however, is applicable to other markers, such as methylation markers and copy number variants, as well. The major limiting factors for the use of Geninter are the availability of data and computational power. Given a number of large-scale efforts to quantify genetic profiles and other markers for thousands of cancer patients and exponential increase in computing power, we believe that Geninter will be a useful tool to identify combinatorial survival effects of multiple attributes, which provide a solid basis for advanced analysis of complex disorders.

References

  1. Pharoah PDP, Antoniou A, Bobrow M, Zimmern RL, Easton DF, Ponder BAJ: Polygenic susceptibility to breast cancer and implications for prevention. Nat Genet. 2002, 31: 33-36. 10.1038/ng853.

    Article  CAS  PubMed  Google Scholar 

  2. Fletcher O, Houlston RS: Architecture of inherited susceptibility to common cancer. Nat Rev Cancer. 2010, 10 (5): 353-361. 10.1038/nrc2840.

    Article  CAS  PubMed  Google Scholar 

  3. Turnbull C, Ahmed S, Morrison J, Pernet D, Renwick A, Maranian M, Seal S, Ghoussaini M, Hines S, Healey CS, Hughes D, Warren-Perry M, Tapper W, Eccles D, Evans DG, Hooning M, Schutte M, van den Ouweland A, Houlston R, Ross G, Langford C, Pharoah PDP, Stratton MR, Dunning AM, Rahman N, Easton DF: Genome-wide association study identifies five new breast cancer susceptibility loci. Nat Genet. 2010, 42 (6): 504-507. 10.1038/ng.586.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  4. Fanale D, Amodeo V, Corsini LR, Rizzo S, Bazan V, Russo A: Breast cancer genome-wide association studies: there is strength in numbers. Oncogene. 2012, 31: 2121-2128. 10.1038/onc.2011.408.

    Article  CAS  PubMed  Google Scholar 

  5. Foulkes WD: Inherited Susceptibility to Common Cancers. N Engl J Med. 2008, 359 (20): 2143-2153. 10.1056/NEJMra0802968.

    Article  CAS  PubMed  Google Scholar 

  6. Tommiska J, Eerola H, Heinonen M, Salonen L, Kaare M, Tallila J, Ristimäki A, von Smitten K, Aittomäki K, Heikkilä P, Blomqvist C, Nevanlinna H: Breast Cancer Patients with p53 Pro72 Homozygous Genotype Have a Poorer Survival. Clin Cancer Res. 2005, 11 (14): 5098-5103. 10.1158/1078-0432.CCR-05-0173.

    Article  CAS  PubMed  Google Scholar 

  7. Schmidt M, Tommiska J, Broeks A, van Leeuwen F, Van't Veer L, Pharoah P, Easton D, Shah M, Humphreys M, Dork T, Reincke S, Fagerholm R, Blomqvist C, Nevanlinna H: Combined effects of single nucleotide polymorphisms TP53 R72P and MDM2 SNP309, and p53 expression on survival of breast cancer patients. Breast Cancer Res. 2009, 11 (6): R89-10.1186/bcr2460.

    Article  PubMed Central  PubMed  Google Scholar 

  8. Fagerholm R, Hofstetter B, Tommiska J, Aaltonen K, Vrtel R, Syrjäkoski K, Kallioniemi A, Kilpivaara O, Mannermaa A, Kosma VM, Uusitupa M, Eskelinen M, Kataja V, Aittomäki K, von Smitten K, Heikkilä P, Lukas J, Holli K, Bartkova J, Blomqvist C, Bartek J, Nevanlinna H: NAD(P)H:quinone oxidoreductase 1 NQO1*2 genotype (P187S) is a strong prognostic and predictive factor in breast cancer. Nat Genet. 2008, 40: 844-853. 10.1038/ng.155.

    Article  CAS  PubMed  Google Scholar 

  9. Onay V, Briollais L, Knight J, Shi E, Wang Y, Wells S, Li H, Rajendram I, Andrulis I, Ozcelik H: SNP-SNP interactions in breast cancer susceptibility. BMC Cancer. 2006, 6: 114-10.1186/1471-2407-6-114.

    Article  PubMed Central  PubMed  Google Scholar 

  10. Boersma BJ, Howe TM, Goodman JE, Yfantis HG, Lee DH, Chanock SJ, Ambs S: Association of Breast Cancer Outcome With Status of p53 and MDM2 SNP309. J Natl Cancer Inst. 2006, 98 (13): 911-919. 10.1093/jnci/djj245.

    Article  CAS  PubMed  Google Scholar 

  11. Cordell HJ: Detecting gene-gene interactions that underlie human diseases. Nat Rev Genet. 2009, 10 (6): 392-404. 10.1038/nrg2579.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  12. Moore JH, Asselbergs FW, Williams SM: Bioinformatics challenges for genome-wide association studies. Bioinformatics. 2010, 26 (4): 445-455. 10.1093/bioinformatics/btp713.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  13. Lawless JF: Statistical Models and Methods for Lifetime Data. 2002, Wiley Series in Probability and Statistics, Wiley Interscience, 2

    Book  Google Scholar 

  14. Ovaska K, Laakso M, Haapa-Paananen S, Louhimo R, Chen P, Aittomäki V, Valo E, Núñez-Fontarnau J, Rantanen V, Karinen S, Nousiainen K, Lahesmaa-Korpinen AM, Miettinen M, Kohonen P, Wu J, Westermarck J, Hautaniemi S: Large-scale data integration framework provides a comprehensive view on glioblastoma multiforme. Genome Med. 2010, 2 (65):

    Article  PubMed Central  PubMed  Google Scholar 

  15. R Development Core Team: R: A Language and Environment for Statistical Computing. 2010, R Foundation for Statistical Computing, Vienna, Austria, ISBN 3-900051-07-0, [http://www.R-project.org]

    Google Scholar 

  16. Li J, Humphreys K, Heikkinen T, Aittomäki K, Blomqvist C, Pharoah PDP, Dunning AM, Ahmed S, Hooning MJ, Martens JWM, Ouweland AM, Alfredsson L, Palotie A, Peltonen-Palotie L, Irwanto A, Low HQ, Teoh GHK, Thalamuthu A, Easton DF, Nevanlinna H, Liu J, Czene K, Hall P: A combined analysis of genome-wide association studies in breast cancer. Breast Cancer Res Treat. 2011, 126: 717-727. 10.1007/s10549-010-1172-9.

    Article  CAS  PubMed  Google Scholar 

  17. Syrjäkoski K, Vahteristo P, Eerola H, Tamminen A, Kivinummi K, Sarantaus L, Holli K, Blomqvist C, Kallioniemi OP, Kainu T, Nevanlinna H: Population-Based Study of BRCA1 and BRCA2 Mutations in 1035 Unselected Finnish Breast Cancer Patients. J Natl Cancer Inst. 2000, 92 (18): 1529-1531. 10.1093/jnci/92.18.1529.

    Article  PubMed  Google Scholar 

  18. Kilpivaara O, Bartkova J, Eerola H, Syrjäkoski K, Vahteristo P, Lukas J, Blomqvist C, Holli K, Heikkilä P, Sauter G, Kallioniemi OP, Bartek J, Nevanlinna H: Correlation of CHEK2 protein expression and c.1100delC mutation status with tumor characteristics among unselected breast cancer patients. Int J Cancer. 2005, 113 (4): 575-580. 10.1002/ijc.20638.

    Article  CAS  PubMed  Google Scholar 

  19. Eerola H, Blomqvist C, Pukkala E, Pyrhönen S, Nevanlinna H: Familial breast cancer in southern Finland: how prevalent are breast cancer families and can we trust the family history reported by patients?. Eur J Cancer. 2000, 36 (9): 1143-1148. 10.1016/S0959-8049(00)00093-9.

    Article  CAS  PubMed  Google Scholar 

  20. Tryggvadottir L, Gislum M, Bray F, Klint A, Hakulinen T, Storm HH, Gerda Engholm G: Trends in the survival of patients diagnosed with breast cancer in the Nordic countries 1964-2003 followed up to the end of 2006. Acta Oncol. 2010, 49 (5): 624-631. 10.3109/02841860903575323.

    Article  PubMed  Google Scholar 

  21. Benjamini Y, Hochberg Y: Controlling the false discovery rate: a practical and powerful approach to multiple testing. J R Stat Soc Series B Stat Methodol. 1995, 57: 289-300.

    Google Scholar 

  22. Zweig MH, Campbell G: Receiver-operating characteristic (ROC) plots: a fundamental evaluation tool in clinical medicine. Clin Chem. 1993, 39 (4): 561-77.

    CAS  PubMed  Google Scholar 

  23. The Cancer Genome Atlas Research Network: Comprehensive genomic characterization defines human glioblastoma genes and core pathways. Nature. 2008, 455 (7216): 1061-1068. 10.1038/nature07385.

    Article  Google Scholar 

Download references

Acknowledgements

We are grateful to Hanni Kärkkäinen for fruitful discussions, and Lilli Saarinen and Tiia Pelkonen for proof-reading. Computational resources were provided partly by CSC - IT Center for Science Ltd (Espoo, Finland). This work was supported by the Academy of Finland (Center of Excellence in Cancer Genetics [SH]; grant 132473 [HN]), Sigrid Jusélius Foundation (SH), Foundation for the Finnish Cancer Institute (SH),Finnish Cancer Society (HN),Helsinki University Central Hospital Research Fund (HN), and Helsinki Biomedical Graduate Program (RL).The funders were not involved in study design; in the collection, analysis, or interpretation of data; in the writing of the manuscript; or in the decision to submit the manuscript for publication.

Declarations

The publication costs for this article were funded by the Academy of Finland Center of Excellence in Cancer Genetics Research Grant Agreement n. 250345.

This article has been published as part of BMC Systems Biology Volume 7 Supplement 1, 2013: Selected articles from the 10th International Workshop on Computational Systems Biology (WCSB) 2013: Systems Biology. The full contents of the supplement are available online at http://www.biomedcentral.com/bmcsystbiol/supplements/7/S1.

Author information

Authors and Affiliations

Authors

Corresponding author

Correspondence to Sampsa Hautaniemi.

Additional information

Competing interests

The authors declare that they have no competing interests.

Authors' contributions

RL and ML designed the algorithm with TH and SL. RL implemented the algorithm with ML and PM. RL and VR wrote the formal description. MM analyzed the rank distribution. RL, ML and SH designed the simulation and interpreted results. HN, CB and JL provided materials for the simulation. HN and SH supervised the study. RL, SH, and HN wrote the manuscript. All authors participated in the critical revision of the manuscript and approved the final manuscript.

Rights and permissions

Open Access This article is published under license to BioMed Central Ltd. This is an Open Access article is distributed under the terms of the Creative Commons Attribution License ( https://creativecommons.org/licenses/by/2.0 ), which permits unrestricted use, distribution, and reproduction in any medium, provided the original work is properly cited.

Reprints and permissions

About this article

Cite this article

Louhimo, R., Laakso, M., Heikkinen, T. et al. Identification of genetic markers with synergistic survival effect in cancer. BMC Syst Biol 7 (Suppl 1), S2 (2013). https://doi.org/10.1186/1752-0509-7-S1-S2

Download citation

  • Published:

  • DOI: https://doi.org/10.1186/1752-0509-7-S1-S2

Keywords