Skip to main content

Hierarchical Naive Bayes for genetic association studies

Abstract

Background

Genome Wide Association Studies represent powerful approaches that aim at disentangling the genetic and molecular mechanisms underlying complex traits. The usual "one-SNP-at-the-time" testing strategy cannot capture the multi-factorial nature of this kind of disorders. We propose a Hierarchical Naïve Bayes classification model for taking into account associations in SNPs data characterized by Linkage Disequilibrium. Validation shows that our model reaches classification performances superior to those obtained by the standard Naïve Bayes classifier for simulated and real datasets.

Methods

In the Hierarchical Naïve Bayes implemented, the SNPs mapping to the same region of Linkage Disequilibrium are considered as "details" or "replicates" of the locus, each contributing to the overall effect of the region on the phenotype. A latent variable for each block, which models the "population" of correlated SNPs, can be then used to summarize the available information. The classification is thus performed relying on the latent variables conditional probability distributions and on the SNPs data available.

Results

The developed methodology has been tested on simulated datasets, each composed by 300 cases, 300 controls and a variable number of SNPs. Our approach has been also applied to two real datasets on the genetic bases of Type 1 Diabetes and Type 2 Diabetes generated by the Wellcome Trust Case Control Consortium.

Conclusions

The approach proposed in this paper, called Hierarchical Naïve Bayes, allows dealing with classification of examples for which genetic information of structurally correlated SNPs are available. It improves the Naïve Bayes performances by properly handling the within-loci variability.

Background

In the last few years, the advent of massive genotyping technologies allowed researchers to define the individual genetic characteristics on a whole-genome scale. These advances boosted the diffusion of Genome Wide Association Studies (GWASs) and transformed them from expensive instruments of investigation into relatively affordable, popular and powerful research tools. For this reason, they have been extensively applied to the study of the most prevalent disorders.

As a matter of fact, most of the common diseases (e.g. diabetes mellitus, obesity, arterial hypertension, etc.) belong to the category of complex traits [1] which expression results from the additive contribution of a large spectrum of environmental determinants (exposure to external factors), behavioural factors (diet, life-style, smoke,...) and genetic variants (point mutations, single nucleotide polymorphisms - SNPs, large scale structural variations) [2]. Moreover, complex interactions among genetic variants, environmental factors and external influences are supposed to modulate not only the expression of the disease, but also the effectiveness of pharmacological treatments [3, 4]. In this context, the identification of the molecular mechanisms underlying a certain disease could help researchers in forecasting the individual-level probability of developing specific disorders and thus in defining personalized pharmacological interventions. GWASs seem thus an interesting approach to cope with such issues by deepening the insight about the contribution of the genetic make-up of an individual to the probability of developing a certain disease or trait [2].

To date, from the statistical viewpoint, the main limitations to the full exploitation of the GWAS results are mostly represented by the lack of appropriate multivariate tools, which can replace the usual univariate testing strategies, commonly used during for the discovery phase of a GWAS. In standard univariate analyses, rules for defining statistically significant associations are usually based on the application of over-conservative significance thresholds, imposed to minimize the probability of false positive associations. The main drawback of these approaches is that they tend to discard potentially informative signals, resumed by genetic loci characterized by small effects on the trait [5].

In this context, multivariate models could overcome the limitations of the usual "one-SNP-at-a-time" testing strategies, offering the possibility of exploring and integrating the huge amount of information deriving both from whole genome screenings and from clinical/phenotypic measurements.

Beside logistic regression (LR), which represents the most common approach for building multivariate models from SNPs data [6], several standard and alternative machine learning approaches such Naïve Bayes (NB), Support Vectors Machines (SVM), Random Forests (RF), Least Absolute Shrinkage and Selection Operator (LASSO) and model-averaged Naïve Bayes (MANB) have been proposed and applied for dealing with GWAS data. NB represents a machine-learning method that has been used for over 50 years in biomedical informatics [7]. NB is computationally inexpensive and it has often been shown to reach optimal classification performances, even when compared to much more advanced and complex methods [8]. However, NB loses accuracy in presence of large amounts of attributes to be analyzed, since it tends to make predictions with posterior probabilities close to 0 and 1 [9]. SVMs are one of the most popular classifiers in the field of machine learning and achieves state-of-the-art accuracy in many computational biology applications [10]. Thanks to their performances, they have been applied recently in the context of GWAS [11, 12]. Classification and Regression Trees (CART) represent machine learning algorithms that allow for the identification of predictive stratifications and functional interactions within data [13]. In the context of CART family of algorithms, RFs [14] allow analysing complex discrete traits using dense genetic information deriving from large sets of markers. In this context RFs are widely employed to the analysis of candidate genes association studies and GWAS for human binary traits [15]. Further, alternative approaches such logistic and Bayesian LASSO have been recently proposed and successfully applied for performing multivariate features selection in a genome-wide context [1618], offering an appealing alternative to the standard univariate SNPs ranking and selection strategies.

