Abstract

Motivation: Recent advances in sequencing technology have made it possible to obtain high-throughput data on the composition of microbial communities and to study the effects of dysbiosis on the human host. Analysis of pairwise intersample distances quantifies the association between the microbiome diversity and covariates of interest (e.g. environmental factors, clinical outcomes, treatment groups). In the design of these analyses, multiple choices for distance metrics are available. Most distance-based methods, however, use a single distance and are underpowered if the distance is poorly chosen. In addition, distance-based tests cannot flexibly handle confounding variables, which can result in excessive false-positive findings.

Results: We derive presence-weighted UniFrac to complement the existing UniFrac distances for more powerful detection of the variation in species richness. We develop PERMANOVA-S, a new distance-based method that tests the association of microbiome composition with any covariates of interest. PERMANOVA-S improves the commonly-used Permutation Multivariate Analysis of Variance (PERMANOVA) test by allowing flexible confounder adjustments and ensembling multiple distances. We conducted extensive simulation studies to evaluate the performance of different distances under various patterns of association. Our simulation studies demonstrate that the power of the test relies on how well the selected distance captures the nature of the association. The PERMANOVA-S unified test combines multiple distances and achieves good power regardless of the patterns of the underlying association. We demonstrate the usefulness of our approach by reanalyzing several real microbiome datasets.

Availability and Implementation: miProfile software is freely available at https://medschool.vanderbilt.edu/tang-lab/software/miProfile .

Contact:  [email protected] or [email protected]

Supplementary information:  Supplementary data are available at Bioinformatics online.

1 Introduction

Biological and empirical evidences suggest that a diverse microbial community plays an important role in human health ( Alekseyenko et al. , 2013 ; Redel et al. , 2013 ; Segal et al. , 2013 ). Understanding the composition of the microbial community provides insight into the functions of bacteria and their effects on the human host. Sequencing technology has made it possible to capture high-throughput data on the microbiome composition in human specimens. A common unit of analysis for sequencing-based microbiome identification studies is the operational taxonomic unit (OTU). OTUs represent the conceptualization of species and are typically constructed by clustering sequences at a certain similarity threshold (e.g. 97%) ( Caporaso et al. , 2010 ; Schloss et al. , 2009 ). Comparison of OTU profiles with respect to differential clinical outcomes or conditions lends important knowledge towards understanding the underlying disease mechanisms and the effects of dysbiosis ( Alekseyenko et al. , 2013 ; Cho et al. , 2012 ).

Testing associations of the microbiome composition with covariates of interest is challenging because the sample size is typically modest and the number of OTUs is large. Distance-based omnibus tests are popular, as these tests successfully address the challenges by partitioning the distance matrix among sources of variation and evaluating the statistical significance by permutation ( Anderson, 2001a ; McArdle and Anderson, 2001 ). Specifically, when testing for the community difference between groups, the distance-based method contrasts the pairwise distance within and between groups. This statistic is an analogue to Fisher’s F -ratio.

The difference between two microbial composition profiles follows various patterns. The difference may exist in one or several clusters of the species on the phylogenetic tree (lineages) or random sets of species. The difference may be driven by the change of species richness, evenness or a combination of the two. Richness and evenness are the two main factors that describe species diversity in microbial communities. Each of these measures addresses a different aspect of community ecology; thus, by considering them together, a much more insightful picture of the community structure is provided. Increased richness and evenness are often associated with more stable and longer established ecosystems ( Legendre and Legendre, 2012 ; Relman, 2012 ). Such ecosystems tend to be resistant to environmental pressures, such as diet, antibiotic use and pathogen invasion ( Cox et al. , 2013 ; Shade et al. , 2012 ).

Over two dozen distance measures are available in open source packages, like vegan ( Oksanen et al. , 2015 ), ade4 ( Dray and Dufour, 2007 ) and phyloseq ( McMurdie and Holmes, 2013 ), to quantify the variation in composition between microbiome samples (beta diversity). The unweighted and weighted UniFrac are two commonly-used distances constructed on the phylogenetic tree ( Lozupone and Knight, 2005 ; Lozupone et al. , 2007 ). These distances are efficient in detecting differential species in lineages of the tree. The unweighted UniFrac uses the difference of the species presence–absence status between two samples to determine the inclusion of a particular tree branch. The weighted UniFrac uses the difference of the species relative abundance (proportion) between two samples to weight the branch. As an extension of the weighted UniFrac, the generalized UniFrac introduces a parameter to attenuate the contribution from high abundant lineages ( Chen et al. , 2012 ). Bray-Curtis and Jaccard distances are two popular dissimilarity measures that do not utilize the phylogenetic tree. They tend to be efficient in detecting association on arbitrary species rather than in lineages. Bray-Curtis distance is defined as the difference of the abundance divided by the total abundance contributed by both samples. Jaccard distance is defined as the number of unique species present in either sample, divided by the number of species present in any of the two samples.

