Figures
Abstract
Since their introduction in the 50’s, variance component mixed models have been widely used in many application fields. In this context, ReML estimation is by far the most popular procedure to infer the variance components of the model. Although many implementations of the ReML procedure are readily available, there is still need for computational improvements due to the ever-increasing size of the datasets to be handled, and to the complexity of the models to be adjusted. In this paper, we present a Min-Max (MM) algorithm for ReML inference and combine it with several speed-up procedures. The ReML MM algorithm we present is compared to 5 state-of-the-art publicly available algorithms used in statistical genetics. The computational performance of the different algorithms are evaluated on several datasets representing different plant breeding experimental designs. The MM algorithm ranks among the top 2 methods in almost all settings and is more versatile than many of its competitors. The MM algorithm is a promising alternative to the classical AI-ReML algorithm in the context of variance component mixed models. It is available in the MM4LMM R-package.
Author summary
Mixed models have been a cornerstone of the quantitative genetics methodology for decades. Due to the growing size of datasets, their associated computational cost is a major burden, particularly in genome-wide association studies that routinely address Millions of markers, requiring as many mixed models to be fitted. In the particular case of a 2-variance component mixed models efficient procedures such as FaST-LMM or GEMMA have been developed to analyze panels with tens of thousands of individuals. However, there is room for improvement in cases where the computational burden is due to the number of variance components in the model rather than the panel size, a classical situation in plant genetics where several variance components are required to handle various polygenic effects. We consider a “MM” (Min-Max) algorithm as an alternative to the by-default AI (Average Information) algorithm used to perform inference in mixed models. The MM algorithm can be combined to the classical tricks used to accelerate the inference process (e.g. simultaneous orthogonalization or squared iterative acceleration methods). The MM procedure is implemented in an MM4LMM package, and is competitive compared to classical algorithms used in plant genetics. This package should help geneticists handling more complex models to analyze their data than today.
Citation: Laporte F, Charcosset A, Mary-Huard T (2022) Efficient ReML inference in variance component mixed models using a Min-Max algorithm. PLoS Comput Biol 18(1): e1009659. https://doi.org/10.1371/journal.pcbi.1009659
Editor: Mona Singh, Princeton University, UNITED STATES
Received: June 4, 2020; Accepted: November 18, 2021; Published: January 24, 2022
Copyright: © 2022 Laporte et al. This is an open access article distributed under the terms of the Creative Commons Attribution License, which permits unrestricted use, distribution, and reproduction in any medium, provided the original author and source are credited.
Data Availability: Datasets are available as downloadable figures, tables, and supplementary files in the following articles: (NAM: https://doi.org/10.1534/genetics.117.300305) (Factorial: https://doi.org/10.1534/genetics.114.165860) (Flint: https://doi.org/10.1007/s00122-014-2379-7)." Data and Code are available as zip file in S1, S2 and S3 Codes.
Funding: This work was funded by the French National Research Agency (ANR) as part of the “Investissements d’Avenir” program, ANR-10-BTBR-0001, Amaizing (https://anr.fr) to FL, AC, and TMH. The funders had no role in study design, data collection and analysis, decision to publish, or preparation of the manuscript.
Competing interests: The authors have declared that no competing interests exist.
This is a PLOS Computational Biology Methods paper.
Introduction
Since their formal introduction in the early 50’s [1, 2], mixed models have become an indispensable tool of modern statistics. They have been successfully used in many application fields [3] to model data with multiple sources of biological or technical variations. Starting with the work of [4] and [5], mixed models have been a favored methodology in quantitative genetics, and are still widely used in the context of Genome-Wide Association Studies (GWAS) and Genomic Selection (GS).
With the development of high throughput technologies, a special care has been dedicated to the development of efficient algorithmic procedures for the inference of mixed models [6–9]. This is illustrated by the availability of many tools/softwares that either perform inference in a mixed model including many (fixed and random) effects on large datasets, or alternatively that efficiently fit hundreds of thousands of mixed models with a limited number of variance components. Many of these tools were developed in the context of animal or human quantitative genetics, or single environment plant studies, where a popular strategy for GWAS analysis is the one presented in [10] that requires the fitting of a simple 2-component mixed model per marker, a favorable case for which efficient algorithms exist that allow the analysis of very large panels with 104 − 105 individuals genotyped at 106 markers [7, 8].
In the context of plant breeding, panels are often of moderate size, including a few hundreds/thousands of individuals only due to experimental/cost constraints. At the same time, the mixed models used for the statistical analysis may be more complex that the ones used in human genetics, since the modeling should account for the specificities of the experimental design (e.g. when a multi-site experiment involving the same varieties in different environments has been carried out) or of the crossing design (e.g. when considering hybrids obtained from parental lines belonging to different populations). One then aims at choosing among the many algorithmic procedures the one that is best suited to cope with these specific features.
From a technical point of view, the Average Information (AI) algorithm [11, 12] has become the reference algorithm for Restricted Maximum Likelihood (ReML) estimation. It has been implemented in many packages [9, 13, 14] and different contexts, the practical implementation being sometimes slightly different from a package to another (see the Methods section). Although in some very specific cases alternative algorithms may be more computationally efficient, it is considered as a reference due to its versatility and its competitive computational performance.
In this article we present a Min-Max (MM) algorithm for the ReML inference in Gaussian Variance Component (VC) mixed model. MM algorithms have been previously described [15], and applied to ML inference in mixed models [16]. We first present here the full derivation of the MM procedure applied to ReML estimation, along with the way it can be combined with some classical computational tricks to significantly speed-up the initial procedure. We then provide a thorough benchmark comparison to illustrate that the proposed MM algorithm can compete with several state-of-the-art algorithms that are widely used in quantitative genetics to perform ReML estimation, including BOLT-LMM [17], FaST-LMM [7], gaston [9], GEMMA [18] and GridLMM [19]. In our study algorithms are compared on different plant breeding scenarios, with a focus for those that may require numerous runs of the model (e.g. GWAS). The study reveals that differences in terms of precision may be marginal between exact ReML procedures, but differences in computational performance may be important. In many scenarios the MM algorithm proves to be competitive with respect to its competitors.
Results
Setting
We considered several procedures corresponding to different implementations of the optimization algorithms described in the Methods section. Our candidate procedure, called hereafter MM4LMM, corresponds to the implementation of the Min-Max algorithm. MM4LMM is compared to the following 3 state-of-the-art procedures:
- ⋆ gaston [9] (version 1.5.7) is an R package that implements the AI algorithm. When K = 2 gaston performs ReML estimation using Newton method.
- ⋆ FaST-LMM [7] (C version 2014) fits mixed models with two variance components only, using the joint orthogonalization and profiling tricks.
- ⋆ GEMMA [18] (version 0.98.1) fits mixed models using the AI algorithm for variance component estimation, combined with the joint orthogonalization trick when applied to a two variance component model.
All aforementioned algorithms aim at optimizing the restricted maximum likelihood (6). Additionally, we considered Grid-LMM [19] that performs an approximate ReML optimization over a grid of candidate variance values, and BOLT-LMM that performs GWAS using a Gaussian mixture modeling of SNP effects (see [17] for details).
In order to compare the different algorithms in terms of precision of variance parameter estimation, one needs a reference procedure that provides the “true” values of the ReML estimates. In the present context we considered the optimizeLmer function of the lme4 [20] R package which performs inference using the BOBYQA algorithm [21]. This algorithm was used as the reference procedure, lme4 being one of the most popular (and consequently one of the most debugged) R package to fit mixed models.
We focus here on the application of mixed models to statistical plant genetics, with two specific application cases in mind: genome-wide association study (GWAS) and variance component analysis (VCA). In GWAS, the goal is to identify markers that are significantly associated with phenotypic variation. The relationship between a given marker and the phenotype needs to be tested in a model that accounts for both the marker effect and background genetic effects specific to each individual.
In classical human and animal studies and also simple plant experiments (one trait in one environment, single population), it is classical to adjust LMM with two variance components (genetic background and residual). Therefore, many softwares exist to fit LMM with only two variance components. However, a number of plant and animal genetic studies address phenotypic data of hybrids (crosses in animals) between different populations, referred to in plants as heterotic groups (e.g. flint and dent for maize genetics). Background genetic effects involve in this case more than one source of variation, at least four when considering the additive variation contributed by each group, the interaction between the two groups and the error term.
A further characteristic of plant experiments is that phenotyping of varieties is generally conducted in multiple environments. These different environments generally reveal different magnitudes of genetic and error variations and complex genotype x environment patterns. In this case, algorithms have to be flexible regarding the high number of possible random effects considered within the LMM.
Most GWAS algorithms fit mixed model including two or more variance components for each tested marker, meaning that computational efficiency is of major importance. Alternatively, some algorithms build on an approximate procedure where only the parameters associated to the fixed part of the model are updated for each marker (e.g. EMMAX or the approximate version of FaST-LMM, see [7, 22]), resulting in a significant computational speed-up. However, one should be sure that such speed-up approximations in the optimization algorithm yield accurate p-values.
Algorithm comparison
The three datasets presented in the next sections were selected as representative of classical GWAS/GS/VCA panels in plant quantitative genetics, both in terms of scale (numbers of trials, individuals per trials and replicates per individuals) and complexity (lines or hybrids, need for gene×environment interaction in the statistical modeling…). All datasets are publicly available, see the Data Availability section. Also we stress out that the models considered for each dataset were selected in order to illustrate the many different aspects that may impact the computational performance of the algorithms to be compared rather than providing general guidelines about statistical modeling in quantitative genetics.
All algorithms were run and compared on a server using a Intel(R) Xeon(R) CPU E5–2420 0 @ 1.90GHz processor, applying their by-default configuration settings. Each dataset was analyzed using the same number of cores and memory setting for all algorithms.
Two variance components.
Dataset. We consider the CornFed Flint Association panel—named Flint hereafter [23]. It consists in 259 maize lines of the Flint heterotic group, genotyped at 39,076 biallelic markers (after quality control). These hybrids were evaluated in an 11 location network. In the following GWAS we considered least square means of the individual phenotypes as the studied trait as in the original publication. We present here the results for two phenotypes, DM_Y_Flo and Tass, the results being similar for the remaining ones.
Statistical analysis. For each marker ℓ and for a given trait, the analysis was performed using the following model:
with Y the vector of phenotypes, Xℓ the vector corresponding to the number of copies of allele 1 present at marker ℓ, βℓ the effect associated with allele 1, U the random effect accounting for the genetic background, and E the error vector. K is the matrix of kinship between lines. To identify markers associated to phenotypic variation the null hypothesis H0: {βℓ = 0} was tested using a Wald test procedure (see S1 Appendix for details).
Computational time. The computational times corresponding to the whole genome analysis are displayed in Table 1. Recall that lme4 represents the reference in terms of inference performance (i.e. sharp estimation of parameters), but is not expected to perform well in terms of computational time, being not optimized for GWAS analysis. Although all methods achieve the GWAS analysis in less than 30s, a factor of at least 10 may be observed between the most efficient (gaston) and the less efficient (FastLMM or BOLT-LMM) methods (excluding lme4). There is no gain in using GridLMM in this context since all exact methods are using the simultaneous orthogonalization trick, making the inference very efficient. One also observes that the computational time of BOLT-LMM is quite unstable from one trait to another.
QTL detection. In order to check the precision of the methods, we applied a full marker identification procedure accounting for multiple testing with each algorithm. A Bonferroni correction using Meff as the number of tests was performed, with Meff being the effective number of tests as estimated using the Gao procedure [24]. For the present application one obtains Meff = 3, 527.
We found the GWAS results to be very similar across all algorithms except BOLT-LMM. For the other algorithms all GWAS analyzes led to the same list of markers (provided in Table 2), and the correlation between the different lists of (log-transformed) p-values were found to be higher than 0.99. The correlation observed between BOLT-LMM and the other methods is 0.97, leading to a different list of significant markers. This could be expected since BOLT-LMM does not rely on the same modeling than the other algorithms.
Several approximate approaches have been proposed in order to further reduce the computational burden. In gaston a score test procedure is provided. FaSTLMM also comes with an approximate version of the test procedure, where the variance components are estimated only once without further refitting of the restricted maximum likelihood for each marker. Although such strategies speed up the computational performance, they result in p-values that are poorly estimated, and possibly to different lists of significant markers (see S1 Code: TwoVarianceComponents/Rmd/SupplementaryResults_TVC.html). Alternatively, it has been advocated to perform GWAS by considering each chromosome separately for the variance component estimation, using a kinship matrix estimated on markers that do not belong to the candidate chromosome under study [25]. Applying this strategy led to an increase of power (i.e. smaller p-values for the best candidates) for the approximate approaches. However in the present example this gain in power did not increase the number of markers detected by the approximate methods up to that detected by the exact ones. Additionally, note that exact procedures can also be combined to this “leave-one-chromosome-out” approach, (see also S1 Code: TwoVarianceComponents/Rmd/SupplementaryResults_TVC.html).
In the next two sections BOLT-LMM and FaST-LMM are not considered since they do not handle models with more than 2 variance components.
Four variance components.
Dataset. The maize dataset (called Factorial in the following) consists in hybrids derived from an incomplete factorial crossing design between flint and dent lines [26]. A total of nD = 123 parental dent lines and nF = 86 parental flint lines were crossed to obtain nH = 1, 254 hybrids. Parental lines were genotyped at 32,486 markers. Two phenotypic traits were quantified: grain yield (GY) and grain moisture (GM). We present the results obtained on GM. The association study was performed using the following model: at a marker ℓ and for a given trait, one has:
(1)
with Y is the vector of phenotype, Xℓ is the vector corresponding to the number of copies of allele 1 present at marker ℓ, βℓ the effect associated with the allele 1, GF, GD and GH are the random polygenic effects corresponding to the flint parent, the dent parent and their specific interaction, respectively, and ZF, ZD and ZH are the associated incidence matrices. Correlation matrices KF and KD correspond to the kinship matrices between the dent (resp. flint) parental lines. Matrix Φ corresponds to the double relatedness matrix between hybrids, of general term
where h (resp. h′) is the hybrid resulting from the crossing between the flint and dent lines f and d (resp. f′ and d′). Lastly, E is the error vector.
Algorithm performances. The analysis of the Factorial dataset required 11.25h with gaston, 2.5h with MM4LMM and 107 seconds with GridLMM. The performance of GEMMA is not reported since it exceeded 20h. In terms of p-values the two exact methods led to very similar results (correlations between −log10(p-values) series >0.999). The correlation between any exact method and GridLMM was found to be of the same order but with p-values being bigger for GridLMM compared with exact methods, see Fig 1. Although in the present example no marker was declared significant whatever the method, the p-value inflation could result in a slight loss power in some applications.
Importantly, the model considered for the analysis only assumed an additive effect for the marker. However in most cases the analysis of a hybrid panel requires one to account for both an additive and a dominance fixed effects. Including a dominance effect is possible when using MM4LMM, GEMMA and gaston, but not when using GridLMM that requires the marker effect to be included in the model through a single numeric incidence vector. This constitutes a significant limitation for the use of GridLMM applied to GWAS in the context of plant or animal genetics.
More than 4 variance components.
Dataset. The dataset (called the NAM dataset hereafter) is constituted of nH = 951 maize hybrids derived from an incomplete factorial crossing design between nD = 875 dent lines and nF = 883 flint lines [27]. All hybrids were evaluated for 4 phenotypes (i.e. response variable). Here we focus on the Dry Matter Yield (hereafter DMY), the results obtained with the other traits being very similar. Hybrids were evaluated in 8 different trials performed in two countries, with a number of measurements per hybrid in a trial going from 0 to 2, most hybrids being measured once. The number of measurements per trial goes from 896 to 1001, the total number of measurements being 7,725. The goal of the study was to evaluate the contribution of the 2 parental populations (dent and flint) to the phenotypic variability.
Statistical analysis. Two different strategies were considered for the statistical analysis. The first strategy consisted in a 2-step analysis. In step 1 a first model was fitted to correct the phenotypic data for field effects—see S2 Appendix for details. In a second step a Variance Component Analysis was performed using the following model:
(2)
where Y here stands for the corrected phenotypes obtained in step 1. Here βT is the the vector of trial fixed effects and XT is the associated incidence matrix, the other terms being defined as in Eq (1).
The second strategy consisted in performing a one-step analysis on the whole dataset, including all trials in a single analysis. The model has to account for both genetics and trial/field effects, but also for gene×environment interactions, a feature that is relevant whenever trials are expected to be diverse (in terms of environmental conditions) and genetic effects sensitive to the environment. The random interaction terms are assumed to have specific variances in each trial, leading to
(3)
with NT the number of trials,
(resp.
and
) the polygenic effect associated to the flint lines (resp. dent lines and flint-dent line interaction) within trial k,
,
and
the associated incidence matrices,
and
are row and column effects within trial k,
and
the associated incidence matrices,
and
are the numbers of row and column within trial k and Ek the residual effect within the trial k, nk the number of hybrids within trial k and
the incidence matrix associated to Ek. Note that residual variances are also assumed to be specific to each trial.
In multi-trial analyzes different factors may impact the computational efficiency of the inference algorithm, including the number of observations, the number of trials, the computational tricks that may be implemented and the number of variance components. In order to quantify the effect of these factors on the different algorithms considered here, we first considered simulated data mimicking a subsample of the full dataset. Synthetic phenotypes were simulated based on the observed genotypic data and the experimental design of the NAM dataset. More precisely, we subsampled sets of hybrids from the NAM dataset and then simulated the phenotype based on Model (2), using the observed kinship matrices and considering no fixed effects (i.e. all observations have a null mean). The computational performance of the 4 algorithms are presented on both the simulated and the NAM data, analyzed using either Model (2) or (3). Note that Model (3) has 44 components when assuming a common error variance, and 51 otherwise, making the model fitting significantly more involving than the previous analyses. Consequently we considered variance component analysis rather than association analysis.
Estimation. In terms of variance estimation, all algorithms yielded the same results when applied to the complete NAM dataset, using Model (2). The table of the variance component estimates is given in S3 Appendix. Similar conclusions were obtained when considering other phenotypic traits (results not shown).
Computational time. We investigated how the number of observations impacts the computational performance of the different algorithms. We first considered a “one-trial” simulation setting where n = 400, 500, …, 900 hybrids were randomly selected from the 951 available ones and phenotypes were generated as described in the previous paragraph. This process was repeated 10 times. The data were then analyzed using Model (2). The results are displayed in Fig 2 (left). As expected the computational time of all procedures increases with n, with gaston and MM4LMM being the top two algorithms. Compared to the Hybrid data application the lower performance of GridLMM comes from the fact that here only a single model is fitted.
Computational time of the algorithms with respect to the number of observations (left) and the number of trials (right).
In a second setting we investigated the impact of the number of trials on the computational performance of the different algorithms. To this end, we fixed the total number of observations at n = 2400, and randomly sampled hybrids in nT = 4, …, 8 trials (balancing the contribution of the different trials). For each number of trials, the simulation process was repeated 10 times and Model (2) was used for the analysis. Results are presented in Fig 2 (right). Apart from MM4LMM, all algorithms are insensitive to nT: as soon as the number of variance components in the model does not depend on nT the algorithms scale with n (which is fixed here) only. The behavior of MM4LMM differs from the other algorithms because MM4LMM automatically selects whether the MME trick (described in the Methods section) should be used or not. In the present setting one can show that the algorithmic complexity of the MM algorithm is O(n3 + K × n2 + p3) whereas the one of MM combined with the MME trick is , where p = rank(X). Here quantities nF, nD and nH decrease with increasing values of nT, and the computational time of MM4LMM decreases accordingly. Consequently, depending on the balance between the number of random effects and of measurements, the MME trick may be beneficial (e.g. when all trials are considered) or detrimental (eg when only 2 or 4 trials are included in the analysis).
Although the previous simulated settings allow one to disentangle the effect of the number of observations and the number of trials, we considered a more realistic setting where both numbers increase together, i.e. a setting where the number of slots in a trial does not depend on nT. Here we used the real NAM data, built intermediate versions of the complete dataset by selecting subsets of 2, 4 or 6 trials among the 8 available ones and analyzed these subsets with Model (2). Table 3 displays the computational time associated with each algorithm. One observes that differences in terms of performance may be important, as quantified using the ratio between the worst and the best computational time obtained (last column), with no single algorithm being uniformly the most efficient. Note that the Bayesian estimation procedure implemented in the MCMCglmm package [28] was also considered for this analysis. Results were similar in terms of parameter estimation but are not reported here due to prohibitive computational costs (>24h for a single 2-trial analysis).
Bold numbers correspond to the best performance.
We then considered the analysis of all trials using Model (3). In this context the use of the MME trick would be detrimental since the cumulative size of the correlation matrices may become significantly high. The computational times obtained are summarized in Table 4. Note that no performance is reported for GridLMM since it cannot handle such a large number of variance components (the memory size required for matrix storage—>80Go for the first iteration—becomes highly prohibitive). The table of the variance component estimates is given in S4 Appendix.
Lastly, note that Model (3) assumes a homogeneous error variance across trials, a strong hypothesis that is highly unlikely in practice. The third strategy is then to analyze the full dataset using Model (3), except that one now assumes that for each trial k. A comparison between the homogeneous and trial specific error variance models based on the BIC criterion confirms that the heterogeneous error variance model is to be preferred for the NAM dataset (BIC(homogeneous)=15,279, BIC(specific)=14,850, smaller is better). Although highly desirable for the statistical analysis, this last model cannot be fitted by the algorithms presented here except for MM4LMM, that run the analysis in 4410 seconds.
Discussion
As illustrated in the Results section, the MM algorithm is a competitive algorithm in the context of ReML inference for VC mixed models. When K = 2, it can be combined with the simultaneous orthogonalization trick to compete with algorithms dedicated to the 2-component case such as FaST-LMM or BOLT-LMM when applied to datasets of moderate size. For large values of K the number of available methods reduces to gaston, GEMMA and MM4LMM, the last one being the more versatile to e.g. handle models including heterogeneous error variances. This versatility is important in the context of GS, GWAS or VCA since it gives access to models more complex than the “reference” model that only includes a polygenic and an error components (as proposed in [10]). Note that the MM4LMM R package also provides estimated standard error values for the variance parameters that help to better interpret the results when the number of variance components is high. These features make MM4LMM a method of choice for i) the analysis of multi-environment trials and ii) the analysis of crossing designs where the modeling of non-additive marker effects is at stake, as these two settings are usually characterized by a large number of variance components.
The analysis of the NAM dataset showed that the MME trick is only beneficial if the number of observations is much higher than the total number of latent effects, but may be detrimental otherwise. Also note that the MME trick requires each matrix Vk in the model to be invertible, a stringent condition that is not required by the ReML procedure itself, and is not satisfied in many applications. For these reasons the use of the MME trick should be restricted to some applications only, an optional strategy that is available in the MM4LMM package but not in most packages/softwares.
Conclusion
The Min-Max algorithm is a simple alternative to the by-default AI-ReML algorithm that is commonly implemented in most packages. We demonstrated that most classical speed-up tricks used in the context of mixed model inference can be easily combined with the MM algorithm, yielding an efficient estimation procedure than can compete with state of the art competitors in most contexts that are commonly encountered in animal or plant genetics—even those for which efficient alternatives exist (such as the K = 2 case). This first study opens a way for new algorithmic developments in the field of VC mixed models and more generally in ReML inference for other classes of mixed models. A limitation for such further developments is the fact that MM methods require the derivation of a specific surrogate function for each class of mixed model to be considered, making the extension of the inference procedure to e.g. auto-regressive or factor analytic models [29] not straightforward.
Methods
Variance component mixed model
In this article we focus on variance component models of the form:
(4)
where Y is a vector of n observations, X is an incidence matrix, β is the vector of fixed effects, Vk is the (known) correlation matrix associated to the kth random effect and
is the vector of variances associated to the K random effects. In what follows X is assumed to be a full rank matrix. A special case of Model (4) is the following mixed model:
(5)
where Uk is the kth random effect vector of size nk, Zk (resp. Rk) is the incidence matrix (resp. the correlation matrix) associated with random effect Uk, E is an error vector, and notation A ⊥ B stands for “A and B are independent”. Model (5) boils down to Model (4) where
. Lastly, we introduce
, the covariance matrix of vector Y.
The goal is to infer the unknown fixed effects and variance parameters β and γ. Here we consider the Restricted Maximum Likelihood (ReML) estimation procedure [30, 31].
Let ΠX⊥ = I − X(XT X)−1 XT be the projection matrix on span(X)⊥, and M be any matrix built from the columns of ΠX⊥ such that M is of full rank and rank(M) = rank(ΠX⊥) = m. Applying M to the initial data vector y allows one to get rid of the fixed effects. The restricted (log-) likelihood corresponds to the (log-) likelihood of the transformed data My, and has the following expression (up to a constant):
(6)
where |H| stands for the determinant of matrix H and
Note that does not depend on β (since MX = 0 by construction), nor on the specific choice of M thanks to the second expression of Pγ above [32]. Variance parameters γ can be estimated by applying the classical Maximum Likelihood procedure to
, then fixed effects can be obtained using the following formula:
Although quite popular, the ReML procedure may be quite challenging from a computational point of view, the bottleneck being the maximization of the log-likelihood (6) w.r.t. γ. Although the first derivative of with respect to
has a simple expression:
solving the K equations
, k = 1, …, K does not lead to a closed form expression for
. Consequently likelihood maximization has to be performed numerically. The next section presents the Newton optimization algorithm and its derivatives to obtain the ReML variance estimates.
Newton based algorithms
Newton algorithm.
Let first rewrite Model (4) as
where Z = (Z1|…|ZK−1),
. The joint distribution of (U, E) is
The restricted likelihood can be reformulated as:
where Σδ = ZGδ ZT + VK,
and m = rank(M). Starting from this last expression, one can perform optimization of
using an iterative scheme like the Newton algorithm that requires the first and second derivatives of
w.r.t. both δ and
. The first derivatives are
Similarly, the second derivatives are
Denoting and
the gradient and the Hessian matrix of
evaluated at point
respectively, the Newton method then iterates the following recursion:
A classical shortcut consists in making use of the fact that the last gradient component leads to an explicit expression of when the ratio δ is known:
(7)
One can then apply the Newton algorithm to update δ only, which reduces the number of unknown parameter by one in the Newton update procedure. This trick is classically known as the “profiling” trick. Additional computational shortcuts are presented in the Computational shortcuts section.
Fisher scoring and average information.
It has been suggested [11, 30] that the use of alternative matrices in place of the Hessian matrix in the Newton procedure could be beneficial in terms of convergence rate and/or computational burden. The first alternative, known as the Fisher algorithm, consists in replacing by its expected value. The expectations of the Hessian matrix terms are
A second alternative is the use of the Average Information (AI) matrix [12]. The AI matrix is defined as the average of the Hessian and its expectation. The efficiency of this strategy leads in the general expression of the resulting matrix. One has
(8)
where for the second term the approximation tr(Vk Pδ) ≈ yTPδVkPδy is used. Compared with the previous expressions obtained for the Newton and FS algorithms, computing the AI matrix does not involve any trace computation anymore. Note that Pδ is computed at each step using formula
where δ and
are fixed at their current value.
Computational shortcuts.
Simultaneous orthogonalization. As mentioned in the Newton based algorithms section, the profiling trick reduces the computational complexity by discarding one of the variance component in the update procedure: the numerical optimization only applies to δ, being estimated afterwards using its explicit expression (7). When applied to the case where K = 2, profiling may be combined to the simultaneous orthogonalization of the two covariance matrices to obtain an even simpler expression of the restricted likelihood. Assuming one of the two matrices (say V2) is positive definite, then there exist a matrix Λ and a diagonal matrix D such that
One can reexpress the restricted log-likelihood associated with Model (4) as a function of , δ and D as follows:
(9)
where
and
. The expression of
can then be plugged back into Eq (9) to obtain a function that depends on δ only:
(10)
This last expression can then be optimized w.r.t. δ. This strategy is implemented in the R package gaston where a Newton Raphson algorithm, followed by a Brent algorithm (if the procedure has not already converged) are used for the optimization of (10), and also in FaST-LMM where the optimization is first performed on a grid then refined using the Brent algorithm [7, 9]. One can observe that the simultaneous orthogonalization trick drastically reduces the computational burden whenever many models with identical random effects but different fixed effects have to be adjusted, the orthogonalization being performed only once (i.e. Λ is common to all models).
Henderson equation shortcut. As mentioned earlier, one needs to invert matrix Σδ at each step to update matrix Pδ. This operation is the computational bottleneck of the optimization procedure and may become cumbersome when the number of measurements n is large. In some configurations this step may be relaxed by deriving the quantities required for the update of δ from the Henderson Mixed Model Equations (MME)
(11)
Noting C the coefficient matrix appearing in the left hand side of the equation, one first notices that solving the system requires the inversion of C, of size ∑k nk + p, where nk is the length of vector Uk and p is the rank of matrix X. Second, it has been shown that the quantities appearing in AI matrix (8) can be reexpressed using C−1, details are given in S5 Appendix [12]. One has:
and
(12)
where
and [C−1]uu corresponds to the submatrix of C−1 associated with the random component u. Assuming all matrices Vk are invertible (i.e. definite positive), all these expressions are easily obtained from
,
and C−1. As soon as ∑k nk + p ≪ n it becomes computationally efficient to compute the AI matrix through the MME rather than through direct inversion of Pδ. In the following, this shortcut will be referred to as the “MME trick”.
Min-Max algorithm for ReML
MM algorithm for ReML inference.
MM algorithms represent another class of iterative schemes [15]. We provide a brief overview of the MM principle based on the previous reference. Consider an optimization problem where one aims at finding the minimizer θ* of a function f(θ) (in our setting and θ = γ), one builds at each step t a surrogate function g(t) satisfying
where θ(t−1) is the current evaluation of θ*. Assuming the surrogate function can be minimized easily, one defines
One can show that the sequence (θ(t))t≥1 satisfies the descent property f(θ(t+1)) ≤ f(θ(t)). In practice, the convergence is assessed using a convergence criterion such as
or
In the present article both criteria were used with ϵ = 10−5.
In the context of variance component mixed models, a MM method has been proposed to maximize the likelihood [16]. Following the same line of proof, we present an MM algorithm for ReML inference. The main difficulty to apply MM optimization is to derive the sequence of surrogate functions. Proposition 1 provides the surrogate function at step t + 1 for the ReML optimization problem:
Proposition 1 Define function g(t+1)(γ) as
(13)
where m = rank(M). Then
where equality holds at point γ(t).
The proof of Proposition 1 is adapted from the one given for ML inference [16] and is given in S6 Appendix. Because at each step t the surrogate function g(t) is linear with respect to , one easily obtains its optimizer by setting its gradient at 0. This provides the following update for the variance parameters:
(14)
The next section presents the adaptation of the computational tricks presented in the Newton based algorithms section to the ReML MM procedure.
Computational shortcuts for the ReML MM procedure.
Two matrix shortcut. In the particular case when K = 2 the correlation matrices can be jointly orthogonalized. Similar to the profiling trick, we introduce
where c(t) is an irrelevant constant. As detailed in S7 Appendix, one can show that optimizing function g(t+1) boils down to solving a quadratic function that admits a unique positive solution corresponding to δ(t+1).
K matrix shortcut. When relevant, the MME trick can be applied to speed up the computation of the quantities appearing in the surrogate function (13). Since and
, the update formulas (14) can be rewritten as follows:
and can be computed using expressions (12) for k = 1, …, K − 1 (recall that Z does not include ZK). For the case k = K, the numerator can be easily obtained from the expression of
in (12), and tr(PVK) can be calculated using the following proposition:
Note that S does not need any update and can be computed at once. The demonstration is given in S8 Appendix.
MM Acceleration. Similar to EM algorithms, MM algorithms can benefit from accelerating strategies to achieve better rates of convergence (by reducing the number of iterations required to achieve a given precision). Here we combined the MM algorithm with a squared iterative method [33]. Assuming one aims at minimizing a function f using a MM algorithm, note θ(t−2), θ(t−1) and θ(t) the MM estimates obtained at steps t − 2, t −1 and t, respectively. At step t one also computes
If f(θ(t′)) < f(θ(t)) then θ(t) ← θ(t′). The acceleration process is then iterated with θ(t+2).
Supporting information
S1 Code. Data and Code for Two variance component analyses available as zip file.
https://doi.org/10.1371/journal.pcbi.1009659.s001
(ZIP)
S2 Code. Data and Code for Four variance component GWAS available as zip file.
https://doi.org/10.1371/journal.pcbi.1009659.s002
(ZIP)
S3 Code. Data and Code for Four variance component VCA available as zip file.
https://doi.org/10.1371/journal.pcbi.1009659.s003
(ZIP)
S2 Appendix. Data correction step for the NAM dataset.
https://doi.org/10.1371/journal.pcbi.1009659.s005
(PDF)
S3 Appendix. Table of variance component estimates for model (2).
https://doi.org/10.1371/journal.pcbi.1009659.s006
(PDF)
S4 Appendix. Table of variance component estimates for model (3) with common error variance.
https://doi.org/10.1371/journal.pcbi.1009659.s007
(PDF)
S6 Appendix. MM surrogate function for the ReML procedure.
https://doi.org/10.1371/journal.pcbi.1009659.s009
(PDF)
S7 Appendix. Two variance component shortcut for the MM algorithm.
https://doi.org/10.1371/journal.pcbi.1009659.s010
(PDF)
Acknowledgments
The authors would like to thank Simon Rio, Aurélien Beugnot and Dimitri Sanchez for their valuable feedback on the R package.
References
- 1. Henderson CR. Estimation of variance and covariance components. Biometrics. 1953;9(2):226–252.
- 2. Scheffe H. A “mixed model” for the analysis of variance. The Annals of Mathematical Statistics. 1956; p. 23–36.
- 3. Gibbons RD, Hedeker D. Applications of mixed-effects models in biostatistics. Sankhyā: Indian J Stat, Series B. 2000; p. 70–103.
- 4. Griffing B. Concept of general and specific combining ability in relation to diallel crossing systems. Australian journal of biological sciences. 1956;9(4):463–493.
- 5. Henderson CR. Sire evaluation and genetic trends. Journal of Animal Science. 1973;1973(Symposium):10–41.
- 6. Kang HM, Zaitlen NA, Wade CM, Kirby A, Heckerman D, Daly MJ, et al. Efficient control of population structure in model organism association mapping. Genetics. 2008;178(3):1709–1723. pmid:18385116
- 7. Lippert C, Listgarten J, Liu Y, Kadie CM, Davidson RI, Heckerman D. FaST linear mixed models for genome-wide association studies. Nature methods. 2011;8(10):833–835. pmid:21892150
- 8. Zhou X, Stephens M. Genome-wide efficient mixed-model analysis for association studies. Nat genet. 2012;44(7):821–824. pmid:22706312
- 9. Dandine-Roulland C, Perdy H. Genome-wide data manipulation, association analysis and heritability estimates in R with Gaston 1.5. Human heredity. 2017;83(1):6–6.
- 10. Yu J, Pressoir G, Briggs WH, Bi IV, Yamasaki M, Doebley JF, et al. A unified mixed-model method for association mapping that accounts for multiple levels of relatedness. Nat Genet. 2006;38(2):203–208. pmid:16380716
- 11. Gilmour AR, Thompson R, Cullis BR. Average information REML: efficient algorithm for variance parameter estimation in linear mixed models. Biometrics. 1995; p. 1440–1450.
- 12. Johnson DL, Thompson R. Restricted maximum likelihood estimation of variance components for univariate animal models using sparse matrix techniques and average information. Journal of dairy science. 1995;78(2):449–456.
- 13.
Gilmour AR, Gogel BJ, Cullis BR, Welham S, Thompson R. ASReml user guide release 4.1. VSN International Ltd, Hemel Hempstead, UK. 2015;.
- 14. Speed D, Cai N, Johnson MR, Nejentsev S, Balding DJ. Reevaluation of SNP heritability in complex human traits. Nat Genet. 2017;49(7):986. pmid:28530675
- 15. Hunter DR, Lange K. A tutorial on MM algorithms. The American Statistician. 2004;58(1):30–37.
- 16. Zhou H, Hu L, Zhou J, Lange K. MM algorithms for variance components models. Journal of Computational and Graphical Statistics. 2019;28(2);350–361. pmid:31592195
- 17. Loh PR, Tucker G, Bulik-Sullivan BK, Vilhjalmsson BJ, Finucane HK, Salem RM, et al. Efficient Bayesian mixed-model analysis increases association power in large cohorts. Nature genetics, 2015;47.3: 284. pmid:25642633
- 18. Zhou X. A unified framework for variance component estimation with summary statistics in genome-wide association studies. The annals of applied statistics. 2017;11(4):2027. pmid:29515717
- 19. Runcie DE, Crawford L. Fast and general-purpose linear mixed models for genome-wide genetics. PLoS genetics. 2019;15.2:e1007978. pmid:30735486
- 20. Bates D, Mächler M, Bolker B, Walker S. Fitting Linear Mixed-Effects Models Using lme4. Journal of Statistical Software, 2015;67(1);1–48.
- 21.
Powell MJ. The BOBYQA algorithm for bound constrained optimization without derivatives. Cambridge NA Report NA2009/06, University of Cambridge, Cambridge. 2009;26–46.
- 22. Kang HM, Sul JH, Service SK, Zaitlen NA, Kong SY, Freimer NB, et al. Variance component model to account for sample structure in genome-wide association studies. Nature genetics. 2010;42(4):348–354. pmid:20208533
- 23. Rincent R, Nicolas S, Bouchet S, Altmann T, Brunel D, Revilla P, et al. Dent and Flint maize diversity panels reveal important genetic potential for increasing biomass production. Theo Appl Genet. 2014;127(11):2313–2331. pmid:25301321
- 24. Li J, Ji L. Adjusting multiple testing in multilocus analyses using the eigenvalues of a correlation matrix. Heredity. 2005;95(3):221–227. pmid:16077740
- 25. Rincent R, Moreau L, Monod H, Kuhn E, Melchinger AE, Malvar RA, et al. Recovering power in association mapping panels with variable levels of linkage disequilibrium. Genetics. 2014;197(1):375–387. pmid:24532779
- 26. Technow F, Schrag TA, Schipprack W, Bauer E, Simianer H, Melchinger AE. Genome properties and prospects of genomic prediction of hybrid performance in a breeding program of maize. Genetics. 2014;197(4):1343–1355. pmid:24850820
- 27. Giraud H, Bauland C, Falque M, Madur D, Combes V, Jamin P, et al. Reciprocal Genetics: Identifying QTL for General and Specific Combining Abilities in Hybrids Between Multiparental Populations from Two Maize (Zea mays L.) Heterotic Groups. Genetics. 2017;207(3):1167–1180. pmid:28971957
- 28. Hadfield JD. MCMC Methods for Multi-Response Generalized Linear Mixed Models: The MCMCglmm R Package. Journal of Statistical Software. 2010;33(2):1–22.
- 29. Piepho HP. Analyzing genotype-environment data by mixed models with multiplicative terms. Biometrics. 1997; p. 761–766.
- 30. Patterson HD, Thompson R. Recovery of inter-block information when block sizes are unequal. Biometrika. 1971;58(3):545–554.
- 31. Harville DA. Maximum likelihood approaches to variance component estimation and to related problems. Journal of the American Statistical Association. 1977;72(358):320–338.
- 32.
Searle SR, Casella G, McCulloch CE. Variance components. vol. 391. John Wiley & Sons; 1992.
- 33. Varadhan R, Roland C. Simple and globally convergent methods for accelerating the convergence of any EM algorithm. Scand J Stats. 2008;35(2):335–353.