Beta diversity (phylogenetic)
Computes a user-specified phylogenetic beta diversity metric for all pairs
of samples in a feature table.
Parameters
- table : FeatureTable[Frequency]
- The feature table containing the samples over which beta diversity
should be computed.
- phylogeny : Phylogeny[Rooted]
- Phylogenetic tree containing tip identifiers that correspond to the
feature identifiers in the table. This tree can contain tip ids that
are not present in the table, but all feature ids in the table must be
present in this tree.
- metric : Str % Choices('weighted_unifrac', 'generalized_unifrac', 'weighted_normalized_unifrac', 'unweighted_unifrac')
- The beta diversity metric to be computed.
- variance_adjusted : Bool, optional
- Perform variance adjustment based on Chang et al. BMC Bioinformatics
2011. Weights distances based on the proportion of the relative
abundance represented between the samples at a given node under
evaluation.
- alpha : Float % Range(0, 1, inclusive_end=True), optional
- This parameter is only used when the choice of metric is
generalized_unifrac. The value of alpha controls importance of sample
proportions. 1.0 is weighted normalized UniFrac. 0.0 is close to
unweighted UniFrac, but only if the sample proportions are
dichotomized.
- bypass_tips : Bool, optional
- In a bifurcating tree, the tips make up about 50% of the nodes in a
tree. By ignoring them, specificity can be traded for reduced compute
time. This has the effect of collapsing the phylogeny, and is analogous
(in concept) to moving from 99% to 97% OTUs
Returns
- distance_matrix : DistanceMatrix % Properties('phylogenetic')
- The resulting distance matrix.