Although distance-based methods provide powerful tools to discover associations between the microbiome composition and covariates, they suffer from two main limitations. First, existing distance-based tests cannot flexibly handle confounders, which are defined as variables correlated with both the covariates of interest and the microbiome composition. Extending these methods to accommodate more-sophisticated outcomes and study designs ( Lin and Zeng, 2009 ; Lin et al. , 2013 ) in the presence of confounders is challenging ( Zhao et al. , 2015 ). Treating confounders as covariates or omitting the confounders in the distance-based test distorts the true association. Hence, the ability to properly model and adjust for confounders becomes critically important. Second, existing distance-based tests cannot simultaneously incorporate multiple distances. As the underlying biology is unknown a priori, the selected distance is most likely suboptimal and may not yield good statistical power. Searching multiple distances and reporting the one that produces the smallest P -value is too liberal and yields excessive false discoveries, unless adjustments are made for multiple comparisons. On the other hand, adjustments for multiple comparisons may result in poor power when an excessive number of distances is tested. Hence, it is highly desirable to have a unified test that combines multiple distances.

In this article, we derive presence-weighted UniFrac to complement the existing UniFrac distances for more powerful detection of variation in species richness. The presence-weighted UniFrac distances achieve adequate power in a wide range of scenarios. We develop PERMANOVA-S, a new distance-based method to test the association of microbial communities with any covariates of interest. PERMANOVA-S improves the commonly-used Permutation Multivariate Analysis of Variance (PERMANOVA) test by allowing flexible confounder adjustments and ensembling multiple distances. We conducted extensive simulations to evaluate the performance of different distances under various patterns of association. Our studies demonstrate that the power of the test relies on how well the selected distance captures the nature of the association. The PERMANOVA-S unified test combines multiple distances and achieves good power regardless of the patterns in the underlying association. Application to real microbiome datasets demonstrates the usefulness of the proposed methods. The relevant software miProfile incorporating the new development is freely available.

2 Methods

The PERMANOVA is the most commonly applied distance-based method to test the association of microbial composition with covariates of interest. The test statistics directly use the distance matrix to partition the diversity among sources of variation. This test is especially suitable for the analysis of composition data from ecology studies with a small sample size and a large number of features.

Suppose we generate the microbiome profile Y with m OTUs and collect the covariates X for n samples. We compute a distance matrix D that quantifies the dissimilarity between samples based on Y and potentially the phylogenetic structure of the OTUs. The pseudo- F test statistic is defined as
where tr(·) is the trace operator on a matrix, H=X(XTX)1XT , and G=12(I11Tn)D2(I11Tn) , where I is an n  ×  n identity matrix, 1 is an n×1 vector consisting of ones and D2 is the element-wise square of D . The significance of the pseudo- F statistic is evaluated by simulating the null distribution from permutations.

2.1 Abundance and presence–absence distances

We categorize all distances into abundance distances and presence–absence distances according to the forms of the microbiome data they use: abundance distances are based on the abundance data (counts or proportions) of the species, and the presence–absence distances are based on the presence–absence data (binary indicator for the presence) of the species.

Among the distances that do not utilize the tree information, Bray-Curtis distance is an abundance distance and Jaccard distance is a presence–absence distance. Let p ji and p ki denote the abundance of OTU i in samples j and k , respectively. Bray-Curtis distance between sample j and k is defined as
Let njk01 and njk11 denote the count of the species present in only one sample or both samples, respectively. Jaccard distance is defined as

After converting the abundance data to the presence–absence data (code the present OTU to 1 and the absent OTU to 0), DBC becomes njk01/(njk01+2njk11) . This expression is almost identical to DJ except for a factor of 2 multiplied to njk11 in the denominator. This difference has ignorable effects in terms of discriminating samples, and we consider the presence–absence version of Bray-Curtis distance as equivalent to the Jaccard distance.

Among the tree-based distances, weighted UniFrac and generalized UniFrac are abundance distances, and unweighted UniFrac is a presence–absence distance. Suppose we have a phylogenetic tree with L branches associated with the OTUs. Let b l denote the length of branch l , and p jl and p kl denote the proportion of the OTUs descending from branch l for samples j and k , respectively. The weighted UniFrac and generalized UniFrac distances between samples j and k are defined as
respectively, where α takes a value between 0 and 1. The lower value corresponds to weaker contribution from the high abundant branches. The distance DGW(α) reduces to DW when α = 1.
Let n jl and n kl denote the number of present OTUs descending from branch l for samples j and k , respectively. Unweighted UniFrac is defined as
where I(·) is the indicator function.
For generalized UniFrac, the corresponding version based on the presence–absence data can be expressed as
Distinct from DUW,DPW(α) uses the relative richness difference |njlnkl|/(njl+nkl) to weight the branch. By decreasing α in DPW(α) , we attenuate the contribution from the high rich branches and make the dissimilarity measures more sensitive to the richness change on the moderately rich lineage. The distance DPW(α) is referred to as presence-weighted UniFrac.