Recently, Lee et al. [19] and Yang et al. [5] proposed two multivariate approaches based on the simultaneous fitting of a genome wide set of SNPs. In particular, Yang et al. [5] showed that about 45% of variance of the human height could be explained by considering simultaneously a whole - genome set of SNPs instead of focusing on a small fraction of highly significant hits. In a Bayesian framework, Wei et al. [20] proposed a model-averaged Naïve Bayes (MANB) to predict late onset Alzheimer's disease using about 310,000 polymorphic markers. These observations suggest that the genetic signature of an individual is represented by the information contained in its whole genome sequence more than in candidate loci.

Multivariate models, however, can be hardly learned from GWASs data due to the so-called "small-n large-p problem": the number of variables in the model, i.e. the genotype loci, is much larger than the number of available individuals. This may cause major problems in model selection and model parameters fitting, instability and overfitting.

Bayesian methods, and in particular Bayesian Hierarchical Models (BHMs), represent a promising framework for deriving information from large sets of variables by exploiting available prior knowledge.

In our paper, we will exploit the capability of such models to use the knowledge about the correlation structure of such variables. Chromosome regions, represented by sequences of nearby SNPs, are often characterized by strong pairwise correlation, making the information available redundant and thus difficult to be analyzed. Hierarchical models (multilevel models) provide a way of pooling the information of correlated variables without assuming that they can be modelled as a unique variable [21]. Data coming from the same population are split in homogeneous subgroups, to which individual-level parameters are associated. The link/correlation among different individual parameters is expressed by population level parameters - or hyper-parameters. In this way it is possible to take into account for both within-group heterogeneity (thanks to the presence of individual level parameters) and between-groups variability (thanks to the presence of the population parameters).

BHMs have been already applied in a variety of biomedical contexts. They have been proposed as a fundamental tool to analyze next generation genomics data [22]. Moreover, Demichelis et al. applied such methods to tissue microarray data coming from tumor biopsies [21].

In the context of GWASs, we propose a Hierarchical Naïve Bayes (HNB) classification model that allows capturing the uncertainty of the information deriving from a set of genetic markers that are functionally/structurally correlated and to use this information to classify new examples. SNPs that do not fall within such regions as well as clinically relevant variables (e.g.: gender, smoke, therapies, candidate markers) can be also included in the model (Figure 1).

Figure 1
figure 1

Graphical representation of a genome region.

The following sections describe the main methodological aspects of the algorithm implemented as well as the results obtained on both simulated datasets and two real GWASs on the genetic bases of Type 1 Diabetes (T1D) and Type 2 Diabetes (T2D) by the Wellcome Trust Case Control Consortium (WTCCC) [23].

Methods

The Hierarchical Naïve Bayes classifier (HBN) is an extension of the well-known Naïve Bayes classifiers (NB). NB assumes that, given a class variable C that we aim at predicting (say disease yes/disease no) on the basis of a set of n f features X = {x1,..., x nf }, the posterior probability of the class given the data P(C|X) is proportional to the product of the prior probability of the class and the conditional probability, P ( X | C ) = f = 1 n f P ( X f | C ) , i.e. that the features are independent among each other given the class. NB is a simple and robust classifier, which may be conveniently used also in the context of large number of features, due to its strong bias.

HBN assumes that the measurements are stochastic variables with a hierarchical structure in terms of their probability distributions. We suppose that we can collect a number n rep of observations, or replicates on each example, and that an example belongs to one of a set of given classes. Let us suppose that is a stochastic variable representing the replicates, whose probability distribution is dependent on a vector of parameters θ, which corresponds to the single example, and may represent, for example, the mean and variance of the probability distribution of replicates; if we consider the i-th example, with i in 1,..., N, the probability distribution of the vector of the replicates is given by p ( X i | θ i ) , with, X i = { x i 1 , . . . , x i j , . . . , x i n r e p } , while the probability distribution of the individual parameters is p ( θ i | ξ c k ) , where ξ C k is a set of population hyper-parameters that depends on the class C k in the set C = {C 1 ,... C h } to which the example belongs, and is thus the same for all the examples of the same class. Figure 2 shows the representation of the problems though a graphical model with plates [21].

Figure 2
figure 2

The hierarchical structure of the data represented with plates notation.

In a Bayesian framework, the classification step is therefore performed by finding the class with the highest posterior probability distribution. Thanks to the conditional independence assumptions of the hierarchical model described above, we can write P ( C k | X ) P ( X | ξ C k ) P ( ξ C k | C k ) P ( C k ) . Since the population parameters ξ C k are determined by the knowledge of the class C k with probability one, the equation can be simplified as P ( C k | X ) P ( X | ξ C k ) P ( C k ) . The posterior is thus dependent on the so-called marginal likelihood, P ( X | ξ C k ) , which can be calculated by integrating out the vector of parameters θ.

Many replicates are available for each example. The examples are characterized by an individual vector of parameters θ; moreover, the examples belonging to the same class have a common set of parameters ξ.