2.2 PERMANOVA-S

We develop a new method, PERMANOVA-S, to flexibly accommodate confounders and multiple distances. We first explain the method for confounder adjustment in the presence of a single distance. Then, we tailor the permutation procedure to combine multiple distances.

2.2.1 Confounder adjustment

In the presence of confounding variables Z , we permute residuals after regressing X on Z . We let γZ denote the linear predictor in the regression model.

If X is a continuous variable, we use standard linear regression to compute the residual and the Freedman–Lane permutation strategy ( Freedman and Lane, 1983 ) to obtain the P -value.

  1. Regress X on Z and obtain the maximum likelihood estimator (MLE) γ^ for γ , compute the residuals R=Xγ^Z and construct the observed pseudo- F statistic based on R .

  2. For each permutation, permute R to yield R* , and replace X by X*=γ^Z+R* . Regress X* on Z and obtain the MLE γ^* for γ , compute the residuals R**=X*γ^*Z and construct the permuted pseudo- F statistic based on R** .

  3. The final P -value is the proportion of the permuted pseudo- F statistics larger than the observed statistic.

If X is a binary variable, we use standard logistic regression to compute the residual and the parametric bootstrap ( Davison and Hinkley, 1997 ) to obtain the P -value.

  1. Regress X on Z and obtain the MLE estimate γ^ for γ , compute the residuals R=Xexp(γ^Z)1+exp(γ^Z) and construct the observed pseudo- F statistic based on R .

  2. For each permutation, sample X* from Bernoulli distribution with probability parameter exp(γ^Z)1+exp(γ^Z) . Regress X* on Z and obtain the MLE γ^* for γ , compute the residuals R**=X*exp(γ^*Z)1+exp(γ^*Z) and construct the permuted pseudo- F statistic based on R** .

  3. The final P -value is the proportion of the permuted pseudo- F statistics larger than the observed statistic.

We have implicitly assumed that the covariate X is univariate and that the samples are unrelated. For repeated measures or paired-sample studies, we restrict the permutation within each stratum. For more complicated designs and data types, we need to seek suitable permutation strategies ( Anderson, 2001b ; Pesarin and Salmaso, 2010 ). A comprehensive discussion of the existing strategies is beyond the scope of this paper.

In order to control confounding effects, sequential F -test partitions the distance matrix first with respect to confounders and second with respect to covariates of interest by fitting linear models to distance matrices ( Oksanen et al. , 2015 ). Our approach is conceptually different because we obtain residuals through regression of the covariates on confounders. Although the two approaches are equivalent under certain scenarios (e.g. continuous covariates, standard linear model), our approach is more flexible because suitable models can be employed according to the types of covariates and study designs.

2.2.2 Ensembling of distances

Choosing the distance sensitive to the patterns of association yields high power in the association test. Instead of considering one distance at a time, we develop a multistage permutation strategy that enables us to ensemble multiple distances in a computationally efficient manner. When unifying multiple distances, we use the minimal P -value across distances as the test statistic. To obtain the unified P -value, we employ a permutation procedure to simulate the null distribution for the minimal P -value. The procedure does not depend on a large-sample approximation, so it can be used in a study with a small sample size. Suppose we consider K distances D1,D2,,DK . The testing procedure is described below

  1. For each Dk , compute the observed pseudo- F statistic F k .

  2. Simultaneously generate B permuted pseudo- F statistics Fk(1),,Fk(B) for the K distances. We suggest starting the value of B from a small value (e.g. 500). As noted in the previous section, the selected permutation strategy should be based on the study design and the data types.

  3. For each Dk , obtain the P -value p k based on the B permutations. If pmin=min(p1,,pK)<1/(tol×B) , increase B and repeat step 2. Otherwise, go to step 4. The pre-specified parameter tol takes a value between 0 and 1, with a smaller value corresponding to a more stringent accuracy requirement.

  4. For each Dk , calculate B permuted ‘ P -values’ pk(1),,pk(B) as pk(b)=(Brank(Fk(b)))/B , where rank(Fk(b)) is the rank of Fk(b) among B permuted statistics. This step can be efficiently completed by the quick sort algorithm.

  5. For each permutation, obtain the minimal permuted ‘ P -value’ across K distances: pmin(b)=min(p1(b),,pK(b)) .

  6. The final P -value is the proportion of pmin(1),,pmin(B) that is smaller than pmin .