P ( X | C k , ξ ) = Ω θ P ( X | C k , θ ) P ( θ | C k , ξ ) d θ
(1)

where Ω θ is the support of θ.

The learning problem will therefore consist in estimating the population parameters ξ C k for each class, while the classification problem is mainly related to the calculation of the marginal likelihood. To deal with multivariate problems, we resort to the Naïve Bayes algorithm (NB), which assumes that each attribute is conditionally independent from the others given the class.

P ( X | C k ) = f = 1 n f P ( X f | C k )
(2)

From the computational viewpoint, this will allow us to compute separately the marginal likelihood for each variable to perform classification and to learn a collection of independent univariate models. In the following we will show how HNB deals with the classification and learning problems when the variables are discrete with multinomial distribution.

Hierarchical Naïve Bayes for discrete variables

In a SNPs based case-control GWAS, the individual-level information is represented by genotype configurations (aa/aA/AA). For sake of readability we have omitted the dependence of the vectors to the class k. We assume that the vector of the occurrences (counts) of the i- th example is X i = { x i 1 , , x i j , , x i S } , where x i j is the number of occurrences of the j-th discrete value, or state, of the i-th example and S is the number of states of the variable x. The number of replicates of each example is given by n r e p i = j S x i j .

We also assume that the relationship between the data X i and the example parameters θ i is expressed by a multinomial distribution:

X i ~Multin ( n r e p i , θ i 1 , , θ i j , , θ i S )
(3)

Therefore θ i is an S-dimensional vector, where θ ij represents the probability of the occurrence of the j-th event in the example i. The parameters θ i , for i = 1, 2,..., N C k , are characterized by the same prior Dirichlet distribution:

θ i ~Dirichlet ( α ξ 1 , α ξ 2 , , α ξ S )
(4)

with probability density:

P ( θ i | α , ξ ) = Γ ( α ) j = 1 s Γ ( α ξ j ) j = 1 s θ i j α ξ j - 1
(5)

where 0 <α < ∞, ξ j < 1 j = 1,..., S and j = 1 s ξ j = 1 . Following the hierarchical model reported in the previous section, the individual example parameters θ i , are independent from each other given ξ = {ξ 1 ,...,ξ S } and α. In the following we will assume that the parameter α will be fixed, and it will be thus treated as a design parameters of the algorithm. α represents the prior assumption on the degree of similarity of all examples belonging to the same class. A proper setting of the parameter α allows finding a compromise between a pooling strategy, where all replicates are assumed to belong to the same example and a full hierarchical strategy where all examples are assumed to be different.

Classification

As described in the previous section, the classification problem requires the computation of the marginal likelihood (1). We assume that an estimate of the population parameters ξ is available and that α, β and γ are known. Given an example with counts distributed on different states X = {x 1 ,..., x S }, where n r e p = j = 1 s x j , we must compute:

P ( X | C k , ξ ) = Ω θ P ( X | θ ) P ( θ | ξ C k ) d θ
(6)

where θ = {θ 1 ,..., θ S } is the vector of the individual example parameters, with j = 1 s θ j = 1 and Ω θ the support of θ. This integral can be solved by noting that it contains the product of a Multinomial and a Dirichlet distribution.

The marginal likelihood can be thus computed as:

P ( X | C k , ξ ) = n r e p ! Γ ( j α ξ j ) Γ ( j ( x j + α ξ j ) ) j Γ ( x j + α ξ j ) x j ! Γ ( α ξ j )
(7)

The NB approach allows to exploit this equation for each variable in the problem at hand, and then to apply the equation (2) to perform the classification. The marginal likelihood however requires the estimate of the population parameters ξ from the data.

Learning with collapsing

The task of learning the population parameters can be performed by resorting to approximated techniques. Herein we will describe a strategy previously presented by [24] and [25].

We suppose that a data set X = {X1,..., X N } is available for each class where X i = {xi 1,..., x is } and N is the number of examples within each class (the number of examples can differ between the classes). Such vector is transformed into a new vector X*where the i-th element X i * = { τ i x i 1 , , τ i x i j , , τ i x i s } with:

τ i = 1 + α n r e p i + α
(8)

τ i is a suitable weight that allows to take into account the prior assumptions on the heterogeneity of the example belonging to the class. The hierarchical model is then collapsed into a new model, where the vector of the measurements X i * is assumed to have a multinomial distribution with parameters ξ and. τ i x i n r e p i .

Such assumption can be justified by the calculation of the first and second moment of P(X*|ξ)which is computed by approximating the distribution of the parameters θ given ξ with its average value [25].

The Maximum Likelihood (ML) estimate of the parameters ξ can be thus obtained for each state of the discrete variable as:

ξ J ¯ = i = 1 N τ i x i j i = 1 N τ i n r e p i
(9)

Within this framework we can also provide a Bayesian estimate of the population parameters ξ. We assume that ξ is a stochastic vector with a Dirichlet prior distribution: ξ ~ Dirichlet(β γ1 ,...., β γS ), where 0 <β < ∞, γ j < 1 j = 1,..., S and j = 1 s γ j =1.

After collapsing, we may derive the posterior distribution of ξ is still a Dirichlet with expected value of the probability of the j-th state of the discrete variable:

ξ J ¯ = i = 1 N τ i x i j + β γ j i = 1 N τ i n r e p i + β
(10)

In this setting, the parameter vector γ and β assume the same meaning of the parameters usually specified in the Bayesian learning strategies applied in many Machine Learning algorithms. In particular, if we assume γ = 1/S and β = 1 we obtain an estimate which is close to the Laplace estimate, while different choices of γ and β lead to estimates which are similar to the m-estimate, where β plays the role of m.

Building the model

The HBN machinery can be conveniently exploited to build a multivariate model for SNPs coming from a GWAS. In presence of regions in which non-random association of alleles at two or more loci or Linkage Disequilibrium (LD) is observed [26], a new variable X is generated, and all the SNPs belonging to the same block are considered as replicate of the same variable (see Figure 1). On the contrary, if the SNPs are not in LD, they are treated as independent variables in equation (2). For this reason, the model needs a convenient pre-processing step, in which blocks of SNPs characterized by LD are identified and the variables extracted.

Figure 3 reports a graphical representation of how SNPs data can be mapped using the plates notation. According to this representation, each individual is characterized by a vector (or individual parameter θ) reporting the genotypes corresponding to set of SNPs mapping to the same LD region. The set of individual parameters are then employed to estimate a latent variable ξ: each latent variable resumes the individual level information deriving from a different LD region. Thus, the complete set of latent variables (along with potentially informative covariates) is used in turns to estimate the probability of being affected or healthy by the Bayes' theorem.

Figure 3
figure 3

The hierarchical structure of the data represented with the plates notation using SNPs data.

Results

Datasets simulation

A total number of 9 independent datasets each composed by 300 cases, 300 controls and approximately 34,000 SNPs (representing the whole chromosome 22) have been simulated by the by the Hapgen software [23], according to the patterns of LD that characterize the HapMap CEU b36 reference population (http://hapmap.ncbi.nlm.nih.gov/). Three simulation scenarios have been evaluated, by imposing different genotype relative risk for causative loci:

  • Scenario 1: heterozygote relative risk = 1.5, homozygote relative risk = 3.0

  • Scenario 2: heterozygote relative risk = 2.0, homozygote relative risk = 4.0

  • Scenario 3: heterozygote relative risk = 3.0, homozygote relative risk = 6.0

Three simulated datasets have been generated according to each scenario, by imposing Minor Allele Frequency (MAF) ≥ 0.05.

Experimental datasets

The experimental case control datasets were represented by two genome-wide scans on T1D and T2D generated by the WTCCC consortium [23]. Individual-level genotypes determination has been performed with the Affymetrix GeneChip 500 K Mapping Array Set (http://www.affymetrix.com), which comprises 500,568 SNPs, while genotypes have been estimated from raw intensity signals by the Chiamo software tool [23].

Genotyped samples underwent a preliminary phase of data quality control (QC) which comprised the removal of cases and controls showing: i) missing data fraction > 3%;

ii) heterozygote genotypes fraction > 0.3 OR heterozygote genotypes fraction < 0.225;

iii) discordances or lack in terms of phenotype vs. laboratory information; iv) not-European ancestry; v) 1st/2nd degree relatives; vi) duplicated samples. Analogously, SNPs QC consisted in removing markers characterized by: i) study-wise missing data proportion > 5% OR study-wise minor allele frequency < 5% AND study-wise missing data proportion > 1%; ii) statistically significant deviations from the Hardy-Weinberg Equilibrium within controls (p-HWE < 5.7 × 10-7); iii) 1 df Trend Test/2 df General test p-value < 5.7 × 10-7 comparing allele and genotype frequencies between control groups; iv) bad clustering quality.

For a more detailed description of samples selection, genotyping procedures and quality control filters applied, the reader may refer to [23].

T1D dataset. The final dataset was composed by 1,963 patients affected by T1D, 1,458 control individuals from the UK Blood Service and 458,868 autosomal SNPs (mapping to chromosomes 1- 22) passing the quality control procedures.

T2D dataset. The final dataset was composed by 1,924 patients affected by T2D, 1,458 control individuals from the UK Blood Service and 458,868 autosomal SNPs (mapping to chromosomes 1- 22) passing the quality control procedures.

Data pre-processing

Both simulated and experimental datasets underwent a preliminary phase of features selection and variables filtering aimed at i) reducing the space of the hypotheses to be tested and ii) isolating chromosome regions characterized by strong LD.