To obtain the exact P -values for each permuted pseudo- F statistic in step 2, one needs to perform another layer of permutation, which is computationally infeasible. In our procedure, the permuted ‘ P -values’ obtained in step 4 are based on the original round of permutation. The accuracy of these ‘ P -values’ depends on the value of B . By adopting the multistage procedure in step 3, we subsequently find a B that makes these ‘ P -values’ accurate enough to calculate the unified P -value. The existence of such B is because of the implicit fact that the unified P -value cannot be smaller than the minimal P -value across distances. In addition, the multistage procedure ensures that the value of B is not so large as to squander computation time.

2.3 Software: miProfile

We have developed a software program miProfile that incorporates the new development. miProfile implements all commonly-used abundance and presence–absence distances. Users can request any combination of these distances. miProfile produces the P -value for each of the requested distances and the unified P -value by combining all of the distances. The operating interface is simple and can directly input the .biom and .tre files. The OTU abundance table and the distance matrices can be generated as output and reused in subsequent runs. The permutation implemented in miProfile is optimized to achieve computational efficiency. It can finish one million permutations within 150 seconds on an IBM HS22 machine for 100 samples.

2.4 Simulation strategies

We performed extensive simulation studies to investigate the type I error of PERMANOVA-S and to compare the power of abundance distances, presence–absence distances and the PERMANOVA-S unified test in the detection of various association patterns. Following Chen et al. (2012) , we generated 856 OTUs under the Dirichlet-multinomial (DM) model with proportion and dispersion parameters estimated from a real respiratory tract microbiome dataset ( Charlson et al. , 2010 ). Then, we partitioned the 856 OTUs into 20 lineages via the Partitioning Around Medoids algorithm based on the patristic distance. We considered total sample sizes of 20 and 50 and split them into two groups. We assumed the sequencing depth was 1000 reads per sample. For all simulation studies, we considered six distances: weighted UniFrac ( DW ), Bray-Curtis ( DBC ), presence-weighted UniFrac with parameter 1 or 0 ( DPW(1),DPW(0) ), unweighted UniFrac ( DUW ) and Jaccard ( DJ ). We performed the PERMANOVA-S unified test across these six distances. For comparison, we conducted the Bonferroni-adjusted test (Pmin) which uses the minimal P -value of the single-distance test and multiplies it by six.

For the type I error simulation, we considered scenarios with and without confounding effects. When no confounders exist, the sample is evenly distributed between the two groups. To simulate a confounding effect, we first generated a variable related to the microbial community. We then assigned the group label based on the value of that variable. Specifically, we simulated a variable Z from the normal distribution with the mean being the standardized abundance or richness of the most common lineage (19.7%), and we assigned the sample to group one with probability exp(0.5Z)/(1+exp(0.5Z)) . We used 10 000 replicates to evaluate the type I error at a significance level of 0.05.

For the power simulation, we focused on evaluating the performance of different single-distance tests and the unified test. We considered the situation with no confounding effects. The unified test was provided using PERMANOVA-S to combine all six distances. We assumed that the differentiation between groups occurred in one of four possible OTU sets: a common lineage (19.7%), a rare lineage (0.9%), a random lineage, or random 40 OTUs. In addition, we designed three patterns of microbial community differentiation.

  • For each OTU i , we randomly changed absence (count of 0) to presence with count of 1 in one group, such that the resulting percentage of presences (positive counts) increased by a factor of c , where c controls the degree of differentiation. Pattern A dominantly changes richness between groups, while minimally fluctuating evenness (blue curve in Fig. 1 ).
    Relative change in richness (total number of present OTUs) and evenness
                    (Shannon’s diversity index) between two groups for the three patterns of
                    differentiation in a random lineage. Each dot represents the effect size we
                    considered in the simulation studies. The plots for the common lineage, rare
                    lineage and random 40 OTUs are similar and not shown
    Fig. 1.

    Relative change in richness (total number of present OTUs) and evenness (Shannon’s diversity index) between two groups for the three patterns of differentiation in a random lineage. Each dot represents the effect size we considered in the simulation studies. The plots for the common lineage, rare lineage and random 40 OTUs are similar and not shown

  • For each OTU i , we increased the relative abundance by a factor of (1p^i)c only at the presences in one group, where p^i is the average observed abundance in the other group. Pattern B dominantly changes evenness between groups without fluctuating richness (green curve in Fig. 1 ).

  • For each OTU i , we increased the proportion parameters p i in DM distribution by a factor of (1pi)c for one group. Pattern C changes richness and evenness at a balanced rate (red curve in Fig. 1 ).

For all patterns, we renormalized the relative abundance, such that the total proportion is equal to one. In all 12 possible scenarios from the combination of four OTU sets and three patterns of differentiation, we varied the degrees of the signal c and generated the power curves based on 2000 replicates at a significance level of 0.05.

3 Results

3.1 Simulation results

The empirical type I errors of PERMANOVA-S are shown in Table 1 . When confounders exist, the test without confounder adjustment produces inflated type I error. The inflation occurs mostly on abundance distances ( DW and DBC ) when the confounder is correlated with abundance and on presence–absence distances ( DPW(1),DPW(0),DUW and DJ ) when the confounder is correlated with richness. The Bonferroni-adjusted test (Pmin) tends to be conservative.

Table 1.

Empirical type I errors for PERMANOVA-S

nD  WD  BCDPW(1)DPW(0)D  UWD  JPminUnified
No confounder

200.0490.0460.0510.0490.0500.0490.0320.048
500.0480.0510.0500.0440.0420.0470.0350.050

Confounder Z correlated with abundance

Adjust for Z200.0490.0470.0520.0480.0500.0500.0370.053
500.0510.0480.0520.0510.0500.0520.0350.052
Not adjust for Z200.100.0650.0550.0480.0480.0500.0510.072
500.200.100.0540.0520.0530.0540.0940.13

Confounder Z correlated with richness

Adjust for Z200.0530.0530.0510.0510.0510.0520.0360.053
500.0470.0470.0490.0520.0500.0540.0350.051
Not adjust for Z200.0550.0510.0740.0540.0520.0560.0440.061
500.0600.0520.110.0620.0580.0610.0540.077
nD  WD  BCDPW(1)DPW(0)D  UWD  JPminUnified
No confounder

200.0490.0460.0510.0490.0500.0490.0320.048
500.0480.0510.0500.0440.0420.0470.0350.050

Confounder Z correlated with abundance

Adjust for Z200.0490.0470.0520.0480.0500.0500.0370.053
500.0510.0480.0520.0510.0500.0520.0350.052
Not adjust for Z200.100.0650.0550.0480.0480.0500.0510.072
500.200.100.0540.0520.0530.0540.0940.13

Confounder Z correlated with richness

Adjust for Z200.0530.0530.0510.0510.0510.0520.0360.053
500.0470.0470.0490.0520.0500.0540.0350.051
Not adjust for Z200.0550.0510.0740.0540.0520.0560.0440.061
500.0600.0520.110.0620.0580.0610.0540.077
Table 1.

Empirical type I errors for PERMANOVA-S

nD  WD  BCDPW(1)DPW(0)D  UWD  JPminUnified
No confounder

200.0490.0460.0510.0490.0500.0490.0320.048
500.0480.0510.0500.0440.0420.0470.0350.050

Confounder Z correlated with abundance

Adjust for Z200.0490.0470.0520.0480.0500.0500.0370.053
500.0510.0480.0520.0510.0500.0520.0350.052
Not adjust for Z200.100.0650.0550.0480.0480.0500.0510.072
500.200.100.0540.0520.0530.0540.0940.13

Confounder Z correlated with richness

Adjust for Z200.0530.0530.0510.0510.0510.0520.0360.053
500.0470.0470.0490.0520.0500.0540.0350.051
Not adjust for Z200.0550.0510.0740.0540.0520.0560.0440.061
500.0600.0520.110.0620.0580.0610.0540.077
nD  WD  BCDPW(1)DPW(0)D  UWD  JPminUnified
No confounder

200.0490.0460.0510.0490.0500.0490.0320.048
500.0480.0510.0500.0440.0420.0470.0350.050

Confounder Z correlated with abundance

Adjust for Z200.0490.0470.0520.0480.0500.0500.0370.053
500.0510.0480.0520.0510.0500.0520.0350.052
Not adjust for Z200.100.0650.0550.0480.0480.0500.0510.072
500.200.100.0540.0520.0530.0540.0940.13

Confounder Z correlated with richness

Adjust for Z200.0530.0530.0510.0510.0510.0520.0360.053
500.0470.0470.0490.0520.0500.0540.0350.051
Not adjust for Z200.0550.0510.0740.0540.0520.0560.0440.061
500.0600.0520.110.0620.0580.0610.0540.077

Figure 2 shows the power results for three differentiation patterns when the sample size is 20 (see Supplementary Fig. S1 for results with a sample size of 50). Under pattern A, where the change of richness dominates the change of evenness (upper panel of Fig. 2 ), the presence–absence distances ( DPW(1),DPW(0),DUW,DJ ) are dramatically more powerful than the abundance distances ( DW,DBC ) regardless of where differentiation appears. If the signal is on the common lineage, DPW(1) (overlapping with the curve for the unified test) is more powerful than the other distances because it up-weights the high rich branches that the common lineage harbors. If the signal is on the rare lineage, DUW produces the most powerful test, and DPW(0) yields similar power as DUW . DPW(1) is more powerful than the other distances if the signal is in a random lineage or on random OTUs.

Power of abundance distances, presence–absence distances, Bonferroni-adjusted test
              and PERMANOVA-S unified test under various differentiation patterns. Each curve is
              created by varying the degree of differentiation between two groups, with 10 samples
              per group