The main steps of the datasets preparation are reported below:

  1. 1.

    The whole datasets have been split randomly into screening (representing 70% of the whole dataset) and replication sets (the remaining 30% of the whole dataset). The sampling procedure has been performed with stratification, so that each fold was represented by the same proportion of cases and controls.

  2. 2.

    On each screening set: a. Selected the top 500 most significant markers, based on the results from univariate Pearson χ2 tests with 2 degrees of freedom (df), comparing genotypes distributions between cases and controls.

    1. b.

      Define chromosome regions characterized by the presence of nearby SNPs showing pairwise r2x, where x represents arbitrary cut-off values corresponding to r2 = 0.6 (SNPs in moderate-to-strong LD) and 0.8 (SNPs in strong LD) respectively.

    2. i.

      Group markers localized within the same LD -block and build latent-variables.

    3. ii.

      Use the remaining SNPs falling outside the LD-blocks as covariates.

    4. c.

      Split the whole screening set into 10 folds of equal sample size and characterized by cases/controls ratio = 1 according to the 10 Folds Cross Validation procedure (10 Folds CV) [27].

  3. 3.

    Apply the LD-based SNPs grouping schema learnt on the screening set to the corresponding replication set.

Both screening and replication sets have been employed for evaluating the generalization performances obtained by the HNB algorithm and to compare them with those obtained by the standard NB classifier on the same datasets.

Results from simulated datasets

The HNB algorithm has been validated on simulated datasets, which underwent the pre-processing phases described in the previous sections.

Descriptive analyses of the simulated datasets revealed that the number of blocks to be analyzed increased proportionally to the stringency of the r2 imposed for defining regions of correlation, while the median number of SNPs characterizing each block decreased. This is due to the fact that SNPs linked by strong correlation (r2 ≥ 8), are generally confined to small and fragmented regions due to structural recombination events. Table 1 resumes the characteristics of the nine simulated datasets.

Table 1 Characteristics of the simulated datasets.

The generalization performances of the two algorithms have been evaluated by comparing the Classification Accuracy (CA) and the Area Under the Curve (AUC) of the two models estimated by 10 Folds CV procedures and by testing the models learnt on single screening set on the corresponding independent replication set [27, 28]. Results are reported in Table 2 and show that the HNB reaches higher or equal generalization performances with respect to the standard NB when chromosome regions characterized by SNPs showing moderate-to-strong (r2 > 0.6) or strong (r2 > 0.8) pairwise LD are analyzed.

Table 2 Results from the analysis of simulated datasets

No significant variations in terms of CA and AUC have been observed as function of the different genotype relative risks imposed for data simulations (p > 0.05), thus CA and AUC estimated from different simulations have been pooled and used for evaluating the differences in terms of classification performances between HNB and NB.

Results show that the median CA and AUC obtained by the HNB over the single results are higher to those reached by the standard NB for both LD thresholds that have been evaluated. The one-tailed Wilcoxon signed rank test [29] has been used for testing the hypotheses that the CA and AUC obtained by the HNB were significantly higher than those estimated by the standard NB and by the majority classifier [30].

Results from the Wilcoxon signed rank test showed that:

  • The distribution of the AUC values estimated by the HNB over the complete set of simulations was significantly higher than the corresponding distribution of AUC estimated by the standard NB when r2 ≥ 0.8 was imposed as threshold for defining LD-regions (AUC from 10 Folds CV: p < 0.05; AUC from independent replication set: p < 0.05).

  • The HNB algorithm reached CA and AUC estimates significantly higher than those obtained by the majority classifier: by comparing the distribution of CA and AUC obtained by the HNB with those generated by the majority classifier on the corresponding folds (maj. CA = 0.50, maj. AUC = 0.50) for each screening set according to both LD thresholds (p < 0.01);

    by comparing the distribution of CA and AUC estimated by the HNB over the 9 independent test sets with the corresponding distribution of CA and AUC obtained by the majority classifier (maj. CA = 0.50, maj. AUC = 0.50) on the corresponding test set according to both LD thresholds (p < 0.01).

Hierarchical Naïve Bayes for Type 1 and Type 2 Diabetes prediction

The HNB algorithm has been evaluated on two real genome-wide datasets aimed at identifying the genetic bases of T1D and T2D respectively. The analyzed datasets have been generated by the WTCCC [23] and they are publicly available. The final datasets were each composed by 1,400 cases and 1,400 controls sampled randomly from the complete set of individuals passing the quality control filters as reported in the previous section. Thus, each final dataset has been split into a fist set of 2,100 individuals (1,050 cases and 1,050 controls) representing the screening cohort, while the replication set was composed by the remaining 350 cases and 350 controls. The preliminary phases of features selection and LD-regions definition (using r2 ≥ 0.8 as threshold) have been performed as reported in methods section, SNPs that did not fall within conserved regions have been used as covariates.

The generalization performances of the proposed approach and of the NB have been estimated by i) 10 Folds CV performed on the each screening set and ii) by learning the models on the whole screening set and then testing the CA and AUC on the two corresponding replication cohorts.

Results are reported in Table 3 and confirm that the HNB algorithm is able to reach the highest generalization performances on both datasets, according to both 10 Folds CV and by testing the model learnt on the whole screening set on the corresponding independent replication cohort. Further, results from the Wilcoxon Signed Rank test evidenced that the distribution of CA and AUC obtained by the HNB by 10 Folds CV was significantly higher than the corresponding distributions obtained by the majority classifier on the same folds (p < 0.05).