Fig. 2.

Power of abundance distances, presence–absence distances, Bonferroni-adjusted test and PERMANOVA-S unified test under various differentiation patterns. Each curve is created by varying the degree of differentiation between two groups, with 10 samples per group

Under pattern B, where the change of evenness dominates the change of richness (middle panel of Fig. 2 ), the use of the abundance distances is substantially more powerful than the use of the presence–absence distances, no matter where the differentiation occurs. DW produces the most powerful test if the differentiation occurs in a lineage, and DBC produces the most powerful test if the differentiation occurs on random OTUs.

Under pattern C, where the richness and evenness change at a balanced rate (lower panel of Fig. 2 ), abundance distances and the corresponding presence–absence distances produce more similar power than in patterns A and B. If differentiation occurs on the common or random lineage, the top two distances are abundance distance DW and the corresponding presence–absence distance DPW(1) . If differentiation occurs on the rare lineage, the top two distances are DUW and DPW(0) , as in pattern A. If differentiation occurs on random OTUs, DJ yields the top power.

The simulation study shows that the power for different distances can vary a lot across association patterns, and the proper choice of distance is essential for conducting well-powered association studies. In practice, the nature of the association usually appears as a mixture of these studied patterns, which makes the choice of the best distance an impossible mission. The Bonferroni-adjusted test is inevitably less powerful than the unified test because it ignores the correlation of the tests using different distances. The power loss of the Bonferroni-adjusted test will become larger if more distances are considered. Our simulation demonstrates that ensembling the abundance distances and presence–absence distances using the PERMANOVA-S unified test yields good discovery power regardless of the underlying association pattern.

3.2 Cutaneous microbiome in psoriasis

Psoriasis is a common chronic inflammatory disease of the skin. Alekseyenko et al. (2013) investigated the community differentiation of the cutaneous microbiota in psoriasis. A total of 51 patients with psoriasis were studied by swabbing the lesion and a contralateral sample of normal tissue from each subject. The microbial OTUs were constructed through the QIIME pipeline.

After removing samples with read depth less than 1000 and discarding OTUs with only one read, we generated an OTU table of 50 complete pairs and 13 429 OTUs. We compared the microbial community composition between the lesion and normal samples from patients with psoriasis using PERMANOVA-S (one million within-subject permutations) and the six distances in the simulation studies. All of the distances give statistically significant results, which indicates that both the richness and evenness of the microbial community are different between the lesion and normal samples. However, the presence–absence distances ( DPW(1)P -value =  1.1×105 ; DPW(0)P -value =  1.4×105 ; DUWP -value =  1.6×105 ; DJP -value =  1.3×105 ) produce stronger evidence of differentiation than the abundance distances ( DWP -value =  1.2×103 ; DBCP -value =  4.7×104 ). The unified P -value is 3.1×105 , which is close to the P -values of the presence–absence distances. We performed the principle coordinate analysis using the distance matrices DW,DPW(1),DBC and DJ . We plotted the samples on the first two principle components ( Fig. 3 ). The distances DPW(1) and DJ separate the samples better than the distances DW and DBC .

Comparison of abundance distances and presence–absence distances for discriminating
              lesion (L) and normal (N) samples. Principle component analysis is performed on the
              four distance matrices. The samples are plotted on the first two principle components.
              The ellipse center indicates groups means, and the height and width represent the
              variances on the two directions
Fig. 3.

Comparison of abundance distances and presence–absence distances for discriminating lesion (L) and normal (N) samples. Principle component analysis is performed on the four distance matrices. The samples are plotted on the first two principle components. The ellipse center indicates groups means, and the height and width represent the variances on the two directions

To identify the differential OTUs, we performed the Wilcoxon signed-rank test for paired samples based on the abundance data, and we performed the McNemar’s test based on the presence–absence data. We identified 10 OTUs from either of the tests at a significance level of 0.001 ( Supplementary Table S1 ). The three related phyla were associated with psoriasis status and were employed to characterize and classify skin microbiota ( Alekseyenko et al. , 2013 ). It is interesting to see that most of these OTUs have a significant P -value in only one test. If the association is mainly driven by the differential abundance, the Wilcoxon test yields more significant results than the McNemar’s test; if the association is mainly driven by the differential proportion of the presence, then the McNemar’s test produces more significant results ( Supplementary Fig. S2 ).

This example demonstrates that the abundance data and the presence–absence data represent different views of the microbial community and the PERMANOVA-S unified test is a very powerful tool to identify the overall associations by combining the abundance and presence–absence distances.

3.3 Microbiome in subtherapeutic antibiotics and adiposity

Another study mimicked the common farm practice of administering low-dose antibiotics to promote animal growth. The laboratory model investigated an increase in adiposity after administration of low-dose antibiotic therapy to young mice and evaluated changes in body fat and composition of the gut microbiome ( Cho et al. , 2012 ). Female mice were given four types of antibiotics or no antibiotics (control), with 10 samples in each group. The mass and percentage of body fat were measured. The microbes in the cecal contents of these animals were analyzed, and the OTUs were constructed through the QIIME pipeline. The study found that administration of low-dose antibiotic therapy increased adiposity in young mice and substantially changed the microbiome composition.

We deleted samples with low read depth and removed OTUs with only one read. In the final dataset, we had 48 samples and 2877 OTUs. We tested whether there is an association between gut microbes and body fat. We performed the unified test across the six distances in the simulation studies. First, we did not adjust for any potential confounders. The unified P -values produced marginally significant association with P -values of 0.058 and 0.069 for mass and percentage body fat, respectively. Among the six distances, the Jaccard distance produced the most significant P -values (0.019 for mass body fat and 0.025 for percentage body fat). We then adjusted for antibiotic treatment and repeated the analysis. The unified P -values became 0.19 and 0.35, which are less significant than the P -values of the tests without confounder adjustment. All of the P -values are listed in the Supplementary Table S2 . Our analysis indicates that antibiotic treatment is a potential confounder when linking body fat to the gut microbiome composition. This example demonstrates the importance of confounder adjustment in the association analysis of microbiome composition.

4 Discussion

We derive the presence-weighted UniFrac based on the presence–absence data of the microbial species. Such distances are sensitive to variation of richness. We develop PERMANOVA-S as an improved version of PERMANOVA in order to facilitate the association study of microbiome composition. PERMANOVA-S is superior to PERMANOVA because it flexibly accommodates confounders and multiple distances. We investigated the type I error and power of PERMANOVA-S under different patterns of association by fluctuating the richness and evenness on various OTU sets. Our results show that PERMANOVA-S properly controls type I error, and the unified test is more robust than the single-distance test.

A method based on the maximum of the pseudo- F statistics (maxF) has been proposed to combine different distances ( Chen et al. , 2012 ). The validity of the maxF test relies on the assumption that the reference distributions of the pseudo- F statistics are the same under different distances. PERMANOVA-S uses the minimum P -values as the test statistic, which is a scale-free approach that is more robust to the various structures of the microbiome data and distances under consideration. We have conducted maxF test on the psoriasis dataset across the six distances and obtained a P -value of 1.2×103 , which is substantially less significant than the P -value of our unified test ( 3.1×105 ).

The permutation strategy of the unified test proposed in this paper is very general and can be applied to any unified tests minimizing P -values. For instance, Zhao et al. (2015) cast the problem in the kernel machine framework and developed a regression-based kernel test MiRKAT. Their framework allows for multiple distances. However, the P -value calculations of their unified test depend on the asymptotic approximation, which is not accurate when the sample size is modest. The Supplementary Table S3 demonstrates that MiRKAT tends to be overly conservative with small sample size. Our permutation strategy can be readily implemented to improve the small-sample performance of their test.

Failure to take into account the sampling variation can cause inflated beta diversity and produce false positive results. To overcome the potential adverse effects of unbalanced sampling, rarefaction is usually adopted to subsample reads to equal depth. However, if the signal is mainly driven by the change of evenness, throwing away large numbers of observations adversely affects the power. Fortunately, the abundance distances based on the unrarefied data stabilize very quickly with increasing depths ( Supplementary Tables S4 and S5 ). As the read depth is usually large (>1000) in most target sequencing studies, we suggest to use unrarefied data for the abundance distances and rarefied data for the presence–absence distances when testing the association of microbiome compositions. Of note, rarefaction does not always obscure association when the presence–absence distances are used (see power of the DPW(1) in Supplementary Tables S4 and S5 ). For instance, the P -value for DPW(1) becomes 2.5×104 if we use the unrarefied psoriasis data, which shows much weaker evidence of the association than the reported P -value using the rarefied data ( 1.1×105 ).

Many microbiome studies are being conducted with more complicated designs and heterogeneous samples. We expect that the use of PERMANOVA-S for the accommodation of confounders and multiple distances will enable more robust discoveries in microbiome research.

Funding

This work was supported by National Institutes of Health, Building Interdisciplinary Research Careers in Women’s Health award 5K12HD043483-14 and the National Institutes of Health award P30CA068485. This work was also supported in part by the Program for Human Microbiome Research at Medical University of South Carolina.

Conflict of Interest : none declared.

References

Alekseyenko
A.V.
 et al. . (
2013
)
Community differentiation of the cutaneous microbiota in psoriasis
.
Microbiome
,
1
,
31.

Anderson
M.J.
(
2001a
)
A new method for non-parametric multivariate analysis of variance
.
Aust. Ecol
.,
26
,
32
46
.