Table 3 Results obtained on the T1D and T2D datasets

Discussion

The approach proposed, called Hierarchical Naïve Bayes, represents an innovative strategy aimed at exploiting correlated information from genome wide datasets. The human genome is typically characterized by local patterns of strong LD that define blocks of SNPs showing low recombination rates. In this scenario, the HNB represents a suitable way of deriving genetic information with respect to standard multivariate models, since it is able to take into account for structural correlations existing between markers. These characteristics allow HNB to overcome the limitations of the standard NB algorithm, which over-simplistic assumptions of independence between attributes are rarely respected in the context of GWAS data. The results obtained by the HNB on both simulated and real datasets show that the proposed approach is able to achieve classification performances that are generally higher or equal to those obtained by multivariate models based on standard NB. In particular, the HNB represents a suitable alternative to the standard NB when analyzing genome regions characterized by strong LD, a typical condition in which the assumptions of independency between variables of the HNB are dramatically violated.

To be noted, even if the results obtained by the 10 Folds CV procedures are prone to overfitting for both simulated and real datasets, since the preliminary filtering phase heavily exploits the screening set for features selection and blocks determination, the results obtained on the replication sets are free from these limitations. These observations confirm how taking into account for structural correlation between markers offers substantial gain in terms of generalization capability with respect to the standard NB approach that does not consider the human genome structure.

Many research groups used the publicly available WTCCC datasets and private case/control cohorts on T1D and T2D for testing the predictive performances of several machine learning algorithms. As an example, Wei et al., explored an approach based on SVM for building risk models using SNPs data and tested their approach on different case/control datasets on T1D [11]. The authors reported AUC ranging from 0.86 to 0.89 by 5 Folds CV, using different SNPs inclusion thresholds on the WTCCC cohort, while AUC corresponding to 0.84 and 0.83 by training the algorithm on WTCCC data and testing the performances on CHOP/Montreal-T1D and GoKinD-T1D datasets respectively, representing independent cohorts of cases and controls. When the algorithm was trained on the CHOP/Montreal-T1D and tested on the WTCCC and GoKinD-T1D data, the algorithm reached comparable AUC estimates, corresponding to 0.84 and 0.82 respectively. Roshan et al. [31] studied the number of causal variants and associated regions identified by top SNPs in rankings given by the 1 df chi-squared statistic, SVM and RF on real datasets on T1D from the WTCCC and GoKinD studies. SVM achieved the highest AUC of 0.83 with 21 SNPs followed by random forest and chi-square AUCs of 0.81 each with 29 and 17 SNPs, respectively. Clayton [32] discussed the impact of including interaction terms for predicting the probability of T1D and reported AUC estimated corresponding to 0.74 using pairwise interaction terms in logistic regression and 0.73 when no interaction were considered. These observations suggest how interaction between SNPs does not add substantial additional information to the correct classification of T1D subjects.

Lower CA and AUC estimates are generally obtained from the T2D datasets. As an example, van Hoek et al. investigated 18 polymorphisms from recent GWAS on T2D by logistic and Cox regression models in the Rotterdam Study cohort, reaching AUC corresponding to 0.60 [33]. Hyo-Jeong Ban et al. [12] analyzed a Korean population of T2D patients and controls, reporting CA corresponding to 0.65 using a combination of 14 SNPs in 12 genes mapping to T2D related pathways by using the radial basis function (RBF)-kernel SVM.

The performances obtained by the HNB on the independent test sets are generally comparable to those reported by other research groups for both T1D and T2D reported in this section. However, a direct comparison of the performances obtained by the HNB on the real datasets with those obtained by other previously published approaches on the same WTCCC cohorts can be hardly interpreted due to differences in terms of sample size of the control population (the analyzed dataset does not include the 1958 British Birth Cohort of controls, generated by the WTCCC and commonly used as reference population along with the UK Blood Service cohort). Further, the lack of covariates regarding T1D and T2D cases and controls (e.g., BMI, smoking history,.., etc.) limited the possibility to integrate genetic and clinical information, a key step for a deeper comprehension of complex trait diseases. Thus, the availability of GWAS datasets complete of detailed phenotype and clinical information will allow testing the HNB in a more realistic scenario. Beside these considerations, the proposed approach can be further improved to take into account also functional correlations, by using, for example, the Tree Augmented Naïve Bayes (TAN) approach on the latent variables, thus combining the two strategies [34].