Anderson
M.J.
(
2001b
)
Permutation tests for univariate or multivariate analysis of variance and regression
.
Can. J. Fish. Aquat. Sci
,
58
,
626
639
.

Caporaso
J.G.
 et al. . (
2010
)
Qiime allows analysis of high-throughput community sequencing data
.
Nat. Methods
,
7
,
335
336
.

Charlson
E.S.
 et al. . (
2010
)
Disordered microbial communities in the upper respiratory tract of cigarette smokers
.
PLoS ONE
,
5
,
e15216.

Chen
J.
 et al. . (
2012
)
Associating microbiome composition with environmental covariates using generalized unifrac distances
.
Bioinformatics
,
28
,
2106
2113
.

Cho
I.
 et al. . (
2012
)
Antibiotics in early life alter the murine colonic microbiome and adiposity
.
Nature
,
488
,
621
626
.

Cox
M.J.
 et al. . (
2013
)
Sequencing the human microbiome in health and disease
.
Hum. Mol. Genet
.,
22
,
R88
R94
.

Davison
A.C.
 
Hinkley
D.V.
(
1997
)
Bootstrap Methods and Their Application
, vol.
1
.
Cambridge
:
Cambridge University Press
.

Dray
S.
 
Dufour
A.
(
2007
)
The ade4 package: implementing the duality diagram for ecologists
.
J. Stat. Softw
.,
22
,
1
20
.

Freedman
D.
 
Lane
D.
(
1983
)
A nonstochastic interpretation of reported significance levels
.
J. Bus. Econ. Stat
.,
1
,
292
298
.

Legendre
P.
 
Legendre
L.F.
(
2012
)
Numerical Ecology
, vol.
24
.
Amsterdam
:
Elsevier
.

Lin
D.Y.
 
Zeng
D.
(
2009
)
Proper analysis of secondary phenotype data in case–control association studies
.
Genet. Epidemiol
.,
33
,
256
265
.

Lin
D.Y.
 et al. . (
2013
)
Quantitative trait analysis in sequencing studies under trait-dependent sampling
.
Proc. Natl. Acad. Sci. U. S. A
.,
110
,
12247
12252
.

Lozupone
C.
 
Knight
R.
(
2005
)
Unifrac: a new phylogenetic method for comparing microbial communities
.
Appl. Environ. Microbiol
.,
71
,
8228
8235
.

Lozupone
C.A.
 et al. . (
2007
)
Quantitative and qualitative β diversity measures lead to different insights into factors that structure microbial communities
.
Appl. Environ. Microbiol
.,
73
,
1576
1585
.

McArdle
B.H.
 
Anderson
M.J.
(
2001
)
Fitting multivariate models to community data: a comment on distance-based redundancy analysis
.
Ecology
,
82
,
290
297
.

McMurdie
P.J.
 
Holmes
S.
(
2013
)
phyloseq: an R package for reproducible interactive analysis and graphics of microbiome census data
.
PLoS ONE
,
8
,
e61217.

Oksanen
J.
 et al. . (
2015
). vegan: Community Ecology Package. R package version 2.2-1.

Pesarin
F.
 
Salmaso
L.
(
2010
)
Permutation Tests for Complex Data: Theory, Applications and Software
.
Hoboken
:
Wiley
.

Redel
H.
 et al. . (
2013
)
Quantitation and composition of cutaneous microbiota in diabetic and nondiabetic men
.
J. Infect. Dis
.,
207
,
1105
1114
.

Relman
D.A.
(
2012
)
The human microbiome: ecosystem resilience and health
.
Nutr. Rev
.,
70
,
S2
S9
.

Schloss
P.D.
 et al. . (
2009
)
Introducing mothur: open-source, platform-independent, community-supported software for describing and comparing microbial communities
.
Appl. Environ. Microbiol
.,
75
,
7537
7541
.

Segal
L.N.
 et al. . (
2013
)
Enrichment of lung microbiome with supraglottic taxa is associated with increased pulmonary inflammation
.
Microbiome
,
1
,
19
.

Shade
A.
 et al. . (
2012
)
Fundamentals of microbial community resistance and resilience
.
Front. Microbiol
.,
3
,
417
.

Zhao
N.
 et al. . (
2015
)
Testing in Microbiome Profiling Studies with the Microbiome Regression-based Kernel Association Test (MiRKAT)
.
Am. J. Hum. Genet
.,
96
,
797
807
.

Author notes

The authors wish it to be known that, in their opinion, the first two authors should be regarded as joint First Authors.

Associate Editor: Inanc Birol

This is an Open Access article distributed under the terms of the Creative Commons Attribution License ( http://creativecommons.org/licenses/by/4.0/ ), which permits unrestricted reuse, distribution, and reproduction in any medium, provided the original work is properly cited.

Supplementary data