References

  1. Steinberger J, Daniels SR: Obesity, insulin resistance, diabetes, and cardiovascular risk in children: an American Heart Association scientific statement from the Atherosclerosis, Hypertension, and Obesity in the Young Committee (Council on Cardiovascular Disease in the Young) and the Diabetes Committee (Council on Nutrition, Physical Activity, and Metabolism). Circulation. 2003, 107 (10): 1448-1453. 10.1161/01.CIR.0000060923.07573.F2.

    Article  PubMed  Google Scholar 

  2. Mechanic LE, Chen HS, Amos CI, Chatterjee N, Cox NJ, Divi RL, Fan R, Harris EL, Jacobs K, Kraft P: Next generation analytic tools for large scale genetic epidemiology studies of complex diseases. Genetic epidemiology. 2011

    Google Scholar 

  3. Heilig M, Goldman D, Berrettini W, O'Brien CP: Pharmacogenetic approaches to the treatment of alcohol addiction. Nature reviews Neuroscience. 2011, 12 (11): 670-684. 10.1038/nrn3110.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  4. Kim K, Yang YJ, Kim K, Kim MK: Interactions of single nucleotide polymorphisms with dietary calcium intake on the risk of metabolic syndrome. The American journal of clinical nutrition. 2012, 95 (1): 231-240. 10.3945/ajcn.111.022749.

    Article  CAS  PubMed  Google Scholar 

  5. Yang J, Benyamin B, McEvoy BP, Gordon S, Henders AK, Nyholt DR, Madden PA, Heath AC, Martin NG, Montgomery GW: Common SNPs explain a large proportion of the heritability for human height. Nature genetics. 2010, 42 (7): 565-569. 10.1038/ng.608.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  6. Chapman J, Whittaker J: Analysis of multiple SNPs in a candidate gene or region. Genetic epidemiology. 2008, 32 (6): 560-566. 10.1002/gepi.20330.

    Article  PubMed Central  PubMed  Google Scholar 

  7. Warner HR, Toronto AF, Veasey LG, Stephenson R: A mathematical approach to medical diagnosis. Application to congenital heart disease. JAMA: the journal of the American Medical Association. 1961, 177: 177-183. 10.1001/jama.1961.03040290005002.

    Article  CAS  PubMed  Google Scholar 

  8. Domingos P, Pazzani M: On the optimality of the simple Bayesian classifier under zero-one loss. Machine Learning. 1997, 29 (29): 103-130.

    Article  Google Scholar 

  9. Bennett PN: Assessing the Calibration of Naive Bayes' Posterior Estimates. Pittsburgh, PA: Carnegie Mellon University, School of Computer Science 2000. 2000, vol. CMU-CS-00-155

    Google Scholar 

  10. Noble WS: What is a support vector machine?. Nature biotechnology. 2006, 24 (12): 1565-1567. 10.1038/nbt1206-1565.

    Article  CAS  PubMed  Google Scholar 

  11. Wei Z, Wang K, Qu HQ, Zhang H, Bradfield J, Kim C, Frackleton E, Hou C, Glessner JT, Chiavacci R: From disease association to risk assessment: an optimistic view from genome-wide association studies on type 1 diabetes. PLoS genetics. 2009, 5 (10): e1000678-10.1371/journal.pgen.1000678.

    Article  PubMed Central  PubMed  Google Scholar 

  12. Ban HJ, Heo JY, Oh KS, Park KJ: Identification of type 2 diabetes-associated combination of SNPs using support vector machine. BMC genetics. 2010, 11: 26-

    Article  PubMed Central  PubMed  Google Scholar 

  13. Breiman L, Friedman J, Stone CJ, Olshen R: Classification and Regression Trees. 1984, New York - London: Chapman & Hall

    Google Scholar 

  14. Breiman L: Random Forests. Machine Learning. 2001, 45 (1): 5-32. 10.1023/A:1010933404324.

    Article  Google Scholar 

  15. Goldstein BA, Hubbard AE, Cutler A, Barcellos LF: An application of Random Forests to a genome-wide association dataset: methodological considerations & new findings. BMC genetics. 2010, 11: 49-

    Article  PubMed Central  PubMed  Google Scholar 

  16. Li J, Das K, Fu G, Li R, Wu R: The Bayesian lasso for genome-wide association studies. Bioinformatics. 2011, 27 (4): 516-523. 10.1093/bioinformatics/btq688.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  17. Tibshirani R: Regression shrinkage and selection via the lasso. Journal of the Royal Statistical Society, Series B. 1996, 58 (1): 267-288.

    Google Scholar 

  18. Wu TT, Chen YF, Hastie T, Sobel E, Lange K: Genome-wide association analysis by lasso penalized logistic regression. Bioinformatics. 2009, 25 (6): 714-721. 10.1093/bioinformatics/btp041.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  19. Lee SH, Wray NR, Goddard ME, Visscher PM: Estimating missing heritability for disease from genome-wide association studies. American journal of human genetics. 2011, 88 (3): 294-305. 10.1016/j.ajhg.2011.02.002.

    Article  PubMed Central  PubMed  Google Scholar 

  20. Wei W, Visweswaran S, Cooper GF: The application of naive Bayes model averaging to predict Alzheimer's disease from genome-wide data. Journal of the American Medical Informatics Association: JAMIA. 2011, 18 (4): 370-375. 10.1136/amiajnl-2011-000101.

    Article  PubMed Central  PubMed  Google Scholar 

  21. Demichelis F, Magni P, Piergiorgi P, Rubin MA, Bellazzi R: A hierarchical Naive Bayes Model for handling sample heterogeneity in classification problems: an application to tissue microarrays. BMC bioinformatics. 2006, 7: 514-10.1186/1471-2105-7-514.

    Article  PubMed Central  PubMed  Google Scholar 

  22. Gompert Z, Buerkle CA: A hierarchical Bayesian model for next-generation population genomics. Genetics. 2011, 187 (3): 903-917. 10.1534/genetics.110.124693.

    Article  PubMed Central  PubMed  Google Scholar 

  23. Genome-wide association study of 14,000 cases of seven common diseases and 3,000 shared controls. Nature. 2007, 447 (7145): 661-678. 10.1038/nature05911.

  24. Leonard T: Bayesian simultaneous estimation for several multinomial experiments. Communications in Statistics - Theory and Methods. 1977, A6 (7): 619-630.

    Article  Google Scholar 

  25. Bellazzi R, Riva A: Learning Bayesian Networks probabilities from longitudinal data. IEEE transactions on systems, man and cybernetics. 1998, 28 (5): 629-636.

    Article  Google Scholar 

  26. Lewontin RC, Kojima K: The evolutionary dynamics of complex polymorphisms. Evolution. 1960, 14 (4): 458-472. 10.2307/2405995.

    Article  Google Scholar 

  27. Geisser S: Predictive Inference. 1993, New York: Chapman and Hall

    Chapter  Google Scholar 

  28. Zhou XH, Obuchowsky N, McClish DK: Statistical Methods in Diagnostic Medicine. 2002, New York, USA: Wiley & Sons

    Chapter  Google Scholar 

  29. Wilcoxon F: Individual comparisons by ranking methods. Biometrics Bulletin. 1945, 1 (6): 80-83. 10.2307/3001968.

    Article  Google Scholar 

  30. Demsar J: Statistical Comparisons of Classifiers over Multiple Data Sets. Journal of Machine Learning Research. 2006, 7:1: 30-

    Google Scholar 

  31. Roshan U, Chikkagoudar S, Wei Z, Wang K, Hakonarson H: Ranking causal variants and associated regions in genome-wide association studies by the support vector machine and random forest. Nucleic acids research. 2011, 39 (9): e62-10.1093/nar/gkr064.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  32. Clayton DG: Prediction and interaction in complex disease genetics: experience in type 1 diabetes. PLoS genetics. 2009, 5 (7): e1000540-10.1371/journal.pgen.1000540.

    Article  PubMed Central  PubMed  Google Scholar 

  33. van Hoek M, Dehghan A, Witteman JC, van Duijn CM, Uitterlinden AG, Oostra BA, Hofman A, Sijbrands EJ, Janssens AC: Predicting type 2 diabetes based on polymorphisms from genome-wide association studies: a population-based study. Diabetes. 2008, 57 (11): 3122-3128. 10.2337/db08-0425.

    Article  PubMed Central  CAS  PubMed  Google Scholar 

  34. Friedman N, Geiger D, Goldszmidt M: Bayesian Network Classifiers. Machine Learning. 1998, 29: 131-161.

    Article  Google Scholar 

Download references

Acknowledgements

We are grateful to Andrea Demartini for the implementation of the HNB algorithm. The research was supported by the Innovative Medicine Initiative under grant agreement n° IMI/115006 (the SUMMIT consortium).

This study makes use of data generated by the Wellcome Trust Case Control Consortium. A full list of the investigators who contributed to the generation of the data is available from http://www.wtccc.org.uk. Funding for the project was provided by the Wellcome Trust under award 076113.

This article has been published as part of BMC Bioinformatics Volume 13 Supplement 14, 2012: Selected articles from Research from the Eleventh International Workshop on Network Tools and Applications in Biology (NETTAB 2011). The full contents of the supplement are available online at http://www.biomedcentral.com/bmcbioinformatics/supplements/13/S14

Author information

Authors and Affiliations

Authors

Corresponding author

Correspondence to Alberto Malovini.

Additional information

Competing interests

The authors declare that they have no competing interests.

Authors' contributions

AM carried out the molecular genetic studies, performed the statistical analysis and drafted the paper. NB carried out software tools development and integrations, participated in study design and drafted the manuscript. RB conceived the study, participated in its design and coordination and helped to draft the manuscript. All authors read and approved the final manuscript.

Rights and permissions

This article is published under license to BioMed Central Ltd. This is an open access article distributed under the terms of the Creative Commons Attribution License (http://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

Malovini, A., Barbarini, N., Bellazzi, R. et al. Hierarchical Naive Bayes for genetic association studies. BMC Bioinformatics 13 (Suppl 14), S6 (2012). https://doi.org/10.1186/1471-2105-13-S14-S6

Download citation

  • Published:

  • DOI: https://doi.org/10.1186/1471-2105-13-S14-S6

Keywords