From b3f0438b13f7c475ade04702e4f16615241407fe Mon Sep 17 00:00:00 2001 From: qiyunzhu <4396343+qiyunzhu@users.noreply.github.com> Date: Fri, 10 Jan 2025 17:14:18 +0000 Subject: [PATCH] Update from https://github.com/scikit-bio/scikit-bio/commit/34d7bbf2fd3e467429b4cee55b95f02521cb5bcb --- docs/dev/_static/pygments.css | 242 +++++++++--------- docs/dev/alignment.html | 20 +- docs/dev/diversity.html | 20 +- docs/dev/embedding.html | 4 +- .../skbio.alignment.AlignPath.from_bits.html | 8 +- ....alignment.AlignPath.from_coordinates.html | 8 +- ...kbio.alignment.AlignPath.from_indices.html | 8 +- ...kbio.alignment.AlignPath.from_tabular.html | 4 +- .../generated/skbio.alignment.AlignPath.html | 8 +- .../skbio.alignment.AlignPath.to_bits.html | 8 +- ...io.alignment.AlignPath.to_coordinates.html | 6 +- .../skbio.alignment.AlignPath.to_indices.html | 6 +- .../skbio.alignment.AlignmentStructure.html | 4 +- ...ment.AlignmentStructure.is_zero_based.html | 4 +- ...ent.AlignmentStructure.set_zero_based.html | 4 +- ...bio.alignment.PairAlignPath.from_bits.html | 4 +- ...io.alignment.PairAlignPath.from_cigar.html | 6 +- .../skbio.alignment.PairAlignPath.html | 4 +- ...skbio.alignment.PairAlignPath.to_bits.html | 4 +- ...kbio.alignment.PairAlignPath.to_cigar.html | 6 +- .../skbio.alignment.StripedSmithWaterman.html | 4 +- .../skbio.alignment.TabularMSA.append.html | 6 +- .../skbio.alignment.TabularMSA.consensus.html | 6 +- ...bio.alignment.TabularMSA.conservation.html | 4 +- .../skbio.alignment.TabularMSA.extend.html | 6 +- .../skbio.alignment.TabularMSA.from_dict.html | 6 +- ...o.alignment.TabularMSA.from_path_seqs.html | 4 +- ....alignment.TabularMSA.gap_frequencies.html | 6 +- .../generated/skbio.alignment.TabularMSA.html | 36 +-- ...o.alignment.TabularMSA.iter_positions.html | 6 +- .../skbio.alignment.TabularMSA.join.html | 6 +- .../skbio.alignment.TabularMSA.read.html | 4 +- ...o.alignment.TabularMSA.reassign_index.html | 6 +- .../skbio.alignment.TabularMSA.sort.html | 6 +- .../skbio.alignment.TabularMSA.to_dict.html | 6 +- .../skbio.alignment.TabularMSA.write.html | 4 +- ...skbio.alignment.global_pairwise_align.html | 4 +- ...ment.global_pairwise_align_nucleotide.html | 4 +- ...ignment.global_pairwise_align_protein.html | 4 +- .../skbio.alignment.local_pairwise_align.html | 4 +- ...nment.local_pairwise_align_nucleotide.html | 4 +- ...lignment.local_pairwise_align_protein.html | 4 +- ...io.alignment.local_pairwise_align_ssw.html | 4 +- ...ent.make_identity_substitution_matrix.html | 4 +- .../generated/skbio.diversity.alpha.ace.html | 4 +- ...skbio.diversity.alpha.berger_parker_d.html | 4 +- .../skbio.diversity.alpha.brillouin_d.html | 4 +- .../skbio.diversity.alpha.chao1.html | 4 +- .../skbio.diversity.alpha.chao1_ci.html | 4 +- .../skbio.diversity.alpha.dominance.html | 4 +- .../skbio.diversity.alpha.doubles.html | 4 +- .../skbio.diversity.alpha.enspie.html | 4 +- .../skbio.diversity.alpha.esty_ci.html | 4 +- .../skbio.diversity.alpha.faith_pd.html | 8 +- .../skbio.diversity.alpha.fisher_alpha.html | 4 +- .../skbio.diversity.alpha.gini_index.html | 4 +- .../skbio.diversity.alpha.goods_coverage.html | 4 +- .../skbio.diversity.alpha.heip_e.html | 4 +- .../generated/skbio.diversity.alpha.hill.html | 4 +- docs/dev/generated/skbio.diversity.alpha.html | 4 +- .../skbio.diversity.alpha.inv_simpson.html | 4 +- ...kbio.diversity.alpha.kempton_taylor_q.html | 4 +- .../skbio.diversity.alpha.lladser_ci.html | 4 +- .../skbio.diversity.alpha.lladser_pe.html | 4 +- .../skbio.diversity.alpha.margalef.html | 4 +- .../skbio.diversity.alpha.mcintosh_d.html | 4 +- .../skbio.diversity.alpha.mcintosh_e.html | 4 +- .../skbio.diversity.alpha.menhinick.html | 4 +- ....diversity.alpha.michaelis_menten_fit.html | 4 +- ...bio.diversity.alpha.observed_features.html | 4 +- .../generated/skbio.diversity.alpha.osd.html | 4 +- .../skbio.diversity.alpha.phydiv.html | 4 +- .../skbio.diversity.alpha.pielou_e.html | 4 +- .../skbio.diversity.alpha.renyi.html | 4 +- .../skbio.diversity.alpha.robbins.html | 4 +- .../skbio.diversity.alpha.shannon.html | 4 +- .../skbio.diversity.alpha.simpson.html | 4 +- .../skbio.diversity.alpha.simpson_d.html | 4 +- .../skbio.diversity.alpha.simpson_e.html | 4 +- .../skbio.diversity.alpha.singles.html | 4 +- .../generated/skbio.diversity.alpha.sobs.html | 4 +- .../skbio.diversity.alpha.strong.html | 4 +- .../skbio.diversity.alpha.tsallis.html | 4 +- .../skbio.diversity.alpha_diversity.html | 4 +- docs/dev/generated/skbio.diversity.beta.html | 4 +- ...bio.diversity.beta.unweighted_unifrac.html | 10 +- ...skbio.diversity.beta.weighted_unifrac.html | 10 +- .../skbio.diversity.beta_diversity.html | 6 +- .../skbio.diversity.block_beta_diversity.html | 4 +- ...diversity.get_alpha_diversity_metrics.html | 4 +- ....diversity.get_beta_diversity_metrics.html | 6 +- ...kbio.diversity.partial_beta_diversity.html | 4 +- .../skbio.embedding.Embedding.bytes.html | 4 +- .../generated/skbio.embedding.Embedding.html | 4 +- .../skbio.embedding.Embedding.read.html | 4 +- .../skbio.embedding.Embedding.write.html | 4 +- .../skbio.embedding.EmbeddingVector.html | 4 +- .../skbio.embedding.ProteinEmbedding.html | 8 +- .../skbio.embedding.ProteinVector.html | 8 +- .../skbio.embedding.SequenceEmbedding.html | 4 +- .../skbio.embedding.SequenceVector.html | 4 +- ...kbio.embedding.embed_vec_to_dataframe.html | 4 +- ...kbio.embedding.embed_vec_to_distances.html | 4 +- .../skbio.embedding.embed_vec_to_numpy.html | 4 +- ...bio.embedding.embed_vec_to_ordination.html | 4 +- .../generated/skbio.io.format.binary_dm.html | 4 +- docs/dev/generated/skbio.io.format.biom.html | 6 +- .../dev/generated/skbio.io.format.blast6.html | 16 +- .../dev/generated/skbio.io.format.blast7.html | 16 +- .../generated/skbio.io.format.clustal.html | 10 +- docs/dev/generated/skbio.io.format.embed.html | 6 +- docs/dev/generated/skbio.io.format.embl.html | 10 +- docs/dev/generated/skbio.io.format.fasta.html | 18 +- docs/dev/generated/skbio.io.format.fastq.html | 8 +- .../generated/skbio.io.format.genbank.html | 8 +- docs/dev/generated/skbio.io.format.gff3.html | 12 +- docs/dev/generated/skbio.io.format.lsmat.html | 4 +- .../dev/generated/skbio.io.format.newick.html | 10 +- .../generated/skbio.io.format.ordination.html | 8 +- .../dev/generated/skbio.io.format.phylip.html | 8 +- docs/dev/generated/skbio.io.format.qseq.html | 8 +- .../skbio.io.format.sample_metadata.html | 4 +- .../generated/skbio.io.format.stockholm.html | 10 +- .../generated/skbio.io.format.taxdump.html | 10 +- .../generated/skbio.io.registry.Format.html | 4 +- .../skbio.io.registry.Format.reader.html | 14 +- .../skbio.io.registry.Format.sniffer.html | 8 +- .../skbio.io.registry.Format.writer.html | 14 +- ...bio.io.registry.IORegistry.add_format.html | 4 +- ....io.registry.IORegistry.create_format.html | 4 +- ...bio.io.registry.IORegistry.get_reader.html | 4 +- ...io.io.registry.IORegistry.get_sniffer.html | 4 +- ...bio.io.registry.IORegistry.get_writer.html | 4 +- .../skbio.io.registry.IORegistry.html | 4 +- ...registry.IORegistry.list_read_formats.html | 4 +- ...egistry.IORegistry.list_write_formats.html | 4 +- .../skbio.io.registry.IORegistry.read.html | 4 +- ....io.registry.IORegistry.remove_format.html | 4 +- .../skbio.io.registry.IORegistry.sniff.html | 4 +- .../skbio.io.registry.IORegistry.write.html | 4 +- .../skbio.io.registry.create_format.html | 4 +- docs/dev/generated/skbio.io.registry.html | 12 +- .../dev/generated/skbio.io.registry.read.html | 4 +- .../generated/skbio.io.registry.sniff.html | 4 +- .../generated/skbio.io.registry.write.html | 4 +- docs/dev/generated/skbio.io.util.html | 4 +- docs/dev/generated/skbio.io.util.open.html | 4 +- .../generated/skbio.io.util.open_file.html | 4 +- .../generated/skbio.io.util.open_files.html | 4 +- ...io.metadata.CategoricalMetadataColumn.html | 4 +- .../skbio.metadata.Interval.drop.html | 4 +- .../generated/skbio.metadata.Interval.html | 6 +- .../skbio.metadata.IntervalMetadata.add.html | 4 +- ...kbio.metadata.IntervalMetadata.concat.html | 6 +- .../skbio.metadata.IntervalMetadata.drop.html | 4 +- .../skbio.metadata.IntervalMetadata.html | 6 +- ...skbio.metadata.IntervalMetadata.merge.html | 4 +- ...skbio.metadata.IntervalMetadata.query.html | 4 +- .../skbio.metadata.IntervalMetadata.read.html | 4 +- .../skbio.metadata.IntervalMetadata.sort.html | 4 +- ...skbio.metadata.IntervalMetadata.write.html | 4 +- ...alMetadataMixin.has_interval_metadata.html | 4 +- .../skbio.metadata.IntervalMetadataMixin.html | 4 +- ...ta.MetadataColumn.drop_missing_values.html | 4 +- ...io.metadata.MetadataColumn.filter_ids.html | 4 +- ...skbio.metadata.MetadataColumn.get_ids.html | 4 +- ...o.metadata.MetadataColumn.get_missing.html | 4 +- ...bio.metadata.MetadataColumn.get_value.html | 4 +- ...ata.MetadataColumn.has_missing_values.html | 4 +- .../skbio.metadata.MetadataColumn.html | 4 +- ....metadata.MetadataColumn.to_dataframe.html | 4 +- ...bio.metadata.MetadataColumn.to_series.html | 4 +- ...o.metadata.MetadataMixin.has_metadata.html | 6 +- .../skbio.metadata.MetadataMixin.html | 6 +- .../skbio.metadata.NumericMetadataColumn.html | 4 +- ...MetadataMixin.has_positional_metadata.html | 8 +- ...kbio.metadata.PositionalMetadataMixin.html | 6 +- ...etadata.SampleMetadata.filter_columns.html | 4 +- ...io.metadata.SampleMetadata.filter_ids.html | 4 +- ...io.metadata.SampleMetadata.get_column.html | 4 +- ...skbio.metadata.SampleMetadata.get_ids.html | 4 +- .../skbio.metadata.SampleMetadata.html | 4 +- .../skbio.metadata.SampleMetadata.load.html | 4 +- .../skbio.metadata.SampleMetadata.merge.html | 4 +- ....metadata.SampleMetadata.to_dataframe.html | 4 +- .../skbio.sequence.DNA.find_motifs.html | 6 +- docs/dev/generated/skbio.sequence.DNA.html | 6 +- .../generated/skbio.sequence.DNA.read.html | 4 +- .../skbio.sequence.DNA.transcribe.html | 6 +- .../skbio.sequence.DNA.translate.html | 6 +- ...bio.sequence.DNA.translate_six_frames.html | 6 +- .../generated/skbio.sequence.DNA.write.html | 4 +- .../skbio.sequence.GeneticCode.from_ncbi.html | 4 +- .../generated/skbio.sequence.GeneticCode.html | 8 +- .../skbio.sequence.GeneticCode.translate.html | 6 +- ...ence.GeneticCode.translate_six_frames.html | 6 +- ....sequence.GrammaredSequence.definites.html | 6 +- ...kbio.sequence.GrammaredSequence.degap.html | 6 +- ...equence.GrammaredSequence.degenerates.html | 6 +- ....GrammaredSequence.expand_degenerates.html | 6 +- ...equence.GrammaredSequence.find_motifs.html | 6 +- ...skbio.sequence.GrammaredSequence.gaps.html | 6 +- ...uence.GrammaredSequence.has_definites.html | 6 +- ...nce.GrammaredSequence.has_degenerates.html | 6 +- ...o.sequence.GrammaredSequence.has_gaps.html | 6 +- ....GrammaredSequence.has_nondegenerates.html | 6 +- .../skbio.sequence.GrammaredSequence.html | 18 +- ...ence.GrammaredSequence.nondegenerates.html | 6 +- ...quence.GrammaredSequence.to_definites.html | 4 +- ...o.sequence.GrammaredSequence.to_regex.html | 6 +- ...o.sequence.NucleotideMixin.complement.html | 6 +- ...o.sequence.NucleotideMixin.gc_content.html | 6 +- ...sequence.NucleotideMixin.gc_frequency.html | 6 +- .../skbio.sequence.NucleotideMixin.html | 4 +- ...NucleotideMixin.is_reverse_complement.html | 6 +- ...ce.NucleotideMixin.reverse_complement.html | 6 +- .../skbio.sequence.Protein.find_motifs.html | 6 +- .../skbio.sequence.Protein.has_stops.html | 6 +- .../dev/generated/skbio.sequence.Protein.html | 6 +- .../skbio.sequence.Protein.read.html | 4 +- .../skbio.sequence.Protein.stops.html | 6 +- .../skbio.sequence.Protein.write.html | 4 +- .../skbio.sequence.RNA.find_motifs.html | 6 +- docs/dev/generated/skbio.sequence.RNA.html | 6 +- .../generated/skbio.sequence.RNA.read.html | 4 +- ...skbio.sequence.RNA.reverse_transcribe.html | 6 +- .../skbio.sequence.RNA.translate.html | 6 +- ...bio.sequence.RNA.translate_six_frames.html | 6 +- .../generated/skbio.sequence.RNA.write.html | 4 +- .../skbio.sequence.Sequence.concat.html | 6 +- .../skbio.sequence.Sequence.count.html | 6 +- .../skbio.sequence.Sequence.distance.html | 8 +- ...bio.sequence.Sequence.find_with_regex.html | 6 +- .../skbio.sequence.Sequence.frequencies.html | 6 +- .../generated/skbio.sequence.Sequence.html | 30 +-- .../skbio.sequence.Sequence.index.html | 6 +- ...bio.sequence.Sequence.iter_contiguous.html | 8 +- .../skbio.sequence.Sequence.iter_kmers.html | 6 +- ...io.sequence.Sequence.kmer_frequencies.html | 6 +- .../skbio.sequence.Sequence.lowercase.html | 6 +- ...bio.sequence.Sequence.match_frequency.html | 6 +- .../skbio.sequence.Sequence.matches.html | 6 +- ....sequence.Sequence.mismatch_frequency.html | 6 +- .../skbio.sequence.Sequence.mismatches.html | 6 +- .../skbio.sequence.Sequence.read.html | 4 +- .../skbio.sequence.Sequence.replace.html | 6 +- .../skbio.sequence.Sequence.to_indices.html | 10 +- .../skbio.sequence.Sequence.write.html | 4 +- ...o.sequence.SubstitutionMatrix.by_name.html | 6 +- ...sequence.SubstitutionMatrix.from_dict.html | 6 +- ...sequence.SubstitutionMatrix.get_names.html | 4 +- .../skbio.sequence.SubstitutionMatrix.html | 6 +- ....sequence.SubstitutionMatrix.identity.html | 6 +- ...o.sequence.SubstitutionMatrix.to_dict.html | 4 +- .../skbio.sequence.distance.hamming.html | 10 +- .../generated/skbio.sequence.distance.html | 4 +- ...skbio.sequence.distance.kmer_distance.html | 6 +- .../skbio.stats.composition.alr.html | 8 +- .../skbio.stats.composition.alr_inv.html | 8 +- .../skbio.stats.composition.ancom.html | 16 +- .../skbio.stats.composition.centralize.html | 8 +- .../skbio.stats.composition.closure.html | 8 +- .../skbio.stats.composition.clr.html | 8 +- .../skbio.stats.composition.clr_inv.html | 8 +- ...skbio.stats.composition.dirmult_ttest.html | 10 +- .../generated/skbio.stats.composition.html | 4 +- .../skbio.stats.composition.ilr.html | 8 +- .../skbio.stats.composition.ilr_inv.html | 8 +- .../skbio.stats.composition.inner.html | 8 +- ...skbio.stats.composition.multi_replace.html | 8 +- .../skbio.stats.composition.pairwise_vlr.html | 8 +- .../skbio.stats.composition.perturb.html | 8 +- .../skbio.stats.composition.perturb_inv.html | 8 +- .../skbio.stats.composition.power.html | 8 +- .../skbio.stats.composition.sbp_basis.html | 6 +- .../skbio.stats.composition.tree_basis.html | 6 +- .../skbio.stats.composition.vlr.html | 8 +- ....distance.DissimilarityMatrix.between.html | 6 +- ...ats.distance.DissimilarityMatrix.copy.html | 4 +- ...s.distance.DissimilarityMatrix.filter.html | 4 +- ...nce.DissimilarityMatrix.from_iterable.html | 4 +- ...io.stats.distance.DissimilarityMatrix.html | 6 +- ...ts.distance.DissimilarityMatrix.index.html | 4 +- ...ats.distance.DissimilarityMatrix.plot.html | 6 +- ...ats.distance.DissimilarityMatrix.read.html | 4 +- ...ce.DissimilarityMatrix.redundant_form.html | 4 +- ...s.distance.DissimilarityMatrix.rename.html | 6 +- ...nce.DissimilarityMatrix.to_data_frame.html | 6 +- ...istance.DissimilarityMatrix.transpose.html | 4 +- ...s.distance.DissimilarityMatrix.within.html | 6 +- ...ts.distance.DissimilarityMatrix.write.html | 4 +- ...istance.DistanceMatrix.condensed_form.html | 4 +- ...distance.DistanceMatrix.from_iterable.html | 4 +- .../skbio.stats.distance.DistanceMatrix.html | 4 +- ...stats.distance.DistanceMatrix.permute.html | 4 +- ...ats.distance.DistanceMatrix.to_series.html | 8 +- .../skbio.stats.distance.anosim.html | 10 +- .../skbio.stats.distance.bioenv.html | 12 +- docs/dev/generated/skbio.stats.distance.html | 10 +- .../skbio.stats.distance.mantel.html | 12 +- .../skbio.stats.distance.permanova.html | 4 +- .../skbio.stats.distance.permdisp.html | 10 +- .../skbio.stats.distance.pwmantel.html | 8 +- .../skbio.stats.distance.randdm.html | 4 +- ...bio.stats.evolve.hommola_cospeciation.html | 8 +- docs/dev/generated/skbio.stats.evolve.html | 4 +- ...o.stats.gradient.AverageGradientANOVA.html | 4 +- .../skbio.stats.gradient.CategoryResults.html | 4 +- ...ats.gradient.CategoryResults.to_files.html | 4 +- ...gradient.FirstDifferenceGradientANOVA.html | 4 +- ...adient.GradientANOVA.get_trajectories.html | 4 +- .../skbio.stats.gradient.GradientANOVA.html | 4 +- ...o.stats.gradient.GradientANOVAResults.html | 4 +- ...radient.GradientANOVAResults.to_files.html | 4 +- .../skbio.stats.gradient.GroupResults.html | 4 +- ....stats.gradient.GroupResults.to_files.html | 4 +- ...tats.gradient.TrajectoryGradientANOVA.html | 4 +- ...radient.WindowDifferenceGradientANOVA.html | 4 +- docs/dev/generated/skbio.stats.gradient.html | 10 +- .../dev/generated/skbio.stats.isubsample.html | 6 +- ...io.stats.ordination.OrdinationResults.html | 4 +- ...ats.ordination.OrdinationResults.plot.html | 10 +- ...ats.ordination.OrdinationResults.read.html | 4 +- ...s.ordination.OrdinationResults.rename.html | 4 +- ...ts.ordination.OrdinationResults.write.html | 4 +- .../generated/skbio.stats.ordination.ca.html | 47 ++-- .../generated/skbio.stats.ordination.cca.html | 4 +- .../skbio.stats.ordination.corr.html | 4 +- .../skbio.stats.ordination.e_matrix.html | 4 +- .../skbio.stats.ordination.f_matrix.html | 4 +- .../dev/generated/skbio.stats.ordination.html | 10 +- .../skbio.stats.ordination.mean_and_std.html | 4 +- .../skbio.stats.ordination.pcoa.html | 4 +- .../skbio.stats.ordination.pcoa_biplot.html | 4 +- .../generated/skbio.stats.ordination.rda.html | 4 +- .../skbio.stats.ordination.scale.html | 4 +- .../skbio.stats.ordination.svd_rank.html | 4 +- .../skbio.stats.power.confidence_bound.html | 4 +- docs/dev/generated/skbio.stats.power.html | 12 +- .../skbio.stats.power.paired_subsamples.html | 10 +- ...io.stats.power.subsample_paired_power.html | 12 +- .../skbio.stats.power.subsample_power.html | 14 +- .../skbio.stats.subsample_counts.html | 8 +- .../skbio.table.Table.add_group_metadata.html | 4 +- .../skbio.table.Table.add_metadata.html | 4 +- .../generated/skbio.table.Table.align_to.html | 8 +- .../skbio.table.Table.align_to_dataframe.html | 10 +- .../skbio.table.Table.align_tree.html | 10 +- .../generated/skbio.table.Table.collapse.html | 8 +- .../generated/skbio.table.Table.concat.html | 8 +- .../dev/generated/skbio.table.Table.copy.html | 4 +- .../dev/generated/skbio.table.Table.data.html | 6 +- .../skbio.table.Table.del_metadata.html | 8 +- .../skbio.table.Table.delimited_self.html | 4 +- ...kbio.table.Table.descriptive_equality.html | 4 +- .../generated/skbio.table.Table.exists.html | 8 +- .../generated/skbio.table.Table.filter.html | 8 +- .../skbio.table.Table.from_adjacency.html | 8 +- .../skbio.table.Table.from_hdf5.html | 8 +- .../skbio.table.Table.from_json.html | 6 +- .../generated/skbio.table.Table.from_tsv.html | 8 +- .../skbio.table.Table.get_table_density.html | 4 +- .../skbio.table.Table.get_value_by_ids.html | 8 +- .../skbio.table.Table.group_metadata.html | 8 +- .../dev/generated/skbio.table.Table.head.html | 8 +- docs/dev/generated/skbio.table.Table.html | 4 +- docs/dev/generated/skbio.table.Table.ids.html | 8 +- .../generated/skbio.table.Table.index.html | 8 +- .../generated/skbio.table.Table.is_empty.html | 4 +- .../dev/generated/skbio.table.Table.iter.html | 8 +- .../skbio.table.Table.iter_data.html | 8 +- .../skbio.table.Table.iter_pairwise.html | 6 +- .../generated/skbio.table.Table.length.html | 6 +- docs/dev/generated/skbio.table.Table.max.html | 6 +- .../generated/skbio.table.Table.merge.html | 8 +- .../generated/skbio.table.Table.metadata.html | 8 +- ...bio.table.Table.metadata_to_dataframe.html | 6 +- docs/dev/generated/skbio.table.Table.min.html | 6 +- .../generated/skbio.table.Table.nonzero.html | 4 +- .../skbio.table.Table.nonzero_counts.html | 4 +- .../dev/generated/skbio.table.Table.norm.html | 8 +- docs/dev/generated/skbio.table.Table.pa.html | 8 +- .../skbio.table.Table.partition.html | 10 +- .../generated/skbio.table.Table.rankdata.html | 10 +- .../dev/generated/skbio.table.Table.read.html | 4 +- .../generated/skbio.table.Table.reduce.html | 8 +- .../skbio.table.Table.remove_empty.html | 4 +- .../dev/generated/skbio.table.Table.sort.html | 8 +- .../skbio.table.Table.sort_order.html | 8 +- .../skbio.table.Table.subsample.html | 8 +- docs/dev/generated/skbio.table.Table.sum.html | 8 +- .../skbio.table.Table.to_anndata.html | 6 +- .../skbio.table.Table.to_dataframe.html | 6 +- .../generated/skbio.table.Table.to_hdf5.html | 10 +- .../generated/skbio.table.Table.to_json.html | 4 +- .../generated/skbio.table.Table.to_tsv.html | 8 +- .../skbio.table.Table.transform.html | 8 +- .../skbio.table.Table.transpose.html | 4 +- .../skbio.table.Table.update_ids.html | 4 +- .../generated/skbio.table.Table.write.html | 4 +- .../generated/skbio.table.example_table.html | 4 +- .../skbio.tree.TreeNode.ancestors.html | 6 +- .../generated/skbio.tree.TreeNode.append.html | 6 +- .../skbio.tree.TreeNode.ascii_art.html | 6 +- .../skbio.tree.TreeNode.assign_ids.html | 4 +- .../skbio.tree.TreeNode.assign_supports.html | 6 +- .../skbio.tree.TreeNode.bifurcate.html | 6 +- .../generated/skbio.tree.TreeNode.bipart.html | 6 +- .../skbio.tree.TreeNode.biparts.html | 6 +- .../skbio.tree.TreeNode.cache_attr.html | 8 +- .../skbio.tree.TreeNode.clear_caches.html | 4 +- .../skbio.tree.TreeNode.compare_biparts.html | 6 +- .../skbio.tree.TreeNode.compare_cophenet.html | 8 +- .../skbio.tree.TreeNode.compare_rfd.html | 6 +- .../skbio.tree.TreeNode.compare_subsets.html | 6 +- .../skbio.tree.TreeNode.compare_wrfd.html | 8 +- .../skbio.tree.TreeNode.cophenet.html | 10 +- .../generated/skbio.tree.TreeNode.copy.html | 6 +- .../generated/skbio.tree.TreeNode.count.html | 6 +- .../skbio.tree.TreeNode.create_caches.html | 4 +- .../skbio.tree.TreeNode.deepcopy.html | 4 +- .../generated/skbio.tree.TreeNode.depth.html | 6 +- .../skbio.tree.TreeNode.distance.html | 6 +- .../generated/skbio.tree.TreeNode.extend.html | 6 +- .../generated/skbio.tree.TreeNode.find.html | 6 +- .../skbio.tree.TreeNode.find_all.html | 6 +- .../skbio.tree.TreeNode.find_by_func.html | 6 +- .../skbio.tree.TreeNode.find_by_id.html | 6 +- ...bio.tree.TreeNode.from_linkage_matrix.html | 6 +- .../skbio.tree.TreeNode.from_taxdump.html | 8 +- .../skbio.tree.TreeNode.from_taxonomy.html | 6 +- .../skbio.tree.TreeNode.has_caches.html | 4 +- .../skbio.tree.TreeNode.has_children.html | 6 +- .../generated/skbio.tree.TreeNode.height.html | 6 +- docs/dev/generated/skbio.tree.TreeNode.html | 4 +- .../skbio.tree.TreeNode.index_tree.html | 4 +- .../generated/skbio.tree.TreeNode.insert.html | 6 +- .../skbio.tree.TreeNode.is_bifurcating.html | 6 +- .../skbio.tree.TreeNode.is_root.html | 6 +- .../generated/skbio.tree.TreeNode.is_tip.html | 6 +- .../generated/skbio.tree.TreeNode.lca.html | 6 +- .../skbio.tree.TreeNode.levelorder.html | 6 +- .../skbio.tree.TreeNode.maxdist.html | 8 +- .../skbio.tree.TreeNode.neighbors.html | 6 +- .../skbio.tree.TreeNode.non_tips.html | 6 +- ...io.tree.TreeNode.observed_node_counts.html | 4 +- .../generated/skbio.tree.TreeNode.path.html | 6 +- .../generated/skbio.tree.TreeNode.pop.html | 6 +- .../skbio.tree.TreeNode.postorder.html | 6 +- ...skbio.tree.TreeNode.pre_and_postorder.html | 6 +- .../skbio.tree.TreeNode.preorder.html | 6 +- .../generated/skbio.tree.TreeNode.prune.html | 6 +- .../generated/skbio.tree.TreeNode.read.html | 4 +- .../generated/skbio.tree.TreeNode.remove.html | 6 +- .../skbio.tree.TreeNode.remove_by_func.html | 6 +- .../skbio.tree.TreeNode.remove_deleted.html | 6 +- .../generated/skbio.tree.TreeNode.root.html | 6 +- .../skbio.tree.TreeNode.root_at.html | 6 +- .../skbio.tree.TreeNode.root_at_midpoint.html | 6 +- .../skbio.tree.TreeNode.root_by_outgroup.html | 6 +- .../generated/skbio.tree.TreeNode.shear.html | 6 +- .../skbio.tree.TreeNode.shuffle.html | 6 +- .../skbio.tree.TreeNode.siblings.html | 6 +- .../generated/skbio.tree.TreeNode.subset.html | 6 +- .../skbio.tree.TreeNode.subsets.html | 6 +- .../skbio.tree.TreeNode.subtree.html | 4 +- .../generated/skbio.tree.TreeNode.tips.html | 6 +- .../skbio.tree.TreeNode.to_array.html | 6 +- .../skbio.tree.TreeNode.to_taxonomy.html | 6 +- .../skbio.tree.TreeNode.total_length.html | 6 +- .../skbio.tree.TreeNode.traverse.html | 6 +- .../generated/skbio.tree.TreeNode.unpack.html | 6 +- .../skbio.tree.TreeNode.unpack_by_func.html | 6 +- .../generated/skbio.tree.TreeNode.unroot.html | 6 +- .../skbio.tree.TreeNode.unrooted_copy.html | 6 +- ...skbio.tree.TreeNode.unrooted_deepcopy.html | 4 +- .../skbio.tree.TreeNode.unrooted_move.html | 6 +- .../generated/skbio.tree.TreeNode.write.html | 4 +- docs/dev/generated/skbio.tree.bme.html | 8 +- docs/dev/generated/skbio.tree.gme.html | 8 +- .../generated/skbio.tree.majority_rule.html | 6 +- docs/dev/generated/skbio.tree.nj.html | 8 +- docs/dev/generated/skbio.tree.nni.html | 10 +- docs/dev/generated/skbio.tree.path_dists.html | 8 +- docs/dev/generated/skbio.tree.rf_dists.html | 6 +- docs/dev/generated/skbio.tree.upgma.html | 6 +- docs/dev/generated/skbio.tree.wrf_dists.html | 8 +- .../generated/skbio.util.PlottableMixin.html | 4 +- docs/dev/generated/skbio.util.aliased.html | 4 +- ...o.util.assert_data_frame_almost_equal.html | 4 +- ....util.assert_ordination_results_equal.html | 4 +- .../skbio.util.cardinal_to_ordinal.html | 6 +- .../generated/skbio.util.classonlymethod.html | 4 +- .../generated/skbio.util.classproperty.html | 4 +- docs/dev/generated/skbio.util.deprecated.html | 4 +- .../generated/skbio.util.find_duplicates.html | 4 +- .../generated/skbio.util.get_data_path.html | 4 +- docs/dev/generated/skbio.util.get_rng.html | 4 +- docs/dev/generated/skbio.util.overrides.html | 4 +- .../generated/skbio.util.params_aliased.html | 4 +- .../skbio.util.register_aliases.html | 6 +- docs/dev/generated/skbio.util.safe_md5.html | 8 +- .../generated/skbio.workflow.Workflow.html | 4 +- ...io.workflow.Workflow.initialize_state.html | 4 +- docs/dev/generated/skbio.workflow.method.html | 4 +- .../generated/skbio.workflow.requires.html | 4 +- docs/dev/genindex.html | 4 +- docs/dev/index.html | 4 +- docs/dev/io.html | 10 +- docs/dev/metadata.html | 4 +- docs/dev/py-modindex.html | 4 +- docs/dev/search.html | 4 +- docs/dev/searchindex.js | 2 +- docs/dev/sequence.html | 6 +- docs/dev/stats.html | 4 +- docs/dev/table.html | 4 +- docs/dev/tree.html | 8 +- docs/dev/util.html | 4 +- docs/dev/workflow.html | 30 +-- 519 files changed, 1690 insertions(+), 1693 deletions(-) diff --git a/docs/dev/_static/pygments.css b/docs/dev/_static/pygments.css index 012e6a00a..d7dd57783 100644 --- a/docs/dev/_static/pygments.css +++ b/docs/dev/_static/pygments.css @@ -6,11 +6,11 @@ html[data-theme="light"] .highlight span.linenos.special { color: #000000; backg html[data-theme="light"] .highlight .hll { background-color: #fae4c2 } html[data-theme="light"] .highlight { background: #fefefe; color: #080808 } html[data-theme="light"] .highlight .c { color: #515151 } /* Comment */ -html[data-theme="light"] .highlight .err { color: #a12236 } /* Error */ -html[data-theme="light"] .highlight .k { color: #6730c5 } /* Keyword */ -html[data-theme="light"] .highlight .l { color: #7f4707 } /* Literal */ +html[data-theme="light"] .highlight .err { color: #A12236 } /* Error */ +html[data-theme="light"] .highlight .k { color: #6730C5 } /* Keyword */ +html[data-theme="light"] .highlight .l { color: #7F4707 } /* Literal */ html[data-theme="light"] .highlight .n { color: #080808 } /* Name */ -html[data-theme="light"] .highlight .o { color: #00622f } /* Operator */ +html[data-theme="light"] .highlight .o { color: #00622F } /* Operator */ html[data-theme="light"] .highlight .p { color: #080808 } /* Punctuation */ html[data-theme="light"] .highlight .ch { color: #515151 } /* Comment.Hashbang */ html[data-theme="light"] .highlight .cm { color: #515151 } /* Comment.Multiline */ @@ -18,135 +18,135 @@ html[data-theme="light"] .highlight .cp { color: #515151 } /* Comment.Preproc */ html[data-theme="light"] .highlight .cpf { color: #515151 } /* Comment.PreprocFile */ html[data-theme="light"] .highlight .c1 { color: #515151 } /* Comment.Single */ html[data-theme="light"] .highlight .cs { color: #515151 } /* Comment.Special */ -html[data-theme="light"] .highlight .gd { color: #005b82 } /* Generic.Deleted */ +html[data-theme="light"] .highlight .gd { color: #005B82 } /* Generic.Deleted */ html[data-theme="light"] .highlight .ge { font-style: italic } /* Generic.Emph */ -html[data-theme="light"] .highlight .gh { color: #005b82 } /* Generic.Heading */ +html[data-theme="light"] .highlight .gh { color: #005B82 } /* Generic.Heading */ html[data-theme="light"] .highlight .gs { font-weight: bold } /* Generic.Strong */ -html[data-theme="light"] .highlight .gu { color: #005b82 } /* Generic.Subheading */ -html[data-theme="light"] .highlight .kc { color: #6730c5 } /* Keyword.Constant */ -html[data-theme="light"] .highlight .kd { color: #6730c5 } /* Keyword.Declaration */ -html[data-theme="light"] .highlight .kn { color: #6730c5 } /* Keyword.Namespace */ -html[data-theme="light"] .highlight .kp { color: #6730c5 } /* Keyword.Pseudo */ -html[data-theme="light"] .highlight .kr { color: #6730c5 } /* Keyword.Reserved */ -html[data-theme="light"] .highlight .kt { color: #7f4707 } /* Keyword.Type */ -html[data-theme="light"] .highlight .ld { color: #7f4707 } /* Literal.Date */ -html[data-theme="light"] .highlight .m { color: #7f4707 } /* Literal.Number */ -html[data-theme="light"] .highlight .s { color: #00622f } /* Literal.String */ +html[data-theme="light"] .highlight .gu { color: #005B82 } /* Generic.Subheading */ +html[data-theme="light"] .highlight .kc { color: #6730C5 } /* Keyword.Constant */ +html[data-theme="light"] .highlight .kd { color: #6730C5 } /* Keyword.Declaration */ +html[data-theme="light"] .highlight .kn { color: #6730C5 } /* Keyword.Namespace */ +html[data-theme="light"] .highlight .kp { color: #6730C5 } /* Keyword.Pseudo */ +html[data-theme="light"] .highlight .kr { color: #6730C5 } /* Keyword.Reserved */ +html[data-theme="light"] .highlight .kt { color: #7F4707 } /* Keyword.Type */ +html[data-theme="light"] .highlight .ld { color: #7F4707 } /* Literal.Date */ +html[data-theme="light"] .highlight .m { color: #7F4707 } /* Literal.Number */ +html[data-theme="light"] .highlight .s { color: #00622F } /* Literal.String */ html[data-theme="light"] .highlight .na { color: #912583 } /* Name.Attribute */ -html[data-theme="light"] .highlight .nb { color: #7f4707 } /* Name.Builtin */ -html[data-theme="light"] .highlight .nc { color: #005b82 } /* Name.Class */ -html[data-theme="light"] .highlight .no { color: #005b82 } /* Name.Constant */ -html[data-theme="light"] .highlight .nd { color: #7f4707 } /* Name.Decorator */ -html[data-theme="light"] .highlight .ni { color: #00622f } /* Name.Entity */ -html[data-theme="light"] .highlight .ne { color: #6730c5 } /* Name.Exception */ -html[data-theme="light"] .highlight .nf { color: #005b82 } /* Name.Function */ -html[data-theme="light"] .highlight .nl { color: #7f4707 } /* Name.Label */ +html[data-theme="light"] .highlight .nb { color: #7F4707 } /* Name.Builtin */ +html[data-theme="light"] .highlight .nc { color: #005B82 } /* Name.Class */ +html[data-theme="light"] .highlight .no { color: #005B82 } /* Name.Constant */ +html[data-theme="light"] .highlight .nd { color: #7F4707 } /* Name.Decorator */ +html[data-theme="light"] .highlight .ni { color: #00622F } /* Name.Entity */ +html[data-theme="light"] .highlight .ne { color: #6730C5 } /* Name.Exception */ +html[data-theme="light"] .highlight .nf { color: #005B82 } /* Name.Function */ +html[data-theme="light"] .highlight .nl { color: #7F4707 } /* Name.Label */ html[data-theme="light"] .highlight .nn { color: #080808 } /* Name.Namespace */ html[data-theme="light"] .highlight .nx { color: #080808 } /* Name.Other */ -html[data-theme="light"] .highlight .py { color: #005b82 } /* Name.Property */ -html[data-theme="light"] .highlight .nt { color: #005b82 } /* Name.Tag */ -html[data-theme="light"] .highlight .nv { color: #a12236 } /* Name.Variable */ -html[data-theme="light"] .highlight .ow { color: #6730c5 } /* Operator.Word */ +html[data-theme="light"] .highlight .py { color: #005B82 } /* Name.Property */ +html[data-theme="light"] .highlight .nt { color: #005B82 } /* Name.Tag */ +html[data-theme="light"] .highlight .nv { color: #A12236 } /* Name.Variable */ +html[data-theme="light"] .highlight .ow { color: #6730C5 } /* Operator.Word */ html[data-theme="light"] .highlight .pm { color: #080808 } /* Punctuation.Marker */ html[data-theme="light"] .highlight .w { color: #080808 } /* Text.Whitespace */ -html[data-theme="light"] .highlight .mb { color: #7f4707 } /* Literal.Number.Bin */ -html[data-theme="light"] .highlight .mf { color: #7f4707 } /* Literal.Number.Float */ -html[data-theme="light"] .highlight .mh { color: #7f4707 } /* Literal.Number.Hex */ -html[data-theme="light"] .highlight .mi { color: #7f4707 } /* Literal.Number.Integer */ -html[data-theme="light"] .highlight .mo { color: #7f4707 } /* Literal.Number.Oct */ -html[data-theme="light"] .highlight .sa { color: #00622f } /* Literal.String.Affix */ -html[data-theme="light"] .highlight .sb { color: #00622f } /* Literal.String.Backtick */ -html[data-theme="light"] .highlight .sc { color: #00622f } /* Literal.String.Char */ -html[data-theme="light"] .highlight .dl { color: #00622f } /* Literal.String.Delimiter */ -html[data-theme="light"] .highlight .sd { color: #00622f } /* Literal.String.Doc */ -html[data-theme="light"] .highlight .s2 { color: #00622f } /* Literal.String.Double */ -html[data-theme="light"] .highlight .se { color: #00622f } /* Literal.String.Escape */ -html[data-theme="light"] .highlight .sh { color: #00622f } /* Literal.String.Heredoc */ -html[data-theme="light"] .highlight .si { color: #00622f } /* Literal.String.Interpol */ -html[data-theme="light"] .highlight .sx { color: #00622f } /* Literal.String.Other */ -html[data-theme="light"] .highlight .sr { color: #a12236 } /* Literal.String.Regex */ -html[data-theme="light"] .highlight .s1 { color: #00622f } /* Literal.String.Single */ -html[data-theme="light"] .highlight .ss { color: #005b82 } /* Literal.String.Symbol */ -html[data-theme="light"] .highlight .bp { color: #7f4707 } /* Name.Builtin.Pseudo */ -html[data-theme="light"] .highlight .fm { color: #005b82 } /* Name.Function.Magic */ -html[data-theme="light"] .highlight .vc { color: #a12236 } /* Name.Variable.Class */ -html[data-theme="light"] .highlight .vg { color: #a12236 } /* Name.Variable.Global */ -html[data-theme="light"] .highlight .vi { color: #a12236 } /* Name.Variable.Instance */ -html[data-theme="light"] .highlight .vm { color: #7f4707 } /* Name.Variable.Magic */ -html[data-theme="light"] .highlight .il { color: #7f4707 } /* Literal.Number.Integer.Long */ +html[data-theme="light"] .highlight .mb { color: #7F4707 } /* Literal.Number.Bin */ +html[data-theme="light"] .highlight .mf { color: #7F4707 } /* Literal.Number.Float */ +html[data-theme="light"] .highlight .mh { color: #7F4707 } /* Literal.Number.Hex */ +html[data-theme="light"] .highlight .mi { color: #7F4707 } /* Literal.Number.Integer */ +html[data-theme="light"] .highlight .mo { color: #7F4707 } /* Literal.Number.Oct */ +html[data-theme="light"] .highlight .sa { color: #00622F } /* Literal.String.Affix */ +html[data-theme="light"] .highlight .sb { color: #00622F } /* Literal.String.Backtick */ +html[data-theme="light"] .highlight .sc { color: #00622F } /* Literal.String.Char */ +html[data-theme="light"] .highlight .dl { color: #00622F } /* Literal.String.Delimiter */ +html[data-theme="light"] .highlight .sd { color: #00622F } /* Literal.String.Doc */ +html[data-theme="light"] .highlight .s2 { color: #00622F } /* Literal.String.Double */ +html[data-theme="light"] .highlight .se { color: #00622F } /* Literal.String.Escape */ +html[data-theme="light"] .highlight .sh { color: #00622F } /* Literal.String.Heredoc */ +html[data-theme="light"] .highlight .si { color: #00622F } /* Literal.String.Interpol */ +html[data-theme="light"] .highlight .sx { color: #00622F } /* Literal.String.Other */ +html[data-theme="light"] .highlight .sr { color: #A12236 } /* Literal.String.Regex */ +html[data-theme="light"] .highlight .s1 { color: #00622F } /* Literal.String.Single */ +html[data-theme="light"] .highlight .ss { color: #005B82 } /* Literal.String.Symbol */ +html[data-theme="light"] .highlight .bp { color: #7F4707 } /* Name.Builtin.Pseudo */ +html[data-theme="light"] .highlight .fm { color: #005B82 } /* Name.Function.Magic */ +html[data-theme="light"] .highlight .vc { color: #A12236 } /* Name.Variable.Class */ +html[data-theme="light"] .highlight .vg { color: #A12236 } /* Name.Variable.Global */ +html[data-theme="light"] .highlight .vi { color: #A12236 } /* Name.Variable.Instance */ +html[data-theme="light"] .highlight .vm { color: #7F4707 } /* Name.Variable.Magic */ +html[data-theme="light"] .highlight .il { color: #7F4707 } /* Literal.Number.Integer.Long */ html[data-theme="dark"] .highlight pre { line-height: 125%; } html[data-theme="dark"] .highlight td.linenos .normal { color: inherit; background-color: transparent; padding-left: 5px; padding-right: 5px; } html[data-theme="dark"] .highlight span.linenos { color: inherit; background-color: transparent; padding-left: 5px; padding-right: 5px; } html[data-theme="dark"] .highlight td.linenos .special { color: #000000; background-color: #ffffc0; padding-left: 5px; padding-right: 5px; } html[data-theme="dark"] .highlight span.linenos.special { color: #000000; background-color: #ffffc0; padding-left: 5px; padding-right: 5px; } html[data-theme="dark"] .highlight .hll { background-color: #ffd9002e } -html[data-theme="dark"] .highlight { background: #2b2b2b; color: #f8f8f2 } -html[data-theme="dark"] .highlight .c { color: #ffd900 } /* Comment */ -html[data-theme="dark"] .highlight .err { color: #ffa07a } /* Error */ -html[data-theme="dark"] .highlight .k { color: #dcc6e0 } /* Keyword */ -html[data-theme="dark"] .highlight .l { color: #ffd900 } /* Literal */ -html[data-theme="dark"] .highlight .n { color: #f8f8f2 } /* Name */ -html[data-theme="dark"] .highlight .o { color: #abe338 } /* Operator */ -html[data-theme="dark"] .highlight .p { color: #f8f8f2 } /* Punctuation */ -html[data-theme="dark"] .highlight .ch { color: #ffd900 } /* Comment.Hashbang */ -html[data-theme="dark"] .highlight .cm { color: #ffd900 } /* Comment.Multiline */ -html[data-theme="dark"] .highlight .cp { color: #ffd900 } /* Comment.Preproc */ -html[data-theme="dark"] .highlight .cpf { color: #ffd900 } /* Comment.PreprocFile */ -html[data-theme="dark"] .highlight .c1 { color: #ffd900 } /* Comment.Single */ -html[data-theme="dark"] .highlight .cs { color: #ffd900 } /* Comment.Special */ -html[data-theme="dark"] .highlight .gd { color: #00e0e0 } /* Generic.Deleted */ +html[data-theme="dark"] .highlight { background: #2b2b2b; color: #F8F8F2 } +html[data-theme="dark"] .highlight .c { color: #FFD900 } /* Comment */ +html[data-theme="dark"] .highlight .err { color: #FFA07A } /* Error */ +html[data-theme="dark"] .highlight .k { color: #DCC6E0 } /* Keyword */ +html[data-theme="dark"] .highlight .l { color: #FFD900 } /* Literal */ +html[data-theme="dark"] .highlight .n { color: #F8F8F2 } /* Name */ +html[data-theme="dark"] .highlight .o { color: #ABE338 } /* Operator */ +html[data-theme="dark"] .highlight .p { color: #F8F8F2 } /* Punctuation */ +html[data-theme="dark"] .highlight .ch { color: #FFD900 } /* Comment.Hashbang */ +html[data-theme="dark"] .highlight .cm { color: #FFD900 } /* Comment.Multiline */ +html[data-theme="dark"] .highlight .cp { color: #FFD900 } /* Comment.Preproc */ +html[data-theme="dark"] .highlight .cpf { color: #FFD900 } /* Comment.PreprocFile */ +html[data-theme="dark"] .highlight .c1 { color: #FFD900 } /* Comment.Single */ +html[data-theme="dark"] .highlight .cs { color: #FFD900 } /* Comment.Special */ +html[data-theme="dark"] .highlight .gd { color: #00E0E0 } /* Generic.Deleted */ html[data-theme="dark"] .highlight .ge { font-style: italic } /* Generic.Emph */ -html[data-theme="dark"] .highlight .gh { color: #00e0e0 } /* Generic.Heading */ +html[data-theme="dark"] .highlight .gh { color: #00E0E0 } /* Generic.Heading */ html[data-theme="dark"] .highlight .gs { font-weight: bold } /* Generic.Strong */ -html[data-theme="dark"] .highlight .gu { color: #00e0e0 } /* Generic.Subheading */ -html[data-theme="dark"] .highlight .kc { color: #dcc6e0 } /* Keyword.Constant */ -html[data-theme="dark"] .highlight .kd { color: #dcc6e0 } /* Keyword.Declaration */ -html[data-theme="dark"] .highlight .kn { color: #dcc6e0 } /* Keyword.Namespace */ -html[data-theme="dark"] .highlight .kp { color: #dcc6e0 } /* Keyword.Pseudo */ -html[data-theme="dark"] .highlight .kr { color: #dcc6e0 } /* Keyword.Reserved */ -html[data-theme="dark"] .highlight .kt { color: #ffd900 } /* Keyword.Type */ -html[data-theme="dark"] .highlight .ld { color: #ffd900 } /* Literal.Date */ -html[data-theme="dark"] .highlight .m { color: #ffd900 } /* Literal.Number */ -html[data-theme="dark"] .highlight .s { color: #abe338 } /* Literal.String */ -html[data-theme="dark"] .highlight .na { color: #ffd900 } /* Name.Attribute */ -html[data-theme="dark"] .highlight .nb { color: #ffd900 } /* Name.Builtin */ -html[data-theme="dark"] .highlight .nc { color: #00e0e0 } /* Name.Class */ -html[data-theme="dark"] .highlight .no { color: #00e0e0 } /* Name.Constant */ -html[data-theme="dark"] .highlight .nd { color: #ffd900 } /* Name.Decorator */ -html[data-theme="dark"] .highlight .ni { color: #abe338 } /* Name.Entity */ -html[data-theme="dark"] .highlight .ne { color: #dcc6e0 } /* Name.Exception */ -html[data-theme="dark"] .highlight .nf { color: #00e0e0 } /* Name.Function */ -html[data-theme="dark"] .highlight .nl { color: #ffd900 } /* Name.Label */ -html[data-theme="dark"] .highlight .nn { color: #f8f8f2 } /* Name.Namespace */ -html[data-theme="dark"] .highlight .nx { color: #f8f8f2 } /* Name.Other */ -html[data-theme="dark"] .highlight .py { color: #00e0e0 } /* Name.Property */ -html[data-theme="dark"] .highlight .nt { color: #00e0e0 } /* Name.Tag */ -html[data-theme="dark"] .highlight .nv { color: #ffa07a } /* Name.Variable */ -html[data-theme="dark"] .highlight .ow { color: #dcc6e0 } /* Operator.Word */ -html[data-theme="dark"] .highlight .pm { color: #f8f8f2 } /* Punctuation.Marker */ -html[data-theme="dark"] .highlight .w { color: #f8f8f2 } /* Text.Whitespace */ -html[data-theme="dark"] .highlight .mb { color: #ffd900 } /* Literal.Number.Bin */ -html[data-theme="dark"] .highlight .mf { color: #ffd900 } /* Literal.Number.Float */ -html[data-theme="dark"] .highlight .mh { color: #ffd900 } /* Literal.Number.Hex */ -html[data-theme="dark"] .highlight .mi { color: #ffd900 } /* Literal.Number.Integer */ -html[data-theme="dark"] .highlight .mo { color: #ffd900 } /* Literal.Number.Oct */ -html[data-theme="dark"] .highlight .sa { color: #abe338 } /* Literal.String.Affix */ -html[data-theme="dark"] .highlight .sb { color: #abe338 } /* Literal.String.Backtick */ -html[data-theme="dark"] .highlight .sc { color: #abe338 } /* Literal.String.Char */ -html[data-theme="dark"] .highlight .dl { color: #abe338 } /* Literal.String.Delimiter */ -html[data-theme="dark"] .highlight .sd { color: #abe338 } /* Literal.String.Doc */ -html[data-theme="dark"] .highlight .s2 { color: #abe338 } /* Literal.String.Double */ -html[data-theme="dark"] .highlight .se { color: #abe338 } /* Literal.String.Escape */ -html[data-theme="dark"] .highlight .sh { color: #abe338 } /* Literal.String.Heredoc */ -html[data-theme="dark"] .highlight .si { color: #abe338 } /* Literal.String.Interpol */ -html[data-theme="dark"] .highlight .sx { color: #abe338 } /* Literal.String.Other */ -html[data-theme="dark"] .highlight .sr { color: #ffa07a } /* Literal.String.Regex */ -html[data-theme="dark"] .highlight .s1 { color: #abe338 } /* Literal.String.Single */ -html[data-theme="dark"] .highlight .ss { color: #00e0e0 } /* Literal.String.Symbol */ -html[data-theme="dark"] .highlight .bp { color: #ffd900 } /* Name.Builtin.Pseudo */ -html[data-theme="dark"] .highlight .fm { color: #00e0e0 } /* Name.Function.Magic */ -html[data-theme="dark"] .highlight .vc { color: #ffa07a } /* Name.Variable.Class */ -html[data-theme="dark"] .highlight .vg { color: #ffa07a } /* Name.Variable.Global */ -html[data-theme="dark"] .highlight .vi { color: #ffa07a } /* Name.Variable.Instance */ -html[data-theme="dark"] .highlight .vm { color: #ffd900 } /* Name.Variable.Magic */ -html[data-theme="dark"] .highlight .il { color: #ffd900 } /* Literal.Number.Integer.Long */ \ No newline at end of file +html[data-theme="dark"] .highlight .gu { color: #00E0E0 } /* Generic.Subheading */ +html[data-theme="dark"] .highlight .kc { color: #DCC6E0 } /* Keyword.Constant */ +html[data-theme="dark"] .highlight .kd { color: #DCC6E0 } /* Keyword.Declaration */ +html[data-theme="dark"] .highlight .kn { color: #DCC6E0 } /* Keyword.Namespace */ +html[data-theme="dark"] .highlight .kp { color: #DCC6E0 } /* Keyword.Pseudo */ +html[data-theme="dark"] .highlight .kr { color: #DCC6E0 } /* Keyword.Reserved */ +html[data-theme="dark"] .highlight .kt { color: #FFD900 } /* Keyword.Type */ +html[data-theme="dark"] .highlight .ld { color: #FFD900 } /* Literal.Date */ +html[data-theme="dark"] .highlight .m { color: #FFD900 } /* Literal.Number */ +html[data-theme="dark"] .highlight .s { color: #ABE338 } /* Literal.String */ +html[data-theme="dark"] .highlight .na { color: #FFD900 } /* Name.Attribute */ +html[data-theme="dark"] .highlight .nb { color: #FFD900 } /* Name.Builtin */ +html[data-theme="dark"] .highlight .nc { color: #00E0E0 } /* Name.Class */ +html[data-theme="dark"] .highlight .no { color: #00E0E0 } /* Name.Constant */ +html[data-theme="dark"] .highlight .nd { color: #FFD900 } /* Name.Decorator */ +html[data-theme="dark"] .highlight .ni { color: #ABE338 } /* Name.Entity */ +html[data-theme="dark"] .highlight .ne { color: #DCC6E0 } /* Name.Exception */ +html[data-theme="dark"] .highlight .nf { color: #00E0E0 } /* Name.Function */ +html[data-theme="dark"] .highlight .nl { color: #FFD900 } /* Name.Label */ +html[data-theme="dark"] .highlight .nn { color: #F8F8F2 } /* Name.Namespace */ +html[data-theme="dark"] .highlight .nx { color: #F8F8F2 } /* Name.Other */ +html[data-theme="dark"] .highlight .py { color: #00E0E0 } /* Name.Property */ +html[data-theme="dark"] .highlight .nt { color: #00E0E0 } /* Name.Tag */ +html[data-theme="dark"] .highlight .nv { color: #FFA07A } /* Name.Variable */ +html[data-theme="dark"] .highlight .ow { color: #DCC6E0 } /* Operator.Word */ +html[data-theme="dark"] .highlight .pm { color: #F8F8F2 } /* Punctuation.Marker */ +html[data-theme="dark"] .highlight .w { color: #F8F8F2 } /* Text.Whitespace */ +html[data-theme="dark"] .highlight .mb { color: #FFD900 } /* Literal.Number.Bin */ +html[data-theme="dark"] .highlight .mf { color: #FFD900 } /* Literal.Number.Float */ +html[data-theme="dark"] .highlight .mh { color: #FFD900 } /* Literal.Number.Hex */ +html[data-theme="dark"] .highlight .mi { color: #FFD900 } /* Literal.Number.Integer */ +html[data-theme="dark"] .highlight .mo { color: #FFD900 } /* Literal.Number.Oct */ +html[data-theme="dark"] .highlight .sa { color: #ABE338 } /* Literal.String.Affix */ +html[data-theme="dark"] .highlight .sb { color: #ABE338 } /* Literal.String.Backtick */ +html[data-theme="dark"] .highlight .sc { color: #ABE338 } /* Literal.String.Char */ +html[data-theme="dark"] .highlight .dl { color: #ABE338 } /* Literal.String.Delimiter */ +html[data-theme="dark"] .highlight .sd { color: #ABE338 } /* Literal.String.Doc */ +html[data-theme="dark"] .highlight .s2 { color: #ABE338 } /* Literal.String.Double */ +html[data-theme="dark"] .highlight .se { color: #ABE338 } /* Literal.String.Escape */ +html[data-theme="dark"] .highlight .sh { color: #ABE338 } /* Literal.String.Heredoc */ +html[data-theme="dark"] .highlight .si { color: #ABE338 } /* Literal.String.Interpol */ +html[data-theme="dark"] .highlight .sx { color: #ABE338 } /* Literal.String.Other */ +html[data-theme="dark"] .highlight .sr { color: #FFA07A } /* Literal.String.Regex */ +html[data-theme="dark"] .highlight .s1 { color: #ABE338 } /* Literal.String.Single */ +html[data-theme="dark"] .highlight .ss { color: #00E0E0 } /* Literal.String.Symbol */ +html[data-theme="dark"] .highlight .bp { color: #FFD900 } /* Name.Builtin.Pseudo */ +html[data-theme="dark"] .highlight .fm { color: #00E0E0 } /* Name.Function.Magic */ +html[data-theme="dark"] .highlight .vc { color: #FFA07A } /* Name.Variable.Class */ +html[data-theme="dark"] .highlight .vg { color: #FFA07A } /* Name.Variable.Global */ +html[data-theme="dark"] .highlight .vi { color: #FFA07A } /* Name.Variable.Instance */ +html[data-theme="dark"] .highlight .vm { color: #FFD900 } /* Name.Variable.Magic */ +html[data-theme="dark"] .highlight .il { color: #FFD900 } /* Literal.Number.Integer.Long */ \ No newline at end of file diff --git a/docs/dev/alignment.html b/docs/dev/alignment.html index 77f47c6e7..2ba1ba88d 100644 --- a/docs/dev/alignment.html +++ b/docs/dev/alignment.html @@ -31,7 +31,7 @@ - + @@ -754,7 +754,7 @@

Tutorial

Alignment data structure#

Load two DNA sequences that have been previously aligned into a TabularMSA object, using sequence IDs as the MSA’s index:

-
>>> from skbio import TabularMSA, DNA
+
>>> from skbio import TabularMSA, DNA
 >>> seqs = [DNA("ACC--G-GGTA..", metadata={'id': "seq1"}),
 ...         DNA("TCC--G-GGCA..", metadata={'id': "seq2"})]
 >>> msa = TabularMSA(seqs, minter='id')
@@ -775,7 +775,7 @@ 

Alignment data structure

Using the optimized alignment algorithm#

Using the convenient local_pairwise_align_ssw function:

-
>>> from skbio.alignment import local_pairwise_align_ssw
+
>>> from skbio.alignment import local_pairwise_align_ssw
 >>> alignment, score, start_end_positions = local_pairwise_align_ssw(
 ...     DNA("ACTAAGGCTCTCTACCCCTCTCAGAGA"),
 ...     DNA("ACTAAGGCTCCTAACCCCCTTTTCTCAGA")
@@ -796,7 +796,7 @@ 

Using the optimized alignment algorithmStripedSmithWaterman object:

-
>>> from skbio.alignment import StripedSmithWaterman
+
>>> from skbio.alignment import StripedSmithWaterman
 >>> query = StripedSmithWaterman("ACTAAGGCTCTCTACCCCTCTCAGAGA")
 >>> alignment = query("AAAAAACTCTCTAAACTCACTAAGGCTCTCTACCCCTCTTCAGAGAAGTCGA")
 >>> print(alignment)
@@ -808,7 +808,7 @@ 

Using the optimized alignment algorithmStripedSmithWaterman object for multiple targets in an efficient way and finding the aligned sequence representations:

-
>>> from skbio.alignment import StripedSmithWaterman
+
>>> from skbio.alignment import StripedSmithWaterman
 >>> alignments = []
 >>> target_sequences = [
 ...     "GCTAACTAGGCTCCCTTCTACCCCTCTCAGAGA",
@@ -848,8 +848,8 @@ 

Using the slow alignment algorithm
>>> from skbio import Protein
->>> from skbio.alignment import local_pairwise_align_protein
+
>>> from skbio import Protein
+>>> from skbio.alignment import local_pairwise_align_protein
 >>> s1 = Protein("HEAGAWGHEE")
 >>> s2 = Protein("PAWHEAE")
 >>> alignment, score, start_end_positions = local_pairwise_align_protein(
@@ -874,8 +874,8 @@ 

Using the slow alignment algorithm
>>> from skbio import DNA
->>> from skbio.alignment import global_pairwise_align_nucleotide
+

First, we’ll compute \(S_{obs}\), an alpha diversity metric, for each sample using the alpha_diversity driver function:

-
>>> from skbio.diversity import alpha_diversity
+
>>> from skbio.diversity import alpha_diversity
 >>> adiv_sobs = alpha_diversity('sobs', data, ids)
 >>> adiv_sobs 
 A    5
@@ -899,8 +899,8 @@ 

Tutorial

Next we’ll compute Faith’s PD on the same samples. Since this is a phylogenetic diversity metric, we’ll first create a tree and an ordered list of taxa.

-
>>> from skbio import TreeNode
->>> from io import StringIO
+
>>> from skbio import TreeNode
+>>> from io import StringIO
 >>> tree = TreeNode.read(StringIO(
 ...                      '(((((U1:0.5,U2:0.5):0.5,U3:1.0):1.0):0.0,'
 ...                      '(U4:0.75,(U5:0.5,(U6:0.5,U7:0.5):0.5):'
@@ -922,7 +922,7 @@ 

Tutorial all pairs of samples. Notice that the data and ids parameters provided to beta_diversity are the same as those provided to alpha_diversity.

-
>>> from skbio.diversity import beta_diversity
+
>>> from skbio.diversity import beta_diversity
 >>> bc_dm = beta_diversity("braycurtis", data, ids)
 >>> print(bc_dm)
 6x6 distance matrix
@@ -961,7 +961,7 @@ 

Tutorial significantly correlated by computing the Mantel correlation between them. Then we’ll determine if the p-value is significant based on an alpha of 0.05.

-
>>> from skbio.stats.distance import mantel
+

Next, we’ll perform principal coordinates analysis (PCoA) on our weighted UniFrac distance matrix.

-
>>> from skbio.stats.ordination import pcoa
+
>>> from skbio.stats.ordination import pcoa
 >>> wu_pc = pcoa(wu_dm)
 

PCoA plots are only really interesting in the context of sample metadata, so let’s define some before we visualize these results.

-
>>> import pandas as pd
+
>>> import pandas as pd
 >>> sample_md = pd.DataFrame([
 ...    ['gut', 's1'],
 ...    ['skin', 's1'],
@@ -1037,7 +1037,7 @@ 

Tutorial quantify the strength of the clustering we see in the ordination plots above, using our weighted UniFrac distance matrix and sample metadata.

First test the grouping of samples by subject:

-
>>> from skbio.stats.distance import anosim
+
>>> from skbio.stats.distance import anosim
 >>> results = anosim(wu_dm, sample_md, column='subject', permutations=999)
 >>> results['test statistic']
 -0.33333333333333331
@@ -1190,7 +1190,7 @@ 

Tutorial diff --git a/docs/dev/embedding.html b/docs/dev/embedding.html index 7fa13c3fc..41931ebd8 100644 --- a/docs/dev/embedding.html +++ b/docs/dev/embedding.html @@ -31,7 +31,7 @@ - + @@ -806,7 +806,7 @@

Embedding vector utilities - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.alignment.AlignPath.from_bits.html b/docs/dev/generated/skbio.alignment.AlignPath.from_bits.html index 9eb593a0f..fac8203f9 100644 --- a/docs/dev/generated/skbio.alignment.AlignPath.from_bits.html +++ b/docs/dev/generated/skbio.alignment.AlignPath.from_bits.html @@ -31,7 +31,7 @@ - + @@ -712,8 +712,8 @@

skbio.alignment.AlignPath.from_bitsExamples

-
>>> import numpy as np
->>> from skbio.alignment import AlignPath
+
>>> import numpy as np
+>>> from skbio.alignment import AlignPath
 >>> bit_arr = np.array([[0, 0, 0, 0, 0, 0, 0, 0],
 ...                     [0, 0, 1, 1, 0, 0, 1, 0],
 ...                     [0, 0, 0, 0, 0, 0, 1, 0]])
@@ -805,7 +805,7 @@ 

skbio.alignment.AlignPath.from_bits - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.alignment.AlignPath.from_coordinates.html b/docs/dev/generated/skbio.alignment.AlignPath.from_coordinates.html index 93de82a6f..c27943b6f 100644 --- a/docs/dev/generated/skbio.alignment.AlignPath.from_coordinates.html +++ b/docs/dev/generated/skbio.alignment.AlignPath.from_coordinates.html @@ -31,7 +31,7 @@ - + @@ -710,8 +710,8 @@

skbio.alignment.AlignPath.from_coordinatesExamples

-
>>> import numpy as np
->>> from skbio.alignment import AlignPath
+
>>> import numpy as np
+>>> from skbio.alignment import AlignPath
 >>> coordinates = np.array([[0, 1, 1, 3, 4],
 ...                         [0, 1, 3, 3, 3],
 ...                         [0, 1, 1, 3, 3]])
@@ -803,7 +803,7 @@ 

skbio.alignment.AlignPath.from_coordinates - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.alignment.AlignPath.from_indices.html b/docs/dev/generated/skbio.alignment.AlignPath.from_indices.html index 0a3b2d535..bb5de21b3 100644 --- a/docs/dev/generated/skbio.alignment.AlignPath.from_indices.html +++ b/docs/dev/generated/skbio.alignment.AlignPath.from_indices.html @@ -31,7 +31,7 @@ - + @@ -716,8 +716,8 @@

skbio.alignment.AlignPath.from_indicesExamples

-
>>> import numpy as np
->>> from skbio.alignment import AlignPath
+
>>> import numpy as np
+>>> from skbio.alignment import AlignPath
 >>> indices = np.array([[0, -1, -1,  1,  2,  3],
 ...                     [0,  1,  2, -1, -1, -1],
 ...                     [0, -1, -1,  1,  2, -1]])
@@ -809,7 +809,7 @@ 

skbio.alignment.AlignPath.from_indices - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.alignment.AlignPath.from_tabular.html b/docs/dev/generated/skbio.alignment.AlignPath.from_tabular.html index 372a019ad..07c10f4d1 100644 --- a/docs/dev/generated/skbio.alignment.AlignPath.from_tabular.html +++ b/docs/dev/generated/skbio.alignment.AlignPath.from_tabular.html @@ -31,7 +31,7 @@ - + @@ -797,7 +797,7 @@

skbio.alignment.AlignPath.from_tabular - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.alignment.AlignPath.html b/docs/dev/generated/skbio.alignment.AlignPath.html index 837f101fb..af2c8af9d 100644 --- a/docs/dev/generated/skbio.alignment.AlignPath.html +++ b/docs/dev/generated/skbio.alignment.AlignPath.html @@ -31,7 +31,7 @@ - + @@ -734,8 +734,8 @@

skbio.alignment.AlignPathExamples

Create an AlignPath object from a TabularMSA object with three DNA sequences and 20 positions.

-
>>> from skbio import DNA, TabularMSA
->>> from skbio.alignment import AlignPath
+
>>> from skbio import DNA, TabularMSA
+>>> from skbio.alignment import AlignPath
 >>> seqs = [
 ...    DNA('CGGTCGTAACGCGTA---CA'),
 ...    DNA('CAG--GTAAG-CATACCTCA'),
@@ -964,7 +964,7 @@ 

skbio.alignment.AlignPath - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.alignment.AlignPath.to_bits.html b/docs/dev/generated/skbio.alignment.AlignPath.to_bits.html index 97d7a4107..f31106349 100644 --- a/docs/dev/generated/skbio.alignment.AlignPath.to_bits.html +++ b/docs/dev/generated/skbio.alignment.AlignPath.to_bits.html @@ -31,7 +31,7 @@ - + @@ -703,8 +703,8 @@

skbio.alignment.AlignPath.to_bitsExamples

-
>>> from skbio import DNA, TabularMSA
->>> from skbio.alignment import AlignPath
+
>>> from skbio import DNA, TabularMSA
+>>> from skbio.alignment import AlignPath
 >>> seqs = [
 ...    DNA('CGTCGTGC'),
 ...    DNA('CA--GT-C'),
@@ -798,7 +798,7 @@ 

skbio.alignment.AlignPath.to_bits - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.alignment.AlignPath.to_coordinates.html b/docs/dev/generated/skbio.alignment.AlignPath.to_coordinates.html index 50e8b4c44..754b882f1 100644 --- a/docs/dev/generated/skbio.alignment.AlignPath.to_coordinates.html +++ b/docs/dev/generated/skbio.alignment.AlignPath.to_coordinates.html @@ -31,7 +31,7 @@ - + @@ -704,7 +704,7 @@

skbio.alignment.AlignPath.to_coordinatesExamples

-
>>> from skbio.alignment import AlignPath
+
>>> from skbio.alignment import AlignPath
 >>> path = AlignPath(lengths=[1, 2, 2, 1],
 ...                  states=[0, 5, 2, 6],
 ...                  starts=[0, 0, 0])
@@ -794,7 +794,7 @@ 

skbio.alignment.AlignPath.to_coordinates - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.alignment.AlignPath.to_indices.html b/docs/dev/generated/skbio.alignment.AlignPath.to_indices.html index 0e1a5722c..dfe892700 100644 --- a/docs/dev/generated/skbio.alignment.AlignPath.to_indices.html +++ b/docs/dev/generated/skbio.alignment.AlignPath.to_indices.html @@ -31,7 +31,7 @@ - + @@ -711,7 +711,7 @@

skbio.alignment.AlignPath.to_indicesExamples

-
>>> from skbio.alignment import AlignPath
+
>>> from skbio.alignment import AlignPath
 >>> path = AlignPath(lengths=[1, 2, 2, 1],
 ...                  states=[0, 5, 2, 6],
 ...                  starts=[0, 0, 0])
@@ -801,7 +801,7 @@ 

skbio.alignment.AlignPath.to_indices - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.alignment.AlignmentStructure.html b/docs/dev/generated/skbio.alignment.AlignmentStructure.html index c54a01f24..c6cb1f25b 100644 --- a/docs/dev/generated/skbio.alignment.AlignmentStructure.html +++ b/docs/dev/generated/skbio.alignment.AlignmentStructure.html @@ -31,7 +31,7 @@ - + @@ -1110,7 +1110,7 @@

skbio.alignment.AlignmentStructure - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.alignment.AlignmentStructure.is_zero_based.html b/docs/dev/generated/skbio.alignment.AlignmentStructure.is_zero_based.html index e99c88dde..077a6e822 100644 --- a/docs/dev/generated/skbio.alignment.AlignmentStructure.is_zero_based.html +++ b/docs/dev/generated/skbio.alignment.AlignmentStructure.is_zero_based.html @@ -31,7 +31,7 @@ - + @@ -777,7 +777,7 @@

skbio.alignment.AlignmentStructure.is_zero_based - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.alignment.AlignmentStructure.set_zero_based.html b/docs/dev/generated/skbio.alignment.AlignmentStructure.set_zero_based.html index 7bef85deb..0c8f864d5 100644 --- a/docs/dev/generated/skbio.alignment.AlignmentStructure.set_zero_based.html +++ b/docs/dev/generated/skbio.alignment.AlignmentStructure.set_zero_based.html @@ -31,7 +31,7 @@ - + @@ -769,7 +769,7 @@

skbio.alignment.AlignmentStructure.set_zero_based - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.alignment.PairAlignPath.from_bits.html b/docs/dev/generated/skbio.alignment.PairAlignPath.from_bits.html index eab1db30b..9e6bebb72 100644 --- a/docs/dev/generated/skbio.alignment.PairAlignPath.from_bits.html +++ b/docs/dev/generated/skbio.alignment.PairAlignPath.from_bits.html @@ -31,7 +31,7 @@ - + @@ -785,7 +785,7 @@

skbio.alignment.PairAlignPath.from_bits - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.alignment.PairAlignPath.from_cigar.html b/docs/dev/generated/skbio.alignment.PairAlignPath.from_cigar.html index 81f9d2d6b..910a1d26b 100644 --- a/docs/dev/generated/skbio.alignment.PairAlignPath.from_cigar.html +++ b/docs/dev/generated/skbio.alignment.PairAlignPath.from_cigar.html @@ -31,7 +31,7 @@ - + @@ -709,7 +709,7 @@

skbio.alignment.PairAlignPath.from_cigarExamples

-
>>> from skbio.alignment import PairAlignPath
+
>>> from skbio.alignment import PairAlignPath
 >>> cigar = "2M5P3D1I"
 >>> path = PairAlignPath.from_cigar(cigar)
 >>> path
@@ -796,7 +796,7 @@ 

skbio.alignment.PairAlignPath.from_cigar - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.alignment.PairAlignPath.html b/docs/dev/generated/skbio.alignment.PairAlignPath.html index d24a7e83b..e3b9746f4 100644 --- a/docs/dev/generated/skbio.alignment.PairAlignPath.html +++ b/docs/dev/generated/skbio.alignment.PairAlignPath.html @@ -31,7 +31,7 @@ - + @@ -894,7 +894,7 @@

skbio.alignment.PairAlignPath - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.alignment.PairAlignPath.to_bits.html b/docs/dev/generated/skbio.alignment.PairAlignPath.to_bits.html index ef742bfdd..a2c11f804 100644 --- a/docs/dev/generated/skbio.alignment.PairAlignPath.to_bits.html +++ b/docs/dev/generated/skbio.alignment.PairAlignPath.to_bits.html @@ -31,7 +31,7 @@ - + @@ -771,7 +771,7 @@

skbio.alignment.PairAlignPath.to_bits - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.alignment.PairAlignPath.to_cigar.html b/docs/dev/generated/skbio.alignment.PairAlignPath.to_cigar.html index a6fc2a23f..943ba8fb5 100644 --- a/docs/dev/generated/skbio.alignment.PairAlignPath.to_cigar.html +++ b/docs/dev/generated/skbio.alignment.PairAlignPath.to_cigar.html @@ -31,7 +31,7 @@ - + @@ -709,7 +709,7 @@

skbio.alignment.PairAlignPath.to_cigarExamples

-
>>> from skbio.alignment import PairAlignPath
+
>>> from skbio.alignment import PairAlignPath
 >>> path = PairAlignPath(lengths=[2, 5, 3, 1],
 ...                      states=[0, 3, 2, 1],
 ...                      starts=[0, 0])
@@ -797,7 +797,7 @@ 

skbio.alignment.PairAlignPath.to_cigar - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.alignment.StripedSmithWaterman.html b/docs/dev/generated/skbio.alignment.StripedSmithWaterman.html index 683612938..5185c9f86 100644 --- a/docs/dev/generated/skbio.alignment.StripedSmithWaterman.html +++ b/docs/dev/generated/skbio.alignment.StripedSmithWaterman.html @@ -31,7 +31,7 @@ - + @@ -959,7 +959,7 @@

skbio.alignment.StripedSmithWaterman - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.alignment.TabularMSA.append.html b/docs/dev/generated/skbio.alignment.TabularMSA.append.html index 955da5ef4..c3c09573f 100644 --- a/docs/dev/generated/skbio.alignment.TabularMSA.append.html +++ b/docs/dev/generated/skbio.alignment.TabularMSA.append.html @@ -31,7 +31,7 @@ - + @@ -748,7 +748,7 @@

skbio.alignment.TabularMSA.appendExamples

Create an MSA with a single sequence labeled 'seq1':

-
>>> from skbio import DNA, TabularMSA
+
>>> from skbio import DNA, TabularMSA
 >>> msa = TabularMSA([DNA('ACGT')], index=['seq1'])
 >>> msa
 TabularMSA[DNA]
@@ -877,7 +877,7 @@ 

skbio.alignment.TabularMSA.append - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.alignment.TabularMSA.consensus.html b/docs/dev/generated/skbio.alignment.TabularMSA.consensus.html index f858b7ab6..5da94a3d7 100644 --- a/docs/dev/generated/skbio.alignment.TabularMSA.consensus.html +++ b/docs/dev/generated/skbio.alignment.TabularMSA.consensus.html @@ -31,7 +31,7 @@ - + @@ -723,7 +723,7 @@

skbio.alignment.TabularMSA.consensusExamples

-
>>> from skbio import DNA, TabularMSA
+
>>> from skbio import DNA, TabularMSA
 >>> sequences = [DNA('AC---'),
 ...              DNA('AT-C.'),
 ...              DNA('TT-CG')]
@@ -829,7 +829,7 @@ 

skbio.alignment.TabularMSA.consensus - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.alignment.TabularMSA.conservation.html b/docs/dev/generated/skbio.alignment.TabularMSA.conservation.html index 5f97bc05c..6025d1b63 100644 --- a/docs/dev/generated/skbio.alignment.TabularMSA.conservation.html +++ b/docs/dev/generated/skbio.alignment.TabularMSA.conservation.html @@ -31,7 +31,7 @@ - + @@ -857,7 +857,7 @@

skbio.alignment.TabularMSA.conservation - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.alignment.TabularMSA.extend.html b/docs/dev/generated/skbio.alignment.TabularMSA.extend.html index 1fa2593a3..dd7795b7d 100644 --- a/docs/dev/generated/skbio.alignment.TabularMSA.extend.html +++ b/docs/dev/generated/skbio.alignment.TabularMSA.extend.html @@ -31,7 +31,7 @@ - + @@ -754,7 +754,7 @@

skbio.alignment.TabularMSA.extendExamples

Create an MSA with a single sequence labeled 'seq1':

-
>>> from skbio import DNA, TabularMSA
+
>>> from skbio import DNA, TabularMSA
 >>> msa = TabularMSA([DNA('ACGT')], index=['seq1'])
 >>> msa
 TabularMSA[DNA]
@@ -887,7 +887,7 @@ 

skbio.alignment.TabularMSA.extend - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.alignment.TabularMSA.from_dict.html b/docs/dev/generated/skbio.alignment.TabularMSA.from_dict.html index 3fea730c9..a432ea23f 100644 --- a/docs/dev/generated/skbio.alignment.TabularMSA.from_dict.html +++ b/docs/dev/generated/skbio.alignment.TabularMSA.from_dict.html @@ -31,7 +31,7 @@ - + @@ -729,7 +729,7 @@

skbio.alignment.TabularMSA.from_dictTabularMSA object is arbitrary. Use TabularMSA.sort to set a different order.

Examples

-
>>> from skbio import DNA, TabularMSA
+
>>> from skbio import DNA, TabularMSA
 >>> seqs = {'a': DNA('ACGT'), 'b': DNA('A--T')}
 >>> msa = TabularMSA.from_dict(seqs)
 >>> msa.shape
@@ -820,7 +820,7 @@ 

skbio.alignment.TabularMSA.from_dict - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.alignment.TabularMSA.from_path_seqs.html b/docs/dev/generated/skbio.alignment.TabularMSA.from_path_seqs.html index fcb9b3e15..e32aee121 100644 --- a/docs/dev/generated/skbio.alignment.TabularMSA.from_path_seqs.html +++ b/docs/dev/generated/skbio.alignment.TabularMSA.from_path_seqs.html @@ -31,7 +31,7 @@ - + @@ -781,7 +781,7 @@

skbio.alignment.TabularMSA.from_path_seqs - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.alignment.TabularMSA.gap_frequencies.html b/docs/dev/generated/skbio.alignment.TabularMSA.gap_frequencies.html index 7f0447d24..9fb44d937 100644 --- a/docs/dev/generated/skbio.alignment.TabularMSA.gap_frequencies.html +++ b/docs/dev/generated/skbio.alignment.TabularMSA.gap_frequencies.html @@ -31,7 +31,7 @@ - + @@ -735,7 +735,7 @@

skbio.alignment.TabularMSA.gap_frequenciesExamples

Compute frequency of gap characters for each position in the MSA (i.e., across the sequence axis):

-
>>> from skbio import DNA, TabularMSA
+
>>> from skbio import DNA, TabularMSA
 >>> msa = TabularMSA([DNA('ACG'),
 ...                   DNA('A--'),
 ...                   DNA('AC.'),
@@ -835,7 +835,7 @@ 

skbio.alignment.TabularMSA.gap_frequencies - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.alignment.TabularMSA.html b/docs/dev/generated/skbio.alignment.TabularMSA.html index c260eb1db..0790f0587 100644 --- a/docs/dev/generated/skbio.alignment.TabularMSA.html +++ b/docs/dev/generated/skbio.alignment.TabularMSA.html @@ -31,7 +31,7 @@ - + @@ -761,7 +761,7 @@

skbio.alignment.TabularMSApd.RangeIndex(start=0, stop=len(sequences), step=1).

Examples

Create a TabularMSA object with three DNA sequences and four positions:

-
>>> from skbio import DNA, TabularMSA
+
>>> from skbio import DNA, TabularMSA
 >>> seqs = [
 ...     DNA('ACGT'),
 ...     DNA('AG-T'),
@@ -978,7 +978,7 @@ 

skbio.alignment.TabularMSANotes

This property is not writeable.

Examples

-
>>> from skbio import DNA, TabularMSA
+
>>> from skbio import DNA, TabularMSA
 >>> msa = TabularMSA([DNA('ACG'), DNA('AC-')])
 >>> msa.dtype
 <class 'skbio.sequence._dna.DNA'>
@@ -1039,7 +1039,7 @@ 

skbio.alignment.TabularMSApositional_metadata will be unset.

Examples

First we need to set up an MSA to slice:

-
>>> from skbio import TabularMSA, DNA
+
>>> from skbio import TabularMSA, DNA
 >>> msa = TabularMSA([DNA("ACGT"), DNA("A-GT"), DNA("AC-T"),
 ...                   DNA("ACGA")])
 >>> msa
@@ -1191,7 +1191,7 @@ 

skbio.alignment.TabularMSAExamples

Create a TabularMSA object with sequences labeled by sequence identifier:

-
>>> from skbio import DNA, TabularMSA
+
>>> from skbio import DNA, TabularMSA
 >>> seqs = [DNA('ACG', metadata={'id': 'a'}),
 ...         DNA('AC-', metadata={'id': 'b'}),
 ...         DNA('AC-', metadata={'id': 'c'})]
@@ -1272,7 +1272,7 @@ 

skbio.alignment.TabularMSAExamples

First we need to set up an MSA to slice:

-
>>> from skbio import TabularMSA, DNA
+
>>> from skbio import TabularMSA, DNA
 >>> msa = TabularMSA([DNA("ACGT"), DNA("A-GT"), DNA("AC-T"),
 ...                   DNA("ACGA")], index=['a', 'b', 'c', 'd'])
 >>> msa
@@ -1482,7 +1482,7 @@ 

skbio.alignment.TabularMSANotes

This property is not writeable.

Examples

-
>>> from skbio import DNA, TabularMSA
+
>>> from skbio import DNA, TabularMSA
 

Create a TabularMSA object with 2 sequences and 3 positions:

@@ -1520,7 +1520,7 @@

skbio.alignment.TabularMSAExamples

-
>>> from skbio import DNA, TabularMSA
+
>>> from skbio import DNA, TabularMSA
 

MSA with sequences and positions:

@@ -1562,7 +1562,7 @@

skbio.alignment.TabularMSAExamples

-
>>> from skbio import DNA, TabularMSA
+
>>> from skbio import DNA, TabularMSA
 >>> msa = TabularMSA([DNA('ACG'), DNA('AC-')], index=['l1', 'l2'])
 >>> 'l1' in msa
 True
@@ -1593,8 +1593,8 @@ 

skbio.alignment.TabularMSAExamples

-
>>> import copy
->>> from skbio import DNA, TabularMSA
+
>>> import copy
+>>> from skbio import DNA, TabularMSA
 >>> msa = TabularMSA([DNA('ACG'), DNA('AC-')])
 >>> msa_copy = copy.copy(msa)
 >>> msa_copy == msa
@@ -1624,8 +1624,8 @@ 

skbio.alignment.TabularMSAExamples

-
>>> import copy
->>> from skbio import DNA, TabularMSA
+
>>> import copy
+>>> from skbio import DNA, TabularMSA
 >>> msa = TabularMSA([DNA('ACG'), DNA('AC-')])
 >>> msa_copy = copy.deepcopy(msa)
 >>> msa_copy == msa
@@ -1657,7 +1657,7 @@ 

skbio.alignment.TabularMSAExamples

-
>>> from skbio import DNA, RNA, TabularMSA
+
>>> from skbio import DNA, RNA, TabularMSA
 >>> msa = TabularMSA([DNA('ACG'), DNA('AC-')])
 >>> msa == msa
 True
@@ -1729,7 +1729,7 @@ 

skbio.alignment.TabularMSAExamples

-
>>> from skbio import DNA, TabularMSA
+
>>> from skbio import DNA, TabularMSA
 >>> msa = TabularMSA([DNA('ACG'), DNA('AC-')])
 >>> for seq in msa:
 ...     str(seq)
@@ -1754,7 +1754,7 @@ 

skbio.alignment.TabularMSANotes

This is equivalent to msa.shape[0].

Examples

-
>>> from skbio import DNA, TabularMSA
+
>>> from skbio import DNA, TabularMSA
 >>> msa = TabularMSA([DNA('ACG'), DNA('AC-')])
 >>> len(msa)
 2
@@ -1806,7 +1806,7 @@ 

skbio.alignment.TabularMSAExamples

-
>>> from skbio import DNA, TabularMSA
+
>>> from skbio import DNA, TabularMSA
 >>> msa = TabularMSA([DNA('ACG'), DNA('AC-')])
 >>> for seq in reversed(msa):
 ...     str(seq)
@@ -1921,7 +1921,7 @@ 

skbio.alignment.TabularMSA - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.alignment.TabularMSA.iter_positions.html b/docs/dev/generated/skbio.alignment.TabularMSA.iter_positions.html index 3ac207312..46eabec9b 100644 --- a/docs/dev/generated/skbio.alignment.TabularMSA.iter_positions.html +++ b/docs/dev/generated/skbio.alignment.TabularMSA.iter_positions.html @@ -31,7 +31,7 @@ - + @@ -740,7 +740,7 @@

skbio.alignment.TabularMSA.iter_positionsSequence.concat(how='outer') for details.

Examples

Create an MSA with positional metadata:

-
>>> from skbio import DNA, TabularMSA
+
>>> from skbio import DNA, TabularMSA
 >>> sequences = [DNA('ACG'),
 ...              DNA('A-T')]
 >>> msa = TabularMSA(sequences,
@@ -893,7 +893,7 @@ 

skbio.alignment.TabularMSA.iter_positions - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.alignment.TabularMSA.join.html b/docs/dev/generated/skbio.alignment.TabularMSA.join.html index 61ee750db..f1b41cb0e 100644 --- a/docs/dev/generated/skbio.alignment.TabularMSA.join.html +++ b/docs/dev/generated/skbio.alignment.TabularMSA.join.html @@ -31,7 +31,7 @@ - + @@ -791,7 +791,7 @@

skbio.alignment.TabularMSA.join
>>> from skbio import DNA, TabularMSA
+
>>> from skbio import DNA, TabularMSA
 >>> msa1 = TabularMSA([DNA('AC'),
 ...                    DNA('A-')])
 >>> msa2 = TabularMSA([DNA('G-T'),
@@ -976,7 +976,7 @@ 

skbio.alignment.TabularMSA.join - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.alignment.TabularMSA.read.html b/docs/dev/generated/skbio.alignment.TabularMSA.read.html index c2c85f759..04a8960d0 100644 --- a/docs/dev/generated/skbio.alignment.TabularMSA.read.html +++ b/docs/dev/generated/skbio.alignment.TabularMSA.read.html @@ -31,7 +31,7 @@ - + @@ -826,7 +826,7 @@

skbio.alignment.TabularMSA.read - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.alignment.TabularMSA.reassign_index.html b/docs/dev/generated/skbio.alignment.TabularMSA.reassign_index.html index 9adb6e02c..c18cb6940 100644 --- a/docs/dev/generated/skbio.alignment.TabularMSA.reassign_index.html +++ b/docs/dev/generated/skbio.alignment.TabularMSA.reassign_index.html @@ -31,7 +31,7 @@ - + @@ -731,7 +731,7 @@

skbio.alignment.TabularMSA.reassign_indexTabularMSA constructor’s default.

Examples

Create a TabularMSA object with default index labels:

-
>>> from skbio import DNA, TabularMSA
+
>>> from skbio import DNA, TabularMSA
 >>> seqs = [DNA('ACG', metadata={'id': 'a'}),
 ...         DNA('AC-', metadata={'id': 'b'}),
 ...         DNA('CCG', metadata={'id': 'c'})]
@@ -839,7 +839,7 @@ 

skbio.alignment.TabularMSA.reassign_index - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.alignment.TabularMSA.sort.html b/docs/dev/generated/skbio.alignment.TabularMSA.sort.html index 51e94f287..c7dc6e8e2 100644 --- a/docs/dev/generated/skbio.alignment.TabularMSA.sort.html +++ b/docs/dev/generated/skbio.alignment.TabularMSA.sort.html @@ -31,7 +31,7 @@ - + @@ -725,7 +725,7 @@

skbio.alignment.TabularMSA.sortExamples

Create a TabularMSA object with sequence identifiers as index labels:

-
>>> from skbio import DNA, TabularMSA
+
>>> from skbio import DNA, TabularMSA
 >>> seqs = [DNA('ACG', metadata={'id': 'c'}),
 ...         DNA('AC-', metadata={'id': 'b'}),
 ...         DNA('AC-', metadata={'id': 'a'})]
@@ -842,7 +842,7 @@ 

skbio.alignment.TabularMSA.sort - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.alignment.TabularMSA.to_dict.html b/docs/dev/generated/skbio.alignment.TabularMSA.to_dict.html index f16ac34da..a7984406c 100644 --- a/docs/dev/generated/skbio.alignment.TabularMSA.to_dict.html +++ b/docs/dev/generated/skbio.alignment.TabularMSA.to_dict.html @@ -31,7 +31,7 @@ - + @@ -725,7 +725,7 @@

skbio.alignment.TabularMSA.to_dictExamples

-
>>> from skbio import DNA, TabularMSA
+
>>> from skbio import DNA, TabularMSA
 >>> seqs = [DNA('ACGT'), DNA('A--T')]
 >>> msa = TabularMSA(seqs, index=['a', 'b'])
 >>> dictionary = msa.to_dict()
@@ -813,7 +813,7 @@ 

skbio.alignment.TabularMSA.to_dict - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.alignment.TabularMSA.write.html b/docs/dev/generated/skbio.alignment.TabularMSA.write.html index 2558da890..452ea7a3f 100644 --- a/docs/dev/generated/skbio.alignment.TabularMSA.write.html +++ b/docs/dev/generated/skbio.alignment.TabularMSA.write.html @@ -31,7 +31,7 @@ - + @@ -819,7 +819,7 @@

skbio.alignment.TabularMSA.write - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.alignment.global_pairwise_align.html b/docs/dev/generated/skbio.alignment.global_pairwise_align.html index 19fb55ae9..9e6274b89 100644 --- a/docs/dev/generated/skbio.alignment.global_pairwise_align.html +++ b/docs/dev/generated/skbio.alignment.global_pairwise_align.html @@ -31,7 +31,7 @@ - + @@ -828,7 +828,7 @@

skbio.alignment.global_pairwise_align - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.alignment.global_pairwise_align_nucleotide.html b/docs/dev/generated/skbio.alignment.global_pairwise_align_nucleotide.html index f8e9876d5..2f8ec3994 100644 --- a/docs/dev/generated/skbio.alignment.global_pairwise_align_nucleotide.html +++ b/docs/dev/generated/skbio.alignment.global_pairwise_align_nucleotide.html @@ -31,7 +31,7 @@ - + @@ -829,7 +829,7 @@

skbio.alignment.global_pairwise_align_nucleotide - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.alignment.global_pairwise_align_protein.html b/docs/dev/generated/skbio.alignment.global_pairwise_align_protein.html index a04977e76..c4a1d1205 100644 --- a/docs/dev/generated/skbio.alignment.global_pairwise_align_protein.html +++ b/docs/dev/generated/skbio.alignment.global_pairwise_align_protein.html @@ -31,7 +31,7 @@ - + @@ -828,7 +828,7 @@

skbio.alignment.global_pairwise_align_protein - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.alignment.local_pairwise_align.html b/docs/dev/generated/skbio.alignment.local_pairwise_align.html index ffa6a9d17..41ef262f5 100644 --- a/docs/dev/generated/skbio.alignment.local_pairwise_align.html +++ b/docs/dev/generated/skbio.alignment.local_pairwise_align.html @@ -31,7 +31,7 @@ - + @@ -817,7 +817,7 @@

skbio.alignment.local_pairwise_align - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.alignment.local_pairwise_align_nucleotide.html b/docs/dev/generated/skbio.alignment.local_pairwise_align_nucleotide.html index e2c8a3214..15be0ce4d 100644 --- a/docs/dev/generated/skbio.alignment.local_pairwise_align_nucleotide.html +++ b/docs/dev/generated/skbio.alignment.local_pairwise_align_nucleotide.html @@ -31,7 +31,7 @@ - + @@ -820,7 +820,7 @@

skbio.alignment.local_pairwise_align_nucleotide - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.alignment.local_pairwise_align_protein.html b/docs/dev/generated/skbio.alignment.local_pairwise_align_protein.html index 6322694db..3757735ff 100644 --- a/docs/dev/generated/skbio.alignment.local_pairwise_align_protein.html +++ b/docs/dev/generated/skbio.alignment.local_pairwise_align_protein.html @@ -31,7 +31,7 @@ - + @@ -819,7 +819,7 @@

skbio.alignment.local_pairwise_align_protein - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.alignment.local_pairwise_align_ssw.html b/docs/dev/generated/skbio.alignment.local_pairwise_align_ssw.html index 268b81c50..014ec3dce 100644 --- a/docs/dev/generated/skbio.alignment.local_pairwise_align_ssw.html +++ b/docs/dev/generated/skbio.alignment.local_pairwise_align_ssw.html @@ -31,7 +31,7 @@ - + @@ -809,7 +809,7 @@

skbio.alignment.local_pairwise_align_ssw - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.alignment.make_identity_substitution_matrix.html b/docs/dev/generated/skbio.alignment.make_identity_substitution_matrix.html index ba12c2f32..98107b50f 100644 --- a/docs/dev/generated/skbio.alignment.make_identity_substitution_matrix.html +++ b/docs/dev/generated/skbio.alignment.make_identity_substitution_matrix.html @@ -31,7 +31,7 @@ - + @@ -787,7 +787,7 @@

skbio.alignment.make_identity_substitution_matrix - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.diversity.alpha.ace.html b/docs/dev/generated/skbio.diversity.alpha.ace.html index 265ddc7ed..442f724ca 100644 --- a/docs/dev/generated/skbio.diversity.alpha.ace.html +++ b/docs/dev/generated/skbio.diversity.alpha.ace.html @@ -31,7 +31,7 @@ - + @@ -874,7 +874,7 @@

skbio.diversity.alpha.ace - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.diversity.alpha.berger_parker_d.html b/docs/dev/generated/skbio.diversity.alpha.berger_parker_d.html index 65c1a3be0..908acca5a 100644 --- a/docs/dev/generated/skbio.diversity.alpha.berger_parker_d.html +++ b/docs/dev/generated/skbio.diversity.alpha.berger_parker_d.html @@ -31,7 +31,7 @@ - + @@ -832,7 +832,7 @@

skbio.diversity.alpha.berger_parker_d - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.diversity.alpha.brillouin_d.html b/docs/dev/generated/skbio.diversity.alpha.brillouin_d.html index c49665686..4212d227c 100644 --- a/docs/dev/generated/skbio.diversity.alpha.brillouin_d.html +++ b/docs/dev/generated/skbio.diversity.alpha.brillouin_d.html @@ -31,7 +31,7 @@ - + @@ -831,7 +831,7 @@

skbio.diversity.alpha.brillouin_d - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.diversity.alpha.chao1.html b/docs/dev/generated/skbio.diversity.alpha.chao1.html index 9c9219bc3..b085613f0 100644 --- a/docs/dev/generated/skbio.diversity.alpha.chao1.html +++ b/docs/dev/generated/skbio.diversity.alpha.chao1.html @@ -31,7 +31,7 @@ - + @@ -845,7 +845,7 @@

skbio.diversity.alpha.chao1 - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.diversity.alpha.chao1_ci.html b/docs/dev/generated/skbio.diversity.alpha.chao1_ci.html index 52e834172..036ad34e5 100644 --- a/docs/dev/generated/skbio.diversity.alpha.chao1_ci.html +++ b/docs/dev/generated/skbio.diversity.alpha.chao1_ci.html @@ -31,7 +31,7 @@ - + @@ -847,7 +847,7 @@

skbio.diversity.alpha.chao1_ci - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.diversity.alpha.dominance.html b/docs/dev/generated/skbio.diversity.alpha.dominance.html index 8d5092e34..e11cf7544 100644 --- a/docs/dev/generated/skbio.diversity.alpha.dominance.html +++ b/docs/dev/generated/skbio.diversity.alpha.dominance.html @@ -31,7 +31,7 @@ - + @@ -858,7 +858,7 @@

skbio.diversity.alpha.dominance - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.diversity.alpha.doubles.html b/docs/dev/generated/skbio.diversity.alpha.doubles.html index 2d70e0c5e..93605f542 100644 --- a/docs/dev/generated/skbio.diversity.alpha.doubles.html +++ b/docs/dev/generated/skbio.diversity.alpha.doubles.html @@ -31,7 +31,7 @@ - + @@ -814,7 +814,7 @@

skbio.diversity.alpha.doubles - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.diversity.alpha.enspie.html b/docs/dev/generated/skbio.diversity.alpha.enspie.html index 28eea5208..7510449d1 100644 --- a/docs/dev/generated/skbio.diversity.alpha.enspie.html +++ b/docs/dev/generated/skbio.diversity.alpha.enspie.html @@ -31,7 +31,7 @@ - + @@ -848,7 +848,7 @@

skbio.diversity.alpha.enspie - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.diversity.alpha.esty_ci.html b/docs/dev/generated/skbio.diversity.alpha.esty_ci.html index 205e95950..b7ae18063 100644 --- a/docs/dev/generated/skbio.diversity.alpha.esty_ci.html +++ b/docs/dev/generated/skbio.diversity.alpha.esty_ci.html @@ -31,7 +31,7 @@ - + @@ -842,7 +842,7 @@

skbio.diversity.alpha.esty_ci - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.diversity.alpha.faith_pd.html b/docs/dev/generated/skbio.diversity.alpha.faith_pd.html index 762fc0d63..926af0b22 100644 --- a/docs/dev/generated/skbio.diversity.alpha.faith_pd.html +++ b/docs/dev/generated/skbio.diversity.alpha.faith_pd.html @@ -31,7 +31,7 @@ - + @@ -843,14 +843,14 @@

skbio.diversity.alpha.faith_pd
>>> from skbio import TreeNode
+
>>> from skbio import TreeNode
 >>> tree = TreeNode.read(['(((((U1:0.5,U2:0.5):0.5,U3:1.0):1.0):0.0,'
 ...                       '(U4:0.75,(U5:0.5,((U6:0.33,U7:0.62):0.5'
 ...                       ',U8:0.5):0.5):0.5):1.25):0.0)root;'])
 

We can then compute the Faith PD of the sample.

-
>>> from skbio.diversity.alpha import faith_pd
+
>>> from skbio.diversity.alpha import faith_pd
 >>> pd = faith_pd(u_counts, taxa, tree)
 >>> print(round(pd, 2))
 6.95
@@ -936,7 +936,7 @@ 

skbio.diversity.alpha.faith_pd - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.diversity.alpha.fisher_alpha.html b/docs/dev/generated/skbio.diversity.alpha.fisher_alpha.html index e7feb321b..fdf27f31f 100644 --- a/docs/dev/generated/skbio.diversity.alpha.fisher_alpha.html +++ b/docs/dev/generated/skbio.diversity.alpha.fisher_alpha.html @@ -31,7 +31,7 @@ - + @@ -845,7 +845,7 @@

skbio.diversity.alpha.fisher_alpha - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.diversity.alpha.gini_index.html b/docs/dev/generated/skbio.diversity.alpha.gini_index.html index 547586bbe..e18bec109 100644 --- a/docs/dev/generated/skbio.diversity.alpha.gini_index.html +++ b/docs/dev/generated/skbio.diversity.alpha.gini_index.html @@ -31,7 +31,7 @@ - + @@ -855,7 +855,7 @@

skbio.diversity.alpha.gini_index - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.diversity.alpha.goods_coverage.html b/docs/dev/generated/skbio.diversity.alpha.goods_coverage.html index 03cb93ca4..ae78fa248 100644 --- a/docs/dev/generated/skbio.diversity.alpha.goods_coverage.html +++ b/docs/dev/generated/skbio.diversity.alpha.goods_coverage.html @@ -31,7 +31,7 @@ - + @@ -839,7 +839,7 @@

skbio.diversity.alpha.goods_coverage - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.diversity.alpha.heip_e.html b/docs/dev/generated/skbio.diversity.alpha.heip_e.html index 384a64991..96984ecea 100644 --- a/docs/dev/generated/skbio.diversity.alpha.heip_e.html +++ b/docs/dev/generated/skbio.diversity.alpha.heip_e.html @@ -31,7 +31,7 @@ - + @@ -838,7 +838,7 @@

skbio.diversity.alpha.heip_e - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.diversity.alpha.hill.html b/docs/dev/generated/skbio.diversity.alpha.hill.html index 68446c2ca..65249e312 100644 --- a/docs/dev/generated/skbio.diversity.alpha.hill.html +++ b/docs/dev/generated/skbio.diversity.alpha.hill.html @@ -31,7 +31,7 @@ - + @@ -863,7 +863,7 @@

skbio.diversity.alpha.hill - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.diversity.alpha.html b/docs/dev/generated/skbio.diversity.alpha.html index c79f7bd00..1d85602f6 100644 --- a/docs/dev/generated/skbio.diversity.alpha.html +++ b/docs/dev/generated/skbio.diversity.alpha.html @@ -30,7 +30,7 @@ - + @@ -1004,7 +1004,7 @@

References - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.diversity.alpha.inv_simpson.html b/docs/dev/generated/skbio.diversity.alpha.inv_simpson.html index cfcb60d7e..cec68ae19 100644 --- a/docs/dev/generated/skbio.diversity.alpha.inv_simpson.html +++ b/docs/dev/generated/skbio.diversity.alpha.inv_simpson.html @@ -31,7 +31,7 @@ - + @@ -841,7 +841,7 @@

skbio.diversity.alpha.inv_simpson - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.diversity.alpha.kempton_taylor_q.html b/docs/dev/generated/skbio.diversity.alpha.kempton_taylor_q.html index 33312b8ac..e7cf0036f 100644 --- a/docs/dev/generated/skbio.diversity.alpha.kempton_taylor_q.html +++ b/docs/dev/generated/skbio.diversity.alpha.kempton_taylor_q.html @@ -31,7 +31,7 @@ - + @@ -854,7 +854,7 @@

skbio.diversity.alpha.kempton_taylor_q - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.diversity.alpha.lladser_ci.html b/docs/dev/generated/skbio.diversity.alpha.lladser_ci.html index 486fea664..d3112619e 100644 --- a/docs/dev/generated/skbio.diversity.alpha.lladser_ci.html +++ b/docs/dev/generated/skbio.diversity.alpha.lladser_ci.html @@ -31,7 +31,7 @@ - + @@ -850,7 +850,7 @@

skbio.diversity.alpha.lladser_ci - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.diversity.alpha.lladser_pe.html b/docs/dev/generated/skbio.diversity.alpha.lladser_pe.html index 9172fba49..b16c84962 100644 --- a/docs/dev/generated/skbio.diversity.alpha.lladser_pe.html +++ b/docs/dev/generated/skbio.diversity.alpha.lladser_pe.html @@ -31,7 +31,7 @@ - + @@ -843,7 +843,7 @@

skbio.diversity.alpha.lladser_pe - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.diversity.alpha.margalef.html b/docs/dev/generated/skbio.diversity.alpha.margalef.html index ecd6ef55e..026fae5aa 100644 --- a/docs/dev/generated/skbio.diversity.alpha.margalef.html +++ b/docs/dev/generated/skbio.diversity.alpha.margalef.html @@ -31,7 +31,7 @@ - + @@ -837,7 +837,7 @@

skbio.diversity.alpha.margalef - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.diversity.alpha.mcintosh_d.html b/docs/dev/generated/skbio.diversity.alpha.mcintosh_d.html index c64a602de..297b19526 100644 --- a/docs/dev/generated/skbio.diversity.alpha.mcintosh_d.html +++ b/docs/dev/generated/skbio.diversity.alpha.mcintosh_d.html @@ -31,7 +31,7 @@ - + @@ -840,7 +840,7 @@

skbio.diversity.alpha.mcintosh_d - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.diversity.alpha.mcintosh_e.html b/docs/dev/generated/skbio.diversity.alpha.mcintosh_e.html index c6d4b6742..72a8ae01d 100644 --- a/docs/dev/generated/skbio.diversity.alpha.mcintosh_e.html +++ b/docs/dev/generated/skbio.diversity.alpha.mcintosh_e.html @@ -31,7 +31,7 @@ - + @@ -837,7 +837,7 @@

skbio.diversity.alpha.mcintosh_e - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.diversity.alpha.menhinick.html b/docs/dev/generated/skbio.diversity.alpha.menhinick.html index 929361948..75d27d0d6 100644 --- a/docs/dev/generated/skbio.diversity.alpha.menhinick.html +++ b/docs/dev/generated/skbio.diversity.alpha.menhinick.html @@ -31,7 +31,7 @@ - + @@ -837,7 +837,7 @@

skbio.diversity.alpha.menhinick - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.diversity.alpha.michaelis_menten_fit.html b/docs/dev/generated/skbio.diversity.alpha.michaelis_menten_fit.html index 612a06ebf..18bc7e0bb 100644 --- a/docs/dev/generated/skbio.diversity.alpha.michaelis_menten_fit.html +++ b/docs/dev/generated/skbio.diversity.alpha.michaelis_menten_fit.html @@ -31,7 +31,7 @@ - + @@ -854,7 +854,7 @@

skbio.diversity.alpha.michaelis_menten_fit - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.diversity.alpha.observed_features.html b/docs/dev/generated/skbio.diversity.alpha.observed_features.html index 39c5e3852..0264fde2d 100644 --- a/docs/dev/generated/skbio.diversity.alpha.observed_features.html +++ b/docs/dev/generated/skbio.diversity.alpha.observed_features.html @@ -31,7 +31,7 @@ - + @@ -822,7 +822,7 @@

skbio.diversity.alpha.observed_features - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.diversity.alpha.osd.html b/docs/dev/generated/skbio.diversity.alpha.osd.html index dc29421a0..e7b0793d9 100644 --- a/docs/dev/generated/skbio.diversity.alpha.osd.html +++ b/docs/dev/generated/skbio.diversity.alpha.osd.html @@ -31,7 +31,7 @@ - + @@ -825,7 +825,7 @@

skbio.diversity.alpha.osd - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.diversity.alpha.phydiv.html b/docs/dev/generated/skbio.diversity.alpha.phydiv.html index a8dbabd4f..a0fe151dd 100644 --- a/docs/dev/generated/skbio.diversity.alpha.phydiv.html +++ b/docs/dev/generated/skbio.diversity.alpha.phydiv.html @@ -31,7 +31,7 @@ - + @@ -973,7 +973,7 @@

skbio.diversity.alpha.phydiv - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.diversity.alpha.pielou_e.html b/docs/dev/generated/skbio.diversity.alpha.pielou_e.html index e5ad26acc..97bf1bfe5 100644 --- a/docs/dev/generated/skbio.diversity.alpha.pielou_e.html +++ b/docs/dev/generated/skbio.diversity.alpha.pielou_e.html @@ -31,7 +31,7 @@ - + @@ -844,7 +844,7 @@

skbio.diversity.alpha.pielou_e - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.diversity.alpha.renyi.html b/docs/dev/generated/skbio.diversity.alpha.renyi.html index baac9a53e..289f24d6e 100644 --- a/docs/dev/generated/skbio.diversity.alpha.renyi.html +++ b/docs/dev/generated/skbio.diversity.alpha.renyi.html @@ -31,7 +31,7 @@ - + @@ -856,7 +856,7 @@

skbio.diversity.alpha.renyi - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.diversity.alpha.robbins.html b/docs/dev/generated/skbio.diversity.alpha.robbins.html index c92d9a78f..af91856cf 100644 --- a/docs/dev/generated/skbio.diversity.alpha.robbins.html +++ b/docs/dev/generated/skbio.diversity.alpha.robbins.html @@ -31,7 +31,7 @@ - + @@ -839,7 +839,7 @@

skbio.diversity.alpha.robbins - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.diversity.alpha.shannon.html b/docs/dev/generated/skbio.diversity.alpha.shannon.html index fd58b4d94..e7f11529d 100644 --- a/docs/dev/generated/skbio.diversity.alpha.shannon.html +++ b/docs/dev/generated/skbio.diversity.alpha.shannon.html @@ -31,7 +31,7 @@ - + @@ -855,7 +855,7 @@

skbio.diversity.alpha.shannon - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.diversity.alpha.simpson.html b/docs/dev/generated/skbio.diversity.alpha.simpson.html index 5a264b4fa..fb3a51ec3 100644 --- a/docs/dev/generated/skbio.diversity.alpha.simpson.html +++ b/docs/dev/generated/skbio.diversity.alpha.simpson.html @@ -31,7 +31,7 @@ - + @@ -850,7 +850,7 @@

skbio.diversity.alpha.simpson - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.diversity.alpha.simpson_d.html b/docs/dev/generated/skbio.diversity.alpha.simpson_d.html index f2624cc91..9d5842256 100644 --- a/docs/dev/generated/skbio.diversity.alpha.simpson_d.html +++ b/docs/dev/generated/skbio.diversity.alpha.simpson_d.html @@ -31,7 +31,7 @@ - + @@ -826,7 +826,7 @@

skbio.diversity.alpha.simpson_d - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.diversity.alpha.simpson_e.html b/docs/dev/generated/skbio.diversity.alpha.simpson_e.html index 45aa787c7..6962acab1 100644 --- a/docs/dev/generated/skbio.diversity.alpha.simpson_e.html +++ b/docs/dev/generated/skbio.diversity.alpha.simpson_e.html @@ -31,7 +31,7 @@ - + @@ -847,7 +847,7 @@

skbio.diversity.alpha.simpson_e - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.diversity.alpha.singles.html b/docs/dev/generated/skbio.diversity.alpha.singles.html index 1c6eef3cc..47606998f 100644 --- a/docs/dev/generated/skbio.diversity.alpha.singles.html +++ b/docs/dev/generated/skbio.diversity.alpha.singles.html @@ -31,7 +31,7 @@ - + @@ -814,7 +814,7 @@

skbio.diversity.alpha.singles - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.diversity.alpha.sobs.html b/docs/dev/generated/skbio.diversity.alpha.sobs.html index 8866c71f9..eb1c89ef3 100644 --- a/docs/dev/generated/skbio.diversity.alpha.sobs.html +++ b/docs/dev/generated/skbio.diversity.alpha.sobs.html @@ -31,7 +31,7 @@ - + @@ -830,7 +830,7 @@

skbio.diversity.alpha.sobs - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.diversity.alpha.strong.html b/docs/dev/generated/skbio.diversity.alpha.strong.html index 24e73fe6a..a65f26052 100644 --- a/docs/dev/generated/skbio.diversity.alpha.strong.html +++ b/docs/dev/generated/skbio.diversity.alpha.strong.html @@ -31,7 +31,7 @@ - + @@ -834,7 +834,7 @@

skbio.diversity.alpha.strong - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.diversity.alpha.tsallis.html b/docs/dev/generated/skbio.diversity.alpha.tsallis.html index fc3d95d3f..30229aa4f 100644 --- a/docs/dev/generated/skbio.diversity.alpha.tsallis.html +++ b/docs/dev/generated/skbio.diversity.alpha.tsallis.html @@ -31,7 +31,7 @@ - + @@ -850,7 +850,7 @@

skbio.diversity.alpha.tsallis - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.diversity.alpha_diversity.html b/docs/dev/generated/skbio.diversity.alpha_diversity.html index a7dcccef9..baeca4d23 100644 --- a/docs/dev/generated/skbio.diversity.alpha_diversity.html +++ b/docs/dev/generated/skbio.diversity.alpha_diversity.html @@ -31,7 +31,7 @@ - + @@ -807,7 +807,7 @@

skbio.diversity.alpha_diversity - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.diversity.beta.html b/docs/dev/generated/skbio.diversity.beta.html index 6a2e537f2..64b32c4ae 100644 --- a/docs/dev/generated/skbio.diversity.beta.html +++ b/docs/dev/generated/skbio.diversity.beta.html @@ -30,7 +30,7 @@ - + @@ -772,7 +772,7 @@

Functions - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.diversity.beta.unweighted_unifrac.html b/docs/dev/generated/skbio.diversity.beta.unweighted_unifrac.html index c4f8bd32a..dd2c2f916 100644 --- a/docs/dev/generated/skbio.diversity.beta.unweighted_unifrac.html +++ b/docs/dev/generated/skbio.diversity.beta.unweighted_unifrac.html @@ -31,7 +31,7 @@ - + @@ -799,8 +799,8 @@

skbio.diversity.beta.unweighted_unifrac
>>> from io import StringIO
->>> from skbio import TreeNode
+
>>> from io import StringIO
+>>> from skbio import TreeNode
 >>> tree = TreeNode.read(StringIO(
 ...                      '(((((U1:0.5,U2:0.5):0.5,U3:1.0):1.0):0.0,'
 ...                      '(U4:0.75,(U5:0.5,((U6:0.33,U7:0.62):0.5'
@@ -808,7 +808,7 @@ 

skbio.diversity.beta.unweighted_unifrac
>>> from skbio.diversity.beta import unweighted_unifrac
+
>>> from skbio.diversity.beta import unweighted_unifrac
 >>> uu = unweighted_unifrac(u_counts, v_counts, taxa, tree)
 >>> print(round(uu, 2))
 0.37
@@ -894,7 +894,7 @@ 

skbio.diversity.beta.unweighted_unifrac - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.diversity.beta.weighted_unifrac.html b/docs/dev/generated/skbio.diversity.beta.weighted_unifrac.html index 9067a8797..e7bce0145 100644 --- a/docs/dev/generated/skbio.diversity.beta.weighted_unifrac.html +++ b/docs/dev/generated/skbio.diversity.beta.weighted_unifrac.html @@ -31,7 +31,7 @@ - + @@ -796,8 +796,8 @@

skbio.diversity.beta.weighted_unifrac
>>> from io import StringIO
->>> from skbio import TreeNode
+
>>> from io import StringIO
+>>> from skbio import TreeNode
 >>> tree = TreeNode.read(StringIO(
 ...                      '(((((U1:0.5,U2:0.5):0.5,U3:1.0):1.0):0.0,'
 ...                      '(U4:0.75,(U5:0.5,((U6:0.33,U7:0.62):0.5'
@@ -805,7 +805,7 @@ 

skbio.diversity.beta.weighted_unifrac
>>> from skbio.diversity.beta import weighted_unifrac
+
@@ -818,7 +818,7 @@

skbio.diversity.beta_diversity - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.diversity.block_beta_diversity.html b/docs/dev/generated/skbio.diversity.block_beta_diversity.html index 14006ab8d..8f6f45fc8 100644 --- a/docs/dev/generated/skbio.diversity.block_beta_diversity.html +++ b/docs/dev/generated/skbio.diversity.block_beta_diversity.html @@ -31,7 +31,7 @@ - + @@ -820,7 +820,7 @@

skbio.diversity.block_beta_diversity - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.diversity.get_alpha_diversity_metrics.html b/docs/dev/generated/skbio.diversity.get_alpha_diversity_metrics.html index fc230c901..31a250827 100644 --- a/docs/dev/generated/skbio.diversity.get_alpha_diversity_metrics.html +++ b/docs/dev/generated/skbio.diversity.get_alpha_diversity_metrics.html @@ -31,7 +31,7 @@ - + @@ -775,7 +775,7 @@

skbio.diversity.get_alpha_diversity_metrics - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.diversity.get_beta_diversity_metrics.html b/docs/dev/generated/skbio.diversity.get_beta_diversity_metrics.html index 3f0c84724..192ced836 100644 --- a/docs/dev/generated/skbio.diversity.get_beta_diversity_metrics.html +++ b/docs/dev/generated/skbio.diversity.get_beta_diversity_metrics.html @@ -31,7 +31,7 @@ - + @@ -693,7 +693,7 @@

skbio.diversity.get_beta_diversity_metrics
beta_diversity
get_alpha_diversity_metrics
-
scipy.spatial.distance.pdist
+
scipy.spatial.distance.pdist

Notes

@@ -780,7 +780,7 @@

skbio.diversity.get_beta_diversity_metrics - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.diversity.partial_beta_diversity.html b/docs/dev/generated/skbio.diversity.partial_beta_diversity.html index feebe1e7e..499309929 100644 --- a/docs/dev/generated/skbio.diversity.partial_beta_diversity.html +++ b/docs/dev/generated/skbio.diversity.partial_beta_diversity.html @@ -31,7 +31,7 @@ - + @@ -808,7 +808,7 @@

skbio.diversity.partial_beta_diversity - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.embedding.Embedding.bytes.html b/docs/dev/generated/skbio.embedding.Embedding.bytes.html index 8dba47c8b..c5a5bb30d 100644 --- a/docs/dev/generated/skbio.embedding.Embedding.bytes.html +++ b/docs/dev/generated/skbio.embedding.Embedding.bytes.html @@ -31,7 +31,7 @@ - + @@ -765,7 +765,7 @@

skbio.embedding.Embedding.bytes - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.embedding.Embedding.html b/docs/dev/generated/skbio.embedding.Embedding.html index 8ae2df3eb..aa8fd84e5 100644 --- a/docs/dev/generated/skbio.embedding.Embedding.html +++ b/docs/dev/generated/skbio.embedding.Embedding.html @@ -31,7 +31,7 @@ - + @@ -862,7 +862,7 @@

skbio.embedding.Embedding - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.embedding.Embedding.read.html b/docs/dev/generated/skbio.embedding.Embedding.read.html index 04543c976..ddfffc4f5 100644 --- a/docs/dev/generated/skbio.embedding.Embedding.read.html +++ b/docs/dev/generated/skbio.embedding.Embedding.read.html @@ -31,7 +31,7 @@ - + @@ -797,7 +797,7 @@

skbio.embedding.Embedding.read - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.embedding.Embedding.write.html b/docs/dev/generated/skbio.embedding.Embedding.write.html index 6120e79b5..e6fdf3b65 100644 --- a/docs/dev/generated/skbio.embedding.Embedding.write.html +++ b/docs/dev/generated/skbio.embedding.Embedding.write.html @@ -31,7 +31,7 @@ - + @@ -790,7 +790,7 @@

skbio.embedding.Embedding.write - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.embedding.EmbeddingVector.html b/docs/dev/generated/skbio.embedding.EmbeddingVector.html index 2ea4463c0..ab039ab77 100644 --- a/docs/dev/generated/skbio.embedding.EmbeddingVector.html +++ b/docs/dev/generated/skbio.embedding.EmbeddingVector.html @@ -31,7 +31,7 @@ - + @@ -873,7 +873,7 @@

skbio.embedding.EmbeddingVector - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.embedding.ProteinEmbedding.html b/docs/dev/generated/skbio.embedding.ProteinEmbedding.html index c9b0f5260..f113b3d4c 100644 --- a/docs/dev/generated/skbio.embedding.ProteinEmbedding.html +++ b/docs/dev/generated/skbio.embedding.ProteinEmbedding.html @@ -31,7 +31,7 @@ - + @@ -703,8 +703,8 @@

skbio.embedding.ProteinEmbeddingExamples

-
>>> from skbio.embedding import ProteinEmbedding
->>> import numpy as np
+
>>> from skbio.embedding import ProteinEmbedding
+>>> import numpy as np
 >>> embedding = np.random.rand(10, 3)
 >>> sequence = "ACDEFGHIKL"
 >>> ProteinEmbedding(embedding, sequence)
@@ -892,7 +892,7 @@ 

skbio.embedding.ProteinEmbedding - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.embedding.ProteinVector.html b/docs/dev/generated/skbio.embedding.ProteinVector.html index 9b21cd082..a9623f869 100644 --- a/docs/dev/generated/skbio.embedding.ProteinVector.html +++ b/docs/dev/generated/skbio.embedding.ProteinVector.html @@ -31,7 +31,7 @@ - + @@ -696,8 +696,8 @@

skbio.embedding.ProteinVectorExamples

-
>>> from skbio.embedding import ProteinVector
->>> import numpy as np
+
>>> from skbio.embedding import ProteinVector
+>>> import numpy as np
 >>> vector = np.random.rand(10)
 >>> sequence = "ACDEFGHIKL"
 >>> ProteinVector(vector, sequence)
@@ -878,7 +878,7 @@ 

skbio.embedding.ProteinVector - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.embedding.SequenceEmbedding.html b/docs/dev/generated/skbio.embedding.SequenceEmbedding.html index 87f2093ef..859d8e302 100644 --- a/docs/dev/generated/skbio.embedding.SequenceEmbedding.html +++ b/docs/dev/generated/skbio.embedding.SequenceEmbedding.html @@ -31,7 +31,7 @@ - + @@ -867,7 +867,7 @@

skbio.embedding.SequenceEmbedding - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.embedding.SequenceVector.html b/docs/dev/generated/skbio.embedding.SequenceVector.html index ab5840e08..d717b9849 100644 --- a/docs/dev/generated/skbio.embedding.SequenceVector.html +++ b/docs/dev/generated/skbio.embedding.SequenceVector.html @@ -31,7 +31,7 @@ - + @@ -857,7 +857,7 @@

skbio.embedding.SequenceVector - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.embedding.embed_vec_to_dataframe.html b/docs/dev/generated/skbio.embedding.embed_vec_to_dataframe.html index 3233221ef..5d5484510 100644 --- a/docs/dev/generated/skbio.embedding.embed_vec_to_dataframe.html +++ b/docs/dev/generated/skbio.embedding.embed_vec_to_dataframe.html @@ -31,7 +31,7 @@ - + @@ -782,7 +782,7 @@

skbio.embedding.embed_vec_to_dataframe - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.embedding.embed_vec_to_distances.html b/docs/dev/generated/skbio.embedding.embed_vec_to_distances.html index 392c0649b..83b5f7c51 100644 --- a/docs/dev/generated/skbio.embedding.embed_vec_to_distances.html +++ b/docs/dev/generated/skbio.embedding.embed_vec_to_distances.html @@ -31,7 +31,7 @@ - + @@ -785,7 +785,7 @@

skbio.embedding.embed_vec_to_distances - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.embedding.embed_vec_to_numpy.html b/docs/dev/generated/skbio.embedding.embed_vec_to_numpy.html index a80ee4a86..7ca8917cb 100644 --- a/docs/dev/generated/skbio.embedding.embed_vec_to_numpy.html +++ b/docs/dev/generated/skbio.embedding.embed_vec_to_numpy.html @@ -31,7 +31,7 @@ - + @@ -782,7 +782,7 @@

skbio.embedding.embed_vec_to_numpy - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.embedding.embed_vec_to_ordination.html b/docs/dev/generated/skbio.embedding.embed_vec_to_ordination.html index 7a463c5eb..fe1e252d9 100644 --- a/docs/dev/generated/skbio.embedding.embed_vec_to_ordination.html +++ b/docs/dev/generated/skbio.embedding.embed_vec_to_ordination.html @@ -31,7 +31,7 @@ - + @@ -782,7 +782,7 @@

skbio.embedding.embed_vec_to_ordination - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.io.format.binary_dm.html b/docs/dev/generated/skbio.io.format.binary_dm.html index b6a6de262..58ea3dade 100644 --- a/docs/dev/generated/skbio.io.format.binary_dm.html +++ b/docs/dev/generated/skbio.io.format.binary_dm.html @@ -30,7 +30,7 @@ - + @@ -861,7 +861,7 @@

References - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.io.format.biom.html b/docs/dev/generated/skbio.io.format.biom.html index a688fdb0a..2feff698c 100644 --- a/docs/dev/generated/skbio.io.format.biom.html +++ b/docs/dev/generated/skbio.io.format.biom.html @@ -30,7 +30,7 @@ - + @@ -729,7 +729,7 @@

Examples

Here we will write an existing BIOM table, and re-read it. Note that the Table from biom implicitly gets the .write method from the IO registry. This ByteIO object can be a file path in a regular use case.

-
>>> import io, skbio
+
>>> import io, skbio
 >>> f = io.BytesIO()
 >>> skbio.table.example_table.write(f)  
 <_io.BytesIO object at ...>
@@ -829,7 +829,7 @@ 

References - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.io.format.blast6.html b/docs/dev/generated/skbio.io.format.blast6.html index 61136bbad..32d971053 100644 --- a/docs/dev/generated/skbio.io.format.blast6.html +++ b/docs/dev/generated/skbio.io.format.blast6.html @@ -30,7 +30,7 @@ - + @@ -973,9 +973,9 @@

Format Parameters

Examples#

Suppose we have a blast+6 file with default columns:

-
>>> from io import StringIO
->>> import skbio.io
->>> import pandas as pd
+
>>> from io import StringIO
+>>> import skbio.io
+>>> import pandas as pd
 >>> fs = '\n'.join([
 ...     'moaC\tgi|15800534|ref|NP_286546.1|\t100.00\t161\t0\t0\t1\t161\t1\t161'
 ...     '\t3e-114\t330',
@@ -1000,9 +1000,9 @@ 

Examples

Suppose we have a blast+6 file with user-supplied (non-default) columns:

-
>>> from io import StringIO
->>> import skbio.io
->>> import pandas as pd
+
>>> from io import StringIO
+>>> import skbio.io
+>>> import pandas as pd
 >>> fs = '\n'.join([
 ...     'moaC\t100.00\t0\t161\t0\t161\t330\t1',
 ...     'moaC\t99.38\t1\t161\t0\t161\t329\t1'
@@ -1125,7 +1125,7 @@ 

References - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.io.format.blast7.html b/docs/dev/generated/skbio.io.format.blast7.html index 4141a4d49..bb3a30cba 100644 --- a/docs/dev/generated/skbio.io.format.blast7.html +++ b/docs/dev/generated/skbio.io.format.blast7.html @@ -30,7 +30,7 @@ - + @@ -923,9 +923,9 @@

BLAST Column Types

Examples#

Suppose we have a BLAST+7 file:

-
>>> from io import StringIO
->>> import skbio.io
->>> import pandas as pd
+
>>> from io import StringIO
+>>> import skbio.io
+>>> import pandas as pd
 >>> fs = '\n'.join([
 ...     '# BLASTN 2.2.18+',
 ...     '# Query: gi|1786181|gb|AE000111.1|AE000111',
@@ -951,9 +951,9 @@ 

Examples

Suppose we have a legacy BLAST 9 file:

-
>>> from io import StringIO
->>> import skbio.io
->>> import pandas as pd
+
 

We can use the following code to read the clustal file into a TabularMSA:

-
>>> from skbio import TabularMSA, RNA
+

We can use the following code to write a TabularMSA to a clustal-formatted file:

-
>>> from io import StringIO
->>> from skbio import DNA
+
>>> from io import StringIO
+>>> from skbio import DNA
 >>> seqs = [DNA('ACCGTTGTA-GTAGCT', metadata={'id': 'seq1'}),
 ...         DNA('A--GTCGAA-GTACCT', metadata={'id': 'sequence-2'}),
 ...         DNA('AGAGTTGAAGGTATCT', metadata={'id': '3'})]
@@ -923,7 +923,7 @@ 

References - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.io.format.embed.html b/docs/dev/generated/skbio.io.format.embed.html index 36d3830f9..fd419bc35 100644 --- a/docs/dev/generated/skbio.io.format.embed.html +++ b/docs/dev/generated/skbio.io.format.embed.html @@ -30,7 +30,7 @@ - + @@ -770,7 +770,7 @@

Examples Note that the embedding from implicitly gets the .write method from the IO registry. This ByteIO object can be a file path in a regular use case.

-
>>> import io, skbio
+
>>> import io, skbio
 >>> f = io.BytesIO()
 >>> skbio.embedding.example_protein_embedding.write(f)  
 <_io.BytesIO object at ...>
@@ -871,7 +871,7 @@ 

Examples diff --git a/docs/dev/generated/skbio.io.format.embl.html b/docs/dev/generated/skbio.io.format.embl.html index e8b4137ae..276ce8ba2 100644 --- a/docs/dev/generated/skbio.io.format.embl.html +++ b/docs/dev/generated/skbio.io.format.embl.html @@ -30,7 +30,7 @@ - + @@ -885,8 +885,8 @@

Reading EMBL FilesDNA object:

-
>>> import io
->>> from skbio import DNA, RNA, Sequence
+
>>> import io
+>>> from skbio import DNA, RNA, Sequence
 >>> embl = io.StringIO(embl_str)
 >>> dna_seq = DNA.read(embl)
 >>> dna_seq
@@ -967,7 +967,7 @@ 

Reading EMBL Files#

Soppose we have an EMBL file with multiple records: we can instantiate a generator object to deal with multiple records

-
>>> import skbio
+
>>> import skbio
 >>> embl = io.StringIO(embl_str)
 >>> embl_gen = skbio.io.read(embl, format="embl")
 >>> dna_seq = next(embl_gen)
@@ -1089,7 +1089,7 @@ 

References - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.io.format.fasta.html b/docs/dev/generated/skbio.io.format.fasta.html index bf687b02d..5edfe3346 100644 --- a/docs/dev/generated/skbio.io.format.fasta.html +++ b/docs/dev/generated/skbio.io.format.fasta.html @@ -30,7 +30,7 @@ - + @@ -1039,7 +1039,7 @@

Reading and Writing FASTA FilesTabularMSA object:

-
>>> from skbio import TabularMSA, DNA
+
>>> from skbio import TabularMSA, DNA
 >>> msa = TabularMSA.read(fl, constructor=DNA)
 >>> msa
 TabularMSA[DNA]
@@ -1058,7 +1058,7 @@ 

Reading and Writing FASTA Filesread call. The FASTA sniffer detected the correct file format for us!

To write the TabularMSA in FASTA format:

-
>>> from io import StringIO
+
>>> from io import StringIO
 >>> with StringIO() as fh:
 ...     print(msa.write(fh).getvalue())
 >seq1 Turkey
@@ -1081,7 +1081,7 @@ 

Reading and Writing FASTA Filesconstructor is supplied) one at a time, instead of loading all sequences into memory. For example, let’s use the generator-based reader to process a single sequence at a time in a for loop:

-
>>> import skbio.io
+
>>> import skbio.io
 >>> for seq in skbio.io.read(fl, format='fasta'):
 ...     seq
 ...     print('')
@@ -1137,7 +1137,7 @@ 

Reading and Writing FASTA FilesSequence (or subclass):

-
>>> from skbio import Sequence
+
>>> from skbio import Sequence
 >>> seq = Sequence.read(fl)
 >>> seq
 Sequence
@@ -1297,9 +1297,9 @@ 

Reading multi-FASTA FilesDNA object in a list. We’ll be using io.StringIO to make a mock FASTA file in memory.

-
>>> from io import StringIO
->>> import skbio
->>> from skbio.sequence import DNA
+
>>> from io import StringIO
+>>> import skbio
+>>> from skbio.sequence import DNA
 >>> fl = ">seq1 Turkey\n" +\
 ...      "AAGCTNGGGCATTTCAGGGTGAGCCCGGGCAATACAGGGTAT\n" +\
 ...      ">seq2 Salmo gair\n" +\
@@ -1492,7 +1492,7 @@ 

References - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.io.format.fastq.html b/docs/dev/generated/skbio.io.format.fastq.html index 0dfa871ef..458219a60 100644 --- a/docs/dev/generated/skbio.io.format.fastq.html +++ b/docs/dev/generated/skbio.io.format.fastq.html @@ -30,7 +30,7 @@ - + @@ -925,7 +925,7 @@

Examples

Let’s define this file in-memory as a StringIO, though this could be a real file path, file handle, or anything that’s supported by scikit-bio’s I/O registry in practice:

-
>>> from io import StringIO
+
 

To load the sequences into a TabularMSA, we run:

-
>>> from skbio import TabularMSA, DNA
+
>>> from skbio import TabularMSA, DNA
 >>> msa = TabularMSA.read(fh, constructor=DNA, variant='sanger')
 >>> msa
 TabularMSA[DNA]
@@ -1105,7 +1105,7 @@ 

References - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.io.format.genbank.html b/docs/dev/generated/skbio.io.format.genbank.html index 507e028b6..4d154387b 100644 --- a/docs/dev/generated/skbio.io.format.genbank.html +++ b/docs/dev/generated/skbio.io.format.genbank.html @@ -30,7 +30,7 @@ - + @@ -951,8 +951,8 @@

Reading and Writing GenBank FilesDNA object:

-
>>> import io
->>> from skbio import DNA, RNA, Sequence
+
>>> import io
+>>> from skbio import DNA, RNA, Sequence
 >>> gb = io.StringIO(gb_str)
 >>> dna_seq = DNA.read(gb)
 >>> dna_seq
@@ -1164,7 +1164,7 @@ 

References - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.io.format.gff3.html b/docs/dev/generated/skbio.io.format.gff3.html index 2a462e3ee..f6ddd75ae 100644 --- a/docs/dev/generated/skbio.io.format.gff3.html +++ b/docs/dev/generated/skbio.io.format.gff3.html @@ -30,7 +30,7 @@ - + @@ -770,7 +770,7 @@

Writer-specific Parameters

Examples#

Let’s create a file stream with following data in GFF3 format:

-
>>> from skbio import Sequence, DNA
+
@@ -975,7 +975,7 @@ 

References - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.io.format.lsmat.html b/docs/dev/generated/skbio.io.format.lsmat.html index 75e9c0ef7..f1eaa2f80 100644 --- a/docs/dev/generated/skbio.io.format.lsmat.html +++ b/docs/dev/generated/skbio.io.format.lsmat.html @@ -30,7 +30,7 @@ - + @@ -841,7 +841,7 @@

Format Parameters - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.io.format.newick.html b/docs/dev/generated/skbio.io.format.newick.html index 20a4dcd67..3352b2726 100644 --- a/docs/dev/generated/skbio.io.format.newick.html +++ b/docs/dev/generated/skbio.io.format.newick.html @@ -30,7 +30,7 @@ - + @@ -861,9 +861,9 @@

Format Parameters

Examples#

This is a simple Newick string.

-
>>> from io import StringIO
->>> from skbio import read
->>> from skbio.tree import TreeNode
+
 

Load the ordination results from the file:

-
>>> from io import StringIO
->>> from skbio import OrdinationResults
+
>>> from io import StringIO
+>>> from skbio import OrdinationResults
 >>> or_f = StringIO(
 ...  "Eigvals\t4\n"
 ...  "0.36\t0.18\t0.07\t0.08\n"
@@ -948,7 +948,7 @@ 

Examples diff --git a/docs/dev/generated/skbio.io.format.phylip.html b/docs/dev/generated/skbio.io.format.phylip.html index 702078309..7c4f1d2be 100644 --- a/docs/dev/generated/skbio.io.format.phylip.html +++ b/docs/dev/generated/skbio.io.format.phylip.html @@ -30,7 +30,7 @@ - + @@ -829,7 +829,7 @@

Format Parameters

Examples#

Let’s create a TabularMSA with three DNA sequences:

-
>>> from skbio import TabularMSA, DNA
+
>>> from skbio import TabularMSA, DNA
 >>> seqs = [DNA('ACCGTTGTA-GTAGCT', metadata={'id':'seq1'}),
 ...         DNA('A--GTCGAA-GTACCT', metadata={'id':'sequence-2'}),
 ...         DNA('AGAGTTGAAGGTATCT', metadata={'id':'3'})]
@@ -850,7 +850,7 @@ 

Examples

Now let’s write the TabularMSA to file in PHYLIP format and take a look at the output:

-
>>> from io import StringIO
+
>>> from io import StringIO
 >>> fh = StringIO()
 >>> print(msa.write(fh, format='phylip').getvalue())
 3 16
@@ -1010,7 +1010,7 @@ 

References - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.io.format.qseq.html b/docs/dev/generated/skbio.io.format.qseq.html index 35af5c099..bfae3ec6b 100644 --- a/docs/dev/generated/skbio.io.format.qseq.html +++ b/docs/dev/generated/skbio.io.format.qseq.html @@ -30,7 +30,7 @@ - + @@ -798,7 +798,7 @@

Examples

Let’s define this file in-memory as a StringIO, though this could be a real file path, file handle, or anything that’s supported by scikit-bio’s I/O registry in practice:

-
>>> from io import StringIO
+
 

To iterate over the sequences using the generator reader, we run:

-
>>> import skbio.io
+
>>> import skbio.io
 >>> for seq in skbio.io.read(fh, format='qseq', variant='illumina1.3'):
 ...     seq
 ...     print('')
@@ -949,7 +949,7 @@ 

References - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.io.format.sample_metadata.html b/docs/dev/generated/skbio.io.format.sample_metadata.html index 8eeaa1d80..4ad4b78b2 100644 --- a/docs/dev/generated/skbio.io.format.sample_metadata.html +++ b/docs/dev/generated/skbio.io.format.sample_metadata.html @@ -30,7 +30,7 @@ - + @@ -1018,7 +1018,7 @@

Number Formatting - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.io.format.stockholm.html b/docs/dev/generated/skbio.io.format.stockholm.html index 0f67043da..7736114bf 100644 --- a/docs/dev/generated/skbio.io.format.stockholm.html +++ b/docs/dev/generated/skbio.io.format.stockholm.html @@ -30,7 +30,7 @@ - + @@ -968,9 +968,9 @@

Format Parameters#

Suppose we have a Stockholm file containing an MSA of protein sequences (modified from [2]):

-
>>> import skbio.io
->>> from io import StringIO
->>> from skbio import Protein, TabularMSA
+
>>> import skbio.io
+>>> from io import StringIO
+>>> from skbio import Protein, TabularMSA
 >>> fs = '\n'.join([
 ...         '# STOCKHOLM 1.0',
 ...         '#=GF CC CBS domains are small intracellular modules mostly'
@@ -1191,7 +1191,7 @@ 

References - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.io.format.taxdump.html b/docs/dev/generated/skbio.io.format.taxdump.html index ffb45ae81..bd67c95fc 100644 --- a/docs/dev/generated/skbio.io.format.taxdump.html +++ b/docs/dev/generated/skbio.io.format.taxdump.html @@ -30,7 +30,7 @@ - + @@ -953,9 +953,9 @@

Format Parameters

Examples#

-
>>> from io import StringIO
->>> import skbio.io
->>> import pandas as pd
+
>>> from io import StringIO
+>>> import skbio.io
+>>> import pandas as pd
 >>> fs = '\n'.join([
 ...     '1\t|\t1\t|\tno rank\t|',
 ...     '2\t|\t131567\t|\tsuperkingdom\t|',
@@ -1108,7 +1108,7 @@ 

References - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.io.registry.Format.html b/docs/dev/generated/skbio.io.registry.Format.html index ea37cddeb..0459c17e9 100644 --- a/docs/dev/generated/skbio.io.registry.Format.html +++ b/docs/dev/generated/skbio.io.registry.Format.html @@ -31,7 +31,7 @@ - + @@ -907,7 +907,7 @@

skbio.io.registry.Format - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.io.registry.Format.reader.html b/docs/dev/generated/skbio.io.registry.Format.reader.html index 70532ba31..971028c21 100644 --- a/docs/dev/generated/skbio.io.registry.Format.reader.html +++ b/docs/dev/generated/skbio.io.registry.Format.reader.html @@ -31,7 +31,7 @@ - + @@ -734,20 +734,20 @@

skbio.io.registry.Format.readerExamples

-
>>> from skbio.io.registry import Format, io_registry
->>> from skbio.io.registry import Read, Write
+
>>> from skbio.io.registry import Format, io_registry
+>>> from skbio.io.registry import Read, Write
 >>> myformat = Format('myformat')
 >>> io_registry.add_format(myformat)
 >>> # If developing a new format for skbio, use the create_format()
 >>> # factory instead of the above.
->>> class MyObject:
+>>> class MyObject:
 ...     read = Read()
 ...     write = Write()
-...     def __init__(self, content):
+...     def __init__(self, content):
 ...         self.content = content
 ...
 >>> @myformat.reader(MyObject)
-... def myformat_reader(fh):
+... def myformat_reader(fh):
 ...     return MyObject(fh.readlines()[1:])
 ...
 >>> MyObject.read(["myformat2\n", "some content here!\n"],
@@ -837,7 +837,7 @@ 

skbio.io.registry.Format.reader - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.io.registry.Format.sniffer.html b/docs/dev/generated/skbio.io.registry.Format.sniffer.html index d4c93b5c3..a7adca425 100644 --- a/docs/dev/generated/skbio.io.registry.Format.sniffer.html +++ b/docs/dev/generated/skbio.io.registry.Format.sniffer.html @@ -31,7 +31,7 @@ - + @@ -735,12 +735,12 @@

skbio.io.registry.Format.snifferExamples

-
>>> from skbio.io.registry import Format
+
>>> from skbio.io.registry import Format
 >>> # If developing a new format for skbio, use the create_format()
 >>> # factory instead of this constructor.
 >>> myformat = Format('myformat')
 >>> @myformat.sniffer()
-... def myformat_sniffer(fh):
+... def myformat_sniffer(fh):
 ...     check = fh.read(8) == "myformat"
 ...     if check:
 ...         version = int(fh.read(1))
@@ -833,7 +833,7 @@ 

skbio.io.registry.Format.sniffer - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.io.registry.Format.writer.html b/docs/dev/generated/skbio.io.registry.Format.writer.html index 72d263906..7f5782178 100644 --- a/docs/dev/generated/skbio.io.registry.Format.writer.html +++ b/docs/dev/generated/skbio.io.registry.Format.writer.html @@ -31,7 +31,7 @@ - + @@ -735,21 +735,21 @@

skbio.io.registry.Format.writerExamples

-
>>> from skbio.io.registry import Format, io_registry
->>> from skbio.io.registry import Read, Write
+
>>> from skbio.io.registry import Format, io_registry
+>>> from skbio.io.registry import Read, Write
 >>> myformat = Format('myformat')
 >>> io_registry.add_format(myformat)
 >>> # If developing a new format for skbio, use the create_format()
 >>> # factory instead of the above.
->>> class MyObject:
+>>> class MyObject:
 ...     default_write_format = 'myformat'
 ...     read = Read()
 ...     write = Write()
-...     def __init__(self, content):
+...     def __init__(self, content):
 ...         self.content = content
 ...
 >>> @myformat.writer(MyObject)
-... def myformat_reader(obj, fh):
+... def myformat_reader(obj, fh):
 ...     fh.write("myformat2\n")
 ...     for c in obj.content:
 ...         fh.write(c)
@@ -841,7 +841,7 @@ 

skbio.io.registry.Format.writer - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.io.registry.IORegistry.add_format.html b/docs/dev/generated/skbio.io.registry.IORegistry.add_format.html index c7247a8c9..40c1a2ce5 100644 --- a/docs/dev/generated/skbio.io.registry.IORegistry.add_format.html +++ b/docs/dev/generated/skbio.io.registry.IORegistry.add_format.html @@ -31,7 +31,7 @@ - + @@ -795,7 +795,7 @@

skbio.io.registry.IORegistry.add_format - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.io.registry.IORegistry.create_format.html b/docs/dev/generated/skbio.io.registry.IORegistry.create_format.html index 6b91e34f5..e1c6960e6 100644 --- a/docs/dev/generated/skbio.io.registry.IORegistry.create_format.html +++ b/docs/dev/generated/skbio.io.registry.IORegistry.create_format.html @@ -31,7 +31,7 @@ - + @@ -798,7 +798,7 @@

skbio.io.registry.IORegistry.create_format - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.io.registry.IORegistry.get_reader.html b/docs/dev/generated/skbio.io.registry.IORegistry.get_reader.html index 05147665d..7bd0723ef 100644 --- a/docs/dev/generated/skbio.io.registry.IORegistry.get_reader.html +++ b/docs/dev/generated/skbio.io.registry.IORegistry.get_reader.html @@ -31,7 +31,7 @@ - + @@ -805,7 +805,7 @@

skbio.io.registry.IORegistry.get_reader - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.io.registry.IORegistry.get_sniffer.html b/docs/dev/generated/skbio.io.registry.IORegistry.get_sniffer.html index 2483fb5bc..2ba78f501 100644 --- a/docs/dev/generated/skbio.io.registry.IORegistry.get_sniffer.html +++ b/docs/dev/generated/skbio.io.registry.IORegistry.get_sniffer.html @@ -31,7 +31,7 @@ - + @@ -801,7 +801,7 @@

skbio.io.registry.IORegistry.get_sniffer - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.io.registry.IORegistry.get_writer.html b/docs/dev/generated/skbio.io.registry.IORegistry.get_writer.html index d541d30d6..5ac44c83d 100644 --- a/docs/dev/generated/skbio.io.registry.IORegistry.get_writer.html +++ b/docs/dev/generated/skbio.io.registry.IORegistry.get_writer.html @@ -31,7 +31,7 @@ - + @@ -805,7 +805,7 @@

skbio.io.registry.IORegistry.get_writer - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.io.registry.IORegistry.html b/docs/dev/generated/skbio.io.registry.IORegistry.html index e1f5afdbe..01668a8b4 100644 --- a/docs/dev/generated/skbio.io.registry.IORegistry.html +++ b/docs/dev/generated/skbio.io.registry.IORegistry.html @@ -31,7 +31,7 @@ - + @@ -857,7 +857,7 @@

skbio.io.registry.IORegistry - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.io.registry.IORegistry.list_read_formats.html b/docs/dev/generated/skbio.io.registry.IORegistry.list_read_formats.html index 3000bd0c0..ac26167f1 100644 --- a/docs/dev/generated/skbio.io.registry.IORegistry.list_read_formats.html +++ b/docs/dev/generated/skbio.io.registry.IORegistry.list_read_formats.html @@ -31,7 +31,7 @@ - + @@ -803,7 +803,7 @@

skbio.io.registry.IORegistry.list_read_formats - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.io.registry.IORegistry.list_write_formats.html b/docs/dev/generated/skbio.io.registry.IORegistry.list_write_formats.html index 95dd770f2..7f0f067d2 100644 --- a/docs/dev/generated/skbio.io.registry.IORegistry.list_write_formats.html +++ b/docs/dev/generated/skbio.io.registry.IORegistry.list_write_formats.html @@ -31,7 +31,7 @@ - + @@ -803,7 +803,7 @@

skbio.io.registry.IORegistry.list_write_formats - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.io.registry.IORegistry.read.html b/docs/dev/generated/skbio.io.registry.IORegistry.read.html index 6405eec18..1436fcfc5 100644 --- a/docs/dev/generated/skbio.io.registry.IORegistry.read.html +++ b/docs/dev/generated/skbio.io.registry.IORegistry.read.html @@ -31,7 +31,7 @@ - + @@ -829,7 +829,7 @@

skbio.io.registry.IORegistry.read - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.io.registry.IORegistry.remove_format.html b/docs/dev/generated/skbio.io.registry.IORegistry.remove_format.html index 6a551e5ae..bdb155356 100644 --- a/docs/dev/generated/skbio.io.registry.IORegistry.remove_format.html +++ b/docs/dev/generated/skbio.io.registry.IORegistry.remove_format.html @@ -31,7 +31,7 @@ - + @@ -796,7 +796,7 @@

skbio.io.registry.IORegistry.remove_format - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.io.registry.IORegistry.sniff.html b/docs/dev/generated/skbio.io.registry.IORegistry.sniff.html index eb429052f..7ddea5570 100644 --- a/docs/dev/generated/skbio.io.registry.IORegistry.sniff.html +++ b/docs/dev/generated/skbio.io.registry.IORegistry.sniff.html @@ -31,7 +31,7 @@ - + @@ -815,7 +815,7 @@

skbio.io.registry.IORegistry.sniff - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.io.registry.IORegistry.write.html b/docs/dev/generated/skbio.io.registry.IORegistry.write.html index 464915fff..32c4c8432 100644 --- a/docs/dev/generated/skbio.io.registry.IORegistry.write.html +++ b/docs/dev/generated/skbio.io.registry.IORegistry.write.html @@ -31,7 +31,7 @@ - + @@ -815,7 +815,7 @@

skbio.io.registry.IORegistry.write - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.io.registry.create_format.html b/docs/dev/generated/skbio.io.registry.create_format.html index 42cc38e8c..42e7ca184 100644 --- a/docs/dev/generated/skbio.io.registry.create_format.html +++ b/docs/dev/generated/skbio.io.registry.create_format.html @@ -31,7 +31,7 @@ - + @@ -795,7 +795,7 @@

skbio.io.registry.create_format - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.io.registry.html b/docs/dev/generated/skbio.io.registry.html index 7696ececb..f49ae6770 100644 --- a/docs/dev/generated/skbio.io.registry.html +++ b/docs/dev/generated/skbio.io.registry.html @@ -30,7 +30,7 @@ - + @@ -751,7 +751,7 @@

Creating a new format for scikit-biocreate_format() as your file name. For example:

-
from skbio.io import create_format
+
from skbio.io import create_format
 
 myformat = create_format('myformat')
 
@@ -774,14 +774,14 @@

Creating a new format for scikit-bio
@myformat.sniffer()
-def _myformat_sniffer(fh):
+def _myformat_sniffer(fh):
     # do something with `fh` to determine the membership of the file
 

For futher details on sniffer functions see Format.sniffer().

Creating a reader is very similar, but has one difference:

@myformat.reader(SomeSkbioClass)
-def _myformat_to_some_skbio_class(fh, kwarg1='default', extra=FileSentinel):
+def _myformat_to_some_skbio_class(fh, kwarg1='default', extra=FileSentinel):
     # parse `fh` and return a SomeSkbioClass instance here
     # `extra` will also be an open filehandle if provided else None
 
@@ -792,7 +792,7 @@

Creating a new format for scikit-bioFormat.reader().

Creating a writer is about the same:

@myformat.writer(SomeSkbioClass)
-def _some_skbio_class_to_myformat(obj, fh, kwarg1='whatever',
+def _some_skbio_class_to_myformat(obj, fh, kwarg1='whatever',
                                   extra=FileSentinel):
     # write the contents of `obj` into `fh` and whatever else into `extra`
     # do not return anything, it will be ignored
@@ -928,7 +928,7 @@ 

Reserved Keyword Arguments - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.io.registry.read.html b/docs/dev/generated/skbio.io.registry.read.html index b2dc3bce3..941b30483 100644 --- a/docs/dev/generated/skbio.io.registry.read.html +++ b/docs/dev/generated/skbio.io.registry.read.html @@ -31,7 +31,7 @@ - + @@ -818,7 +818,7 @@

skbio.io.registry.read - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.io.registry.sniff.html b/docs/dev/generated/skbio.io.registry.sniff.html index 9430ca39f..9317278c3 100644 --- a/docs/dev/generated/skbio.io.registry.sniff.html +++ b/docs/dev/generated/skbio.io.registry.sniff.html @@ -31,7 +31,7 @@ - + @@ -804,7 +804,7 @@

skbio.io.registry.sniff - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.io.registry.write.html b/docs/dev/generated/skbio.io.registry.write.html index 899bcd295..c4c8ec204 100644 --- a/docs/dev/generated/skbio.io.registry.write.html +++ b/docs/dev/generated/skbio.io.registry.write.html @@ -31,7 +31,7 @@ - + @@ -804,7 +804,7 @@

skbio.io.registry.write - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.io.util.html b/docs/dev/generated/skbio.io.util.html index c4503f7b7..f88898f0b 100644 --- a/docs/dev/generated/skbio.io.util.html +++ b/docs/dev/generated/skbio.io.util.html @@ -30,7 +30,7 @@ - + @@ -792,7 +792,7 @@

Functions - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.io.util.open.html b/docs/dev/generated/skbio.io.util.open.html index 1992060f9..8ffa7ea85 100644 --- a/docs/dev/generated/skbio.io.util.open.html +++ b/docs/dev/generated/skbio.io.util.open.html @@ -31,7 +31,7 @@ - + @@ -910,7 +910,7 @@

skbio.io.util.open - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.io.util.open_file.html b/docs/dev/generated/skbio.io.util.open_file.html index 0e826ed85..9aced5997 100644 --- a/docs/dev/generated/skbio.io.util.open_file.html +++ b/docs/dev/generated/skbio.io.util.open_file.html @@ -31,7 +31,7 @@ - + @@ -811,7 +811,7 @@

skbio.io.util.open_file - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.io.util.open_files.html b/docs/dev/generated/skbio.io.util.open_files.html index 92fdddd18..b18065737 100644 --- a/docs/dev/generated/skbio.io.util.open_files.html +++ b/docs/dev/generated/skbio.io.util.open_files.html @@ -31,7 +31,7 @@ - + @@ -785,7 +785,7 @@

skbio.io.util.open_files - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.metadata.CategoricalMetadataColumn.html b/docs/dev/generated/skbio.metadata.CategoricalMetadataColumn.html index d6c27cf77..fb77bb8fa 100644 --- a/docs/dev/generated/skbio.metadata.CategoricalMetadataColumn.html +++ b/docs/dev/generated/skbio.metadata.CategoricalMetadataColumn.html @@ -31,7 +31,7 @@ - + @@ -869,7 +869,7 @@

skbio.metadata.CategoricalMetadataColumn - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.metadata.Interval.drop.html b/docs/dev/generated/skbio.metadata.Interval.drop.html index f96f6cdf1..450b9a02c 100644 --- a/docs/dev/generated/skbio.metadata.Interval.drop.html +++ b/docs/dev/generated/skbio.metadata.Interval.drop.html @@ -31,7 +31,7 @@ - + @@ -773,7 +773,7 @@

skbio.metadata.Interval.drop - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.metadata.Interval.html b/docs/dev/generated/skbio.metadata.Interval.html index 93105ed87..574f1e900 100644 --- a/docs/dev/generated/skbio.metadata.Interval.html +++ b/docs/dev/generated/skbio.metadata.Interval.html @@ -31,7 +31,7 @@ - + @@ -739,7 +739,7 @@

skbio.metadata.Interval

We can create an Interval object to represent the exons of the gene:

-
>>> from skbio.metadata import Interval, IntervalMetadata
+
>>> from skbio.metadata import Interval, IntervalMetadata
 >>> interval_metadata = IntervalMetadata(10)
 
@@ -1000,7 +1000,7 @@

skbio.metadata.Interval - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.metadata.IntervalMetadata.add.html b/docs/dev/generated/skbio.metadata.IntervalMetadata.add.html index ee575df58..c30c5ddcd 100644 --- a/docs/dev/generated/skbio.metadata.IntervalMetadata.add.html +++ b/docs/dev/generated/skbio.metadata.IntervalMetadata.add.html @@ -31,7 +31,7 @@ - + @@ -800,7 +800,7 @@

skbio.metadata.IntervalMetadata.add - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.metadata.IntervalMetadata.concat.html b/docs/dev/generated/skbio.metadata.IntervalMetadata.concat.html index 9a8e41d8d..5c8209337 100644 --- a/docs/dev/generated/skbio.metadata.IntervalMetadata.concat.html +++ b/docs/dev/generated/skbio.metadata.IntervalMetadata.concat.html @@ -31,7 +31,7 @@ - + @@ -712,7 +712,7 @@

skbio.metadata.IntervalMetadata.concatExamples

-
>>> from skbio.metadata import IntervalMetadata
+
>>> from skbio.metadata import IntervalMetadata
 

Create two IntervalMetadata objects:

@@ -816,7 +816,7 @@

skbio.metadata.IntervalMetadata.concat - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.metadata.IntervalMetadata.drop.html b/docs/dev/generated/skbio.metadata.IntervalMetadata.drop.html index d9fba66b2..c1d047c7e 100644 --- a/docs/dev/generated/skbio.metadata.IntervalMetadata.drop.html +++ b/docs/dev/generated/skbio.metadata.IntervalMetadata.drop.html @@ -31,7 +31,7 @@ - + @@ -784,7 +784,7 @@

skbio.metadata.IntervalMetadata.drop - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.metadata.IntervalMetadata.html b/docs/dev/generated/skbio.metadata.IntervalMetadata.html index 661fd015d..3a4dc9824 100644 --- a/docs/dev/generated/skbio.metadata.IntervalMetadata.html +++ b/docs/dev/generated/skbio.metadata.IntervalMetadata.html @@ -31,7 +31,7 @@ - + @@ -731,7 +731,7 @@

skbio.metadata.IntervalMetadataExamples

Let’s say we have a sequence of length 10 and want to add annotation to it. Create an IntervalMetadata object:

-
>>> from skbio.metadata import Interval, IntervalMetadata
+
>>> from skbio.metadata import Interval, IntervalMetadata
 >>> im = IntervalMetadata(10)
 
@@ -1075,7 +1075,7 @@

skbio.metadata.IntervalMetadata - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.metadata.IntervalMetadata.merge.html b/docs/dev/generated/skbio.metadata.IntervalMetadata.merge.html index 0527ca9fd..4d39621ac 100644 --- a/docs/dev/generated/skbio.metadata.IntervalMetadata.merge.html +++ b/docs/dev/generated/skbio.metadata.IntervalMetadata.merge.html @@ -31,7 +31,7 @@ - + @@ -789,7 +789,7 @@

skbio.metadata.IntervalMetadata.merge - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.metadata.IntervalMetadata.query.html b/docs/dev/generated/skbio.metadata.IntervalMetadata.query.html index 4425eeba3..f85bc1eff 100644 --- a/docs/dev/generated/skbio.metadata.IntervalMetadata.query.html +++ b/docs/dev/generated/skbio.metadata.IntervalMetadata.query.html @@ -31,7 +31,7 @@ - + @@ -799,7 +799,7 @@

skbio.metadata.IntervalMetadata.query - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.metadata.IntervalMetadata.read.html b/docs/dev/generated/skbio.metadata.IntervalMetadata.read.html index c57b0b724..fe3f62c1d 100644 --- a/docs/dev/generated/skbio.metadata.IntervalMetadata.read.html +++ b/docs/dev/generated/skbio.metadata.IntervalMetadata.read.html @@ -31,7 +31,7 @@ - + @@ -808,7 +808,7 @@

skbio.metadata.IntervalMetadata.read - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.metadata.IntervalMetadata.sort.html b/docs/dev/generated/skbio.metadata.IntervalMetadata.sort.html index 67f4d3ece..b65d4335d 100644 --- a/docs/dev/generated/skbio.metadata.IntervalMetadata.sort.html +++ b/docs/dev/generated/skbio.metadata.IntervalMetadata.sort.html @@ -31,7 +31,7 @@ - + @@ -783,7 +783,7 @@

skbio.metadata.IntervalMetadata.sort - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.metadata.IntervalMetadata.write.html b/docs/dev/generated/skbio.metadata.IntervalMetadata.write.html index 5df3804e3..ff66bdfd9 100644 --- a/docs/dev/generated/skbio.metadata.IntervalMetadata.write.html +++ b/docs/dev/generated/skbio.metadata.IntervalMetadata.write.html @@ -31,7 +31,7 @@ - + @@ -801,7 +801,7 @@

skbio.metadata.IntervalMetadata.write - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.metadata.IntervalMetadataMixin.has_interval_metadata.html b/docs/dev/generated/skbio.metadata.IntervalMetadataMixin.has_interval_metadata.html index 36e11a7c8..eb6004ac1 100644 --- a/docs/dev/generated/skbio.metadata.IntervalMetadataMixin.has_interval_metadata.html +++ b/docs/dev/generated/skbio.metadata.IntervalMetadataMixin.has_interval_metadata.html @@ -31,7 +31,7 @@ - + @@ -774,7 +774,7 @@

skbio.metadata.IntervalMetadataMixin.has_interval_metadata - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.metadata.IntervalMetadataMixin.html b/docs/dev/generated/skbio.metadata.IntervalMetadataMixin.html index 013b32c79..ba0854367 100644 --- a/docs/dev/generated/skbio.metadata.IntervalMetadataMixin.html +++ b/docs/dev/generated/skbio.metadata.IntervalMetadataMixin.html @@ -31,7 +31,7 @@ - + @@ -860,7 +860,7 @@

skbio.metadata.IntervalMetadataMixin - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.metadata.MetadataColumn.drop_missing_values.html b/docs/dev/generated/skbio.metadata.MetadataColumn.drop_missing_values.html index 9d1cfb4e1..eb45f05f3 100644 --- a/docs/dev/generated/skbio.metadata.MetadataColumn.drop_missing_values.html +++ b/docs/dev/generated/skbio.metadata.MetadataColumn.drop_missing_values.html @@ -31,7 +31,7 @@ - + @@ -786,7 +786,7 @@

skbio.metadata.MetadataColumn.drop_missing_values - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.metadata.MetadataColumn.filter_ids.html b/docs/dev/generated/skbio.metadata.MetadataColumn.filter_ids.html index eaf0fd868..ccf3d2a41 100644 --- a/docs/dev/generated/skbio.metadata.MetadataColumn.filter_ids.html +++ b/docs/dev/generated/skbio.metadata.MetadataColumn.filter_ids.html @@ -31,7 +31,7 @@ - + @@ -797,7 +797,7 @@

skbio.metadata.MetadataColumn.filter_ids - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.metadata.MetadataColumn.get_ids.html b/docs/dev/generated/skbio.metadata.MetadataColumn.get_ids.html index 15ee905b7..10fa6b5d6 100644 --- a/docs/dev/generated/skbio.metadata.MetadataColumn.get_ids.html +++ b/docs/dev/generated/skbio.metadata.MetadataColumn.get_ids.html @@ -31,7 +31,7 @@ - + @@ -796,7 +796,7 @@

skbio.metadata.MetadataColumn.get_ids - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.metadata.MetadataColumn.get_missing.html b/docs/dev/generated/skbio.metadata.MetadataColumn.get_missing.html index 96d2c3e1e..26f9df12f 100644 --- a/docs/dev/generated/skbio.metadata.MetadataColumn.get_missing.html +++ b/docs/dev/generated/skbio.metadata.MetadataColumn.get_missing.html @@ -31,7 +31,7 @@ - + @@ -773,7 +773,7 @@

skbio.metadata.MetadataColumn.get_missing - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.metadata.MetadataColumn.get_value.html b/docs/dev/generated/skbio.metadata.MetadataColumn.get_value.html index fe2eb7925..cf680c373 100644 --- a/docs/dev/generated/skbio.metadata.MetadataColumn.get_value.html +++ b/docs/dev/generated/skbio.metadata.MetadataColumn.get_value.html @@ -31,7 +31,7 @@ - + @@ -785,7 +785,7 @@

skbio.metadata.MetadataColumn.get_value - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.metadata.MetadataColumn.has_missing_values.html b/docs/dev/generated/skbio.metadata.MetadataColumn.has_missing_values.html index 678460e19..393a5e795 100644 --- a/docs/dev/generated/skbio.metadata.MetadataColumn.has_missing_values.html +++ b/docs/dev/generated/skbio.metadata.MetadataColumn.has_missing_values.html @@ -31,7 +31,7 @@ - + @@ -787,7 +787,7 @@

skbio.metadata.MetadataColumn.has_missing_values - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.metadata.MetadataColumn.html b/docs/dev/generated/skbio.metadata.MetadataColumn.html index 03650474a..732bca475 100644 --- a/docs/dev/generated/skbio.metadata.MetadataColumn.html +++ b/docs/dev/generated/skbio.metadata.MetadataColumn.html @@ -31,7 +31,7 @@ - + @@ -1001,7 +1001,7 @@

skbio.metadata.MetadataColumn - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.metadata.MetadataColumn.to_dataframe.html b/docs/dev/generated/skbio.metadata.MetadataColumn.to_dataframe.html index 09a9036cb..c8b4682bd 100644 --- a/docs/dev/generated/skbio.metadata.MetadataColumn.to_dataframe.html +++ b/docs/dev/generated/skbio.metadata.MetadataColumn.to_dataframe.html @@ -31,7 +31,7 @@ - + @@ -796,7 +796,7 @@

skbio.metadata.MetadataColumn.to_dataframe - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.metadata.MetadataColumn.to_series.html b/docs/dev/generated/skbio.metadata.MetadataColumn.to_series.html index 7d61f8e71..4a3d8778c 100644 --- a/docs/dev/generated/skbio.metadata.MetadataColumn.to_series.html +++ b/docs/dev/generated/skbio.metadata.MetadataColumn.to_series.html @@ -31,7 +31,7 @@ - + @@ -795,7 +795,7 @@

skbio.metadata.MetadataColumn.to_series - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.metadata.MetadataMixin.has_metadata.html b/docs/dev/generated/skbio.metadata.MetadataMixin.has_metadata.html index 980718e72..3de9aeba8 100644 --- a/docs/dev/generated/skbio.metadata.MetadataMixin.has_metadata.html +++ b/docs/dev/generated/skbio.metadata.MetadataMixin.has_metadata.html @@ -31,7 +31,7 @@ - + @@ -703,7 +703,7 @@

skbio.metadata.MetadataMixin.has_metadata
>>> from skbio import Sequence
+
>>> from skbio import Sequence
 >>> seq = Sequence('ACGT')
 >>> seq.has_metadata()
 False
@@ -795,7 +795,7 @@ 

skbio.metadata.MetadataMixin.has_metadata - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.metadata.MetadataMixin.html b/docs/dev/generated/skbio.metadata.MetadataMixin.html index baa3866af..e58bae5d6 100644 --- a/docs/dev/generated/skbio.metadata.MetadataMixin.html +++ b/docs/dev/generated/skbio.metadata.MetadataMixin.html @@ -31,7 +31,7 @@ - + @@ -758,7 +758,7 @@

skbio.metadata.MetadataMixin
>>> from skbio import Sequence
+
>>> from skbio import Sequence
 >>> seq = Sequence('ACGT', metadata={'description': 'seq description',
 ...                                  'id': 'seq-id'})
 
@@ -902,7 +902,7 @@

skbio.metadata.MetadataMixin - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.metadata.NumericMetadataColumn.html b/docs/dev/generated/skbio.metadata.NumericMetadataColumn.html index 3020a8cea..2d2ef2479 100644 --- a/docs/dev/generated/skbio.metadata.NumericMetadataColumn.html +++ b/docs/dev/generated/skbio.metadata.NumericMetadataColumn.html @@ -31,7 +31,7 @@ - + @@ -869,7 +869,7 @@

skbio.metadata.NumericMetadataColumn - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.metadata.PositionalMetadataMixin.has_positional_metadata.html b/docs/dev/generated/skbio.metadata.PositionalMetadataMixin.has_positional_metadata.html index 737111f5c..be782067b 100644 --- a/docs/dev/generated/skbio.metadata.PositionalMetadataMixin.has_positional_metadata.html +++ b/docs/dev/generated/skbio.metadata.PositionalMetadataMixin.has_positional_metadata.html @@ -31,7 +31,7 @@ - + @@ -703,8 +703,8 @@

skbio.metadata.PositionalMetadataMixin.has_positional_metadata

- © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.metadata.PositionalMetadataMixin.html b/docs/dev/generated/skbio.metadata.PositionalMetadataMixin.html index 7a86bdff6..3461b169f 100644 --- a/docs/dev/generated/skbio.metadata.PositionalMetadataMixin.html +++ b/docs/dev/generated/skbio.metadata.PositionalMetadataMixin.html @@ -31,7 +31,7 @@ - + @@ -759,7 +759,7 @@

skbio.metadata.PositionalMetadataMixin
>>> from skbio import DNA
+
>>> from skbio import DNA
 >>> seq = DNA(
 ...     'ACGT',
 ...     positional_metadata={'exons': [True, True, False, True],
@@ -932,7 +932,7 @@ 

skbio.metadata.PositionalMetadataMixin - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.metadata.SampleMetadata.filter_columns.html b/docs/dev/generated/skbio.metadata.SampleMetadata.filter_columns.html index 0f0d57b6c..ac1fe0ad4 100644 --- a/docs/dev/generated/skbio.metadata.SampleMetadata.filter_columns.html +++ b/docs/dev/generated/skbio.metadata.SampleMetadata.filter_columns.html @@ -31,7 +31,7 @@ - + @@ -804,7 +804,7 @@

skbio.metadata.SampleMetadata.filter_columns - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.metadata.SampleMetadata.filter_ids.html b/docs/dev/generated/skbio.metadata.SampleMetadata.filter_ids.html index e8788a6bb..a8f878f34 100644 --- a/docs/dev/generated/skbio.metadata.SampleMetadata.filter_ids.html +++ b/docs/dev/generated/skbio.metadata.SampleMetadata.filter_ids.html @@ -31,7 +31,7 @@ - + @@ -797,7 +797,7 @@

skbio.metadata.SampleMetadata.filter_ids - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.metadata.SampleMetadata.get_column.html b/docs/dev/generated/skbio.metadata.SampleMetadata.get_column.html index 813822746..fd152ce98 100644 --- a/docs/dev/generated/skbio.metadata.SampleMetadata.get_column.html +++ b/docs/dev/generated/skbio.metadata.SampleMetadata.get_column.html @@ -31,7 +31,7 @@ - + @@ -791,7 +791,7 @@

skbio.metadata.SampleMetadata.get_column - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.metadata.SampleMetadata.get_ids.html b/docs/dev/generated/skbio.metadata.SampleMetadata.get_ids.html index a0f10e267..4959f7b92 100644 --- a/docs/dev/generated/skbio.metadata.SampleMetadata.get_ids.html +++ b/docs/dev/generated/skbio.metadata.SampleMetadata.get_ids.html @@ -31,7 +31,7 @@ - + @@ -796,7 +796,7 @@

skbio.metadata.SampleMetadata.get_ids - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.metadata.SampleMetadata.html b/docs/dev/generated/skbio.metadata.SampleMetadata.html index 2f6dcbf25..53c491207 100644 --- a/docs/dev/generated/skbio.metadata.SampleMetadata.html +++ b/docs/dev/generated/skbio.metadata.SampleMetadata.html @@ -31,7 +31,7 @@ - + @@ -1061,7 +1061,7 @@

skbio.metadata.SampleMetadata - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.metadata.SampleMetadata.load.html b/docs/dev/generated/skbio.metadata.SampleMetadata.load.html index 45f509fbb..f6efcc76c 100644 --- a/docs/dev/generated/skbio.metadata.SampleMetadata.load.html +++ b/docs/dev/generated/skbio.metadata.SampleMetadata.load.html @@ -31,7 +31,7 @@ - + @@ -813,7 +813,7 @@

skbio.metadata.SampleMetadata.load - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.metadata.SampleMetadata.merge.html b/docs/dev/generated/skbio.metadata.SampleMetadata.merge.html index 2eeeff14e..7528ca72d 100644 --- a/docs/dev/generated/skbio.metadata.SampleMetadata.merge.html +++ b/docs/dev/generated/skbio.metadata.SampleMetadata.merge.html @@ -31,7 +31,7 @@ - + @@ -807,7 +807,7 @@

skbio.metadata.SampleMetadata.merge - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.metadata.SampleMetadata.to_dataframe.html b/docs/dev/generated/skbio.metadata.SampleMetadata.to_dataframe.html index 64e066939..0fe881055 100644 --- a/docs/dev/generated/skbio.metadata.SampleMetadata.to_dataframe.html +++ b/docs/dev/generated/skbio.metadata.SampleMetadata.to_dataframe.html @@ -31,7 +31,7 @@ - + @@ -791,7 +791,7 @@

skbio.metadata.SampleMetadata.to_dataframe - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.DNA.find_motifs.html b/docs/dev/generated/skbio.sequence.DNA.find_motifs.html index 0f5c904ef..4da2a217e 100644 --- a/docs/dev/generated/skbio.sequence.DNA.find_motifs.html +++ b/docs/dev/generated/skbio.sequence.DNA.find_motifs.html @@ -31,7 +31,7 @@ - + @@ -723,7 +723,7 @@

skbio.sequence.DNA.find_motifsExamples

-
>>> from skbio import DNA
+
>>> from skbio import DNA
 >>> s = DNA('ACGGGGAGGCGGAG')
 >>> for motif_slice in s.find_motifs('purine-run', min_length=2):
 ...     motif_slice
@@ -829,7 +829,7 @@ 

skbio.sequence.DNA.find_motifs - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.DNA.html b/docs/dev/generated/skbio.sequence.DNA.html index bcf8bc7d4..7c9f59f69 100644 --- a/docs/dev/generated/skbio.sequence.DNA.html +++ b/docs/dev/generated/skbio.sequence.DNA.html @@ -31,7 +31,7 @@ - + @@ -830,7 +830,7 @@

skbio.sequence.DNAExamples

-
>>> from skbio import DNA
+
>>> from skbio import DNA
 >>> DNA('ACCGAAT')
 DNA
 --------------------------
@@ -1290,7 +1290,7 @@ 

skbio.sequence.DNA - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.DNA.read.html b/docs/dev/generated/skbio.sequence.DNA.read.html index 64f101f19..e32d42bdf 100644 --- a/docs/dev/generated/skbio.sequence.DNA.read.html +++ b/docs/dev/generated/skbio.sequence.DNA.read.html @@ -31,7 +31,7 @@ - + @@ -816,7 +816,7 @@

skbio.sequence.DNA.read - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.DNA.transcribe.html b/docs/dev/generated/skbio.sequence.DNA.transcribe.html index 67024d264..4ac063066 100644 --- a/docs/dev/generated/skbio.sequence.DNA.transcribe.html +++ b/docs/dev/generated/skbio.sequence.DNA.transcribe.html @@ -31,7 +31,7 @@ - + @@ -711,7 +711,7 @@

skbio.sequence.DNA.transcribeExamples

Transcribe DNA into RNA:

-
>>> from skbio import DNA
+
>>> from skbio import DNA
 >>> dna = DNA('TAACGTTA')
 >>> dna
 DNA
@@ -817,7 +817,7 @@ 

skbio.sequence.DNA.transcribe - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.DNA.translate.html b/docs/dev/generated/skbio.sequence.DNA.translate.html index ae8786c2c..a1959a004 100644 --- a/docs/dev/generated/skbio.sequence.DNA.translate.html +++ b/docs/dev/generated/skbio.sequence.DNA.translate.html @@ -31,7 +31,7 @@ - + @@ -722,7 +722,7 @@

skbio.sequence.DNA.translateExamples

Translate DNA into protein using NCBI’s standard genetic code (table ID 1, the default genetic code in scikit-bio):

-
>>> from skbio import DNA
+
>>> from skbio import DNA
 >>> dna = DNA('ATGCCACTTTAA')
 >>> dna.translate()
 Protein
@@ -833,7 +833,7 @@ 

skbio.sequence.DNA.translate - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.DNA.translate_six_frames.html b/docs/dev/generated/skbio.sequence.DNA.translate_six_frames.html index 1a7daa176..7656fc1f6 100644 --- a/docs/dev/generated/skbio.sequence.DNA.translate_six_frames.html +++ b/docs/dev/generated/skbio.sequence.DNA.translate_six_frames.html @@ -31,7 +31,7 @@ - + @@ -736,7 +736,7 @@

skbio.sequence.DNA.translate_six_frames
>>> from skbio import DNA
+
>>> from skbio import DNA
 >>> dna = DNA('ATGCCACTTTAA')
 >>> for protein in dna.translate_six_frames():
 ...     protein
@@ -888,7 +888,7 @@ 

skbio.sequence.DNA.translate_six_frames - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.DNA.write.html b/docs/dev/generated/skbio.sequence.DNA.write.html index 3591b6c57..f999e8b20 100644 --- a/docs/dev/generated/skbio.sequence.DNA.write.html +++ b/docs/dev/generated/skbio.sequence.DNA.write.html @@ -31,7 +31,7 @@ - + @@ -807,7 +807,7 @@

skbio.sequence.DNA.write - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.GeneticCode.from_ncbi.html b/docs/dev/generated/skbio.sequence.GeneticCode.from_ncbi.html index c594da2a8..27d2db819 100644 --- a/docs/dev/generated/skbio.sequence.GeneticCode.from_ncbi.html +++ b/docs/dev/generated/skbio.sequence.GeneticCode.from_ncbi.html @@ -31,7 +31,7 @@ - + @@ -797,7 +797,7 @@

skbio.sequence.GeneticCode.from_ncbi - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.GeneticCode.html b/docs/dev/generated/skbio.sequence.GeneticCode.html index faf7b2501..fd448a44b 100644 --- a/docs/dev/generated/skbio.sequence.GeneticCode.html +++ b/docs/dev/generated/skbio.sequence.GeneticCode.html @@ -31,7 +31,7 @@ - + @@ -735,7 +735,7 @@

skbio.sequence.GeneticCodeExamples

Get NCBI’s standard genetic code (table ID 1, the default genetic code in scikit-bio):

-
>>> from skbio import GeneticCode
+
>>> from skbio import GeneticCode
 >>> GeneticCode.from_ncbi()
 GeneticCode (Standard)
 -------------------------------------------------------------------------
@@ -769,7 +769,7 @@ 

skbio.sequence.GeneticCode
>>> from skbio import RNA
+
>>> from skbio import RNA
 >>> rna = RNA('AUGCCACUUUAA')
 >>> GeneticCode.from_ncbi().translate(rna)
 Protein
@@ -1062,7 +1062,7 @@ 

skbio.sequence.GeneticCode - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.GeneticCode.translate.html b/docs/dev/generated/skbio.sequence.GeneticCode.translate.html index bffee50fd..cb107cb6e 100644 --- a/docs/dev/generated/skbio.sequence.GeneticCode.translate.html +++ b/docs/dev/generated/skbio.sequence.GeneticCode.translate.html @@ -31,7 +31,7 @@ - + @@ -744,7 +744,7 @@

skbio.sequence.GeneticCode.translateExamples

Translate RNA into protein using NCBI’s standard genetic code (table ID 1, the default genetic code in scikit-bio):

-
>>> from skbio import RNA, GeneticCode
+
>>> from skbio import RNA, GeneticCode
 >>> rna = RNA('AGUAUUCUGCCACUGUAAGAA')
 >>> sgc = GeneticCode.from_ncbi()
 >>> sgc.translate(rna)
@@ -889,7 +889,7 @@ 

skbio.sequence.GeneticCode.translate - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.GeneticCode.translate_six_frames.html b/docs/dev/generated/skbio.sequence.GeneticCode.translate_six_frames.html index 5d9658a25..0a09d5fc3 100644 --- a/docs/dev/generated/skbio.sequence.GeneticCode.translate_six_frames.html +++ b/docs/dev/generated/skbio.sequence.GeneticCode.translate_six_frames.html @@ -31,7 +31,7 @@ - + @@ -733,7 +733,7 @@

skbio.sequence.GeneticCode.translate_six_frames
>>> from skbio import RNA, GeneticCode
+
>>> from skbio import RNA, GeneticCode
 >>> rna = RNA('AUGCCACUUUAA')
 >>> sgc = GeneticCode.from_ncbi()
 >>> for protein in sgc.translate_six_frames(rna):
@@ -886,7 +886,7 @@ 

skbio.sequence.GeneticCode.translate_six_frames - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.GrammaredSequence.definites.html b/docs/dev/generated/skbio.sequence.GrammaredSequence.definites.html index 513073bbe..54b069994 100644 --- a/docs/dev/generated/skbio.sequence.GrammaredSequence.definites.html +++ b/docs/dev/generated/skbio.sequence.GrammaredSequence.definites.html @@ -31,7 +31,7 @@ - + @@ -713,7 +713,7 @@

skbio.sequence.GrammaredSequence.definitesExamples

-
>>> from skbio import DNA
+
>>> from skbio import DNA
 >>> s = DNA('ACWGN')
 >>> s.definites()
 array([ True,  True, False,  True, False], dtype=bool)
@@ -799,7 +799,7 @@ 

skbio.sequence.GrammaredSequence.definites - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.GrammaredSequence.degap.html b/docs/dev/generated/skbio.sequence.GrammaredSequence.degap.html index 698888292..bb8316f89 100644 --- a/docs/dev/generated/skbio.sequence.GrammaredSequence.degap.html +++ b/docs/dev/generated/skbio.sequence.GrammaredSequence.degap.html @@ -31,7 +31,7 @@ - + @@ -716,7 +716,7 @@

skbio.sequence.GrammaredSequence.degapExamples

-
>>> from skbio import DNA
+
>>> from skbio import DNA
 >>> s = DNA('GGTC-C--ATT-C.',
 ...         positional_metadata={'quality':range(14)})
 >>> s.degap()
@@ -814,7 +814,7 @@ 

skbio.sequence.GrammaredSequence.degap - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.GrammaredSequence.degenerates.html b/docs/dev/generated/skbio.sequence.GrammaredSequence.degenerates.html index 0e9dea1d3..fa0e80e5a 100644 --- a/docs/dev/generated/skbio.sequence.GrammaredSequence.degenerates.html +++ b/docs/dev/generated/skbio.sequence.GrammaredSequence.degenerates.html @@ -31,7 +31,7 @@ - + @@ -714,7 +714,7 @@

skbio.sequence.GrammaredSequence.degeneratesExamples

-
>>> from skbio import DNA
+
>>> from skbio import DNA
 >>> s = DNA('ACWGN')
 >>> s.degenerates()
 array([False, False,  True, False,  True], dtype=bool)
@@ -800,7 +800,7 @@ 

skbio.sequence.GrammaredSequence.degenerates - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.GrammaredSequence.expand_degenerates.html b/docs/dev/generated/skbio.sequence.GrammaredSequence.expand_degenerates.html index e7d970615..57e0143b5 100644 --- a/docs/dev/generated/skbio.sequence.GrammaredSequence.expand_degenerates.html +++ b/docs/dev/generated/skbio.sequence.GrammaredSequence.expand_degenerates.html @@ -31,7 +31,7 @@ - + @@ -716,7 +716,7 @@

skbio.sequence.GrammaredSequence.expand_degeneratesEach definite sequence will have the same type, metadata, and positional metadata as the biological sequence.

Examples

-
>>> from skbio import DNA
+
>>> from skbio import DNA
 >>> seq = DNA('TRG')
 >>> seq_generator = seq.expand_degenerates()
 >>> for s in sorted(seq_generator, key=str):
@@ -825,7 +825,7 @@ 

skbio.sequence.GrammaredSequence.expand_degenerates - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.GrammaredSequence.find_motifs.html b/docs/dev/generated/skbio.sequence.GrammaredSequence.find_motifs.html index 9f35acdd4..a6705f3e7 100644 --- a/docs/dev/generated/skbio.sequence.GrammaredSequence.find_motifs.html +++ b/docs/dev/generated/skbio.sequence.GrammaredSequence.find_motifs.html @@ -31,7 +31,7 @@ - + @@ -725,7 +725,7 @@

skbio.sequence.GrammaredSequence.find_motifsExamples

-
>>> from skbio import DNA
+
>>> from skbio import DNA
 >>> s = DNA('ACGGGGAGGCGGAG')
 >>> for motif_slice in s.find_motifs('purine-run', min_length=2):
 ...     motif_slice
@@ -831,7 +831,7 @@ 

skbio.sequence.GrammaredSequence.find_motifs - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.GrammaredSequence.gaps.html b/docs/dev/generated/skbio.sequence.GrammaredSequence.gaps.html index 6a5e92258..8111be2ec 100644 --- a/docs/dev/generated/skbio.sequence.GrammaredSequence.gaps.html +++ b/docs/dev/generated/skbio.sequence.GrammaredSequence.gaps.html @@ -31,7 +31,7 @@ - + @@ -712,7 +712,7 @@

skbio.sequence.GrammaredSequence.gapsExamples

-
>>> from skbio import DNA
+
>>> from skbio import DNA
 >>> s = DNA('AC-G-')
 >>> s.gaps()
 array([False, False,  True, False,  True], dtype=bool)
@@ -798,7 +798,7 @@ 

skbio.sequence.GrammaredSequence.gaps - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.GrammaredSequence.has_definites.html b/docs/dev/generated/skbio.sequence.GrammaredSequence.has_definites.html index 5644f5c2f..f679bd589 100644 --- a/docs/dev/generated/skbio.sequence.GrammaredSequence.has_definites.html +++ b/docs/dev/generated/skbio.sequence.GrammaredSequence.has_definites.html @@ -31,7 +31,7 @@ - + @@ -714,7 +714,7 @@

skbio.sequence.GrammaredSequence.has_definitesExamples

-
>>> from skbio import DNA
+
>>> from skbio import DNA
 >>> s = DNA('NWNNNNNN')
 >>> s.has_definites()
 False
@@ -803,7 +803,7 @@ 

skbio.sequence.GrammaredSequence.has_definites - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.GrammaredSequence.has_degenerates.html b/docs/dev/generated/skbio.sequence.GrammaredSequence.has_degenerates.html index f70b949aa..29d2cddab 100644 --- a/docs/dev/generated/skbio.sequence.GrammaredSequence.has_degenerates.html +++ b/docs/dev/generated/skbio.sequence.GrammaredSequence.has_degenerates.html @@ -31,7 +31,7 @@ - + @@ -714,7 +714,7 @@

skbio.sequence.GrammaredSequence.has_degeneratesExamples

-
>>> from skbio import DNA
+
>>> from skbio import DNA
 >>> s = DNA('ACAC-GACGTT')
 >>> s.has_degenerates()
 False
@@ -803,7 +803,7 @@ 

skbio.sequence.GrammaredSequence.has_degenerates - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.GrammaredSequence.has_gaps.html b/docs/dev/generated/skbio.sequence.GrammaredSequence.has_gaps.html index fd4aa38cd..a584b4854 100644 --- a/docs/dev/generated/skbio.sequence.GrammaredSequence.has_gaps.html +++ b/docs/dev/generated/skbio.sequence.GrammaredSequence.has_gaps.html @@ -31,7 +31,7 @@ - + @@ -706,7 +706,7 @@

skbio.sequence.GrammaredSequence.has_gapsExamples

-
>>> from skbio import DNA
+

Examples

-
>>> from skbio import DNA
+
>>> from skbio import DNA
 >>> s = DNA('NWNNNNNN')
 >>> s.has_nondegenerates()
 False
@@ -809,7 +809,7 @@ 

skbio.sequence.GrammaredSequence.has_nondegenerates - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.GrammaredSequence.html b/docs/dev/generated/skbio.sequence.GrammaredSequence.html index 7a5691ff6..4892577ea 100644 --- a/docs/dev/generated/skbio.sequence.GrammaredSequence.html +++ b/docs/dev/generated/skbio.sequence.GrammaredSequence.html @@ -31,7 +31,7 @@ - + @@ -725,24 +725,24 @@

skbio.sequence.GrammaredSequenceExamples

Note in the example below that properties either need to be static or use skbio’s classproperty decorator.

-
>>> from skbio.sequence import GrammaredSequence
->>> from skbio.util import classproperty
->>> class CustomSequence(GrammaredSequence):
+
>>> from skbio.sequence import GrammaredSequence
+>>> from skbio.util import classproperty
+>>> class CustomSequence(GrammaredSequence):
 ...     @classproperty
-...     def degenerate_map(cls):
+...     def degenerate_map(cls):
 ...         return {"X": set("AB")}
 ...
 ...     @classproperty
-...     def definite_chars(cls):
+...     def definite_chars(cls):
 ...         return set("ABC")
 ...
 ...
 ...     @classproperty
-...     def default_gap_char(cls):
+...     def default_gap_char(cls):
 ...         return '-'
 ...
 ...     @classproperty
-...     def gap_chars(cls):
+...     def gap_chars(cls):
 ...         return set('-.')
 
@@ -1231,7 +1231,7 @@

skbio.sequence.GrammaredSequence - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.GrammaredSequence.nondegenerates.html b/docs/dev/generated/skbio.sequence.GrammaredSequence.nondegenerates.html index 41dfebb17..23be2f80f 100644 --- a/docs/dev/generated/skbio.sequence.GrammaredSequence.nondegenerates.html +++ b/docs/dev/generated/skbio.sequence.GrammaredSequence.nondegenerates.html @@ -31,7 +31,7 @@ - + @@ -719,7 +719,7 @@

skbio.sequence.GrammaredSequence.nondegeneratesExamples

-
>>> from skbio import DNA
+
>>> from skbio import DNA
 >>> s = DNA('ACWGN')
 >>> s.nondegenerates()
 array([ True,  True, False,  True, False], dtype=bool)
@@ -805,7 +805,7 @@ 

skbio.sequence.GrammaredSequence.nondegenerates - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.GrammaredSequence.to_definites.html b/docs/dev/generated/skbio.sequence.GrammaredSequence.to_definites.html index 23456abcc..7a85143d0 100644 --- a/docs/dev/generated/skbio.sequence.GrammaredSequence.to_definites.html +++ b/docs/dev/generated/skbio.sequence.GrammaredSequence.to_definites.html @@ -31,7 +31,7 @@ - + @@ -796,7 +796,7 @@

skbio.sequence.GrammaredSequence.to_definites - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.GrammaredSequence.to_regex.html b/docs/dev/generated/skbio.sequence.GrammaredSequence.to_regex.html index b379faefe..d769f7f3d 100644 --- a/docs/dev/generated/skbio.sequence.GrammaredSequence.to_regex.html +++ b/docs/dev/generated/skbio.sequence.GrammaredSequence.to_regex.html @@ -31,7 +31,7 @@ - + @@ -715,7 +715,7 @@

skbio.sequence.GrammaredSequence.to_regexExamples

-
>>> from skbio import DNA
+
>>> from skbio import DNA
 >>> seq = DNA('TRG')
 >>> regex = seq.to_regex()
 >>> regex.match('TAG').string
@@ -809,7 +809,7 @@ 

skbio.sequence.GrammaredSequence.to_regex - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.NucleotideMixin.complement.html b/docs/dev/generated/skbio.sequence.NucleotideMixin.complement.html index 09a19d95c..efe7bd350 100644 --- a/docs/dev/generated/skbio.sequence.NucleotideMixin.complement.html +++ b/docs/dev/generated/skbio.sequence.NucleotideMixin.complement.html @@ -31,7 +31,7 @@ - + @@ -714,7 +714,7 @@

skbio.sequence.NucleotideMixin.complementExamples

-
>>> from skbio import DNA
+
>>> from skbio import DNA
 >>> seq = DNA('TTCATT', positional_metadata={'quality':range(6)})
 >>> seq
 DNA
@@ -840,7 +840,7 @@ 

skbio.sequence.NucleotideMixin.complement - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.NucleotideMixin.gc_content.html b/docs/dev/generated/skbio.sequence.NucleotideMixin.gc_content.html index c3a0312d3..c714bae09 100644 --- a/docs/dev/generated/skbio.sequence.NucleotideMixin.gc_content.html +++ b/docs/dev/generated/skbio.sequence.NucleotideMixin.gc_content.html @@ -31,7 +31,7 @@ - + @@ -707,7 +707,7 @@

skbio.sequence.NucleotideMixin.gc_contentExamples

-
>>> from skbio import DNA
+
>>> from skbio import DNA
 >>> DNA('ACGT').gc_content()
 0.5
 >>> DNA('ACGTACGT').gc_content()
@@ -810,7 +810,7 @@ 

skbio.sequence.NucleotideMixin.gc_content - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.NucleotideMixin.gc_frequency.html b/docs/dev/generated/skbio.sequence.NucleotideMixin.gc_frequency.html index cfec2e452..e7879e867 100644 --- a/docs/dev/generated/skbio.sequence.NucleotideMixin.gc_frequency.html +++ b/docs/dev/generated/skbio.sequence.NucleotideMixin.gc_frequency.html @@ -31,7 +31,7 @@ - + @@ -717,7 +717,7 @@

skbio.sequence.NucleotideMixin.gc_frequencyExamples

-
>>> from skbio import DNA
+

Examples

-
>>> from skbio import DNA
+
>>> from skbio import DNA
 >>> DNA('TTCATT').is_reverse_complement('AATGAA')
 True
 >>> DNA('TTCATT').is_reverse_complement('AATGTT')
@@ -806,7 +806,7 @@ 

skbio.sequence.NucleotideMixin.is_reverse_complement - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.NucleotideMixin.reverse_complement.html b/docs/dev/generated/skbio.sequence.NucleotideMixin.reverse_complement.html index 5f79d159a..3d1edad64 100644 --- a/docs/dev/generated/skbio.sequence.NucleotideMixin.reverse_complement.html +++ b/docs/dev/generated/skbio.sequence.NucleotideMixin.reverse_complement.html @@ -31,7 +31,7 @@ - + @@ -708,7 +708,7 @@

skbio.sequence.NucleotideMixin.reverse_complementNotes

This method is equivalent to self.complement(reverse=True).

Examples

-
>>> from skbio import DNA
+
>>> from skbio import DNA
 >>> seq = DNA('TTCATT',
 ...           positional_metadata={'quality':range(6)})
 >>> seq = seq.reverse_complement()
@@ -809,7 +809,7 @@ 

skbio.sequence.NucleotideMixin.reverse_complement - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.Protein.find_motifs.html b/docs/dev/generated/skbio.sequence.Protein.find_motifs.html index 67197904f..ebd6b6252 100644 --- a/docs/dev/generated/skbio.sequence.Protein.find_motifs.html +++ b/docs/dev/generated/skbio.sequence.Protein.find_motifs.html @@ -31,7 +31,7 @@ - + @@ -720,7 +720,7 @@

skbio.sequence.Protein.find_motifsExamples

-
>>> from skbio import DNA
+
>>> from skbio import DNA
 >>> s = DNA('ACGGGGAGGCGGAG')
 >>> for motif_slice in s.find_motifs('purine-run', min_length=2):
 ...     motif_slice
@@ -826,7 +826,7 @@ 

skbio.sequence.Protein.find_motifs - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.Protein.has_stops.html b/docs/dev/generated/skbio.sequence.Protein.has_stops.html index b40a12fcb..79d1a03ab 100644 --- a/docs/dev/generated/skbio.sequence.Protein.has_stops.html +++ b/docs/dev/generated/skbio.sequence.Protein.has_stops.html @@ -31,7 +31,7 @@ - + @@ -698,7 +698,7 @@

skbio.sequence.Protein.has_stopsExamples

-
>>> from skbio import Protein
+

Examples

-
>>> from skbio import Protein
+
>>> from skbio import Protein
 >>> Protein('PAW')
 Protein
 --------------------------
@@ -1339,7 +1339,7 @@ 

skbio.sequence.Protein - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.Protein.read.html b/docs/dev/generated/skbio.sequence.Protein.read.html index e198dc154..0e8acd4bc 100644 --- a/docs/dev/generated/skbio.sequence.Protein.read.html +++ b/docs/dev/generated/skbio.sequence.Protein.read.html @@ -31,7 +31,7 @@ - + @@ -813,7 +813,7 @@

skbio.sequence.Protein.read - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.Protein.stops.html b/docs/dev/generated/skbio.sequence.Protein.stops.html index 679337ddb..b6ea968b8 100644 --- a/docs/dev/generated/skbio.sequence.Protein.stops.html +++ b/docs/dev/generated/skbio.sequence.Protein.stops.html @@ -31,7 +31,7 @@ - + @@ -704,7 +704,7 @@

skbio.sequence.Protein.stopsExamples

-
>>> from skbio import Protein
+
>>> from skbio import Protein
 >>> s = Protein('PAW')
 >>> s.stops()
 array([False, False, False], dtype=bool)
@@ -793,7 +793,7 @@ 

skbio.sequence.Protein.stops - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.Protein.write.html b/docs/dev/generated/skbio.sequence.Protein.write.html index 01f14fabe..c5bc354b7 100644 --- a/docs/dev/generated/skbio.sequence.Protein.write.html +++ b/docs/dev/generated/skbio.sequence.Protein.write.html @@ -31,7 +31,7 @@ - + @@ -804,7 +804,7 @@

skbio.sequence.Protein.write - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.RNA.find_motifs.html b/docs/dev/generated/skbio.sequence.RNA.find_motifs.html index eccf5c085..0cc74a76f 100644 --- a/docs/dev/generated/skbio.sequence.RNA.find_motifs.html +++ b/docs/dev/generated/skbio.sequence.RNA.find_motifs.html @@ -31,7 +31,7 @@ - + @@ -723,7 +723,7 @@

skbio.sequence.RNA.find_motifsExamples

-
>>> from skbio import DNA
+
>>> from skbio import DNA
 >>> s = DNA('ACGGGGAGGCGGAG')
 >>> for motif_slice in s.find_motifs('purine-run', min_length=2):
 ...     motif_slice
@@ -829,7 +829,7 @@ 

skbio.sequence.RNA.find_motifs - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.RNA.html b/docs/dev/generated/skbio.sequence.RNA.html index 1cdf65d73..775137df1 100644 --- a/docs/dev/generated/skbio.sequence.RNA.html +++ b/docs/dev/generated/skbio.sequence.RNA.html @@ -31,7 +31,7 @@ - + @@ -774,7 +774,7 @@

skbio.sequence.RNAExamples

-
>>> from skbio import RNA
+
>>> from skbio import RNA
 >>> RNA('ACCGAAU')
 RNA
 --------------------------
@@ -1234,7 +1234,7 @@ 

skbio.sequence.RNA - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.RNA.read.html b/docs/dev/generated/skbio.sequence.RNA.read.html index cb92a875a..946f9a102 100644 --- a/docs/dev/generated/skbio.sequence.RNA.read.html +++ b/docs/dev/generated/skbio.sequence.RNA.read.html @@ -31,7 +31,7 @@ - + @@ -814,7 +814,7 @@

skbio.sequence.RNA.read - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.RNA.reverse_transcribe.html b/docs/dev/generated/skbio.sequence.RNA.reverse_transcribe.html index 989b3f709..5cda501b8 100644 --- a/docs/dev/generated/skbio.sequence.RNA.reverse_transcribe.html +++ b/docs/dev/generated/skbio.sequence.RNA.reverse_transcribe.html @@ -31,7 +31,7 @@ - + @@ -712,7 +712,7 @@

skbio.sequence.RNA.reverse_transcribeExamples

Reverse transcribe RNA into DNA:

-
>>> from skbio import RNA
+
>>> from skbio import RNA
 >>> rna = RNA('UAACGUUA')
 >>> rna
 RNA
@@ -818,7 +818,7 @@ 

skbio.sequence.RNA.reverse_transcribe - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.RNA.translate.html b/docs/dev/generated/skbio.sequence.RNA.translate.html index 67b4f4705..5e9ebed81 100644 --- a/docs/dev/generated/skbio.sequence.RNA.translate.html +++ b/docs/dev/generated/skbio.sequence.RNA.translate.html @@ -31,7 +31,7 @@ - + @@ -722,7 +722,7 @@

skbio.sequence.RNA.translateExamples

Translate RNA into protein using NCBI’s standard genetic code (table ID 1, the default genetic code in scikit-bio):

-
>>> from skbio import RNA
+
>>> from skbio import RNA
 >>> rna = RNA('AUGCCACUUUAA')
 >>> rna.translate()
 Protein
@@ -833,7 +833,7 @@ 

skbio.sequence.RNA.translate - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.RNA.translate_six_frames.html b/docs/dev/generated/skbio.sequence.RNA.translate_six_frames.html index 4a767475d..3e56ca442 100644 --- a/docs/dev/generated/skbio.sequence.RNA.translate_six_frames.html +++ b/docs/dev/generated/skbio.sequence.RNA.translate_six_frames.html @@ -31,7 +31,7 @@ - + @@ -738,7 +738,7 @@

skbio.sequence.RNA.translate_six_frames
>>> from skbio import RNA
+
>>> from skbio import RNA
 >>> rna = RNA('AUGCCACUUUAA')
 >>> for protein in rna.translate_six_frames():
 ...     protein
@@ -890,7 +890,7 @@ 

skbio.sequence.RNA.translate_six_frames - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.RNA.write.html b/docs/dev/generated/skbio.sequence.RNA.write.html index 6a9fa9310..c5a39aff7 100644 --- a/docs/dev/generated/skbio.sequence.RNA.write.html +++ b/docs/dev/generated/skbio.sequence.RNA.write.html @@ -31,7 +31,7 @@ - + @@ -805,7 +805,7 @@

skbio.sequence.RNA.write - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.Sequence.concat.html b/docs/dev/generated/skbio.sequence.Sequence.concat.html index 4ffb7711c..f917e53d7 100644 --- a/docs/dev/generated/skbio.sequence.Sequence.concat.html +++ b/docs/dev/generated/skbio.sequence.Sequence.concat.html @@ -31,7 +31,7 @@ - + @@ -743,7 +743,7 @@

skbio.sequence.Sequence.concatExamples

Concatenate two DNA sequences into a new DNA object:

-
>>> from skbio import DNA, Sequence
+
>>> from skbio import DNA, Sequence
 >>> s1 = DNA("ACGT")
 >>> s2 = DNA("GGAA")
 >>> DNA.concat([s1, s2])
@@ -880,7 +880,7 @@ 

skbio.sequence.Sequence.concat - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.Sequence.count.html b/docs/dev/generated/skbio.sequence.Sequence.count.html index 789570ac8..27aad3d50 100644 --- a/docs/dev/generated/skbio.sequence.Sequence.count.html +++ b/docs/dev/generated/skbio.sequence.Sequence.count.html @@ -31,7 +31,7 @@ - + @@ -729,7 +729,7 @@

skbio.sequence.Sequence.countExamples

-
>>> from skbio import Sequence
+
>>> from skbio import Sequence
 >>> s = Sequence('GGUCG')
 >>> s.count('G')
 3
@@ -821,7 +821,7 @@ 

skbio.sequence.Sequence.count - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.Sequence.distance.html b/docs/dev/generated/skbio.sequence.Sequence.distance.html index d7c4a58d0..428c11300 100644 --- a/docs/dev/generated/skbio.sequence.Sequence.distance.html +++ b/docs/dev/generated/skbio.sequence.Sequence.distance.html @@ -31,7 +31,7 @@ - + @@ -742,7 +742,7 @@

skbio.sequence.Sequence.distanceExamples

-
>>> from skbio import Sequence
+
>>> from skbio import Sequence
 >>> s = Sequence('GGUC')
 >>> t = Sequence('AGUC')
 
@@ -753,7 +753,7 @@

skbio.sequence.Sequence.distance
>>> def custom_metric(s1, s2): return 0.42
+
>>> def custom_metric(s1, s2): return 0.42
 >>> s.distance(t, custom_metric)
 0.42
 
@@ -838,7 +838,7 @@

skbio.sequence.Sequence.distance - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.Sequence.find_with_regex.html b/docs/dev/generated/skbio.sequence.Sequence.find_with_regex.html index 273b38f62..030459dc4 100644 --- a/docs/dev/generated/skbio.sequence.Sequence.find_with_regex.html +++ b/docs/dev/generated/skbio.sequence.Sequence.find_with_regex.html @@ -31,7 +31,7 @@ - + @@ -720,7 +720,7 @@

skbio.sequence.Sequence.find_with_regexExamples

-
>>> from skbio import Sequence
+
>>> from skbio import Sequence
 >>> s = Sequence('AATATACCGGTTATAA')
 >>> for match in s.find_with_regex('(TATA+)'):
 ...     match
@@ -811,7 +811,7 @@ 

skbio.sequence.Sequence.find_with_regex - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.Sequence.frequencies.html b/docs/dev/generated/skbio.sequence.Sequence.frequencies.html index 9cc96fda3..63bab4d9c 100644 --- a/docs/dev/generated/skbio.sequence.Sequence.frequencies.html +++ b/docs/dev/generated/skbio.sequence.Sequence.frequencies.html @@ -31,7 +31,7 @@ - + @@ -754,7 +754,7 @@

skbio.sequence.Sequence.frequencieschars=seq.observed_chars.

Examples

Compute character frequencies of a sequence:

-
>>> from skbio import Sequence
+

Examples

-
>>> from skbio import Sequence
->>> from skbio.metadata import IntervalMetadata
+
>>> from skbio import Sequence
+>>> from skbio.metadata import IntervalMetadata
 

Creating sequences:

@@ -1198,7 +1198,7 @@

skbio.sequence.SequenceNotes

This property is not writeable.

Examples

-
>>> from skbio import Sequence
+
>>> from skbio import Sequence
 >>> s = Sequence('AACGAC')
 >>> s.observed_chars == {'G', 'A', 'C'}
 True
@@ -1213,7 +1213,7 @@ 

skbio.sequence.SequenceNotes

This property is not writeable.

Examples

-
>>> from skbio import Sequence
+
>>> from skbio import Sequence
 >>> s = Sequence('AACGA')
 >>> s.values 
 array([b'A', b'A', b'C', b'G', b'A'],
@@ -1235,7 +1235,7 @@ 

skbio.sequence.Sequence

Examples

-
>>> from skbio import Sequence
+
>>> from skbio import Sequence
 >>> bool(Sequence(''))
 False
 >>> bool(Sequence('ACGT'))
@@ -1270,7 +1270,7 @@ 

skbio.sequence.Sequence

Examples

-
>>> from skbio import Sequence
+
>>> from skbio import Sequence
 >>> s = Sequence('GGUCGUGAAGGA')
 >>> 'GGU' in s
 True
@@ -1331,7 +1331,7 @@ 

skbio.sequence.SequenceExamples

Define two Sequence objects that have the same underlying sequence of characters:

-
>>> from skbio import Sequence
+
>>> from skbio import Sequence
 >>> s = Sequence('ACGT')
 >>> t = Sequence('ACGT')
 
@@ -1397,7 +1397,7 @@

skbio.sequence.SequenceThis drops the self.interval_metadata from the returned new Sequence object.

Examples

-
>>> from skbio import Sequence
+
>>> from skbio import Sequence
 >>> s = Sequence('GGUCGUGAAGGA')
 
@@ -1459,7 +1459,7 @@

skbio.sequence.Sequence

Examples

-
>>> from skbio import Sequence
+
>>> from skbio import Sequence
 >>> s = Sequence('GGUC')
 >>> for c in s:
 ...     str(c)
@@ -1484,7 +1484,7 @@ 

skbio.sequence.Sequence

Examples

-
>>> from skbio import Sequence
+
>>> from skbio import Sequence
 >>> s = Sequence('GGUC')
 >>> len(s)
 4
@@ -1513,7 +1513,7 @@ 

skbio.sequence.Sequence

Examples

-
>>> from skbio import Sequence
+
>>> from skbio import Sequence
 >>> s = Sequence('ACGT')
 >>> t = Sequence('ACGT')
 >>> s != t
@@ -1542,7 +1542,7 @@ 

skbio.sequence.Sequence

Examples

-
>>> from skbio import Sequence
+

Examples

-
>>> from skbio import Sequence
+
>>> from skbio import Sequence
 >>> s = Sequence('GGUCGUAAAGGA', metadata={'id':'hello'})
 >>> str(s)
 'GGUCGUAAAGGA'
@@ -1678,7 +1678,7 @@ 

skbio.sequence.Sequence - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.Sequence.index.html b/docs/dev/generated/skbio.sequence.Sequence.index.html index 68e0cc258..5bf03ffc7 100644 --- a/docs/dev/generated/skbio.sequence.Sequence.index.html +++ b/docs/dev/generated/skbio.sequence.Sequence.index.html @@ -31,7 +31,7 @@ - + @@ -729,7 +729,7 @@

skbio.sequence.Sequence.indexExamples

-
>>> from skbio import Sequence
+
>>> from skbio import Sequence
 >>> s = Sequence('ACACGACGTT-')
 >>> s.index('ACG')
 2
@@ -815,7 +815,7 @@ 

skbio.sequence.Sequence.index - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.Sequence.iter_contiguous.html b/docs/dev/generated/skbio.sequence.Sequence.iter_contiguous.html index 3d094862f..521006b2b 100644 --- a/docs/dev/generated/skbio.sequence.Sequence.iter_contiguous.html +++ b/docs/dev/generated/skbio.sequence.Sequence.iter_contiguous.html @@ -31,7 +31,7 @@ - + @@ -729,7 +729,7 @@

skbio.sequence.Sequence.iter_contiguousExamples

Here we use iter_contiguous to find all of the contiguous ungapped sequences using a boolean vector derived from our DNA sequence.

-
>>> from skbio import DNA
+
>>> from skbio import DNA
 >>> s = DNA('AAA--TT-CCCC-G-')
 >>> no_gaps = ~s.gaps()
 >>> for ungapped_subsequence in s.iter_contiguous(no_gaps,
@@ -744,7 +744,7 @@ 

skbio.sequence.Sequence.iter_contiguous
>>> from skbio import Protein
+
>>> from skbio import Protein
 >>> s = Protein('ACDFNASANFTACGNPNRTESL')
 >>> for subseq in s.iter_contiguous(s.find_motifs('N-glycosylation')):
 ...     print(subseq)
@@ -834,7 +834,7 @@ 

skbio.sequence.Sequence.iter_contiguous - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.Sequence.iter_kmers.html b/docs/dev/generated/skbio.sequence.Sequence.iter_kmers.html index 699e91f65..acf0ce262 100644 --- a/docs/dev/generated/skbio.sequence.Sequence.iter_kmers.html +++ b/docs/dev/generated/skbio.sequence.Sequence.iter_kmers.html @@ -31,7 +31,7 @@ - + @@ -724,7 +724,7 @@

skbio.sequence.Sequence.iter_kmersExamples

-
>>> from skbio import Sequence
+
>>> from skbio import Sequence
 >>> s = Sequence('ACACGACGTT')
 >>> for kmer in s.iter_kmers(4, overlap=False):
 ...     str(kmer)
@@ -822,7 +822,7 @@ 

skbio.sequence.Sequence.iter_kmers - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.Sequence.kmer_frequencies.html b/docs/dev/generated/skbio.sequence.Sequence.kmer_frequencies.html index 5ecb831a4..597ecfc26 100644 --- a/docs/dev/generated/skbio.sequence.Sequence.kmer_frequencies.html +++ b/docs/dev/generated/skbio.sequence.Sequence.kmer_frequencies.html @@ -31,7 +31,7 @@ - + @@ -727,7 +727,7 @@

skbio.sequence.Sequence.kmer_frequenciesExamples

-
>>> from skbio import Sequence
+
>>> from skbio import Sequence
 >>> s = Sequence('ACACATTTATTA')
 >>> freqs = s.kmer_frequencies(3, overlap=False)
 >>> freqs
@@ -817,7 +817,7 @@ 

skbio.sequence.Sequence.kmer_frequencies - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.Sequence.lowercase.html b/docs/dev/generated/skbio.sequence.Sequence.lowercase.html index 50ea97427..3217fee77 100644 --- a/docs/dev/generated/skbio.sequence.Sequence.lowercase.html +++ b/docs/dev/generated/skbio.sequence.Sequence.lowercase.html @@ -31,7 +31,7 @@ - + @@ -722,7 +722,7 @@

skbio.sequence.Sequence.lowercaseExamples

-
>>> from skbio import Sequence
+
>>> from skbio import Sequence
 >>> s = Sequence('ACGT')
 >>> s.lowercase([True, True, False, False])
 'acGT'
@@ -823,7 +823,7 @@ 

skbio.sequence.Sequence.lowercase - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.Sequence.match_frequency.html b/docs/dev/generated/skbio.sequence.Sequence.match_frequency.html index 649f23777..da0b804db 100644 --- a/docs/dev/generated/skbio.sequence.Sequence.match_frequency.html +++ b/docs/dev/generated/skbio.sequence.Sequence.match_frequency.html @@ -31,7 +31,7 @@ - + @@ -739,7 +739,7 @@

skbio.sequence.Sequence.match_frequencyExamples

-
>>> from skbio import Sequence
+
>>> from skbio import Sequence
 >>> s = Sequence('GGUC')
 >>> t = Sequence('AGUC')
 >>> s.match_frequency(t)
@@ -828,7 +828,7 @@ 

skbio.sequence.Sequence.match_frequency - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.Sequence.matches.html b/docs/dev/generated/skbio.sequence.Sequence.matches.html index aca3c3f6a..e3cc823ee 100644 --- a/docs/dev/generated/skbio.sequence.Sequence.matches.html +++ b/docs/dev/generated/skbio.sequence.Sequence.matches.html @@ -31,7 +31,7 @@ - + @@ -732,7 +732,7 @@

skbio.sequence.Sequence.matchesExamples

-
>>> from skbio import Sequence
+
>>> from skbio import Sequence
 >>> s = Sequence('GGUC')
 >>> t = Sequence('GAUU')
 >>> s.matches(t)
@@ -819,7 +819,7 @@ 

skbio.sequence.Sequence.matches - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.Sequence.mismatch_frequency.html b/docs/dev/generated/skbio.sequence.Sequence.mismatch_frequency.html index 759601302..188f3ee23 100644 --- a/docs/dev/generated/skbio.sequence.Sequence.mismatch_frequency.html +++ b/docs/dev/generated/skbio.sequence.Sequence.mismatch_frequency.html @@ -31,7 +31,7 @@ - + @@ -739,7 +739,7 @@

skbio.sequence.Sequence.mismatch_frequencyExamples

-
>>> from skbio import Sequence
+
>>> from skbio import Sequence
 >>> s = Sequence('GGUC')
 >>> t = Sequence('AGUC')
 >>> s.mismatch_frequency(t)
@@ -828,7 +828,7 @@ 

skbio.sequence.Sequence.mismatch_frequency - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.Sequence.mismatches.html b/docs/dev/generated/skbio.sequence.Sequence.mismatches.html index 9e8dc9cf0..4d6ba7ca7 100644 --- a/docs/dev/generated/skbio.sequence.Sequence.mismatches.html +++ b/docs/dev/generated/skbio.sequence.Sequence.mismatches.html @@ -31,7 +31,7 @@ - + @@ -732,7 +732,7 @@

skbio.sequence.Sequence.mismatchesExamples

-
>>> from skbio import Sequence
+
>>> from skbio import Sequence
 >>> s = Sequence('GGUC')
 >>> t = Sequence('GAUU')
 >>> s.mismatches(t)
@@ -819,7 +819,7 @@ 

skbio.sequence.Sequence.mismatches - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.Sequence.read.html b/docs/dev/generated/skbio.sequence.Sequence.read.html index c018ac665..540edf992 100644 --- a/docs/dev/generated/skbio.sequence.Sequence.read.html +++ b/docs/dev/generated/skbio.sequence.Sequence.read.html @@ -31,7 +31,7 @@ - + @@ -828,7 +828,7 @@

skbio.sequence.Sequence.read - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.Sequence.replace.html b/docs/dev/generated/skbio.sequence.Sequence.replace.html index 039564828..4c0f7171f 100644 --- a/docs/dev/generated/skbio.sequence.Sequence.replace.html +++ b/docs/dev/generated/skbio.sequence.Sequence.replace.html @@ -31,7 +31,7 @@ - + @@ -723,7 +723,7 @@

skbio.sequence.Sequence.replaceExamples

Let’s create and display a Sequence:

-
>>> from skbio import Sequence
+
>>> from skbio import Sequence
 >>> sequence = Sequence('GGTACCAACG')
 >>> str(sequence)
 'GGTACCAACG'
@@ -839,7 +839,7 @@ 

skbio.sequence.Sequence.replace - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.Sequence.to_indices.html b/docs/dev/generated/skbio.sequence.Sequence.to_indices.html index 0a24df0df..eb3f1d5fc 100644 --- a/docs/dev/generated/skbio.sequence.Sequence.to_indices.html +++ b/docs/dev/generated/skbio.sequence.Sequence.to_indices.html @@ -31,7 +31,7 @@ - + @@ -749,7 +749,7 @@

skbio.sequence.Sequence.to_indicesExamples

Convert a protein sequence into indices of unique amino acids in it. Note that the unique characters are ordered.

-
>>> from skbio import Protein
+
>>> from skbio import Protein
 >>> seq = Protein('MEEPQSDPSV')
 >>> idx, uniq = seq.to_indices()
 >>> idx
@@ -760,7 +760,7 @@ 

skbio.sequence.Sequence.to_indices
>>> from skbio import DNA
+
>>> from skbio import DNA
 >>> seq = DNA('CTCAAAAGTC')
 >>> idx = seq.to_indices(alphabet='TCGA')
 >>> idx
@@ -768,7 +768,7 @@ 

skbio.sequence.Sequence.to_indices
>>> from skbio import SubstitutionMatrix
+
>>> from skbio import SubstitutionMatrix
 >>> sm = SubstitutionMatrix.by_name('NUC.4.4')
 >>> idx = seq.to_indices(alphabet=sm)
 >>> idx
@@ -874,7 +874,7 @@ 

skbio.sequence.Sequence.to_indices - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.Sequence.write.html b/docs/dev/generated/skbio.sequence.Sequence.write.html index f243e4afc..f41dcf252 100644 --- a/docs/dev/generated/skbio.sequence.Sequence.write.html +++ b/docs/dev/generated/skbio.sequence.Sequence.write.html @@ -31,7 +31,7 @@ - + @@ -819,7 +819,7 @@

skbio.sequence.Sequence.write - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.SubstitutionMatrix.by_name.html b/docs/dev/generated/skbio.sequence.SubstitutionMatrix.by_name.html index 6e072d86e..49be3441a 100644 --- a/docs/dev/generated/skbio.sequence.SubstitutionMatrix.by_name.html +++ b/docs/dev/generated/skbio.sequence.SubstitutionMatrix.by_name.html @@ -31,7 +31,7 @@ - + @@ -744,7 +744,7 @@

skbio.sequence.SubstitutionMatrix.by_nameExamples

-
>>> from skbio import SubstitutionMatrix
+
>>> from skbio import SubstitutionMatrix
 >>> mat = SubstitutionMatrix.by_name('BLOSUM62')
 >>> len(mat.alphabet)
 24
@@ -832,7 +832,7 @@ 

skbio.sequence.SubstitutionMatrix.by_name - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.SubstitutionMatrix.from_dict.html b/docs/dev/generated/skbio.sequence.SubstitutionMatrix.from_dict.html index 9dd3b4da2..a4705d1ed 100644 --- a/docs/dev/generated/skbio.sequence.SubstitutionMatrix.from_dict.html +++ b/docs/dev/generated/skbio.sequence.SubstitutionMatrix.from_dict.html @@ -31,7 +31,7 @@ - + @@ -712,7 +712,7 @@

skbio.sequence.SubstitutionMatrix.from_dictExamples

-
>>> from skbio import SubstitutionMatrix
+
>>> from skbio import SubstitutionMatrix
 >>> d = {'a': {'a': 1, 'b': 0, 'c': 0},
 ...      'b': {'a': 0, 'b': 1, 'c': 0},
 ...      'c': {'a': 0, 'b': 0, 'c': 1}}
@@ -805,7 +805,7 @@ 

skbio.sequence.SubstitutionMatrix.from_dict - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.SubstitutionMatrix.get_names.html b/docs/dev/generated/skbio.sequence.SubstitutionMatrix.get_names.html index 9fc766297..ab2c9c731 100644 --- a/docs/dev/generated/skbio.sequence.SubstitutionMatrix.get_names.html +++ b/docs/dev/generated/skbio.sequence.SubstitutionMatrix.get_names.html @@ -31,7 +31,7 @@ - + @@ -782,7 +782,7 @@

skbio.sequence.SubstitutionMatrix.get_names - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.SubstitutionMatrix.html b/docs/dev/generated/skbio.sequence.SubstitutionMatrix.html index 4538059c1..10b33cecd 100644 --- a/docs/dev/generated/skbio.sequence.SubstitutionMatrix.html +++ b/docs/dev/generated/skbio.sequence.SubstitutionMatrix.html @@ -31,7 +31,7 @@ - + @@ -728,7 +728,7 @@

skbio.sequence.SubstitutionMatrixSubstitutionMatrix is a subclass of DissimilarityMatrix. Therefore, all attributes and methods of the latter also apply to the former.

Examples

-
>>> from skbio import SubstitutionMatrix
+
>>> from skbio import SubstitutionMatrix
 >>> mat = SubstitutionMatrix('ACGT', np.array([
 ...     [2, -1, -1, -1],
 ...     [-1, 2, -1, -1],
@@ -1035,7 +1035,7 @@ 

skbio.sequence.SubstitutionMatrix - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.SubstitutionMatrix.identity.html b/docs/dev/generated/skbio.sequence.SubstitutionMatrix.identity.html index 767116832..321d7aad0 100644 --- a/docs/dev/generated/skbio.sequence.SubstitutionMatrix.identity.html +++ b/docs/dev/generated/skbio.sequence.SubstitutionMatrix.identity.html @@ -31,7 +31,7 @@ - + @@ -709,7 +709,7 @@

skbio.sequence.SubstitutionMatrix.identityExamples

-
>>> from skbio import SubstitutionMatrix
+

Notes

@@ -725,8 +725,8 @@

skbio.sequence.distance.hammingExamples

-
>>> from skbio import Sequence
->>> from skbio.sequence.distance import hamming
+
>>> from skbio import Sequence
+>>> from skbio.sequence.distance import hamming
 >>> seq1 = Sequence('AGGGTA')
 >>> seq2 = Sequence('CGTTTA')
 >>> hamming(seq1, seq2)
@@ -813,7 +813,7 @@ 

skbio.sequence.distance.hamming - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.distance.html b/docs/dev/generated/skbio.sequence.distance.html index 856bcb3f0..1e9f967b4 100644 --- a/docs/dev/generated/skbio.sequence.distance.html +++ b/docs/dev/generated/skbio.sequence.distance.html @@ -30,7 +30,7 @@ - + @@ -774,7 +774,7 @@

Functions - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.sequence.distance.kmer_distance.html b/docs/dev/generated/skbio.sequence.distance.kmer_distance.html index 0ff365f56..f71cd7719 100644 --- a/docs/dev/generated/skbio.sequence.distance.kmer_distance.html +++ b/docs/dev/generated/skbio.sequence.distance.kmer_distance.html @@ -31,7 +31,7 @@ - + @@ -720,7 +720,7 @@

skbio.sequence.distance.kmer_distancenp.nan will be returned if there are no kmers defined for the sequences.

Examples

-
>>> from skbio import Sequence
+
>>> from skbio import Sequence
 >>> seq1 = Sequence('ATCGGCGAT')
 >>> seq2 = Sequence('GCAGATGTG')
 >>> kmer_distance(seq1, seq2, 3) 
@@ -807,7 +807,7 @@ 

skbio.sequence.distance.kmer_distance - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.composition.alr.html b/docs/dev/generated/skbio.stats.composition.alr.html index 82236cad4..9215bad1f 100644 --- a/docs/dev/generated/skbio.stats.composition.alr.html +++ b/docs/dev/generated/skbio.stats.composition.alr.html @@ -31,7 +31,7 @@ - + @@ -736,8 +736,8 @@

skbio.stats.composition.alrExamples

-
>>> import numpy as np
->>> from skbio.stats.composition import alr
+
>>> import numpy as np
+>>> from skbio.stats.composition import alr
 >>> x = np.array([.1, .3, .4, .2])
 >>> alr(x)
 array([ 1.09861229,  1.38629436,  0.69314718])
@@ -823,7 +823,7 @@ 

skbio.stats.composition.alr - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.composition.alr_inv.html b/docs/dev/generated/skbio.stats.composition.alr_inv.html index 0d1f4c91c..54d0c4032 100644 --- a/docs/dev/generated/skbio.stats.composition.alr_inv.html +++ b/docs/dev/generated/skbio.stats.composition.alr_inv.html @@ -31,7 +31,7 @@ - + @@ -736,8 +736,8 @@

skbio.stats.composition.alr_invExamples

-
>>> import numpy as np
->>> from skbio.stats.composition import alr, alr_inv
+

Notes

@@ -830,8 +830,8 @@

skbio.stats.composition.ancomExamples

-
>>> from skbio.stats.composition import ancom
->>> import pandas as pd
+
>>> from skbio.stats.composition import ancom
+>>> import pandas as pd
 

Let’s load in a DataFrame with six samples and seven features (e.g., these @@ -1004,7 +1004,7 @@

skbio.stats.composition.ancom - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.composition.centralize.html b/docs/dev/generated/skbio.stats.composition.centralize.html index b5461fb6d..3ef50c6f8 100644 --- a/docs/dev/generated/skbio.stats.composition.centralize.html +++ b/docs/dev/generated/skbio.stats.composition.centralize.html @@ -31,7 +31,7 @@ - + @@ -718,8 +718,8 @@

skbio.stats.composition.centralizeExamples

-
>>> import numpy as np
->>> from skbio.stats.composition import centralize
+
>>> import numpy as np
+>>> from skbio.stats.composition import centralize
 >>> X = np.array([[.1, .3, .4, .2], [.2, .2, .2, .4]])
 >>> centralize(X)
 array([[ 0.17445763,  0.30216948,  0.34891526,  0.17445763],
@@ -806,7 +806,7 @@ 

skbio.stats.composition.centralize - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.composition.closure.html b/docs/dev/generated/skbio.stats.composition.closure.html index 18f22ebc6..e0bf9fd75 100644 --- a/docs/dev/generated/skbio.stats.composition.closure.html +++ b/docs/dev/generated/skbio.stats.composition.closure.html @@ -31,7 +31,7 @@ - + @@ -729,8 +729,8 @@

skbio.stats.composition.closureExamples

-
>>> import numpy as np
->>> from skbio.stats.composition import closure
+
>>> import numpy as np
+>>> from skbio.stats.composition import closure
 >>> X = np.array([[2, 2, 6], [4, 4, 2]])
 >>> closure(X)
 array([[ 0.2,  0.2,  0.6],
@@ -817,7 +817,7 @@ 

skbio.stats.composition.closure - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.composition.clr.html b/docs/dev/generated/skbio.stats.composition.clr.html index 34dc8d421..23a8075e0 100644 --- a/docs/dev/generated/skbio.stats.composition.clr.html +++ b/docs/dev/generated/skbio.stats.composition.clr.html @@ -31,7 +31,7 @@ - + @@ -731,8 +731,8 @@

skbio.stats.composition.clrExamples

-
>>> import numpy as np
->>> from skbio.stats.composition import clr
+
>>> import numpy as np
+>>> from skbio.stats.composition import clr
 >>> x = np.array([.1, .3, .4, .2])
 >>> clr(x)
 array([-0.79451346,  0.30409883,  0.5917809 , -0.10136628])
@@ -818,7 +818,7 @@ 

skbio.stats.composition.clr - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.composition.clr_inv.html b/docs/dev/generated/skbio.stats.composition.clr_inv.html index c7158ef88..8cf43220a 100644 --- a/docs/dev/generated/skbio.stats.composition.clr_inv.html +++ b/docs/dev/generated/skbio.stats.composition.clr_inv.html @@ -31,7 +31,7 @@ - + @@ -729,8 +729,8 @@

skbio.stats.composition.clr_invExamples

-
>>> import numpy as np
->>> from skbio.stats.composition import clr_inv
+

Notes

@@ -814,8 +814,8 @@

skbio.stats.composition.dirmult_ttestExamples

-
>>> import pandas as pd
->>> from skbio.stats.composition import dirmult_ttest
+
>>> import pandas as pd
+>>> from skbio.stats.composition import dirmult_ttest
 >>> table = pd.DataFrame([[20,  110, 100, 101, 100, 103, 104],
 ...                       [33,  110, 120, 100, 101, 100, 102],
 ...                       [12,  110, 100, 110, 100, 50,  90],
@@ -920,7 +920,7 @@ 

skbio.stats.composition.dirmult_ttest - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.composition.html b/docs/dev/generated/skbio.stats.composition.html index 2d902ee77..94be77a5d 100644 --- a/docs/dev/generated/skbio.stats.composition.html +++ b/docs/dev/generated/skbio.stats.composition.html @@ -30,7 +30,7 @@ - + @@ -939,7 +939,7 @@

References - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.composition.ilr.html b/docs/dev/generated/skbio.stats.composition.ilr.html index e7009b4a6..e537d3c68 100644 --- a/docs/dev/generated/skbio.stats.composition.ilr.html +++ b/docs/dev/generated/skbio.stats.composition.ilr.html @@ -31,7 +31,7 @@ - + @@ -741,8 +741,8 @@

skbio.stats.composition.ilrmat, then the dimensions of the basis needs be \((D-1) \times D\), where rows represent basis vectors, and the columns represent proportions.

Examples

-
>>> import numpy as np
->>> from skbio.stats.composition import ilr
+
>>> import numpy as np
+>>> from skbio.stats.composition import ilr
 >>> x = np.array([.1, .3, .4, .2])
 >>> ilr(x)
 array([-0.7768362 , -0.68339802,  0.11704769])
@@ -828,7 +828,7 @@ 

skbio.stats.composition.ilr - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.composition.ilr_inv.html b/docs/dev/generated/skbio.stats.composition.ilr_inv.html index 566d280f1..a102f1219 100644 --- a/docs/dev/generated/skbio.stats.composition.ilr_inv.html +++ b/docs/dev/generated/skbio.stats.composition.ilr_inv.html @@ -31,7 +31,7 @@ - + @@ -741,8 +741,8 @@

skbio.stats.composition.ilr_invmat, then the dimensions of the basis needs be \((D-1) \times D\), where rows represent basis vectors, and the columns represent proportions.

Examples

-
>>> import numpy as np
->>> from skbio.stats.composition import ilr
+
>>> import numpy as np
+>>> from skbio.stats.composition import ilr
 >>> x = np.array([.1, .3, .6,])
 >>> ilr_inv(x)
 array([ 0.34180297,  0.29672718,  0.22054469,  0.14092516])
@@ -828,7 +828,7 @@ 

skbio.stats.composition.ilr_inv - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.composition.inner.html b/docs/dev/generated/skbio.stats.composition.inner.html index cfda6550d..34b56551f 100644 --- a/docs/dev/generated/skbio.stats.composition.inner.html +++ b/docs/dev/generated/skbio.stats.composition.inner.html @@ -31,7 +31,7 @@ - + @@ -726,8 +726,8 @@

skbio.stats.composition.innerExamples

-
>>> import numpy as np
->>> from skbio.stats.composition import inner
+
>>> import numpy as np
+>>> from skbio.stats.composition import inner
 >>> x = np.array([.1, .3, .4, .2])
 >>> y = np.array([.2, .4, .2, .2])
 >>> inner(x, y)  
@@ -814,7 +814,7 @@ 

skbio.stats.composition.inner - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.composition.multi_replace.html b/docs/dev/generated/skbio.stats.composition.multi_replace.html index 155b676b5..139223166 100644 --- a/docs/dev/generated/skbio.stats.composition.multi_replace.html +++ b/docs/dev/generated/skbio.stats.composition.multi_replace.html @@ -31,7 +31,7 @@ - + @@ -746,8 +746,8 @@

skbio.stats.composition.multi_replaceExamples

-
>>> import numpy as np
->>> from skbio.stats.composition import multi_replace
+
>>> import numpy as np
+>>> from skbio.stats.composition import multi_replace
 >>> X = np.array([[.2, .4, .4, 0],[0, .5, .5, 0]])
 >>> multi_replace(X)
 array([[ 0.1875,  0.375 ,  0.375 ,  0.0625],
@@ -834,7 +834,7 @@ 

skbio.stats.composition.multi_replace - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.composition.pairwise_vlr.html b/docs/dev/generated/skbio.stats.composition.pairwise_vlr.html index 0a6f9665c..9f416f7d5 100644 --- a/docs/dev/generated/skbio.stats.composition.pairwise_vlr.html +++ b/docs/dev/generated/skbio.stats.composition.pairwise_vlr.html @@ -31,7 +31,7 @@ - + @@ -747,8 +747,8 @@

skbio.stats.composition.pairwise_vlrExamples

-
>>> import numpy as np
->>> from skbio.stats.composition import pairwise_vlr
+
>>> import numpy as np
+>>> from skbio.stats.composition import pairwise_vlr
 >>> mat = np.array([np.exp([1, 2, 2]),
 ...                 np.exp([2, 3, 6]),
 ...                 np.exp([2, 3, 12])]).T
@@ -839,7 +839,7 @@ 

skbio.stats.composition.pairwise_vlr - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.composition.perturb.html b/docs/dev/generated/skbio.stats.composition.perturb.html index 10c29a056..8c21c1a26 100644 --- a/docs/dev/generated/skbio.stats.composition.perturb.html +++ b/docs/dev/generated/skbio.stats.composition.perturb.html @@ -31,7 +31,7 @@ - + @@ -731,8 +731,8 @@

skbio.stats.composition.perturbExamples

-
>>> import numpy as np
->>> from skbio.stats.composition import perturb
+
>>> import numpy as np
+>>> from skbio.stats.composition import perturb
 

Consider a very simple environment with only three species. The species in @@ -831,7 +831,7 @@

skbio.stats.composition.perturb - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.composition.perturb_inv.html b/docs/dev/generated/skbio.stats.composition.perturb_inv.html index c6fa486d0..d3b8a7225 100644 --- a/docs/dev/generated/skbio.stats.composition.perturb_inv.html +++ b/docs/dev/generated/skbio.stats.composition.perturb_inv.html @@ -31,7 +31,7 @@ - + @@ -731,8 +731,8 @@

skbio.stats.composition.perturb_invExamples

-
>>> import numpy as np
->>> from skbio.stats.composition import perturb_inv
+
>>> import numpy as np
+>>> from skbio.stats.composition import perturb_inv
 >>> x = np.array([.1, .3, .4, .2])
 >>> y = np.array([1/6, 1/6, 1/3, 1/3])
 >>> perturb_inv(x, y)
@@ -819,7 +819,7 @@ 

skbio.stats.composition.perturb_inv - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.composition.power.html b/docs/dev/generated/skbio.stats.composition.power.html index 449a7faf7..e98f1064a 100644 --- a/docs/dev/generated/skbio.stats.composition.power.html +++ b/docs/dev/generated/skbio.stats.composition.power.html @@ -31,7 +31,7 @@ - + @@ -731,8 +731,8 @@

skbio.stats.composition.powerExamples

-
>>> import numpy as np
->>> from skbio.stats.composition import power
+
>>> import numpy as np
+>>> from skbio.stats.composition import power
 >>> x = np.array([.1, .3, .4, .2])
 >>> power(x, .1)
 array([ 0.23059566,  0.25737316,  0.26488486,  0.24714631])
@@ -818,7 +818,7 @@ 

skbio.stats.composition.power - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.composition.sbp_basis.html b/docs/dev/generated/skbio.stats.composition.sbp_basis.html index 245271e0a..eaf94bccf 100644 --- a/docs/dev/generated/skbio.stats.composition.sbp_basis.html +++ b/docs/dev/generated/skbio.stats.composition.sbp_basis.html @@ -31,7 +31,7 @@ - + @@ -756,7 +756,7 @@

skbio.stats.composition.sbp_basisExamples

-
>>> import numpy as np
+
>>> import numpy as np
 >>> sbp = np.array([[1, 1,-1,-1,-1],
 ...                 [1,-1, 0, 0, 0],
 ...                 [0, 0, 1,-1,-1],
@@ -849,7 +849,7 @@ 

skbio.stats.composition.sbp_basis - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.composition.tree_basis.html b/docs/dev/generated/skbio.stats.composition.tree_basis.html index 5f129e5d9..fb686c6a4 100644 --- a/docs/dev/generated/skbio.stats.composition.tree_basis.html +++ b/docs/dev/generated/skbio.stats.composition.tree_basis.html @@ -31,7 +31,7 @@ - + @@ -731,7 +731,7 @@

skbio.stats.composition.tree_basisExamples

-
>>> from skbio import TreeNode
+
>>> from skbio import TreeNode
 >>> tree = u"((b,c)a, d)root;"
 >>> t = TreeNode.read([tree])
 >>> basis, nodes = tree_basis(t)
@@ -820,7 +820,7 @@ 

skbio.stats.composition.tree_basis - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.composition.vlr.html b/docs/dev/generated/skbio.stats.composition.vlr.html index 939f3a70d..997c7af8e 100644 --- a/docs/dev/generated/skbio.stats.composition.vlr.html +++ b/docs/dev/generated/skbio.stats.composition.vlr.html @@ -31,7 +31,7 @@ - + @@ -743,8 +743,8 @@

skbio.stats.composition.vlrExamples

-
>>> import numpy as np
->>> from skbio.stats.composition import vlr
+
>>> import numpy as np
+>>> from skbio.stats.composition import vlr
 >>> x = np.exp([1, 2, 3])
 >>> y = np.exp([2, 3, 4])
 >>> vlr(x, y)  # no zeros
@@ -831,7 +831,7 @@ 

skbio.stats.composition.vlr - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.distance.DissimilarityMatrix.between.html b/docs/dev/generated/skbio.stats.distance.DissimilarityMatrix.between.html index 77aa8eef1..d6b29e56e 100644 --- a/docs/dev/generated/skbio.stats.distance.DissimilarityMatrix.between.html +++ b/docs/dev/generated/skbio.stats.distance.DissimilarityMatrix.between.html @@ -31,7 +31,7 @@ - + @@ -729,7 +729,7 @@

skbio.stats.distance.DissimilarityMatrix.betweenExamples

-
>>> from skbio.stats.distance import DissimilarityMatrix
+
>>> from skbio.stats.distance import DissimilarityMatrix
 >>> dm = DissimilarityMatrix([[0, 1, 2, 3, 4], [1, 0, 1, 2, 3],
 ...                           [2, 1, 0, 1, 2], [3, 2, 1, 0, 1],
 ...                           [4, 3, 2, 1, 0]],
@@ -824,7 +824,7 @@ 

skbio.stats.distance.DissimilarityMatrix.between - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.distance.DissimilarityMatrix.copy.html b/docs/dev/generated/skbio.stats.distance.DissimilarityMatrix.copy.html index 73c483187..ec8df2c47 100644 --- a/docs/dev/generated/skbio.stats.distance.DissimilarityMatrix.copy.html +++ b/docs/dev/generated/skbio.stats.distance.DissimilarityMatrix.copy.html @@ -31,7 +31,7 @@ - + @@ -785,7 +785,7 @@

skbio.stats.distance.DissimilarityMatrix.copy - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.distance.DissimilarityMatrix.filter.html b/docs/dev/generated/skbio.stats.distance.DissimilarityMatrix.filter.html index 2368ffc4f..1214adb2d 100644 --- a/docs/dev/generated/skbio.stats.distance.DissimilarityMatrix.filter.html +++ b/docs/dev/generated/skbio.stats.distance.DissimilarityMatrix.filter.html @@ -31,7 +31,7 @@ - + @@ -802,7 +802,7 @@

skbio.stats.distance.DissimilarityMatrix.filter - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.distance.DissimilarityMatrix.from_iterable.html b/docs/dev/generated/skbio.stats.distance.DissimilarityMatrix.from_iterable.html index f3ae5b75a..70d230028 100644 --- a/docs/dev/generated/skbio.stats.distance.DissimilarityMatrix.from_iterable.html +++ b/docs/dev/generated/skbio.stats.distance.DissimilarityMatrix.from_iterable.html @@ -31,7 +31,7 @@ - + @@ -808,7 +808,7 @@

skbio.stats.distance.DissimilarityMatrix.from_iterable - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.distance.DissimilarityMatrix.html b/docs/dev/generated/skbio.stats.distance.DissimilarityMatrix.html index 37212daff..2889b6b68 100644 --- a/docs/dev/generated/skbio.stats.distance.DissimilarityMatrix.html +++ b/docs/dev/generated/skbio.stats.distance.DissimilarityMatrix.html @@ -31,7 +31,7 @@ - + @@ -727,7 +727,7 @@

skbio.stats.distance.DissimilarityMatrixSee also

DistanceMatrix
-
scipy.spatial.distance.squareform
+
scipy.spatial.distance.squareform

Notes

@@ -1163,7 +1163,7 @@

skbio.stats.distance.DissimilarityMatrix - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.distance.DissimilarityMatrix.index.html b/docs/dev/generated/skbio.stats.distance.DissimilarityMatrix.index.html index 0331e8c7d..c8e562756 100644 --- a/docs/dev/generated/skbio.stats.distance.DissimilarityMatrix.index.html +++ b/docs/dev/generated/skbio.stats.distance.DissimilarityMatrix.index.html @@ -31,7 +31,7 @@ - + @@ -796,7 +796,7 @@

skbio.stats.distance.DissimilarityMatrix.index - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.distance.DissimilarityMatrix.plot.html b/docs/dev/generated/skbio.stats.distance.DissimilarityMatrix.plot.html index 68b038ce0..7695f47cc 100644 --- a/docs/dev/generated/skbio.stats.distance.DissimilarityMatrix.plot.html +++ b/docs/dev/generated/skbio.stats.distance.DissimilarityMatrix.plot.html @@ -31,7 +31,7 @@ - + @@ -718,7 +718,7 @@

skbio.stats.distance.DissimilarityMatrix.plotExamples

Define a dissimilarity matrix with five objects labeled A-E:

-
>>> from skbio.stats.distance import DissimilarityMatrix
+
>>> from skbio.stats.distance import DissimilarityMatrix
 >>> dm = DissimilarityMatrix([[0, 1, 2, 3, 4], [1, 0, 1, 2, 3],
 ...                           [2, 1, 0, 1, 2], [3, 2, 1, 0, 1],
 ...                           [4, 3, 2, 1, 0]],
@@ -812,7 +812,7 @@ 

skbio.stats.distance.DissimilarityMatrix.plot - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.distance.DissimilarityMatrix.read.html b/docs/dev/generated/skbio.stats.distance.DissimilarityMatrix.read.html index 6f15ce700..a55cf7ee0 100644 --- a/docs/dev/generated/skbio.stats.distance.DissimilarityMatrix.read.html +++ b/docs/dev/generated/skbio.stats.distance.DissimilarityMatrix.read.html @@ -31,7 +31,7 @@ - + @@ -815,7 +815,7 @@

skbio.stats.distance.DissimilarityMatrix.read - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.distance.DissimilarityMatrix.redundant_form.html b/docs/dev/generated/skbio.stats.distance.DissimilarityMatrix.redundant_form.html index bd79f8d5a..2ac83b14b 100644 --- a/docs/dev/generated/skbio.stats.distance.DissimilarityMatrix.redundant_form.html +++ b/docs/dev/generated/skbio.stats.distance.DissimilarityMatrix.redundant_form.html @@ -31,7 +31,7 @@ - + @@ -797,7 +797,7 @@

skbio.stats.distance.DissimilarityMatrix.redundant_form - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.distance.DissimilarityMatrix.rename.html b/docs/dev/generated/skbio.stats.distance.DissimilarityMatrix.rename.html index a1bbe81b2..fb871544e 100644 --- a/docs/dev/generated/skbio.stats.distance.DissimilarityMatrix.rename.html +++ b/docs/dev/generated/skbio.stats.distance.DissimilarityMatrix.rename.html @@ -31,7 +31,7 @@ - + @@ -715,7 +715,7 @@

skbio.stats.distance.DissimilarityMatrix.renameExamples

-
>>> from skbio import DistanceMatrix
+
>>> from skbio import DistanceMatrix
 >>> dm = DistanceMatrix([[0, 1], [1, 0]], ids=['a', 'b'])
 >>> dm.rename({'a': 'x', 'b': 'y'})
 >>> print(dm.ids)
@@ -802,7 +802,7 @@ 

skbio.stats.distance.DissimilarityMatrix.rename - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.distance.DissimilarityMatrix.to_data_frame.html b/docs/dev/generated/skbio.stats.distance.DissimilarityMatrix.to_data_frame.html index 377cfd1a9..015890353 100644 --- a/docs/dev/generated/skbio.stats.distance.DissimilarityMatrix.to_data_frame.html +++ b/docs/dev/generated/skbio.stats.distance.DissimilarityMatrix.to_data_frame.html @@ -31,7 +31,7 @@ - + @@ -705,7 +705,7 @@

skbio.stats.distance.DissimilarityMatrix.to_data_frame

Examples

-
>>> from skbio import DistanceMatrix
+
>>> from skbio import DistanceMatrix
 >>> dm = DistanceMatrix([[0, 1, 2],
 ...                      [1, 0, 3],
 ...                      [2, 3, 0]], ids=['a', 'b', 'c'])
@@ -797,7 +797,7 @@ 

skbio.stats.distance.DissimilarityMatrix.to_data_frame - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.distance.DissimilarityMatrix.transpose.html b/docs/dev/generated/skbio.stats.distance.DissimilarityMatrix.transpose.html index 0bd7a701c..980355936 100644 --- a/docs/dev/generated/skbio.stats.distance.DissimilarityMatrix.transpose.html +++ b/docs/dev/generated/skbio.stats.distance.DissimilarityMatrix.transpose.html @@ -31,7 +31,7 @@ - + @@ -787,7 +787,7 @@

skbio.stats.distance.DissimilarityMatrix.transpose - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.distance.DissimilarityMatrix.within.html b/docs/dev/generated/skbio.stats.distance.DissimilarityMatrix.within.html index 5c750d51e..5dde4ebe1 100644 --- a/docs/dev/generated/skbio.stats.distance.DissimilarityMatrix.within.html +++ b/docs/dev/generated/skbio.stats.distance.DissimilarityMatrix.within.html @@ -31,7 +31,7 @@ - + @@ -725,7 +725,7 @@

skbio.stats.distance.DissimilarityMatrix.withinExamples

-
>>> from skbio.stats.distance import DissimilarityMatrix
+
>>> from skbio.stats.distance import DissimilarityMatrix
 >>> dm = DissimilarityMatrix([[0, 1, 2, 3, 4], [1, 0, 1, 2, 3],
 ...                           [2, 1, 0, 1, 2], [3, 2, 1, 0, 1],
 ...                           [4, 3, 2, 1, 0]],
@@ -823,7 +823,7 @@ 

skbio.stats.distance.DissimilarityMatrix.within - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.distance.DissimilarityMatrix.write.html b/docs/dev/generated/skbio.stats.distance.DissimilarityMatrix.write.html index ac2335d13..cad25e5dc 100644 --- a/docs/dev/generated/skbio.stats.distance.DissimilarityMatrix.write.html +++ b/docs/dev/generated/skbio.stats.distance.DissimilarityMatrix.write.html @@ -31,7 +31,7 @@ - + @@ -808,7 +808,7 @@

skbio.stats.distance.DissimilarityMatrix.write - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.distance.DistanceMatrix.condensed_form.html b/docs/dev/generated/skbio.stats.distance.DistanceMatrix.condensed_form.html index dd17c342e..2fac6ef76 100644 --- a/docs/dev/generated/skbio.stats.distance.DistanceMatrix.condensed_form.html +++ b/docs/dev/generated/skbio.stats.distance.DistanceMatrix.condensed_form.html @@ -31,7 +31,7 @@ - + @@ -795,7 +795,7 @@

skbio.stats.distance.DistanceMatrix.condensed_form - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.distance.DistanceMatrix.from_iterable.html b/docs/dev/generated/skbio.stats.distance.DistanceMatrix.from_iterable.html index 99a4660b6..ed7ecd4c8 100644 --- a/docs/dev/generated/skbio.stats.distance.DistanceMatrix.from_iterable.html +++ b/docs/dev/generated/skbio.stats.distance.DistanceMatrix.from_iterable.html @@ -31,7 +31,7 @@ - + @@ -816,7 +816,7 @@

skbio.stats.distance.DistanceMatrix.from_iterable - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.distance.DistanceMatrix.html b/docs/dev/generated/skbio.stats.distance.DistanceMatrix.html index 1e55898eb..a97a33bc6 100644 --- a/docs/dev/generated/skbio.stats.distance.DistanceMatrix.html +++ b/docs/dev/generated/skbio.stats.distance.DistanceMatrix.html @@ -31,7 +31,7 @@ - + @@ -933,7 +933,7 @@

skbio.stats.distance.DistanceMatrix - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.distance.DistanceMatrix.permute.html b/docs/dev/generated/skbio.stats.distance.DistanceMatrix.permute.html index 2e6c057a4..3d499680b 100644 --- a/docs/dev/generated/skbio.stats.distance.DistanceMatrix.permute.html +++ b/docs/dev/generated/skbio.stats.distance.DistanceMatrix.permute.html @@ -31,7 +31,7 @@ - + @@ -813,7 +813,7 @@

skbio.stats.distance.DistanceMatrix.permute - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.distance.DistanceMatrix.to_series.html b/docs/dev/generated/skbio.stats.distance.DistanceMatrix.to_series.html index 05a5825d8..d29f6ca8e 100644 --- a/docs/dev/generated/skbio.stats.distance.DistanceMatrix.to_series.html +++ b/docs/dev/generated/skbio.stats.distance.DistanceMatrix.to_series.html @@ -31,7 +31,7 @@ - + @@ -718,11 +718,11 @@

skbio.stats.distance.DistanceMatrix.to_series
to_data_frame
condensed_form
-
scipy.spatial.distance.squareform
+
scipy.spatial.distance.squareform

Examples

-
>>> from skbio import DistanceMatrix
+
>>> from skbio import DistanceMatrix
 >>> dm = DistanceMatrix([[0, 1, 2, 3],
 ...                      [1, 0, 4, 5],
 ...                      [2, 4, 0, 6],
@@ -817,7 +817,7 @@ 

skbio.stats.distance.DistanceMatrix.to_series - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.distance.anosim.html b/docs/dev/generated/skbio.stats.distance.anosim.html index 94cb36f38..d3a8b912e 100644 --- a/docs/dev/generated/skbio.stats.distance.anosim.html +++ b/docs/dev/generated/skbio.stats.distance.anosim.html @@ -31,7 +31,7 @@ - + @@ -774,7 +774,7 @@

skbio.stats.distance.anosimExamples

Load a 4x4 distance matrix and grouping vector denoting 2 groups of objects:

-
>>> from skbio import DistanceMatrix
+
>>> from skbio import DistanceMatrix
 >>> dm = DistanceMatrix([[0, 1, 1, 4],
 ...                      [1, 0, 3, 2],
 ...                      [1, 3, 0, 3],
@@ -785,7 +785,7 @@ 

skbio.stats.distance.anosim
>>> from skbio.stats.distance import anosim
+
>>> from skbio.stats.distance import anosim
 >>> anosim(dm, grouping, permutations=99, seed=42)
 method name               ANOSIM
 test statistic name            R
@@ -817,7 +817,7 @@ 

skbio.stats.distance.anosimGroup column specifies the same grouping as the vector we used in the previous examples:

Notes

@@ -787,9 +787,9 @@

skbio.stats.distance.bioenvExamples

Import the functionality we’ll use in the following examples:

-

Load a distance matrix from the file:

-
>>> from io import StringIO
->>> from skbio import DistanceMatrix
+

A distance matrix object can also be created from an existing numpy.array (or an array-like object, such as a nested Python list):

-
>>> import numpy as np
+
@@ -836,8 +836,8 @@

skbio.stats.distance.mantelExamples

Import the functionality we’ll use in the following examples:

-
>>> from skbio import DistanceMatrix
->>> from skbio.stats.distance import mantel
+
>>> from skbio import DistanceMatrix
+>>> from skbio.stats.distance import mantel
 

Define two 3x3 distance matrices:

@@ -1004,7 +1004,7 @@

skbio.stats.distance.mantel - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.distance.permanova.html b/docs/dev/generated/skbio.stats.distance.permanova.html index 09b0d6cd6..e7b061d4b 100644 --- a/docs/dev/generated/skbio.stats.distance.permanova.html +++ b/docs/dev/generated/skbio.stats.distance.permanova.html @@ -31,7 +31,7 @@ - + @@ -853,7 +853,7 @@

skbio.stats.distance.permanova - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.distance.permdisp.html b/docs/dev/generated/skbio.stats.distance.permdisp.html index f3ca985ac..3ea8ff0d1 100644 --- a/docs/dev/generated/skbio.stats.distance.permdisp.html +++ b/docs/dev/generated/skbio.stats.distance.permdisp.html @@ -31,7 +31,7 @@ - + @@ -812,7 +812,7 @@

skbio.stats.distance.permdispExamples

Load a 6x6 distance matrix and grouping vector denoting 2 groups of objects:

-
>>> from skbio import DistanceMatrix
+
>>> from skbio import DistanceMatrix
 >>> dm = DistanceMatrix([[0,    0.5,  0.75, 1, 0.66, 0.33],
 ...                       [0.5,  0,    0.25, 0.33, 0.77, 0.61],
 ...                       [0.75, 0.25, 0,    0.1, 0.44, 0.55],
@@ -825,7 +825,7 @@ 

skbio.stats.distance.permdisp
>>> from skbio.stats.distance import permdisp
+
>>> from skbio.stats.distance import permdisp
 >>> permdisp(dm, grouping, permutations=99, seed=42) 
 method name               PERMDISP
 test statistic name        F-value
@@ -875,7 +875,7 @@ 

skbio.stats.distance.permdisp
>>> import pandas as pd
+
>>> import pandas as pd
 >>> df = pd.DataFrame.from_dict(
 ...      {'Grouping': {'s1': 'G1', 's2': 'G1', 's3': 'G1', 's4': 'G2',
 ...                    's5': 'G2', 's6': 'G2'}})
@@ -986,7 +986,7 @@ 

skbio.stats.distance.permdisp - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.distance.pwmantel.html b/docs/dev/generated/skbio.stats.distance.pwmantel.html index edea58f99..50d89d893 100644 --- a/docs/dev/generated/skbio.stats.distance.pwmantel.html +++ b/docs/dev/generated/skbio.stats.distance.pwmantel.html @@ -31,7 +31,7 @@ - + @@ -754,8 +754,8 @@

skbio.stats.distance.pwmantelExamples

Import the functionality we’ll use in the following examples:

-

Notes

@@ -783,7 +783,7 @@

skbio.stats.evolve.hommola_cospeciationExamples

-
>>> from skbio.stats.evolve import hommola_cospeciation
+
>>> from skbio.stats.evolve import hommola_cospeciation
 

Create arrays for host distances, parasite distances, and their @@ -894,7 +894,7 @@

skbio.stats.evolve.hommola_cospeciation - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.evolve.html b/docs/dev/generated/skbio.stats.evolve.html index ad0a1a472..aaa168129 100644 --- a/docs/dev/generated/skbio.stats.evolve.html +++ b/docs/dev/generated/skbio.stats.evolve.html @@ -30,7 +30,7 @@ - + @@ -775,7 +775,7 @@

Functions - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.gradient.AverageGradientANOVA.html b/docs/dev/generated/skbio.stats.gradient.AverageGradientANOVA.html index 3701c018d..ead13d2e2 100644 --- a/docs/dev/generated/skbio.stats.gradient.AverageGradientANOVA.html +++ b/docs/dev/generated/skbio.stats.gradient.AverageGradientANOVA.html @@ -31,7 +31,7 @@ - + @@ -824,7 +824,7 @@

skbio.stats.gradient.AverageGradientANOVA - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.gradient.CategoryResults.html b/docs/dev/generated/skbio.stats.gradient.CategoryResults.html index 05d786dce..00bc10bdf 100644 --- a/docs/dev/generated/skbio.stats.gradient.CategoryResults.html +++ b/docs/dev/generated/skbio.stats.gradient.CategoryResults.html @@ -31,7 +31,7 @@ - + @@ -829,7 +829,7 @@

skbio.stats.gradient.CategoryResults - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.gradient.CategoryResults.to_files.html b/docs/dev/generated/skbio.stats.gradient.CategoryResults.to_files.html index 511287695..5280e691b 100644 --- a/docs/dev/generated/skbio.stats.gradient.CategoryResults.to_files.html +++ b/docs/dev/generated/skbio.stats.gradient.CategoryResults.to_files.html @@ -31,7 +31,7 @@ - + @@ -789,7 +789,7 @@

skbio.stats.gradient.CategoryResults.to_files - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.gradient.FirstDifferenceGradientANOVA.html b/docs/dev/generated/skbio.stats.gradient.FirstDifferenceGradientANOVA.html index c9d0671a9..6f86607f4 100644 --- a/docs/dev/generated/skbio.stats.gradient.FirstDifferenceGradientANOVA.html +++ b/docs/dev/generated/skbio.stats.gradient.FirstDifferenceGradientANOVA.html @@ -31,7 +31,7 @@ - + @@ -823,7 +823,7 @@

skbio.stats.gradient.FirstDifferenceGradientANOVA - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.gradient.GradientANOVA.get_trajectories.html b/docs/dev/generated/skbio.stats.gradient.GradientANOVA.get_trajectories.html index 84b0fc4fe..e8c7daf15 100644 --- a/docs/dev/generated/skbio.stats.gradient.GradientANOVA.get_trajectories.html +++ b/docs/dev/generated/skbio.stats.gradient.GradientANOVA.get_trajectories.html @@ -31,7 +31,7 @@ - + @@ -785,7 +785,7 @@

skbio.stats.gradient.GradientANOVA.get_trajectories - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.gradient.GradientANOVA.html b/docs/dev/generated/skbio.stats.gradient.GradientANOVA.html index 702efbf34..4ddf5bfbf 100644 --- a/docs/dev/generated/skbio.stats.gradient.GradientANOVA.html +++ b/docs/dev/generated/skbio.stats.gradient.GradientANOVA.html @@ -31,7 +31,7 @@ - + @@ -854,7 +854,7 @@

skbio.stats.gradient.GradientANOVA - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.gradient.GradientANOVAResults.html b/docs/dev/generated/skbio.stats.gradient.GradientANOVAResults.html index 19b2eb237..c4dd828ca 100644 --- a/docs/dev/generated/skbio.stats.gradient.GradientANOVAResults.html +++ b/docs/dev/generated/skbio.stats.gradient.GradientANOVAResults.html @@ -31,7 +31,7 @@ - + @@ -827,7 +827,7 @@

skbio.stats.gradient.GradientANOVAResults - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.gradient.GradientANOVAResults.to_files.html b/docs/dev/generated/skbio.stats.gradient.GradientANOVAResults.to_files.html index 036d60c27..7bf9266d2 100644 --- a/docs/dev/generated/skbio.stats.gradient.GradientANOVAResults.to_files.html +++ b/docs/dev/generated/skbio.stats.gradient.GradientANOVAResults.to_files.html @@ -31,7 +31,7 @@ - + @@ -789,7 +789,7 @@

skbio.stats.gradient.GradientANOVAResults.to_files - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.gradient.GroupResults.html b/docs/dev/generated/skbio.stats.gradient.GroupResults.html index 760ecba7f..83a5b20fa 100644 --- a/docs/dev/generated/skbio.stats.gradient.GroupResults.html +++ b/docs/dev/generated/skbio.stats.gradient.GroupResults.html @@ -31,7 +31,7 @@ - + @@ -832,7 +832,7 @@

skbio.stats.gradient.GroupResults - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.gradient.GroupResults.to_files.html b/docs/dev/generated/skbio.stats.gradient.GroupResults.to_files.html index 951af5092..fef6c935a 100644 --- a/docs/dev/generated/skbio.stats.gradient.GroupResults.to_files.html +++ b/docs/dev/generated/skbio.stats.gradient.GroupResults.to_files.html @@ -31,7 +31,7 @@ - + @@ -789,7 +789,7 @@

skbio.stats.gradient.GroupResults.to_files - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.gradient.TrajectoryGradientANOVA.html b/docs/dev/generated/skbio.stats.gradient.TrajectoryGradientANOVA.html index 91c7020e5..85d2ee700 100644 --- a/docs/dev/generated/skbio.stats.gradient.TrajectoryGradientANOVA.html +++ b/docs/dev/generated/skbio.stats.gradient.TrajectoryGradientANOVA.html @@ -31,7 +31,7 @@ - + @@ -825,7 +825,7 @@

skbio.stats.gradient.TrajectoryGradientANOVA - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.gradient.WindowDifferenceGradientANOVA.html b/docs/dev/generated/skbio.stats.gradient.WindowDifferenceGradientANOVA.html index 3c5ef3b56..78c2b1b7b 100644 --- a/docs/dev/generated/skbio.stats.gradient.WindowDifferenceGradientANOVA.html +++ b/docs/dev/generated/skbio.stats.gradient.WindowDifferenceGradientANOVA.html @@ -31,7 +31,7 @@ - + @@ -846,7 +846,7 @@

skbio.stats.gradient.WindowDifferenceGradientANOVA - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.gradient.html b/docs/dev/generated/skbio.stats.gradient.html index f714325f1..8c2fdf2c5 100644 --- a/docs/dev/generated/skbio.stats.gradient.html +++ b/docs/dev/generated/skbio.stats.gradient.html @@ -30,7 +30,7 @@ - + @@ -723,9 +723,9 @@

Classes#<

Examples#

Assume we have the following coordinates:

-
>>> import numpy as np
->>> import pandas as pd
->>> from skbio.stats.gradient import AverageGradientANOVA
+
>>> import numpy as np
+>>> import pandas as pd
+>>> from skbio.stats.gradient import AverageGradientANOVA
 >>> coord_data = {'PC.354': np.array([0.2761, -0.0341, 0.0633, 0.1004]),
 ...               'PC.355': np.array([0.2364, 0.2186, -0.0301, -0.0225]),
 ...               'PC.356': np.array([0.2208, 0.0874, -0.3519, -0.0031]),
@@ -860,7 +860,7 @@ 

Examples diff --git a/docs/dev/generated/skbio.stats.isubsample.html b/docs/dev/generated/skbio.stats.isubsample.html index f21c33c40..c2a7dbe9c 100644 --- a/docs/dev/generated/skbio.stats.isubsample.html +++ b/docs/dev/generated/skbio.stats.isubsample.html @@ -31,7 +31,7 @@ - + @@ -744,7 +744,7 @@

skbio.stats.isubsampleExamples

Randomly keep up to 2 sequences per sample from a set of demultiplexed sequences:

-
>>> from skbio.stats import isubsample
+
>>> from skbio.stats import isubsample
 >>> seqs = [('sampleA', 'AATTGG'),
 ...         ('sampleB', 'ATATATAT'),
 ...         ('sampleC', 'ATGGCC'),
@@ -851,7 +851,7 @@ 

skbio.stats.isubsample - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.ordination.OrdinationResults.html b/docs/dev/generated/skbio.stats.ordination.OrdinationResults.html index 238ded0a3..db977fef7 100644 --- a/docs/dev/generated/skbio.stats.ordination.OrdinationResults.html +++ b/docs/dev/generated/skbio.stats.ordination.OrdinationResults.html @@ -31,7 +31,7 @@ - + @@ -923,7 +923,7 @@

skbio.stats.ordination.OrdinationResults - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.ordination.OrdinationResults.plot.html b/docs/dev/generated/skbio.stats.ordination.OrdinationResults.plot.html index e0f3eaeea..0e48cd3a0 100644 --- a/docs/dev/generated/skbio.stats.ordination.OrdinationResults.plot.html +++ b/docs/dev/generated/skbio.stats.ordination.OrdinationResults.plot.html @@ -31,7 +31,7 @@ - + @@ -786,7 +786,7 @@

skbio.stats.ordination.OrdinationResults.plotExamples

Define a distance matrix with four samples labelled A-D:

-
>>> from skbio import DistanceMatrix
+
>>> from skbio import DistanceMatrix
 >>> dm = DistanceMatrix([[0., 0.21712454, 0.5007512, 0.91769271],
 ...                      [0.21712454, 0., 0.45995501, 0.80332382],
 ...                      [0.5007512, 0.45995501, 0., 0.65463348],
@@ -795,7 +795,7 @@ 

skbio.stats.ordination.OrdinationResults.plotpandas.DataFrame:

-
>>> import pandas as pd
+
>>> import pandas as pd
 >>> metadata = {
 ...     'A': {'body_site': 'skin'},
 ...     'B': {'body_site': 'gut'},
@@ -805,7 +805,7 @@ 

skbio.stats.ordination.OrdinationResults.plot
>>> from skbio.stats.ordination import pcoa
+
>>> from skbio.stats.ordination import pcoa
 >>> pcoa_results = pcoa(dm)
 
@@ -901,7 +901,7 @@

skbio.stats.ordination.OrdinationResults.plot - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.ordination.OrdinationResults.read.html b/docs/dev/generated/skbio.stats.ordination.OrdinationResults.read.html index 7a3528da6..4f81f2299 100644 --- a/docs/dev/generated/skbio.stats.ordination.OrdinationResults.read.html +++ b/docs/dev/generated/skbio.stats.ordination.OrdinationResults.read.html @@ -31,7 +31,7 @@ - + @@ -816,7 +816,7 @@

skbio.stats.ordination.OrdinationResults.read - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.ordination.OrdinationResults.rename.html b/docs/dev/generated/skbio.stats.ordination.OrdinationResults.rename.html index 18b7b1734..7fb13f7de 100644 --- a/docs/dev/generated/skbio.stats.ordination.OrdinationResults.rename.html +++ b/docs/dev/generated/skbio.stats.ordination.OrdinationResults.rename.html @@ -31,7 +31,7 @@ - + @@ -804,7 +804,7 @@

skbio.stats.ordination.OrdinationResults.rename - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.ordination.OrdinationResults.write.html b/docs/dev/generated/skbio.stats.ordination.OrdinationResults.write.html index a9a8f51dd..282ed60be 100644 --- a/docs/dev/generated/skbio.stats.ordination.OrdinationResults.write.html +++ b/docs/dev/generated/skbio.stats.ordination.OrdinationResults.write.html @@ -31,7 +31,7 @@ - + @@ -809,7 +809,7 @@

skbio.stats.ordination.OrdinationResults.write - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.ordination.ca.html b/docs/dev/generated/skbio.stats.ordination.ca.html index f25a9ceeb..988fe50e5 100644 --- a/docs/dev/generated/skbio.stats.ordination.ca.html +++ b/docs/dev/generated/skbio.stats.ordination.ca.html @@ -31,7 +31,7 @@ - + @@ -708,35 +708,18 @@

skbio.stats.ordination.ca +
Parameters:
-
+
Xpd.DataFrame

Samples by features table (n, m). It can be applied to different kinds of data tables but data must be non-negative and dimensionally homogeneous (quantitative or binary). The rows correspond to the samples and the columns correspond to the features.

-
scaling{1, 2}

For a more detailed explanation of the interpretation, check Legendre & -Legendre 1998, section 9.4.3. The notes that follow are quick -recommendations.

-

Scaling type 1 maintains \(\chi^2\) distances between rows -(samples): in the transformed space, the euclidean distances between -rows are equal to the \(\chi^2\) distances between rows in the -original space. It should be used when studying the ordination of -samples. Rows (samples) that are near a column (features) have high -contributions from it.

-

Scaling type 2 preserves \(\chi^2\) distances between columns -(features), so euclidean distance between columns after transformation -is equal to \(\chi^2\) distance between columns in the original -space. It is best used when we are interested in the ordination of -features. A column (features) that is next to a row (sample) means that -it is more abundant there.

-

Other types of scalings are currently not implemented, as they’re less -used by ecologists (Legendre & Legendre 1998, p. 456).

-

In general, features appearing far from the center of the biplot and -far from its edges will probably exhibit better relationships than -features either in the center (may be multimodal features, not related -to the shown ordination axes…) or the edges (sparse features…).

+
scaling{1, 2}

Scaling type 1 maintains \(\chi^2\) distances between rows. +Scaling type 2 preserves \(\chi^2\) distances between columns. +For a more detailed explanation of the interpretation, +check notes below and Legendre & Legendre 1998, section 9.4.3.

@@ -768,6 +751,20 @@

skbio.stats.ordination.caNotes

The algorithm is based on [1], S 9.4.1., and is expected to give the same results as cca(X) in R’s package vegan.

+

In Scaling type 1, the euclidean distances between rows in the transformed +space equal their \(\chi^2\) distances in the original space. +Rows (samples) near a column (features) indicate high contributions from +that feature.

+

In Scaling type 2, the euclidean distances between columns in the +transformed space equal their \(\chi^2\) distances in the original +space. Columns (features) near a row (sample) indicate higher abundance +in that sample. +Other types of scalings are currently not implemented, as they are less used +by ecologists (Legendre & Legendre 1998, p. 456).

+

Features far from the center of the biplot and far from its edges often +exhibit better relationships than features either in the center (may represent +multimodal features, not related to the shown ordination axes) or the +edges (sparse features).

References

@@ -856,7 +853,7 @@

skbio.stats.ordination.ca - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.ordination.cca.html b/docs/dev/generated/skbio.stats.ordination.cca.html index b942eb806..a9eb32e5c 100644 --- a/docs/dev/generated/skbio.stats.ordination.cca.html +++ b/docs/dev/generated/skbio.stats.ordination.cca.html @@ -31,7 +31,7 @@ - + @@ -864,7 +864,7 @@

skbio.stats.ordination.cca - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.ordination.corr.html b/docs/dev/generated/skbio.stats.ordination.corr.html index c76d406d4..7635bdc47 100644 --- a/docs/dev/generated/skbio.stats.ordination.corr.html +++ b/docs/dev/generated/skbio.stats.ordination.corr.html @@ -31,7 +31,7 @@ - + @@ -799,7 +799,7 @@

skbio.stats.ordination.corr - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.ordination.e_matrix.html b/docs/dev/generated/skbio.stats.ordination.e_matrix.html index 82cc2dea5..a52438cc6 100644 --- a/docs/dev/generated/skbio.stats.ordination.e_matrix.html +++ b/docs/dev/generated/skbio.stats.ordination.e_matrix.html @@ -31,7 +31,7 @@ - + @@ -778,7 +778,7 @@

skbio.stats.ordination.e_matrix - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.ordination.f_matrix.html b/docs/dev/generated/skbio.stats.ordination.f_matrix.html index 2c6e75496..0f225c06c 100644 --- a/docs/dev/generated/skbio.stats.ordination.f_matrix.html +++ b/docs/dev/generated/skbio.stats.ordination.f_matrix.html @@ -31,7 +31,7 @@ - + @@ -779,7 +779,7 @@

skbio.stats.ordination.f_matrix - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.ordination.html b/docs/dev/generated/skbio.stats.ordination.html index f449bd767..50d93c44e 100644 --- a/docs/dev/generated/skbio.stats.ordination.html +++ b/docs/dev/generated/skbio.stats.ordination.html @@ -30,7 +30,7 @@ - + @@ -781,8 +781,8 @@

Examples

This is an artificial dataset (table 11.3 in [1]) that represents fish abundance in different sites (Y, the response variables) and environmental variables (X, the explanatory variables).

-
>>> import numpy as np
->>> import pandas as pd
+
>>> import numpy as np
+>>> import pandas as pd
 

First we need to construct our explanatory variable dataset X.

@@ -823,7 +823,7 @@

Examples

We can now perform canonical correspondence analysis. Matrix X contains a continuous variable (depth) and a categorical one (substrate type) encoded using a one-hot encoding.

-
>>> from skbio.stats.ordination import cca
+
>>> from skbio.stats.ordination import cca
 

We explicitly need to avoid perfect collinearity, so we’ll drop one of the @@ -942,7 +942,7 @@

References - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.ordination.mean_and_std.html b/docs/dev/generated/skbio.stats.ordination.mean_and_std.html index 68515a0c7..ec13e0646 100644 --- a/docs/dev/generated/skbio.stats.ordination.mean_and_std.html +++ b/docs/dev/generated/skbio.stats.ordination.mean_and_std.html @@ -31,7 +31,7 @@ - + @@ -810,7 +810,7 @@

skbio.stats.ordination.mean_and_std - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.ordination.pcoa.html b/docs/dev/generated/skbio.stats.ordination.pcoa.html index be3025f77..03e9b7f38 100644 --- a/docs/dev/generated/skbio.stats.ordination.pcoa.html +++ b/docs/dev/generated/skbio.stats.ordination.pcoa.html @@ -31,7 +31,7 @@ - + @@ -871,7 +871,7 @@

skbio.stats.ordination.pcoa - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.ordination.pcoa_biplot.html b/docs/dev/generated/skbio.stats.ordination.pcoa_biplot.html index 520a9a24c..c7dd30d88 100644 --- a/docs/dev/generated/skbio.stats.ordination.pcoa_biplot.html +++ b/docs/dev/generated/skbio.stats.ordination.pcoa_biplot.html @@ -31,7 +31,7 @@ - + @@ -805,7 +805,7 @@

skbio.stats.ordination.pcoa_biplot - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.ordination.rda.html b/docs/dev/generated/skbio.stats.ordination.rda.html index 289647ef7..5c5771bfd 100644 --- a/docs/dev/generated/skbio.stats.ordination.rda.html +++ b/docs/dev/generated/skbio.stats.ordination.rda.html @@ -31,7 +31,7 @@ - + @@ -858,7 +858,7 @@

skbio.stats.ordination.rda - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.ordination.scale.html b/docs/dev/generated/skbio.stats.ordination.scale.html index f33628123..7a685754f 100644 --- a/docs/dev/generated/skbio.stats.ordination.scale.html +++ b/docs/dev/generated/skbio.stats.ordination.scale.html @@ -31,7 +31,7 @@ - + @@ -808,7 +808,7 @@

skbio.stats.ordination.scale - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.ordination.svd_rank.html b/docs/dev/generated/skbio.stats.ordination.svd_rank.html index da9bc25d3..592acdc07 100644 --- a/docs/dev/generated/skbio.stats.ordination.svd_rank.html +++ b/docs/dev/generated/skbio.stats.ordination.svd_rank.html @@ -31,7 +31,7 @@ - + @@ -779,7 +779,7 @@

skbio.stats.ordination.svd_rank - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.power.confidence_bound.html b/docs/dev/generated/skbio.stats.power.confidence_bound.html index d4055ac53..3b223361a 100644 --- a/docs/dev/generated/skbio.stats.power.confidence_bound.html +++ b/docs/dev/generated/skbio.stats.power.confidence_bound.html @@ -31,7 +31,7 @@ - + @@ -792,7 +792,7 @@

skbio.stats.power.confidence_bound - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.power.html b/docs/dev/generated/skbio.stats.power.html index f21796d5d..d9b685347 100644 --- a/docs/dev/generated/skbio.stats.power.html +++ b/docs/dev/generated/skbio.stats.power.html @@ -30,7 +30,7 @@ - + @@ -737,7 +737,7 @@

Examples variables, ind and dep. Let’s use random subsampling to estimate the statistical power of our test with an alpha of 0.1, 0.01, and 0.001.

We will use a random seed to ensure the reproducibility of results.

-
>>> import numpy as np
+
 

Let’s define a test that will draw a list of sample pairs and determine -if they’re correlated. We’ll use scipy.stats.pearsonr() which takes +if they’re correlated. We’ll use scipy.stats.pearsonr() which takes two arrays and returns a correlation coefficient and a p-value representing the probability the two distributions are correlated.

-
>>> from scipy.stats import pearsonr
+
>>> from scipy.stats import pearsonr
 >>> f = lambda x: pearsonr(*x).pvalue
 
@@ -768,7 +768,7 @@

Examples by setting draw_mode to “matched”. We can also set our critical value, so that we estimate power for a critical value of \(\alpha = 0.05\), an estimate for the critical value of 0.01, and a critical value of 0.001.

-
>>> from skbio.stats.power import subsample_power
+
>>> from skbio.stats.power import subsample_power
 >>> pwr_100, counts_100 = subsample_power(
 ...     test=f, samples=samples, max_counts=10, min_counts=3, counts_interval=1,
 ...     draw_mode='matched', alpha_pwr=0.1, num_iter=25, seed=rng)
@@ -871,7 +871,7 @@ 

Examples diff --git a/docs/dev/generated/skbio.stats.power.paired_subsamples.html b/docs/dev/generated/skbio.stats.power.paired_subsamples.html index a8900709e..f9e9f9e4a 100644 --- a/docs/dev/generated/skbio.stats.power.paired_subsamples.html +++ b/docs/dev/generated/skbio.stats.power.paired_subsamples.html @@ -31,7 +31,7 @@ - + @@ -734,8 +734,8 @@

skbio.stats.power.paired_subsamplesExamples

If we have a mapping file for a set of random individuals looking at housing, sex, age and antibiotic use.

-
>>> import pandas as pd
->>> import numpy as np
+
>>> import pandas as pd
+>>> import numpy as np
 >>> meta = {'SW': {'HOUSING': '2', 'SEX': 'M', 'AGE': np.nan, 'ABX': 'Y'},
 ...         'TS': {'HOUSING': '2', 'SEX': 'M', 'AGE': '40s', 'ABX': 'Y'},
 ...         'CB': {'HOUSING': '3', 'SEX': 'M', 'AGE': '40s', 'ABX': 'Y'},
@@ -752,7 +752,7 @@ 

skbio.stats.power.paired_subsamples
>>> from skbio.stats.power import paired_subsamples
+
>>> from skbio.stats.power import paired_subsamples
 >>> ids = paired_subsamples(meta, 'HOUSING', ['SEX', 'AGE', 'ABX'])
 >>> np.hstack(ids) 
 array(['BB', 'TS', 'CB']...)
@@ -841,7 +841,7 @@ 

skbio.stats.power.paired_subsamples - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.power.subsample_paired_power.html b/docs/dev/generated/skbio.stats.power.subsample_paired_power.html index a3f0c2692..6cc03e718 100644 --- a/docs/dev/generated/skbio.stats.power.subsample_paired_power.html +++ b/docs/dev/generated/skbio.stats.power.subsample_paired_power.html @@ -31,7 +31,7 @@ - + @@ -773,8 +773,8 @@

skbio.stats.power.subsample_paired_power
>>> import numpy as np
->>> import pandas as pd
+
>>> import numpy as np
+>>> import pandas as pd
 >>> rng = np.random.default_rng(123)
 >>> data = pd.DataFrame.from_dict({
 ...     'CELL_LINE': rng.binomial(1, 0.5, size=(60,)),
@@ -790,7 +790,7 @@ 

skbio.stats.power.subsample_paired_power
>>> from scipy.stats import kruskal
+
>>> from scipy.stats import kruskal
 >>> f = lambda x: kruskal(*[data.loc[i, 'OUTCOME'] for i in x]).pvalue
 
@@ -814,7 +814,7 @@

skbio.stats.power.subsample_paired_power
>>> control_cats = ['SOURCE', 'CELL_LINE']
->>> from skbio.stats.power import subsample_paired_power
+>>> from skbio.stats.power import subsample_paired_power
 >>> pwr, cnt = subsample_paired_power(
 ...     test=f, meta=data, cat='TREATMENT', control_cats=control_cats,
 ...     counts_interval=5, num_iter=25, num_runs=5, seed=rng)
@@ -910,7 +910,7 @@ 

skbio.stats.power.subsample_paired_power - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.power.subsample_power.html b/docs/dev/generated/skbio.stats.power.subsample_power.html index 85dfd3079..fe3392bcc 100644 --- a/docs/dev/generated/skbio.stats.power.subsample_power.html +++ b/docs/dev/generated/skbio.stats.power.subsample_power.html @@ -31,7 +31,7 @@ - + @@ -782,7 +782,7 @@

skbio.stats.power.subsample_power
>>> import numpy as np
+
>>> import numpy as np
 >>> rng = np.random.default_rng(123)
 >>> pre_rate = rng.binomial(1, 0.85, size=50)
 >>> print(pre_rate.sum())
@@ -794,9 +794,9 @@ 

skbio.stats.power.subsample_powerscipy.stats.chisquare() to look for the difference in frequency +scipy.stats.chisquare() to look for the difference in frequency between groups.

-
>>> from scipy.stats import chisquare
+
>>> from scipy.stats import chisquare
 >>> test = lambda x: chisquare(np.array([x[i].sum() for i in
 ...     range(len(x))])).pvalue
 
@@ -813,7 +813,7 @@

skbio.stats.power.subsample_powersubsample_paired_power(). We’ll also use “ind” draw_mode, since there is no linkage between the two groups of samples.

-
>>> from skbio.stats.power import subsample_power
+
>>> from skbio.stats.power import subsample_power
 >>> pwr_est, counts = subsample_power(
 ...     test=test, samples=[pre_rate, pos_rate], num_iter=100, num_runs=5,
 ...     counts_interval=5, seed=rng)
@@ -848,7 +848,7 @@ 

skbio.stats.power.subsample_power
>>> from scipy.stats import kruskal
+
>>> from scipy.stats import kruskal
 >>> test2 = lambda x: kruskal(*x).pvalue
 >>> print('{:.3e}'.format(test2([met_pos, met_neg])))
 9.783e-06
@@ -956,7 +956,7 @@ 

skbio.stats.power.subsample_power - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.stats.subsample_counts.html b/docs/dev/generated/skbio.stats.subsample_counts.html index c0b894f21..89c627079 100644 --- a/docs/dev/generated/skbio.stats.subsample_counts.html +++ b/docs/dev/generated/skbio.stats.subsample_counts.html @@ -31,7 +31,7 @@ - + @@ -727,8 +727,8 @@

skbio.stats.subsample_countsExamples

Subsample 4 items (without replacement) from a vector of counts:

-
>>> import numpy as np
->>> from skbio.stats import subsample_counts
+
>>> import numpy as np
+>>> from skbio.stats import subsample_counts
 >>> a = np.array([4, 5, 0, 2, 1])
 >>> sub = subsample_counts(a, 4)
 >>> sub.sum()
@@ -831,7 +831,7 @@ 

skbio.stats.subsample_counts - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.table.Table.add_group_metadata.html b/docs/dev/generated/skbio.table.Table.add_group_metadata.html index 01c2dd855..3aeb8fb48 100644 --- a/docs/dev/generated/skbio.table.Table.add_group_metadata.html +++ b/docs/dev/generated/skbio.table.Table.add_group_metadata.html @@ -31,7 +31,7 @@ - + @@ -824,7 +824,7 @@

skbio.table.Table.add_group_metadata - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.table.Table.add_metadata.html b/docs/dev/generated/skbio.table.Table.add_metadata.html index 882d10926..8ccf44a69 100644 --- a/docs/dev/generated/skbio.table.Table.add_metadata.html +++ b/docs/dev/generated/skbio.table.Table.add_metadata.html @@ -31,7 +31,7 @@ - + @@ -818,7 +818,7 @@

skbio.table.Table.add_metadata - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.table.Table.align_to.html b/docs/dev/generated/skbio.table.Table.align_to.html index 7682e82a4..b30790c81 100644 --- a/docs/dev/generated/skbio.table.Table.align_to.html +++ b/docs/dev/generated/skbio.table.Table.align_to.html @@ -31,7 +31,7 @@ - + @@ -751,8 +751,8 @@

skbio.table.Table.align_to
>>> from biom import Table
->>> import numpy as np
+
>>> from biom import Table
+>>> import numpy as np
 >>> amplicon = Table(np.array([[0, 1, 2], [3, 4, 5]]),
 ...                  ['Ecoli', 'Staphylococcus'],
 ...                  ['S1', 'S2', 'S3'])
@@ -847,7 +847,7 @@ 

skbio.table.Table.align_to - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.table.Table.align_to_dataframe.html b/docs/dev/generated/skbio.table.Table.align_to_dataframe.html index 58c025d27..f6af27c0b 100644 --- a/docs/dev/generated/skbio.table.Table.align_to_dataframe.html +++ b/docs/dev/generated/skbio.table.Table.align_to_dataframe.html @@ -31,7 +31,7 @@ - + @@ -748,9 +748,9 @@

skbio.table.Table.align_to_dataframeExamples

-
>>> from biom import Table
->>> import numpy as np
->>> import pandas as pd
+
>>> from biom import Table
+>>> import numpy as np
+>>> import pandas as pd
 >>> table = Table(np.array([[0, 0, 1, 1],
 ...                         [2, 2, 4, 4],
 ...                         [5, 5, 3, 3],
@@ -856,7 +856,7 @@ 

skbio.table.Table.align_to_dataframe - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.table.Table.align_tree.html b/docs/dev/generated/skbio.table.Table.align_tree.html index e8753d4f7..c64c2f40d 100644 --- a/docs/dev/generated/skbio.table.Table.align_tree.html +++ b/docs/dev/generated/skbio.table.Table.align_tree.html @@ -31,7 +31,7 @@ - + @@ -748,9 +748,9 @@

skbio.table.Table.align_treeExamples

-
>>> from biom import Table
->>> import numpy as np
->>> from skbio import TreeNode
+
>>> from biom import Table
+>>> import numpy as np
+>>> from skbio import TreeNode
 >>> table = Table(np.array([[0, 0, 1, 1],
 ...                         [2, 2, 4, 4],
 ...                         [5, 5, 3, 3],
@@ -853,7 +853,7 @@ 

skbio.table.Table.align_tree - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.table.Table.collapse.html b/docs/dev/generated/skbio.table.Table.collapse.html index 3a97276e2..66619d6f0 100644 --- a/docs/dev/generated/skbio.table.Table.collapse.html +++ b/docs/dev/generated/skbio.table.Table.collapse.html @@ -31,7 +31,7 @@ - + @@ -814,8 +814,8 @@

skbio.table.Table.collapseExamples

-
>>> import numpy as np
->>> from biom.table import Table
+
>>> import numpy as np
+>>> from biom.table import Table
 

Create a Table

@@ -928,7 +928,7 @@

skbio.table.Table.collapse - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.table.Table.concat.html b/docs/dev/generated/skbio.table.Table.concat.html index 441b4f481..20f909e4a 100644 --- a/docs/dev/generated/skbio.table.Table.concat.html +++ b/docs/dev/generated/skbio.table.Table.concat.html @@ -31,7 +31,7 @@ - + @@ -752,8 +752,8 @@

skbio.table.Table.concat
>>> from biom import Table
->>> import numpy as np
+

Examples

-
>>> from biom import example_table
+
>>> from biom import example_table
 >>> example_table.data('S1', axis='sample')
 array([ 0.,  3.])
 
@@ -844,7 +844,7 @@

skbio.table.Table.data - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.table.Table.del_metadata.html b/docs/dev/generated/skbio.table.Table.del_metadata.html index 59fd326b5..fbe6cb174 100644 --- a/docs/dev/generated/skbio.table.Table.del_metadata.html +++ b/docs/dev/generated/skbio.table.Table.del_metadata.html @@ -31,7 +31,7 @@ - + @@ -747,8 +747,8 @@

skbio.table.Table.del_metadataExamples

-
>>> from biom import Table
->>> import numpy as np
+
>>> from biom import Table
+>>> import numpy as np
 >>> tab = Table(np.array([[1, 2], [3, 4]]),
 ...             ['O1', 'O2'],
 ...             ['S1', 'S2'],
@@ -841,7 +841,7 @@ 

skbio.table.Table.del_metadata - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.table.Table.delimited_self.html b/docs/dev/generated/skbio.table.Table.delimited_self.html index 8c295c753..e9dce75e6 100644 --- a/docs/dev/generated/skbio.table.Table.delimited_self.html +++ b/docs/dev/generated/skbio.table.Table.delimited_self.html @@ -31,7 +31,7 @@ - + @@ -826,7 +826,7 @@

skbio.table.Table.delimited_self - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.table.Table.descriptive_equality.html b/docs/dev/generated/skbio.table.Table.descriptive_equality.html index 47bbad7bc..dae0e3ba0 100644 --- a/docs/dev/generated/skbio.table.Table.descriptive_equality.html +++ b/docs/dev/generated/skbio.table.Table.descriptive_equality.html @@ -31,7 +31,7 @@ - + @@ -808,7 +808,7 @@

skbio.table.Table.descriptive_equality - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.table.Table.exists.html b/docs/dev/generated/skbio.table.Table.exists.html index b7735cfc7..fbfb832ee 100644 --- a/docs/dev/generated/skbio.table.Table.exists.html +++ b/docs/dev/generated/skbio.table.Table.exists.html @@ -31,7 +31,7 @@ - + @@ -745,8 +745,8 @@

skbio.table.Table.existsExamples

-
>>> import numpy as np
->>> from biom.table import Table
+
>>> import numpy as np
+>>> from biom.table import Table
 

Create a 2x3 BIOM table:

@@ -848,7 +848,7 @@

skbio.table.Table.exists - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.table.Table.filter.html b/docs/dev/generated/skbio.table.Table.filter.html index 7ac569a1a..1ca2bd135 100644 --- a/docs/dev/generated/skbio.table.Table.filter.html +++ b/docs/dev/generated/skbio.table.Table.filter.html @@ -31,7 +31,7 @@ - + @@ -762,8 +762,8 @@

skbio.table.Table.filterExamples

-
>>> import numpy as np
->>> from biom.table import Table
+
>>> import numpy as np
+>>> from biom.table import Table
 

Create a 2x3 BIOM table, with observation metadata and sample @@ -896,7 +896,7 @@

skbio.table.Table.filter - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.table.Table.from_adjacency.html b/docs/dev/generated/skbio.table.Table.from_adjacency.html index e98a58431..43425f0f8 100644 --- a/docs/dev/generated/skbio.table.Table.from_adjacency.html +++ b/docs/dev/generated/skbio.table.Table.from_adjacency.html @@ -31,7 +31,7 @@ - + @@ -756,8 +756,8 @@

skbio.table.Table.from_adjacencyExamples

Parse tab separated adjacency data into a table:

-
>>> from biom.table import Table
->>> from io import StringIO
+
>>> from biom.table import Table
+>>> from io import StringIO
 >>> data = 'a\tb\t1\na\tc\t2\nd\tc\t3'
 >>> data_fh = StringIO(data)
 >>> test_table = Table.from_adjacency(data_fh)
@@ -843,7 +843,7 @@ 

skbio.table.Table.from_adjacency - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.table.Table.from_hdf5.html b/docs/dev/generated/skbio.table.Table.from_hdf5.html index c3b1826fc..11ebfbd52 100644 --- a/docs/dev/generated/skbio.table.Table.from_hdf5.html +++ b/docs/dev/generated/skbio.table.Table.from_hdf5.html @@ -31,7 +31,7 @@ - + @@ -834,8 +834,8 @@

skbio.table.Table.from_hdf5Examples

-
>>> from biom.table import Table
->>> from biom.util import biom_open
+
>>> from biom.table import Table
+>>> from biom.util import biom_open
 >>> with biom_open('rich_sparse_otu_table_hdf5.biom') as f 
 >>>     t = Table.from_hdf5(f) 
 
@@ -926,7 +926,7 @@

skbio.table.Table.from_hdf5 - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.table.Table.from_json.html b/docs/dev/generated/skbio.table.Table.from_json.html index c9af3f55d..8f4ce71c8 100644 --- a/docs/dev/generated/skbio.table.Table.from_json.html +++ b/docs/dev/generated/skbio.table.Table.from_json.html @@ -31,7 +31,7 @@ - + @@ -746,7 +746,7 @@

skbio.table.Table.from_jsonExamples

-
>>> from biom import Table
+
>>> from biom import Table
 >>> json_obj = {"id": "None",
 ...             "format": "Biological Observation Matrix 1.0.0",
 ...             "format_url": "http://biom-format.org",
@@ -865,7 +865,7 @@ 

skbio.table.Table.from_json - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.table.Table.from_tsv.html b/docs/dev/generated/skbio.table.Table.from_tsv.html index f6501d875..e967269f1 100644 --- a/docs/dev/generated/skbio.table.Table.from_tsv.html +++ b/docs/dev/generated/skbio.table.Table.from_tsv.html @@ -31,7 +31,7 @@ - + @@ -750,8 +750,8 @@

skbio.table.Table.from_tsvExamples

Parse tab separated data into a table:

-
>>> from biom.table import Table
->>> from io import StringIO
+
>>> from biom.table import Table
+>>> from io import StringIO
 >>> tsv = 'a\tb\tc\n1\t2\t3\n4\t5\t6'
 >>> tsv_fh = StringIO(tsv)
 >>> func = lambda x : x
@@ -838,7 +838,7 @@ 

skbio.table.Table.from_tsv - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.table.Table.get_table_density.html b/docs/dev/generated/skbio.table.Table.get_table_density.html index be643e68e..a02a6326d 100644 --- a/docs/dev/generated/skbio.table.Table.get_table_density.html +++ b/docs/dev/generated/skbio.table.Table.get_table_density.html @@ -31,7 +31,7 @@ - + @@ -816,7 +816,7 @@

skbio.table.Table.get_table_density - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.table.Table.get_value_by_ids.html b/docs/dev/generated/skbio.table.Table.get_value_by_ids.html index 9dc566df0..270ad5643 100644 --- a/docs/dev/generated/skbio.table.Table.get_value_by_ids.html +++ b/docs/dev/generated/skbio.table.Table.get_value_by_ids.html @@ -31,7 +31,7 @@ - + @@ -751,8 +751,8 @@

skbio.table.Table.get_value_by_idsExamples

-
>>> import numpy as np
->>> from biom.table import Table
+
>>> import numpy as np
+>>> from biom.table import Table
 

Create a 2x3 BIOM table:

@@ -845,7 +845,7 @@

skbio.table.Table.get_value_by_ids - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.table.Table.group_metadata.html b/docs/dev/generated/skbio.table.Table.group_metadata.html index 14dc6b424..aa3a26dd9 100644 --- a/docs/dev/generated/skbio.table.Table.group_metadata.html +++ b/docs/dev/generated/skbio.table.Table.group_metadata.html @@ -31,7 +31,7 @@ - + @@ -749,8 +749,8 @@

skbio.table.Table.group_metadataExamples

-
>>> import numpy as np
->>> from biom.table import Table
+
>>> import numpy as np
+>>> from biom.table import Table
 

Create a 2x3 BIOM table, with group observation metadata and no group @@ -849,7 +849,7 @@

skbio.table.Table.group_metadata - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.table.Table.head.html b/docs/dev/generated/skbio.table.Table.head.html index 1035ec87f..bc9b092be 100644 --- a/docs/dev/generated/skbio.table.Table.head.html +++ b/docs/dev/generated/skbio.table.Table.head.html @@ -31,7 +31,7 @@ - + @@ -757,8 +757,8 @@

skbio.table.Table.headLike head for Linux like systems, requesting more rows (or columns) than exists will silently work.

Examples

-

Examples

-

Examples

-
>>> import numpy as np
->>> from biom.table import Table
+
>>> import numpy as np
+>>> from biom.table import Table
 

Create a 2x3 BIOM table:

@@ -852,7 +852,7 @@

skbio.table.Table.index - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.table.Table.is_empty.html b/docs/dev/generated/skbio.table.Table.is_empty.html index cb1d5d9f4..f0bc6818b 100644 --- a/docs/dev/generated/skbio.table.Table.is_empty.html +++ b/docs/dev/generated/skbio.table.Table.is_empty.html @@ -31,7 +31,7 @@ - + @@ -816,7 +816,7 @@

skbio.table.Table.is_empty - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.table.Table.iter.html b/docs/dev/generated/skbio.table.Table.iter.html index 9cfc010b0..a8d7fcac9 100644 --- a/docs/dev/generated/skbio.table.Table.iter.html +++ b/docs/dev/generated/skbio.table.Table.iter.html @@ -31,7 +31,7 @@ - + @@ -747,8 +747,8 @@

skbio.table.Table.iter

Examples

-
>>> import numpy as np
->>> from biom.table import Table
+
>>> import numpy as np
+>>> from biom.table import Table
 

Create a 2x3 BIOM table:

@@ -848,7 +848,7 @@

skbio.table.Table.iter - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.table.Table.iter_data.html b/docs/dev/generated/skbio.table.Table.iter_data.html index 61d7bf41c..227d9355a 100644 --- a/docs/dev/generated/skbio.table.Table.iter_data.html +++ b/docs/dev/generated/skbio.table.Table.iter_data.html @@ -31,7 +31,7 @@ - + @@ -753,8 +753,8 @@

skbio.table.Table.iter_dataExamples

-
>>> import numpy as np
->>> from biom.table import Table
+
>>> import numpy as np
+>>> from biom.table import Table
 >>> data = np.arange(30).reshape(3,10) # 3 X 10 OTU X Sample table
 >>> obs_ids = ['o1', 'o2', 'o3']
 >>> sam_ids = ['s%i' %i for i in range(1,11)]
@@ -848,7 +848,7 @@ 

skbio.table.Table.iter_data - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.table.Table.iter_pairwise.html b/docs/dev/generated/skbio.table.Table.iter_pairwise.html index f40f60498..a4597ad52 100644 --- a/docs/dev/generated/skbio.table.Table.iter_pairwise.html +++ b/docs/dev/generated/skbio.table.Table.iter_pairwise.html @@ -31,7 +31,7 @@ - + @@ -756,7 +756,7 @@

skbio.table.Table.iter_pairwiseExamples

-
>>> from biom import example_table
+
>>> from biom import example_table
 

By default, only the upper triangle without the diagonal of the @@ -864,7 +864,7 @@

skbio.table.Table.iter_pairwise - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.table.Table.length.html b/docs/dev/generated/skbio.table.Table.length.html index 69b5a7a7e..3dbd1384b 100644 --- a/docs/dev/generated/skbio.table.Table.length.html +++ b/docs/dev/generated/skbio.table.Table.length.html @@ -31,7 +31,7 @@ - + @@ -743,7 +743,7 @@

skbio.table.Table.lengthExamples

-
>>> from biom import example_table
+
>>> from biom import example_table
 >>> print(example_table.length(axis='sample'))
 3
 >>> print(example_table.length(axis='observation'))
@@ -830,7 +830,7 @@ 

skbio.table.Table.length - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.table.Table.max.html b/docs/dev/generated/skbio.table.Table.max.html index 6c5a43096..3105d47ff 100644 --- a/docs/dev/generated/skbio.table.Table.max.html +++ b/docs/dev/generated/skbio.table.Table.max.html @@ -31,7 +31,7 @@ - + @@ -748,7 +748,7 @@

skbio.table.Table.max

Examples

-
>>> from biom import example_table
+
>>> from biom import example_table
 >>> print(example_table.max(axis='observation'))
 [ 2.  5.]
 
@@ -833,7 +833,7 @@

skbio.table.Table.max - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.table.Table.merge.html b/docs/dev/generated/skbio.table.Table.merge.html index 6efe0f4fa..3309c7f1b 100644 --- a/docs/dev/generated/skbio.table.Table.merge.html +++ b/docs/dev/generated/skbio.table.Table.merge.html @@ -31,7 +31,7 @@ - + @@ -771,8 +771,8 @@

skbio.table.Table.merge

The return type is always that of self

Examples

-
>>> import numpy as np
->>> from biom.table import Table
+
>>> import numpy as np
+>>> from biom.table import Table
 

Create a 2x2 table and a 3x2 table:

@@ -874,7 +874,7 @@

skbio.table.Table.merge - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.table.Table.metadata.html b/docs/dev/generated/skbio.table.Table.metadata.html index 308efcc81..fc46fdda8 100644 --- a/docs/dev/generated/skbio.table.Table.metadata.html +++ b/docs/dev/generated/skbio.table.Table.metadata.html @@ -31,7 +31,7 @@ - + @@ -754,8 +754,8 @@

skbio.table.Table.metadataExamples

-
>>> import numpy as np
->>> from biom.table import Table
+
>>> import numpy as np
+>>> from biom.table import Table
 

Create a 2x3 BIOM table, with observation metadata and no sample @@ -856,7 +856,7 @@

skbio.table.Table.metadata - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.table.Table.metadata_to_dataframe.html b/docs/dev/generated/skbio.table.Table.metadata_to_dataframe.html index b8d3fa3ea..193d573bc 100644 --- a/docs/dev/generated/skbio.table.Table.metadata_to_dataframe.html +++ b/docs/dev/generated/skbio.table.Table.metadata_to_dataframe.html @@ -31,7 +31,7 @@ - + @@ -761,7 +761,7 @@

skbio.table.Table.metadata_to_dataframeExamples

-
>>> from biom import example_table
+
>>> from biom import example_table
 >>> example_table.metadata_to_dataframe('observation')
    taxonomy_0     taxonomy_1
 O1   Bacteria     Firmicutes
@@ -848,7 +848,7 @@ 

skbio.table.Table.metadata_to_dataframe - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.table.Table.min.html b/docs/dev/generated/skbio.table.Table.min.html index d20fdc13f..fc2095112 100644 --- a/docs/dev/generated/skbio.table.Table.min.html +++ b/docs/dev/generated/skbio.table.Table.min.html @@ -31,7 +31,7 @@ - + @@ -748,7 +748,7 @@

skbio.table.Table.min

Examples

-
>>> from biom import example_table
+
>>> from biom import example_table
 >>> print(example_table.min(axis='sample'))
 [ 3.  1.  2.]
 
@@ -833,7 +833,7 @@

skbio.table.Table.min - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.table.Table.nonzero.html b/docs/dev/generated/skbio.table.Table.nonzero.html index db2309d4e..9479d0380 100644 --- a/docs/dev/generated/skbio.table.Table.nonzero.html +++ b/docs/dev/generated/skbio.table.Table.nonzero.html @@ -31,7 +31,7 @@ - + @@ -816,7 +816,7 @@

skbio.table.Table.nonzero - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.table.Table.nonzero_counts.html b/docs/dev/generated/skbio.table.Table.nonzero_counts.html index 081e1a94a..da9cffb39 100644 --- a/docs/dev/generated/skbio.table.Table.nonzero_counts.html +++ b/docs/dev/generated/skbio.table.Table.nonzero_counts.html @@ -31,7 +31,7 @@ - + @@ -825,7 +825,7 @@

skbio.table.Table.nonzero_counts - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.table.Table.norm.html b/docs/dev/generated/skbio.table.Table.norm.html index b2d8b3e55..7b4238ade 100644 --- a/docs/dev/generated/skbio.table.Table.norm.html +++ b/docs/dev/generated/skbio.table.Table.norm.html @@ -31,7 +31,7 @@ - + @@ -747,8 +747,8 @@

skbio.table.Table.norm

Examples

-
>>> import numpy as np
->>> from biom.table import Table
+
>>> import numpy as np
+>>> from biom.table import Table
 

Create a 2x2 table:

@@ -876,7 +876,7 @@

skbio.table.Table.norm - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.table.Table.pa.html b/docs/dev/generated/skbio.table.Table.pa.html index d66b93949..98fca7c15 100644 --- a/docs/dev/generated/skbio.table.Table.pa.html +++ b/docs/dev/generated/skbio.table.Table.pa.html @@ -31,7 +31,7 @@ - + @@ -744,8 +744,8 @@

skbio.table.Table.pa

Examples

-
>>> from biom.table import Table
->>> import numpy as np
+
>>> from biom.table import Table
+>>> import numpy as np
 

Create a 2x3 BIOM table

@@ -841,7 +841,7 @@

skbio.table.Table.pa - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.table.Table.partition.html b/docs/dev/generated/skbio.table.Table.partition.html index d22bd7273..513070809 100644 --- a/docs/dev/generated/skbio.table.Table.partition.html +++ b/docs/dev/generated/skbio.table.Table.partition.html @@ -31,7 +31,7 @@ - + @@ -753,9 +753,9 @@

skbio.table.Table.partitionExamples

-

Examples

-
>>> import numpy as np
->>> from biom import Table
+
>>> import numpy as np
+>>> from biom import Table
 >>> data = np.array([[ 99,  12,   8], [  0,  42,   7],
 ...                  [112,  42,   6], [  5,  75,   5]])
 >>> t = Table(data, sample_ids=['s1', 's2', 's3'],
@@ -860,7 +860,7 @@ 

skbio.table.Table.rankdata - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.table.Table.read.html b/docs/dev/generated/skbio.table.Table.read.html index d1794255f..5dbef49bf 100644 --- a/docs/dev/generated/skbio.table.Table.read.html +++ b/docs/dev/generated/skbio.table.Table.read.html @@ -31,7 +31,7 @@ - + @@ -845,7 +845,7 @@

skbio.table.Table.read - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.table.Table.reduce.html b/docs/dev/generated/skbio.table.Table.reduce.html index 959c4095b..bbe6d7e5d 100644 --- a/docs/dev/generated/skbio.table.Table.reduce.html +++ b/docs/dev/generated/skbio.table.Table.reduce.html @@ -31,7 +31,7 @@ - + @@ -754,8 +754,8 @@

skbio.table.Table.reduceExamples

-
>>> import numpy as np
->>> from biom.table import Table
+
>>> import numpy as np
+>>> from biom.table import Table
 

Create a 2x3 table

@@ -858,7 +858,7 @@

skbio.table.Table.reduce - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.table.Table.remove_empty.html b/docs/dev/generated/skbio.table.Table.remove_empty.html index ce17e45c2..35e4795aa 100644 --- a/docs/dev/generated/skbio.table.Table.remove_empty.html +++ b/docs/dev/generated/skbio.table.Table.remove_empty.html @@ -31,7 +31,7 @@ - + @@ -832,7 +832,7 @@

skbio.table.Table.remove_empty - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.table.Table.sort.html b/docs/dev/generated/skbio.table.Table.sort.html index dd376b87f..4e15ecbc0 100644 --- a/docs/dev/generated/skbio.table.Table.sort.html +++ b/docs/dev/generated/skbio.table.Table.sort.html @@ -31,7 +31,7 @@ - + @@ -747,8 +747,8 @@

skbio.table.Table.sort

Examples

-
>>> import numpy as np
->>> from biom.table import Table
+
>>> import numpy as np
+>>> from biom.table import Table
 

Create a 2x3 BIOM table:

@@ -871,7 +871,7 @@

skbio.table.Table.sort - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.table.Table.sort_order.html b/docs/dev/generated/skbio.table.Table.sort_order.html index 9dccafb0c..aac53b353 100644 --- a/docs/dev/generated/skbio.table.Table.sort_order.html +++ b/docs/dev/generated/skbio.table.Table.sort_order.html @@ -31,7 +31,7 @@ - + @@ -746,8 +746,8 @@

skbio.table.Table.sort_orderExamples

-
>>> import numpy as np
->>> from biom.table import Table
+
>>> import numpy as np
+>>> from biom.table import Table
 

Create a 2x3 BIOM table:

@@ -858,7 +858,7 @@

skbio.table.Table.sort_order - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.table.Table.subsample.html b/docs/dev/generated/skbio.table.Table.subsample.html index 914ef92da..bb3e3d472 100644 --- a/docs/dev/generated/skbio.table.Table.subsample.html +++ b/docs/dev/generated/skbio.table.Table.subsample.html @@ -31,7 +31,7 @@ - + @@ -774,8 +774,8 @@

skbio.table.Table.subsampleExamples

-
>>> import numpy as np
->>> from biom.table import Table
+
>>> import numpy as np
+>>> from biom.table import Table
 >>> table = Table(np.array([[0, 2, 3], [1, 0, 2]]), ['O1', 'O2'],
 ...               ['S1', 'S2', 'S3'])
 
@@ -882,7 +882,7 @@

skbio.table.Table.subsample - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.table.Table.sum.html b/docs/dev/generated/skbio.table.Table.sum.html index 265c76dff..fe77637a8 100644 --- a/docs/dev/generated/skbio.table.Table.sum.html +++ b/docs/dev/generated/skbio.table.Table.sum.html @@ -31,7 +31,7 @@ - + @@ -746,8 +746,8 @@

skbio.table.Table.sum

Examples

-
>>> import numpy as np
->>> from biom.table import Table
+
>>> import numpy as np
+>>> from biom.table import Table
 

Create a 2x3 BIOM table:

@@ -850,7 +850,7 @@

skbio.table.Table.sum - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.table.Table.to_anndata.html b/docs/dev/generated/skbio.table.Table.to_anndata.html index 43a52571c..da3ed30c0 100644 --- a/docs/dev/generated/skbio.table.Table.to_anndata.html +++ b/docs/dev/generated/skbio.table.Table.to_anndata.html @@ -31,7 +31,7 @@ - + @@ -750,7 +750,7 @@

skbio.table.Table.to_anndataNotes

Nested metadata are not included.

Examples

-
>>> from biom import example_table
+
>>> from biom import example_table
 >>> adata = example_table.to_anndata()
 >>> adata
 AnnData object with n_obs × n_vars = 3 × 2
@@ -838,7 +838,7 @@ 

skbio.table.Table.to_anndata - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.table.Table.to_dataframe.html b/docs/dev/generated/skbio.table.Table.to_dataframe.html index 1a56886ac..85713a123 100644 --- a/docs/dev/generated/skbio.table.Table.to_dataframe.html +++ b/docs/dev/generated/skbio.table.Table.to_dataframe.html @@ -31,7 +31,7 @@ - + @@ -746,7 +746,7 @@

skbio.table.Table.to_dataframeNotes

Metadata are not included.

Examples

-
>>> from biom import example_table
+
>>> from biom import example_table
 >>> df = example_table.to_dataframe()
 >>> df
      S1   S2   S3
@@ -834,7 +834,7 @@ 

skbio.table.Table.to_dataframe - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.table.Table.to_hdf5.html b/docs/dev/generated/skbio.table.Table.to_hdf5.html index e9a18776a..9fb5e71b8 100644 --- a/docs/dev/generated/skbio.table.Table.to_hdf5.html +++ b/docs/dev/generated/skbio.table.Table.to_hdf5.html @@ -31,7 +31,7 @@ - + @@ -827,9 +827,9 @@

skbio.table.Table.to_hdf5Examples

-
>>> from biom.util import biom_open  
->>> from biom.table import Table
->>> from numpy import array
+
>>> from biom.util import biom_open  
+>>> from biom.table import Table
+>>> from numpy import array
 >>> t = Table(array([[1, 2], [3, 4]]), ['a', 'b'], ['x', 'y'])
 >>> with biom_open('foo.biom', 'w') as f:  
 ...     t.to_hdf5(f, "example")
@@ -915,7 +915,7 @@ 

skbio.table.Table.to_hdf5 - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.table.Table.to_json.html b/docs/dev/generated/skbio.table.Table.to_json.html index c1f96b091..61e4ab418 100644 --- a/docs/dev/generated/skbio.table.Table.to_json.html +++ b/docs/dev/generated/skbio.table.Table.to_json.html @@ -31,7 +31,7 @@ - + @@ -828,7 +828,7 @@

skbio.table.Table.to_json - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.table.Table.to_tsv.html b/docs/dev/generated/skbio.table.Table.to_tsv.html index 43270ecf8..0bde67700 100644 --- a/docs/dev/generated/skbio.table.Table.to_tsv.html +++ b/docs/dev/generated/skbio.table.Table.to_tsv.html @@ -31,7 +31,7 @@ - + @@ -757,8 +757,8 @@

skbio.table.Table.to_tsvExamples

-
>>> import numpy as np
->>> from biom.table import Table
+
>>> import numpy as np
+>>> from biom.table import Table
 

Create a 2x3 BIOM table, with observation metadata and no sample @@ -855,7 +855,7 @@

skbio.table.Table.to_tsv - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.table.Table.transform.html b/docs/dev/generated/skbio.table.Table.transform.html index 74c03efc0..e54f8c3cb 100644 --- a/docs/dev/generated/skbio.table.Table.transform.html +++ b/docs/dev/generated/skbio.table.Table.transform.html @@ -31,7 +31,7 @@ - + @@ -760,8 +760,8 @@

skbio.table.Table.transformExamples

-
>>> import numpy as np
->>> from biom.table import Table
+
>>> import numpy as np
+>>> from biom.table import Table
 

Create a 2x3 table

@@ -896,7 +896,7 @@

skbio.table.Table.transform - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.table.Table.transpose.html b/docs/dev/generated/skbio.table.Table.transpose.html index 3e052bb3e..5d0bf26c2 100644 --- a/docs/dev/generated/skbio.table.Table.transpose.html +++ b/docs/dev/generated/skbio.table.Table.transpose.html @@ -31,7 +31,7 @@ - + @@ -818,7 +818,7 @@

skbio.table.Table.transpose - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.table.Table.update_ids.html b/docs/dev/generated/skbio.table.Table.update_ids.html index 34bf0b148..75664242f 100644 --- a/docs/dev/generated/skbio.table.Table.update_ids.html +++ b/docs/dev/generated/skbio.table.Table.update_ids.html @@ -31,7 +31,7 @@ - + @@ -864,7 +864,7 @@

skbio.table.Table.update_ids - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.table.Table.write.html b/docs/dev/generated/skbio.table.Table.write.html index 3c341bb4f..328f4184c 100644 --- a/docs/dev/generated/skbio.table.Table.write.html +++ b/docs/dev/generated/skbio.table.Table.write.html @@ -31,7 +31,7 @@ - + @@ -838,7 +838,7 @@

skbio.table.Table.write - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.table.example_table.html b/docs/dev/generated/skbio.table.example_table.html index a67452231..14c471835 100644 --- a/docs/dev/generated/skbio.table.example_table.html +++ b/docs/dev/generated/skbio.table.example_table.html @@ -31,7 +31,7 @@ - + @@ -789,7 +789,7 @@

skbio.table.example_table - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.ancestors.html b/docs/dev/generated/skbio.tree.TreeNode.ancestors.html index 577f0941f..f16f12064 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.ancestors.html +++ b/docs/dev/generated/skbio.tree.TreeNode.ancestors.html @@ -31,7 +31,7 @@ - + @@ -777,7 +777,7 @@

skbio.tree.TreeNode.ancestorsExamples

-
>>> from skbio import TreeNode
+
>>> from skbio import TreeNode
 >>> tree = TreeNode.read(["((a,b)c,(d,e)f)g;"])
 >>> print(tree.ascii_art())
                     /-a
@@ -876,7 +876,7 @@ 

skbio.tree.TreeNode.ancestors - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.append.html b/docs/dev/generated/skbio.tree.TreeNode.append.html index ed1b7cf27..8c473bdea 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.append.html +++ b/docs/dev/generated/skbio.tree.TreeNode.append.html @@ -31,7 +31,7 @@ - + @@ -789,7 +789,7 @@

skbio.tree.TreeNode.appenduncache parameter applies to both donor and recipient trees.

Examples

-
>>> from skbio import TreeNode
+
>>> from skbio import TreeNode
 >>> root = TreeNode(name="root")
 >>> child1 = TreeNode(name="child1")
 >>> child2 = TreeNode(name="child2")
@@ -879,7 +879,7 @@ 

skbio.tree.TreeNode.append - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.ascii_art.html b/docs/dev/generated/skbio.tree.TreeNode.ascii_art.html index fe0d8fcc1..0bc7de9f9 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.ascii_art.html +++ b/docs/dev/generated/skbio.tree.TreeNode.ascii_art.html @@ -31,7 +31,7 @@ - + @@ -781,7 +781,7 @@

skbio.tree.TreeNode.ascii_artExamples

-
>>> from skbio import TreeNode
+
>>> from skbio import TreeNode
 >>> tree = TreeNode.read(["((a,b)c,(d,e)f)root;"])
 >>> print(tree.ascii_art())
                     /-a
@@ -873,7 +873,7 @@ 

skbio.tree.TreeNode.ascii_art - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.assign_ids.html b/docs/dev/generated/skbio.tree.TreeNode.assign_ids.html index d9cf4ce37..04e07f90f 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.assign_ids.html +++ b/docs/dev/generated/skbio.tree.TreeNode.assign_ids.html @@ -31,7 +31,7 @@ - + @@ -854,7 +854,7 @@

skbio.tree.TreeNode.assign_ids - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.assign_supports.html b/docs/dev/generated/skbio.tree.TreeNode.assign_supports.html index 62ee5ef46..148b5cf7d 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.assign_supports.html +++ b/docs/dev/generated/skbio.tree.TreeNode.assign_supports.html @@ -31,7 +31,7 @@ - + @@ -791,7 +791,7 @@

skbio.tree.TreeNode.assign_supportsExamples

-
>>> from skbio import TreeNode
+
>>> from skbio import TreeNode
 >>> newick = "((a,b)95,(c,d):1.1,(e,f)'80:speciesA':1.0);"
 >>> tree = TreeNode.read([newick])
 >>> tree.assign_supports()
@@ -885,7 +885,7 @@ 

skbio.tree.TreeNode.assign_supports - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.bifurcate.html b/docs/dev/generated/skbio.tree.TreeNode.bifurcate.html index 276af9c11..f45340f2d 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.bifurcate.html +++ b/docs/dev/generated/skbio.tree.TreeNode.bifurcate.html @@ -31,7 +31,7 @@ - + @@ -790,7 +790,7 @@

skbio.tree.TreeNode.bifurcateprune() prior to this method to create a strictly bifurcating tree.

This method modifies the subtree under the current node.

Examples

-
>>> from skbio import TreeNode
+
>>> from skbio import TreeNode
 >>> tree = TreeNode.read(["((a,b,g,h)c,(d,e)f)root;"])
 >>> print(tree.ascii_art())
                     /-a
@@ -901,7 +901,7 @@ 

skbio.tree.TreeNode.bifurcate - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.bipart.html b/docs/dev/generated/skbio.tree.TreeNode.bipart.html index e733101b8..fa7cf7ebf 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.bipart.html +++ b/docs/dev/generated/skbio.tree.TreeNode.bipart.html @@ -31,7 +31,7 @@ - + @@ -801,7 +801,7 @@

skbio.tree.TreeNode.bipartExamples

-
>>> from skbio import TreeNode
+
>>> from skbio import TreeNode
 >>> tree = TreeNode.read(["(((a,(b,c)X)Y,d)Z,(e,f),g);"])
 >>> print(tree.ascii_art())
                               /-a
@@ -942,7 +942,7 @@ 

skbio.tree.TreeNode.bipart - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.biparts.html b/docs/dev/generated/skbio.tree.TreeNode.biparts.html index 18b9c7215..4fca89a84 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.biparts.html +++ b/docs/dev/generated/skbio.tree.TreeNode.biparts.html @@ -31,7 +31,7 @@ - + @@ -815,7 +815,7 @@

skbio.tree.TreeNode.bipartssubsets() instead.

This method operates on the subtree below the current node.

Examples

-
>>> from skbio import TreeNode
+
>>> from skbio import TreeNode
 >>> tree = TreeNode.read(["((a,(b,c)),(d,e),f);"])
 >>> print(tree.ascii_art())
                     /-a
@@ -941,7 +941,7 @@ 

skbio.tree.TreeNode.biparts - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.cache_attr.html b/docs/dev/generated/skbio.tree.TreeNode.cache_attr.html index 13b3167f0..ec565a06c 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.cache_attr.html +++ b/docs/dev/generated/skbio.tree.TreeNode.cache_attr.html @@ -31,7 +31,7 @@ - + @@ -814,7 +814,7 @@

skbio.tree.TreeNode.cache_attrExamples

This method facilitates evaluation for various useful node properties. Some representative examples are provided below.

-
>>> from skbio import TreeNode
+
>>> from skbio import TreeNode
 >>> tree = TreeNode.read(["((a:1.2,b:1.6)c:0.3,(d:0.8,e:1.0)f:0.6)g;"])
 >>> print(tree.ascii_art())
                     /-a
@@ -862,7 +862,7 @@ 

skbio.tree.TreeNode.cache_attrdepth() multiple times. One can further apply calculations like mean and standard deviation to the results.

-
>>> import numpy as np
+
>>> import numpy as np
 >>> dist_f = lambda n: np.array(n.length or 0.0, ndmin=1)
 >>> comb_f = lambda prev, curr: np.concatenate(prev) + curr if prev else curr
 >>> tree.cache_attr(dist_f, 'accu_dists', comb_f)
@@ -950,7 +950,7 @@ 

skbio.tree.TreeNode.cache_attr - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.clear_caches.html b/docs/dev/generated/skbio.tree.TreeNode.clear_caches.html index 735bedf82..2ce7c8d6c 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.clear_caches.html +++ b/docs/dev/generated/skbio.tree.TreeNode.clear_caches.html @@ -31,7 +31,7 @@ - + @@ -876,7 +876,7 @@

skbio.tree.TreeNode.clear_caches - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.compare_biparts.html b/docs/dev/generated/skbio.tree.TreeNode.compare_biparts.html index 2e20361a1..87f7e15d0 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.compare_biparts.html +++ b/docs/dev/generated/skbio.tree.TreeNode.compare_biparts.html @@ -31,7 +31,7 @@ - + @@ -794,7 +794,7 @@

skbio.tree.TreeNode.compare_bipartsExamples

-
>>> from skbio import TreeNode
+
>>> from skbio import TreeNode
 >>> tree1 = TreeNode.read(["((a,b),(c,d));"])
 >>> tree2 = TreeNode.read(["(((a,b),c),d);"])
 >>> tree1.compare_biparts(tree2)
@@ -881,7 +881,7 @@ 

skbio.tree.TreeNode.compare_biparts - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.compare_cophenet.html b/docs/dev/generated/skbio.tree.TreeNode.compare_cophenet.html index 83c134f35..5ab18bb59 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.compare_cophenet.html +++ b/docs/dev/generated/skbio.tree.TreeNode.compare_cophenet.html @@ -31,7 +31,7 @@ - + @@ -775,7 +775,7 @@

skbio.tree.TreeNode.compare_cophenetstr or callable, optional

The distance metric to use. Can be a preset, a distance function name under -scipy.spatial.distance, or a custom function that takes two vectors +scipy.spatial.distance, or a custom function that takes two vectors and returns a number. Some notable options are:

Changed in version 0.6.3: Renamed from dist_f. The old name is kept as an alias but is deprecated.

@@ -899,7 +899,7 @@

skbio.tree.TreeNode.compare_cophenetExamples

-
>>> from skbio import TreeNode
+
>>> from skbio import TreeNode
 >>> tree1 = TreeNode.read(["((a:1,b:2):1,c:4,((d:4,e:5):2,f:6):1);"])
 >>> print(tree1.ascii_art())
                     /-a
@@ -1029,7 +1029,7 @@ 

skbio.tree.TreeNode.compare_cophenet - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.compare_rfd.html b/docs/dev/generated/skbio.tree.TreeNode.compare_rfd.html index 9bd2353d7..4e9829731 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.compare_rfd.html +++ b/docs/dev/generated/skbio.tree.TreeNode.compare_rfd.html @@ -31,7 +31,7 @@ - + @@ -844,7 +844,7 @@

skbio.tree.TreeNode.compare_rfd
>>> from skbio import TreeNode
+
>>> from skbio import TreeNode
 >>> tree1 = TreeNode.read(["((a,b),c,((d,e),f));"])
 >>> print(tree1.ascii_art())
                     /-a
@@ -959,7 +959,7 @@ 

skbio.tree.TreeNode.compare_rfd - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.compare_subsets.html b/docs/dev/generated/skbio.tree.TreeNode.compare_subsets.html index cd84b8286..da04d1186 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.compare_subsets.html +++ b/docs/dev/generated/skbio.tree.TreeNode.compare_subsets.html @@ -31,7 +31,7 @@ - + @@ -798,7 +798,7 @@

skbio.tree.TreeNode.compare_subsetsNotes

This metric is equivalent to the Robinson-Foulds distance on rooted trees.

Examples

-
>>> from skbio import TreeNode
+
>>> from skbio import TreeNode
 >>> tree1 = TreeNode.read(["((a,b),(c,d));"])
 >>> tree2 = TreeNode.read(["(((a,b),c),d);"])
 >>> tree1.compare_subsets(tree2)
@@ -885,7 +885,7 @@ 

skbio.tree.TreeNode.compare_subsets - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.compare_wrfd.html b/docs/dev/generated/skbio.tree.TreeNode.compare_wrfd.html index f2668dc10..eed5da249 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.compare_wrfd.html +++ b/docs/dev/generated/skbio.tree.TreeNode.compare_wrfd.html @@ -31,7 +31,7 @@ - + @@ -772,7 +772,7 @@

skbio.tree.TreeNode.compare_wrfdTreeNode

The other tree to compare with.

metricstr or callable, optional

The distance metric to use. Can be a preset, a distance function name under -scipy.spatial.distance, or a custom function that takes two vectors +scipy.spatial.distance, or a custom function that takes two vectors and returns a number. Some notable options are:

@@ -864,7 +864,7 @@

skbio.tree.TreeNode.from_linkage_matrix - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.from_taxdump.html b/docs/dev/generated/skbio.tree.TreeNode.from_taxdump.html index ede113212..949f98abe 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.from_taxdump.html +++ b/docs/dev/generated/skbio.tree.TreeNode.from_taxdump.html @@ -31,7 +31,7 @@ - + @@ -800,8 +800,8 @@

skbio.tree.TreeNode.from_taxdumpnames is omitted, taxonomy IDs be used as taxon names.

Examples

-
>>> import pandas as pd
->>> from skbio.tree import TreeNode
+
>>> import pandas as pd
+>>> from skbio.tree import TreeNode
 >>> nodes = pd.DataFrame([
 ...             [1, 1, 'no rank'],
 ...             [2, 1, 'domain'],
@@ -900,7 +900,7 @@ 

skbio.tree.TreeNode.from_taxdump - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.from_taxonomy.html b/docs/dev/generated/skbio.tree.TreeNode.from_taxonomy.html index 32a655fbf..5b1a5cd74 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.from_taxonomy.html +++ b/docs/dev/generated/skbio.tree.TreeNode.from_taxonomy.html @@ -31,7 +31,7 @@ - + @@ -784,7 +784,7 @@

skbio.tree.TreeNode.from_taxonomyExamples

-
>>> from skbio.tree import TreeNode
+
>>> from skbio.tree import TreeNode
 >>> lineages = [
 ...     ('1', ['Bacteria', 'Firmicutes', 'Clostridia']),
 ...     ('2', ['Bacteria', 'Firmicutes', 'Bacilli']),
@@ -898,7 +898,7 @@ 

skbio.tree.TreeNode.from_taxonomy - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.has_caches.html b/docs/dev/generated/skbio.tree.TreeNode.has_caches.html index 92a7bcb42..da5f575b6 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.has_caches.html +++ b/docs/dev/generated/skbio.tree.TreeNode.has_caches.html @@ -31,7 +31,7 @@ - + @@ -884,7 +884,7 @@

skbio.tree.TreeNode.has_caches - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.has_children.html b/docs/dev/generated/skbio.tree.TreeNode.has_children.html index 186c8e8ae..0e7f623df 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.has_children.html +++ b/docs/dev/generated/skbio.tree.TreeNode.has_children.html @@ -31,7 +31,7 @@ - + @@ -778,7 +778,7 @@

skbio.tree.TreeNode.has_childrenExamples

-
>>> from skbio import TreeNode
+
>>> from skbio import TreeNode
 >>> tree = TreeNode.read(["((a,b)c);"])
 >>> print(tree.has_children())
 True
@@ -866,7 +866,7 @@ 

skbio.tree.TreeNode.has_children - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.height.html b/docs/dev/generated/skbio.tree.TreeNode.height.html index 4d5018af8..908e78d29 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.height.html +++ b/docs/dev/generated/skbio.tree.TreeNode.height.html @@ -31,7 +31,7 @@ - + @@ -809,7 +809,7 @@

skbio.tree.TreeNode.heightuse_length=False.

Examples

-
>>> from skbio import TreeNode
+
>>> from skbio import TreeNode
 >>> tree = TreeNode.read(["((a:1,b:2)c:3,(d:4,e:5)f:6)root;"])
 >>> dist, tip = tree.find('c').height()
 >>> dist
@@ -898,7 +898,7 @@ 

skbio.tree.TreeNode.height - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.html b/docs/dev/generated/skbio.tree.TreeNode.html index e83f469b4..563ce4f5f 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.html +++ b/docs/dev/generated/skbio.tree.TreeNode.html @@ -31,7 +31,7 @@ - + @@ -1290,7 +1290,7 @@

skbio.tree.TreeNode - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.index_tree.html b/docs/dev/generated/skbio.tree.TreeNode.index_tree.html index 2c2dd3ddc..e99d93227 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.index_tree.html +++ b/docs/dev/generated/skbio.tree.TreeNode.index_tree.html @@ -31,7 +31,7 @@ - + @@ -857,7 +857,7 @@

skbio.tree.TreeNode.index_tree - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.insert.html b/docs/dev/generated/skbio.tree.TreeNode.insert.html index 58b3a5af4..4dc54c565 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.insert.html +++ b/docs/dev/generated/skbio.tree.TreeNode.insert.html @@ -31,7 +31,7 @@ - + @@ -810,7 +810,7 @@

skbio.tree.TreeNode.insertuncache parameter applies to both donor and recipient trees.

Examples

-
>>> from skbio import TreeNode
+
>>> from skbio import TreeNode
 >>> tree = TreeNode.read(["((a:1,b:2)c:4,d:5)e;"])
 >>> print(tree.ascii_art())
                     /-a
@@ -913,7 +913,7 @@ 

skbio.tree.TreeNode.insert - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.is_bifurcating.html b/docs/dev/generated/skbio.tree.TreeNode.is_bifurcating.html index 3fdd018a9..b779ad4a5 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.is_bifurcating.html +++ b/docs/dev/generated/skbio.tree.TreeNode.is_bifurcating.html @@ -31,7 +31,7 @@ - + @@ -791,7 +791,7 @@

skbio.tree.TreeNode.is_bifurcatingprune().

This method operates on the subtree below the current node.

Examples

-
>>> from skbio import TreeNode
+
>>> from skbio import TreeNode
 >>> tree = TreeNode.read(["((a,b,c),(d,e))root;"])
 >>> tree.is_bifurcating()
 False
@@ -877,7 +877,7 @@ 

skbio.tree.TreeNode.is_bifurcating - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.is_root.html b/docs/dev/generated/skbio.tree.TreeNode.is_root.html index 5df927d84..cf3208f54 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.is_root.html +++ b/docs/dev/generated/skbio.tree.TreeNode.is_root.html @@ -31,7 +31,7 @@ - + @@ -781,7 +781,7 @@

skbio.tree.TreeNode.is_rootparent. A tree has exactly one root.

Examples

-
>>> from skbio import TreeNode
+
>>> from skbio import TreeNode
 >>> tree = TreeNode.read(["((a,b)c);"])
 >>> print(tree.is_root())
 True
@@ -869,7 +869,7 @@ 

skbio.tree.TreeNode.is_root - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.is_tip.html b/docs/dev/generated/skbio.tree.TreeNode.is_tip.html index 183e63a4b..bf093a780 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.is_tip.html +++ b/docs/dev/generated/skbio.tree.TreeNode.is_tip.html @@ -31,7 +31,7 @@ - + @@ -778,7 +778,7 @@

skbio.tree.TreeNode.is_tipExamples

-
>>> from skbio import TreeNode
+
>>> from skbio import TreeNode
 >>> tree = TreeNode.read(["((a,b)c);"])
 >>> print(tree.is_tip())
 False
@@ -866,7 +866,7 @@ 

skbio.tree.TreeNode.is_tip - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.lca.html b/docs/dev/generated/skbio.tree.TreeNode.lca.html index 045b888c5..8c470d65e 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.lca.html +++ b/docs/dev/generated/skbio.tree.TreeNode.lca.html @@ -31,7 +31,7 @@ - + @@ -794,7 +794,7 @@

skbio.tree.TreeNode.lca

Examples

-
>>> from skbio import TreeNode
+
>>> from skbio import TreeNode
 >>> tree = TreeNode.read(["((a,b)c,(d,e)f)root;"])
 >>> nodes = [tree.find('a'), tree.find('b')]
 >>> lca = tree.lca(nodes)
@@ -886,7 +886,7 @@ 

skbio.tree.TreeNode.lca - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.levelorder.html b/docs/dev/generated/skbio.tree.TreeNode.levelorder.html index 778de6480..6a458d03e 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.levelorder.html +++ b/docs/dev/generated/skbio.tree.TreeNode.levelorder.html @@ -31,7 +31,7 @@ - + @@ -790,7 +790,7 @@

skbio.tree.TreeNode.levelorderExamples

-
>>> from skbio import TreeNode
+

Notes

@@ -803,7 +803,7 @@

skbio.tree.TreeNode.maxdistuse_length=False.

This method operates on the subtree below the current node.

Examples

-
>>> from skbio import TreeNode
+
>>> from skbio import TreeNode
 >>> tree = TreeNode.read(["((a:1,b:2)c:3,(d:4,e:5)f:6)root;"])
 >>> dist, tips = tree.maxdist()
 >>> dist
@@ -892,7 +892,7 @@ 

skbio.tree.TreeNode.maxdist - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.neighbors.html b/docs/dev/generated/skbio.tree.TreeNode.neighbors.html index a7f60adc6..4611b2171 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.neighbors.html +++ b/docs/dev/generated/skbio.tree.TreeNode.neighbors.html @@ -31,7 +31,7 @@ - + @@ -780,7 +780,7 @@

skbio.tree.TreeNode.neighborsExamples

-
>>> from skbio import TreeNode
+
>>> from skbio import TreeNode
 >>> tree = TreeNode.read(["((a,b)c,(d,e)f)root;"])
 >>> node_c = tree.find('c')
 >>> [n.name for n in node_c.neighbors()]
@@ -867,7 +867,7 @@ 

skbio.tree.TreeNode.neighbors - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.non_tips.html b/docs/dev/generated/skbio.tree.TreeNode.non_tips.html index cfc224380..8f4857387 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.non_tips.html +++ b/docs/dev/generated/skbio.tree.TreeNode.non_tips.html @@ -31,7 +31,7 @@ - + @@ -787,7 +787,7 @@

skbio.tree.TreeNode.non_tipsExamples

-
>>> from skbio import TreeNode
+
>>> from skbio import TreeNode
 >>> tree = TreeNode.read(["((a,b)c,(d,e)f);"])
 >>> print(tree.ascii_art())
                     /-a
@@ -885,7 +885,7 @@ 

skbio.tree.TreeNode.non_tips - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.observed_node_counts.html b/docs/dev/generated/skbio.tree.TreeNode.observed_node_counts.html index 0f8a5e0f7..71594080f 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.observed_node_counts.html +++ b/docs/dev/generated/skbio.tree.TreeNode.observed_node_counts.html @@ -31,7 +31,7 @@ - + @@ -867,7 +867,7 @@

skbio.tree.TreeNode.observed_node_counts - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.path.html b/docs/dev/generated/skbio.tree.TreeNode.path.html index 45d2eff8d..0a0ac0073 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.path.html +++ b/docs/dev/generated/skbio.tree.TreeNode.path.html @@ -31,7 +31,7 @@ - + @@ -789,7 +789,7 @@

skbio.tree.TreeNode.pathExamples

-
>>> from skbio import TreeNode
+
>>> from skbio import TreeNode
 >>> tree = TreeNode.read(["((a,b)c,(d,e)f)root;"])
 >>> print(tree.ascii_art())
                     /-a
@@ -894,7 +894,7 @@ 

skbio.tree.TreeNode.path - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.pop.html b/docs/dev/generated/skbio.tree.TreeNode.pop.html index fc522e9fb..2d7a4cc7e 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.pop.html +++ b/docs/dev/generated/skbio.tree.TreeNode.pop.html @@ -31,7 +31,7 @@ - + @@ -798,7 +798,7 @@

skbio.tree.TreeNode.popNotes

The parent of the popped node will be set to None.

Examples

-
>>> from skbio import TreeNode
+
>>> from skbio import TreeNode
 >>> tree = TreeNode.read(["(a,b)c;"])
 >>> print(tree.pop(0))
 a;
@@ -884,7 +884,7 @@ 

skbio.tree.TreeNode.pop - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.postorder.html b/docs/dev/generated/skbio.tree.TreeNode.postorder.html index e438c9595..45c3563ae 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.postorder.html +++ b/docs/dev/generated/skbio.tree.TreeNode.postorder.html @@ -31,7 +31,7 @@ - + @@ -791,7 +791,7 @@

skbio.tree.TreeNode.postorderExamples

-
>>> from skbio import TreeNode
+
>>> from skbio import TreeNode
 >>> tree = TreeNode.read(["((a,b)c,(d,e)f)g;"])
 >>> print(tree.ascii_art())
                     /-a
@@ -894,7 +894,7 @@ 

skbio.tree.TreeNode.postorder - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.pre_and_postorder.html b/docs/dev/generated/skbio.tree.TreeNode.pre_and_postorder.html index 177505113..3aa31c222 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.pre_and_postorder.html +++ b/docs/dev/generated/skbio.tree.TreeNode.pre_and_postorder.html @@ -31,7 +31,7 @@ - + @@ -791,7 +791,7 @@

skbio.tree.TreeNode.pre_and_postorderExamples

-
>>> from skbio import TreeNode
+
>>> from skbio import TreeNode
 >>> tree = TreeNode.read(["((a,b)c,(d,e)f)g;"])
 >>> print(tree.ascii_art())
                     /-a
@@ -897,7 +897,7 @@ 

skbio.tree.TreeNode.pre_and_postorder - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.preorder.html b/docs/dev/generated/skbio.tree.TreeNode.preorder.html index 61c03d228..2fc0786cb 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.preorder.html +++ b/docs/dev/generated/skbio.tree.TreeNode.preorder.html @@ -31,7 +31,7 @@ - + @@ -791,7 +791,7 @@

skbio.tree.TreeNode.preorderExamples

-
>>> from skbio import TreeNode
+
>>> from skbio import TreeNode
 >>> tree = TreeNode.read(["((a,b)c,(d,e)f)g;"])
 >>> print(tree.ascii_art())
                     /-a
@@ -894,7 +894,7 @@ 

skbio.tree.TreeNode.preorder - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.prune.html b/docs/dev/generated/skbio.tree.TreeNode.prune.html index ea564f887..c542c0430 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.prune.html +++ b/docs/dev/generated/skbio.tree.TreeNode.prune.html @@ -31,7 +31,7 @@ - + @@ -793,7 +793,7 @@

skbio.tree.TreeNode.pruneExamples

-
>>> from skbio import TreeNode
+
>>> from skbio import TreeNode
 >>> tree = TreeNode.read(["(((a,b)c,(d)e)g,((h,i)j)k)root;"])
 >>> print(tree.ascii_art())
                               /-a
@@ -900,7 +900,7 @@ 

skbio.tree.TreeNode.prune - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.read.html b/docs/dev/generated/skbio.tree.TreeNode.read.html index 31977c7d3..ead9672c2 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.read.html +++ b/docs/dev/generated/skbio.tree.TreeNode.read.html @@ -31,7 +31,7 @@ - + @@ -879,7 +879,7 @@

skbio.tree.TreeNode.read - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.remove.html b/docs/dev/generated/skbio.tree.TreeNode.remove.html index 81f7ba089..82f6037c9 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.remove.html +++ b/docs/dev/generated/skbio.tree.TreeNode.remove.html @@ -31,7 +31,7 @@ - + @@ -794,7 +794,7 @@

skbio.tree.TreeNode.removeExamples

-
>>> from skbio import TreeNode
+
>>> from skbio import TreeNode
 >>> tree = TreeNode.read(["(a,b)c;"])
 >>> tree.remove(tree.children[0])
 True
@@ -880,7 +880,7 @@ 

skbio.tree.TreeNode.remove - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.remove_by_func.html b/docs/dev/generated/skbio.tree.TreeNode.remove_by_func.html index 0e55c6a3c..d38ea7a72 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.remove_by_func.html +++ b/docs/dev/generated/skbio.tree.TreeNode.remove_by_func.html @@ -31,7 +31,7 @@ - + @@ -794,7 +794,7 @@

skbio.tree.TreeNode.remove_by_funcprune().

Examples

-
>>> from skbio import TreeNode
+
>>> from skbio import TreeNode
 >>> tree = TreeNode.read(["(a,b)c;"])
 >>> tree.remove_by_func(lambda x: x.name == 'b')
 >>> print(tree)
@@ -881,7 +881,7 @@ 

skbio.tree.TreeNode.remove_by_func - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.remove_deleted.html b/docs/dev/generated/skbio.tree.TreeNode.remove_deleted.html index 0e3814378..a190d677a 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.remove_deleted.html +++ b/docs/dev/generated/skbio.tree.TreeNode.remove_deleted.html @@ -31,7 +31,7 @@ - + @@ -794,7 +794,7 @@

skbio.tree.TreeNode.remove_deletedprune().

Examples

-
>>> from skbio import TreeNode
+
>>> from skbio import TreeNode
 >>> tree = TreeNode.read(["(a,b)c;"])
 >>> tree.remove_by_func(lambda x: x.name == 'b')
 >>> print(tree)
@@ -881,7 +881,7 @@ 

skbio.tree.TreeNode.remove_deleted - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.root.html b/docs/dev/generated/skbio.tree.TreeNode.root.html index 04cd79a68..560e14199 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.root.html +++ b/docs/dev/generated/skbio.tree.TreeNode.root.html @@ -31,7 +31,7 @@ - + @@ -771,7 +771,7 @@

skbio.tree.TreeNode.rootExamples

-
>>> from skbio import TreeNode
+
>>> from skbio import TreeNode
 >>> tree = TreeNode.read(["((a,b)c,(d,e)f)root;"])
 >>> tip_a = tree.find('a')
 >>> root = tip_a.root()
@@ -859,7 +859,7 @@ 

skbio.tree.TreeNode.root - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.root_at.html b/docs/dev/generated/skbio.tree.TreeNode.root_at.html index 03337d424..b5c9814b0 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.root_at.html +++ b/docs/dev/generated/skbio.tree.TreeNode.root_at.html @@ -31,7 +31,7 @@ - + @@ -850,7 +850,7 @@

skbio.tree.TreeNode.root_atExamples

-
>>> from skbio import TreeNode
+
>>> from skbio import TreeNode
 >>> tree = TreeNode.read(["(((a,b)c,(d,e)f)g,h)i;"])
 >>> print(tree.ascii_art())
                               /-a
@@ -980,7 +980,7 @@ 

skbio.tree.TreeNode.root_at - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.root_at_midpoint.html b/docs/dev/generated/skbio.tree.TreeNode.root_at_midpoint.html index 7e7cdedea..a3a691d5c 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.root_at_midpoint.html +++ b/docs/dev/generated/skbio.tree.TreeNode.root_at_midpoint.html @@ -31,7 +31,7 @@ - + @@ -849,7 +849,7 @@

skbio.tree.TreeNode.root_at_midpointExamples

-
>>> from skbio import TreeNode
+
>>> from skbio import TreeNode
 >>> tree = TreeNode.read(["((a:1,b:1)c:2,(d:3,e:4)f:5,g:1)h;"])
 >>> print(tree.ascii_art())
                     /-a
@@ -959,7 +959,7 @@ 

skbio.tree.TreeNode.root_at_midpoint - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.root_by_outgroup.html b/docs/dev/generated/skbio.tree.TreeNode.root_by_outgroup.html index e43f87a91..aa58058ab 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.root_by_outgroup.html +++ b/docs/dev/generated/skbio.tree.TreeNode.root_by_outgroup.html @@ -31,7 +31,7 @@ - + @@ -829,7 +829,7 @@

skbio.tree.TreeNode.root_by_outgroupExamples

-
>>> from skbio import TreeNode
+
>>> from skbio import TreeNode
 >>> tree = TreeNode.read(['((((a,b),(c,d)),(e,f)),g);'])
 >>> print(tree.ascii_art())
                                         /-a
@@ -961,7 +961,7 @@ 

skbio.tree.TreeNode.root_by_outgroup - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.shear.html b/docs/dev/generated/skbio.tree.TreeNode.shear.html index 17ca9c530..70e66cf0c 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.shear.html +++ b/docs/dev/generated/skbio.tree.TreeNode.shear.html @@ -31,7 +31,7 @@ - + @@ -820,7 +820,7 @@

skbio.tree.TreeNode.shearinplace is False) will only include the clade.

Examples

-
>>> from skbio import TreeNode
+
>>> from skbio import TreeNode
 >>> tree = TreeNode.read(["(((a,b)c,(d,e)f)g,(h,i)j)root;"])
 >>> print(tree.ascii_art())
                               /-a
@@ -925,7 +925,7 @@ 

skbio.tree.TreeNode.shear - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.shuffle.html b/docs/dev/generated/skbio.tree.TreeNode.shuffle.html index c6f598d46..cbf186aa7 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.shuffle.html +++ b/docs/dev/generated/skbio.tree.TreeNode.shuffle.html @@ -31,7 +31,7 @@ - + @@ -822,7 +822,7 @@

skbio.tree.TreeNode.shufflenames are provided, all tips will be shuffled.

Examples

Shuffle the names of a 4-tip tree for 5 times:

-
>>> from skbio import TreeNode
+
>>> from skbio import TreeNode
 >>> tree = TreeNode.read(["((a,b),(c,d));"])
 >>> for shuffled in tree.shuffle(shuffler=42, n=5):
 ...     print(shuffled)
@@ -917,7 +917,7 @@ 

skbio.tree.TreeNode.shuffle - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.siblings.html b/docs/dev/generated/skbio.tree.TreeNode.siblings.html index 07af2192a..36955b812 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.siblings.html +++ b/docs/dev/generated/skbio.tree.TreeNode.siblings.html @@ -31,7 +31,7 @@ - + @@ -779,7 +779,7 @@

skbio.tree.TreeNode.siblingsExamples

-
>>> from skbio import TreeNode
+
>>> from skbio import TreeNode
 >>> tree = TreeNode.read(["((a,b)c,(d,e,f)g)root;"])
 >>> tip_e = tree.find('e')
 >>> [n.name for n in tip_e.siblings()]
@@ -866,7 +866,7 @@ 

skbio.tree.TreeNode.siblings - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.subset.html b/docs/dev/generated/skbio.tree.TreeNode.subset.html index 61a4fc0cb..df837a1a3 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.subset.html +++ b/docs/dev/generated/skbio.tree.TreeNode.subset.html @@ -31,7 +31,7 @@ - + @@ -803,7 +803,7 @@

skbio.tree.TreeNode.subsetExamples

-
>>> from skbio import TreeNode
+
>>> from skbio import TreeNode
 >>> tree = TreeNode.read(["((a,(b,c)d)e,(f,g)h)i;"])
 >>> print(tree.ascii_art())
                     /-a
@@ -914,7 +914,7 @@ 

skbio.tree.TreeNode.subset - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.subsets.html b/docs/dev/generated/skbio.tree.TreeNode.subsets.html index 526880c04..5db44ae5c 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.subsets.html +++ b/docs/dev/generated/skbio.tree.TreeNode.subsets.html @@ -31,7 +31,7 @@ - + @@ -826,7 +826,7 @@

skbio.tree.TreeNode.subsetsbiparts() instead.

This method operates on the subtree below the current node.

Examples

-
>>> from skbio import TreeNode
+
>>> from skbio import TreeNode
 >>> tree = TreeNode.read(["((a,(b,c)d)e,(f,g)h)i;"])
 >>> print(tree.ascii_art())
                     /-a
@@ -936,7 +936,7 @@ 

skbio.tree.TreeNode.subsets - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.subtree.html b/docs/dev/generated/skbio.tree.TreeNode.subtree.html index d2745fa7f..f8c6461a0 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.subtree.html +++ b/docs/dev/generated/skbio.tree.TreeNode.subtree.html @@ -31,7 +31,7 @@ - + @@ -846,7 +846,7 @@

skbio.tree.TreeNode.subtree - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.tips.html b/docs/dev/generated/skbio.tree.TreeNode.tips.html index 8b731b28c..b808e1a9f 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.tips.html +++ b/docs/dev/generated/skbio.tree.TreeNode.tips.html @@ -31,7 +31,7 @@ - + @@ -788,7 +788,7 @@

skbio.tree.TreeNode.tipsExamples

-
>>> from skbio import TreeNode
+
>>> from skbio import TreeNode
 >>> tree = TreeNode.read(["((a,b)c,(d,e)f);"])
 >>> print(tree.ascii_art())
                     /-a
@@ -888,7 +888,7 @@ 

skbio.tree.TreeNode.tips - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.to_array.html b/docs/dev/generated/skbio.tree.TreeNode.to_array.html index d6743ef41..ce037d90b 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.to_array.html +++ b/docs/dev/generated/skbio.tree.TreeNode.to_array.html @@ -31,7 +31,7 @@ - + @@ -793,7 +793,7 @@

skbio.tree.TreeNode.to_arrayExamples

-
>>> from skbio import TreeNode
+
>>> from skbio import TreeNode
 >>> t = TreeNode.read(['(((a:1,b:2,c:3)x:4,(d:5)y:6)z:7);'])
 >>> res = t.to_array()
 >>> sorted(res.keys())
@@ -908,7 +908,7 @@ 

skbio.tree.TreeNode.to_array - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.to_taxonomy.html b/docs/dev/generated/skbio.tree.TreeNode.to_taxonomy.html index 3f8e50f17..c6eba2e60 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.to_taxonomy.html +++ b/docs/dev/generated/skbio.tree.TreeNode.to_taxonomy.html @@ -31,7 +31,7 @@ - + @@ -789,7 +789,7 @@

skbio.tree.TreeNode.to_taxonomyExamples

-
>>> from skbio.tree import TreeNode
+
>>> from skbio.tree import TreeNode
 >>> lineages = {'1': ['Bacteria', 'Firmicutes', 'Clostridia'],
 ...             '2': ['Bacteria', 'Firmicutes', 'Bacilli'],
 ...             '3': ['Bacteria', 'Bacteroidetes', 'Sphingobacteria'],
@@ -894,7 +894,7 @@ 

skbio.tree.TreeNode.to_taxonomy - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.total_length.html b/docs/dev/generated/skbio.tree.TreeNode.total_length.html index 843635247..8eafae40b 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.total_length.html +++ b/docs/dev/generated/skbio.tree.TreeNode.total_length.html @@ -31,7 +31,7 @@ - + @@ -818,7 +818,7 @@

skbio.tree.TreeNode.total_lengthExamples

-
>>> from skbio import TreeNode
+
>>> from skbio import TreeNode
 >>> tree = TreeNode.read([
 ...     "(((A:.1,B:1.2)C:.6,(D:.9,E:.6)F:.9)G:2.4,(H:.4,I:.5)J:1.3)K;"])
 >>> print(tree.ascii_art())
@@ -927,7 +927,7 @@ 

skbio.tree.TreeNode.total_length - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.traverse.html b/docs/dev/generated/skbio.tree.TreeNode.traverse.html index 19e4f0726..a28e24629 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.traverse.html +++ b/docs/dev/generated/skbio.tree.TreeNode.traverse.html @@ -31,7 +31,7 @@ - + @@ -801,7 +801,7 @@

skbio.tree.TreeNode.traverseself_before=True, self_after=False) is equivalent to preorder traversal.

Examples

-
>>> from skbio import TreeNode
+
>>> from skbio import TreeNode
 >>> tree = TreeNode.read(["((a,b)c,(d,e)f)g;"])
 >>> print(tree.ascii_art())
                     /-a
@@ -904,7 +904,7 @@ 

skbio.tree.TreeNode.traverse - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.unpack.html b/docs/dev/generated/skbio.tree.TreeNode.unpack.html index 852e10baa..6e1916a3d 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.unpack.html +++ b/docs/dev/generated/skbio.tree.TreeNode.unpack.html @@ -31,7 +31,7 @@ - + @@ -792,7 +792,7 @@

skbio.tree.TreeNode.unpackExamples

-
>>> from skbio import TreeNode
+
>>> from skbio import TreeNode
 >>> tree = TreeNode.read(['((c:2.0,d:3.0)a:1.0,(e:2.0,f:1.0)b:2.0);'])
 >>> tree.find('b').unpack()
 >>> print(tree)
@@ -879,7 +879,7 @@ 

skbio.tree.TreeNode.unpack - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.unpack_by_func.html b/docs/dev/generated/skbio.tree.TreeNode.unpack_by_func.html index cb02b5859..082f774cc 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.unpack_by_func.html +++ b/docs/dev/generated/skbio.tree.TreeNode.unpack_by_func.html @@ -31,7 +31,7 @@ - + @@ -785,7 +785,7 @@

skbio.tree.TreeNode.unpack_by_funcExamples

-
>>> from skbio import TreeNode
+
>>> from skbio import TreeNode
 >>> tree = TreeNode.read(['((c:2,d:3)a:1,(e:1,f:2)b:2);'])
 >>> tree.unpack_by_func(lambda x: x.length <= 1)
 >>> print(tree)
@@ -878,7 +878,7 @@ 

skbio.tree.TreeNode.unpack_by_func - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.unroot.html b/docs/dev/generated/skbio.tree.TreeNode.unroot.html index c887a578e..1656161f4 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.unroot.html +++ b/docs/dev/generated/skbio.tree.TreeNode.unroot.html @@ -31,7 +31,7 @@ - + @@ -813,7 +813,7 @@

skbio.tree.TreeNode.unrootExamples

-
>>> from skbio import TreeNode
+
>>> from skbio import TreeNode
 >>> tree = TreeNode.read(['(((a,b)c,(d,e)f)g,(h,i)j)k;'])
 >>> print(tree.ascii_art())
                               /-a
@@ -924,7 +924,7 @@ 

skbio.tree.TreeNode.unroot - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.unrooted_copy.html b/docs/dev/generated/skbio.tree.TreeNode.unrooted_copy.html index 07d62a841..8d7e8c377 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.unrooted_copy.html +++ b/docs/dev/generated/skbio.tree.TreeNode.unrooted_copy.html @@ -31,7 +31,7 @@ - + @@ -838,7 +838,7 @@

skbio.tree.TreeNode.unrooted_copybranch_attrs will be transferred to the node at the other end of a branch if the branch is flipped in the new tree.

Examples

-
>>> from skbio import TreeNode
+
>>> from skbio import TreeNode
 >>> tree = TreeNode.read(["((a,(b,c)d)e,(f,g)h)i;"])
 >>> new_tree = tree.find('d').unrooted_copy()
 >>> print(new_tree)
@@ -925,7 +925,7 @@ 

skbio.tree.TreeNode.unrooted_copy - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.unrooted_deepcopy.html b/docs/dev/generated/skbio.tree.TreeNode.unrooted_deepcopy.html index 2efab3054..e60ca8277 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.unrooted_deepcopy.html +++ b/docs/dev/generated/skbio.tree.TreeNode.unrooted_deepcopy.html @@ -31,7 +31,7 @@ - + @@ -872,7 +872,7 @@

skbio.tree.TreeNode.unrooted_deepcopy - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.unrooted_move.html b/docs/dev/generated/skbio.tree.TreeNode.unrooted_move.html index cfa183855..81a7cc856 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.unrooted_move.html +++ b/docs/dev/generated/skbio.tree.TreeNode.unrooted_move.html @@ -31,7 +31,7 @@ - + @@ -799,7 +799,7 @@

skbio.tree.TreeNode.unrooted_moveExamples

-
>>> from skbio import TreeNode
+
>>> from skbio import TreeNode
 >>> tree = TreeNode.read(["((a,(b,c)d)e,(f,g)h)i;"])
 >>> new_root = tree.find('d')
 >>> new_root.unrooted_move()
@@ -887,7 +887,7 @@ 

skbio.tree.TreeNode.unrooted_move - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.TreeNode.write.html b/docs/dev/generated/skbio.tree.TreeNode.write.html index 4bca53873..57a2d323d 100644 --- a/docs/dev/generated/skbio.tree.TreeNode.write.html +++ b/docs/dev/generated/skbio.tree.TreeNode.write.html @@ -31,7 +31,7 @@ - + @@ -872,7 +872,7 @@

skbio.tree.TreeNode.write - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.bme.html b/docs/dev/generated/skbio.tree.bme.html index 4473a9ed9..c702f260b 100644 --- a/docs/dev/generated/skbio.tree.bme.html +++ b/docs/dev/generated/skbio.tree.bme.html @@ -31,7 +31,7 @@ - + @@ -724,8 +724,8 @@

skbio.tree.bmeExamples

Define a new distance matrix object describing the distances between five taxa: human, monkey, pig, rat, and chicken.

-
>>> from skbio import DistanceMatrix
->>> from skbio.tree import bme
+
>>> from skbio import DistanceMatrix
+>>> from skbio.tree import bme
 
>>> dm = DistanceMatrix([[0, 0.02,  0.18,  0.34,  0.55],
@@ -833,7 +833,7 @@ 

skbio.tree.bme - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.gme.html b/docs/dev/generated/skbio.tree.gme.html index 237c2ec80..f7df802b4 100644 --- a/docs/dev/generated/skbio.tree.gme.html +++ b/docs/dev/generated/skbio.tree.gme.html @@ -31,7 +31,7 @@ - + @@ -718,8 +718,8 @@

skbio.tree.gmeExamples

Define a new distance matrix object describing the distances between five taxa: human, monkey, pig, rat, and chicken.

-
>>> from skbio import DistanceMatrix
->>> from skbio.tree import gme
+
>>> from skbio import DistanceMatrix
+>>> from skbio.tree import gme
 
>>> dm = DistanceMatrix([[0, 0.02,  0.18,  0.34,  0.55],
@@ -827,7 +827,7 @@ 

skbio.tree.gme - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.majority_rule.html b/docs/dev/generated/skbio.tree.majority_rule.html index a3750080a..568144eaf 100644 --- a/docs/dev/generated/skbio.tree.majority_rule.html +++ b/docs/dev/generated/skbio.tree.majority_rule.html @@ -31,7 +31,7 @@ - + @@ -737,7 +737,7 @@

skbio.tree.majority_rule
>>> from skbio.tree import TreeNode
+
>>> from skbio.tree import TreeNode
 >>> trees = [
 ... TreeNode.read(["(A,(B,(H,(D,(J,(((G,E),(F,I)),C))))));"]),
 ... TreeNode.read(["(A,(B,(D,((J,H),(((G,E),(F,I)),C)))));"]),
@@ -854,7 +854,7 @@ 

skbio.tree.majority_rule - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.nj.html b/docs/dev/generated/skbio.tree.nj.html index 43e012668..8451d8caa 100644 --- a/docs/dev/generated/skbio.tree.nj.html +++ b/docs/dev/generated/skbio.tree.nj.html @@ -31,7 +31,7 @@ - + @@ -770,8 +770,8 @@

skbio.tree.njExamples

Define a new distance matrix object describing the distances between five taxa: a, b, c, d, and e.

-
>>> from skbio import DistanceMatrix
->>> from skbio.tree import nj
+
>>> from skbio import DistanceMatrix
+>>> from skbio.tree import nj
 

metricstr or callable, optional

The distance metric to use. Can be a preset, a distance function name under -scipy.spatial.distance, or a custom function that takes two vectors and +scipy.spatial.distance, or a custom function that takes two vectors and returns a number. See compare_cophenet() for details.

use_lengthbool, optional

Whether to calculate the sum of branch lengths (True, default) or the @@ -752,7 +752,7 @@

skbio.tree.path_dists

Examples

-
>>> from skbio import TreeNode
+
>>> from skbio import TreeNode
 >>> trees = [TreeNode.read([x]) for x in (
 ...     "((a:1,b:2):1,c:4,((d:4,e:5):2,f:6):1);",
 ...     "((a:3,(b:2,c:2):1):3,d:8,(e:5,f:6):2);",
@@ -849,7 +849,7 @@ 

skbio.tree.path_dists - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.rf_dists.html b/docs/dev/generated/skbio.tree.rf_dists.html index 8d4ef6dc7..7b620c137 100644 --- a/docs/dev/generated/skbio.tree.rf_dists.html +++ b/docs/dev/generated/skbio.tree.rf_dists.html @@ -31,7 +31,7 @@ - + @@ -735,7 +735,7 @@

skbio.tree.rf_distsExamples

-
>>> from skbio import TreeNode
+
>>> from skbio import TreeNode
 >>> trees = [TreeNode.read([x]) for x in (
 ...     "(((a,b),c),d,e);",
 ...     "((a,(b,c)),d,e);",
@@ -834,7 +834,7 @@ 

skbio.tree.rf_dists - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.tree.upgma.html b/docs/dev/generated/skbio.tree.upgma.html index 28ae0a012..ca207fc3d 100644 --- a/docs/dev/generated/skbio.tree.upgma.html +++ b/docs/dev/generated/skbio.tree.upgma.html @@ -32,7 +32,7 @@ - + @@ -722,7 +722,7 @@

skbio.tree.upgmaExamples

Define a distance matrix object for the taxa a, b, and c.

-
>>> from skbio import DistanceMatrix
+
>>> from skbio import DistanceMatrix
 

Examples

-
>>> from skbio import TreeNode
+
>>> from skbio import TreeNode
 >>> trees = [TreeNode.read([x]) for x in (
 ...     "((a:1,b:2):1,c:4,((d:4,e:5):2,f:6):1);",
 ...     "((a:3,(b:2,c:2):1):3,d:8,(e:5,f:6):2);",
@@ -842,7 +842,7 @@ 

skbio.tree.wrf_dists - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.util.PlottableMixin.html b/docs/dev/generated/skbio.util.PlottableMixin.html index 78a74f8ff..d6c4189a2 100644 --- a/docs/dev/generated/skbio.util.PlottableMixin.html +++ b/docs/dev/generated/skbio.util.PlottableMixin.html @@ -31,7 +31,7 @@ - + @@ -842,7 +842,7 @@

skbio.util.PlottableMixin - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.util.aliased.html b/docs/dev/generated/skbio.util.aliased.html index 5837e31a6..1c43a14ce 100644 --- a/docs/dev/generated/skbio.util.aliased.html +++ b/docs/dev/generated/skbio.util.aliased.html @@ -31,7 +31,7 @@ - + @@ -788,7 +788,7 @@

skbio.util.aliased - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.util.assert_data_frame_almost_equal.html b/docs/dev/generated/skbio.util.assert_data_frame_almost_equal.html index 100576a6c..6210148c6 100644 --- a/docs/dev/generated/skbio.util.assert_data_frame_almost_equal.html +++ b/docs/dev/generated/skbio.util.assert_data_frame_almost_equal.html @@ -31,7 +31,7 @@ - + @@ -800,7 +800,7 @@

skbio.util.assert_data_frame_almost_equal - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.util.assert_ordination_results_equal.html b/docs/dev/generated/skbio.util.assert_ordination_results_equal.html index b8364295f..0252b27e8 100644 --- a/docs/dev/generated/skbio.util.assert_ordination_results_equal.html +++ b/docs/dev/generated/skbio.util.assert_ordination_results_equal.html @@ -31,7 +31,7 @@ - + @@ -790,7 +790,7 @@

skbio.util.assert_ordination_results_equal - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.util.cardinal_to_ordinal.html b/docs/dev/generated/skbio.util.cardinal_to_ordinal.html index 558266eec..9b95a2f00 100644 --- a/docs/dev/generated/skbio.util.cardinal_to_ordinal.html +++ b/docs/dev/generated/skbio.util.cardinal_to_ordinal.html @@ -31,7 +31,7 @@ - + @@ -707,7 +707,7 @@

skbio.util.cardinal_to_ordinalNotes

This function can be useful when writing human-readable error messages.

Examples

-
>>> from skbio.util import cardinal_to_ordinal
+
>>> from skbio.util import cardinal_to_ordinal
 >>> cardinal_to_ordinal(0)
 '0th'
 >>> cardinal_to_ordinal(1)
@@ -798,7 +798,7 @@ 

skbio.util.cardinal_to_ordinal - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.util.classonlymethod.html b/docs/dev/generated/skbio.util.classonlymethod.html index ffcdd8495..df6ea6132 100644 --- a/docs/dev/generated/skbio.util.classonlymethod.html +++ b/docs/dev/generated/skbio.util.classonlymethod.html @@ -31,7 +31,7 @@ - + @@ -816,7 +816,7 @@

skbio.util.classonlymethod - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.util.classproperty.html b/docs/dev/generated/skbio.util.classproperty.html index 0d006e9ee..9542b988f 100644 --- a/docs/dev/generated/skbio.util.classproperty.html +++ b/docs/dev/generated/skbio.util.classproperty.html @@ -31,7 +31,7 @@ - + @@ -885,7 +885,7 @@

skbio.util.classproperty - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.util.deprecated.html b/docs/dev/generated/skbio.util.deprecated.html index 8c7de5b20..8f436fa67 100644 --- a/docs/dev/generated/skbio.util.deprecated.html +++ b/docs/dev/generated/skbio.util.deprecated.html @@ -31,7 +31,7 @@ - + @@ -781,7 +781,7 @@

skbio.util.deprecated - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.util.find_duplicates.html b/docs/dev/generated/skbio.util.find_duplicates.html index 5f9836964..6654eb7ab 100644 --- a/docs/dev/generated/skbio.util.find_duplicates.html +++ b/docs/dev/generated/skbio.util.find_duplicates.html @@ -31,7 +31,7 @@ - + @@ -779,7 +779,7 @@

skbio.util.find_duplicates - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.util.get_data_path.html b/docs/dev/generated/skbio.util.get_data_path.html index c7415fb22..19eb60327 100644 --- a/docs/dev/generated/skbio.util.get_data_path.html +++ b/docs/dev/generated/skbio.util.get_data_path.html @@ -31,7 +31,7 @@ - + @@ -787,7 +787,7 @@

skbio.util.get_data_path - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.util.get_rng.html b/docs/dev/generated/skbio.util.get_rng.html index 5f2ec4b26..3795bdfc7 100644 --- a/docs/dev/generated/skbio.util.get_rng.html +++ b/docs/dev/generated/skbio.util.get_rng.html @@ -31,7 +31,7 @@ - + @@ -843,7 +843,7 @@

skbio.util.get_rng - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.util.overrides.html b/docs/dev/generated/skbio.util.overrides.html index 5d881b648..9713db518 100644 --- a/docs/dev/generated/skbio.util.overrides.html +++ b/docs/dev/generated/skbio.util.overrides.html @@ -31,7 +31,7 @@ - + @@ -789,7 +789,7 @@

skbio.util.overrides - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.util.params_aliased.html b/docs/dev/generated/skbio.util.params_aliased.html index 2c253623d..2b0838364 100644 --- a/docs/dev/generated/skbio.util.params_aliased.html +++ b/docs/dev/generated/skbio.util.params_aliased.html @@ -31,7 +31,7 @@ - + @@ -783,7 +783,7 @@

skbio.util.params_aliased - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.util.register_aliases.html b/docs/dev/generated/skbio.util.register_aliases.html index bc36568a9..9d6084365 100644 --- a/docs/dev/generated/skbio.util.register_aliases.html +++ b/docs/dev/generated/skbio.util.register_aliases.html @@ -31,7 +31,7 @@ - + @@ -694,7 +694,7 @@

skbio.util.register_aliases
@register_aliases
-class MyClass():
+class MyClass():
 

Alternatively, this function may be called at the end of a module to register @@ -782,7 +782,7 @@

skbio.util.register_aliases - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.util.safe_md5.html b/docs/dev/generated/skbio.util.safe_md5.html index 496b3a627..92aed44ff 100644 --- a/docs/dev/generated/skbio.util.safe_md5.html +++ b/docs/dev/generated/skbio.util.safe_md5.html @@ -31,7 +31,7 @@ - + @@ -704,8 +704,8 @@

skbio.util.safe_md5http://stackoverflow.com/a/1131255/379593

Examples

-
>>> from io import BytesIO
->>> from skbio.util import safe_md5
+
>>> from io import BytesIO
+>>> from skbio.util import safe_md5
 >>> fd = BytesIO(b"foo bar baz") # open file like object
 >>> x = safe_md5(fd)
 >>> x.hexdigest()
@@ -784,7 +784,7 @@ 

skbio.util.safe_md5 - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.workflow.Workflow.html b/docs/dev/generated/skbio.workflow.Workflow.html index 886a8ef2a..b953982b2 100644 --- a/docs/dev/generated/skbio.workflow.Workflow.html +++ b/docs/dev/generated/skbio.workflow.Workflow.html @@ -31,7 +31,7 @@ - + @@ -860,7 +860,7 @@

skbio.workflow.Workflow - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.workflow.Workflow.initialize_state.html b/docs/dev/generated/skbio.workflow.Workflow.initialize_state.html index c745924dc..4542f0096 100644 --- a/docs/dev/generated/skbio.workflow.Workflow.initialize_state.html +++ b/docs/dev/generated/skbio.workflow.Workflow.initialize_state.html @@ -31,7 +31,7 @@ - + @@ -764,7 +764,7 @@

skbio.workflow.Workflow.initialize_state - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.workflow.method.html b/docs/dev/generated/skbio.workflow.method.html index d55a94247..1abbe7027 100644 --- a/docs/dev/generated/skbio.workflow.method.html +++ b/docs/dev/generated/skbio.workflow.method.html @@ -31,7 +31,7 @@ - + @@ -824,7 +824,7 @@

skbio.workflow.method - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/generated/skbio.workflow.requires.html b/docs/dev/generated/skbio.workflow.requires.html index c0be5e710..c737b8e75 100644 --- a/docs/dev/generated/skbio.workflow.requires.html +++ b/docs/dev/generated/skbio.workflow.requires.html @@ -31,7 +31,7 @@ - + @@ -824,7 +824,7 @@

skbio.workflow.requires - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/genindex.html b/docs/dev/genindex.html index dce9044b8..bb11a1f8e 100644 --- a/docs/dev/genindex.html +++ b/docs/dev/genindex.html @@ -29,7 +29,7 @@ - + @@ -2698,7 +2698,7 @@

W

diff --git a/docs/dev/index.html b/docs/dev/index.html index 6771fece0..76fd492a9 100644 --- a/docs/dev/index.html +++ b/docs/dev/index.html @@ -31,7 +31,7 @@ - + @@ -696,7 +696,7 @@

scikit-bio 0.6.3-dev documentation - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/io.html b/docs/dev/io.html index 710f50cf4..1a865caf8 100644 --- a/docs/dev/io.html +++ b/docs/dev/io.html @@ -31,7 +31,7 @@ - + @@ -933,9 +933,9 @@

Reading files into scikit-bionewick file into a TreeNode object using both interfaces. Here we will use Python’s built-in StringIO class to mimick an open file:

-
>>> from skbio import read as sk_read
->>> from skbio import TreeNode
->>> from io import StringIO
+
>>> from skbio import read as sk_read
+>>> from skbio import TreeNode
+>>> from io import StringIO
 >>> open_filehandle = StringIO('(a, b);')
 >>> tree = sk_read(open_filehandle, format='newick', into=TreeNode)
 >>> tree
@@ -1096,7 +1096,7 @@ 

Streaming files with read and write - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/metadata.html b/docs/dev/metadata.html index 4a708d07a..754f738e5 100644 --- a/docs/dev/metadata.html +++ b/docs/dev/metadata.html @@ -31,7 +31,7 @@ - + @@ -817,7 +817,7 @@

Abstract classes - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/py-modindex.html b/docs/dev/py-modindex.html index c71ae610f..1e828885d 100644 --- a/docs/dev/py-modindex.html +++ b/docs/dev/py-modindex.html @@ -29,7 +29,7 @@ - + @@ -880,7 +880,7 @@

Python Module Index

diff --git a/docs/dev/search.html b/docs/dev/search.html index 0d2a70dae..46334e119 100644 --- a/docs/dev/search.html +++ b/docs/dev/search.html @@ -28,7 +28,7 @@ - + @@ -683,7 +683,7 @@

Search

diff --git a/docs/dev/searchindex.js b/docs/dev/searchindex.js index c912aa42e..cdd76f153 100644 --- a/docs/dev/searchindex.js +++ b/docs/dev/searchindex.js @@ -1 +1 @@ -Search.setIndex({"alltitles": {"Abstract classes": [[507, "abstract-classes"], [508, "abstract-classes"]], "Adding Node Information": [[116, "adding-node-information"]], "Advanced Label and Length Rules": [[116, "advanced-label-and-length-rules"]], "Alignment Section": [[108, "alignment-section"], [118, "alignment-section"]], "Alignment algorithms": [[0, "alignment-algorithms"]], "Alignment data structure": [[0, "alignment-data-structure"]], "Alignment structure": [[0, "alignment-structure"]], "Alpha diversity": [[1, "alpha-diversity"]], "Alpha diversity measures (skbio.diversity.alpha)": [[43, null]], "Application of Rules": [[116, "application-of-rules"]], "Arithmetic operations": [[256, "arithmetic-operations"]], "BIOM table": [[510, "biom-table"]], "BIOM-Format (skbio.io.format.biom)": [[105, null]], "BLAST Column Types": [[106, "blast-column-types"], [107, "blast-column-types"]], "BLAST+6 format (skbio.io.format.blast6)": [[106, null]], "BLAST+7 format (skbio.io.format.blast7)": [[107, null]], "Basic Symbols": [[116, "basic-symbols"]], "Basis construction": [[256, "basis-construction"]], "Beta diversity": [[1, "beta-diversity"]], "Beta diversity measures (skbio.diversity.beta)": [[83, null]], "Biological Embeddings (skbio.embedding)": [[2, null]], "Biological Sequences (skbio.sequence)": [[508, null]], "Canonical analysis": [[319, "canonical-analysis"]], "Categorical Variable Stats": [[276, "categorical-variable-stats"]], "Caveats": [[116, "caveats"]], "Classes": [[123, "classes"], [276, "classes"], [305, "classes"], [513, "classes"]], "Clustal format (skbio.io.format.clustal)": [[108, null]], "Column Types": [[120, "column-types"]], "Comments and Empty Rows": [[120, "comments-and-empty-rows"]], "Community Diversity (skbio.diversity)": [[1, null]], "Composition Statistics (skbio.stats.composition)": [[256, null]], "Composition statistics": [[509, "composition-statistics"]], "Continuous Variable Stats": [[276, "continuous-variable-stats"]], "Cophylogenetic methods": [[303, "cophylogenetic-methods"]], "Correlation analysis": [[256, "correlation-analysis"]], "Correspondence analysis": [[319, "correspondence-analysis"]], "Count vectors": [[1, "count-vectors"]], "Coverage metrics": [[43, "coverage-metrics"]], "Creating a new format for scikit-bio": [[123, "creating-a-new-format-for-scikit-bio"]], "Data Table (skbio.table)": [[510, null]], "Data structures": [[276, "data-structures"]], "Data subsampling": [[509, "data-subsampling"]], "Decorators": [[512, "decorators"], [513, "decorators"]], "Deprecated functionality": [[0, "deprecated-functionality"]], "Develop custom formats": [[506, "develop-custom-formats"]], "Differential abundance": [[256, "differential-abundance"]], "Distance Matrix Comparisons": [[276, "distance-matrix-comparisons"]], "Distance calculation": [[508, "distance-calculation"]], "Distance matrix statistics": [[509, "distance-matrix-statistics"]], "Distance matrix-based statistics (skbio.stats.distance)": [[276, null]], "Distance-based statistics": [[276, "distance-based-statistics"]], "Diversity metrics": [[43, "diversity-metrics"]], "Dominance metrics": [[43, "dominance-metrics"]], "EMBL format (skbio.io.format.embl)": [[110, null]], "Embedding format (skbio.io.format.embed).": [[109, null]], "Embedding types": [[2, "embedding-types"]], "Embedding vector types": [[2, "embedding-vector-types"]], "Embedding vector utilities": [[2, "embedding-vector-utilities"]], "Empirical Power Estimation (skbio.stats.power)": [[336, null]], "Evenness metrics": [[43, "evenness-metrics"]], "Evolutionary statistics (skbio.stats.evolve)": [[303, null]], "Example data": [[510, "example-data"]], "Examples": [[105, "examples"], [106, "examples"], [107, "examples"], [108, "examples"], [109, "examples"], [110, "examples"], [111, "examples"], [112, "examples"], [113, "examples"], [114, "examples"], [116, "examples"], [117, "examples"], [118, "examples"], [119, "examples"], [121, "examples"], [122, "examples"], [276, "examples"], [305, "examples"], [319, "examples"], [336, "examples"]], "Exceptions": [[123, "exceptions"], [276, "exceptions"], [511, "exceptions"]], "Exceptions and warnings": [[506, "exceptions-and-warnings"]], "Explanation": [[116, "explanation"]], "FASTA Format": [[111, "fasta-format"]], "FASTA/QUAL format (skbio.io.format.fasta)": [[111, null]], "FASTQ format (skbio.io.format.fastq)": [[112, null]], "FEATURES section": [[113, "features-section"]], "FT section": [[110, "ft-section"]], "Feature Level Products": [[110, "feature-level-products"]], "Footer": [[121, "footer"]], "Formal Grammar": [[116, "formal-grammar"]], "Format Parameters": [[106, "format-parameters"], [108, "format-parameters"], [111, "format-parameters"], [112, "format-parameters"], [113, "format-parameters"], [114, "format-parameters"], [115, "format-parameters"], [116, "format-parameters"], [118, "format-parameters"], [119, "format-parameters"], [121, "format-parameters"], [122, "format-parameters"]], "Format Specification": [[104, "format-specification"], [105, "format-specification"], [106, "format-specification"], [107, "format-specification"], [108, "format-specification"], [109, "format-specification"], [110, "format-specification"], [111, "format-specification"], [112, "format-specification"], [113, "format-specification"], [114, "format-specification"], [115, "format-specification"], [116, "format-specification"], [117, "format-specification"], [118, "format-specification"], [119, "format-specification"], [120, "format-specification"], [121, "format-specification"], [122, "format-specification"]], "Format Support": [[104, "format-support"], [105, "format-support"], [106, "format-support"], [107, "format-support"], [108, "format-support"], [109, "format-support"], [110, "format-support"], [111, "format-support"], [112, "format-support"], [113, "format-support"], [114, "format-support"], [115, "format-support"], [116, "format-support"], [117, "format-support"], [118, "format-support"], [119, "format-support"], [120, null], [121, "format-support"], [122, "format-support"]], "Functions": [[83, "functions"], [123, "functions"], [144, "functions"], [253, "functions"], [276, "functions"], [303, "functions"], [336, "functions"]], "GC metadata": [[121, "gc-metadata"]], "GF metadata": [[121, "gf-metadata"]], "GFF3 format (skbio.io.format.gff3)": [[114, null]], "GR metadata": [[121, "gr-metadata"]], "GS metadata": [[121, "gs-metadata"]], "GenBank format (skbio.io.format.genbank)": [[113, null]], "Generator and TabularMSA Reader Parameters": [[111, "generator-and-tabularmsa-reader-parameters"]], "Generators Only": [[119, "generators-only"]], "Gradient analyses (skbio.stats.gradient)": [[305, null]], "Header": [[121, "header"]], "Header Section": [[118, "header-section"]], "I/O Registry (skbio.io.registry)": [[123, null]], "I/O utilities (skbio.io.util)": [[144, null]], "Identifier Column": [[120, "identifier-column"]], "Inline Comments": [[116, "inline-comments"]], "Input and Output (skbio.io)": [[506, null]], "Input validation": [[1, "input-validation"]], "Interval metadata": [[507, "interval-metadata"]], "Introduction": [[1, "introduction"]], "Labeled square matrix format (skbio.io.format.lsmat)": [[115, null]], "Leading and trailing whitespace characters": [[120, "leading-and-trailing-whitespace-characters"]], "Location string": [[113, "location-string"]], "Log-ratio transformation": [[256, "log-ratio-transformation"]], "Metadata": [[121, "metadata"]], "Metadata (skbio.metadata)": [[507, null]], "Metadata Columns": [[120, "metadata-columns"]], "Metadata Formatting Requirements": [[120, "metadata-formatting-requirements"]], "Metadata Validation": [[120, "metadata-validation"]], "Metadata columns": [[507, "metadata-columns"]], "Miscellaneous utilities": [[512, "miscellaneous-utilities"]], "Multidimensional scaling": [[319, "multidimensional-scaling"]], "Multiple Sequence Alignment": [[121, "multiple-sequence-alignment"]], "Multivariate Statistics (skbio.stats)": [[509, null]], "Newick format (skbio.io.format.newick)": [[116, null]], "Number Formatting": [[120, "number-formatting"]], "ORIGIN section": [[113, "origin-section"]], "Ordination methods": [[509, "ordination-methods"]], "Ordination methods (skbio.stats.ordination)": [[319, null]], "Ordination results": [[319, "ordination-results"]], "Ordination results format (skbio.io.format.ordination)": [[117, null]], "Other statistical methods": [[509, "other-statistical-methods"]], "PHYLIP multiple sequence alignment format (skbio.io.format.phylip)": [[118, null]], "Plotting utilities": [[512, "plotting-utilities"]], "QSeq format (skbio.io.format.qseq)": [[119, null]], "QUAL File Parameter (Readers and Writers)": [[111, "qual-file-parameter-readers-and-writers"]], "QUAL Format": [[111, "qual-format"]], "Quality Score Variants": [[112, "quality-score-variants"]], "Read/write files": [[506, "read-write-files"]], "Reader-specific Parameters": [[111, "reader-specific-parameters"], [113, "reader-specific-parameters"], [114, "reader-specific-parameters"]], "Reading EMBL Files": [[110, "reading-embl-files"]], "Reading EMBL Files using generators": [[110, "reading-embl-files-using-generators"]], "Reading and Writing FASTA Files": [[111, "reading-and-writing-fasta-files"]], "Reading and Writing FASTA/QUAL Files": [[111, "reading-and-writing-fasta-qual-files"]], "Reading and Writing GenBank Files": [[113, "reading-and-writing-genbank-files"]], "Reading files into scikit-bio": [[506, "reading-files-into-scikit-bio"]], "Reading multi-FASTA Files": [[111, "reading-multi-fasta-files"]], "Recommendations for Identifiers": [[120, "recommendations-for-identifiers"]], "References": [[43, "references"], [104, "references"], [105, "references"], [106, "references"], [107, "references"], [108, "references"], [110, "references"], [111, "references"], [112, "references"], [113, "references"], [114, "references"], [116, "references"], [118, "references"], [119, "references"], [121, "references"], [122, "references"], [256, "references"], [276, "references"], [319, "references"]], "Reserved Keyword Arguments": [[123, "reserved-keyword-arguments"]], "Richness metrics": [[43, "richness-metrics"]], "SQ section": [[110, "sq-section"]], "Sample metadata": [[507, "sample-metadata"]], "Sections before FEATURES": [[113, "sections-before-features"]], "Sections before FH (Feature Header)": [[110, "sections-before-fh-feature-header"]], "Sequence Alignments (skbio.alignment)": [[0, null]], "Sequence Data": [[111, "sequence-data"]], "Sequence Header": [[111, "sequence-header"]], "Sequence Reader Parameters": [[111, "sequence-reader-parameters"]], "Sequence distance metrics (skbio.sequence.distance)": [[253, null]], "Sequence types": [[508, "sequence-types"]], "Sequence utilities": [[508, "sequence-utilities"]], "Simple binary dissimilarity matrix format (skbio.io.format.binary_dm)": [[104, null]], "Specifying a diversity metric": [[1, "specifying-a-diversity-metric"]], "Stockholm format (skbio.io.format.stockholm)": [[121, null]], "Streaming files with read and write": [[506, "streaming-files-with-read-and-write"]], "Supported file formats": [[506, "supported-file-formats"]], "Taxdump format (skbio.io.format.taxdump)": [[122, null]], "Testing utilities": [[512, "testing-utilities"]], "Tree Comparison": [[511, "tree-comparison"]], "Tree Construction": [[511, "tree-construction"]], "Tree Rearrangement": [[511, "tree-rearrangement"]], "Tree structure and operations": [[511, "tree-structure-and-operations"]], "Tree utilities": [[511, "tree-utilities"]], "Trees and Phylogenetics (skbio.tree)": [[511, null]], "Tutorial": [[0, "tutorial"], [1, "tutorial"], [506, "tutorial"], [508, "tutorial"], [511, "tutorial"], [513, "tutorial"]], "Using the optimized alignment algorithm": [[0, "using-the-optimized-alignment-algorithm"]], "Using the slow alignment algorithm": [[0, "using-the-slow-alignment-algorithm"]], "Utilities for Developers (skbio.util)": [[512, null]], "Utility functions": [[319, "utility-functions"]], "What kinds of files scikit-bio can use": [[506, "what-kinds-of-files-scikit-bio-can-use"]], "Whitespace": [[116, "whitespace"]], "Workflow construction (skbio.workflow)": [[513, null]], "Writer-specific Parameters": [[111, "writer-specific-parameters"], [114, "writer-specific-parameters"]], "Writing files from scikit-bio": [[506, "writing-files-from-scikit-bio"]], "Zero handling": [[256, "zero-handling"]], "division.dmp": [[122, "division-dmp"]], "gencode.dmp": [[122, "gencode-dmp"]], "names.dmp": [[122, "names-dmp"]], "nodes.dmp": [[122, "nodes-dmp"]], "scikit-bio 0.6.3-dev documentation": [[505, null]], "skbio.alignment.AlignPath": [[3, null]], "skbio.alignment.AlignPath.from_bits": [[4, null]], "skbio.alignment.AlignPath.from_coordinates": [[5, null]], "skbio.alignment.AlignPath.from_indices": [[6, null]], "skbio.alignment.AlignPath.from_tabular": [[7, null]], "skbio.alignment.AlignPath.to_bits": [[8, null]], "skbio.alignment.AlignPath.to_coordinates": [[9, null]], "skbio.alignment.AlignPath.to_indices": [[10, null]], "skbio.alignment.AlignmentStructure": [[11, null]], "skbio.alignment.AlignmentStructure.is_zero_based": [[12, null]], "skbio.alignment.AlignmentStructure.set_zero_based": [[13, null]], "skbio.alignment.PairAlignPath": [[14, null]], "skbio.alignment.PairAlignPath.from_bits": [[15, null]], "skbio.alignment.PairAlignPath.from_cigar": [[16, null]], "skbio.alignment.PairAlignPath.to_bits": [[17, null]], "skbio.alignment.PairAlignPath.to_cigar": [[18, null]], "skbio.alignment.StripedSmithWaterman": [[19, null]], "skbio.alignment.TabularMSA": [[20, null]], "skbio.alignment.TabularMSA.append": [[21, null]], "skbio.alignment.TabularMSA.consensus": [[22, null]], "skbio.alignment.TabularMSA.conservation": [[23, null]], "skbio.alignment.TabularMSA.extend": [[24, null]], "skbio.alignment.TabularMSA.from_dict": [[25, null]], "skbio.alignment.TabularMSA.from_path_seqs": [[26, null]], "skbio.alignment.TabularMSA.gap_frequencies": [[27, null]], "skbio.alignment.TabularMSA.iter_positions": [[28, null]], "skbio.alignment.TabularMSA.join": [[29, null]], "skbio.alignment.TabularMSA.read": [[30, null]], "skbio.alignment.TabularMSA.reassign_index": [[31, null]], "skbio.alignment.TabularMSA.sort": [[32, null]], "skbio.alignment.TabularMSA.to_dict": [[33, null]], "skbio.alignment.TabularMSA.write": [[34, null]], "skbio.alignment.global_pairwise_align": [[35, null]], "skbio.alignment.global_pairwise_align_nucleotide": [[36, null]], "skbio.alignment.global_pairwise_align_protein": [[37, null]], "skbio.alignment.local_pairwise_align": [[38, null]], "skbio.alignment.local_pairwise_align_nucleotide": [[39, null]], "skbio.alignment.local_pairwise_align_protein": [[40, null]], "skbio.alignment.local_pairwise_align_ssw": [[41, null]], "skbio.alignment.make_identity_substitution_matrix": [[42, null]], "skbio.diversity.alpha.ace": [[44, null]], "skbio.diversity.alpha.berger_parker_d": [[45, null]], "skbio.diversity.alpha.brillouin_d": [[46, null]], "skbio.diversity.alpha.chao1": [[47, null]], "skbio.diversity.alpha.chao1_ci": [[48, null]], "skbio.diversity.alpha.dominance": [[49, null]], "skbio.diversity.alpha.doubles": [[50, null]], "skbio.diversity.alpha.enspie": [[51, null]], "skbio.diversity.alpha.esty_ci": [[52, null]], "skbio.diversity.alpha.faith_pd": [[53, null]], "skbio.diversity.alpha.fisher_alpha": [[54, null]], "skbio.diversity.alpha.gini_index": [[55, null]], "skbio.diversity.alpha.goods_coverage": [[56, null]], "skbio.diversity.alpha.heip_e": [[57, null]], "skbio.diversity.alpha.hill": [[58, null]], "skbio.diversity.alpha.inv_simpson": [[59, null]], "skbio.diversity.alpha.kempton_taylor_q": [[60, null]], "skbio.diversity.alpha.lladser_ci": [[61, null]], "skbio.diversity.alpha.lladser_pe": [[62, null]], "skbio.diversity.alpha.margalef": [[63, null]], "skbio.diversity.alpha.mcintosh_d": [[64, null]], "skbio.diversity.alpha.mcintosh_e": [[65, null]], "skbio.diversity.alpha.menhinick": [[66, null]], "skbio.diversity.alpha.michaelis_menten_fit": [[67, null]], "skbio.diversity.alpha.observed_features": [[68, null]], "skbio.diversity.alpha.osd": [[69, null]], "skbio.diversity.alpha.phydiv": [[70, null]], "skbio.diversity.alpha.pielou_e": [[71, null]], "skbio.diversity.alpha.renyi": [[72, null]], "skbio.diversity.alpha.robbins": [[73, null]], "skbio.diversity.alpha.shannon": [[74, null]], "skbio.diversity.alpha.simpson": [[75, null]], "skbio.diversity.alpha.simpson_d": [[76, null]], "skbio.diversity.alpha.simpson_e": [[77, null]], "skbio.diversity.alpha.singles": [[78, null]], "skbio.diversity.alpha.sobs": [[79, null]], "skbio.diversity.alpha.strong": [[80, null]], "skbio.diversity.alpha.tsallis": [[81, null]], "skbio.diversity.alpha_diversity": [[82, null]], "skbio.diversity.beta.unweighted_unifrac": [[84, null]], "skbio.diversity.beta.weighted_unifrac": [[85, null]], "skbio.diversity.beta_diversity": [[86, null]], "skbio.diversity.block_beta_diversity": [[87, null]], "skbio.diversity.get_alpha_diversity_metrics": [[88, null]], "skbio.diversity.get_beta_diversity_metrics": [[89, null]], "skbio.diversity.partial_beta_diversity": [[90, null]], "skbio.embedding.Embedding": [[91, null]], "skbio.embedding.Embedding.bytes": [[92, null]], "skbio.embedding.Embedding.read": [[93, null]], "skbio.embedding.Embedding.write": [[94, null]], "skbio.embedding.EmbeddingVector": [[95, null]], "skbio.embedding.ProteinEmbedding": [[96, null]], "skbio.embedding.ProteinVector": [[97, null]], "skbio.embedding.SequenceEmbedding": [[98, null]], "skbio.embedding.SequenceVector": [[99, null]], "skbio.embedding.embed_vec_to_dataframe": [[100, null]], "skbio.embedding.embed_vec_to_distances": [[101, null]], "skbio.embedding.embed_vec_to_numpy": [[102, null]], "skbio.embedding.embed_vec_to_ordination": [[103, null]], "skbio.io.registry.Format": [[124, null]], "skbio.io.registry.Format.reader": [[125, null]], "skbio.io.registry.Format.sniffer": [[126, null]], "skbio.io.registry.Format.writer": [[127, null]], "skbio.io.registry.IORegistry": [[128, null]], "skbio.io.registry.IORegistry.add_format": [[129, null]], "skbio.io.registry.IORegistry.create_format": [[130, null]], "skbio.io.registry.IORegistry.get_reader": [[131, null]], "skbio.io.registry.IORegistry.get_sniffer": [[132, null]], "skbio.io.registry.IORegistry.get_writer": [[133, null]], "skbio.io.registry.IORegistry.list_read_formats": [[134, null]], "skbio.io.registry.IORegistry.list_write_formats": [[135, null]], "skbio.io.registry.IORegistry.read": [[136, null]], "skbio.io.registry.IORegistry.remove_format": [[137, null]], "skbio.io.registry.IORegistry.sniff": [[138, null]], "skbio.io.registry.IORegistry.write": [[139, null]], "skbio.io.registry.create_format": [[140, null]], "skbio.io.registry.read": [[141, null]], "skbio.io.registry.sniff": [[142, null]], "skbio.io.registry.write": [[143, null]], "skbio.io.util.open": [[145, null]], "skbio.io.util.open_file": [[146, null]], "skbio.io.util.open_files": [[147, null]], "skbio.metadata.CategoricalMetadataColumn": [[148, null]], "skbio.metadata.Interval": [[149, null]], "skbio.metadata.Interval.drop": [[150, null]], "skbio.metadata.IntervalMetadata": [[151, null]], "skbio.metadata.IntervalMetadata.add": [[152, null]], "skbio.metadata.IntervalMetadata.concat": [[153, null]], "skbio.metadata.IntervalMetadata.drop": [[154, null]], "skbio.metadata.IntervalMetadata.merge": [[155, null]], "skbio.metadata.IntervalMetadata.query": [[156, null]], "skbio.metadata.IntervalMetadata.read": [[157, null]], "skbio.metadata.IntervalMetadata.sort": [[158, null]], "skbio.metadata.IntervalMetadata.write": [[159, null]], "skbio.metadata.IntervalMetadataMixin": [[160, null]], "skbio.metadata.IntervalMetadataMixin.has_interval_metadata": [[161, null]], "skbio.metadata.MetadataColumn": [[162, null]], "skbio.metadata.MetadataColumn.drop_missing_values": [[163, null]], "skbio.metadata.MetadataColumn.filter_ids": [[164, null]], "skbio.metadata.MetadataColumn.get_ids": [[165, null]], "skbio.metadata.MetadataColumn.get_missing": [[166, null]], "skbio.metadata.MetadataColumn.get_value": [[167, null]], "skbio.metadata.MetadataColumn.has_missing_values": [[168, null]], "skbio.metadata.MetadataColumn.to_dataframe": [[169, null]], "skbio.metadata.MetadataColumn.to_series": [[170, null]], "skbio.metadata.MetadataMixin": [[171, null]], "skbio.metadata.MetadataMixin.has_metadata": [[172, null]], "skbio.metadata.NumericMetadataColumn": [[173, null]], "skbio.metadata.PositionalMetadataMixin": [[174, null]], "skbio.metadata.PositionalMetadataMixin.has_positional_metadata": [[175, null]], "skbio.metadata.SampleMetadata": [[176, null]], "skbio.metadata.SampleMetadata.filter_columns": [[177, null]], "skbio.metadata.SampleMetadata.filter_ids": [[178, null]], "skbio.metadata.SampleMetadata.get_column": [[179, null]], "skbio.metadata.SampleMetadata.get_ids": [[180, null]], "skbio.metadata.SampleMetadata.load": [[181, null]], "skbio.metadata.SampleMetadata.merge": [[182, null]], "skbio.metadata.SampleMetadata.to_dataframe": [[183, null]], "skbio.sequence.DNA": [[184, null]], "skbio.sequence.DNA.find_motifs": [[185, null]], "skbio.sequence.DNA.read": [[186, null]], "skbio.sequence.DNA.transcribe": [[187, null]], "skbio.sequence.DNA.translate": [[188, null]], "skbio.sequence.DNA.translate_six_frames": [[189, null]], "skbio.sequence.DNA.write": [[190, null]], "skbio.sequence.GeneticCode": [[191, null]], "skbio.sequence.GeneticCode.from_ncbi": [[192, null]], "skbio.sequence.GeneticCode.translate": [[193, null]], "skbio.sequence.GeneticCode.translate_six_frames": [[194, null]], "skbio.sequence.GrammaredSequence": [[195, null]], "skbio.sequence.GrammaredSequence.definites": [[196, null]], "skbio.sequence.GrammaredSequence.degap": [[197, null]], "skbio.sequence.GrammaredSequence.degenerates": [[198, null]], "skbio.sequence.GrammaredSequence.expand_degenerates": [[199, null]], "skbio.sequence.GrammaredSequence.find_motifs": [[200, null]], "skbio.sequence.GrammaredSequence.gaps": [[201, null]], "skbio.sequence.GrammaredSequence.has_definites": [[202, null]], "skbio.sequence.GrammaredSequence.has_degenerates": [[203, null]], "skbio.sequence.GrammaredSequence.has_gaps": [[204, null]], "skbio.sequence.GrammaredSequence.has_nondegenerates": [[205, null]], "skbio.sequence.GrammaredSequence.nondegenerates": [[206, null]], "skbio.sequence.GrammaredSequence.to_definites": [[207, null]], "skbio.sequence.GrammaredSequence.to_regex": [[208, null]], "skbio.sequence.NucleotideMixin": [[209, null]], "skbio.sequence.NucleotideMixin.complement": [[210, null]], "skbio.sequence.NucleotideMixin.gc_content": [[211, null]], "skbio.sequence.NucleotideMixin.gc_frequency": [[212, null]], "skbio.sequence.NucleotideMixin.is_reverse_complement": [[213, null]], "skbio.sequence.NucleotideMixin.reverse_complement": [[214, null]], "skbio.sequence.Protein": [[215, null]], "skbio.sequence.Protein.find_motifs": [[216, null]], "skbio.sequence.Protein.has_stops": [[217, null]], "skbio.sequence.Protein.read": [[218, null]], "skbio.sequence.Protein.stops": [[219, null]], "skbio.sequence.Protein.write": [[220, null]], "skbio.sequence.RNA": [[221, null]], "skbio.sequence.RNA.find_motifs": [[222, null]], "skbio.sequence.RNA.read": [[223, null]], "skbio.sequence.RNA.reverse_transcribe": [[224, null]], "skbio.sequence.RNA.translate": [[225, null]], "skbio.sequence.RNA.translate_six_frames": [[226, null]], "skbio.sequence.RNA.write": [[227, null]], "skbio.sequence.Sequence": [[228, null]], "skbio.sequence.Sequence.concat": [[229, null]], "skbio.sequence.Sequence.count": [[230, null]], "skbio.sequence.Sequence.distance": [[231, null]], "skbio.sequence.Sequence.find_with_regex": [[232, null]], "skbio.sequence.Sequence.frequencies": [[233, null]], "skbio.sequence.Sequence.index": [[234, null]], "skbio.sequence.Sequence.iter_contiguous": [[235, null]], "skbio.sequence.Sequence.iter_kmers": [[236, null]], "skbio.sequence.Sequence.kmer_frequencies": [[237, null]], "skbio.sequence.Sequence.lowercase": [[238, null]], "skbio.sequence.Sequence.match_frequency": [[239, null]], "skbio.sequence.Sequence.matches": [[240, null]], "skbio.sequence.Sequence.mismatch_frequency": [[241, null]], "skbio.sequence.Sequence.mismatches": [[242, null]], "skbio.sequence.Sequence.read": [[243, null]], "skbio.sequence.Sequence.replace": [[244, null]], "skbio.sequence.Sequence.to_indices": [[245, null]], "skbio.sequence.Sequence.write": [[246, null]], "skbio.sequence.SubstitutionMatrix": [[247, null]], "skbio.sequence.SubstitutionMatrix.by_name": [[248, null]], "skbio.sequence.SubstitutionMatrix.from_dict": [[249, null]], "skbio.sequence.SubstitutionMatrix.get_names": [[250, null]], "skbio.sequence.SubstitutionMatrix.identity": [[251, null]], "skbio.sequence.SubstitutionMatrix.to_dict": [[252, null]], "skbio.sequence.distance.hamming": [[254, null]], "skbio.sequence.distance.kmer_distance": [[255, null]], "skbio.stats.composition.alr": [[257, null]], "skbio.stats.composition.alr_inv": [[258, null]], "skbio.stats.composition.ancom": [[259, null]], "skbio.stats.composition.centralize": [[260, null]], "skbio.stats.composition.closure": [[261, null]], "skbio.stats.composition.clr": [[262, null]], "skbio.stats.composition.clr_inv": [[263, null]], "skbio.stats.composition.dirmult_ttest": [[264, null]], "skbio.stats.composition.ilr": [[265, null]], "skbio.stats.composition.ilr_inv": [[266, null]], "skbio.stats.composition.inner": [[267, null]], "skbio.stats.composition.multi_replace": [[268, null]], "skbio.stats.composition.pairwise_vlr": [[269, null]], "skbio.stats.composition.perturb": [[270, null]], "skbio.stats.composition.perturb_inv": [[271, null]], "skbio.stats.composition.power": [[272, null]], "skbio.stats.composition.sbp_basis": [[273, null]], "skbio.stats.composition.tree_basis": [[274, null]], "skbio.stats.composition.vlr": [[275, null]], "skbio.stats.distance.DissimilarityMatrix": [[277, null]], "skbio.stats.distance.DissimilarityMatrix.between": [[278, null]], "skbio.stats.distance.DissimilarityMatrix.copy": [[279, null]], "skbio.stats.distance.DissimilarityMatrix.filter": [[280, null]], "skbio.stats.distance.DissimilarityMatrix.from_iterable": [[281, null]], "skbio.stats.distance.DissimilarityMatrix.index": [[282, null]], "skbio.stats.distance.DissimilarityMatrix.plot": [[283, null]], "skbio.stats.distance.DissimilarityMatrix.read": [[284, null]], "skbio.stats.distance.DissimilarityMatrix.redundant_form": [[285, null]], "skbio.stats.distance.DissimilarityMatrix.rename": [[286, null]], "skbio.stats.distance.DissimilarityMatrix.to_data_frame": [[287, null]], "skbio.stats.distance.DissimilarityMatrix.transpose": [[288, null]], "skbio.stats.distance.DissimilarityMatrix.within": [[289, null]], "skbio.stats.distance.DissimilarityMatrix.write": [[290, null]], "skbio.stats.distance.DistanceMatrix": [[291, null]], "skbio.stats.distance.DistanceMatrix.condensed_form": [[292, null]], "skbio.stats.distance.DistanceMatrix.from_iterable": [[293, null]], "skbio.stats.distance.DistanceMatrix.permute": [[294, null]], "skbio.stats.distance.DistanceMatrix.to_series": [[295, null]], "skbio.stats.distance.anosim": [[296, null]], "skbio.stats.distance.bioenv": [[297, null]], "skbio.stats.distance.mantel": [[298, null]], "skbio.stats.distance.permanova": [[299, null]], "skbio.stats.distance.permdisp": [[300, null]], "skbio.stats.distance.pwmantel": [[301, null]], "skbio.stats.distance.randdm": [[302, null]], "skbio.stats.evolve.hommola_cospeciation": [[304, null]], "skbio.stats.gradient.AverageGradientANOVA": [[306, null]], "skbio.stats.gradient.CategoryResults": [[307, null]], "skbio.stats.gradient.CategoryResults.to_files": [[308, null]], "skbio.stats.gradient.FirstDifferenceGradientANOVA": [[309, null]], "skbio.stats.gradient.GradientANOVA": [[310, null]], "skbio.stats.gradient.GradientANOVA.get_trajectories": [[311, null]], "skbio.stats.gradient.GradientANOVAResults": [[312, null]], "skbio.stats.gradient.GradientANOVAResults.to_files": [[313, null]], "skbio.stats.gradient.GroupResults": [[314, null]], "skbio.stats.gradient.GroupResults.to_files": [[315, null]], "skbio.stats.gradient.TrajectoryGradientANOVA": [[316, null]], "skbio.stats.gradient.WindowDifferenceGradientANOVA": [[317, null]], "skbio.stats.isubsample": [[318, null]], "skbio.stats.ordination.OrdinationResults": [[320, null]], "skbio.stats.ordination.OrdinationResults.plot": [[321, null]], "skbio.stats.ordination.OrdinationResults.read": [[322, null]], "skbio.stats.ordination.OrdinationResults.rename": [[323, null]], "skbio.stats.ordination.OrdinationResults.write": [[324, null]], "skbio.stats.ordination.ca": [[325, null]], "skbio.stats.ordination.cca": [[326, null]], "skbio.stats.ordination.corr": [[327, null]], "skbio.stats.ordination.e_matrix": [[328, null]], "skbio.stats.ordination.f_matrix": [[329, null]], "skbio.stats.ordination.mean_and_std": [[330, null]], "skbio.stats.ordination.pcoa": [[331, null]], "skbio.stats.ordination.pcoa_biplot": [[332, null]], "skbio.stats.ordination.rda": [[333, null]], "skbio.stats.ordination.scale": [[334, null]], "skbio.stats.ordination.svd_rank": [[335, null]], "skbio.stats.power.confidence_bound": [[337, null]], "skbio.stats.power.paired_subsamples": [[338, null]], "skbio.stats.power.subsample_paired_power": [[339, null]], "skbio.stats.power.subsample_power": [[340, null]], "skbio.stats.subsample_counts": [[341, null]], "skbio.table.Table": [[342, null]], "skbio.table.Table.add_group_metadata": [[343, null]], "skbio.table.Table.add_metadata": [[344, null]], "skbio.table.Table.align_to": [[345, null]], "skbio.table.Table.align_to_dataframe": [[346, null]], "skbio.table.Table.align_tree": [[347, null]], "skbio.table.Table.collapse": [[348, null]], "skbio.table.Table.concat": [[349, null]], "skbio.table.Table.copy": [[350, null]], "skbio.table.Table.data": [[351, null]], "skbio.table.Table.del_metadata": [[352, null]], "skbio.table.Table.delimited_self": [[353, null]], "skbio.table.Table.descriptive_equality": [[354, null]], "skbio.table.Table.exists": [[355, null]], "skbio.table.Table.filter": [[356, null]], "skbio.table.Table.from_adjacency": [[357, null]], "skbio.table.Table.from_hdf5": [[358, null]], "skbio.table.Table.from_json": [[359, null]], "skbio.table.Table.from_tsv": [[360, null]], "skbio.table.Table.get_table_density": [[361, null]], "skbio.table.Table.get_value_by_ids": [[362, null]], "skbio.table.Table.group_metadata": [[363, null]], "skbio.table.Table.head": [[364, null]], "skbio.table.Table.ids": [[365, null]], "skbio.table.Table.index": [[366, null]], "skbio.table.Table.is_empty": [[367, null]], "skbio.table.Table.iter": [[368, null]], "skbio.table.Table.iter_data": [[369, null]], "skbio.table.Table.iter_pairwise": [[370, null]], "skbio.table.Table.length": [[371, null]], "skbio.table.Table.max": [[372, null]], "skbio.table.Table.merge": [[373, null]], "skbio.table.Table.metadata": [[374, null]], "skbio.table.Table.metadata_to_dataframe": [[375, null]], "skbio.table.Table.min": [[376, null]], "skbio.table.Table.nonzero": [[377, null]], "skbio.table.Table.nonzero_counts": [[378, null]], "skbio.table.Table.norm": [[379, null]], "skbio.table.Table.pa": [[380, null]], "skbio.table.Table.partition": [[381, null]], "skbio.table.Table.rankdata": [[382, null]], "skbio.table.Table.read": [[383, null]], "skbio.table.Table.reduce": [[384, null]], "skbio.table.Table.remove_empty": [[385, null]], "skbio.table.Table.sort": [[386, null]], "skbio.table.Table.sort_order": [[387, null]], "skbio.table.Table.subsample": [[388, null]], "skbio.table.Table.sum": [[389, null]], "skbio.table.Table.to_anndata": [[390, null]], "skbio.table.Table.to_dataframe": [[391, null]], "skbio.table.Table.to_hdf5": [[392, null]], "skbio.table.Table.to_json": [[393, null]], "skbio.table.Table.to_tsv": [[394, null]], "skbio.table.Table.transform": [[395, null]], "skbio.table.Table.transpose": [[396, null]], "skbio.table.Table.update_ids": [[397, null]], "skbio.table.Table.write": [[398, null]], "skbio.table.example_table": [[399, null]], "skbio.tree.TreeNode": [[400, null]], "skbio.tree.TreeNode.ancestors": [[401, null]], "skbio.tree.TreeNode.append": [[402, null]], "skbio.tree.TreeNode.ascii_art": [[403, null]], "skbio.tree.TreeNode.assign_ids": [[404, null]], "skbio.tree.TreeNode.assign_supports": [[405, null]], "skbio.tree.TreeNode.bifurcate": [[406, null]], "skbio.tree.TreeNode.bipart": [[407, null]], "skbio.tree.TreeNode.biparts": [[408, null]], "skbio.tree.TreeNode.cache_attr": [[409, null]], "skbio.tree.TreeNode.clear_caches": [[410, null]], "skbio.tree.TreeNode.compare_biparts": [[411, null]], "skbio.tree.TreeNode.compare_cophenet": [[412, null]], "skbio.tree.TreeNode.compare_rfd": [[413, null]], "skbio.tree.TreeNode.compare_subsets": [[414, null]], "skbio.tree.TreeNode.compare_wrfd": [[415, null]], "skbio.tree.TreeNode.cophenet": [[416, null]], "skbio.tree.TreeNode.copy": [[417, null]], "skbio.tree.TreeNode.count": [[418, null]], "skbio.tree.TreeNode.create_caches": [[419, null]], "skbio.tree.TreeNode.deepcopy": [[420, null]], "skbio.tree.TreeNode.depth": [[421, null]], "skbio.tree.TreeNode.distance": [[422, null]], "skbio.tree.TreeNode.extend": [[423, null]], "skbio.tree.TreeNode.find": [[424, null]], "skbio.tree.TreeNode.find_all": [[425, null]], "skbio.tree.TreeNode.find_by_func": [[426, null]], "skbio.tree.TreeNode.find_by_id": [[427, null]], "skbio.tree.TreeNode.from_linkage_matrix": [[428, null]], "skbio.tree.TreeNode.from_taxdump": [[429, null]], "skbio.tree.TreeNode.from_taxonomy": [[430, null]], "skbio.tree.TreeNode.has_caches": [[431, null]], "skbio.tree.TreeNode.has_children": [[432, null]], "skbio.tree.TreeNode.height": [[433, null]], "skbio.tree.TreeNode.index_tree": [[434, null]], "skbio.tree.TreeNode.insert": [[435, null]], "skbio.tree.TreeNode.is_bifurcating": [[436, null]], "skbio.tree.TreeNode.is_root": [[437, null]], "skbio.tree.TreeNode.is_tip": [[438, null]], "skbio.tree.TreeNode.lca": [[439, null]], "skbio.tree.TreeNode.levelorder": [[440, null]], "skbio.tree.TreeNode.maxdist": [[441, null]], "skbio.tree.TreeNode.neighbors": [[442, null]], "skbio.tree.TreeNode.non_tips": [[443, null]], "skbio.tree.TreeNode.observed_node_counts": [[444, null]], "skbio.tree.TreeNode.path": [[445, null]], "skbio.tree.TreeNode.pop": [[446, null]], "skbio.tree.TreeNode.postorder": [[447, null]], "skbio.tree.TreeNode.pre_and_postorder": [[448, null]], "skbio.tree.TreeNode.preorder": [[449, null]], "skbio.tree.TreeNode.prune": [[450, null]], "skbio.tree.TreeNode.read": [[451, null]], "skbio.tree.TreeNode.remove": [[452, null]], "skbio.tree.TreeNode.remove_by_func": [[453, null]], "skbio.tree.TreeNode.remove_deleted": [[454, null]], "skbio.tree.TreeNode.root": [[455, null]], "skbio.tree.TreeNode.root_at": [[456, null]], "skbio.tree.TreeNode.root_at_midpoint": [[457, null]], "skbio.tree.TreeNode.root_by_outgroup": [[458, null]], "skbio.tree.TreeNode.shear": [[459, null]], "skbio.tree.TreeNode.shuffle": [[460, null]], "skbio.tree.TreeNode.siblings": [[461, null]], "skbio.tree.TreeNode.subset": [[462, null]], "skbio.tree.TreeNode.subsets": [[463, null]], "skbio.tree.TreeNode.subtree": [[464, null]], "skbio.tree.TreeNode.tips": [[465, null]], "skbio.tree.TreeNode.to_array": [[466, null]], "skbio.tree.TreeNode.to_taxonomy": [[467, null]], "skbio.tree.TreeNode.total_length": [[468, null]], "skbio.tree.TreeNode.traverse": [[469, null]], "skbio.tree.TreeNode.unpack": [[470, null]], "skbio.tree.TreeNode.unpack_by_func": [[471, null]], "skbio.tree.TreeNode.unroot": [[472, null]], "skbio.tree.TreeNode.unrooted_copy": [[473, null]], "skbio.tree.TreeNode.unrooted_deepcopy": [[474, null]], "skbio.tree.TreeNode.unrooted_move": [[475, null]], "skbio.tree.TreeNode.write": [[476, null]], "skbio.tree.bme": [[477, null]], "skbio.tree.gme": [[478, null]], "skbio.tree.majority_rule": [[479, null]], "skbio.tree.nj": [[480, null]], "skbio.tree.nni": [[481, null]], "skbio.tree.path_dists": [[482, null]], "skbio.tree.rf_dists": [[483, null]], "skbio.tree.upgma": [[484, null]], "skbio.tree.wrf_dists": [[485, null]], "skbio.util.PlottableMixin": [[486, null]], "skbio.util.aliased": [[487, null]], "skbio.util.assert_data_frame_almost_equal": [[488, null]], "skbio.util.assert_ordination_results_equal": [[489, null]], "skbio.util.cardinal_to_ordinal": [[490, null]], "skbio.util.classonlymethod": [[491, null]], "skbio.util.classproperty": [[492, null]], "skbio.util.deprecated": [[493, null]], "skbio.util.find_duplicates": [[494, null]], "skbio.util.get_data_path": [[495, null]], "skbio.util.get_rng": [[496, null]], "skbio.util.overrides": [[497, null]], "skbio.util.params_aliased": [[498, null]], "skbio.util.register_aliases": [[499, null]], "skbio.util.safe_md5": [[500, null]], "skbio.workflow.Workflow": [[501, null]], "skbio.workflow.Workflow.initialize_state": [[502, null]], "skbio.workflow.method": [[503, null]], "skbio.workflow.requires": [[504, null]]}, "docnames": ["alignment", "diversity", "embedding", "generated/skbio.alignment.AlignPath", "generated/skbio.alignment.AlignPath.from_bits", "generated/skbio.alignment.AlignPath.from_coordinates", "generated/skbio.alignment.AlignPath.from_indices", "generated/skbio.alignment.AlignPath.from_tabular", "generated/skbio.alignment.AlignPath.to_bits", "generated/skbio.alignment.AlignPath.to_coordinates", "generated/skbio.alignment.AlignPath.to_indices", "generated/skbio.alignment.AlignmentStructure", "generated/skbio.alignment.AlignmentStructure.is_zero_based", "generated/skbio.alignment.AlignmentStructure.set_zero_based", "generated/skbio.alignment.PairAlignPath", "generated/skbio.alignment.PairAlignPath.from_bits", "generated/skbio.alignment.PairAlignPath.from_cigar", "generated/skbio.alignment.PairAlignPath.to_bits", "generated/skbio.alignment.PairAlignPath.to_cigar", "generated/skbio.alignment.StripedSmithWaterman", "generated/skbio.alignment.TabularMSA", "generated/skbio.alignment.TabularMSA.append", "generated/skbio.alignment.TabularMSA.consensus", "generated/skbio.alignment.TabularMSA.conservation", "generated/skbio.alignment.TabularMSA.extend", "generated/skbio.alignment.TabularMSA.from_dict", "generated/skbio.alignment.TabularMSA.from_path_seqs", "generated/skbio.alignment.TabularMSA.gap_frequencies", "generated/skbio.alignment.TabularMSA.iter_positions", "generated/skbio.alignment.TabularMSA.join", "generated/skbio.alignment.TabularMSA.read", "generated/skbio.alignment.TabularMSA.reassign_index", "generated/skbio.alignment.TabularMSA.sort", "generated/skbio.alignment.TabularMSA.to_dict", "generated/skbio.alignment.TabularMSA.write", "generated/skbio.alignment.global_pairwise_align", "generated/skbio.alignment.global_pairwise_align_nucleotide", "generated/skbio.alignment.global_pairwise_align_protein", "generated/skbio.alignment.local_pairwise_align", "generated/skbio.alignment.local_pairwise_align_nucleotide", "generated/skbio.alignment.local_pairwise_align_protein", "generated/skbio.alignment.local_pairwise_align_ssw", "generated/skbio.alignment.make_identity_substitution_matrix", "generated/skbio.diversity.alpha", "generated/skbio.diversity.alpha.ace", "generated/skbio.diversity.alpha.berger_parker_d", "generated/skbio.diversity.alpha.brillouin_d", "generated/skbio.diversity.alpha.chao1", "generated/skbio.diversity.alpha.chao1_ci", "generated/skbio.diversity.alpha.dominance", "generated/skbio.diversity.alpha.doubles", "generated/skbio.diversity.alpha.enspie", "generated/skbio.diversity.alpha.esty_ci", "generated/skbio.diversity.alpha.faith_pd", "generated/skbio.diversity.alpha.fisher_alpha", "generated/skbio.diversity.alpha.gini_index", "generated/skbio.diversity.alpha.goods_coverage", "generated/skbio.diversity.alpha.heip_e", "generated/skbio.diversity.alpha.hill", "generated/skbio.diversity.alpha.inv_simpson", "generated/skbio.diversity.alpha.kempton_taylor_q", "generated/skbio.diversity.alpha.lladser_ci", "generated/skbio.diversity.alpha.lladser_pe", "generated/skbio.diversity.alpha.margalef", "generated/skbio.diversity.alpha.mcintosh_d", "generated/skbio.diversity.alpha.mcintosh_e", "generated/skbio.diversity.alpha.menhinick", "generated/skbio.diversity.alpha.michaelis_menten_fit", "generated/skbio.diversity.alpha.observed_features", "generated/skbio.diversity.alpha.osd", "generated/skbio.diversity.alpha.phydiv", "generated/skbio.diversity.alpha.pielou_e", "generated/skbio.diversity.alpha.renyi", "generated/skbio.diversity.alpha.robbins", "generated/skbio.diversity.alpha.shannon", "generated/skbio.diversity.alpha.simpson", "generated/skbio.diversity.alpha.simpson_d", "generated/skbio.diversity.alpha.simpson_e", "generated/skbio.diversity.alpha.singles", "generated/skbio.diversity.alpha.sobs", "generated/skbio.diversity.alpha.strong", "generated/skbio.diversity.alpha.tsallis", "generated/skbio.diversity.alpha_diversity", "generated/skbio.diversity.beta", "generated/skbio.diversity.beta.unweighted_unifrac", "generated/skbio.diversity.beta.weighted_unifrac", "generated/skbio.diversity.beta_diversity", "generated/skbio.diversity.block_beta_diversity", "generated/skbio.diversity.get_alpha_diversity_metrics", "generated/skbio.diversity.get_beta_diversity_metrics", "generated/skbio.diversity.partial_beta_diversity", "generated/skbio.embedding.Embedding", "generated/skbio.embedding.Embedding.bytes", "generated/skbio.embedding.Embedding.read", "generated/skbio.embedding.Embedding.write", "generated/skbio.embedding.EmbeddingVector", "generated/skbio.embedding.ProteinEmbedding", "generated/skbio.embedding.ProteinVector", "generated/skbio.embedding.SequenceEmbedding", "generated/skbio.embedding.SequenceVector", "generated/skbio.embedding.embed_vec_to_dataframe", "generated/skbio.embedding.embed_vec_to_distances", "generated/skbio.embedding.embed_vec_to_numpy", "generated/skbio.embedding.embed_vec_to_ordination", "generated/skbio.io.format.binary_dm", "generated/skbio.io.format.biom", "generated/skbio.io.format.blast6", "generated/skbio.io.format.blast7", "generated/skbio.io.format.clustal", "generated/skbio.io.format.embed", "generated/skbio.io.format.embl", "generated/skbio.io.format.fasta", "generated/skbio.io.format.fastq", "generated/skbio.io.format.genbank", "generated/skbio.io.format.gff3", "generated/skbio.io.format.lsmat", "generated/skbio.io.format.newick", "generated/skbio.io.format.ordination", "generated/skbio.io.format.phylip", "generated/skbio.io.format.qseq", "generated/skbio.io.format.sample_metadata", "generated/skbio.io.format.stockholm", "generated/skbio.io.format.taxdump", "generated/skbio.io.registry", "generated/skbio.io.registry.Format", "generated/skbio.io.registry.Format.reader", "generated/skbio.io.registry.Format.sniffer", "generated/skbio.io.registry.Format.writer", "generated/skbio.io.registry.IORegistry", "generated/skbio.io.registry.IORegistry.add_format", "generated/skbio.io.registry.IORegistry.create_format", "generated/skbio.io.registry.IORegistry.get_reader", "generated/skbio.io.registry.IORegistry.get_sniffer", "generated/skbio.io.registry.IORegistry.get_writer", "generated/skbio.io.registry.IORegistry.list_read_formats", "generated/skbio.io.registry.IORegistry.list_write_formats", "generated/skbio.io.registry.IORegistry.read", "generated/skbio.io.registry.IORegistry.remove_format", "generated/skbio.io.registry.IORegistry.sniff", "generated/skbio.io.registry.IORegistry.write", "generated/skbio.io.registry.create_format", "generated/skbio.io.registry.read", "generated/skbio.io.registry.sniff", "generated/skbio.io.registry.write", "generated/skbio.io.util", "generated/skbio.io.util.open", "generated/skbio.io.util.open_file", "generated/skbio.io.util.open_files", "generated/skbio.metadata.CategoricalMetadataColumn", "generated/skbio.metadata.Interval", "generated/skbio.metadata.Interval.drop", "generated/skbio.metadata.IntervalMetadata", "generated/skbio.metadata.IntervalMetadata.add", "generated/skbio.metadata.IntervalMetadata.concat", "generated/skbio.metadata.IntervalMetadata.drop", "generated/skbio.metadata.IntervalMetadata.merge", "generated/skbio.metadata.IntervalMetadata.query", "generated/skbio.metadata.IntervalMetadata.read", "generated/skbio.metadata.IntervalMetadata.sort", "generated/skbio.metadata.IntervalMetadata.write", "generated/skbio.metadata.IntervalMetadataMixin", "generated/skbio.metadata.IntervalMetadataMixin.has_interval_metadata", "generated/skbio.metadata.MetadataColumn", "generated/skbio.metadata.MetadataColumn.drop_missing_values", "generated/skbio.metadata.MetadataColumn.filter_ids", "generated/skbio.metadata.MetadataColumn.get_ids", "generated/skbio.metadata.MetadataColumn.get_missing", "generated/skbio.metadata.MetadataColumn.get_value", "generated/skbio.metadata.MetadataColumn.has_missing_values", "generated/skbio.metadata.MetadataColumn.to_dataframe", "generated/skbio.metadata.MetadataColumn.to_series", "generated/skbio.metadata.MetadataMixin", "generated/skbio.metadata.MetadataMixin.has_metadata", "generated/skbio.metadata.NumericMetadataColumn", "generated/skbio.metadata.PositionalMetadataMixin", "generated/skbio.metadata.PositionalMetadataMixin.has_positional_metadata", "generated/skbio.metadata.SampleMetadata", "generated/skbio.metadata.SampleMetadata.filter_columns", "generated/skbio.metadata.SampleMetadata.filter_ids", "generated/skbio.metadata.SampleMetadata.get_column", "generated/skbio.metadata.SampleMetadata.get_ids", "generated/skbio.metadata.SampleMetadata.load", "generated/skbio.metadata.SampleMetadata.merge", "generated/skbio.metadata.SampleMetadata.to_dataframe", "generated/skbio.sequence.DNA", "generated/skbio.sequence.DNA.find_motifs", "generated/skbio.sequence.DNA.read", "generated/skbio.sequence.DNA.transcribe", "generated/skbio.sequence.DNA.translate", "generated/skbio.sequence.DNA.translate_six_frames", "generated/skbio.sequence.DNA.write", "generated/skbio.sequence.GeneticCode", "generated/skbio.sequence.GeneticCode.from_ncbi", "generated/skbio.sequence.GeneticCode.translate", "generated/skbio.sequence.GeneticCode.translate_six_frames", "generated/skbio.sequence.GrammaredSequence", "generated/skbio.sequence.GrammaredSequence.definites", "generated/skbio.sequence.GrammaredSequence.degap", "generated/skbio.sequence.GrammaredSequence.degenerates", "generated/skbio.sequence.GrammaredSequence.expand_degenerates", "generated/skbio.sequence.GrammaredSequence.find_motifs", "generated/skbio.sequence.GrammaredSequence.gaps", "generated/skbio.sequence.GrammaredSequence.has_definites", "generated/skbio.sequence.GrammaredSequence.has_degenerates", "generated/skbio.sequence.GrammaredSequence.has_gaps", "generated/skbio.sequence.GrammaredSequence.has_nondegenerates", "generated/skbio.sequence.GrammaredSequence.nondegenerates", "generated/skbio.sequence.GrammaredSequence.to_definites", "generated/skbio.sequence.GrammaredSequence.to_regex", "generated/skbio.sequence.NucleotideMixin", "generated/skbio.sequence.NucleotideMixin.complement", "generated/skbio.sequence.NucleotideMixin.gc_content", "generated/skbio.sequence.NucleotideMixin.gc_frequency", "generated/skbio.sequence.NucleotideMixin.is_reverse_complement", "generated/skbio.sequence.NucleotideMixin.reverse_complement", "generated/skbio.sequence.Protein", "generated/skbio.sequence.Protein.find_motifs", "generated/skbio.sequence.Protein.has_stops", "generated/skbio.sequence.Protein.read", "generated/skbio.sequence.Protein.stops", "generated/skbio.sequence.Protein.write", "generated/skbio.sequence.RNA", "generated/skbio.sequence.RNA.find_motifs", "generated/skbio.sequence.RNA.read", "generated/skbio.sequence.RNA.reverse_transcribe", "generated/skbio.sequence.RNA.translate", "generated/skbio.sequence.RNA.translate_six_frames", "generated/skbio.sequence.RNA.write", "generated/skbio.sequence.Sequence", "generated/skbio.sequence.Sequence.concat", "generated/skbio.sequence.Sequence.count", "generated/skbio.sequence.Sequence.distance", "generated/skbio.sequence.Sequence.find_with_regex", "generated/skbio.sequence.Sequence.frequencies", "generated/skbio.sequence.Sequence.index", "generated/skbio.sequence.Sequence.iter_contiguous", "generated/skbio.sequence.Sequence.iter_kmers", "generated/skbio.sequence.Sequence.kmer_frequencies", "generated/skbio.sequence.Sequence.lowercase", "generated/skbio.sequence.Sequence.match_frequency", "generated/skbio.sequence.Sequence.matches", "generated/skbio.sequence.Sequence.mismatch_frequency", "generated/skbio.sequence.Sequence.mismatches", "generated/skbio.sequence.Sequence.read", "generated/skbio.sequence.Sequence.replace", "generated/skbio.sequence.Sequence.to_indices", "generated/skbio.sequence.Sequence.write", "generated/skbio.sequence.SubstitutionMatrix", "generated/skbio.sequence.SubstitutionMatrix.by_name", "generated/skbio.sequence.SubstitutionMatrix.from_dict", "generated/skbio.sequence.SubstitutionMatrix.get_names", "generated/skbio.sequence.SubstitutionMatrix.identity", "generated/skbio.sequence.SubstitutionMatrix.to_dict", "generated/skbio.sequence.distance", "generated/skbio.sequence.distance.hamming", "generated/skbio.sequence.distance.kmer_distance", "generated/skbio.stats.composition", "generated/skbio.stats.composition.alr", "generated/skbio.stats.composition.alr_inv", "generated/skbio.stats.composition.ancom", "generated/skbio.stats.composition.centralize", "generated/skbio.stats.composition.closure", "generated/skbio.stats.composition.clr", "generated/skbio.stats.composition.clr_inv", "generated/skbio.stats.composition.dirmult_ttest", "generated/skbio.stats.composition.ilr", "generated/skbio.stats.composition.ilr_inv", "generated/skbio.stats.composition.inner", "generated/skbio.stats.composition.multi_replace", "generated/skbio.stats.composition.pairwise_vlr", "generated/skbio.stats.composition.perturb", "generated/skbio.stats.composition.perturb_inv", "generated/skbio.stats.composition.power", "generated/skbio.stats.composition.sbp_basis", "generated/skbio.stats.composition.tree_basis", "generated/skbio.stats.composition.vlr", "generated/skbio.stats.distance", "generated/skbio.stats.distance.DissimilarityMatrix", "generated/skbio.stats.distance.DissimilarityMatrix.between", "generated/skbio.stats.distance.DissimilarityMatrix.copy", "generated/skbio.stats.distance.DissimilarityMatrix.filter", "generated/skbio.stats.distance.DissimilarityMatrix.from_iterable", "generated/skbio.stats.distance.DissimilarityMatrix.index", "generated/skbio.stats.distance.DissimilarityMatrix.plot", "generated/skbio.stats.distance.DissimilarityMatrix.read", "generated/skbio.stats.distance.DissimilarityMatrix.redundant_form", "generated/skbio.stats.distance.DissimilarityMatrix.rename", "generated/skbio.stats.distance.DissimilarityMatrix.to_data_frame", "generated/skbio.stats.distance.DissimilarityMatrix.transpose", "generated/skbio.stats.distance.DissimilarityMatrix.within", "generated/skbio.stats.distance.DissimilarityMatrix.write", "generated/skbio.stats.distance.DistanceMatrix", "generated/skbio.stats.distance.DistanceMatrix.condensed_form", "generated/skbio.stats.distance.DistanceMatrix.from_iterable", "generated/skbio.stats.distance.DistanceMatrix.permute", "generated/skbio.stats.distance.DistanceMatrix.to_series", "generated/skbio.stats.distance.anosim", "generated/skbio.stats.distance.bioenv", "generated/skbio.stats.distance.mantel", "generated/skbio.stats.distance.permanova", "generated/skbio.stats.distance.permdisp", "generated/skbio.stats.distance.pwmantel", "generated/skbio.stats.distance.randdm", "generated/skbio.stats.evolve", "generated/skbio.stats.evolve.hommola_cospeciation", "generated/skbio.stats.gradient", "generated/skbio.stats.gradient.AverageGradientANOVA", "generated/skbio.stats.gradient.CategoryResults", "generated/skbio.stats.gradient.CategoryResults.to_files", "generated/skbio.stats.gradient.FirstDifferenceGradientANOVA", "generated/skbio.stats.gradient.GradientANOVA", "generated/skbio.stats.gradient.GradientANOVA.get_trajectories", "generated/skbio.stats.gradient.GradientANOVAResults", "generated/skbio.stats.gradient.GradientANOVAResults.to_files", "generated/skbio.stats.gradient.GroupResults", "generated/skbio.stats.gradient.GroupResults.to_files", "generated/skbio.stats.gradient.TrajectoryGradientANOVA", "generated/skbio.stats.gradient.WindowDifferenceGradientANOVA", "generated/skbio.stats.isubsample", "generated/skbio.stats.ordination", "generated/skbio.stats.ordination.OrdinationResults", "generated/skbio.stats.ordination.OrdinationResults.plot", "generated/skbio.stats.ordination.OrdinationResults.read", "generated/skbio.stats.ordination.OrdinationResults.rename", "generated/skbio.stats.ordination.OrdinationResults.write", "generated/skbio.stats.ordination.ca", "generated/skbio.stats.ordination.cca", "generated/skbio.stats.ordination.corr", "generated/skbio.stats.ordination.e_matrix", "generated/skbio.stats.ordination.f_matrix", "generated/skbio.stats.ordination.mean_and_std", "generated/skbio.stats.ordination.pcoa", "generated/skbio.stats.ordination.pcoa_biplot", "generated/skbio.stats.ordination.rda", "generated/skbio.stats.ordination.scale", "generated/skbio.stats.ordination.svd_rank", "generated/skbio.stats.power", "generated/skbio.stats.power.confidence_bound", "generated/skbio.stats.power.paired_subsamples", "generated/skbio.stats.power.subsample_paired_power", "generated/skbio.stats.power.subsample_power", "generated/skbio.stats.subsample_counts", "generated/skbio.table.Table", "generated/skbio.table.Table.add_group_metadata", "generated/skbio.table.Table.add_metadata", "generated/skbio.table.Table.align_to", "generated/skbio.table.Table.align_to_dataframe", "generated/skbio.table.Table.align_tree", "generated/skbio.table.Table.collapse", "generated/skbio.table.Table.concat", "generated/skbio.table.Table.copy", "generated/skbio.table.Table.data", "generated/skbio.table.Table.del_metadata", "generated/skbio.table.Table.delimited_self", "generated/skbio.table.Table.descriptive_equality", "generated/skbio.table.Table.exists", "generated/skbio.table.Table.filter", "generated/skbio.table.Table.from_adjacency", "generated/skbio.table.Table.from_hdf5", "generated/skbio.table.Table.from_json", "generated/skbio.table.Table.from_tsv", "generated/skbio.table.Table.get_table_density", "generated/skbio.table.Table.get_value_by_ids", "generated/skbio.table.Table.group_metadata", "generated/skbio.table.Table.head", "generated/skbio.table.Table.ids", "generated/skbio.table.Table.index", "generated/skbio.table.Table.is_empty", "generated/skbio.table.Table.iter", "generated/skbio.table.Table.iter_data", "generated/skbio.table.Table.iter_pairwise", "generated/skbio.table.Table.length", "generated/skbio.table.Table.max", "generated/skbio.table.Table.merge", "generated/skbio.table.Table.metadata", "generated/skbio.table.Table.metadata_to_dataframe", "generated/skbio.table.Table.min", "generated/skbio.table.Table.nonzero", "generated/skbio.table.Table.nonzero_counts", "generated/skbio.table.Table.norm", "generated/skbio.table.Table.pa", "generated/skbio.table.Table.partition", "generated/skbio.table.Table.rankdata", "generated/skbio.table.Table.read", "generated/skbio.table.Table.reduce", "generated/skbio.table.Table.remove_empty", "generated/skbio.table.Table.sort", "generated/skbio.table.Table.sort_order", "generated/skbio.table.Table.subsample", "generated/skbio.table.Table.sum", "generated/skbio.table.Table.to_anndata", "generated/skbio.table.Table.to_dataframe", "generated/skbio.table.Table.to_hdf5", "generated/skbio.table.Table.to_json", "generated/skbio.table.Table.to_tsv", "generated/skbio.table.Table.transform", "generated/skbio.table.Table.transpose", "generated/skbio.table.Table.update_ids", "generated/skbio.table.Table.write", "generated/skbio.table.example_table", "generated/skbio.tree.TreeNode", "generated/skbio.tree.TreeNode.ancestors", "generated/skbio.tree.TreeNode.append", "generated/skbio.tree.TreeNode.ascii_art", "generated/skbio.tree.TreeNode.assign_ids", "generated/skbio.tree.TreeNode.assign_supports", "generated/skbio.tree.TreeNode.bifurcate", "generated/skbio.tree.TreeNode.bipart", "generated/skbio.tree.TreeNode.biparts", "generated/skbio.tree.TreeNode.cache_attr", "generated/skbio.tree.TreeNode.clear_caches", "generated/skbio.tree.TreeNode.compare_biparts", "generated/skbio.tree.TreeNode.compare_cophenet", "generated/skbio.tree.TreeNode.compare_rfd", "generated/skbio.tree.TreeNode.compare_subsets", "generated/skbio.tree.TreeNode.compare_wrfd", "generated/skbio.tree.TreeNode.cophenet", "generated/skbio.tree.TreeNode.copy", "generated/skbio.tree.TreeNode.count", "generated/skbio.tree.TreeNode.create_caches", "generated/skbio.tree.TreeNode.deepcopy", "generated/skbio.tree.TreeNode.depth", "generated/skbio.tree.TreeNode.distance", "generated/skbio.tree.TreeNode.extend", "generated/skbio.tree.TreeNode.find", "generated/skbio.tree.TreeNode.find_all", "generated/skbio.tree.TreeNode.find_by_func", "generated/skbio.tree.TreeNode.find_by_id", "generated/skbio.tree.TreeNode.from_linkage_matrix", "generated/skbio.tree.TreeNode.from_taxdump", "generated/skbio.tree.TreeNode.from_taxonomy", "generated/skbio.tree.TreeNode.has_caches", "generated/skbio.tree.TreeNode.has_children", "generated/skbio.tree.TreeNode.height", "generated/skbio.tree.TreeNode.index_tree", "generated/skbio.tree.TreeNode.insert", "generated/skbio.tree.TreeNode.is_bifurcating", "generated/skbio.tree.TreeNode.is_root", "generated/skbio.tree.TreeNode.is_tip", "generated/skbio.tree.TreeNode.lca", "generated/skbio.tree.TreeNode.levelorder", "generated/skbio.tree.TreeNode.maxdist", "generated/skbio.tree.TreeNode.neighbors", "generated/skbio.tree.TreeNode.non_tips", "generated/skbio.tree.TreeNode.observed_node_counts", "generated/skbio.tree.TreeNode.path", "generated/skbio.tree.TreeNode.pop", "generated/skbio.tree.TreeNode.postorder", "generated/skbio.tree.TreeNode.pre_and_postorder", "generated/skbio.tree.TreeNode.preorder", "generated/skbio.tree.TreeNode.prune", "generated/skbio.tree.TreeNode.read", "generated/skbio.tree.TreeNode.remove", "generated/skbio.tree.TreeNode.remove_by_func", "generated/skbio.tree.TreeNode.remove_deleted", "generated/skbio.tree.TreeNode.root", "generated/skbio.tree.TreeNode.root_at", "generated/skbio.tree.TreeNode.root_at_midpoint", "generated/skbio.tree.TreeNode.root_by_outgroup", "generated/skbio.tree.TreeNode.shear", "generated/skbio.tree.TreeNode.shuffle", "generated/skbio.tree.TreeNode.siblings", "generated/skbio.tree.TreeNode.subset", "generated/skbio.tree.TreeNode.subsets", "generated/skbio.tree.TreeNode.subtree", "generated/skbio.tree.TreeNode.tips", "generated/skbio.tree.TreeNode.to_array", "generated/skbio.tree.TreeNode.to_taxonomy", "generated/skbio.tree.TreeNode.total_length", "generated/skbio.tree.TreeNode.traverse", "generated/skbio.tree.TreeNode.unpack", "generated/skbio.tree.TreeNode.unpack_by_func", "generated/skbio.tree.TreeNode.unroot", "generated/skbio.tree.TreeNode.unrooted_copy", "generated/skbio.tree.TreeNode.unrooted_deepcopy", "generated/skbio.tree.TreeNode.unrooted_move", "generated/skbio.tree.TreeNode.write", "generated/skbio.tree.bme", "generated/skbio.tree.gme", "generated/skbio.tree.majority_rule", "generated/skbio.tree.nj", "generated/skbio.tree.nni", "generated/skbio.tree.path_dists", "generated/skbio.tree.rf_dists", "generated/skbio.tree.upgma", "generated/skbio.tree.wrf_dists", "generated/skbio.util.PlottableMixin", "generated/skbio.util.aliased", "generated/skbio.util.assert_data_frame_almost_equal", "generated/skbio.util.assert_ordination_results_equal", "generated/skbio.util.cardinal_to_ordinal", "generated/skbio.util.classonlymethod", "generated/skbio.util.classproperty", "generated/skbio.util.deprecated", "generated/skbio.util.find_duplicates", "generated/skbio.util.get_data_path", "generated/skbio.util.get_rng", "generated/skbio.util.overrides", "generated/skbio.util.params_aliased", "generated/skbio.util.register_aliases", "generated/skbio.util.safe_md5", "generated/skbio.workflow.Workflow", "generated/skbio.workflow.Workflow.initialize_state", "generated/skbio.workflow.method", "generated/skbio.workflow.requires", "index", "io", "metadata", "sequence", "stats", "table", "tree", "util", "workflow"], "envversion": {"sphinx": 64, "sphinx.domains.c": 3, "sphinx.domains.changeset": 1, "sphinx.domains.citation": 1, "sphinx.domains.cpp": 9, "sphinx.domains.index": 1, "sphinx.domains.javascript": 3, "sphinx.domains.math": 2, "sphinx.domains.python": 4, "sphinx.domains.rst": 2, "sphinx.domains.std": 2, "sphinx.ext.intersphinx": 1}, "filenames": ["alignment.rst", "diversity.rst", "embedding.rst", "generated/skbio.alignment.AlignPath.rst", "generated/skbio.alignment.AlignPath.from_bits.rst", "generated/skbio.alignment.AlignPath.from_coordinates.rst", "generated/skbio.alignment.AlignPath.from_indices.rst", "generated/skbio.alignment.AlignPath.from_tabular.rst", "generated/skbio.alignment.AlignPath.to_bits.rst", "generated/skbio.alignment.AlignPath.to_coordinates.rst", "generated/skbio.alignment.AlignPath.to_indices.rst", "generated/skbio.alignment.AlignmentStructure.rst", "generated/skbio.alignment.AlignmentStructure.is_zero_based.rst", "generated/skbio.alignment.AlignmentStructure.set_zero_based.rst", "generated/skbio.alignment.PairAlignPath.rst", "generated/skbio.alignment.PairAlignPath.from_bits.rst", "generated/skbio.alignment.PairAlignPath.from_cigar.rst", "generated/skbio.alignment.PairAlignPath.to_bits.rst", "generated/skbio.alignment.PairAlignPath.to_cigar.rst", "generated/skbio.alignment.StripedSmithWaterman.rst", "generated/skbio.alignment.TabularMSA.rst", "generated/skbio.alignment.TabularMSA.append.rst", "generated/skbio.alignment.TabularMSA.consensus.rst", "generated/skbio.alignment.TabularMSA.conservation.rst", "generated/skbio.alignment.TabularMSA.extend.rst", "generated/skbio.alignment.TabularMSA.from_dict.rst", "generated/skbio.alignment.TabularMSA.from_path_seqs.rst", "generated/skbio.alignment.TabularMSA.gap_frequencies.rst", "generated/skbio.alignment.TabularMSA.iter_positions.rst", "generated/skbio.alignment.TabularMSA.join.rst", "generated/skbio.alignment.TabularMSA.read.rst", "generated/skbio.alignment.TabularMSA.reassign_index.rst", "generated/skbio.alignment.TabularMSA.sort.rst", "generated/skbio.alignment.TabularMSA.to_dict.rst", "generated/skbio.alignment.TabularMSA.write.rst", "generated/skbio.alignment.global_pairwise_align.rst", "generated/skbio.alignment.global_pairwise_align_nucleotide.rst", "generated/skbio.alignment.global_pairwise_align_protein.rst", "generated/skbio.alignment.local_pairwise_align.rst", "generated/skbio.alignment.local_pairwise_align_nucleotide.rst", "generated/skbio.alignment.local_pairwise_align_protein.rst", "generated/skbio.alignment.local_pairwise_align_ssw.rst", "generated/skbio.alignment.make_identity_substitution_matrix.rst", "generated/skbio.diversity.alpha.rst", "generated/skbio.diversity.alpha.ace.rst", "generated/skbio.diversity.alpha.berger_parker_d.rst", "generated/skbio.diversity.alpha.brillouin_d.rst", "generated/skbio.diversity.alpha.chao1.rst", "generated/skbio.diversity.alpha.chao1_ci.rst", "generated/skbio.diversity.alpha.dominance.rst", "generated/skbio.diversity.alpha.doubles.rst", "generated/skbio.diversity.alpha.enspie.rst", "generated/skbio.diversity.alpha.esty_ci.rst", "generated/skbio.diversity.alpha.faith_pd.rst", "generated/skbio.diversity.alpha.fisher_alpha.rst", "generated/skbio.diversity.alpha.gini_index.rst", "generated/skbio.diversity.alpha.goods_coverage.rst", "generated/skbio.diversity.alpha.heip_e.rst", "generated/skbio.diversity.alpha.hill.rst", "generated/skbio.diversity.alpha.inv_simpson.rst", "generated/skbio.diversity.alpha.kempton_taylor_q.rst", "generated/skbio.diversity.alpha.lladser_ci.rst", "generated/skbio.diversity.alpha.lladser_pe.rst", "generated/skbio.diversity.alpha.margalef.rst", "generated/skbio.diversity.alpha.mcintosh_d.rst", "generated/skbio.diversity.alpha.mcintosh_e.rst", "generated/skbio.diversity.alpha.menhinick.rst", "generated/skbio.diversity.alpha.michaelis_menten_fit.rst", "generated/skbio.diversity.alpha.observed_features.rst", "generated/skbio.diversity.alpha.osd.rst", "generated/skbio.diversity.alpha.phydiv.rst", "generated/skbio.diversity.alpha.pielou_e.rst", "generated/skbio.diversity.alpha.renyi.rst", "generated/skbio.diversity.alpha.robbins.rst", "generated/skbio.diversity.alpha.shannon.rst", "generated/skbio.diversity.alpha.simpson.rst", "generated/skbio.diversity.alpha.simpson_d.rst", "generated/skbio.diversity.alpha.simpson_e.rst", "generated/skbio.diversity.alpha.singles.rst", "generated/skbio.diversity.alpha.sobs.rst", "generated/skbio.diversity.alpha.strong.rst", "generated/skbio.diversity.alpha.tsallis.rst", "generated/skbio.diversity.alpha_diversity.rst", "generated/skbio.diversity.beta.rst", "generated/skbio.diversity.beta.unweighted_unifrac.rst", "generated/skbio.diversity.beta.weighted_unifrac.rst", "generated/skbio.diversity.beta_diversity.rst", "generated/skbio.diversity.block_beta_diversity.rst", "generated/skbio.diversity.get_alpha_diversity_metrics.rst", "generated/skbio.diversity.get_beta_diversity_metrics.rst", "generated/skbio.diversity.partial_beta_diversity.rst", "generated/skbio.embedding.Embedding.rst", "generated/skbio.embedding.Embedding.bytes.rst", "generated/skbio.embedding.Embedding.read.rst", "generated/skbio.embedding.Embedding.write.rst", "generated/skbio.embedding.EmbeddingVector.rst", "generated/skbio.embedding.ProteinEmbedding.rst", "generated/skbio.embedding.ProteinVector.rst", "generated/skbio.embedding.SequenceEmbedding.rst", "generated/skbio.embedding.SequenceVector.rst", "generated/skbio.embedding.embed_vec_to_dataframe.rst", "generated/skbio.embedding.embed_vec_to_distances.rst", "generated/skbio.embedding.embed_vec_to_numpy.rst", "generated/skbio.embedding.embed_vec_to_ordination.rst", "generated/skbio.io.format.binary_dm.rst", "generated/skbio.io.format.biom.rst", "generated/skbio.io.format.blast6.rst", "generated/skbio.io.format.blast7.rst", "generated/skbio.io.format.clustal.rst", "generated/skbio.io.format.embed.rst", "generated/skbio.io.format.embl.rst", "generated/skbio.io.format.fasta.rst", "generated/skbio.io.format.fastq.rst", "generated/skbio.io.format.genbank.rst", "generated/skbio.io.format.gff3.rst", "generated/skbio.io.format.lsmat.rst", "generated/skbio.io.format.newick.rst", "generated/skbio.io.format.ordination.rst", "generated/skbio.io.format.phylip.rst", "generated/skbio.io.format.qseq.rst", "generated/skbio.io.format.sample_metadata.rst", "generated/skbio.io.format.stockholm.rst", "generated/skbio.io.format.taxdump.rst", "generated/skbio.io.registry.rst", "generated/skbio.io.registry.Format.rst", "generated/skbio.io.registry.Format.reader.rst", "generated/skbio.io.registry.Format.sniffer.rst", "generated/skbio.io.registry.Format.writer.rst", "generated/skbio.io.registry.IORegistry.rst", "generated/skbio.io.registry.IORegistry.add_format.rst", "generated/skbio.io.registry.IORegistry.create_format.rst", "generated/skbio.io.registry.IORegistry.get_reader.rst", "generated/skbio.io.registry.IORegistry.get_sniffer.rst", "generated/skbio.io.registry.IORegistry.get_writer.rst", "generated/skbio.io.registry.IORegistry.list_read_formats.rst", "generated/skbio.io.registry.IORegistry.list_write_formats.rst", "generated/skbio.io.registry.IORegistry.read.rst", "generated/skbio.io.registry.IORegistry.remove_format.rst", "generated/skbio.io.registry.IORegistry.sniff.rst", "generated/skbio.io.registry.IORegistry.write.rst", "generated/skbio.io.registry.create_format.rst", "generated/skbio.io.registry.read.rst", "generated/skbio.io.registry.sniff.rst", "generated/skbio.io.registry.write.rst", "generated/skbio.io.util.rst", "generated/skbio.io.util.open.rst", "generated/skbio.io.util.open_file.rst", "generated/skbio.io.util.open_files.rst", "generated/skbio.metadata.CategoricalMetadataColumn.rst", "generated/skbio.metadata.Interval.rst", "generated/skbio.metadata.Interval.drop.rst", "generated/skbio.metadata.IntervalMetadata.rst", "generated/skbio.metadata.IntervalMetadata.add.rst", "generated/skbio.metadata.IntervalMetadata.concat.rst", "generated/skbio.metadata.IntervalMetadata.drop.rst", "generated/skbio.metadata.IntervalMetadata.merge.rst", "generated/skbio.metadata.IntervalMetadata.query.rst", "generated/skbio.metadata.IntervalMetadata.read.rst", "generated/skbio.metadata.IntervalMetadata.sort.rst", "generated/skbio.metadata.IntervalMetadata.write.rst", "generated/skbio.metadata.IntervalMetadataMixin.rst", "generated/skbio.metadata.IntervalMetadataMixin.has_interval_metadata.rst", "generated/skbio.metadata.MetadataColumn.rst", "generated/skbio.metadata.MetadataColumn.drop_missing_values.rst", "generated/skbio.metadata.MetadataColumn.filter_ids.rst", "generated/skbio.metadata.MetadataColumn.get_ids.rst", "generated/skbio.metadata.MetadataColumn.get_missing.rst", "generated/skbio.metadata.MetadataColumn.get_value.rst", "generated/skbio.metadata.MetadataColumn.has_missing_values.rst", "generated/skbio.metadata.MetadataColumn.to_dataframe.rst", "generated/skbio.metadata.MetadataColumn.to_series.rst", "generated/skbio.metadata.MetadataMixin.rst", "generated/skbio.metadata.MetadataMixin.has_metadata.rst", "generated/skbio.metadata.NumericMetadataColumn.rst", "generated/skbio.metadata.PositionalMetadataMixin.rst", "generated/skbio.metadata.PositionalMetadataMixin.has_positional_metadata.rst", "generated/skbio.metadata.SampleMetadata.rst", "generated/skbio.metadata.SampleMetadata.filter_columns.rst", "generated/skbio.metadata.SampleMetadata.filter_ids.rst", "generated/skbio.metadata.SampleMetadata.get_column.rst", "generated/skbio.metadata.SampleMetadata.get_ids.rst", "generated/skbio.metadata.SampleMetadata.load.rst", "generated/skbio.metadata.SampleMetadata.merge.rst", "generated/skbio.metadata.SampleMetadata.to_dataframe.rst", "generated/skbio.sequence.DNA.rst", "generated/skbio.sequence.DNA.find_motifs.rst", "generated/skbio.sequence.DNA.read.rst", "generated/skbio.sequence.DNA.transcribe.rst", "generated/skbio.sequence.DNA.translate.rst", "generated/skbio.sequence.DNA.translate_six_frames.rst", "generated/skbio.sequence.DNA.write.rst", "generated/skbio.sequence.GeneticCode.rst", "generated/skbio.sequence.GeneticCode.from_ncbi.rst", "generated/skbio.sequence.GeneticCode.translate.rst", "generated/skbio.sequence.GeneticCode.translate_six_frames.rst", "generated/skbio.sequence.GrammaredSequence.rst", "generated/skbio.sequence.GrammaredSequence.definites.rst", "generated/skbio.sequence.GrammaredSequence.degap.rst", "generated/skbio.sequence.GrammaredSequence.degenerates.rst", "generated/skbio.sequence.GrammaredSequence.expand_degenerates.rst", "generated/skbio.sequence.GrammaredSequence.find_motifs.rst", "generated/skbio.sequence.GrammaredSequence.gaps.rst", "generated/skbio.sequence.GrammaredSequence.has_definites.rst", "generated/skbio.sequence.GrammaredSequence.has_degenerates.rst", "generated/skbio.sequence.GrammaredSequence.has_gaps.rst", "generated/skbio.sequence.GrammaredSequence.has_nondegenerates.rst", "generated/skbio.sequence.GrammaredSequence.nondegenerates.rst", "generated/skbio.sequence.GrammaredSequence.to_definites.rst", "generated/skbio.sequence.GrammaredSequence.to_regex.rst", "generated/skbio.sequence.NucleotideMixin.rst", "generated/skbio.sequence.NucleotideMixin.complement.rst", "generated/skbio.sequence.NucleotideMixin.gc_content.rst", "generated/skbio.sequence.NucleotideMixin.gc_frequency.rst", "generated/skbio.sequence.NucleotideMixin.is_reverse_complement.rst", "generated/skbio.sequence.NucleotideMixin.reverse_complement.rst", "generated/skbio.sequence.Protein.rst", "generated/skbio.sequence.Protein.find_motifs.rst", "generated/skbio.sequence.Protein.has_stops.rst", "generated/skbio.sequence.Protein.read.rst", "generated/skbio.sequence.Protein.stops.rst", "generated/skbio.sequence.Protein.write.rst", "generated/skbio.sequence.RNA.rst", "generated/skbio.sequence.RNA.find_motifs.rst", "generated/skbio.sequence.RNA.read.rst", "generated/skbio.sequence.RNA.reverse_transcribe.rst", "generated/skbio.sequence.RNA.translate.rst", "generated/skbio.sequence.RNA.translate_six_frames.rst", "generated/skbio.sequence.RNA.write.rst", "generated/skbio.sequence.Sequence.rst", "generated/skbio.sequence.Sequence.concat.rst", "generated/skbio.sequence.Sequence.count.rst", "generated/skbio.sequence.Sequence.distance.rst", "generated/skbio.sequence.Sequence.find_with_regex.rst", "generated/skbio.sequence.Sequence.frequencies.rst", "generated/skbio.sequence.Sequence.index.rst", "generated/skbio.sequence.Sequence.iter_contiguous.rst", "generated/skbio.sequence.Sequence.iter_kmers.rst", "generated/skbio.sequence.Sequence.kmer_frequencies.rst", "generated/skbio.sequence.Sequence.lowercase.rst", "generated/skbio.sequence.Sequence.match_frequency.rst", "generated/skbio.sequence.Sequence.matches.rst", "generated/skbio.sequence.Sequence.mismatch_frequency.rst", "generated/skbio.sequence.Sequence.mismatches.rst", "generated/skbio.sequence.Sequence.read.rst", "generated/skbio.sequence.Sequence.replace.rst", "generated/skbio.sequence.Sequence.to_indices.rst", "generated/skbio.sequence.Sequence.write.rst", "generated/skbio.sequence.SubstitutionMatrix.rst", "generated/skbio.sequence.SubstitutionMatrix.by_name.rst", "generated/skbio.sequence.SubstitutionMatrix.from_dict.rst", "generated/skbio.sequence.SubstitutionMatrix.get_names.rst", "generated/skbio.sequence.SubstitutionMatrix.identity.rst", "generated/skbio.sequence.SubstitutionMatrix.to_dict.rst", "generated/skbio.sequence.distance.rst", "generated/skbio.sequence.distance.hamming.rst", "generated/skbio.sequence.distance.kmer_distance.rst", "generated/skbio.stats.composition.rst", "generated/skbio.stats.composition.alr.rst", "generated/skbio.stats.composition.alr_inv.rst", "generated/skbio.stats.composition.ancom.rst", "generated/skbio.stats.composition.centralize.rst", "generated/skbio.stats.composition.closure.rst", "generated/skbio.stats.composition.clr.rst", "generated/skbio.stats.composition.clr_inv.rst", "generated/skbio.stats.composition.dirmult_ttest.rst", "generated/skbio.stats.composition.ilr.rst", "generated/skbio.stats.composition.ilr_inv.rst", "generated/skbio.stats.composition.inner.rst", "generated/skbio.stats.composition.multi_replace.rst", "generated/skbio.stats.composition.pairwise_vlr.rst", "generated/skbio.stats.composition.perturb.rst", "generated/skbio.stats.composition.perturb_inv.rst", "generated/skbio.stats.composition.power.rst", "generated/skbio.stats.composition.sbp_basis.rst", "generated/skbio.stats.composition.tree_basis.rst", "generated/skbio.stats.composition.vlr.rst", "generated/skbio.stats.distance.rst", "generated/skbio.stats.distance.DissimilarityMatrix.rst", "generated/skbio.stats.distance.DissimilarityMatrix.between.rst", "generated/skbio.stats.distance.DissimilarityMatrix.copy.rst", "generated/skbio.stats.distance.DissimilarityMatrix.filter.rst", "generated/skbio.stats.distance.DissimilarityMatrix.from_iterable.rst", "generated/skbio.stats.distance.DissimilarityMatrix.index.rst", "generated/skbio.stats.distance.DissimilarityMatrix.plot.rst", "generated/skbio.stats.distance.DissimilarityMatrix.read.rst", "generated/skbio.stats.distance.DissimilarityMatrix.redundant_form.rst", "generated/skbio.stats.distance.DissimilarityMatrix.rename.rst", "generated/skbio.stats.distance.DissimilarityMatrix.to_data_frame.rst", "generated/skbio.stats.distance.DissimilarityMatrix.transpose.rst", "generated/skbio.stats.distance.DissimilarityMatrix.within.rst", "generated/skbio.stats.distance.DissimilarityMatrix.write.rst", "generated/skbio.stats.distance.DistanceMatrix.rst", "generated/skbio.stats.distance.DistanceMatrix.condensed_form.rst", "generated/skbio.stats.distance.DistanceMatrix.from_iterable.rst", "generated/skbio.stats.distance.DistanceMatrix.permute.rst", "generated/skbio.stats.distance.DistanceMatrix.to_series.rst", "generated/skbio.stats.distance.anosim.rst", "generated/skbio.stats.distance.bioenv.rst", "generated/skbio.stats.distance.mantel.rst", "generated/skbio.stats.distance.permanova.rst", "generated/skbio.stats.distance.permdisp.rst", "generated/skbio.stats.distance.pwmantel.rst", "generated/skbio.stats.distance.randdm.rst", "generated/skbio.stats.evolve.rst", "generated/skbio.stats.evolve.hommola_cospeciation.rst", "generated/skbio.stats.gradient.rst", "generated/skbio.stats.gradient.AverageGradientANOVA.rst", "generated/skbio.stats.gradient.CategoryResults.rst", "generated/skbio.stats.gradient.CategoryResults.to_files.rst", "generated/skbio.stats.gradient.FirstDifferenceGradientANOVA.rst", "generated/skbio.stats.gradient.GradientANOVA.rst", "generated/skbio.stats.gradient.GradientANOVA.get_trajectories.rst", "generated/skbio.stats.gradient.GradientANOVAResults.rst", "generated/skbio.stats.gradient.GradientANOVAResults.to_files.rst", "generated/skbio.stats.gradient.GroupResults.rst", "generated/skbio.stats.gradient.GroupResults.to_files.rst", "generated/skbio.stats.gradient.TrajectoryGradientANOVA.rst", "generated/skbio.stats.gradient.WindowDifferenceGradientANOVA.rst", "generated/skbio.stats.isubsample.rst", "generated/skbio.stats.ordination.rst", "generated/skbio.stats.ordination.OrdinationResults.rst", "generated/skbio.stats.ordination.OrdinationResults.plot.rst", "generated/skbio.stats.ordination.OrdinationResults.read.rst", "generated/skbio.stats.ordination.OrdinationResults.rename.rst", "generated/skbio.stats.ordination.OrdinationResults.write.rst", "generated/skbio.stats.ordination.ca.rst", "generated/skbio.stats.ordination.cca.rst", "generated/skbio.stats.ordination.corr.rst", "generated/skbio.stats.ordination.e_matrix.rst", "generated/skbio.stats.ordination.f_matrix.rst", "generated/skbio.stats.ordination.mean_and_std.rst", "generated/skbio.stats.ordination.pcoa.rst", "generated/skbio.stats.ordination.pcoa_biplot.rst", "generated/skbio.stats.ordination.rda.rst", "generated/skbio.stats.ordination.scale.rst", "generated/skbio.stats.ordination.svd_rank.rst", "generated/skbio.stats.power.rst", "generated/skbio.stats.power.confidence_bound.rst", "generated/skbio.stats.power.paired_subsamples.rst", "generated/skbio.stats.power.subsample_paired_power.rst", "generated/skbio.stats.power.subsample_power.rst", "generated/skbio.stats.subsample_counts.rst", "generated/skbio.table.Table.rst", "generated/skbio.table.Table.add_group_metadata.rst", "generated/skbio.table.Table.add_metadata.rst", "generated/skbio.table.Table.align_to.rst", "generated/skbio.table.Table.align_to_dataframe.rst", "generated/skbio.table.Table.align_tree.rst", "generated/skbio.table.Table.collapse.rst", "generated/skbio.table.Table.concat.rst", "generated/skbio.table.Table.copy.rst", "generated/skbio.table.Table.data.rst", "generated/skbio.table.Table.del_metadata.rst", "generated/skbio.table.Table.delimited_self.rst", "generated/skbio.table.Table.descriptive_equality.rst", "generated/skbio.table.Table.exists.rst", "generated/skbio.table.Table.filter.rst", "generated/skbio.table.Table.from_adjacency.rst", "generated/skbio.table.Table.from_hdf5.rst", "generated/skbio.table.Table.from_json.rst", "generated/skbio.table.Table.from_tsv.rst", "generated/skbio.table.Table.get_table_density.rst", "generated/skbio.table.Table.get_value_by_ids.rst", "generated/skbio.table.Table.group_metadata.rst", "generated/skbio.table.Table.head.rst", "generated/skbio.table.Table.ids.rst", "generated/skbio.table.Table.index.rst", "generated/skbio.table.Table.is_empty.rst", "generated/skbio.table.Table.iter.rst", "generated/skbio.table.Table.iter_data.rst", "generated/skbio.table.Table.iter_pairwise.rst", "generated/skbio.table.Table.length.rst", "generated/skbio.table.Table.max.rst", "generated/skbio.table.Table.merge.rst", "generated/skbio.table.Table.metadata.rst", "generated/skbio.table.Table.metadata_to_dataframe.rst", "generated/skbio.table.Table.min.rst", "generated/skbio.table.Table.nonzero.rst", "generated/skbio.table.Table.nonzero_counts.rst", "generated/skbio.table.Table.norm.rst", "generated/skbio.table.Table.pa.rst", "generated/skbio.table.Table.partition.rst", "generated/skbio.table.Table.rankdata.rst", "generated/skbio.table.Table.read.rst", "generated/skbio.table.Table.reduce.rst", "generated/skbio.table.Table.remove_empty.rst", "generated/skbio.table.Table.sort.rst", "generated/skbio.table.Table.sort_order.rst", "generated/skbio.table.Table.subsample.rst", "generated/skbio.table.Table.sum.rst", "generated/skbio.table.Table.to_anndata.rst", "generated/skbio.table.Table.to_dataframe.rst", "generated/skbio.table.Table.to_hdf5.rst", "generated/skbio.table.Table.to_json.rst", "generated/skbio.table.Table.to_tsv.rst", "generated/skbio.table.Table.transform.rst", "generated/skbio.table.Table.transpose.rst", "generated/skbio.table.Table.update_ids.rst", "generated/skbio.table.Table.write.rst", "generated/skbio.table.example_table.rst", "generated/skbio.tree.TreeNode.rst", "generated/skbio.tree.TreeNode.ancestors.rst", "generated/skbio.tree.TreeNode.append.rst", "generated/skbio.tree.TreeNode.ascii_art.rst", "generated/skbio.tree.TreeNode.assign_ids.rst", "generated/skbio.tree.TreeNode.assign_supports.rst", "generated/skbio.tree.TreeNode.bifurcate.rst", "generated/skbio.tree.TreeNode.bipart.rst", "generated/skbio.tree.TreeNode.biparts.rst", "generated/skbio.tree.TreeNode.cache_attr.rst", "generated/skbio.tree.TreeNode.clear_caches.rst", "generated/skbio.tree.TreeNode.compare_biparts.rst", "generated/skbio.tree.TreeNode.compare_cophenet.rst", "generated/skbio.tree.TreeNode.compare_rfd.rst", "generated/skbio.tree.TreeNode.compare_subsets.rst", "generated/skbio.tree.TreeNode.compare_wrfd.rst", "generated/skbio.tree.TreeNode.cophenet.rst", "generated/skbio.tree.TreeNode.copy.rst", "generated/skbio.tree.TreeNode.count.rst", "generated/skbio.tree.TreeNode.create_caches.rst", "generated/skbio.tree.TreeNode.deepcopy.rst", "generated/skbio.tree.TreeNode.depth.rst", "generated/skbio.tree.TreeNode.distance.rst", "generated/skbio.tree.TreeNode.extend.rst", "generated/skbio.tree.TreeNode.find.rst", "generated/skbio.tree.TreeNode.find_all.rst", "generated/skbio.tree.TreeNode.find_by_func.rst", "generated/skbio.tree.TreeNode.find_by_id.rst", "generated/skbio.tree.TreeNode.from_linkage_matrix.rst", "generated/skbio.tree.TreeNode.from_taxdump.rst", "generated/skbio.tree.TreeNode.from_taxonomy.rst", "generated/skbio.tree.TreeNode.has_caches.rst", "generated/skbio.tree.TreeNode.has_children.rst", "generated/skbio.tree.TreeNode.height.rst", "generated/skbio.tree.TreeNode.index_tree.rst", "generated/skbio.tree.TreeNode.insert.rst", "generated/skbio.tree.TreeNode.is_bifurcating.rst", "generated/skbio.tree.TreeNode.is_root.rst", "generated/skbio.tree.TreeNode.is_tip.rst", "generated/skbio.tree.TreeNode.lca.rst", "generated/skbio.tree.TreeNode.levelorder.rst", "generated/skbio.tree.TreeNode.maxdist.rst", "generated/skbio.tree.TreeNode.neighbors.rst", "generated/skbio.tree.TreeNode.non_tips.rst", "generated/skbio.tree.TreeNode.observed_node_counts.rst", "generated/skbio.tree.TreeNode.path.rst", "generated/skbio.tree.TreeNode.pop.rst", "generated/skbio.tree.TreeNode.postorder.rst", "generated/skbio.tree.TreeNode.pre_and_postorder.rst", "generated/skbio.tree.TreeNode.preorder.rst", "generated/skbio.tree.TreeNode.prune.rst", "generated/skbio.tree.TreeNode.read.rst", "generated/skbio.tree.TreeNode.remove.rst", "generated/skbio.tree.TreeNode.remove_by_func.rst", "generated/skbio.tree.TreeNode.remove_deleted.rst", "generated/skbio.tree.TreeNode.root.rst", "generated/skbio.tree.TreeNode.root_at.rst", "generated/skbio.tree.TreeNode.root_at_midpoint.rst", "generated/skbio.tree.TreeNode.root_by_outgroup.rst", "generated/skbio.tree.TreeNode.shear.rst", "generated/skbio.tree.TreeNode.shuffle.rst", "generated/skbio.tree.TreeNode.siblings.rst", "generated/skbio.tree.TreeNode.subset.rst", "generated/skbio.tree.TreeNode.subsets.rst", "generated/skbio.tree.TreeNode.subtree.rst", "generated/skbio.tree.TreeNode.tips.rst", "generated/skbio.tree.TreeNode.to_array.rst", "generated/skbio.tree.TreeNode.to_taxonomy.rst", "generated/skbio.tree.TreeNode.total_length.rst", "generated/skbio.tree.TreeNode.traverse.rst", "generated/skbio.tree.TreeNode.unpack.rst", "generated/skbio.tree.TreeNode.unpack_by_func.rst", "generated/skbio.tree.TreeNode.unroot.rst", "generated/skbio.tree.TreeNode.unrooted_copy.rst", "generated/skbio.tree.TreeNode.unrooted_deepcopy.rst", "generated/skbio.tree.TreeNode.unrooted_move.rst", "generated/skbio.tree.TreeNode.write.rst", "generated/skbio.tree.bme.rst", "generated/skbio.tree.gme.rst", "generated/skbio.tree.majority_rule.rst", "generated/skbio.tree.nj.rst", "generated/skbio.tree.nni.rst", "generated/skbio.tree.path_dists.rst", "generated/skbio.tree.rf_dists.rst", "generated/skbio.tree.upgma.rst", "generated/skbio.tree.wrf_dists.rst", "generated/skbio.util.PlottableMixin.rst", "generated/skbio.util.aliased.rst", "generated/skbio.util.assert_data_frame_almost_equal.rst", "generated/skbio.util.assert_ordination_results_equal.rst", "generated/skbio.util.cardinal_to_ordinal.rst", "generated/skbio.util.classonlymethod.rst", "generated/skbio.util.classproperty.rst", "generated/skbio.util.deprecated.rst", "generated/skbio.util.find_duplicates.rst", "generated/skbio.util.get_data_path.rst", "generated/skbio.util.get_rng.rst", "generated/skbio.util.overrides.rst", "generated/skbio.util.params_aliased.rst", "generated/skbio.util.register_aliases.rst", "generated/skbio.util.safe_md5.rst", "generated/skbio.workflow.Workflow.rst", "generated/skbio.workflow.Workflow.initialize_state.rst", "generated/skbio.workflow.method.rst", "generated/skbio.workflow.requires.rst", "index.rst", "io.rst", "metadata.rst", "sequence.rst", "stats.rst", "table.rst", "tree.rst", "util.rst", "workflow.rst"], "indexentries": {"__bool__() (skbio.alignment.tabularmsa method)": [[20, "skbio.alignment.TabularMSA.__bool__", false]], "__bool__() (skbio.sequence.sequence method)": [[228, "skbio.sequence.Sequence.__bool__", false]], "__call__() (skbio.alignment.stripedsmithwaterman method)": [[19, "skbio.alignment.StripedSmithWaterman.__call__", false]], "__call__() (skbio.workflow.method method)": [[503, "skbio.workflow.method.__call__", false]], "__call__() (skbio.workflow.requires method)": [[504, "skbio.workflow.requires.__call__", false]], "__call__() (skbio.workflow.workflow method)": [[501, "skbio.workflow.Workflow.__call__", false]], "__contains__() (skbio.alignment.tabularmsa method)": [[20, "skbio.alignment.TabularMSA.__contains__", false]], "__contains__() (skbio.sequence.sequence method)": [[228, "skbio.sequence.Sequence.__contains__", false]], "__contains__() (skbio.stats.distance.dissimilaritymatrix method)": [[277, "skbio.stats.distance.DissimilarityMatrix.__contains__", false]], "__copy__() (skbio.alignment.tabularmsa method)": [[20, "skbio.alignment.TabularMSA.__copy__", false]], "__copy__() (skbio.metadata.intervalmetadata method)": [[151, "skbio.metadata.IntervalMetadata.__copy__", false]], "__copy__() (skbio.metadata.intervalmetadatamixin method)": [[160, "skbio.metadata.IntervalMetadataMixin.__copy__", false]], "__copy__() (skbio.metadata.metadatamixin method)": [[171, "skbio.metadata.MetadataMixin.__copy__", false]], "__copy__() (skbio.metadata.positionalmetadatamixin method)": [[174, "skbio.metadata.PositionalMetadataMixin.__copy__", false]], "__copy__() (skbio.sequence.sequence method)": [[228, "skbio.sequence.Sequence.__copy__", false]], "__copy__() (skbio.tree.treenode method)": [[400, "skbio.tree.TreeNode.__copy__", false]], "__deepcopy__() (skbio.alignment.tabularmsa method)": [[20, "skbio.alignment.TabularMSA.__deepcopy__", false]], "__deepcopy__() (skbio.metadata.intervalmetadata method)": [[151, "skbio.metadata.IntervalMetadata.__deepcopy__", false]], "__deepcopy__() (skbio.metadata.intervalmetadatamixin method)": [[160, "skbio.metadata.IntervalMetadataMixin.__deepcopy__", false]], "__deepcopy__() (skbio.metadata.metadatamixin method)": [[171, "skbio.metadata.MetadataMixin.__deepcopy__", false]], "__deepcopy__() (skbio.metadata.positionalmetadatamixin method)": [[174, "skbio.metadata.PositionalMetadataMixin.__deepcopy__", false]], "__deepcopy__() (skbio.sequence.sequence method)": [[228, "skbio.sequence.Sequence.__deepcopy__", false]], "__deepcopy__() (skbio.tree.treenode method)": [[400, "skbio.tree.TreeNode.__deepcopy__", false]], "__eq__() (skbio.alignment.tabularmsa method)": [[20, "skbio.alignment.TabularMSA.__eq__", false]], "__eq__() (skbio.metadata.interval method)": [[149, "skbio.metadata.Interval.__eq__", false]], "__eq__() (skbio.metadata.intervalmetadata method)": [[151, "skbio.metadata.IntervalMetadata.__eq__", false]], "__eq__() (skbio.metadata.intervalmetadatamixin method)": [[160, "skbio.metadata.IntervalMetadataMixin.__eq__", false]], "__eq__() (skbio.metadata.metadatacolumn method)": [[162, "skbio.metadata.MetadataColumn.__eq__", false]], "__eq__() (skbio.metadata.metadatamixin method)": [[171, "skbio.metadata.MetadataMixin.__eq__", false]], "__eq__() (skbio.metadata.positionalmetadatamixin method)": [[174, "skbio.metadata.PositionalMetadataMixin.__eq__", false]], "__eq__() (skbio.metadata.samplemetadata method)": [[176, "skbio.metadata.SampleMetadata.__eq__", false]], "__eq__() (skbio.sequence.geneticcode method)": [[191, "skbio.sequence.GeneticCode.__eq__", false]], "__eq__() (skbio.sequence.sequence method)": [[228, "skbio.sequence.Sequence.__eq__", false]], "__eq__() (skbio.stats.distance.dissimilaritymatrix method)": [[277, "skbio.stats.distance.DissimilarityMatrix.__eq__", false]], "__eq__() (skbio.table.table method)": [[342, "skbio.table.Table.__eq__", false]], "__get__() (skbio.util.classonlymethod method)": [[491, "skbio.util.classonlymethod.__get__", false]], "__get__() (skbio.util.classproperty method)": [[492, "skbio.util.classproperty.__get__", false]], "__getitem__() (skbio.alignment.alignmentstructure method)": [[11, "skbio.alignment.AlignmentStructure.__getitem__", false]], "__getitem__() (skbio.alignment.tabularmsa method)": [[20, "skbio.alignment.TabularMSA.__getitem__", false]], "__getitem__() (skbio.sequence.sequence method)": [[228, "skbio.sequence.Sequence.__getitem__", false]], "__getitem__() (skbio.stats.distance.dissimilaritymatrix method)": [[277, "skbio.stats.distance.DissimilarityMatrix.__getitem__", false]], "__getitem__() (skbio.table.table method)": [[342, "skbio.table.Table.__getitem__", false]], "__getitem__() (skbio.tree.treenode method)": [[400, "skbio.tree.TreeNode.__getitem__", false]], "__iter__() (skbio.alignment.tabularmsa method)": [[20, "skbio.alignment.TabularMSA.__iter__", false]], "__iter__() (skbio.sequence.sequence method)": [[228, "skbio.sequence.Sequence.__iter__", false]], "__iter__() (skbio.table.table method)": [[342, "skbio.table.Table.__iter__", false]], "__iter__() (skbio.tree.treenode method)": [[400, "skbio.tree.TreeNode.__iter__", false]], "__len__() (skbio.alignment.tabularmsa method)": [[20, "skbio.alignment.TabularMSA.__len__", false]], "__len__() (skbio.sequence.sequence method)": [[228, "skbio.sequence.Sequence.__len__", false]], "__len__() (skbio.tree.treenode method)": [[400, "skbio.tree.TreeNode.__len__", false]], "__ne__() (skbio.alignment.tabularmsa method)": [[20, "skbio.alignment.TabularMSA.__ne__", false]], "__ne__() (skbio.metadata.interval method)": [[149, "skbio.metadata.Interval.__ne__", false]], "__ne__() (skbio.metadata.intervalmetadata method)": [[151, "skbio.metadata.IntervalMetadata.__ne__", false]], "__ne__() (skbio.metadata.intervalmetadatamixin method)": [[160, "skbio.metadata.IntervalMetadataMixin.__ne__", false]], "__ne__() (skbio.metadata.metadatacolumn method)": [[162, "skbio.metadata.MetadataColumn.__ne__", false]], "__ne__() (skbio.metadata.metadatamixin method)": [[171, "skbio.metadata.MetadataMixin.__ne__", false]], "__ne__() (skbio.metadata.positionalmetadatamixin method)": [[174, "skbio.metadata.PositionalMetadataMixin.__ne__", false]], "__ne__() (skbio.metadata.samplemetadata method)": [[176, "skbio.metadata.SampleMetadata.__ne__", false]], "__ne__() (skbio.sequence.geneticcode method)": [[191, "skbio.sequence.GeneticCode.__ne__", false]], "__ne__() (skbio.sequence.sequence method)": [[228, "skbio.sequence.Sequence.__ne__", false]], "__ne__() (skbio.stats.distance.dissimilaritymatrix method)": [[277, "skbio.stats.distance.DissimilarityMatrix.__ne__", false]], "__ne__() (skbio.table.table method)": [[342, "skbio.table.Table.__ne__", false]], "__reversed__() (skbio.alignment.tabularmsa method)": [[20, "skbio.alignment.TabularMSA.__reversed__", false]], "__reversed__() (skbio.sequence.sequence method)": [[228, "skbio.sequence.Sequence.__reversed__", false]], "__set__() (skbio.util.classproperty method)": [[492, "skbio.util.classproperty.__set__", false]], "__setstate__() (skbio.alignment.alignmentstructure method)": [[11, "skbio.alignment.AlignmentStructure.__setstate__", false]], "__setstate__() (skbio.alignment.stripedsmithwaterman method)": [[19, "skbio.alignment.StripedSmithWaterman.__setstate__", false]], "__str__() (skbio.alignment.alignmentstructure method)": [[11, "skbio.alignment.AlignmentStructure.__str__", false]], "__str__() (skbio.alignment.alignpath method)": [[3, "skbio.alignment.AlignPath.__str__", false]], "__str__() (skbio.alignment.pairalignpath method)": [[14, "skbio.alignment.PairAlignPath.__str__", false]], "__str__() (skbio.alignment.tabularmsa method)": [[20, "skbio.alignment.TabularMSA.__str__", false]], "__str__() (skbio.embedding.embedding method)": [[91, "skbio.embedding.Embedding.__str__", false]], "__str__() (skbio.embedding.embeddingvector method)": [[95, "skbio.embedding.EmbeddingVector.__str__", false]], "__str__() (skbio.embedding.sequenceembedding method)": [[98, "skbio.embedding.SequenceEmbedding.__str__", false]], "__str__() (skbio.sequence.geneticcode method)": [[191, "skbio.sequence.GeneticCode.__str__", false]], "__str__() (skbio.sequence.sequence method)": [[228, "skbio.sequence.Sequence.__str__", false]], "__str__() (skbio.stats.distance.dissimilaritymatrix method)": [[277, "skbio.stats.distance.DissimilarityMatrix.__str__", false]], "__str__() (skbio.stats.ordination.ordinationresults method)": [[320, "skbio.stats.ordination.OrdinationResults.__str__", false]], "__str__() (skbio.table.table method)": [[342, "skbio.table.Table.__str__", false]], "__str__() (skbio.tree.treenode method)": [[400, "skbio.tree.TreeNode.__str__", false]], "ace() (in module skbio.diversity.alpha)": [[44, "skbio.diversity.alpha.ace", false]], "add() (skbio.metadata.intervalmetadata method)": [[152, "skbio.metadata.IntervalMetadata.add", false]], "add_format() (skbio.io.registry.ioregistry method)": [[129, "skbio.io.registry.IORegistry.add_format", false]], "add_group_metadata() (skbio.table.table method)": [[343, "skbio.table.Table.add_group_metadata", false]], "add_metadata() (skbio.table.table method)": [[344, "skbio.table.Table.add_metadata", false]], "aliased() (in module skbio.util)": [[487, "skbio.util.aliased", false]], "align_to() (skbio.table.table method)": [[345, "skbio.table.Table.align_to", false]], "align_to_dataframe() (skbio.table.table method)": [[346, "skbio.table.Table.align_to_dataframe", false]], "align_tree() (skbio.table.table method)": [[347, "skbio.table.Table.align_tree", false]], "aligned_query_sequence (skbio.alignment.alignmentstructure attribute)": [[11, "skbio.alignment.AlignmentStructure.aligned_query_sequence", false]], "aligned_target_sequence (skbio.alignment.alignmentstructure attribute)": [[11, "skbio.alignment.AlignmentStructure.aligned_target_sequence", false]], "alignmentstructure (class in skbio.alignment)": [[11, "skbio.alignment.AlignmentStructure", false]], "alignpath (class in skbio.alignment)": [[3, "skbio.alignment.AlignPath", false]], "alpha_diversity() (in module skbio.diversity)": [[82, "skbio.diversity.alpha_diversity", false]], "alphabet (skbio.sequence.grammaredsequence attribute)": [[195, "skbio.sequence.GrammaredSequence.alphabet", false]], "alphabet (skbio.sequence.protein attribute)": [[215, "skbio.sequence.Protein.alphabet", false]], "alphabet (skbio.sequence.substitutionmatrix attribute)": [[247, "skbio.sequence.SubstitutionMatrix.alphabet", false]], "alr() (in module skbio.stats.composition)": [[257, "skbio.stats.composition.alr", false]], "alr_inv() (in module skbio.stats.composition)": [[258, "skbio.stats.composition.alr_inv", false]], "ancestors() (skbio.tree.treenode method)": [[401, "skbio.tree.TreeNode.ancestors", false]], "ancom() (in module skbio.stats.composition)": [[259, "skbio.stats.composition.ancom", false]], "anosim() (in module skbio.stats.distance)": [[296, "skbio.stats.distance.anosim", false]], "append() (skbio.alignment.tabularmsa method)": [[21, "skbio.alignment.TabularMSA.append", false]], "append() (skbio.tree.treenode method)": [[402, "skbio.tree.TreeNode.append", false]], "ascii_art() (skbio.tree.treenode method)": [[403, "skbio.tree.TreeNode.ascii_art", false]], "assert_data_frame_almost_equal() (in module skbio.util)": [[488, "skbio.util.assert_data_frame_almost_equal", false]], "assert_ordination_results_equal() (in module skbio.util)": [[489, "skbio.util.assert_ordination_results_equal", false]], "assign_ids() (skbio.tree.treenode method)": [[404, "skbio.tree.TreeNode.assign_ids", false]], "assign_supports() (skbio.tree.treenode method)": [[405, "skbio.tree.TreeNode.assign_supports", false]], "averagegradientanova (class in skbio.stats.gradient)": [[306, "skbio.stats.gradient.AverageGradientANOVA", false]], "berger_parker_d() (in module skbio.diversity.alpha)": [[45, "skbio.diversity.alpha.berger_parker_d", false]], "beta_diversity() (in module skbio.diversity)": [[86, "skbio.diversity.beta_diversity", false]], "between() (skbio.stats.distance.dissimilaritymatrix method)": [[278, "skbio.stats.distance.DissimilarityMatrix.between", false]], "bifurcate() (skbio.tree.treenode method)": [[406, "skbio.tree.TreeNode.bifurcate", false]], "bioenv() (in module skbio.stats.distance)": [[297, "skbio.stats.distance.bioenv", false]], "bipart() (skbio.tree.treenode method)": [[407, "skbio.tree.TreeNode.bipart", false]], "biparts() (skbio.tree.treenode method)": [[408, "skbio.tree.TreeNode.biparts", false]], "block_beta_diversity() (in module skbio.diversity)": [[87, "skbio.diversity.block_beta_diversity", false]], "bme() (in module skbio.tree)": [[477, "skbio.tree.bme", false]], "bounds (skbio.metadata.interval attribute)": [[149, "skbio.metadata.Interval.bounds", false]], "brillouin_d() (in module skbio.diversity.alpha)": [[46, "skbio.diversity.alpha.brillouin_d", false]], "by_name() (skbio.sequence.substitutionmatrix class method)": [[248, "skbio.sequence.SubstitutionMatrix.by_name", false]], "bytes() (skbio.embedding.embedding method)": [[92, "skbio.embedding.Embedding.bytes", false]], "ca() (in module skbio.stats.ordination)": [[325, "skbio.stats.ordination.ca", false]], "cache_attr() (skbio.tree.treenode method)": [[409, "skbio.tree.TreeNode.cache_attr", false]], "cardinal_to_ordinal() (in module skbio.util)": [[490, "skbio.util.cardinal_to_ordinal", false]], "categoricalmetadatacolumn (class in skbio.metadata)": [[148, "skbio.metadata.CategoricalMetadataColumn", false]], "categoryresults (class in skbio.stats.gradient)": [[307, "skbio.stats.gradient.CategoryResults", false]], "cca() (in module skbio.stats.ordination)": [[326, "skbio.stats.ordination.cca", false]], "centralize() (in module skbio.stats.composition)": [[260, "skbio.stats.composition.centralize", false]], "chao1() (in module skbio.diversity.alpha)": [[47, "skbio.diversity.alpha.chao1", false]], "chao1_ci() (in module skbio.diversity.alpha)": [[48, "skbio.diversity.alpha.chao1_ci", false]], "cigar (skbio.alignment.alignmentstructure attribute)": [[11, "skbio.alignment.AlignmentStructure.cigar", false]], "classonlymethod (class in skbio.util)": [[491, "skbio.util.classonlymethod", false]], "classproperty (class in skbio.util)": [[492, "skbio.util.classproperty", false]], "clear_caches() (skbio.tree.treenode method)": [[410, "skbio.tree.TreeNode.clear_caches", false]], "closure() (in module skbio.stats.composition)": [[261, "skbio.stats.composition.closure", false]], "clr() (in module skbio.stats.composition)": [[262, "skbio.stats.composition.clr", false]], "clr_inv() (in module skbio.stats.composition)": [[263, "skbio.stats.composition.clr_inv", false]], "collapse() (skbio.table.table method)": [[348, "skbio.table.Table.collapse", false]], "column_count (skbio.metadata.samplemetadata attribute)": [[176, "skbio.metadata.SampleMetadata.column_count", false]], "columns (skbio.metadata.samplemetadata attribute)": [[176, "skbio.metadata.SampleMetadata.columns", false]], "compare_biparts() (skbio.tree.treenode method)": [[411, "skbio.tree.TreeNode.compare_biparts", false]], "compare_cophenet() (skbio.tree.treenode method)": [[412, "skbio.tree.TreeNode.compare_cophenet", false]], "compare_rfd() (skbio.tree.treenode method)": [[413, "skbio.tree.TreeNode.compare_rfd", false]], "compare_subsets() (skbio.tree.treenode method)": [[414, "skbio.tree.TreeNode.compare_subsets", false]], "compare_wrfd() (skbio.tree.treenode method)": [[415, "skbio.tree.TreeNode.compare_wrfd", false]], "complement() (skbio.sequence.nucleotidemixin method)": [[210, "skbio.sequence.NucleotideMixin.complement", false]], "complement_map (skbio.sequence.dna attribute)": [[184, "skbio.sequence.DNA.complement_map", false]], "complement_map (skbio.sequence.nucleotidemixin attribute)": [[209, "skbio.sequence.NucleotideMixin.complement_map", false]], "complement_map (skbio.sequence.rna attribute)": [[221, "skbio.sequence.RNA.complement_map", false]], "concat() (skbio.metadata.intervalmetadata class method)": [[153, "skbio.metadata.IntervalMetadata.concat", false]], "concat() (skbio.sequence.sequence class method)": [[229, "skbio.sequence.Sequence.concat", false]], "concat() (skbio.table.table method)": [[349, "skbio.table.Table.concat", false]], "condensed_form() (skbio.stats.distance.distancematrix method)": [[292, "skbio.stats.distance.DistanceMatrix.condensed_form", false]], "confidence_bound() (in module skbio.stats.power)": [[337, "skbio.stats.power.confidence_bound", false]], "consensus() (skbio.alignment.tabularmsa method)": [[22, "skbio.alignment.TabularMSA.consensus", false]], "conservation() (skbio.alignment.tabularmsa method)": [[23, "skbio.alignment.TabularMSA.conservation", false]], "cophenet() (skbio.tree.treenode method)": [[416, "skbio.tree.TreeNode.cophenet", false]], "copy() (skbio.stats.distance.dissimilaritymatrix method)": [[279, "skbio.stats.distance.DissimilarityMatrix.copy", false]], "copy() (skbio.table.table method)": [[350, "skbio.table.Table.copy", false]], "copy() (skbio.tree.treenode method)": [[417, "skbio.tree.TreeNode.copy", false]], "corr() (in module skbio.stats.ordination)": [[327, "skbio.stats.ordination.corr", false]], "count() (skbio.sequence.sequence method)": [[230, "skbio.sequence.Sequence.count", false]], "count() (skbio.tree.treenode method)": [[418, "skbio.tree.TreeNode.count", false]], "create_caches() (skbio.tree.treenode method)": [[419, "skbio.tree.TreeNode.create_caches", false]], "create_format() (in module skbio.io.registry)": [[140, "skbio.io.registry.create_format", false]], "create_format() (skbio.io.registry.ioregistry method)": [[130, "skbio.io.registry.IORegistry.create_format", false]], "data (skbio.stats.distance.dissimilaritymatrix attribute)": [[277, "skbio.stats.distance.DissimilarityMatrix.data", false]], "data() (skbio.table.table method)": [[351, "skbio.table.Table.data", false]], "deepcopy() (skbio.tree.treenode method)": [[420, "skbio.tree.TreeNode.deepcopy", false]], "default_gap_char (skbio.sequence.dna attribute)": [[184, "skbio.sequence.DNA.default_gap_char", false]], "default_gap_char (skbio.sequence.grammaredsequence attribute)": [[195, "skbio.sequence.GrammaredSequence.default_gap_char", false]], "default_gap_char (skbio.sequence.protein attribute)": [[215, "skbio.sequence.Protein.default_gap_char", false]], "default_gap_char (skbio.sequence.rna attribute)": [[221, "skbio.sequence.RNA.default_gap_char", false]], "default_write_format (skbio.alignment.tabularmsa attribute)": [[20, "skbio.alignment.TabularMSA.default_write_format", false]], "default_write_format (skbio.embedding.proteinembedding attribute)": [[96, "skbio.embedding.ProteinEmbedding.default_write_format", false]], "default_write_format (skbio.embedding.proteinvector attribute)": [[97, "skbio.embedding.ProteinVector.default_write_format", false]], "default_write_format (skbio.metadata.intervalmetadata attribute)": [[151, "skbio.metadata.IntervalMetadata.default_write_format", false]], "default_write_format (skbio.metadata.samplemetadata attribute)": [[176, "skbio.metadata.SampleMetadata.default_write_format", false]], "default_write_format (skbio.sequence.sequence attribute)": [[228, "skbio.sequence.Sequence.default_write_format", false]], "default_write_format (skbio.stats.distance.dissimilaritymatrix attribute)": [[277, "skbio.stats.distance.DissimilarityMatrix.default_write_format", false]], "default_write_format (skbio.stats.ordination.ordinationresults attribute)": [[320, "skbio.stats.ordination.OrdinationResults.default_write_format", false]], "default_write_format (skbio.table.table attribute)": [[342, "skbio.table.Table.default_write_format", false]], "default_write_format (skbio.tree.treenode attribute)": [[400, "skbio.tree.TreeNode.default_write_format", false]], "definite_chars (skbio.sequence.dna attribute)": [[184, "skbio.sequence.DNA.definite_chars", false]], "definite_chars (skbio.sequence.grammaredsequence attribute)": [[195, "skbio.sequence.GrammaredSequence.definite_chars", false]], "definite_chars (skbio.sequence.protein attribute)": [[215, "skbio.sequence.Protein.definite_chars", false]], "definite_chars (skbio.sequence.rna attribute)": [[221, "skbio.sequence.RNA.definite_chars", false]], "definites() (skbio.sequence.grammaredsequence method)": [[196, "skbio.sequence.GrammaredSequence.definites", false]], "degap() (skbio.sequence.grammaredsequence method)": [[197, "skbio.sequence.GrammaredSequence.degap", false]], "degenerate_chars (skbio.sequence.grammaredsequence attribute)": [[195, "skbio.sequence.GrammaredSequence.degenerate_chars", false]], "degenerate_map (skbio.sequence.dna attribute)": [[184, "skbio.sequence.DNA.degenerate_map", false]], "degenerate_map (skbio.sequence.grammaredsequence attribute)": [[195, "skbio.sequence.GrammaredSequence.degenerate_map", false]], "degenerate_map (skbio.sequence.protein attribute)": [[215, "skbio.sequence.Protein.degenerate_map", false]], "degenerate_map (skbio.sequence.rna attribute)": [[221, "skbio.sequence.RNA.degenerate_map", false]], "degenerates() (skbio.sequence.grammaredsequence method)": [[198, "skbio.sequence.GrammaredSequence.degenerates", false]], "del_metadata() (skbio.table.table method)": [[352, "skbio.table.Table.del_metadata", false]], "delimited_self() (skbio.table.table method)": [[353, "skbio.table.Table.delimited_self", false]], "deprecated() (in module skbio.util)": [[493, "skbio.util.deprecated", false]], "depth() (skbio.tree.treenode method)": [[421, "skbio.tree.TreeNode.depth", false]], "descriptive_equality() (skbio.table.table method)": [[354, "skbio.table.Table.descriptive_equality", false]], "dirmult_ttest() (in module skbio.stats.composition)": [[264, "skbio.stats.composition.dirmult_ttest", false]], "dissimilaritymatrix (class in skbio.stats.distance)": [[277, "skbio.stats.distance.DissimilarityMatrix", false]], "distance() (skbio.sequence.sequence method)": [[231, "skbio.sequence.Sequence.distance", false]], "distance() (skbio.tree.treenode method)": [[422, "skbio.tree.TreeNode.distance", false]], "distancematrix (class in skbio.stats.distance)": [[291, "skbio.stats.distance.DistanceMatrix", false]], "dna (class in skbio.sequence)": [[184, "skbio.sequence.DNA", false]], "dominance() (in module skbio.diversity.alpha)": [[49, "skbio.diversity.alpha.dominance", false]], "doubles() (in module skbio.diversity.alpha)": [[50, "skbio.diversity.alpha.doubles", false]], "drop() (skbio.metadata.interval method)": [[150, "skbio.metadata.Interval.drop", false]], "drop() (skbio.metadata.intervalmetadata method)": [[154, "skbio.metadata.IntervalMetadata.drop", false]], "drop_missing_values() (skbio.metadata.metadatacolumn method)": [[163, "skbio.metadata.MetadataColumn.drop_missing_values", false]], "dropped (skbio.metadata.interval attribute)": [[149, "skbio.metadata.Interval.dropped", false]], "dtype (skbio.alignment.tabularmsa attribute)": [[20, "skbio.alignment.TabularMSA.dtype", false]], "dtype (skbio.stats.distance.dissimilaritymatrix attribute)": [[277, "skbio.stats.distance.DissimilarityMatrix.dtype", false]], "dtype (skbio.table.table attribute)": [[342, "skbio.table.Table.dtype", false]], "e_matrix() (in module skbio.stats.ordination)": [[328, "skbio.stats.ordination.e_matrix", false]], "embed_vec_to_dataframe() (in module skbio.embedding)": [[100, "skbio.embedding.embed_vec_to_dataframe", false]], "embed_vec_to_distances() (in module skbio.embedding)": [[101, "skbio.embedding.embed_vec_to_distances", false]], "embed_vec_to_numpy() (in module skbio.embedding)": [[102, "skbio.embedding.embed_vec_to_numpy", false]], "embed_vec_to_ordination() (in module skbio.embedding)": [[103, "skbio.embedding.embed_vec_to_ordination", false]], "embedding (class in skbio.embedding)": [[91, "skbio.embedding.Embedding", false]], "embedding (skbio.embedding.embedding attribute)": [[91, "skbio.embedding.Embedding.embedding", false]], "embedding (skbio.embedding.embeddingvector attribute)": [[95, "skbio.embedding.EmbeddingVector.embedding", false]], "embeddingvector (class in skbio.embedding)": [[95, "skbio.embedding.EmbeddingVector", false]], "enspie() (in module skbio.diversity.alpha)": [[51, "skbio.diversity.alpha.enspie", false]], "esty_ci() (in module skbio.diversity.alpha)": [[52, "skbio.diversity.alpha.esty_ci", false]], "example_table (in module skbio.table)": [[399, "skbio.table.example_table", false]], "exists() (skbio.table.table method)": [[355, "skbio.table.Table.exists", false]], "expand_degenerates() (skbio.sequence.grammaredsequence method)": [[199, "skbio.sequence.GrammaredSequence.expand_degenerates", false]], "extend() (skbio.alignment.tabularmsa method)": [[24, "skbio.alignment.TabularMSA.extend", false]], "extend() (skbio.tree.treenode method)": [[423, "skbio.tree.TreeNode.extend", false]], "f_matrix() (in module skbio.stats.ordination)": [[329, "skbio.stats.ordination.f_matrix", false]], "faith_pd() (in module skbio.diversity.alpha)": [[53, "skbio.diversity.alpha.faith_pd", false]], "filter() (skbio.stats.distance.dissimilaritymatrix method)": [[280, "skbio.stats.distance.DissimilarityMatrix.filter", false]], "filter() (skbio.table.table method)": [[356, "skbio.table.Table.filter", false]], "filter_columns() (skbio.metadata.samplemetadata method)": [[177, "skbio.metadata.SampleMetadata.filter_columns", false]], "filter_ids() (skbio.metadata.metadatacolumn method)": [[164, "skbio.metadata.MetadataColumn.filter_ids", false]], "filter_ids() (skbio.metadata.samplemetadata method)": [[178, "skbio.metadata.SampleMetadata.filter_ids", false]], "find() (skbio.tree.treenode method)": [[424, "skbio.tree.TreeNode.find", false]], "find_all() (skbio.tree.treenode method)": [[425, "skbio.tree.TreeNode.find_all", false]], "find_by_func() (skbio.tree.treenode method)": [[426, "skbio.tree.TreeNode.find_by_func", false]], "find_by_id() (skbio.tree.treenode method)": [[427, "skbio.tree.TreeNode.find_by_id", false]], "find_duplicates() (in module skbio.util)": [[494, "skbio.util.find_duplicates", false]], "find_motifs() (skbio.sequence.dna method)": [[185, "skbio.sequence.DNA.find_motifs", false]], "find_motifs() (skbio.sequence.grammaredsequence method)": [[200, "skbio.sequence.GrammaredSequence.find_motifs", false]], "find_motifs() (skbio.sequence.protein method)": [[216, "skbio.sequence.Protein.find_motifs", false]], "find_motifs() (skbio.sequence.rna method)": [[222, "skbio.sequence.RNA.find_motifs", false]], "find_with_regex() (skbio.sequence.sequence method)": [[232, "skbio.sequence.Sequence.find_with_regex", false]], "firstdifferencegradientanova (class in skbio.stats.gradient)": [[309, "skbio.stats.gradient.FirstDifferenceGradientANOVA", false]], "fisher_alpha() (in module skbio.diversity.alpha)": [[54, "skbio.diversity.alpha.fisher_alpha", false]], "format (class in skbio.io.registry)": [[124, "skbio.io.registry.Format", false]], "frequencies() (skbio.sequence.sequence method)": [[233, "skbio.sequence.Sequence.frequencies", false]], "from_adjacency() (skbio.table.table static method)": [[357, "skbio.table.Table.from_adjacency", false]], "from_bits() (skbio.alignment.alignpath class method)": [[4, "skbio.alignment.AlignPath.from_bits", false]], "from_bits() (skbio.alignment.pairalignpath class method)": [[15, "skbio.alignment.PairAlignPath.from_bits", false]], "from_cigar() (skbio.alignment.pairalignpath class method)": [[16, "skbio.alignment.PairAlignPath.from_cigar", false]], "from_coordinates() (skbio.alignment.alignpath class method)": [[5, "skbio.alignment.AlignPath.from_coordinates", false]], "from_dict() (skbio.alignment.tabularmsa class method)": [[25, "skbio.alignment.TabularMSA.from_dict", false]], "from_dict() (skbio.sequence.substitutionmatrix class method)": [[249, "skbio.sequence.SubstitutionMatrix.from_dict", false]], "from_hdf5() (skbio.table.table class method)": [[358, "skbio.table.Table.from_hdf5", false]], "from_indices() (skbio.alignment.alignpath class method)": [[6, "skbio.alignment.AlignPath.from_indices", false]], "from_iterable() (skbio.stats.distance.dissimilaritymatrix class method)": [[281, "skbio.stats.distance.DissimilarityMatrix.from_iterable", false]], "from_iterable() (skbio.stats.distance.distancematrix class method)": [[293, "skbio.stats.distance.DistanceMatrix.from_iterable", false]], "from_json() (skbio.table.table class method)": [[359, "skbio.table.Table.from_json", false]], "from_linkage_matrix() (skbio.tree.treenode class method)": [[428, "skbio.tree.TreeNode.from_linkage_matrix", false]], "from_ncbi() (skbio.sequence.geneticcode class method)": [[192, "skbio.sequence.GeneticCode.from_ncbi", false]], "from_path_seqs() (skbio.alignment.tabularmsa class method)": [[26, "skbio.alignment.TabularMSA.from_path_seqs", false]], "from_tabular() (skbio.alignment.alignpath class method)": [[7, "skbio.alignment.AlignPath.from_tabular", false]], "from_taxdump() (skbio.tree.treenode class method)": [[429, "skbio.tree.TreeNode.from_taxdump", false]], "from_taxonomy() (skbio.tree.treenode class method)": [[430, "skbio.tree.TreeNode.from_taxonomy", false]], "from_tsv() (skbio.table.table static method)": [[360, "skbio.table.Table.from_tsv", false]], "fuzzy (skbio.metadata.interval attribute)": [[149, "skbio.metadata.Interval.fuzzy", false]], "gap_chars (skbio.sequence.dna attribute)": [[184, "skbio.sequence.DNA.gap_chars", false]], "gap_chars (skbio.sequence.grammaredsequence attribute)": [[195, "skbio.sequence.GrammaredSequence.gap_chars", false]], "gap_chars (skbio.sequence.protein attribute)": [[215, "skbio.sequence.Protein.gap_chars", false]], "gap_chars (skbio.sequence.rna attribute)": [[221, "skbio.sequence.RNA.gap_chars", false]], "gap_frequencies() (skbio.alignment.tabularmsa method)": [[27, "skbio.alignment.TabularMSA.gap_frequencies", false]], "gaps() (skbio.sequence.grammaredsequence method)": [[201, "skbio.sequence.GrammaredSequence.gaps", false]], "gc_content() (skbio.sequence.nucleotidemixin method)": [[211, "skbio.sequence.NucleotideMixin.gc_content", false]], "gc_frequency() (skbio.sequence.nucleotidemixin method)": [[212, "skbio.sequence.NucleotideMixin.gc_frequency", false]], "geneticcode (class in skbio.sequence)": [[191, "skbio.sequence.GeneticCode", false]], "get_alpha_diversity_metrics() (in module skbio.diversity)": [[88, "skbio.diversity.get_alpha_diversity_metrics", false]], "get_beta_diversity_metrics() (in module skbio.diversity)": [[89, "skbio.diversity.get_beta_diversity_metrics", false]], "get_column() (skbio.metadata.samplemetadata method)": [[179, "skbio.metadata.SampleMetadata.get_column", false]], "get_data_path() (in module skbio.util)": [[495, "skbio.util.get_data_path", false]], "get_ids() (skbio.metadata.metadatacolumn method)": [[165, "skbio.metadata.MetadataColumn.get_ids", false]], "get_ids() (skbio.metadata.samplemetadata method)": [[180, "skbio.metadata.SampleMetadata.get_ids", false]], "get_missing() (skbio.metadata.metadatacolumn method)": [[166, "skbio.metadata.MetadataColumn.get_missing", false]], "get_names() (skbio.sequence.substitutionmatrix class method)": [[250, "skbio.sequence.SubstitutionMatrix.get_names", false]], "get_reader() (skbio.io.registry.ioregistry method)": [[131, "skbio.io.registry.IORegistry.get_reader", false]], "get_rng() (in module skbio.util)": [[496, "skbio.util.get_rng", false]], "get_sniffer() (skbio.io.registry.ioregistry method)": [[132, "skbio.io.registry.IORegistry.get_sniffer", false]], "get_table_density() (skbio.table.table method)": [[361, "skbio.table.Table.get_table_density", false]], "get_trajectories() (skbio.stats.gradient.gradientanova method)": [[311, "skbio.stats.gradient.GradientANOVA.get_trajectories", false]], "get_value() (skbio.metadata.metadatacolumn method)": [[167, "skbio.metadata.MetadataColumn.get_value", false]], "get_value_by_ids() (skbio.table.table method)": [[362, "skbio.table.Table.get_value_by_ids", false]], "get_writer() (skbio.io.registry.ioregistry method)": [[133, "skbio.io.registry.IORegistry.get_writer", false]], "gini_index() (in module skbio.diversity.alpha)": [[55, "skbio.diversity.alpha.gini_index", false]], "global_pairwise_align() (in module skbio.alignment)": [[35, "skbio.alignment.global_pairwise_align", false]], "global_pairwise_align_nucleotide() (in module skbio.alignment)": [[36, "skbio.alignment.global_pairwise_align_nucleotide", false]], "global_pairwise_align_protein() (in module skbio.alignment)": [[37, "skbio.alignment.global_pairwise_align_protein", false]], "gme() (in module skbio.tree)": [[478, "skbio.tree.gme", false]], "goods_coverage() (in module skbio.diversity.alpha)": [[56, "skbio.diversity.alpha.goods_coverage", false]], "gradientanova (class in skbio.stats.gradient)": [[310, "skbio.stats.gradient.GradientANOVA", false]], "gradientanovaresults (class in skbio.stats.gradient)": [[312, "skbio.stats.gradient.GradientANOVAResults", false]], "grammaredsequence (class in skbio.sequence)": [[195, "skbio.sequence.GrammaredSequence", false]], "group_metadata() (skbio.table.table method)": [[363, "skbio.table.Table.group_metadata", false]], "groupresults (class in skbio.stats.gradient)": [[314, "skbio.stats.gradient.GroupResults", false]], "hamming() (in module skbio.sequence.distance)": [[254, "skbio.sequence.distance.hamming", false]], "has_caches() (skbio.tree.treenode method)": [[431, "skbio.tree.TreeNode.has_caches", false]], "has_children() (skbio.tree.treenode method)": [[432, "skbio.tree.TreeNode.has_children", false]], "has_definites() (skbio.sequence.grammaredsequence method)": [[202, "skbio.sequence.GrammaredSequence.has_definites", false]], "has_degenerates() (skbio.sequence.grammaredsequence method)": [[203, "skbio.sequence.GrammaredSequence.has_degenerates", false]], "has_gaps() (skbio.sequence.grammaredsequence method)": [[204, "skbio.sequence.GrammaredSequence.has_gaps", false]], "has_interval_metadata() (skbio.metadata.intervalmetadatamixin method)": [[161, "skbio.metadata.IntervalMetadataMixin.has_interval_metadata", false]], "has_metadata() (skbio.metadata.metadatamixin method)": [[172, "skbio.metadata.MetadataMixin.has_metadata", false]], "has_missing_values() (skbio.metadata.metadatacolumn method)": [[168, "skbio.metadata.MetadataColumn.has_missing_values", false]], "has_nondegenerates() (skbio.sequence.grammaredsequence method)": [[205, "skbio.sequence.GrammaredSequence.has_nondegenerates", false]], "has_positional_metadata() (skbio.metadata.positionalmetadatamixin method)": [[175, "skbio.metadata.PositionalMetadataMixin.has_positional_metadata", false]], "has_stops() (skbio.sequence.protein method)": [[217, "skbio.sequence.Protein.has_stops", false]], "head() (skbio.table.table method)": [[364, "skbio.table.Table.head", false]], "height() (skbio.tree.treenode method)": [[433, "skbio.tree.TreeNode.height", false]], "heip_e() (in module skbio.diversity.alpha)": [[57, "skbio.diversity.alpha.heip_e", false]], "highest_priority (skbio.workflow.method attribute)": [[503, "skbio.workflow.method.highest_priority", false]], "hill() (in module skbio.diversity.alpha)": [[58, "skbio.diversity.alpha.hill", false]], "hommola_cospeciation() (in module skbio.stats.evolve)": [[304, "skbio.stats.evolve.hommola_cospeciation", false]], "identity() (skbio.sequence.substitutionmatrix class method)": [[251, "skbio.sequence.SubstitutionMatrix.identity", false]], "ids (skbio.embedding.embedding attribute)": [[91, "skbio.embedding.Embedding.ids", false]], "ids (skbio.stats.distance.dissimilaritymatrix attribute)": [[277, "skbio.stats.distance.DissimilarityMatrix.ids", false]], "ids() (skbio.table.table method)": [[365, "skbio.table.Table.ids", false]], "iloc (skbio.alignment.tabularmsa attribute)": [[20, "skbio.alignment.TabularMSA.iloc", false]], "ilr() (in module skbio.stats.composition)": [[265, "skbio.stats.composition.ilr", false]], "ilr_inv() (in module skbio.stats.composition)": [[266, "skbio.stats.composition.ilr_inv", false]], "index (skbio.alignment.tabularmsa attribute)": [[20, "skbio.alignment.TabularMSA.index", false]], "index() (skbio.sequence.sequence method)": [[234, "skbio.sequence.Sequence.index", false]], "index() (skbio.stats.distance.dissimilaritymatrix method)": [[282, "skbio.stats.distance.DissimilarityMatrix.index", false]], "index() (skbio.table.table method)": [[366, "skbio.table.Table.index", false]], "index_tree() (skbio.tree.treenode method)": [[434, "skbio.tree.TreeNode.index_tree", false]], "initialize_state() (skbio.workflow.workflow method)": [[502, "skbio.workflow.Workflow.initialize_state", false]], "inner() (in module skbio.stats.composition)": [[267, "skbio.stats.composition.inner", false]], "insert() (skbio.tree.treenode method)": [[435, "skbio.tree.TreeNode.insert", false]], "interval (class in skbio.metadata)": [[149, "skbio.metadata.Interval", false]], "interval_metadata (skbio.metadata.intervalmetadatamixin attribute)": [[160, "skbio.metadata.IntervalMetadataMixin.interval_metadata", false]], "intervalmetadata (class in skbio.metadata)": [[151, "skbio.metadata.IntervalMetadata", false]], "intervalmetadatamixin (class in skbio.metadata)": [[160, "skbio.metadata.IntervalMetadataMixin", false]], "inv_simpson() (in module skbio.diversity.alpha)": [[59, "skbio.diversity.alpha.inv_simpson", false]], "ioregistry (class in skbio.io.registry)": [[128, "skbio.io.registry.IORegistry", false]], "is_ascii (skbio.sequence.substitutionmatrix attribute)": [[247, "skbio.sequence.SubstitutionMatrix.is_ascii", false]], "is_bifurcating() (skbio.tree.treenode method)": [[436, "skbio.tree.TreeNode.is_bifurcating", false]], "is_binary_format (skbio.io.registry.format attribute)": [[124, "skbio.io.registry.Format.is_binary_format", false]], "is_empty() (skbio.table.table method)": [[367, "skbio.table.Table.is_empty", false]], "is_reverse_complement() (skbio.sequence.nucleotidemixin method)": [[213, "skbio.sequence.NucleotideMixin.is_reverse_complement", false]], "is_root() (skbio.tree.treenode method)": [[437, "skbio.tree.TreeNode.is_root", false]], "is_tip() (skbio.tree.treenode method)": [[438, "skbio.tree.TreeNode.is_tip", false]], "is_zero_based() (skbio.alignment.alignmentstructure method)": [[12, "skbio.alignment.AlignmentStructure.is_zero_based", false]], "isubsample() (in module skbio.stats)": [[318, "skbio.stats.isubsample", false]], "iter() (skbio.table.table method)": [[368, "skbio.table.Table.iter", false]], "iter_contiguous() (skbio.sequence.sequence method)": [[235, "skbio.sequence.Sequence.iter_contiguous", false]], "iter_data() (skbio.table.table method)": [[369, "skbio.table.Table.iter_data", false]], "iter_kmers() (skbio.sequence.sequence method)": [[236, "skbio.sequence.Sequence.iter_kmers", false]], "iter_pairwise() (skbio.table.table method)": [[370, "skbio.table.Table.iter_pairwise", false]], "iter_positions() (skbio.alignment.tabularmsa method)": [[28, "skbio.alignment.TabularMSA.iter_positions", false]], "join() (skbio.alignment.tabularmsa method)": [[29, "skbio.alignment.TabularMSA.join", false]], "kempton_taylor_q() (in module skbio.diversity.alpha)": [[60, "skbio.diversity.alpha.kempton_taylor_q", false]], "kmer_distance() (in module skbio.sequence.distance)": [[255, "skbio.sequence.distance.kmer_distance", false]], "kmer_frequencies() (skbio.sequence.sequence method)": [[237, "skbio.sequence.Sequence.kmer_frequencies", false]], "lca() (skbio.tree.treenode method)": [[439, "skbio.tree.TreeNode.lca", false]], "length() (skbio.table.table method)": [[371, "skbio.table.Table.length", false]], "lengths (skbio.alignment.alignpath attribute)": [[3, "skbio.alignment.AlignPath.lengths", false]], "levelorder() (skbio.tree.treenode method)": [[440, "skbio.tree.TreeNode.levelorder", false]], "list_read_formats() (skbio.io.registry.ioregistry method)": [[134, "skbio.io.registry.IORegistry.list_read_formats", false]], "list_write_formats() (skbio.io.registry.ioregistry method)": [[135, "skbio.io.registry.IORegistry.list_write_formats", false]], "lladser_ci() (in module skbio.diversity.alpha)": [[61, "skbio.diversity.alpha.lladser_ci", false]], "lladser_pe() (in module skbio.diversity.alpha)": [[62, "skbio.diversity.alpha.lladser_pe", false]], "load() (skbio.metadata.samplemetadata class method)": [[181, "skbio.metadata.SampleMetadata.load", false]], "loc (skbio.alignment.tabularmsa attribute)": [[20, "skbio.alignment.TabularMSA.loc", false]], "local_pairwise_align() (in module skbio.alignment)": [[38, "skbio.alignment.local_pairwise_align", false]], "local_pairwise_align_nucleotide() (in module skbio.alignment)": [[39, "skbio.alignment.local_pairwise_align_nucleotide", false]], "local_pairwise_align_protein() (in module skbio.alignment)": [[40, "skbio.alignment.local_pairwise_align_protein", false]], "local_pairwise_align_ssw() (in module skbio.alignment)": [[41, "skbio.alignment.local_pairwise_align_ssw", false]], "lower_bound (skbio.metadata.intervalmetadata attribute)": [[151, "skbio.metadata.IntervalMetadata.lower_bound", false]], "lowercase() (skbio.sequence.sequence method)": [[238, "skbio.sequence.Sequence.lowercase", false]], "majority_rule() (in module skbio.tree)": [[479, "skbio.tree.majority_rule", false]], "make_identity_substitution_matrix() (in module skbio.alignment)": [[42, "skbio.alignment.make_identity_substitution_matrix", false]], "mantel() (in module skbio.stats.distance)": [[298, "skbio.stats.distance.mantel", false]], "margalef() (in module skbio.diversity.alpha)": [[63, "skbio.diversity.alpha.margalef", false]], "match_frequency() (skbio.sequence.sequence method)": [[239, "skbio.sequence.Sequence.match_frequency", false]], "matches() (skbio.sequence.sequence method)": [[240, "skbio.sequence.Sequence.matches", false]], "matrix_data (skbio.table.table attribute)": [[342, "skbio.table.Table.matrix_data", false]], "max() (skbio.table.table method)": [[372, "skbio.table.Table.max", false]], "maxdist() (skbio.tree.treenode method)": [[441, "skbio.tree.TreeNode.maxdist", false]], "mcintosh_d() (in module skbio.diversity.alpha)": [[64, "skbio.diversity.alpha.mcintosh_d", false]], "mcintosh_e() (in module skbio.diversity.alpha)": [[65, "skbio.diversity.alpha.mcintosh_e", false]], "mean_and_std() (in module skbio.stats.ordination)": [[330, "skbio.stats.ordination.mean_and_std", false]], "menhinick() (in module skbio.diversity.alpha)": [[66, "skbio.diversity.alpha.menhinick", false]], "merge() (skbio.metadata.intervalmetadata method)": [[155, "skbio.metadata.IntervalMetadata.merge", false]], "merge() (skbio.metadata.samplemetadata method)": [[182, "skbio.metadata.SampleMetadata.merge", false]], "merge() (skbio.table.table method)": [[373, "skbio.table.Table.merge", false]], "metadata (skbio.metadata.interval attribute)": [[149, "skbio.metadata.Interval.metadata", false]], "metadata (skbio.metadata.metadatamixin attribute)": [[171, "skbio.metadata.MetadataMixin.metadata", false]], "metadata() (skbio.table.table method)": [[374, "skbio.table.Table.metadata", false]], "metadata_to_dataframe() (skbio.table.table method)": [[375, "skbio.table.Table.metadata_to_dataframe", false]], "metadatacolumn (class in skbio.metadata)": [[162, "skbio.metadata.MetadataColumn", false]], "metadatamixin (class in skbio.metadata)": [[171, "skbio.metadata.MetadataMixin", false]], "method (class in skbio.workflow)": [[503, "skbio.workflow.method", false]], "michaelis_menten_fit() (in module skbio.diversity.alpha)": [[67, "skbio.diversity.alpha.michaelis_menten_fit", false]], "min() (skbio.table.table method)": [[376, "skbio.table.Table.min", false]], "mismatch_frequency() (skbio.sequence.sequence method)": [[241, "skbio.sequence.Sequence.mismatch_frequency", false]], "mismatches() (skbio.sequence.sequence method)": [[242, "skbio.sequence.Sequence.mismatches", false]], "missing_scheme (skbio.metadata.metadatacolumn attribute)": [[162, "skbio.metadata.MetadataColumn.missing_scheme", false]], "module": [[0, "module-skbio.alignment", false], [1, "module-skbio.diversity", false], [2, "module-skbio.embedding", false], [43, "module-skbio.diversity.alpha", false], [83, "module-skbio.diversity.beta", false], [104, "module-skbio.io.format.binary_dm", false], [105, "module-skbio.io.format.biom", false], [106, "module-skbio.io.format.blast6", false], [107, "module-skbio.io.format.blast7", false], [108, "module-skbio.io.format.clustal", false], [109, "module-skbio.io.format.embed", false], [110, "module-skbio.io.format.embl", false], [111, "module-skbio.io.format.fasta", false], [112, "module-skbio.io.format.fastq", false], [113, "module-skbio.io.format.genbank", false], [114, "module-skbio.io.format.gff3", false], [115, "module-skbio.io.format.lsmat", false], [116, "module-skbio.io.format.newick", false], [117, "module-skbio.io.format.ordination", false], [118, "module-skbio.io.format.phylip", false], [119, "module-skbio.io.format.qseq", false], [120, "module-skbio.io.format.sample_metadata", false], [121, "module-skbio.io.format.stockholm", false], [122, "module-skbio.io.format.taxdump", false], [123, "module-skbio.io.registry", false], [144, "module-skbio.io.util", false], [253, "module-skbio.sequence.distance", false], [256, "module-skbio.stats.composition", false], [276, "module-skbio.stats.distance", false], [303, "module-skbio.stats.evolve", false], [305, "module-skbio.stats.gradient", false], [319, "module-skbio.stats.ordination", false], [336, "module-skbio.stats.power", false], [506, "module-skbio.io", false], [507, "module-skbio.metadata", false], [508, "module-skbio.sequence", false], [509, "module-skbio.stats", false], [510, "module-skbio.table", false], [511, "module-skbio.tree", false], [512, "module-skbio.util", false], [513, "module-skbio.workflow", false]], "multi_replace() (in module skbio.stats.composition)": [[268, "skbio.stats.composition.multi_replace", false]], "name (skbio.io.registry.format attribute)": [[124, "skbio.io.registry.Format.name", false]], "name (skbio.metadata.metadatacolumn attribute)": [[162, "skbio.metadata.MetadataColumn.name", false]], "name (skbio.sequence.geneticcode attribute)": [[191, "skbio.sequence.GeneticCode.name", false]], "neighbors() (skbio.tree.treenode method)": [[442, "skbio.tree.TreeNode.neighbors", false]], "nj() (in module skbio.tree)": [[480, "skbio.tree.nj", false]], "nni() (in module skbio.tree)": [[481, "skbio.tree.nni", false]], "nnz (skbio.table.table attribute)": [[342, "skbio.table.Table.nnz", false]], "non_tips() (skbio.tree.treenode method)": [[443, "skbio.tree.TreeNode.non_tips", false]], "noncanonical_chars (skbio.sequence.grammaredsequence attribute)": [[195, "skbio.sequence.GrammaredSequence.noncanonical_chars", false]], "noncanonical_chars (skbio.sequence.protein attribute)": [[215, "skbio.sequence.Protein.noncanonical_chars", false]], "nondegenerate_chars (skbio.sequence.grammaredsequence attribute)": [[195, "skbio.sequence.GrammaredSequence.nondegenerate_chars", false]], "nondegenerates() (skbio.sequence.grammaredsequence method)": [[206, "skbio.sequence.GrammaredSequence.nondegenerates", false]], "nonzero() (skbio.table.table method)": [[377, "skbio.table.Table.nonzero", false]], "nonzero_counts() (skbio.table.table method)": [[378, "skbio.table.Table.nonzero_counts", false]], "norm() (skbio.table.table method)": [[379, "skbio.table.Table.norm", false]], "nucleotidemixin (class in skbio.sequence)": [[209, "skbio.sequence.NucleotideMixin", false]], "num_interval_features (skbio.metadata.intervalmetadata attribute)": [[151, "skbio.metadata.IntervalMetadata.num_interval_features", false]], "numericmetadatacolumn (class in skbio.metadata)": [[173, "skbio.metadata.NumericMetadataColumn", false]], "observed_chars (skbio.sequence.sequence attribute)": [[228, "skbio.sequence.Sequence.observed_chars", false]], "observed_features() (in module skbio.diversity.alpha)": [[68, "skbio.diversity.alpha.observed_features", false]], "observed_node_counts() (skbio.tree.treenode method)": [[444, "skbio.tree.TreeNode.observed_node_counts", false]], "open() (in module skbio.io.util)": [[145, "skbio.io.util.open", false]], "open_file() (in module skbio.io.util)": [[146, "skbio.io.util.open_file", false]], "open_files() (in module skbio.io.util)": [[147, "skbio.io.util.open_files", false]], "optimal_alignment_score (skbio.alignment.alignmentstructure attribute)": [[11, "skbio.alignment.AlignmentStructure.optimal_alignment_score", false]], "ordinationresults (class in skbio.stats.ordination)": [[320, "skbio.stats.ordination.OrdinationResults", false]], "osd() (in module skbio.diversity.alpha)": [[69, "skbio.diversity.alpha.osd", false]], "overrides() (in module skbio.util)": [[497, "skbio.util.overrides", false]], "pa() (skbio.table.table method)": [[380, "skbio.table.Table.pa", false]], "pairalignpath (class in skbio.alignment)": [[14, "skbio.alignment.PairAlignPath", false]], "paired_subsamples() (in module skbio.stats.power)": [[338, "skbio.stats.power.paired_subsamples", false]], "pairwise_vlr() (in module skbio.stats.composition)": [[269, "skbio.stats.composition.pairwise_vlr", false]], "params_aliased() (in module skbio.util)": [[498, "skbio.util.params_aliased", false]], "partial_beta_diversity() (in module skbio.diversity)": [[90, "skbio.diversity.partial_beta_diversity", false]], "partition() (skbio.table.table method)": [[381, "skbio.table.Table.partition", false]], "path() (skbio.tree.treenode method)": [[445, "skbio.tree.TreeNode.path", false]], "path_dists() (in module skbio.tree)": [[482, "skbio.tree.path_dists", false]], "pcoa() (in module skbio.stats.ordination)": [[331, "skbio.stats.ordination.pcoa", false]], "pcoa_biplot() (in module skbio.stats.ordination)": [[332, "skbio.stats.ordination.pcoa_biplot", false]], "permanova() (in module skbio.stats.distance)": [[299, "skbio.stats.distance.permanova", false]], "permdisp() (in module skbio.stats.distance)": [[300, "skbio.stats.distance.permdisp", false]], "permute() (skbio.stats.distance.distancematrix method)": [[294, "skbio.stats.distance.DistanceMatrix.permute", false]], "perturb() (in module skbio.stats.composition)": [[270, "skbio.stats.composition.perturb", false]], "perturb_inv() (in module skbio.stats.composition)": [[271, "skbio.stats.composition.perturb_inv", false]], "phydiv() (in module skbio.diversity.alpha)": [[70, "skbio.diversity.alpha.phydiv", false]], "pielou_e() (in module skbio.diversity.alpha)": [[71, "skbio.diversity.alpha.pielou_e", false]], "plot() (skbio.stats.distance.dissimilaritymatrix method)": [[283, "skbio.stats.distance.DissimilarityMatrix.plot", false]], "plot() (skbio.stats.ordination.ordinationresults method)": [[321, "skbio.stats.ordination.OrdinationResults.plot", false]], "plottablemixin (class in skbio.util)": [[486, "skbio.util.PlottableMixin", false]], "png (skbio.util.plottablemixin attribute)": [[486, "skbio.util.PlottableMixin.png", false]], "pop() (skbio.tree.treenode method)": [[446, "skbio.tree.TreeNode.pop", false]], "positional_metadata (skbio.metadata.positionalmetadatamixin attribute)": [[174, "skbio.metadata.PositionalMetadataMixin.positional_metadata", false]], "positionalmetadatamixin (class in skbio.metadata)": [[174, "skbio.metadata.PositionalMetadataMixin", false]], "postorder() (skbio.tree.treenode method)": [[447, "skbio.tree.TreeNode.postorder", false]], "power() (in module skbio.stats.composition)": [[272, "skbio.stats.composition.power", false]], "pre_and_postorder() (skbio.tree.treenode method)": [[448, "skbio.tree.TreeNode.pre_and_postorder", false]], "preorder() (skbio.tree.treenode method)": [[449, "skbio.tree.TreeNode.preorder", false]], "protein (class in skbio.sequence)": [[215, "skbio.sequence.Protein", false]], "proteinembedding (class in skbio.embedding)": [[96, "skbio.embedding.ProteinEmbedding", false]], "proteinvector (class in skbio.embedding)": [[97, "skbio.embedding.ProteinVector", false]], "prune() (skbio.tree.treenode method)": [[450, "skbio.tree.TreeNode.prune", false]], "pwmantel() (in module skbio.stats.distance)": [[301, "skbio.stats.distance.pwmantel", false]], "query() (skbio.metadata.intervalmetadata method)": [[156, "skbio.metadata.IntervalMetadata.query", false]], "query_begin (skbio.alignment.alignmentstructure attribute)": [[11, "skbio.alignment.AlignmentStructure.query_begin", false]], "query_end (skbio.alignment.alignmentstructure attribute)": [[11, "skbio.alignment.AlignmentStructure.query_end", false]], "query_sequence (skbio.alignment.alignmentstructure attribute)": [[11, "skbio.alignment.AlignmentStructure.query_sequence", false]], "randdm() (in module skbio.stats.distance)": [[302, "skbio.stats.distance.randdm", false]], "rankdata() (skbio.table.table method)": [[382, "skbio.table.Table.rankdata", false]], "rda() (in module skbio.stats.ordination)": [[333, "skbio.stats.ordination.rda", false]], "read() (in module skbio.io.registry)": [[141, "skbio.io.registry.read", false]], "read() (skbio.alignment.tabularmsa method)": [[30, "skbio.alignment.TabularMSA.read", false]], "read() (skbio.embedding.embedding method)": [[93, "skbio.embedding.Embedding.read", false]], "read() (skbio.io.registry.ioregistry method)": [[136, "skbio.io.registry.IORegistry.read", false]], "read() (skbio.metadata.intervalmetadata method)": [[157, "skbio.metadata.IntervalMetadata.read", false]], "read() (skbio.sequence.dna method)": [[186, "skbio.sequence.DNA.read", false]], "read() (skbio.sequence.protein method)": [[218, "skbio.sequence.Protein.read", false]], "read() (skbio.sequence.rna method)": [[223, "skbio.sequence.RNA.read", false]], "read() (skbio.sequence.sequence method)": [[243, "skbio.sequence.Sequence.read", false]], "read() (skbio.stats.distance.dissimilaritymatrix method)": [[284, "skbio.stats.distance.DissimilarityMatrix.read", false]], "read() (skbio.stats.ordination.ordinationresults method)": [[322, "skbio.stats.ordination.OrdinationResults.read", false]], "read() (skbio.table.table method)": [[383, "skbio.table.Table.read", false]], "read() (skbio.tree.treenode method)": [[451, "skbio.tree.TreeNode.read", false]], "reader() (skbio.io.registry.format method)": [[125, "skbio.io.registry.Format.reader", false]], "readers (skbio.io.registry.format attribute)": [[124, "skbio.io.registry.Format.readers", false]], "reading_frames (skbio.sequence.geneticcode attribute)": [[191, "skbio.sequence.GeneticCode.reading_frames", false]], "reassign_index() (skbio.alignment.tabularmsa method)": [[31, "skbio.alignment.TabularMSA.reassign_index", false]], "reduce() (skbio.table.table method)": [[384, "skbio.table.Table.reduce", false]], "redundant_form() (skbio.stats.distance.dissimilaritymatrix method)": [[285, "skbio.stats.distance.DissimilarityMatrix.redundant_form", false]], "register_aliases() (in module skbio.util)": [[499, "skbio.util.register_aliases", false]], "remove() (skbio.tree.treenode method)": [[452, "skbio.tree.TreeNode.remove", false]], "remove_by_func() (skbio.tree.treenode method)": [[453, "skbio.tree.TreeNode.remove_by_func", false]], "remove_deleted() (skbio.tree.treenode method)": [[454, "skbio.tree.TreeNode.remove_deleted", false]], "remove_empty() (skbio.table.table method)": [[385, "skbio.table.Table.remove_empty", false]], "remove_format() (skbio.io.registry.ioregistry method)": [[137, "skbio.io.registry.IORegistry.remove_format", false]], "rename() (skbio.stats.distance.dissimilaritymatrix method)": [[286, "skbio.stats.distance.DissimilarityMatrix.rename", false]], "rename() (skbio.stats.ordination.ordinationresults method)": [[323, "skbio.stats.ordination.OrdinationResults.rename", false]], "renyi() (in module skbio.diversity.alpha)": [[72, "skbio.diversity.alpha.renyi", false]], "replace() (skbio.sequence.sequence method)": [[244, "skbio.sequence.Sequence.replace", false]], "requires (class in skbio.workflow)": [[504, "skbio.workflow.requires", false]], "residues (skbio.embedding.proteinembedding attribute)": [[96, "skbio.embedding.ProteinEmbedding.residues", false]], "reverse_complement() (skbio.sequence.nucleotidemixin method)": [[214, "skbio.sequence.NucleotideMixin.reverse_complement", false]], "reverse_transcribe() (skbio.sequence.rna method)": [[224, "skbio.sequence.RNA.reverse_transcribe", false]], "rf_dists() (in module skbio.tree)": [[483, "skbio.tree.rf_dists", false]], "rna (class in skbio.sequence)": [[221, "skbio.sequence.RNA", false]], "robbins() (in module skbio.diversity.alpha)": [[73, "skbio.diversity.alpha.robbins", false]], "root() (skbio.tree.treenode method)": [[455, "skbio.tree.TreeNode.root", false]], "root_at() (skbio.tree.treenode method)": [[456, "skbio.tree.TreeNode.root_at", false]], "root_at_midpoint() (skbio.tree.treenode method)": [[457, "skbio.tree.TreeNode.root_at_midpoint", false]], "root_by_outgroup() (skbio.tree.treenode method)": [[458, "skbio.tree.TreeNode.root_by_outgroup", false]], "safe_md5() (in module skbio.util)": [[500, "skbio.util.safe_md5", false]], "samplemetadata (class in skbio.metadata)": [[176, "skbio.metadata.SampleMetadata", false]], "sbp_basis() (in module skbio.stats.composition)": [[273, "skbio.stats.composition.sbp_basis", false]], "scale() (in module skbio.stats.ordination)": [[334, "skbio.stats.ordination.scale", false]], "scores (skbio.sequence.substitutionmatrix attribute)": [[247, "skbio.sequence.SubstitutionMatrix.scores", false]], "sequence (class in skbio.sequence)": [[228, "skbio.sequence.Sequence", false]], "sequence (skbio.embedding.sequenceembedding attribute)": [[98, "skbio.embedding.SequenceEmbedding.sequence", false]], "sequence (skbio.embedding.sequencevector attribute)": [[99, "skbio.embedding.SequenceVector.sequence", false]], "sequenceembedding (class in skbio.embedding)": [[98, "skbio.embedding.SequenceEmbedding", false]], "sequencevector (class in skbio.embedding)": [[99, "skbio.embedding.SequenceVector", false]], "set_zero_based() (skbio.alignment.alignmentstructure method)": [[13, "skbio.alignment.AlignmentStructure.set_zero_based", false]], "shannon() (in module skbio.diversity.alpha)": [[74, "skbio.diversity.alpha.shannon", false]], "shape (skbio.alignment.alignpath attribute)": [[3, "skbio.alignment.AlignPath.shape", false]], "shape (skbio.alignment.tabularmsa attribute)": [[20, "skbio.alignment.TabularMSA.shape", false]], "shape (skbio.stats.distance.dissimilaritymatrix attribute)": [[277, "skbio.stats.distance.DissimilarityMatrix.shape", false]], "shape (skbio.table.table attribute)": [[342, "skbio.table.Table.shape", false]], "shear() (skbio.tree.treenode method)": [[459, "skbio.tree.TreeNode.shear", false]], "shuffle() (skbio.tree.treenode method)": [[460, "skbio.tree.TreeNode.shuffle", false]], "siblings() (skbio.tree.treenode method)": [[461, "skbio.tree.TreeNode.siblings", false]], "simpson() (in module skbio.diversity.alpha)": [[75, "skbio.diversity.alpha.simpson", false]], "simpson_d() (in module skbio.diversity.alpha)": [[76, "skbio.diversity.alpha.simpson_d", false]], "simpson_e() (in module skbio.diversity.alpha)": [[77, "skbio.diversity.alpha.simpson_e", false]], "singles() (in module skbio.diversity.alpha)": [[78, "skbio.diversity.alpha.singles", false]], "size (skbio.stats.distance.dissimilaritymatrix attribute)": [[277, "skbio.stats.distance.DissimilarityMatrix.size", false]], "skbio.alignment": [[0, "module-skbio.alignment", false]], "skbio.diversity": [[1, "module-skbio.diversity", false]], "skbio.diversity.alpha": [[43, "module-skbio.diversity.alpha", false]], "skbio.diversity.beta": [[83, "module-skbio.diversity.beta", false]], "skbio.embedding": [[2, "module-skbio.embedding", false]], "skbio.io": [[506, "module-skbio.io", false]], "skbio.io.format.binary_dm": [[104, "module-skbio.io.format.binary_dm", false]], "skbio.io.format.biom": [[105, "module-skbio.io.format.biom", false]], "skbio.io.format.blast6": [[106, "module-skbio.io.format.blast6", false]], "skbio.io.format.blast7": [[107, "module-skbio.io.format.blast7", false]], "skbio.io.format.clustal": [[108, "module-skbio.io.format.clustal", false]], "skbio.io.format.embed": [[109, "module-skbio.io.format.embed", false]], "skbio.io.format.embl": [[110, "module-skbio.io.format.embl", false]], "skbio.io.format.fasta": [[111, "module-skbio.io.format.fasta", false]], "skbio.io.format.fastq": [[112, "module-skbio.io.format.fastq", false]], "skbio.io.format.genbank": [[113, "module-skbio.io.format.genbank", false]], "skbio.io.format.gff3": [[114, "module-skbio.io.format.gff3", false]], "skbio.io.format.lsmat": [[115, "module-skbio.io.format.lsmat", false]], "skbio.io.format.newick": [[116, "module-skbio.io.format.newick", false]], "skbio.io.format.ordination": [[117, "module-skbio.io.format.ordination", false]], "skbio.io.format.phylip": [[118, "module-skbio.io.format.phylip", false]], "skbio.io.format.qseq": [[119, "module-skbio.io.format.qseq", false]], "skbio.io.format.sample_metadata": [[120, "module-skbio.io.format.sample_metadata", false]], "skbio.io.format.stockholm": [[121, "module-skbio.io.format.stockholm", false]], "skbio.io.format.taxdump": [[122, "module-skbio.io.format.taxdump", false]], "skbio.io.registry": [[123, "module-skbio.io.registry", false]], "skbio.io.util": [[144, "module-skbio.io.util", false]], "skbio.metadata": [[507, "module-skbio.metadata", false]], "skbio.sequence": [[508, "module-skbio.sequence", false]], "skbio.sequence.distance": [[253, "module-skbio.sequence.distance", false]], "skbio.stats": [[509, "module-skbio.stats", false]], "skbio.stats.composition": [[256, "module-skbio.stats.composition", false]], "skbio.stats.distance": [[276, "module-skbio.stats.distance", false]], "skbio.stats.evolve": [[303, "module-skbio.stats.evolve", false]], "skbio.stats.gradient": [[305, "module-skbio.stats.gradient", false]], "skbio.stats.ordination": [[319, "module-skbio.stats.ordination", false]], "skbio.stats.power": [[336, "module-skbio.stats.power", false]], "skbio.table": [[510, "module-skbio.table", false]], "skbio.tree": [[511, "module-skbio.tree", false]], "skbio.util": [[512, "module-skbio.util", false]], "skbio.workflow": [[513, "module-skbio.workflow", false]], "sniff() (in module skbio.io.registry)": [[142, "skbio.io.registry.sniff", false]], "sniff() (skbio.io.registry.ioregistry method)": [[138, "skbio.io.registry.IORegistry.sniff", false]], "sniffer() (skbio.io.registry.format method)": [[126, "skbio.io.registry.Format.sniffer", false]], "sniffer_function (skbio.io.registry.format attribute)": [[124, "skbio.io.registry.Format.sniffer_function", false]], "sobs() (in module skbio.diversity.alpha)": [[79, "skbio.diversity.alpha.sobs", false]], "sort() (skbio.alignment.tabularmsa method)": [[32, "skbio.alignment.TabularMSA.sort", false]], "sort() (skbio.metadata.intervalmetadata method)": [[158, "skbio.metadata.IntervalMetadata.sort", false]], "sort() (skbio.table.table method)": [[386, "skbio.table.Table.sort", false]], "sort_order() (skbio.table.table method)": [[387, "skbio.table.Table.sort_order", false]], "starts (skbio.alignment.alignpath attribute)": [[3, "skbio.alignment.AlignPath.starts", false]], "states (skbio.alignment.alignpath attribute)": [[3, "skbio.alignment.AlignPath.states", false]], "stop_chars (skbio.sequence.protein attribute)": [[215, "skbio.sequence.Protein.stop_chars", false]], "stops() (skbio.sequence.protein method)": [[219, "skbio.sequence.Protein.stops", false]], "stripedsmithwaterman (class in skbio.alignment)": [[19, "skbio.alignment.StripedSmithWaterman", false]], "strong() (in module skbio.diversity.alpha)": [[80, "skbio.diversity.alpha.strong", false]], "suboptimal_alignment_score (skbio.alignment.alignmentstructure attribute)": [[11, "skbio.alignment.AlignmentStructure.suboptimal_alignment_score", false]], "subsample() (skbio.table.table method)": [[388, "skbio.table.Table.subsample", false]], "subsample_counts() (in module skbio.stats)": [[341, "skbio.stats.subsample_counts", false]], "subsample_paired_power() (in module skbio.stats.power)": [[339, "skbio.stats.power.subsample_paired_power", false]], "subsample_power() (in module skbio.stats.power)": [[340, "skbio.stats.power.subsample_power", false]], "subset() (skbio.tree.treenode method)": [[462, "skbio.tree.TreeNode.subset", false]], "subsets() (skbio.tree.treenode method)": [[463, "skbio.tree.TreeNode.subsets", false]], "substitutionmatrix (class in skbio.sequence)": [[247, "skbio.sequence.SubstitutionMatrix", false]], "subtree() (skbio.tree.treenode method)": [[464, "skbio.tree.TreeNode.subtree", false]], "sum() (skbio.table.table method)": [[389, "skbio.table.Table.sum", false]], "svd_rank() (in module skbio.stats.ordination)": [[335, "skbio.stats.ordination.svd_rank", false]], "svg (skbio.util.plottablemixin attribute)": [[486, "skbio.util.PlottableMixin.svg", false]], "t (skbio.stats.distance.dissimilaritymatrix attribute)": [[277, "skbio.stats.distance.DissimilarityMatrix.T", false]], "table (class in skbio.table)": [[342, "skbio.table.Table", false]], "tabularmsa (class in skbio.alignment)": [[20, "skbio.alignment.TabularMSA", false]], "target_begin (skbio.alignment.alignmentstructure attribute)": [[11, "skbio.alignment.AlignmentStructure.target_begin", false]], "target_end_optimal (skbio.alignment.alignmentstructure attribute)": [[11, "skbio.alignment.AlignmentStructure.target_end_optimal", false]], "target_end_suboptimal (skbio.alignment.alignmentstructure attribute)": [[11, "skbio.alignment.AlignmentStructure.target_end_suboptimal", false]], "target_sequence (skbio.alignment.alignmentstructure attribute)": [[11, "skbio.alignment.AlignmentStructure.target_sequence", false]], "tips() (skbio.tree.treenode method)": [[465, "skbio.tree.TreeNode.tips", false]], "to_anndata() (skbio.table.table method)": [[390, "skbio.table.Table.to_anndata", false]], "to_array() (skbio.tree.treenode method)": [[466, "skbio.tree.TreeNode.to_array", false]], "to_bits() (skbio.alignment.alignpath method)": [[8, "skbio.alignment.AlignPath.to_bits", false]], "to_bits() (skbio.alignment.pairalignpath method)": [[17, "skbio.alignment.PairAlignPath.to_bits", false]], "to_cigar() (skbio.alignment.pairalignpath method)": [[18, "skbio.alignment.PairAlignPath.to_cigar", false]], "to_coordinates() (skbio.alignment.alignpath method)": [[9, "skbio.alignment.AlignPath.to_coordinates", false]], "to_data_frame() (skbio.stats.distance.dissimilaritymatrix method)": [[287, "skbio.stats.distance.DissimilarityMatrix.to_data_frame", false]], "to_dataframe() (skbio.metadata.metadatacolumn method)": [[169, "skbio.metadata.MetadataColumn.to_dataframe", false]], "to_dataframe() (skbio.metadata.samplemetadata method)": [[183, "skbio.metadata.SampleMetadata.to_dataframe", false]], "to_dataframe() (skbio.table.table method)": [[391, "skbio.table.Table.to_dataframe", false]], "to_definites() (skbio.sequence.grammaredsequence method)": [[207, "skbio.sequence.GrammaredSequence.to_definites", false]], "to_dict() (skbio.alignment.tabularmsa method)": [[33, "skbio.alignment.TabularMSA.to_dict", false]], "to_dict() (skbio.sequence.substitutionmatrix method)": [[252, "skbio.sequence.SubstitutionMatrix.to_dict", false]], "to_files() (skbio.stats.gradient.categoryresults method)": [[308, "skbio.stats.gradient.CategoryResults.to_files", false]], "to_files() (skbio.stats.gradient.gradientanovaresults method)": [[313, "skbio.stats.gradient.GradientANOVAResults.to_files", false]], "to_files() (skbio.stats.gradient.groupresults method)": [[315, "skbio.stats.gradient.GroupResults.to_files", false]], "to_hdf5() (skbio.table.table method)": [[392, "skbio.table.Table.to_hdf5", false]], "to_indices() (skbio.alignment.alignpath method)": [[10, "skbio.alignment.AlignPath.to_indices", false]], "to_indices() (skbio.sequence.sequence method)": [[245, "skbio.sequence.Sequence.to_indices", false]], "to_json() (skbio.table.table method)": [[393, "skbio.table.Table.to_json", false]], "to_regex() (skbio.sequence.grammaredsequence method)": [[208, "skbio.sequence.GrammaredSequence.to_regex", false]], "to_series() (skbio.metadata.metadatacolumn method)": [[170, "skbio.metadata.MetadataColumn.to_series", false]], "to_series() (skbio.stats.distance.distancematrix method)": [[295, "skbio.stats.distance.DistanceMatrix.to_series", false]], "to_taxonomy() (skbio.tree.treenode method)": [[467, "skbio.tree.TreeNode.to_taxonomy", false]], "to_tsv() (skbio.table.table method)": [[394, "skbio.table.Table.to_tsv", false]], "total_length() (skbio.tree.treenode method)": [[468, "skbio.tree.TreeNode.total_length", false]], "trajectorygradientanova (class in skbio.stats.gradient)": [[316, "skbio.stats.gradient.TrajectoryGradientANOVA", false]], "transcribe() (skbio.sequence.dna method)": [[187, "skbio.sequence.DNA.transcribe", false]], "transform() (skbio.table.table method)": [[395, "skbio.table.Table.transform", false]], "translate() (skbio.sequence.dna method)": [[188, "skbio.sequence.DNA.translate", false]], "translate() (skbio.sequence.geneticcode method)": [[193, "skbio.sequence.GeneticCode.translate", false]], "translate() (skbio.sequence.rna method)": [[225, "skbio.sequence.RNA.translate", false]], "translate_six_frames() (skbio.sequence.dna method)": [[189, "skbio.sequence.DNA.translate_six_frames", false]], "translate_six_frames() (skbio.sequence.geneticcode method)": [[194, "skbio.sequence.GeneticCode.translate_six_frames", false]], "translate_six_frames() (skbio.sequence.rna method)": [[226, "skbio.sequence.RNA.translate_six_frames", false]], "transpose() (skbio.stats.distance.dissimilaritymatrix method)": [[288, "skbio.stats.distance.DissimilarityMatrix.transpose", false]], "transpose() (skbio.table.table method)": [[396, "skbio.table.Table.transpose", false]], "traverse() (skbio.tree.treenode method)": [[469, "skbio.tree.TreeNode.traverse", false]], "tree_basis() (in module skbio.stats.composition)": [[274, "skbio.stats.composition.tree_basis", false]], "treenode (class in skbio.tree)": [[400, "skbio.tree.TreeNode", false]], "tsallis() (in module skbio.diversity.alpha)": [[81, "skbio.diversity.alpha.tsallis", false]], "type (skbio.metadata.categoricalmetadatacolumn attribute)": [[148, "skbio.metadata.CategoricalMetadataColumn.type", false]], "type (skbio.metadata.metadatacolumn attribute)": [[162, "skbio.metadata.MetadataColumn.type", false]], "type (skbio.metadata.numericmetadatacolumn attribute)": [[173, "skbio.metadata.NumericMetadataColumn.type", false]], "unpack() (skbio.tree.treenode method)": [[470, "skbio.tree.TreeNode.unpack", false]], "unpack_by_func() (skbio.tree.treenode method)": [[471, "skbio.tree.TreeNode.unpack_by_func", false]], "unroot() (skbio.tree.treenode method)": [[472, "skbio.tree.TreeNode.unroot", false]], "unrooted_copy() (skbio.tree.treenode method)": [[473, "skbio.tree.TreeNode.unrooted_copy", false]], "unrooted_deepcopy() (skbio.tree.treenode method)": [[474, "skbio.tree.TreeNode.unrooted_deepcopy", false]], "unrooted_move() (skbio.tree.treenode method)": [[475, "skbio.tree.TreeNode.unrooted_move", false]], "unweighted_unifrac() (in module skbio.diversity.beta)": [[84, "skbio.diversity.beta.unweighted_unifrac", false]], "update_ids() (skbio.table.table method)": [[397, "skbio.table.Table.update_ids", false]], "upgma() (in module skbio.tree)": [[484, "skbio.tree.upgma", false]], "upper_bound (skbio.metadata.intervalmetadata attribute)": [[151, "skbio.metadata.IntervalMetadata.upper_bound", false]], "values (skbio.sequence.sequence attribute)": [[228, "skbio.sequence.Sequence.values", false]], "vector (skbio.embedding.embeddingvector attribute)": [[95, "skbio.embedding.EmbeddingVector.vector", false]], "vlr() (in module skbio.stats.composition)": [[275, "skbio.stats.composition.vlr", false]], "weighted_unifrac() (in module skbio.diversity.beta)": [[85, "skbio.diversity.beta.weighted_unifrac", false]], "wildcard_char (skbio.sequence.dna attribute)": [[184, "skbio.sequence.DNA.wildcard_char", false]], "wildcard_char (skbio.sequence.grammaredsequence attribute)": [[195, "skbio.sequence.GrammaredSequence.wildcard_char", false]], "wildcard_char (skbio.sequence.protein attribute)": [[215, "skbio.sequence.Protein.wildcard_char", false]], "wildcard_char (skbio.sequence.rna attribute)": [[221, "skbio.sequence.RNA.wildcard_char", false]], "windowdifferencegradientanova (class in skbio.stats.gradient)": [[317, "skbio.stats.gradient.WindowDifferenceGradientANOVA", false]], "within() (skbio.stats.distance.dissimilaritymatrix method)": [[289, "skbio.stats.distance.DissimilarityMatrix.within", false]], "workflow (class in skbio.workflow)": [[501, "skbio.workflow.Workflow", false]], "wrf_dists() (in module skbio.tree)": [[485, "skbio.tree.wrf_dists", false]], "write() (in module skbio.io.registry)": [[143, "skbio.io.registry.write", false]], "write() (skbio.alignment.tabularmsa method)": [[34, "skbio.alignment.TabularMSA.write", false]], "write() (skbio.embedding.embedding method)": [[94, "skbio.embedding.Embedding.write", false]], "write() (skbio.io.registry.ioregistry method)": [[139, "skbio.io.registry.IORegistry.write", false]], "write() (skbio.metadata.intervalmetadata method)": [[159, "skbio.metadata.IntervalMetadata.write", false]], "write() (skbio.sequence.dna method)": [[190, "skbio.sequence.DNA.write", false]], "write() (skbio.sequence.protein method)": [[220, "skbio.sequence.Protein.write", false]], "write() (skbio.sequence.rna method)": [[227, "skbio.sequence.RNA.write", false]], "write() (skbio.sequence.sequence method)": [[246, "skbio.sequence.Sequence.write", false]], "write() (skbio.stats.distance.dissimilaritymatrix method)": [[290, "skbio.stats.distance.DissimilarityMatrix.write", false]], "write() (skbio.stats.ordination.ordinationresults method)": [[324, "skbio.stats.ordination.OrdinationResults.write", false]], "write() (skbio.table.table method)": [[398, "skbio.table.Table.write", false]], "write() (skbio.tree.treenode method)": [[476, "skbio.tree.TreeNode.write", false]], "writer() (skbio.io.registry.format method)": [[127, "skbio.io.registry.Format.writer", false]], "writers (skbio.io.registry.format attribute)": [[124, "skbio.io.registry.Format.writers", false]]}, "objects": {"skbio": [[0, 0, 0, "-", "alignment"], [1, 0, 0, "-", "diversity"], [2, 0, 0, "-", "embedding"], [506, 0, 0, "-", "io"], [507, 0, 0, "-", "metadata"], [508, 0, 0, "-", "sequence"], [509, 0, 0, "-", "stats"], [510, 0, 0, "-", "table"], [511, 0, 0, "-", "tree"], [512, 0, 0, "-", "util"], [513, 0, 0, "-", "workflow"]], "skbio.alignment": [[3, 1, 1, "", "AlignPath"], [11, 1, 1, "", "AlignmentStructure"], [14, 1, 1, "", "PairAlignPath"], [19, 1, 1, "", "StripedSmithWaterman"], [20, 1, 1, "", "TabularMSA"], [35, 4, 1, "", "global_pairwise_align"], [36, 4, 1, "", "global_pairwise_align_nucleotide"], [37, 4, 1, "", "global_pairwise_align_protein"], [38, 4, 1, "", "local_pairwise_align"], [39, 4, 1, "", "local_pairwise_align_nucleotide"], [40, 4, 1, "", "local_pairwise_align_protein"], [41, 4, 1, "", "local_pairwise_align_ssw"], [42, 4, 1, "", "make_identity_substitution_matrix"]], "skbio.alignment.AlignPath": [[3, 2, 1, "", "__str__"], [4, 2, 1, "", "from_bits"], [5, 2, 1, "", "from_coordinates"], [6, 2, 1, "", "from_indices"], [7, 2, 1, "", "from_tabular"], [3, 3, 1, "", "lengths"], [3, 3, 1, "", "shape"], [3, 3, 1, "", "starts"], [3, 3, 1, "", "states"], [8, 2, 1, "", "to_bits"], [9, 2, 1, "", "to_coordinates"], [10, 2, 1, "", "to_indices"]], "skbio.alignment.AlignmentStructure": [[11, 2, 1, "", "__getitem__"], [11, 2, 1, "", "__setstate__"], [11, 2, 1, "", "__str__"], [11, 3, 1, "", "aligned_query_sequence"], [11, 3, 1, "", "aligned_target_sequence"], [11, 3, 1, "", "cigar"], [12, 2, 1, "", "is_zero_based"], [11, 3, 1, "", "optimal_alignment_score"], [11, 3, 1, "", "query_begin"], [11, 3, 1, "", "query_end"], [11, 3, 1, "", "query_sequence"], [13, 2, 1, "", "set_zero_based"], [11, 3, 1, "", "suboptimal_alignment_score"], [11, 3, 1, "", "target_begin"], [11, 3, 1, "", "target_end_optimal"], [11, 3, 1, "", "target_end_suboptimal"], [11, 3, 1, "", "target_sequence"]], "skbio.alignment.PairAlignPath": [[14, 2, 1, "", "__str__"], [15, 2, 1, "", "from_bits"], [16, 2, 1, "", "from_cigar"], [17, 2, 1, "", "to_bits"], [18, 2, 1, "", "to_cigar"]], "skbio.alignment.StripedSmithWaterman": [[19, 2, 1, "", "__call__"], [19, 2, 1, "", "__setstate__"]], "skbio.alignment.TabularMSA": [[20, 2, 1, "", "__bool__"], [20, 2, 1, "", "__contains__"], [20, 2, 1, "", "__copy__"], [20, 2, 1, "", "__deepcopy__"], [20, 2, 1, "", "__eq__"], [20, 2, 1, "", "__getitem__"], [20, 2, 1, "", "__iter__"], [20, 2, 1, "", "__len__"], [20, 2, 1, "", "__ne__"], [20, 2, 1, "", "__reversed__"], [20, 2, 1, "", "__str__"], [21, 2, 1, "", "append"], [22, 2, 1, "", "consensus"], [23, 2, 1, "", "conservation"], [20, 3, 1, "", "default_write_format"], [20, 3, 1, "", "dtype"], [24, 2, 1, "", "extend"], [25, 2, 1, "", "from_dict"], [26, 2, 1, "", "from_path_seqs"], [27, 2, 1, "", "gap_frequencies"], [20, 3, 1, "", "iloc"], [20, 3, 1, "", "index"], [28, 2, 1, "", "iter_positions"], [29, 2, 1, "", "join"], [20, 3, 1, "", "loc"], [30, 2, 1, "", "read"], [31, 2, 1, "", "reassign_index"], [20, 3, 1, "", "shape"], [32, 2, 1, "", "sort"], [33, 2, 1, "", "to_dict"], [34, 2, 1, "", "write"]], "skbio.diversity": [[43, 0, 0, "-", "alpha"], [82, 4, 1, "", "alpha_diversity"], [83, 0, 0, "-", "beta"], [86, 4, 1, "", "beta_diversity"], [87, 4, 1, "", "block_beta_diversity"], [88, 4, 1, "", "get_alpha_diversity_metrics"], [89, 4, 1, "", "get_beta_diversity_metrics"], [90, 4, 1, "", "partial_beta_diversity"]], "skbio.diversity.alpha": [[44, 4, 1, "", "ace"], [45, 4, 1, "", "berger_parker_d"], [46, 4, 1, "", "brillouin_d"], [47, 4, 1, "", "chao1"], [48, 4, 1, "", "chao1_ci"], [49, 4, 1, "", "dominance"], [50, 4, 1, "", "doubles"], [51, 4, 1, "", "enspie"], [52, 4, 1, "", "esty_ci"], [53, 4, 1, "", "faith_pd"], [54, 4, 1, "", "fisher_alpha"], [55, 4, 1, "", "gini_index"], [56, 4, 1, "", "goods_coverage"], [57, 4, 1, "", "heip_e"], [58, 4, 1, "", "hill"], [59, 4, 1, "", "inv_simpson"], [60, 4, 1, "", "kempton_taylor_q"], [61, 4, 1, "", "lladser_ci"], [62, 4, 1, "", "lladser_pe"], [63, 4, 1, "", "margalef"], [64, 4, 1, "", "mcintosh_d"], [65, 4, 1, "", "mcintosh_e"], [66, 4, 1, "", "menhinick"], [67, 4, 1, "", "michaelis_menten_fit"], [68, 4, 1, "", "observed_features"], [69, 4, 1, "", "osd"], [70, 4, 1, "", "phydiv"], [71, 4, 1, "", "pielou_e"], [72, 4, 1, "", "renyi"], [73, 4, 1, "", "robbins"], [74, 4, 1, "", "shannon"], [75, 4, 1, "", "simpson"], [76, 4, 1, "", "simpson_d"], [77, 4, 1, "", "simpson_e"], [78, 4, 1, "", "singles"], [79, 4, 1, "", "sobs"], [80, 4, 1, "", "strong"], [81, 4, 1, "", "tsallis"]], "skbio.diversity.beta": [[84, 4, 1, "", "unweighted_unifrac"], [85, 4, 1, "", "weighted_unifrac"]], "skbio.embedding": [[91, 1, 1, "", "Embedding"], [95, 1, 1, "", "EmbeddingVector"], [96, 1, 1, "", "ProteinEmbedding"], [97, 1, 1, "", "ProteinVector"], [98, 1, 1, "", "SequenceEmbedding"], [99, 1, 1, "", "SequenceVector"], [100, 4, 1, "", "embed_vec_to_dataframe"], [101, 4, 1, "", "embed_vec_to_distances"], [102, 4, 1, "", "embed_vec_to_numpy"], [103, 4, 1, "", "embed_vec_to_ordination"]], "skbio.embedding.Embedding": [[91, 2, 1, "", "__str__"], [92, 2, 1, "", "bytes"], [91, 3, 1, "", "embedding"], [91, 3, 1, "", "ids"], [93, 2, 1, "", "read"], [94, 2, 1, "", "write"]], "skbio.embedding.EmbeddingVector": [[95, 2, 1, "", "__str__"], [95, 3, 1, "", "embedding"], [95, 3, 1, "", "vector"]], "skbio.embedding.ProteinEmbedding": [[96, 3, 1, "", "default_write_format"], [96, 3, 1, "", "residues"]], "skbio.embedding.ProteinVector": [[97, 3, 1, "", "default_write_format"]], "skbio.embedding.SequenceEmbedding": [[98, 2, 1, "", "__str__"], [98, 3, 1, "", "sequence"]], "skbio.embedding.SequenceVector": [[99, 3, 1, "", "sequence"]], "skbio.io": [[123, 0, 0, "-", "registry"], [144, 0, 0, "-", "util"]], "skbio.io.format": [[104, 0, 0, "-", "binary_dm"], [105, 0, 0, "-", "biom"], [106, 0, 0, "-", "blast6"], [107, 0, 0, "-", "blast7"], [108, 0, 0, "-", "clustal"], [109, 0, 0, "-", "embed"], [110, 0, 0, "-", "embl"], [111, 0, 0, "-", "fasta"], [112, 0, 0, "-", "fastq"], [113, 0, 0, "-", "genbank"], [114, 0, 0, "-", "gff3"], [115, 0, 0, "-", "lsmat"], [116, 0, 0, "-", "newick"], [117, 0, 0, "-", "ordination"], [118, 0, 0, "-", "phylip"], [119, 0, 0, "-", "qseq"], [120, 0, 0, "-", "sample_metadata"], [121, 0, 0, "-", "stockholm"], [122, 0, 0, "-", "taxdump"]], "skbio.io.registry": [[124, 1, 1, "", "Format"], [128, 1, 1, "", "IORegistry"], [140, 4, 1, "", "create_format"], [141, 4, 1, "", "read"], [142, 4, 1, "", "sniff"], [143, 4, 1, "", "write"]], "skbio.io.registry.Format": [[124, 3, 1, "", "is_binary_format"], [124, 3, 1, "", "name"], [125, 2, 1, "", "reader"], [124, 3, 1, "", "readers"], [126, 2, 1, "", "sniffer"], [124, 3, 1, "", "sniffer_function"], [127, 2, 1, "", "writer"], [124, 3, 1, "", "writers"]], "skbio.io.registry.IORegistry": [[129, 2, 1, "", "add_format"], [130, 2, 1, "", "create_format"], [131, 2, 1, "", "get_reader"], [132, 2, 1, "", "get_sniffer"], [133, 2, 1, "", "get_writer"], [134, 2, 1, "", "list_read_formats"], [135, 2, 1, "", "list_write_formats"], [136, 2, 1, "", "read"], [137, 2, 1, "", "remove_format"], [138, 2, 1, "", "sniff"], [139, 2, 1, "", "write"]], "skbio.io.util": [[145, 4, 1, "", "open"], [146, 4, 1, "", "open_file"], [147, 4, 1, "", "open_files"]], "skbio.metadata": [[148, 1, 1, "", "CategoricalMetadataColumn"], [149, 1, 1, "", "Interval"], [151, 1, 1, "", "IntervalMetadata"], [160, 1, 1, "", "IntervalMetadataMixin"], [162, 1, 1, "", "MetadataColumn"], [171, 1, 1, "", "MetadataMixin"], [173, 1, 1, "", "NumericMetadataColumn"], [174, 1, 1, "", "PositionalMetadataMixin"], [176, 1, 1, "", "SampleMetadata"]], "skbio.metadata.CategoricalMetadataColumn": [[148, 3, 1, "", "type"]], "skbio.metadata.Interval": [[149, 2, 1, "", "__eq__"], [149, 2, 1, "", "__ne__"], [149, 3, 1, "", "bounds"], [150, 2, 1, "", "drop"], [149, 3, 1, "", "dropped"], [149, 3, 1, "", "fuzzy"], [149, 3, 1, "", "metadata"]], "skbio.metadata.IntervalMetadata": [[151, 2, 1, "", "__copy__"], [151, 2, 1, "", "__deepcopy__"], [151, 2, 1, "", "__eq__"], [151, 2, 1, "", "__ne__"], [152, 2, 1, "", "add"], [153, 2, 1, "", "concat"], [151, 3, 1, "", "default_write_format"], [154, 2, 1, "", "drop"], [151, 3, 1, "", "lower_bound"], [155, 2, 1, "", "merge"], [151, 3, 1, "", "num_interval_features"], [156, 2, 1, "", "query"], [157, 2, 1, "", "read"], [158, 2, 1, "", "sort"], [151, 3, 1, "", "upper_bound"], [159, 2, 1, "", "write"]], "skbio.metadata.IntervalMetadataMixin": [[160, 2, 1, "", "__copy__"], [160, 2, 1, "", "__deepcopy__"], [160, 2, 1, "", "__eq__"], [160, 2, 1, "", "__ne__"], [161, 2, 1, "", "has_interval_metadata"], [160, 3, 1, "", "interval_metadata"]], "skbio.metadata.MetadataColumn": [[162, 2, 1, "", "__eq__"], [162, 2, 1, "", "__ne__"], [163, 2, 1, "", "drop_missing_values"], [164, 2, 1, "", "filter_ids"], [165, 2, 1, "", "get_ids"], [166, 2, 1, "", "get_missing"], [167, 2, 1, "", "get_value"], [168, 2, 1, "", "has_missing_values"], [162, 3, 1, "", "missing_scheme"], [162, 3, 1, "", "name"], [169, 2, 1, "", "to_dataframe"], [170, 2, 1, "", "to_series"], [162, 3, 1, "", "type"]], "skbio.metadata.MetadataMixin": [[171, 2, 1, "", "__copy__"], [171, 2, 1, "", "__deepcopy__"], [171, 2, 1, "", "__eq__"], [171, 2, 1, "", "__ne__"], [172, 2, 1, "", "has_metadata"], [171, 3, 1, "", "metadata"]], "skbio.metadata.NumericMetadataColumn": [[173, 3, 1, "", "type"]], "skbio.metadata.PositionalMetadataMixin": [[174, 2, 1, "", "__copy__"], [174, 2, 1, "", "__deepcopy__"], [174, 2, 1, "", "__eq__"], [174, 2, 1, "", "__ne__"], [175, 2, 1, "", "has_positional_metadata"], [174, 3, 1, "", "positional_metadata"]], "skbio.metadata.SampleMetadata": [[176, 2, 1, "", "__eq__"], [176, 2, 1, "", "__ne__"], [176, 3, 1, "", "column_count"], [176, 3, 1, "", "columns"], [176, 3, 1, "", "default_write_format"], [177, 2, 1, "", "filter_columns"], [178, 2, 1, "", "filter_ids"], [179, 2, 1, "", "get_column"], [180, 2, 1, "", "get_ids"], [181, 2, 1, "", "load"], [182, 2, 1, "", "merge"], [183, 2, 1, "", "to_dataframe"]], "skbio.sequence": [[184, 1, 1, "", "DNA"], [191, 1, 1, "", "GeneticCode"], [195, 1, 1, "", "GrammaredSequence"], [209, 1, 1, "", "NucleotideMixin"], [215, 1, 1, "", "Protein"], [221, 1, 1, "", "RNA"], [228, 1, 1, "", "Sequence"], [247, 1, 1, "", "SubstitutionMatrix"], [253, 0, 0, "-", "distance"]], "skbio.sequence.DNA": [[184, 3, 1, "", "complement_map"], [184, 3, 1, "", "default_gap_char"], [184, 3, 1, "", "definite_chars"], [184, 3, 1, "", "degenerate_map"], [185, 2, 1, "", "find_motifs"], [184, 3, 1, "", "gap_chars"], [186, 2, 1, "", "read"], [187, 2, 1, "", "transcribe"], [188, 2, 1, "", "translate"], [189, 2, 1, "", "translate_six_frames"], [184, 3, 1, "", "wildcard_char"], [190, 2, 1, "", "write"]], "skbio.sequence.GeneticCode": [[191, 2, 1, "", "__eq__"], [191, 2, 1, "", "__ne__"], [191, 2, 1, "", "__str__"], [192, 2, 1, "", "from_ncbi"], [191, 3, 1, "", "name"], [191, 3, 1, "", "reading_frames"], [193, 2, 1, "", "translate"], [194, 2, 1, "", "translate_six_frames"]], "skbio.sequence.GrammaredSequence": [[195, 3, 1, "", "alphabet"], [195, 3, 1, "", "default_gap_char"], [195, 3, 1, "", "definite_chars"], [196, 2, 1, "", "definites"], [197, 2, 1, "", "degap"], [195, 3, 1, "", "degenerate_chars"], [195, 3, 1, "", "degenerate_map"], [198, 2, 1, "", "degenerates"], [199, 2, 1, "", "expand_degenerates"], [200, 2, 1, "", "find_motifs"], [195, 3, 1, "", "gap_chars"], [201, 2, 1, "", "gaps"], [202, 2, 1, "", "has_definites"], [203, 2, 1, "", "has_degenerates"], [204, 2, 1, "", "has_gaps"], [205, 2, 1, "", "has_nondegenerates"], [195, 3, 1, "", "noncanonical_chars"], [195, 3, 1, "", "nondegenerate_chars"], [206, 2, 1, "", "nondegenerates"], [207, 2, 1, "", "to_definites"], [208, 2, 1, "", "to_regex"], [195, 3, 1, "", "wildcard_char"]], "skbio.sequence.NucleotideMixin": [[210, 2, 1, "", "complement"], [209, 3, 1, "", "complement_map"], [211, 2, 1, "", "gc_content"], [212, 2, 1, "", "gc_frequency"], [213, 2, 1, "", "is_reverse_complement"], [214, 2, 1, "", "reverse_complement"]], "skbio.sequence.Protein": [[215, 3, 1, "", "alphabet"], [215, 3, 1, "", "default_gap_char"], [215, 3, 1, "", "definite_chars"], [215, 3, 1, "", "degenerate_map"], [216, 2, 1, "", "find_motifs"], [215, 3, 1, "", "gap_chars"], [217, 2, 1, "", "has_stops"], [215, 3, 1, "", "noncanonical_chars"], [218, 2, 1, "", "read"], [215, 3, 1, "", "stop_chars"], [219, 2, 1, "", "stops"], [215, 3, 1, "", "wildcard_char"], [220, 2, 1, "", "write"]], "skbio.sequence.RNA": [[221, 3, 1, "", "complement_map"], [221, 3, 1, "", "default_gap_char"], [221, 3, 1, "", "definite_chars"], [221, 3, 1, "", "degenerate_map"], [222, 2, 1, "", "find_motifs"], [221, 3, 1, "", "gap_chars"], [223, 2, 1, "", "read"], [224, 2, 1, "", "reverse_transcribe"], [225, 2, 1, "", "translate"], [226, 2, 1, "", "translate_six_frames"], [221, 3, 1, "", "wildcard_char"], [227, 2, 1, "", "write"]], "skbio.sequence.Sequence": [[228, 2, 1, "", "__bool__"], [228, 2, 1, "", "__contains__"], [228, 2, 1, "", "__copy__"], [228, 2, 1, "", "__deepcopy__"], [228, 2, 1, "", "__eq__"], [228, 2, 1, "", "__getitem__"], [228, 2, 1, "", "__iter__"], [228, 2, 1, "", "__len__"], [228, 2, 1, "", "__ne__"], [228, 2, 1, "", "__reversed__"], [228, 2, 1, "", "__str__"], [229, 2, 1, "", "concat"], [230, 2, 1, "", "count"], [228, 3, 1, "", "default_write_format"], [231, 2, 1, "", "distance"], [232, 2, 1, "", "find_with_regex"], [233, 2, 1, "", "frequencies"], [234, 2, 1, "", "index"], [235, 2, 1, "", "iter_contiguous"], [236, 2, 1, "", "iter_kmers"], [237, 2, 1, "", "kmer_frequencies"], [238, 2, 1, "", "lowercase"], [239, 2, 1, "", "match_frequency"], [240, 2, 1, "", "matches"], [241, 2, 1, "", "mismatch_frequency"], [242, 2, 1, "", "mismatches"], [228, 3, 1, "", "observed_chars"], [243, 2, 1, "", "read"], [244, 2, 1, "", "replace"], [245, 2, 1, "", "to_indices"], [228, 3, 1, "", "values"], [246, 2, 1, "", "write"]], "skbio.sequence.SubstitutionMatrix": [[247, 3, 1, "", "alphabet"], [248, 2, 1, "", "by_name"], [249, 2, 1, "", "from_dict"], [250, 2, 1, "", "get_names"], [251, 2, 1, "", "identity"], [247, 3, 1, "", "is_ascii"], [247, 3, 1, "", "scores"], [252, 2, 1, "", "to_dict"]], "skbio.sequence.distance": [[254, 4, 1, "", "hamming"], [255, 4, 1, "", "kmer_distance"]], "skbio.stats": [[256, 0, 0, "-", "composition"], [276, 0, 0, "-", "distance"], [303, 0, 0, "-", "evolve"], [305, 0, 0, "-", "gradient"], [318, 4, 1, "", "isubsample"], [319, 0, 0, "-", "ordination"], [336, 0, 0, "-", "power"], [341, 4, 1, "", "subsample_counts"]], "skbio.stats.composition": [[257, 4, 1, "", "alr"], [258, 4, 1, "", "alr_inv"], [259, 4, 1, "", "ancom"], [260, 4, 1, "", "centralize"], [261, 4, 1, "", "closure"], [262, 4, 1, "", "clr"], [263, 4, 1, "", "clr_inv"], [264, 4, 1, "", "dirmult_ttest"], [265, 4, 1, "", "ilr"], [266, 4, 1, "", "ilr_inv"], [267, 4, 1, "", "inner"], [268, 4, 1, "", "multi_replace"], [269, 4, 1, "", "pairwise_vlr"], [270, 4, 1, "", "perturb"], [271, 4, 1, "", "perturb_inv"], [272, 4, 1, "", "power"], [273, 4, 1, "", "sbp_basis"], [274, 4, 1, "", "tree_basis"], [275, 4, 1, "", "vlr"]], "skbio.stats.distance": [[277, 1, 1, "", "DissimilarityMatrix"], [291, 1, 1, "", "DistanceMatrix"], [296, 4, 1, "", "anosim"], [297, 4, 1, "", "bioenv"], [298, 4, 1, "", "mantel"], [299, 4, 1, "", "permanova"], [300, 4, 1, "", "permdisp"], [301, 4, 1, "", "pwmantel"], [302, 4, 1, "", "randdm"]], "skbio.stats.distance.DissimilarityMatrix": [[277, 3, 1, "", "T"], [277, 2, 1, "", "__contains__"], [277, 2, 1, "", "__eq__"], [277, 2, 1, "", "__getitem__"], [277, 2, 1, "", "__ne__"], [277, 2, 1, "", "__str__"], [278, 2, 1, "", "between"], [279, 2, 1, "", "copy"], [277, 3, 1, "", "data"], [277, 3, 1, "", "default_write_format"], [277, 3, 1, "", "dtype"], [280, 2, 1, "", "filter"], [281, 2, 1, "", "from_iterable"], [277, 3, 1, "", "ids"], [282, 2, 1, "", "index"], [283, 2, 1, "", "plot"], [284, 2, 1, "", "read"], [285, 2, 1, "", "redundant_form"], [286, 2, 1, "", "rename"], [277, 3, 1, "", "shape"], [277, 3, 1, "", "size"], [287, 2, 1, "", "to_data_frame"], [288, 2, 1, "", "transpose"], [289, 2, 1, "", "within"], [290, 2, 1, "", "write"]], "skbio.stats.distance.DistanceMatrix": [[292, 2, 1, "", "condensed_form"], [293, 2, 1, "", "from_iterable"], [294, 2, 1, "", "permute"], [295, 2, 1, "", "to_series"]], "skbio.stats.evolve": [[304, 4, 1, "", "hommola_cospeciation"]], "skbio.stats.gradient": [[306, 1, 1, "", "AverageGradientANOVA"], [307, 1, 1, "", "CategoryResults"], [309, 1, 1, "", "FirstDifferenceGradientANOVA"], [310, 1, 1, "", "GradientANOVA"], [312, 1, 1, "", "GradientANOVAResults"], [314, 1, 1, "", "GroupResults"], [316, 1, 1, "", "TrajectoryGradientANOVA"], [317, 1, 1, "", "WindowDifferenceGradientANOVA"]], "skbio.stats.gradient.CategoryResults": [[308, 2, 1, "", "to_files"]], "skbio.stats.gradient.GradientANOVA": [[311, 2, 1, "", "get_trajectories"]], "skbio.stats.gradient.GradientANOVAResults": [[313, 2, 1, "", "to_files"]], "skbio.stats.gradient.GroupResults": [[315, 2, 1, "", "to_files"]], "skbio.stats.ordination": [[320, 1, 1, "", "OrdinationResults"], [325, 4, 1, "", "ca"], [326, 4, 1, "", "cca"], [327, 4, 1, "", "corr"], [328, 4, 1, "", "e_matrix"], [329, 4, 1, "", "f_matrix"], [330, 4, 1, "", "mean_and_std"], [331, 4, 1, "", "pcoa"], [332, 4, 1, "", "pcoa_biplot"], [333, 4, 1, "", "rda"], [334, 4, 1, "", "scale"], [335, 4, 1, "", "svd_rank"]], "skbio.stats.ordination.OrdinationResults": [[320, 2, 1, "", "__str__"], [320, 3, 1, "", "default_write_format"], [321, 2, 1, "", "plot"], [322, 2, 1, "", "read"], [323, 2, 1, "", "rename"], [324, 2, 1, "", "write"]], "skbio.stats.power": [[337, 4, 1, "", "confidence_bound"], [338, 4, 1, "", "paired_subsamples"], [339, 4, 1, "", "subsample_paired_power"], [340, 4, 1, "", "subsample_power"]], "skbio.table": [[342, 1, 1, "", "Table"], [399, 5, 1, "", "example_table"]], "skbio.table.Table": [[342, 2, 1, "", "__eq__"], [342, 2, 1, "", "__getitem__"], [342, 2, 1, "", "__iter__"], [342, 2, 1, "", "__ne__"], [342, 2, 1, "", "__str__"], [343, 2, 1, "", "add_group_metadata"], [344, 2, 1, "", "add_metadata"], [345, 2, 1, "", "align_to"], [346, 2, 1, "", "align_to_dataframe"], [347, 2, 1, "", "align_tree"], [348, 2, 1, "", "collapse"], [349, 2, 1, "", "concat"], [350, 2, 1, "", "copy"], [351, 2, 1, "", "data"], [342, 3, 1, "", "default_write_format"], [352, 2, 1, "", "del_metadata"], [353, 2, 1, "", "delimited_self"], [354, 2, 1, "", "descriptive_equality"], [342, 3, 1, "", "dtype"], [355, 2, 1, "", "exists"], [356, 2, 1, "", "filter"], [357, 2, 1, "", "from_adjacency"], [358, 2, 1, "", "from_hdf5"], [359, 2, 1, "", "from_json"], [360, 2, 1, "", "from_tsv"], [361, 2, 1, "", "get_table_density"], [362, 2, 1, "", "get_value_by_ids"], [363, 2, 1, "", "group_metadata"], [364, 2, 1, "", "head"], [365, 2, 1, "", "ids"], [366, 2, 1, "", "index"], [367, 2, 1, "", "is_empty"], [368, 2, 1, "", "iter"], [369, 2, 1, "", "iter_data"], [370, 2, 1, "", "iter_pairwise"], [371, 2, 1, "", "length"], [342, 3, 1, "", "matrix_data"], [372, 2, 1, "", "max"], [373, 2, 1, "", "merge"], [374, 2, 1, "", "metadata"], [375, 2, 1, "", "metadata_to_dataframe"], [376, 2, 1, "", "min"], [342, 3, 1, "", "nnz"], [377, 2, 1, "", "nonzero"], [378, 2, 1, "", "nonzero_counts"], [379, 2, 1, "", "norm"], [380, 2, 1, "", "pa"], [381, 2, 1, "", "partition"], [382, 2, 1, "", "rankdata"], [383, 2, 1, "", "read"], [384, 2, 1, "", "reduce"], [385, 2, 1, "", "remove_empty"], [342, 3, 1, "", "shape"], [386, 2, 1, "", "sort"], [387, 2, 1, "", "sort_order"], [388, 2, 1, "", "subsample"], [389, 2, 1, "", "sum"], [390, 2, 1, "", "to_anndata"], [391, 2, 1, "", "to_dataframe"], [392, 2, 1, "", "to_hdf5"], [393, 2, 1, "", "to_json"], [394, 2, 1, "", "to_tsv"], [395, 2, 1, "", "transform"], [396, 2, 1, "", "transpose"], [397, 2, 1, "", "update_ids"], [398, 2, 1, "", "write"]], "skbio.tree": [[400, 1, 1, "", "TreeNode"], [477, 4, 1, "", "bme"], [478, 4, 1, "", "gme"], [479, 4, 1, "", "majority_rule"], [480, 4, 1, "", "nj"], [481, 4, 1, "", "nni"], [482, 4, 1, "", "path_dists"], [483, 4, 1, "", "rf_dists"], [484, 4, 1, "", "upgma"], [485, 4, 1, "", "wrf_dists"]], "skbio.tree.TreeNode": [[400, 2, 1, "", "__copy__"], [400, 2, 1, "", "__deepcopy__"], [400, 2, 1, "", "__getitem__"], [400, 2, 1, "", "__iter__"], [400, 2, 1, "", "__len__"], [400, 2, 1, "", "__str__"], [401, 2, 1, "", "ancestors"], [402, 2, 1, "", "append"], [403, 2, 1, "", "ascii_art"], [404, 2, 1, "", "assign_ids"], [405, 2, 1, "", "assign_supports"], [406, 2, 1, "", "bifurcate"], [407, 2, 1, "", "bipart"], [408, 2, 1, "", "biparts"], [409, 2, 1, "", "cache_attr"], [410, 2, 1, "", "clear_caches"], [411, 2, 1, "", "compare_biparts"], [412, 2, 1, "", "compare_cophenet"], [413, 2, 1, "", "compare_rfd"], [414, 2, 1, "", "compare_subsets"], [415, 2, 1, "", "compare_wrfd"], [416, 2, 1, "", "cophenet"], [417, 2, 1, "", "copy"], [418, 2, 1, "", "count"], [419, 2, 1, "", "create_caches"], [420, 2, 1, "", "deepcopy"], [400, 3, 1, "", "default_write_format"], [421, 2, 1, "", "depth"], [422, 2, 1, "", "distance"], [423, 2, 1, "", "extend"], [424, 2, 1, "", "find"], [425, 2, 1, "", "find_all"], [426, 2, 1, "", "find_by_func"], [427, 2, 1, "", "find_by_id"], [428, 2, 1, "", "from_linkage_matrix"], [429, 2, 1, "", "from_taxdump"], [430, 2, 1, "", "from_taxonomy"], [431, 2, 1, "", "has_caches"], [432, 2, 1, "", "has_children"], [433, 2, 1, "", "height"], [434, 2, 1, "", "index_tree"], [435, 2, 1, "", "insert"], [436, 2, 1, "", "is_bifurcating"], [437, 2, 1, "", "is_root"], [438, 2, 1, "", "is_tip"], [439, 2, 1, "", "lca"], [440, 2, 1, "", "levelorder"], [441, 2, 1, "", "maxdist"], [442, 2, 1, "", "neighbors"], [443, 2, 1, "", "non_tips"], [444, 2, 1, "", "observed_node_counts"], [445, 2, 1, "", "path"], [446, 2, 1, "", "pop"], [447, 2, 1, "", "postorder"], [448, 2, 1, "", "pre_and_postorder"], [449, 2, 1, "", "preorder"], [450, 2, 1, "", "prune"], [451, 2, 1, "", "read"], [452, 2, 1, "", "remove"], [453, 2, 1, "", "remove_by_func"], [454, 2, 1, "", "remove_deleted"], [455, 2, 1, "", "root"], [456, 2, 1, "", "root_at"], [457, 2, 1, "", "root_at_midpoint"], [458, 2, 1, "", "root_by_outgroup"], [459, 2, 1, "", "shear"], [460, 2, 1, "", "shuffle"], [461, 2, 1, "", "siblings"], [462, 2, 1, "", "subset"], [463, 2, 1, "", "subsets"], [464, 2, 1, "", "subtree"], [465, 2, 1, "", "tips"], [466, 2, 1, "", "to_array"], [467, 2, 1, "", "to_taxonomy"], [468, 2, 1, "", "total_length"], [469, 2, 1, "", "traverse"], [470, 2, 1, "", "unpack"], [471, 2, 1, "", "unpack_by_func"], [472, 2, 1, "", "unroot"], [473, 2, 1, "", "unrooted_copy"], [474, 2, 1, "", "unrooted_deepcopy"], [475, 2, 1, "", "unrooted_move"], [476, 2, 1, "", "write"]], "skbio.util": [[486, 1, 1, "", "PlottableMixin"], [487, 4, 1, "", "aliased"], [488, 4, 1, "", "assert_data_frame_almost_equal"], [489, 4, 1, "", "assert_ordination_results_equal"], [490, 4, 1, "", "cardinal_to_ordinal"], [491, 1, 1, "", "classonlymethod"], [492, 1, 1, "", "classproperty"], [493, 4, 1, "", "deprecated"], [494, 4, 1, "", "find_duplicates"], [495, 4, 1, "", "get_data_path"], [496, 4, 1, "", "get_rng"], [497, 4, 1, "", "overrides"], [498, 4, 1, "", "params_aliased"], [499, 4, 1, "", "register_aliases"], [500, 4, 1, "", "safe_md5"]], "skbio.util.PlottableMixin": [[486, 3, 1, "", "png"], [486, 3, 1, "", "svg"]], "skbio.util.classonlymethod": [[491, 2, 1, "", "__get__"]], "skbio.util.classproperty": [[492, 2, 1, "", "__get__"], [492, 2, 1, "", "__set__"]], "skbio.workflow": [[501, 1, 1, "", "Workflow"], [503, 1, 1, "", "method"], [504, 1, 1, "", "requires"]], "skbio.workflow.Workflow": [[501, 2, 1, "", "__call__"], [502, 2, 1, "", "initialize_state"]], "skbio.workflow.method": [[503, 2, 1, "", "__call__"], [503, 3, 1, "", "highest_priority"]], "skbio.workflow.requires": [[504, 2, 1, "", "__call__"]]}, "objnames": {"0": ["py", "module", "Python module"], "1": ["py", "class", "Python class"], "2": ["py", "method", "Python method"], "3": ["py", "attribute", "Python attribute"], "4": ["py", "function", "Python function"], "5": ["py", "data", "Python data"]}, "objtypes": {"0": "py:module", "1": "py:class", "2": "py:method", "3": "py:attribute", "4": "py:function", "5": "py:data"}, "terms": {"": [0, 1, 3, 11, 15, 19, 20, 21, 22, 23, 24, 28, 29, 31, 35, 36, 37, 40, 44, 46, 49, 51, 52, 53, 54, 56, 57, 58, 59, 60, 63, 65, 66, 67, 70, 71, 72, 74, 75, 76, 77, 79, 80, 81, 82, 84, 85, 87, 88, 89, 106, 107, 111, 112, 114, 115, 116, 117, 118, 119, 120, 121, 122, 149, 151, 153, 169, 170, 171, 172, 174, 175, 176, 180, 181, 183, 184, 185, 187, 188, 189, 191, 193, 194, 195, 196, 197, 198, 199, 200, 201, 202, 203, 204, 205, 206, 211, 212, 215, 216, 217, 219, 221, 222, 224, 225, 226, 228, 230, 231, 232, 234, 235, 236, 237, 238, 239, 240, 241, 242, 244, 245, 248, 254, 257, 258, 259, 262, 263, 265, 266, 269, 273, 275, 277, 278, 280, 289, 296, 297, 298, 299, 300, 302, 308, 313, 315, 318, 321, 325, 326, 327, 333, 335, 336, 338, 339, 340, 348, 356, 364, 369, 384, 387, 402, 408, 409, 412, 415, 416, 423, 434, 435, 439, 452, 457, 460, 461, 463, 468, 472, 479, 496, 504, 506, 508, 511, 513], "0": [0, 1, 3, 4, 5, 6, 8, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 24, 27, 28, 29, 31, 41, 42, 44, 49, 53, 54, 55, 57, 58, 60, 61, 62, 70, 71, 72, 74, 79, 81, 84, 85, 90, 96, 97, 105, 106, 107, 108, 109, 110, 111, 112, 113, 114, 115, 116, 117, 118, 119, 120, 121, 122, 145, 153, 174, 184, 185, 187, 188, 189, 191, 193, 194, 195, 197, 199, 200, 205, 206, 208, 210, 211, 212, 214, 215, 216, 221, 222, 224, 225, 226, 228, 229, 230, 231, 233, 237, 239, 241, 245, 247, 248, 249, 254, 255, 256, 257, 258, 259, 260, 261, 262, 263, 264, 265, 266, 267, 268, 269, 270, 271, 272, 273, 274, 275, 276, 277, 278, 283, 286, 287, 289, 294, 295, 296, 297, 298, 299, 300, 301, 302, 304, 305, 310, 318, 319, 321, 326, 330, 331, 334, 336, 337, 338, 339, 340, 341, 342, 345, 346, 347, 348, 349, 351, 355, 356, 359, 362, 363, 364, 365, 366, 368, 369, 373, 374, 379, 380, 381, 382, 384, 386, 387, 388, 389, 391, 392, 394, 395, 397, 399, 402, 404, 405, 406, 407, 408, 409, 410, 411, 412, 413, 414, 415, 416, 417, 420, 421, 422, 423, 425, 431, 433, 435, 436, 439, 441, 445, 446, 450, 452, 453, 454, 456, 457, 458, 459, 460, 462, 463, 464, 466, 468, 470, 471, 472, 473, 474, 475, 477, 478, 479, 480, 481, 482, 483, 484, 485, 490, 496, 503, 506, 508, 511, 513], "00": [1, 20, 106, 107, 111, 114, 117, 174, 187, 224, 229, 508], "000": 87, "000000": 1, "000000e": [106, 107], "000123": 120, "000532": 319, "00064": 340, "001": [259, 336], "001562": 319, "00176": 339, "0019": 496, "0031": 305, "007022633956606": 305, "007446": 264, "0082138": [19, 41], "01": [117, 300, 331, 336], "0118478282382": 305, "0123": 120, "0123456789": 149, "012631": 319, "015": [269, 275], "02": [117, 122, 259, 477, 478, 481], "020131": 264, "0220": [269, 275], "0225": 305, "029747": 319, "03": 117, "0301": 305, "03296": 300, "0341": 305, "036910": 264, "0378111988903307": 108, "039": 339, "03t14": 359, "04": 117, "043888": 264, "044": 336, "044805": 319, "048219": 264, "05": [1, 117, 259, 264, 304, 336, 337, 339, 340, 488], "053": 339, "057": 339, "06": [117, 340, 359], "0625": 268, "0633": 305, "065613": 264, "068310": 264, "069": 339, "07": 117, "072": 336, "0721": 305, "076": 336, "08": [117, 120], "083071": 121, "0874": 305, "0898": 305, "09": 117, "09392265": 1, "09861229": 257, "0i": 259, "0th": [375, 490], "1": [0, 1, 3, 4, 5, 6, 8, 9, 10, 11, 13, 14, 15, 18, 19, 20, 21, 22, 23, 24, 27, 28, 29, 31, 35, 36, 37, 38, 39, 40, 41, 43, 44, 45, 46, 47, 48, 49, 50, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 71, 72, 73, 74, 75, 76, 77, 78, 79, 80, 81, 84, 85, 87, 104, 105, 106, 107, 108, 110, 111, 112, 113, 114, 115, 116, 117, 118, 119, 120, 121, 122, 125, 126, 149, 151, 153, 156, 158, 174, 184, 185, 188, 189, 191, 192, 193, 194, 195, 200, 207, 210, 214, 215, 216, 221, 222, 225, 226, 228, 229, 230, 233, 235, 236, 237, 241, 245, 247, 248, 249, 251, 255, 256, 257, 258, 259, 260, 261, 262, 263, 264, 265, 266, 267, 268, 269, 270, 271, 272, 273, 275, 276, 277, 278, 283, 285, 286, 287, 289, 291, 292, 295, 296, 297, 298, 299, 300, 301, 302, 304, 310, 314, 317, 318, 319, 321, 325, 326, 330, 331, 332, 333, 334, 336, 338, 339, 340, 341, 342, 345, 346, 347, 348, 349, 352, 355, 356, 358, 359, 362, 363, 364, 365, 366, 368, 369, 373, 374, 376, 379, 380, 381, 382, 384, 386, 387, 388, 389, 391, 392, 394, 395, 397, 399, 405, 409, 412, 413, 415, 416, 421, 422, 425, 429, 430, 433, 435, 441, 446, 457, 460, 466, 467, 468, 470, 471, 472, 477, 478, 479, 480, 481, 482, 483, 484, 485, 490, 493, 496, 508, 511, 513], "10": [19, 23, 41, 44, 61, 62, 74, 96, 97, 107, 110, 111, 112, 113, 114, 116, 117, 118, 149, 151, 156, 184, 185, 195, 200, 215, 216, 221, 222, 228, 259, 264, 269, 275, 300, 319, 336, 339, 340, 342, 345, 348, 349, 353, 369, 373, 477, 478, 480, 481, 513], "100": [1, 106, 107, 111, 114, 156, 259, 264, 340, 364, 388, 513], "1000": [156, 318], "1004": 305, "1004075": [269, 275], "100548": 319, "1007": [110, 269, 275], "101": 264, "10136628": 262, "102": 264, "1024": 109, "103": 264, "104": [121, 264], "1048576": 500, "104937": 319, "1055": 305, "10596": 107, "106": 457, "106652702761034136": [477, 478, 481], "1089": [477, 478, 481], "10915": [37, 40, 248], "10919": [37, 40, 248], "1093": [112, 480], "10937312": 1, "11": [0, 16, 19, 37, 40, 41, 47, 52, 53, 106, 110, 117, 119, 174, 184, 221, 232, 259, 264, 269, 275, 305, 319, 326, 333, 340, 345, 348, 349, 369, 415, 480, 482], "110": 264, "1115": 64, "112": 382, "1126": 64, "113": [58, 74, 336], "1131255": 500, "114": 106, "1154": 305, "116": 305, "1167": 326, "117": 296, "11704769": 265, "117693430600200007": 53, "1179": 326, "119": [415, 485], "11th": 118, "12": [1, 110, 117, 228, 259, 264, 269, 348, 349, 382, 508], "120": [114, 264], "120492524415": 511, "1215": 305, "123": [120, 171, 318, 339, 340], "12345": [111, 171, 228], "12487758": [477, 478, 481], "126": [112, 412, 415, 485], "128": 264, "13": [0, 48, 71, 77, 107, 111, 117, 119, 184, 195, 215, 221, 228, 259, 264, 319, 336, 348, 349, 392, 412, 482], "131": [71, 77, 413, 483], "131567": 122, "1345": 45, "1347": 45, "135": [107, 269, 275], "1371": [19, 41, 269, 275], "139": 121, "14": [1, 48, 60, 70, 110, 112, 117, 185, 197, 200, 216, 222, 259, 264, 305, 336, 349, 416, 422], "1409": 484, "14092516": 266, "141": [70, 412], "14131": 412, "142857": 301, "14285714": 271, "142857142857": 379, "143": 296, "1435": 111, "1438": 484, "144": 77, "1457": 304, "1468": 304, "147": [38, 413, 483], "1495": 110, "149855": 111, "1499": 110, "15": [19, 37, 40, 60, 107, 117, 120, 305, 336, 339, 340, 349, 416, 485], "1535": 405, "1542": [107, 405], "156": 55, "1566": 107, "1576": [84, 85], "15800534": 106, "1585": [84, 85], "16": [1, 51, 70, 108, 111, 112, 113, 117, 118, 210, 214, 232, 264, 321, 340, 345, 349, 415, 416, 441, 485], "16025641": 1, "161": 106, "16247744": 260, "1627907": 1, "163": [49, 59, 75, 77], "16441": 415, "164998": 264, "165": 70, "168": 45, "169": [84, 85], "17": [51, 53, 84, 85, 110, 117, 184, 221, 319, 336, 349, 496], "170768970": 106, "172": [84, 85], "1740": 110, "17445763": 260, "1767": 112, "1771": 112, "1786181": 107, "18": [107, 117, 121, 296, 336, 415, 477, 478, 481, 508], "1800": 110, "1814": 41, "182343": 264, "1859": 110, "1875": 268, "18761279": 260, "19": [1, 110, 117, 336, 340, 348, 477, 478, 481, 482, 496], "1907511": 110, "1912": 55, "1913": 42, "192": 121, "19234468": 113, "193": 44, "194": 70, "1943": 54, "1948": 74, "1949": [49, 59, 75, 77], "195": 38, "1953": [43, 56], "1955": 55, "1956": 46, "1958": [63, 484], "1961": 72, "1962": [412, 416], "1966": [71, 77, 331], "1967": [64, 298], "1968": 73, "1970": [35, 45], "1971": [51, 75], "1972": 457, "1973": 58, "1974": [57, 65], "1976": 60, "1978": 248, "1979": [415, 485], "1981": [38, 413, 479, 483], "1983": 52, "1984": [47, 184, 195, 215, 221, 228], "1985": [111, 184, 195, 215, 221, 228], "1986": [111, 116, 118, 326], "1987": [67, 480], "1988": 81, "199": 113, "1990": [106, 107, 110], "1991": 110, "1992": [37, 40, 44, 53, 70, 248, 276], "1993": [44, 296, 297, 412], "1994": 415, "1995": 326, "1997": [53, 121, 412, 480, 482], "1998": [60, 319, 325, 326, 328, 329, 332, 333], "1d": [20, 27, 74, 82, 95, 96, 97, 98, 99, 184, 185, 196, 198, 200, 201, 206, 213, 215, 216, 219, 221, 222, 228, 230, 231, 232, 234, 235, 239, 240, 241, 242, 244, 245], "1e": [107, 116, 488], "1e51ca3a5450c43524b9185c236cc5cc": 110, "1e9": 120, "1st": [20, 316, 490], "1x1": 118, "2": [0, 1, 3, 4, 5, 6, 9, 10, 11, 16, 18, 19, 20, 21, 22, 23, 25, 27, 28, 29, 31, 35, 36, 37, 38, 39, 40, 43, 44, 47, 49, 51, 53, 55, 58, 59, 60, 61, 62, 64, 65, 67, 70, 72, 74, 75, 77, 81, 84, 85, 86, 105, 106, 107, 108, 110, 111, 112, 113, 114, 116, 117, 118, 119, 120, 121, 122, 126, 151, 153, 156, 158, 174, 176, 184, 185, 189, 191, 193, 194, 200, 210, 212, 214, 216, 222, 226, 228, 229, 230, 232, 233, 234, 235, 237, 245, 247, 248, 251, 256, 257, 258, 259, 260, 261, 262, 263, 264, 265, 267, 268, 269, 270, 271, 272, 273, 275, 276, 277, 278, 283, 287, 289, 291, 295, 296, 297, 298, 299, 300, 301, 302, 304, 305, 318, 319, 321, 325, 326, 328, 331, 333, 336, 338, 339, 340, 341, 342, 345, 346, 347, 348, 349, 352, 353, 356, 358, 359, 364, 371, 372, 373, 376, 379, 382, 388, 390, 391, 392, 395, 397, 399, 405, 409, 412, 413, 415, 416, 417, 420, 421, 422, 423, 427, 429, 430, 433, 435, 441, 456, 457, 458, 460, 466, 467, 468, 470, 471, 472, 473, 474, 475, 479, 480, 482, 483, 484, 485, 490, 493, 496, 506, 508, 511, 513], "20": [0, 3, 117, 174, 215, 259, 264, 321, 328, 336, 339, 340, 364], "200": [113, 264], "2000": [44, 340, 480], "2001": 299, "2002": [23, 53, 70, 80, 107, 111, 477, 478, 481], "2003": [111, 256], "2004": 66, "2005": [84, 110], "2006": [53, 58, 74, 300, 416, 422, 480], "2007": [70, 84, 85], "2008": [111, 118], "2009": [112, 113, 304], "201": [44, 264], "2010": [53, 84, 85, 112], "2011": [61, 62, 70, 84, 85, 331], "2012": [70, 113, 122, 298, 342, 399], "2013": [19, 41, 51, 70, 273, 321, 413], "2014": [19, 41, 106, 118, 264, 273, 359], "2015": [23, 256, 259, 269, 275], "2016": [70, 269, 275], "2017": 405, "2018": 122, "202": 264, "2020": 122, "2022": 122, "2024": 120, "203": 264, "20309816": 305, "204": 336, "205": 297, "206": 336, "207": 70, "209": [110, 113, 298], "21": [110, 117, 259, 269, 275, 329, 348, 364, 395, 481], "210": 44, "2106": 70, "2107852473": 267, "2113": 70, "2130": 107, "21383822": 263, "215": [106, 107], "217": 44, "21712454": 321, "2186": 305, "219": [107, 110, 297], "22": [37, 40, 117, 122, 248, 259, 364, 508], "220": 298, "22054469": 266, "2208": 305, "2214": 107, "227": [44, 111], "23": [1, 117, 120, 121, 192, 259, 348, 364, 413, 480, 508], "23059566": 272, "23632778": 263, "2364": 305, "237": [43, 56, 80], "238327": 319, "239": 479, "23e": 120, "24": [0, 107, 117, 248, 359, 364], "24270353": 1, "245": 300, "246": [44, 80, 121], "24714631": 272, "25": [0, 1, 27, 38, 53, 60, 70, 84, 85, 87, 110, 116, 117, 187, 191, 211, 224, 231, 233, 237, 241, 259, 270, 296, 297, 300, 305, 336, 339, 340, 379, 484, 508], "2500": 340, "253": 300, "255": [19, 247, 326], "256": 73, "257": 73, "25737316": 272, "2580": 331, "259": 121, "2594": 331, "25th": 259, "26": [51, 107, 116, 259, 299, 304, 321], "260656459": 113, "26118259": 263, "262": 60, "264": [43, 56], "26433692": 1, "26488486": 272, "265": 47, "27": [0, 53, 74, 84, 85, 107, 215, 269, 298, 485], "270": 47, "272": 339, "2761": 305, "278": 53, "28": [0, 70, 117], "285714": 300, "28571429": 271, "28865141": 263, "289": 326, "28ecologi": 43, "29": [43, 110, 112, 113, 336], "293463": 264, "29597001": 305, "29672718": 266, "2_": 44, "2a": 118, "2b": 55, "2d": [19, 35, 36, 37, 38, 39, 40, 59, 82, 86, 87, 90, 95, 97, 99, 247, 249, 252, 267, 302, 327, 334], "2e": 120, "2f_2": 47, "2m5p3d1i": [16, 18], "2nd": [20, 316, 368, 490], "2nf_2": 52, "2x2": [1, 115, 373, 379], "2x3": [355, 356, 362, 363, 365, 366, 368, 374, 380, 381, 384, 386, 387, 389, 394, 395, 397], "3": [1, 3, 4, 5, 6, 9, 10, 18, 19, 20, 21, 22, 24, 27, 28, 29, 31, 32, 35, 39, 43, 44, 52, 53, 56, 61, 62, 63, 70, 74, 80, 84, 85, 96, 105, 106, 107, 108, 110, 111, 112, 113, 114, 116, 117, 118, 119, 120, 121, 122, 149, 151, 153, 158, 174, 185, 188, 189, 191, 193, 194, 199, 200, 210, 214, 215, 216, 222, 225, 226, 228, 229, 230, 236, 237, 239, 244, 245, 255, 256, 257, 258, 260, 262, 263, 264, 265, 266, 267, 269, 270, 271, 272, 275, 277, 278, 283, 287, 289, 294, 295, 296, 297, 298, 299, 300, 301, 302, 304, 305, 306, 309, 310, 316, 318, 319, 320, 321, 325, 326, 331, 336, 338, 339, 340, 341, 345, 346, 347, 348, 349, 351, 352, 355, 356, 359, 362, 363, 364, 365, 366, 368, 369, 371, 373, 374, 376, 379, 380, 381, 382, 384, 386, 387, 388, 389, 390, 391, 392, 394, 395, 397, 399, 402, 406, 407, 408, 409, 410, 411, 412, 413, 414, 415, 416, 417, 421, 422, 423, 429, 430, 431, 433, 435, 436, 439, 441, 445, 446, 450, 452, 453, 454, 456, 457, 458, 459, 460, 462, 463, 464, 466, 467, 468, 470, 471, 472, 473, 475, 480, 482, 483, 484, 485, 490, 496, 508, 511, 513], "30": [0, 107, 113, 114, 117, 119, 339, 340, 369], "3021": [184, 195, 215, 221, 228], "30216948": 260, "3030": [184, 195, 215, 221, 228], "30409883": 262, "306": [412, 482], "30870431": 1, "30927835": 1, "31": 107, "312": [121, 412, 482], "314": 110, "32": [117, 299, 336], "32495488": 260, "325": 331, "32630": 113, "329": 106, "33": [20, 22, 53, 84, 85, 112, 199, 264, 297, 300, 331, 336, 339, 412, 416, 508], "330": 106, "33333333333333331": 1, "335928": 122, "338": [331, 336], "34": [113, 119, 405, 477, 478, 481], "34180297": 266, "343": 113, "344": 113, "3447015": 480, "345": 248, "34891526": 260, "34989": 111, "35": [1, 110, 112, 113, 119, 256, 340, 477, 478, 481], "3519": 305, "352": 248, "354": 305, "355": [110, 305], "356": 305, "36": [63, 117, 120, 269, 275], "363": [58, 74], "36463": 121, "36514837": 273, "37": [84, 121], "3716": 305, "375": [58, 74, 268], "379": 74, "379593": 500, "38": [0, 106, 112, 117, 484], "38629436": 257, "388": 340, "3899": 110, "39": [73, 111, 117, 273, 336], "392": 336, "3937": 45, "397": 336, "3e": [106, 107, 336, 340], "3f": 304, "3k1v_a": 113, "3rd": [298, 316, 490, 513], "3x2": 373, "3x3": [276, 298, 301, 302, 482, 485], "4": [0, 1, 3, 5, 9, 20, 21, 24, 25, 29, 42, 43, 44, 51, 53, 56, 70, 72, 75, 84, 85, 110, 111, 113, 116, 117, 118, 120, 121, 122, 149, 151, 153, 158, 174, 175, 184, 188, 189, 191, 194, 210, 214, 225, 226, 228, 229, 233, 236, 245, 247, 248, 257, 258, 259, 260, 261, 262, 263, 264, 265, 267, 268, 271, 272, 273, 275, 278, 283, 289, 295, 296, 298, 304, 319, 325, 326, 331, 333, 336, 341, 345, 346, 347, 349, 352, 353, 359, 363, 364, 373, 382, 386, 387, 391, 392, 409, 412, 413, 415, 416, 421, 422, 429, 430, 433, 435, 441, 457, 460, 466, 467, 468, 470, 471, 479, 482, 483, 485, 496, 508, 511], "40": [1, 43, 56, 111, 120, 122, 273, 338, 340, 359, 364, 412, 416], "400": 297, "402": 53, "403": [106, 107], "40824829": [273, 274], "41": [111, 117, 364], "410": [106, 107], "4140": 305, "4148": [49, 59, 75, 77], "416": 336, "42": [1, 29, 54, 111, 117, 118, 120, 184, 221, 231, 296, 297, 300, 304, 336, 340, 355, 356, 362, 363, 364, 365, 366, 368, 374, 380, 381, 382, 384, 389, 394, 395, 397, 412, 460, 496], "423": 74, "42512039": 1, "427": 58, "42857143": 271, "43": [29, 67, 117, 364, 384, 389, 479], "431": 70, "432": 58, "4375": 268, "44": [1, 71, 300, 364, 479], "443": 35, "444": 70, "45": [1, 117, 120, 336, 340], "450": 297, "456": 325, "459": 415, "45995501": 321, "46": [117, 299, 336, 368, 384, 389, 412, 482], "4603377592": 114, "4603378712": 114, "4604421736": 114, "462339": 264, "466911": 319, "467481": 264, "46774194": 1, "468": 415, "4693": 111, "47": [117, 389], "479": 81, "48": [35, 64, 336], "480232": 264, "487": 81, "49": [0, 114, 117], "4hh": 110, "4x4": [296, 297, 416, 483], "5": [0, 1, 3, 5, 6, 9, 10, 18, 19, 22, 29, 36, 39, 41, 43, 48, 53, 55, 70, 84, 85, 87, 90, 105, 107, 110, 111, 112, 113, 116, 118, 121, 122, 149, 185, 193, 195, 200, 205, 206, 210, 211, 212, 214, 216, 222, 228, 229, 230, 233, 237, 245, 248, 254, 259, 264, 268, 270, 276, 278, 289, 295, 296, 297, 300, 301, 304, 319, 326, 331, 336, 339, 340, 341, 342, 345, 346, 347, 348, 349, 359, 364, 372, 373, 382, 391, 395, 399, 405, 409, 412, 414, 415, 416, 418, 421, 422, 429, 430, 433, 435, 441, 445, 457, 460, 466, 467, 468, 477, 478, 479, 480, 481, 482, 484, 485, 488, 511], "50": [1, 20, 37, 40, 111, 114, 117, 174, 229, 259, 264, 305, 321, 339, 340, 356, 508], "500": [339, 340], "5007512": 321, "50th": [111, 259], "512": 336, "5192213": 482, "52": [51, 75, 81, 117, 339], "52199973": 305, "528243": 264, "53": [35, 117, 331, 336, 413, 483], "530": 297, "533729": 264, "5338": 53, "54": [57, 58, 85, 111, 477, 478, 481], "547": 72, "54772256": 273, "55": [117, 197, 300, 305, 477, 478, 481], "55152525": 121, "555": 57, "556061": 264, "5565": 107, "557": 57, "5587": 107, "56": [70, 197], "560": 65, "562": 72, "5671": 107, "57": [107, 117, 326, 369], "577": [51, 75], "58": [54, 117], "581": 110, "586": [51, 75], "59": 112, "5917809": 262, "594590": 264, "595": 336, "5990": 121, "5996": 121, "5e": 120, "5f": [339, 340], "6": [1, 3, 4, 5, 6, 9, 10, 24, 43, 47, 48, 53, 61, 62, 70, 73, 74, 79, 84, 85, 107, 110, 111, 112, 113, 120, 121, 122, 195, 210, 214, 229, 232, 233, 244, 245, 259, 261, 266, 268, 269, 271, 289, 294, 295, 296, 298, 299, 300, 301, 302, 304, 318, 319, 331, 336, 338, 339, 340, 345, 348, 349, 359, 364, 373, 379, 382, 402, 405, 406, 407, 408, 409, 410, 411, 412, 413, 414, 415, 416, 417, 420, 421, 422, 423, 430, 431, 433, 435, 436, 439, 441, 445, 446, 450, 452, 453, 454, 456, 457, 458, 459, 460, 462, 463, 464, 466, 467, 468, 470, 471, 472, 473, 474, 475, 479, 480, 482, 483, 485, 496, 508], "60": [108, 109, 110, 114, 305, 339, 364], "601277": 264, "6018555": 298, "606e": 336, "607": 305, "609": 110, "61": [117, 300, 336, 364], "619": 121, "62": [53, 84, 85, 108, 109, 112, 300, 364, 477, 478, 481, 508], "6212": 121, "6216": 305, "6234": 121, "627677": 264, "63": [107, 117, 364], "634": 305, "636": 336, "64": [1, 87, 112, 120, 191, 364, 471], "641": 121, "645": 457, "65": 305, "65463348": 321, "66": [111, 113, 117, 199, 296, 300, 508], "6666666666666666": 511, "668": 457, "669": 413, "67": [111, 113, 117, 199, 210, 214, 326, 508], "670816": 300, "68": [113, 305], "6821": 107, "68235294": 1, "68339802": 265, "684": [340, 413], "687": [477, 478, 481], "688": [49, 59, 75, 77, 340], "69": 117, "6913": 305, "692": 53, "6928": 107, "69314718": 257, "694": 53, "6e": 107, "6x6": [1, 300], "7": [1, 38, 48, 70, 87, 111, 112, 113, 121, 122, 149, 151, 153, 158, 184, 193, 221, 228, 229, 264, 289, 297, 298, 300, 301, 304, 319, 336, 342, 345, 348, 349, 382, 399, 409, 412, 417, 430, 456, 457, 464, 466, 467, 473, 480, 482, 485, 489, 508], "70": 117, "702656": 264, "704": 336, "705": [477, 478, 481], "70710678": [273, 274], "707221": 264, "71": [63, 84, 117, 121], "7113092": 482, "71131": 412, "712": 339, "714286": 297, "71597633": 1, "72": 70, "73": [84, 85], "735": 336, "74": 117, "74166": 415, "75": [1, 27, 53, 60, 84, 85, 239, 259, 276, 297, 300, 336, 379, 382, 471, 484], "750792": 264, "7559": 298, "755929": 301, "75th": 259, "76": [66, 70, 111, 117], "77": [66, 300], "7715": 305, "771517": 297, "77549923": 1, "7768362": 265, "78": [117, 471], "78142077": 1, "783e": 340, "78787879": 1, "79": [111, 114, 117], "793": 67, "79451346": 262, "796": 336, "8": [0, 1, 4, 41, 106, 107, 112, 113, 118, 121, 122, 126, 158, 187, 195, 224, 229, 233, 244, 269, 275, 289, 297, 304, 319, 336, 340, 341, 345, 348, 349, 353, 382, 409, 412, 415, 430, 467, 468, 480, 482, 485, 508, 511], "80": [44, 111, 319, 339, 340, 364, 405, 471, 513], "803": 67, "80332382": 321, "81": 364, "810": 297, "811": 107, "81521739": 1, "81649658": [273, 274], "818": 60, "82": [107, 108, 121, 364], "820": 60, "8228": 84, "8235": 84, "82857143": 1, "82967033": 1, "83": [105, 364, 399], "8304": 305, "832": 304, "84": 364, "844": 336, "8468": 107, "85": [110, 117, 340, 471], "8547619": 1, "8552": 107, "857142857143": 379, "85714286": 1, "86": [184, 221], "86111111": 1, "86666667": 1, "86813187": 1, "87": [44, 117], "874": 340, "87434209": 482, "87709497": 1, "87777778": 1, "88": [121, 300], "884420": 359, "884498": 264, "888": 336, "889": 336, "89": [37, 40, 113, 248], "89285714": 1, "898": 340, "8e": 107, "9": [1, 106, 107, 108, 111, 114, 117, 120, 121, 145, 149, 151, 184, 185, 195, 197, 200, 215, 216, 221, 222, 228, 259, 264, 304, 305, 319, 325, 326, 328, 329, 332, 333, 336, 340, 345, 348, 349, 409, 416, 418, 430, 467, 468, 477, 478, 479, 480, 481, 508], "90": [23, 114, 264, 513], "900": 156, "905": 52, "909": 107, "912": 52, "916": 336, "91769271": 321, "92": 297, "9223372036854775807": 503, "9223489": 121, "922404392093": 1, "9230769230": 255, "93": 112, "936": 336, "939336": 1, "94": [107, 117], "948": 336, "95": [48, 52, 53, 61, 112, 117, 405], "951": 457, "952": 339, "95224719": 1, "96": [48, 114], "964": [336, 340], "97": [117, 264], "978387": 264, "984": 336, "98435423": 1, "986": 340, "98796148": 1, "99": [106, 107, 110, 117, 296, 300, 304, 382], "991987": 264, "996": 336, "999": [1, 228, 296, 298, 299, 300, 301, 304], "999887756453524252": 121, "9e": 106, "A": [1, 18, 19, 20, 25, 27, 28, 29, 30, 33, 35, 37, 40, 44, 47, 52, 53, 54, 55, 57, 58, 60, 61, 62, 66, 70, 72, 74, 84, 85, 87, 93, 101, 102, 103, 104, 106, 108, 110, 111, 112, 113, 115, 116, 118, 119, 120, 121, 130, 134, 135, 140, 147, 148, 149, 152, 156, 157, 173, 176, 184, 186, 191, 195, 197, 204, 209, 215, 218, 221, 223, 228, 233, 243, 245, 247, 248, 251, 256, 257, 258, 259, 260, 261, 262, 263, 264, 265, 266, 267, 268, 269, 270, 271, 272, 273, 275, 276, 277, 278, 281, 283, 284, 286, 288, 289, 291, 293, 294, 296, 297, 298, 299, 300, 301, 302, 304, 307, 310, 314, 318, 320, 321, 322, 323, 325, 326, 331, 333, 338, 339, 340, 341, 342, 346, 347, 348, 352, 357, 358, 359, 360, 368, 375, 381, 383, 384, 385, 386, 387, 388, 391, 392, 393, 395, 400, 405, 407, 408, 412, 415, 417, 420, 426, 427, 428, 434, 437, 442, 451, 453, 454, 456, 457, 458, 462, 463, 468, 471, 472, 473, 474, 479, 482, 483, 484, 485, 486, 493, 496, 504, 506, 511, 513], "AS": 121, "AT": [22, 111, 112, 118], "And": [114, 184, 215, 270, 508], "As": [1, 110, 113, 116, 120, 228, 277, 285, 298, 300, 326, 424, 506, 513], "At": [120, 123, 348], "Be": 228, "But": [427, 458], "By": [29, 60, 70, 82, 86, 111, 113, 120, 259, 302, 330, 334, 358, 370, 413, 458, 462, 481, 501], "For": [1, 20, 23, 30, 34, 41, 70, 93, 94, 107, 108, 109, 110, 111, 112, 113, 114, 115, 116, 117, 118, 119, 120, 121, 123, 151, 156, 157, 158, 159, 176, 184, 186, 190, 195, 215, 218, 220, 221, 223, 227, 228, 243, 246, 248, 259, 264, 284, 290, 296, 297, 298, 299, 300, 302, 304, 306, 316, 321, 322, 324, 325, 326, 331, 336, 338, 339, 340, 342, 348, 353, 354, 375, 383, 388, 398, 399, 405, 407, 408, 413, 416, 451, 462, 463, 476, 479, 481, 496, 506, 508, 511], "IF": 375, "IN": 121, "If": [1, 4, 6, 10, 11, 16, 18, 19, 20, 21, 23, 24, 27, 28, 29, 30, 31, 32, 33, 35, 36, 37, 39, 41, 44, 47, 48, 49, 51, 53, 54, 55, 59, 61, 67, 70, 74, 75, 76, 82, 84, 85, 86, 87, 90, 93, 96, 100, 101, 102, 103, 106, 109, 111, 114, 115, 116, 117, 118, 119, 120, 121, 123, 124, 125, 126, 127, 131, 133, 136, 138, 141, 142, 145, 149, 150, 151, 157, 158, 164, 165, 166, 176, 177, 178, 181, 182, 184, 185, 186, 193, 195, 197, 200, 208, 210, 212, 213, 214, 215, 216, 218, 221, 222, 223, 225, 226, 228, 229, 230, 231, 233, 234, 235, 236, 237, 238, 239, 240, 241, 242, 243, 245, 248, 249, 254, 255, 259, 261, 264, 265, 266, 268, 274, 277, 278, 280, 281, 282, 283, 284, 286, 289, 293, 294, 296, 297, 298, 299, 300, 301, 302, 304, 310, 312, 317, 318, 320, 321, 322, 323, 325, 326, 327, 330, 331, 333, 334, 336, 337, 338, 339, 340, 341, 342, 343, 345, 348, 349, 351, 352, 353, 356, 357, 358, 359, 363, 364, 365, 366, 368, 369, 370, 371, 372, 373, 374, 375, 376, 378, 379, 381, 382, 383, 384, 385, 388, 389, 390, 391, 392, 393, 394, 395, 397, 402, 405, 407, 408, 409, 412, 413, 415, 416, 418, 419, 421, 422, 424, 425, 427, 429, 431, 433, 435, 439, 444, 446, 450, 451, 456, 457, 458, 459, 460, 462, 463, 465, 466, 467, 468, 469, 470, 472, 473, 474, 475, 479, 480, 482, 483, 484, 485, 487, 488, 489, 490, 492, 496, 497, 506], "In": [1, 3, 19, 20, 23, 53, 70, 72, 84, 85, 87, 111, 112, 113, 114, 116, 118, 122, 176, 184, 193, 212, 215, 221, 247, 256, 259, 264, 276, 297, 298, 304, 318, 325, 326, 336, 340, 345, 400, 405, 407, 409, 415, 416, 424, 436, 456, 457, 458, 459, 472, 479, 481, 485, 506, 508, 511, 513], "It": [1, 3, 19, 41, 42, 43, 49, 53, 54, 56, 58, 59, 60, 67, 70, 72, 74, 75, 79, 81, 105, 106, 108, 111, 112, 113, 114, 116, 118, 120, 122, 126, 137, 149, 151, 152, 153, 155, 156, 158, 184, 195, 205, 206, 215, 221, 224, 259, 262, 264, 268, 276, 294, 298, 299, 302, 304, 308, 309, 313, 315, 317, 325, 326, 330, 333, 336, 339, 340, 356, 395, 400, 408, 409, 413, 416, 422, 440, 447, 448, 449, 463, 464, 473, 475, 480, 481, 482, 485, 488, 496, 500, 504, 508], "Its": [7, 333], "NOT": [19, 145], "No": [20, 48, 106, 107, 110, 119, 122, 151, 228, 298], "Not": [112, 184, 245, 300], "ONE": [19, 41], "OR": 20, "Of": 113, "On": [72, 331, 413], "One": [53, 118, 123, 182, 264, 292, 407, 409, 410, 413, 416, 431, 442, 480, 482, 483, 485, 506], "Or": [409, 506], "That": [71, 77, 116, 238, 417, 453, 454, 463], "The": [0, 1, 3, 4, 5, 6, 7, 11, 15, 16, 18, 19, 21, 22, 23, 24, 25, 29, 30, 34, 35, 36, 37, 38, 39, 40, 41, 42, 43, 44, 47, 48, 51, 53, 54, 55, 56, 58, 59, 60, 67, 70, 71, 73, 74, 75, 77, 79, 80, 82, 84, 85, 86, 87, 88, 89, 90, 91, 93, 94, 95, 96, 97, 98, 99, 101, 104, 105, 106, 107, 108, 109, 110, 111, 112, 113, 114, 115, 116, 117, 118, 119, 120, 121, 122, 123, 124, 125, 126, 127, 129, 131, 132, 133, 134, 135, 136, 137, 138, 139, 141, 142, 143, 145, 146, 149, 151, 152, 153, 154, 155, 156, 157, 159, 162, 164, 169, 170, 171, 172, 174, 175, 176, 177, 178, 180, 181, 182, 183, 186, 189, 190, 191, 192, 193, 194, 197, 210, 214, 218, 220, 221, 223, 226, 227, 228, 229, 230, 231, 233, 234, 235, 236, 237, 243, 245, 246, 247, 254, 255, 256, 257, 258, 259, 261, 262, 263, 264, 265, 266, 268, 270, 272, 273, 274, 277, 278, 281, 284, 289, 290, 291, 292, 293, 294, 295, 296, 297, 298, 299, 300, 302, 304, 305, 307, 310, 312, 314, 317, 318, 320, 322, 324, 325, 326, 330, 331, 332, 333, 336, 337, 338, 339, 340, 342, 343, 344, 345, 346, 347, 348, 349, 352, 355, 357, 358, 360, 361, 362, 363, 364, 365, 368, 370, 371, 372, 373, 374, 375, 376, 378, 379, 381, 382, 383, 384, 385, 386, 387, 388, 389, 392, 394, 395, 396, 398, 399, 400, 401, 402, 404, 406, 407, 408, 409, 410, 411, 412, 413, 414, 415, 416, 417, 418, 419, 421, 422, 423, 424, 425, 426, 427, 429, 430, 431, 433, 434, 435, 436, 439, 440, 441, 442, 443, 446, 447, 448, 449, 450, 451, 452, 453, 454, 455, 456, 457, 458, 459, 460, 461, 462, 463, 465, 466, 468, 469, 472, 473, 475, 476, 477, 479, 480, 481, 482, 483, 484, 485, 488, 492, 495, 496, 497, 501, 506, 508, 511, 513], "Then": [1, 3, 259, 270, 305, 319], "There": [1, 29, 54, 67, 107, 113, 116, 119, 199, 291, 339, 340, 348, 373, 400, 472, 475, 506, 511, 513], "These": [0, 1, 20, 22, 43, 53, 84, 85, 113, 116, 120, 121, 122, 162, 171, 172, 174, 175, 253, 301, 303, 320, 332, 338, 342, 373, 406, 407, 436], "To": [1, 20, 53, 84, 85, 111, 112, 113, 116, 119, 120, 123, 145, 176, 184, 215, 221, 259, 264, 291, 295, 296, 298, 300, 304, 336, 405, 472, 487, 506, 513], "Will": [27, 139, 143, 145, 279, 288, 320, 341], "With": [106, 256, 268, 496], "_": [44, 108, 111, 112, 116, 121, 153, 228, 276, 298, 380, 481], "_1": 116, "__": 113, "____________1______________2_________": 121, "________________": 121, "____________________": 121, "__bool__": [20, 228], "__call__": [19, 501, 503, 504], "__contains__": [20, 228, 277], "__copy__": [20, 151, 160, 171, 174, 228, 400], "__deepcopy__": [20, 151, 160, 171, 174, 228, 400], "__eq__": [20, 149, 151, 160, 162, 171, 174, 176, 191, 228, 277, 342], "__get__": [491, 492], "__getitem__": [11, 20, 228, 277, 342, 400], "__init__": [123, 125, 127], "__iter__": [20, 28, 228, 342, 400], "__len__": [20, 228, 400], "__locat": 113, "__name__": 499, "__ne__": [20, 149, 151, 160, 162, 171, 174, 176, 191, 228, 277, 342], "__reversed__": [20, 28, 228], "__set__": 492, "__setstate__": [11, 19], "__str__": [3, 11, 14, 20, 91, 95, 98, 191, 228, 277, 320, 342, 400], "_block_comput": 87, "_ci": 43, "_dna": 20, "_except": 118, "_interval_tre": 151, "_io": [105, 109], "_is_stale_tre": 151, "_leaf_index": 434, "_myformat_sniff": 123, "_myformat_to_some_skbio_class": 123, "_not_": 348, "_rebuild_tre": 151, "_setup_debug_trac": 502, "_some_skbio_class_to_myformat": 123, "_tree": 479, "aT": 112, "a_1": 116, "aa": [28, 111, 113, 118, 191], "aaa": [121, 235], "aaaaaaaaa": 110, "aaaaaaaaaa": 110, "aaaaaaattttttt": 513, "aaaaaactctctaaactcactaaggctctctacccctcttcagagaagtcga": 0, "aaaaaccgat": 110, "aaaataaata": 110, "aaacaaacca": 110, "aaaccattgc": [111, 118], "aaacccttgc": [111, 118], "aaacccttgccg": 111, "aaacccttgccggtacgcttaaaccattgccggtacgcttaa": 111, "aaacccttgccgttacgcttaaaccgaggccgggacactcat": 111, "aaaccgaggc": [111, 118], "aaagataggc": 110, "aaatatggat": 110, "aaatcctatg": 110, "aac": 119, "aacaaatgca": 110, "aacaacagga": 110, "aacaccaaacttctccacc": 112, "aacaccaaacttctccaccacgtgagctacaaaag": 112, "aaccttatca": 110, "aacga": 228, "aacgaaggcg": 110, "aacgac": 228, "aactttgtag": 110, "aagaactttc": 110, "aagaggttac": 110, "aagcctggtg": 110, "aagccttggc": 111, "aagccttggcagtgcagggtgagccgtgg": 111, "aagccttggcagtgcagggtgagccgtggccgggcacggtat": 111, "aagctngggc": [111, 118], "aagctngggcatttcagggtgagcccgggcaatacagggtat": 111, "aagga": 228, "aaggaatcaa": 110, "aaggaatttg": 110, "aagtaa": 210, "aagtatttgg": 110, "aagtcttaga": 110, "aagtcttttt": 110, "aagttgttag": 110, "aagucuuuuu": 110, "aata": 119, "aataaac": 119, "aataagtgca": 110, "aatacagggt": [111, 118], "aatataccggttataa": 232, "aatatggatt": 110, "aatgaa": [210, 213, 214], "aatgtt": 213, "aatt": 348, "aattaaataa": 110, "aattctggat": 110, "aattg": 513, "aattgccggac": 513, "aattgg": 318, "aauauggauu": 110, "ab": [112, 195, 413], "ab07acbb1e496801937adfa772424bf7": 500, "ababacac": 195, "abbrevi": [122, 320], "abc": [108, 171, 195, 209, 228, 413, 482, 484, 485], "abcd": [413, 480, 483], "abcdef": 1, "abcf": 413, "abil": [116, 506], "abl": [20, 24, 87, 184, 215, 221, 228, 259, 339, 402, 506], "about": [1, 30, 34, 67, 93, 94, 108, 111, 112, 116, 120, 121, 123, 148, 151, 157, 159, 160, 162, 173, 176, 186, 190, 218, 220, 223, 227, 243, 246, 254, 284, 290, 319, 322, 324, 333, 339, 340, 348, 378, 383, 398, 451, 476, 482, 483, 485, 507, 508], "abov": [0, 1, 3, 29, 49, 111, 113, 117, 118, 119, 120, 121, 123, 125, 127, 184, 215, 221, 228, 276, 296, 298, 300, 304, 407, 456, 458, 463, 508], "absenc": [48, 340, 380, 431], "absent": [245, 331, 415], "absolut": [256, 264, 298, 388, 415, 473, 495], "abstract": [160, 162, 171, 174, 195, 209], "abund": [1, 43, 44, 45, 53, 55, 58, 60, 67, 70, 80, 82, 84, 85, 86, 87, 90, 105, 259, 264, 319, 325, 326, 332, 333, 340, 382, 388], "abx": 338, "ac": [20, 22, 24, 27, 29, 31, 32, 35, 38, 110, 112, 113, 121, 149, 201, 508], "aca": [236, 237], "acaatcaaat": 110, "acac": [203, 236], "acacatttatta": 237, "acacgacgtt": [204, 234, 236], "acad": [37, 40], "academ": 46, "academi": 248, "acagaattga": 110, "acaggttggc": [111, 118], "acata": 112, "acatggcaat": 110, "acatgggata": 110, "acc": [0, 107, 508], "accaatattt": 110, "accaatttga": 110, "acccc": 0, "acceler": 431, "accept": [1, 20, 31, 87, 188, 189, 225, 226, 244, 248, 253, 259, 298, 302, 304, 336, 339, 340, 412, 423, 426, 453, 454, 460, 467, 468, 471, 504], "acces": 106, "access": [11, 20, 104, 110, 111, 113, 122, 171, 172, 174, 175, 176, 191, 276, 480, 492], "accgaat": 184, "accgaau": 221, "accgggta": 508, "accggttggc": 111, "accggttggccgttcagggtacaggttggccgttcagggtaa": 111, "accgttcg": 121, "accgttgta": [108, 118], "accguuaguc": 508, "accommod": 149, "accompani": [111, 277], "accomplish": [1, 256, 506], "accord": [49, 53, 184, 215, 221, 330, 334, 386, 387, 478], "accordingli": [473, 475], "account": [49, 96, 208, 310, 325, 333, 340, 415, 511], "accu_dist": 409, "accumul": [63, 66, 409], "accumulate_to_ancestor": 421, "accur": [49, 55, 61, 62, 477, 478, 480, 481], "accuraci": 331, "acdefghikl": [96, 97], "acdfnasanftacgnpnrtesl": 235, "acg": [20, 27, 28, 29, 31, 32, 119, 121, 234, 236], "acga": [20, 21, 24, 228], "acgaactatt": 110, "acggggaggcggag": [185, 200, 216, 222], "acgggu": 508, "acgt": [20, 21, 24, 25, 33, 171, 172, 174, 175, 211, 212, 213, 228, 229, 238, 247, 251], "acgta": 119, "acgtac": 119, "acgtacgt": 211, "acgtgagctacaaaag": 112, "acgtgccta": 0, "acgtgcctaggtacgcaag": 0, "acgtggaa": 229, "acgtn": 245, "acgtu": 42, "achiev": [70, 456, 457, 464, 473, 506, 508], "acid": [35, 37, 40, 110, 111, 112, 115, 118, 122, 184, 191, 193, 195, 215, 221, 228, 245, 247, 248], "acquir": 339, "across": [7, 27, 70, 111, 112, 118, 151, 182, 259, 264, 298, 339, 349, 458, 468, 479, 482, 483, 485], "act": [0, 29, 125, 126, 127], "actaaggctc": 0, "actaaggctcctaacccccttttctcaga": 0, "actaaggctctct": 0, "actaaggctctctacccctctcagaga": 0, "actacattcg": 110, "actatacgga": 110, "actcat": 111, "action": 162, "activ": 505, "acttagtt": 211, "actual": [71, 77, 120, 123, 298], "acwgn": [196, 198, 206], "ad": [19, 35, 36, 37, 38, 39, 40, 61, 62, 111, 121, 152, 209, 228, 259, 264, 294, 296, 298, 299, 300, 301, 304, 318, 326, 329, 331, 338, 339, 340, 348, 373, 402, 406, 407, 408, 409, 410, 411, 412, 413, 414, 415, 416, 417, 421, 422, 423, 431, 433, 435, 436, 441, 445, 446, 450, 452, 453, 454, 456, 457, 458, 459, 462, 463, 468, 470, 471, 472, 473, 475, 480, 482, 483, 485, 493, 496, 498, 501, 511], "adapt": 479, "adata": 390, "add": [1, 36, 39, 120, 121, 123, 129, 149, 151, 153, 155, 228, 261, 268, 270, 271, 272, 343, 344, 348, 368, 389, 402, 423], "add_format": [125, 127], "addit": [1, 30, 34, 41, 42, 53, 83, 84, 85, 89, 93, 94, 110, 111, 112, 113, 114, 118, 119, 120, 157, 159, 176, 184, 186, 190, 215, 218, 220, 221, 223, 227, 243, 246, 247, 256, 257, 258, 259, 276, 284, 290, 291, 322, 324, 383, 398, 400, 406, 415, 423, 424, 425, 451, 468, 476, 479, 480, 501, 506], "addition": [1, 20, 105, 116, 145, 151, 387, 472, 508, 511], "additon": 111, "address": [259, 506], "adef": 413, "adenin": [184, 221], "adequ": 339, "adher": 120, "adiv_faith_pd": 1, "adiv_sob": 1, "adjac": [235, 357], "adjust": 70, "adoni": 299, "adopt": [70, 245], "advanc": [1, 20, 496], "advantag": [70, 291, 501], "advis": [84, 85, 90], "ae000111": 107, "ae000171": 107, "ae000174": 107, "ae000394": 107, "ae000425": 107, "af031394": 107, "af035635": 121, "af178031": 107, "af178032": 107, "af178033": 107, "affect": [111, 116, 191, 228, 296, 300, 472], "aforement": 122, "after": [19, 21, 24, 35, 36, 37, 111, 112, 120, 121, 122, 123, 151, 155, 182, 264, 269, 270, 297, 298, 301, 304, 325, 340, 419, 448, 450, 459, 469], "ag": [20, 21, 24, 27, 276, 338, 339], "agaagacc": 233, "agaagctatg": 110, "agaagctctt": 110, "agaagcuaug": 110, "agacatcacg": 110, "agagcatgcg": 110, "agaggttcta": 113, "agagguucua": 113, "agagttgaag": 118, "agagttgaaggtatct": [108, 118], "again": [1, 20, 111, 112, 176, 273, 379], "against": [20, 35, 38, 112, 149, 151, 191, 228, 259, 304, 346, 347], "agatataaag": 110, "agatcttttg": 110, "agatgagtat": 110, "agctttctgc": 110, "agg": 508, "aggaccttat": 110, "aggctc": 0, "aggctcccttctacccctctcagaga": 0, "agggaaagtt": 110, "agggctggct": 110, "agggga": 508, "agggta": 254, "agglom": 480, "aggreg": 513, "aggtacccta": 110, "aggtgcagta": 110, "agre": [136, 141, 407], "agtactctaa": 110, "agtgcagggt": [111, 118], "aguauucugccacuguaagaa": 193, "aguc": [231, 239, 241], "ahead": 513, "aiacaqkm": 121, "aim": 319, "ainsworth": 297, "aitchison": [256, 257, 258, 262, 263, 265, 266, 273], "aitchson": 267, "al": [259, 304, 342, 399], "ala": 215, "alanin": [23, 215], "aldex2": 264, "alexandro": 405, "algorithm": [35, 38, 113, 296, 297, 298, 300, 305, 306, 307, 309, 310, 312, 314, 316, 317, 325, 326, 331, 333, 415, 477, 478, 480, 481], "alia": [11, 51, 53, 68, 70, 76, 79, 84, 85, 114, 247, 259, 268, 285, 410, 412, 414, 416, 421, 439, 441, 453, 454, 460, 468, 480, 487, 498], "alias": [498, 499], "alic": 228, "alig": 13, "align": [106, 107, 111, 112, 149, 151, 228, 247, 345, 346, 347, 505, 506, 508], "aligned_query_sequ": [0, 11], "aligned_target_sequ": [0, 11], "alignmentstructur": 19, "alignpath": 14, "all": [1, 19, 20, 22, 23, 29, 35, 36, 37, 42, 44, 53, 54, 55, 67, 70, 71, 77, 80, 82, 84, 85, 86, 87, 100, 101, 102, 103, 104, 106, 108, 109, 110, 111, 112, 113, 114, 115, 117, 118, 120, 121, 122, 123, 124, 130, 140, 149, 151, 153, 155, 156, 165, 171, 172, 174, 175, 180, 182, 184, 193, 197, 199, 208, 215, 221, 228, 229, 233, 235, 244, 247, 248, 251, 259, 261, 264, 268, 270, 271, 272, 273, 276, 278, 281, 286, 289, 293, 295, 296, 297, 298, 299, 300, 301, 309, 310, 317, 318, 319, 321, 323, 330, 331, 339, 340, 341, 348, 349, 352, 356, 389, 397, 401, 404, 405, 406, 407, 408, 409, 412, 415, 416, 417, 422, 425, 426, 440, 442, 447, 448, 453, 454, 460, 461, 462, 463, 468, 472, 473, 475, 479, 482, 483, 485, 501], "all_char": 116, "allow": [106, 111, 112, 116, 118, 119, 120, 123, 145, 151, 176, 184, 215, 221, 229, 233, 256, 277, 278, 296, 297, 299, 300, 301, 305, 331, 342, 348, 399, 412, 467, 477, 478, 501, 513], "allow_edge_estim": [477, 478, 481], "allow_empti": 467, "allow_overlap": 278, "allvltkt": 121, "almost": 488, "alon": [116, 297], "along": [20, 115, 174, 321, 330, 331, 365, 386, 397], "alpha": [82, 88, 259, 336, 337, 341], "alpha_divers": [1, 43, 53, 70, 86, 88], "alpha_pwr": [336, 339, 340], "alphabet": [0, 32, 42, 88, 89, 106, 111, 184, 191, 195, 215, 221, 228, 245, 247, 248, 249, 251, 254, 508], "alphanumer": 120, "alr": 258, "alreadi": [116, 121, 123, 125, 126, 127, 228, 277, 298, 456, 458, 472], "also": [0, 1, 20, 22, 23, 49, 53, 75, 83, 84, 85, 86, 95, 97, 99, 110, 111, 112, 113, 114, 115, 116, 118, 120, 121, 122, 123, 124, 151, 176, 193, 212, 228, 235, 244, 245, 247, 259, 273, 274, 276, 296, 297, 298, 300, 304, 319, 326, 333, 336, 339, 340, 353, 358, 370, 400, 416, 422, 441, 447, 449, 473, 481, 484, 488, 504, 506, 508, 513], "altern": [31, 51, 75, 122, 123, 193, 207, 256, 269, 275, 281, 293, 298, 301, 304, 331, 336, 429, 496, 499], "although": [70, 304, 339, 349, 405, 407, 408], "altschul": [106, 107], "alwai": [1, 19, 20, 110, 113, 116, 118, 120, 126, 145, 149, 152, 176, 182, 193, 277, 373, 435, 456, 457, 458, 492, 513], "amar": 113, "ambigu": [138, 142, 184, 209, 221], "amen": 257, "american": [44, 457], "amino": [35, 37, 40, 110, 111, 115, 184, 191, 193, 215, 245, 247, 248], "amino_acid": 191, "among": [1, 49, 70, 101, 113, 256, 289, 306, 326, 333, 412, 413, 433, 441, 480, 482, 483, 485, 509], "amount": [301, 400, 468, 513], "amplicon": [1, 345], "amsterdam": [319, 325, 326, 332, 333], "an": [0, 1, 3, 4, 5, 6, 7, 8, 9, 10, 11, 17, 19, 20, 21, 22, 23, 24, 26, 27, 28, 29, 31, 34, 35, 36, 37, 41, 51, 53, 54, 56, 64, 67, 68, 72, 73, 76, 79, 81, 82, 84, 85, 86, 90, 94, 100, 101, 102, 103, 104, 105, 106, 107, 108, 109, 110, 111, 112, 113, 114, 115, 116, 117, 118, 120, 121, 122, 123, 124, 125, 126, 127, 131, 133, 134, 135, 136, 139, 141, 143, 145, 146, 149, 151, 152, 153, 155, 156, 158, 159, 161, 166, 167, 172, 174, 175, 176, 182, 185, 190, 191, 193, 195, 200, 209, 216, 220, 221, 222, 227, 228, 229, 239, 241, 244, 245, 246, 247, 251, 259, 262, 263, 265, 266, 268, 270, 273, 274, 276, 277, 278, 280, 281, 285, 289, 290, 292, 293, 296, 298, 299, 300, 302, 304, 311, 314, 318, 319, 320, 324, 330, 331, 336, 338, 339, 340, 341, 342, 343, 344, 345, 351, 352, 355, 356, 357, 358, 363, 365, 366, 368, 371, 372, 373, 374, 376, 378, 379, 389, 392, 395, 396, 397, 398, 399, 400, 402, 403, 405, 407, 408, 409, 410, 412, 414, 416, 417, 419, 420, 421, 422, 424, 427, 428, 433, 439, 441, 444, 450, 453, 454, 456, 457, 458, 459, 460, 462, 463, 466, 468, 470, 472, 473, 474, 475, 476, 477, 478, 479, 480, 481, 482, 483, 485, 487, 491, 492, 494, 495, 496, 500, 501, 504, 506, 508, 511, 513], "analog": 70, "analogu": 300, "analys": [53, 84, 85, 296, 431, 436, 480, 509], "analysi": [1, 53, 67, 84, 85, 111, 118, 257, 259, 264, 273, 296, 299, 300, 305, 306, 308, 309, 313, 315, 316, 317, 321, 325, 326, 331, 332, 333, 336, 339, 340, 400, 431], "analyt": 54, "analyz": [1, 256, 326, 339], "ancacwwgacgtt": [202, 203, 205], "ancestor": [53, 70, 229, 400, 409, 416, 421, 439, 458, 468], "ancestr": [53, 401, 421, 439], "ancom_df": 259, "anderson": [299, 300], "ani": [1, 10, 19, 20, 22, 23, 29, 31, 41, 42, 45, 79, 80, 111, 113, 115, 116, 120, 121, 125, 126, 127, 138, 142, 145, 149, 151, 155, 156, 164, 176, 178, 181, 184, 215, 221, 228, 247, 254, 259, 261, 264, 298, 300, 301, 305, 310, 314, 325, 330, 331, 336, 338, 339, 353, 358, 382, 392, 394, 400, 402, 405, 409, 410, 416, 419, 423, 431, 432, 433, 435, 441, 452, 466, 479, 496, 501, 502, 504, 506, 511, 513], "anim": 54, "ann": [52, 73], "anndata": 390, "annot": [110, 113, 114, 120, 151], "announc": 120, "anosim": [1, 299, 300], "anoth": [1, 20, 21, 29, 53, 84, 85, 113, 115, 116, 149, 151, 155, 158, 162, 176, 191, 228, 231, 240, 242, 247, 277, 304, 345, 402, 422, 445], "anova": [259, 299, 307, 311], "answer": 500, "anti": [1, 296], "antibiot": [270, 338], "anticip": 513, "anyon": 120, "anyth": [1, 111, 112, 119, 123, 228, 392, 501, 502, 504, 513], "anytim": 120, "anywher": [115, 116, 120, 259], "apart": [441, 457], "api": [111, 176, 253], "app": 119, "appear": [1, 44, 106, 118, 120, 121, 280, 297, 325, 326, 336, 342, 472, 484], "append": [0, 24, 118, 123, 228, 423, 435, 493], "appl": [84, 85], "appli": [0, 1, 19, 20, 23, 82, 85, 86, 87, 90, 110, 111, 116, 120, 122, 151, 162, 171, 172, 174, 175, 184, 215, 221, 228, 247, 256, 281, 293, 294, 298, 301, 305, 325, 339, 352, 373, 379, 382, 388, 395, 402, 407, 408, 409, 413, 417, 423, 435, 462, 463, 480, 487, 498, 499, 501, 513], "applic": [19, 23, 35, 41, 176, 319, 409, 421, 422, 433, 459, 468, 513], "approach": [264, 298, 339, 417, 420], "appropri": [1, 104, 115, 145, 229, 259, 506, 511], "approx": 336, "approxim": [333, 336], "aqfvdhwkel": 109, "aquat": 326, "ar": [0, 1, 3, 19, 20, 22, 23, 27, 28, 29, 30, 31, 33, 34, 35, 36, 37, 38, 39, 40, 41, 42, 44, 47, 48, 49, 53, 54, 60, 61, 62, 70, 82, 84, 85, 86, 87, 89, 90, 93, 94, 100, 101, 102, 103, 104, 106, 107, 108, 109, 110, 111, 112, 113, 114, 115, 116, 117, 118, 119, 120, 121, 122, 123, 125, 126, 127, 130, 136, 140, 141, 145, 149, 151, 153, 155, 157, 158, 159, 162, 164, 165, 176, 177, 178, 180, 181, 182, 184, 186, 187, 188, 189, 190, 191, 192, 193, 194, 195, 199, 202, 203, 204, 205, 210, 215, 217, 218, 220, 221, 223, 224, 225, 226, 227, 228, 229, 233, 239, 240, 241, 242, 243, 244, 245, 246, 247, 248, 249, 254, 255, 256, 257, 259, 261, 264, 265, 266, 268, 270, 271, 272, 273, 276, 277, 281, 284, 285, 289, 290, 291, 293, 294, 295, 296, 297, 298, 299, 300, 301, 302, 304, 307, 310, 317, 318, 319, 320, 321, 322, 324, 325, 326, 329, 330, 331, 333, 334, 336, 338, 339, 340, 342, 348, 349, 352, 354, 358, 364, 373, 375, 383, 385, 386, 387, 388, 390, 391, 392, 397, 398, 399, 400, 404, 405, 407, 408, 409, 411, 412, 413, 415, 416, 417, 419, 421, 422, 427, 429, 431, 433, 435, 436, 439, 442, 443, 444, 451, 452, 453, 454, 456, 457, 458, 459, 460, 461, 463, 465, 466, 467, 468, 469, 472, 473, 475, 476, 479, 480, 481, 484, 488, 489, 492, 494, 496, 501, 503, 504, 506, 508, 511, 513], "arang": [364, 369], "arbitrari": [20, 22, 25, 115, 120, 121, 184, 215, 221, 228, 318, 358, 392, 408, 482, 483, 485, 501, 508], "arbitrarili": [479, 496, 513], "archaea": [429, 430, 467], "archiv": [122, 500], "area": [1, 55], "arg": [123, 130, 140, 188, 189, 215, 225, 226, 342], "arginin": 215, "argument": [19, 20, 30, 31, 34, 41, 93, 94, 115, 125, 126, 127, 130, 136, 138, 139, 140, 141, 142, 143, 157, 159, 186, 188, 189, 190, 218, 220, 223, 225, 226, 227, 238, 243, 246, 247, 257, 281, 284, 290, 293, 322, 324, 342, 383, 398, 409, 451, 476, 501, 504], "argumentoverridewarn": [136, 141], "aris": [466, 479], "arithmet": 484, "armidal": [415, 485], "around": [61, 62, 87, 111, 118, 121, 247, 260, 298, 337, 506, 511], "arrai": [1, 3, 4, 5, 6, 8, 9, 10, 15, 17, 19, 23, 27, 53, 70, 84, 85, 95, 96, 97, 99, 102, 111, 117, 184, 196, 198, 201, 206, 210, 214, 215, 219, 221, 228, 240, 242, 245, 247, 249, 251, 257, 258, 260, 261, 262, 263, 265, 266, 267, 268, 269, 270, 271, 272, 273, 274, 276, 277, 285, 292, 302, 304, 305, 310, 314, 317, 319, 330, 334, 336, 337, 338, 339, 340, 341, 345, 346, 347, 348, 349, 351, 352, 365, 368, 372, 376, 378, 382, 384, 388, 389, 392, 395, 409, 434, 466, 479, 508], "arrang": [319, 480], "array_lik": [1, 3, 4, 5, 6, 14, 15, 16, 20, 44, 45, 46, 47, 48, 49, 50, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 71, 72, 73, 74, 75, 76, 77, 78, 79, 80, 81, 82, 86, 87, 90, 91, 95, 96, 97, 98, 99, 185, 200, 216, 222, 228, 232, 235, 244, 257, 258, 260, 261, 262, 263, 265, 266, 267, 268, 269, 270, 271, 272, 273, 275, 277, 296, 298, 299, 300, 301, 304, 327, 330, 334, 337, 340, 341], "articl": [19, 41, 108], "artifact": [28, 35, 36, 37], "artifici": [113, 319], "asarrai": [277, 355, 356, 362, 363, 365, 366, 368, 373, 374, 379, 380, 381, 384, 386, 387, 389, 394, 395, 397], "ascend": [32, 158], "ascii": [112, 119, 120, 123, 245, 247, 403, 511], "ascii_art": [116, 347, 401, 406, 407, 408, 409, 412, 413, 415, 425, 429, 430, 435, 440, 443, 445, 447, 448, 449, 450, 456, 457, 458, 459, 462, 463, 465, 468, 469, 472, 477, 478, 480, 481, 484, 511], "ask": 126, "asn": 215, "asp": 215, "asparagin": 215, "aspart": 215, "aspect": 501, "ass": 57, "assai": 339, "assembl": 110, "assert": 489, "assert_frame_equ": 488, "assertionerror": [488, 489], "assess": [70, 80, 296, 298, 299, 300, 304, 408, 463], "assign": [23, 31, 42, 82, 86, 118, 120, 149, 228, 244, 251, 259, 264, 296, 299, 300, 318, 340, 404, 405, 406, 409, 427, 431, 477, 478, 481, 484], "assign_id": 427, "assign_support": 471, "assist": [120, 513], "associ": [1, 20, 44, 70, 112, 120, 121, 122, 124, 131, 132, 133, 149, 152, 154, 156, 165, 167, 176, 184, 215, 221, 228, 297, 304, 318, 330, 334, 337, 338, 339, 348, 351, 358, 373, 390, 392, 421, 422, 427, 433, 506], "asst": [211, 212], "assum": [1, 44, 53, 55, 63, 66, 84, 85, 108, 111, 112, 115, 117, 125, 127, 176, 187, 188, 189, 228, 264, 276, 277, 293, 304, 305, 326, 330, 336, 337, 339, 340, 388, 473, 475], "assumpt": [67, 116, 254, 259, 264, 424, 425, 463, 480], "asv": 1, "asx": 215, "asymmetr": [247, 277], "asymptot": 67, "ataaatcacg": 110, "ataacgttgg": 110, "ataagggatg": 110, "atacaaccat": 110, "atactcccaa": 110, "atagacc": 513, "atagcatacc": 110, "atagttacac": 110, "atatatacat": 112, "atatatat": 318, "atatatgttt": 110, "atatgaacaaa": 513, "atattacaac": 110, "atcaaaaggg": 110, "atcaccgcta": 110, "atcactgaaa": 110, "atcataacta": 110, "atccatatat": 110, "atcggcgat": 255, "atgagccatg": 110, "atgc": 352, "atgcactagg": 110, "atgcatgcat": 114, "atgcatgcatgcatgcatgcatgcatgcatgcatgcatgc": 114, "atgcatgcatgcatgcatgcatgcatgcatgcatgcatgcatgcatgcatgcatgcatgc": 114, "atgccactttaa": [188, 189], "atgccccttc": 110, "atggca": 318, "atggcc": 318, "atggcg": 318, "atggct": 318, "atggtatgaa": 110, "atgtgtatttga": 508, "atgttgtagt": 110, "atl": [189, 194, 226], "atla": 248, "atom": [358, 392], "att": 197, "attach": [405, 409, 410, 419, 431, 472], "attagaaaga": 110, "attcgttgtg": 110, "attctggaac": 110, "attempt": [111, 120, 145, 405, 424], "attr": [114, 358, 392, 410, 466], "attr_1": 466, "attr_n": 466, "attribut": [3, 11, 14, 20, 31, 91, 95, 96, 97, 98, 99, 104, 109, 110, 111, 113, 114, 117, 119, 120, 121, 124, 148, 149, 150, 151, 156, 160, 162, 171, 173, 174, 176, 184, 191, 195, 209, 215, 221, 228, 245, 247, 277, 278, 289, 291, 307, 312, 314, 320, 332, 339, 342, 358, 392, 399, 400, 404, 409, 410, 417, 431, 435, 456, 457, 458, 466, 473, 475, 479, 486, 489, 491, 492, 503, 508], "attribute_nam": 466, "attributeerror": [228, 492], "atttcagggt": [111, 118], "aucauaacua": 110, "aug": 111, "augccacuuuaa": [191, 194, 225, 226], "auguguauuu": 508, "austral": 299, "australia": [415, 485], "australian": [296, 415, 485], "auth": 123, "author": [70, 113, 121, 228, 259], "auto": [145, 245], "autom": 409, "automat": [19, 21, 24, 29, 30, 34, 93, 94, 115, 119, 120, 130, 140, 149, 157, 159, 186, 190, 218, 220, 223, 227, 238, 243, 246, 276, 284, 290, 320, 322, 324, 383, 398, 409, 413, 419, 431, 435, 451, 456, 457, 458, 476, 506], "auxilari": 123, "av": 305, "avail": [1, 86, 106, 111, 112, 113, 117, 120, 122, 134, 135, 191, 192, 245, 248, 291, 296, 297, 298, 299, 300, 310, 336, 340, 358, 392, 472, 506, 513], "averag": [260, 264, 305, 306, 330, 334, 382, 412, 477, 479, 481, 482, 484], "averagegradientanova": 305, "avg": 305, "avoid": [19, 109, 120, 121, 123, 155, 319, 334, 472], "aw": [0, 70], "awar": [23, 70, 120, 228], "awesom": 513, "awgh": 0, "ax": [20, 306, 309, 310, 316, 319, 321, 325, 326, 342, 345, 352, 373], "axes3d": 321, "axi": [20, 27, 55, 91, 115, 174, 247, 310, 317, 320, 321, 330, 337, 340, 342, 343, 344, 345, 346, 347, 348, 349, 351, 352, 355, 356, 358, 363, 365, 366, 368, 369, 370, 371, 372, 373, 374, 375, 376, 378, 379, 381, 382, 384, 385, 386, 387, 388, 389, 392, 395, 397, 489], "axis_label": [1, 321], "axis_len": 174, "b": [1, 19, 20, 25, 29, 31, 32, 33, 53, 54, 55, 67, 70, 74, 90, 112, 115, 116, 120, 146, 184, 215, 221, 228, 248, 249, 264, 274, 276, 277, 278, 283, 286, 287, 289, 295, 297, 298, 318, 321, 338, 339, 346, 348, 349, 352, 356, 381, 392, 401, 403, 405, 406, 407, 408, 409, 411, 412, 413, 414, 415, 416, 417, 418, 421, 422, 424, 425, 426, 427, 432, 433, 435, 436, 437, 438, 439, 440, 441, 442, 443, 445, 446, 447, 448, 449, 450, 452, 453, 454, 455, 456, 457, 458, 459, 460, 461, 462, 463, 465, 466, 468, 469, 470, 471, 472, 473, 475, 479, 480, 482, 483, 484, 485, 500, 506, 508, 511], "b1": [259, 264], "b2": [259, 264], "b3": [259, 264], "b4": [259, 264], "b5": [259, 264], "b6": [259, 264], "b7": [259, 264], "b_b": 116, "b_i": [80, 273], "ba": 121, "babp": 19, "bacilli": [430, 467], "bacillu": 121, "back": [20, 70, 109, 111, 114, 139, 143, 169, 170, 183, 401, 448, 511], "backward": [53, 70, 84, 85, 120], "bacteri": 259, "bacteria": [340, 375, 429, 430, 467], "bacteroidet": [375, 429, 430, 467], "baeza": 321, "baker": 53, "balanc": [70, 273, 477, 481], "band": 19, "bar": [120, 349, 374, 384, 394, 395, 500, 513], "barcod": [346, 348, 352], "barker": 70, "barlow": 273, "basal": 472, "base": [1, 3, 4, 11, 14, 16, 29, 36, 39, 43, 44, 47, 48, 52, 53, 60, 66, 67, 70, 71, 72, 74, 77, 84, 85, 105, 106, 111, 113, 117, 119, 120, 149, 152, 162, 176, 179, 184, 195, 209, 215, 221, 228, 235, 277, 296, 298, 299, 300, 304, 310, 325, 326, 333, 336, 338, 339, 340, 342, 348, 356, 388, 399, 412, 413, 415, 426, 477, 478, 479, 480, 481, 482, 483, 485, 500, 508, 509, 511, 513], "base1": 191, "base2": 191, "base3": 191, "basi": [265, 266, 273, 274], "basic": [35, 55, 106, 107, 304, 320, 321, 358, 392], "baz": [349, 500], "bb": 338, "bbb": 112, "bbf": 112, "bbx": 112, "bc": 413, "bc_dm": 1, "bct": 122, "becam": [116, 493], "becaus": [1, 20, 23, 28, 29, 53, 84, 85, 106, 111, 112, 113, 116, 118, 119, 120, 123, 176, 184, 193, 209, 221, 228, 235, 259, 298, 326, 331, 333, 335, 338, 407, 419, 462, 467, 474, 482], "becom": [1, 3, 54, 111, 112, 116, 120, 151, 348, 375, 421, 431, 456, 473, 475], "been": [0, 20, 35, 36, 37, 42, 43, 90, 111, 112, 113, 118, 138, 142, 145, 176, 181, 195, 205, 206, 228, 235, 298, 304, 358, 392, 397, 407, 408, 480, 496], "befor": [1, 23, 111, 115, 120, 121, 193, 211, 212, 270, 297, 298, 340, 348, 416, 425, 440, 447, 448, 456, 457, 458, 469, 480, 511, 513], "begin": [11, 19, 110, 111, 112, 113, 117, 120, 121, 126, 149, 176, 193, 340], "behav": [20, 184, 215, 221, 298], "behavior": [29, 35, 36, 37, 111, 112, 113, 120, 145, 171, 172, 174, 175, 193, 228, 245, 296, 298, 300, 412, 415, 420, 456, 457, 458, 462, 473, 480, 513], "being": [1, 19, 21, 23, 24, 35, 36, 37, 53, 82, 86, 111, 112, 118, 122, 176, 182, 273, 300, 304, 318, 339, 348, 392, 412, 457, 497, 506, 508], "bell": 74, "belong": [19, 45, 49, 75, 114, 259, 264, 296, 299, 300, 348], "below": [108, 111, 112, 116, 118, 120, 121, 122, 176, 191, 195, 228, 297, 298, 321, 339, 358, 388, 392, 408, 409, 413, 415, 416, 417, 436, 439, 441, 450, 459, 463, 493], "benefit": 264, "benjamini": [259, 264], "berger": [45, 58], "berkelei": 72, "besid": 481, "best": [19, 35, 36, 37, 38, 39, 40, 61, 62, 256, 297, 325], "beta": [86, 87, 89, 110], "beta_divers": [1, 82, 84, 85, 87, 89, 90], "betadisp": 300, "bethesda": 111, "better": [111, 325, 326, 506], "between": [1, 3, 19, 36, 39, 54, 55, 58, 61, 71, 72, 80, 81, 84, 85, 86, 90, 104, 111, 112, 113, 115, 118, 121, 122, 151, 158, 229, 231, 239, 240, 241, 242, 247, 253, 254, 255, 259, 264, 273, 276, 277, 281, 291, 293, 296, 297, 298, 299, 300, 301, 303, 304, 310, 325, 326, 327, 331, 333, 336, 339, 340, 342, 373, 411, 412, 413, 414, 415, 416, 417, 422, 435, 441, 443, 456, 458, 465, 477, 478, 480, 481, 482, 483, 485, 506, 508, 511], "bf": 440, "bf00039495": 110, "bh": [259, 264], "bia": [47, 48, 264], "bias": [47, 48, 264], "bias_correct": [47, 48], "bifurc": [116, 274, 428, 436], "big_fil": 506, "bigoplu": 266, "bin": [318, 348, 381], "bin_": 318, "bin_f": [318, 348], "binari": [123, 124, 125, 126, 127, 145, 273, 274, 304, 325, 333, 378, 400, 436, 481, 500], "binary_dm": [284, 290], "binomi": [339, 340], "bio": [0, 1, 30, 34, 35, 38, 41, 42, 53, 84, 85, 86, 87, 88, 89, 90, 93, 94, 105, 106, 107, 108, 110, 111, 112, 116, 117, 118, 119, 121, 122, 157, 159, 171, 172, 174, 175, 186, 188, 189, 190, 191, 193, 194, 218, 220, 223, 225, 226, 227, 243, 246, 253, 284, 290, 297, 319, 322, 324, 383, 398, 400, 451, 472, 476, 496, 508, 512], "biocor": [84, 85, 321], "biodivers": [1, 43, 51, 53, 70], "bioinformat": [53, 70, 112, 118, 120, 405, 506], "biol": [35, 38, 53, 57, 70, 106, 107, 110, 113, 269, 275, 477, 478, 481], "biolog": [1, 20, 28, 35, 36, 37, 66, 70, 71, 77, 79, 91, 95, 98, 99, 111, 112, 114, 116, 119, 149, 185, 196, 197, 198, 199, 200, 201, 202, 203, 204, 205, 206, 216, 222, 228, 247, 339, 342, 359, 399, 480, 505, 509, 510], "biologi": [70, 71, 77, 193, 304, 405, 412, 415, 416, 422, 424, 479, 480, 482], "biom": [120, 342, 345, 346, 347, 348, 349, 351, 352, 355, 356, 357, 358, 359, 360, 362, 363, 364, 365, 366, 368, 369, 370, 371, 372, 373, 374, 375, 376, 379, 380, 381, 382, 383, 384, 386, 387, 388, 389, 390, 391, 392, 393, 394, 395, 397, 398, 399], "biom_format": [342, 399], "biom_open": [358, 392], "biometr": [67, 300], "biometrika": [43, 44, 56, 331], "bioperl": [112, 118], "biopython": [3, 112], "biosci": [269, 275], "bioscienc": [413, 483], "biotechnologi": [111, 122], "biotit": 3, "biowulf": 119, "biparit": [415, 485], "bipart": [411, 462, 463], "bipartit": [407, 408, 411, 413, 415, 483, 485], "biplot": [117, 325, 333], "biplot_scor": [320, 489], "bit": [3, 4, 8, 14, 15, 17, 106, 107, 120], "bit_arr": 4, "bitscor": [106, 107], "bitting": 70, "biz": 349, "blackwel": 66, "blank": [111, 112, 116, 117, 118, 120, 148, 162, 173, 176, 181, 283], "blast": [36, 37, 39, 40, 111], "blast6": 107, "blastcgihelp": 111, "blastedbio": 106, "blastn": 107, "blastp": 107, "block": [37, 40, 87, 248, 412, 415, 500], "block_siz": 500, "blocksiz": 87, "blogspot": 106, "blosum": [37, 40, 215, 247, 248], "blosum45": 248, "blosum50": 248, "blosum62": [247, 248], "blosum80": 248, "blosum90": 248, "bmc": [416, 422], "bme": [480, 481], "bmi": 340, "bnni": 481, "bob": 228, "bodi": [1, 321], "body_sit": [1, 321], "bogdanowicz": 413, "boilerpl": 123, "bologna": 55, "boltzmann": 81, "bone": 339, "bonferroni": [259, 264], "boniferroni": [259, 264], "boogaart": 273, "book": [106, 107, 111], "bool": [12, 19, 20, 21, 24, 27, 28, 32, 35, 36, 37, 47, 48, 49, 51, 53, 59, 70, 74, 75, 76, 82, 84, 85, 86, 87, 90, 96, 100, 101, 102, 103, 125, 126, 127, 136, 141, 149, 151, 152, 154, 158, 161, 162, 165, 168, 169, 170, 172, 174, 175, 176, 177, 183, 184, 185, 191, 196, 198, 200, 201, 202, 203, 204, 205, 206, 207, 208, 210, 212, 213, 215, 216, 217, 219, 221, 222, 228, 229, 232, 233, 235, 236, 237, 239, 240, 241, 242, 244, 245, 247, 255, 259, 265, 266, 269, 275, 277, 278, 280, 286, 294, 298, 300, 301, 304, 310, 312, 323, 330, 331, 333, 334, 338, 339, 341, 348, 351, 355, 356, 358, 359, 367, 368, 369, 370, 378, 379, 380, 381, 382, 385, 390, 391, 392, 395, 397, 401, 402, 403, 406, 408, 409, 410, 411, 412, 413, 414, 415, 416, 417, 418, 421, 422, 423, 431, 432, 433, 435, 436, 437, 438, 440, 441, 443, 445, 446, 447, 448, 449, 450, 452, 453, 454, 456, 457, 458, 459, 462, 463, 465, 467, 468, 469, 470, 471, 472, 473, 475, 477, 478, 480, 481, 482, 483, 484, 485, 487, 489, 493, 501], "boolean": [20, 85, 111, 114, 119, 149, 184, 185, 196, 198, 200, 201, 206, 215, 216, 219, 221, 222, 228, 235, 238, 240, 242, 244, 293, 356, 388], "bootstrap": 400, "both": [20, 22, 29, 31, 42, 47, 48, 49, 53, 70, 104, 105, 106, 107, 109, 111, 112, 118, 120, 122, 136, 141, 156, 193, 262, 263, 265, 266, 276, 277, 281, 293, 294, 295, 297, 298, 299, 300, 331, 342, 345, 348, 352, 358, 373, 388, 392, 402, 407, 408, 423, 435, 439, 460, 463, 469, 481, 484, 506, 508], "bound": [60, 61, 113, 114, 123, 149, 150, 151, 152, 153, 155, 156, 228, 259, 264, 337, 340], "bound_moieti": 113, "bowden": [184, 195, 215, 221, 228], "boxplot": 1, "bp": [110, 113], "braak": 326, "bracket": [80, 116], "brai": 1, "branch": [1, 53, 70, 85, 274, 400, 405, 406, 407, 408, 409, 412, 413, 415, 416, 421, 422, 433, 435, 441, 442, 450, 456, 457, 458, 462, 463, 466, 468, 470, 472, 473, 475, 477, 478, 480, 482, 485, 511], "branch_attr": [435, 456, 457, 458, 473, 475], "braycurti": 1, "breadth": 440, "break": [184, 215, 221], "bren": 273, "brillouin": 46, "broader": 319, "broadinstitut": 111, "broken": [22, 479], "brows": 110, "bsd": 505, "bt": [112, 369], "btop": [106, 107], "buf_siz": 318, "buffer": [123, 145, 318], "buffer_s": 123, "bufferedrandom": 145, "bufferedread": [124, 125, 126, 145], "bufferedwrit": [124, 127, 145], "bui": 505, "build": [16, 151, 273, 393, 480], "buildilrbas": 273, "built": 506, "bulletin": [479, 484], "busi": 123, "bwpd_": 70, "by_id": 388, "by_nam": [245, 247, 250], "bypass": [53, 82, 84, 85, 86], "byte": [3, 145, 244, 486], "byteio": [105, 109], "bytesio": [105, 109, 145, 146, 500], "bz2": 145, "bzh91ai": 146, "b\u00e4hler": [269, 275], "c": [1, 8, 11, 19, 20, 22, 28, 29, 31, 32, 41, 44, 53, 54, 55, 56, 57, 70, 71, 74, 77, 81, 84, 85, 90, 110, 111, 112, 116, 118, 120, 121, 122, 127, 184, 197, 211, 212, 215, 221, 228, 233, 247, 249, 251, 256, 258, 263, 269, 270, 271, 272, 274, 275, 276, 278, 283, 287, 289, 295, 297, 298, 321, 331, 332, 338, 339, 346, 348, 349, 401, 403, 405, 406, 407, 408, 409, 411, 412, 413, 414, 415, 416, 417, 418, 421, 422, 424, 425, 426, 427, 432, 433, 435, 436, 437, 438, 439, 440, 441, 442, 443, 445, 446, 447, 448, 449, 450, 452, 453, 454, 455, 456, 457, 458, 459, 460, 461, 462, 463, 465, 466, 468, 469, 470, 471, 472, 473, 475, 479, 480, 482, 483, 484, 485, 508, 511], "c_": 44, "ca": [3, 8, 23, 117, 320, 326, 333], "caa40058": 110, "caaatgtgaa": 110, "caacgtggcc": 110, "caaggaagat": 110, "caagggctgc": 110, "cabcacc": 112, "cac": [204, 236], "cacaattact": 110, "cacaauuacu": 110, "cach": [402, 406, 409, 410, 417, 419, 423, 424, 425, 426, 427, 431, 435, 446, 450, 452, 453, 454, 456, 457, 458, 459, 460, 470, 471, 472, 473, 475], "cache_attr": [410, 431], "cache_attrnam": 409, "cache_typ": 409, "cag": 3, "caggcc": 513, "cagttgaagc": 110, "cagtttgatg": 110, "caguugaagc": 110, "caguuugaug": 110, "cajo": 326, "calcul": [3, 19, 43, 44, 45, 46, 47, 48, 49, 50, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 71, 72, 73, 74, 75, 76, 77, 78, 79, 80, 81, 84, 85, 87, 90, 101, 104, 211, 212, 259, 264, 267, 274, 275, 296, 297, 298, 299, 300, 304, 309, 310, 317, 330, 331, 334, 337, 339, 340, 372, 376, 388, 409, 411, 412, 413, 414, 415, 416, 421, 422, 433, 468, 481, 482, 483, 485], "california": 72, "call": [1, 29, 53, 54, 61, 62, 84, 85, 108, 111, 118, 121, 123, 145, 149, 193, 211, 228, 229, 232, 244, 294, 297, 298, 318, 326, 336, 356, 403, 404, 409, 410, 419, 424, 425, 427, 431, 443, 450, 459, 465, 472, 474, 487, 491, 493, 495, 496, 499, 501, 502, 506, 513], "callabl": [19, 20, 21, 24, 31, 82, 86, 87, 90, 101, 259, 281, 286, 293, 302, 323, 409, 412, 415, 426, 453, 454, 460, 471, 482, 485], "callback": [501, 513], "caller": [30, 34, 93, 94, 157, 159, 186, 190, 218, 220, 223, 227, 243, 246, 284, 290, 308, 313, 315, 322, 324, 383, 396, 398, 451, 476], "calucul": 300, "can": [0, 1, 6, 19, 20, 28, 31, 35, 36, 37, 41, 42, 43, 49, 53, 54, 70, 73, 75, 82, 84, 85, 86, 88, 89, 90, 95, 96, 97, 99, 105, 106, 108, 109, 110, 111, 112, 113, 114, 115, 116, 118, 120, 121, 122, 123, 124, 137, 145, 149, 150, 151, 156, 160, 171, 174, 176, 185, 191, 200, 216, 222, 228, 229, 231, 235, 244, 247, 248, 253, 256, 259, 264, 273, 276, 277, 291, 296, 297, 298, 300, 301, 302, 305, 319, 321, 325, 330, 331, 332, 333, 336, 338, 339, 340, 342, 345, 349, 358, 370, 373, 382, 392, 395, 400, 406, 407, 408, 409, 410, 412, 413, 415, 422, 423, 431, 436, 453, 454, 456, 457, 458, 460, 462, 463, 464, 466, 468, 473, 479, 480, 482, 483, 485, 487, 490, 491, 492, 496, 498, 501, 504, 508, 511, 513], "cancer": 298, "candid": [191, 340], "cannot": [6, 19, 20, 21, 24, 111, 112, 115, 116, 120, 136, 138, 141, 142, 145, 176, 184, 195, 209, 221, 229, 259, 296, 297, 298, 299, 300, 318, 321, 338, 340, 424, 427, 439, 460, 506], "canon": [184, 195, 207, 215, 221, 247, 326, 333, 342, 399, 505], "capabl": [20, 400], "captur": 208, "cardin": 490, "care": [1, 23, 111, 113], "carlo": 336, "carol": 228, "casava": 119, "casava_ug_15011196b": 119, "case": [1, 23, 35, 36, 37, 45, 72, 81, 87, 105, 109, 111, 116, 118, 120, 122, 124, 176, 182, 184, 212, 221, 238, 245, 248, 259, 264, 277, 298, 304, 325, 330, 331, 332, 340, 405, 409, 412, 459, 472, 479, 501, 506, 511], "cast": [1, 116, 176, 229, 276, 277, 302, 321, 374], "cat": [237, 338, 339], "catacctca": 3, "catatttgct": 110, "catcgatcgatcgatgcatgcatgcatg": 111, "catcgtc": 111, "categor": [120, 148, 176, 177, 181, 183, 296, 299, 319, 321], "categori": [1, 120, 121, 305, 306, 307, 308, 310, 311, 312, 314, 315, 316, 317, 319, 321, 336, 338, 339, 343, 348, 392, 507], "categoricalmetadatacolumn": [162, 176, 179], "categoryresult": 312, "catttagga": 119, "catttgaaaa": 110, "cauauuugcu": 110, "caugcaucguacguacgcaugac": 108, "caus": [19, 120, 145, 193, 480], "caution": [90, 431], "cautiou": 407, "cauucguacguacgcaugac": 108, "caveat": [111, 256], "cb": [121, 338], "cc": [20, 121, 191, 244], "cca": [117, 319, 320, 325, 333], "cca1": 319, "cca2": 319, "cca3": 319, "cca4": 319, "cca5": 319, "cca6": 319, "cca7": 319, "cca8": 319, "cca9": 319, "ccaatggtac": 110, "ccaggtcgat": 110, "ccc": 228, "cccataaata": 110, "cccc": 235, "ccccchhhhhhhhhhhhh": 121, "ccchhhhhhhhhhhhhhh": 121, "cccttaggtc": 110, "ccg": 31, "ccggac": 513, "ccgggcacggtat": 111, "ccgwllllpppphhqqrrrriiimttttnnkkssrrvvvvaaaaddeegggg": 191, "ccora": 326, "ccyt": 112, "cd": [35, 110, 113, 193], "cde": 122, "cdef": 413, "ceil": 388, "cell": [120, 339], "cell_lin": 339, "center": [111, 122, 260, 297, 325, 327, 331, 334], "centr": [256, 262, 263, 329], "centroid": 300, "cepa": 405, "certain": [53, 64, 82, 84, 85, 86, 136, 139, 141, 143, 176, 184, 215, 221, 254, 426, 431, 453, 454, 471], "cg": [22, 228, 244], "cga": 236, "cgac": 108, "cgagc": 228, "cgaggccgggac": 111, "cgatgtc": 111, "cgatgtcgatcgatcgatcgatcag": 111, "cgau": 108, "cgcgaugcaugcau": 108, "cgggacactc": [111, 118], "cgggcacggt": [111, 118], "cgggcasdgca": 119, "cgggcattgca": 119, "cggtacgctt": [111, 118], "cggtcgtaacgcgta": 3, "cggtcgtcac": 3, "cgi": [36, 37, 39, 40, 191, 192], "cgt": 236, "cgtcacttat": 110, "cgtcgt": 8, "cgtcgtgc": 8, "cgttacgctt": [111, 118], "cgttcagggt": [111, 118], "cgttta": 254, "cgugcaugcau": 108, "chain": [113, 497], "challeng": [53, 480], "chanc": [247, 304, 388], "chang": [60, 74, 79, 111, 150, 151, 193, 228, 248, 259, 264, 268, 296, 302, 318, 395, 407, 409, 410, 412, 413, 414, 416, 417, 421, 422, 423, 439, 441, 453, 454, 456, 457, 460, 468, 473, 480, 496, 497, 513], "chao": [44, 47, 70], "chao1": 48, "chao1_ci": 47, "chapter": [111, 332], "char": [208, 233], "charact": [3, 4, 6, 8, 10, 11, 14, 15, 19, 20, 22, 23, 27, 29, 42, 95, 96, 97, 98, 99, 106, 107, 108, 111, 112, 115, 116, 117, 118, 119, 121, 122, 123, 176, 184, 185, 191, 193, 195, 196, 197, 198, 200, 201, 202, 203, 204, 205, 206, 207, 209, 211, 212, 215, 216, 217, 219, 221, 222, 228, 233, 238, 244, 245, 247, 249, 251, 254, 358, 392, 508], "character": 264, "charg": [111, 118], "charlson": 70, "chase": 51, "check": [19, 112, 126, 136, 141, 149, 151, 155, 265, 266, 276, 277, 291, 305, 325, 326, 339, 355, 367, 407, 408, 431, 432, 436, 437, 438, 462, 463, 488, 489, 495, 513], "check_length": 513, "checksum": 500, "chemic": [247, 340], "chen": [44, 70], "chf": [189, 194, 226], "chi": [325, 326], "chichest": 256, "chicken": [477, 478, 481], "child": [116, 151, 229, 273, 400, 402, 406, 416, 432, 436, 446, 450, 452, 453, 454, 459, 470, 472, 511], "child1": [402, 423], "child2": [402, 423], "child_index": 466, "children": [116, 274, 400, 402, 406, 409, 413, 423, 425, 432, 435, 436, 442, 446, 447, 448, 449, 452, 456, 461, 469, 472], "chimp": [111, 118], "chisquar": 340, "chiu": 70, "choic": [21, 24, 115, 331, 433, 441, 472], "choos": [53, 120, 326, 336], "chosen": [244, 268, 297, 321, 333, 341, 496], "christoph": 112, "chunk": [118, 506], "ci": [43, 61, 264], "ci_typ": 61, "cigar": [3, 11, 16, 18, 19], "circuit": 513, "circumst": [55, 215, 339], "citat": 122, "citi": [412, 415], "cityblock": [412, 415, 485], "ciufo": 122, "cl": [125, 127, 131, 133, 134, 135, 195, 491, 492, 499], "clade": [400, 402, 407, 409, 413, 416, 450, 452, 453, 454, 458, 459, 462, 463, 479, 511], "clade_s": 409, "cladogenesi": 304, "claim": [138, 142], "clarifi": 53, "clariti": 116, "clark": [296, 297], "class": [3, 11, 14, 19, 20, 42, 44, 47, 91, 95, 96, 97, 98, 99, 104, 105, 106, 107, 108, 109, 110, 111, 112, 113, 114, 115, 116, 117, 118, 119, 120, 121, 122, 124, 125, 127, 128, 131, 133, 134, 135, 148, 149, 151, 160, 162, 171, 172, 173, 174, 175, 176, 184, 191, 195, 209, 215, 221, 228, 229, 247, 259, 277, 291, 306, 307, 309, 310, 312, 314, 316, 317, 320, 342, 353, 356, 379, 394, 399, 400, 409, 479, 486, 487, 491, 492, 497, 498, 499, 501, 503, 504, 506], "classic": 122, "classif": [122, 321], "classmethod": [4, 5, 6, 7, 15, 16, 25, 26, 153, 181, 192, 229, 248, 249, 250, 251, 281, 293, 358, 359, 428, 429, 430, 491], "classproperti": 195, "claus": 180, "clean": [145, 450], "cleanup": [125, 127], "clear": [119, 402, 406, 423, 431, 435, 446, 450, 452, 453, 454, 456, 457, 458, 459, 460, 470, 471, 472, 475], "clear_cach": [409, 419, 431], "clinic": [340, 507], "clip_head": 96, "clip_tail": 96, "clip_to_zero": 480, "clone": 110, "clone_lib": 110, "close": [30, 34, 43, 54, 93, 94, 111, 112, 116, 118, 121, 145, 146, 157, 159, 176, 186, 190, 193, 218, 220, 223, 227, 243, 246, 259, 284, 290, 308, 313, 315, 322, 324, 383, 398, 412, 451, 468, 476, 500], "closeabl": 145, "closefd": 123, "closer": [1, 513], "clostridia": [430, 467], "closur": [258, 270, 271, 272], "clover": 110, "clr": [256, 263, 264, 274], "clustal": [30, 34, 506], "clustal_f": 108, "clustalw": 108, "cluster": [1, 298, 300, 412, 416, 428, 441, 480, 484, 508], "cmap": [1, 283, 321], "cnt": 339, "co": 304, "co2": 339, "cock": 112, "cocryst": 113, "code": [108, 111, 112, 113, 122, 156, 184, 187, 188, 189, 191, 192, 193, 194, 215, 221, 224, 225, 226, 245, 247, 304, 388, 479, 496, 508], "codon": [113, 122, 188, 191, 193, 194, 215, 225, 247], "codon_start": 113, "coeff": 298, "coeffici": [44, 297, 298, 304, 320, 333, 336, 412, 415], "coercion": 229, "col": [277, 342, 353, 368, 394], "col1": [29, 120], "col2": [29, 120], "col3": [29, 120], "collabor": 113, "collaps": [120, 406, 436, 450, 453, 454, 459], "collapse_f": 348, "collapsed_id": [348, 358, 392], "collat": 301, "collect": [19, 71, 77, 79, 145, 176, 273, 278, 318, 400], "collinear": [319, 326], "collis": 72, "colon": 116, "color": [1, 61, 62, 283, 321], "colorbar": [283, 321], "colormap": [283, 321], "colormaps_refer": 321, "column": [1, 3, 10, 19, 20, 28, 29, 86, 100, 104, 105, 111, 113, 114, 117, 118, 121, 122, 148, 162, 163, 164, 165, 166, 167, 168, 169, 170, 173, 174, 175, 176, 177, 179, 180, 181, 182, 183, 228, 229, 238, 247, 257, 258, 259, 264, 265, 266, 276, 277, 282, 287, 294, 296, 297, 298, 299, 300, 301, 304, 310, 317, 319, 321, 325, 326, 327, 329, 333, 334, 338, 339, 342, 346, 348, 353, 358, 359, 364, 368, 369, 370, 375, 384, 385, 390, 391, 392, 394, 429, 434, 488, 489], "column_count": 176, "column_missing_schem": [176, 181], "column_typ": [177, 181], "columnproperti": 176, "columnwis": 327, "com": [60, 106, 107, 108, 297, 500], "comb_f": 409, "combin": [19, 20, 21, 24, 43, 113, 264, 297, 320, 326, 370, 409, 412, 482], "combinatori": [415, 485], "come": [121, 304, 456], "comma": [114, 115, 116], "command": [120, 122, 193], "comment": [110, 111, 113, 114, 115, 121, 122, 176], "comment_char": 116, "commit": 336, "common": [22, 38, 53, 70, 106, 111, 112, 113, 120, 121, 122, 171, 172, 174, 175, 257, 277, 310, 346, 347, 400, 409, 412, 416, 424, 439, 458, 466, 467, 468, 472, 480, 506, 508, 511, 512], "commonli": [116, 120, 247, 300, 333, 416, 511], "commun": [43, 44, 49, 53, 58, 67, 70, 74, 80, 84, 85, 264, 276, 296, 297, 299, 300, 319, 321, 326, 333, 340, 468, 505], "compact": 403, "compani": 339, "compar": [1, 65, 84, 90, 106, 107, 158, 213, 239, 240, 241, 242, 244, 259, 276, 277, 298, 304, 331, 338, 339, 340, 411, 412, 413, 414, 415, 416, 422, 482, 485, 488, 489, 508, 511], "compare_bipart": [413, 414], "compare_cophenet": [415, 416, 422, 482, 511], "compare_rfd": [411, 412, 414, 415, 483], "compare_subset": [411, 413, 463, 511], "compare_tip_dist": 412, "compare_wrfd": [412, 413, 485], "comparison": [84, 85, 256, 259, 264, 304, 338, 400, 407, 408, 412, 413, 415, 416, 463, 482, 483, 485, 488], "compat": [53, 70, 84, 85, 120, 122, 191, 496], "compil": [208, 232], "complement": [184, 193, 209, 213, 214, 221, 508], "complement_map": [184, 209, 210, 221], "complementari": 407, "complet": [20, 41, 43, 49, 61, 62, 112, 113, 116, 331, 336, 413, 506], "complex": [116, 513], "compliant": [184, 215, 221], "complic": [247, 506], "compon": [20, 256, 258, 268, 269, 270, 271, 272, 316, 320, 325, 331, 408, 416, 422, 463, 513], "compos": [23, 112, 119, 176, 400], "composit": [49, 53, 70, 145, 326], "compound": 264, "comprehens": 122, "compress": [105, 123, 145, 358, 368, 369, 370, 392], "compresslevel": [123, 145], "comput": [0, 1, 22, 23, 27, 44, 47, 53, 62, 80, 82, 83, 84, 85, 86, 87, 90, 151, 231, 233, 253, 254, 255, 259, 264, 269, 273, 274, 275, 276, 281, 293, 296, 297, 298, 299, 300, 301, 304, 305, 306, 310, 311, 312, 314, 316, 317, 319, 325, 326, 327, 328, 329, 330, 331, 332, 333, 334, 408, 413, 422, 477, 478, 479, 481, 484, 500, 508, 511], "computation": 19, "concat": [28, 29], "concaten": [28, 121, 153, 229, 349, 409], "concentr": [43, 49, 340], "concept": [3, 64, 273], "conceptu": [112, 299], "concern": [19, 115, 408], "conclud": 259, "concret": 162, "condens": [291, 292, 294, 295], "condensed_form": [291, 294, 295], "condit": [1, 61, 62, 339, 388], "confer": [415, 485], "confid": [1, 43, 48, 52, 61, 264, 336, 337, 400, 405], "confirm": [1, 296, 300, 340], "conflict": [419, 460], "conform": 195, "confus": 326, "conjunct": 300, "connect": [53, 55, 70, 116, 400, 407, 412, 416, 422, 435, 441, 442, 450, 453, 454, 456, 457, 458, 462, 468, 472, 480, 482], "consens": 479, "consensu": [184, 195, 215, 221, 412, 479, 482], "consensus_tre": 479, "consequ": 58, "conserv": [53, 60, 61, 70, 108, 229, 259, 276], "consid": [3, 23, 43, 44, 53, 60, 70, 84, 85, 111, 116, 176, 228, 235, 254, 256, 270, 301, 318, 338, 339, 340, 408, 411, 412, 413, 414, 415, 435, 436, 439, 441, 456, 457, 458, 462, 463, 468, 472, 473, 475, 481, 483, 485, 488, 501], "consider": [60, 70, 162, 176, 339], "consist": [3, 6, 74, 107, 111, 112, 114, 117, 118, 120, 121, 122, 177, 228, 245, 247, 339, 407, 408, 412, 435, 443, 465, 478], "constant": [52, 256, 259, 292, 298, 338], "constitut": [1, 247, 251], "constrain": [320, 326], "constraint": [117, 320, 326, 333], "construct": [25, 33, 113, 122, 149, 162, 166, 169, 170, 176, 183, 184, 195, 215, 221, 247, 249, 251, 252, 269, 276, 302, 319, 345, 346, 347, 348, 349, 364, 373, 379, 381, 382, 386, 387, 394, 395, 412, 419, 429, 430, 460, 477, 478, 480, 482, 484, 505, 506], "constructor": [20, 21, 24, 31, 108, 111, 112, 113, 118, 119, 121, 126, 130, 140, 184, 191, 215, 221, 228, 238, 247, 302], "consum": [20, 24, 127, 184, 191, 215, 221, 228], "consumpt": [301, 331, 348, 480], "contain": [1, 3, 19, 20, 22, 24, 29, 35, 36, 37, 38, 39, 40, 41, 44, 82, 83, 86, 87, 90, 96, 100, 104, 106, 108, 109, 110, 111, 112, 114, 115, 117, 118, 120, 121, 122, 123, 148, 160, 164, 166, 169, 170, 171, 173, 174, 176, 177, 178, 182, 183, 184, 191, 196, 198, 201, 202, 203, 204, 205, 206, 215, 217, 219, 221, 228, 233, 235, 236, 237, 244, 245, 253, 254, 259, 273, 274, 276, 277, 280, 281, 283, 286, 293, 295, 296, 297, 298, 299, 300, 301, 303, 305, 319, 321, 323, 326, 348, 358, 359, 388, 392, 403, 407, 412, 455, 462, 477, 478, 479, 480, 481, 482, 495, 501, 504, 508, 511], "content": [20, 22, 110, 111, 112, 113, 114, 116, 120, 123, 125, 126, 127, 174, 182, 184, 187, 197, 199, 210, 214, 221, 224, 229, 508], "context": [1, 19, 74, 146, 147, 254, 321, 407, 416], "contextu": 501, "contigu": [114, 149, 235], "conting": [264, 333, 342, 396], "continu": [35, 36, 37, 319], "contrast": [70, 273, 416, 436, 472, 480], "contribut": [22, 70, 72, 304, 325, 330], "control": [29, 111, 296, 298, 299, 305, 331, 333, 336, 338, 339, 340, 346, 356, 373], "control_cat": [338, 339], "controversi": 67, "contruct": 506, "conveni": [0, 19, 30, 34, 69, 93, 94, 139, 143, 157, 159, 186, 190, 218, 220, 223, 227, 243, 246, 284, 290, 322, 324, 383, 398, 451, 462, 476, 512], "convent": [53, 84, 85, 106, 110, 113], "convers": [3, 112, 145, 292, 373, 400], "convert": [1, 3, 7, 100, 101, 102, 103, 106, 108, 110, 111, 113, 116, 118, 121, 145, 162, 169, 170, 183, 184, 207, 215, 221, 228, 231, 245, 256, 277, 294, 297, 375, 380, 382, 390, 391, 405, 406, 472, 480, 490], "convert_underscor": 116, "convienc": 439, "coo_matrix": 274, "coord": [5, 305, 306, 309, 310, 316, 317], "coord_data": 305, "coordin": [1, 3, 5, 9, 96, 98, 113, 119, 149, 151, 152, 153, 158, 264, 274, 300, 305, 310, 316, 317, 320, 321, 325, 331, 332, 333], "cophenet": [412, 422, 441, 482, 511], "copi": [20, 111, 118, 121, 151, 160, 171, 174, 228, 244, 277, 285, 288, 334, 341, 396, 400, 420, 431, 456, 457, 458, 459, 460, 464, 473, 474, 481], "copy_from": 151, "copyright": [111, 118], "corbet": 54, "cornish": [184, 195, 215, 221, 228], "cornwel": 70, "corr": 1, "corr_coeff": [298, 304], "correct": [47, 48, 49, 51, 55, 59, 75, 76, 111, 259, 264, 456, 457, 458, 506], "correl": [1, 269, 275, 276, 297, 298, 301, 303, 304, 320, 326, 327, 333, 336, 340, 412, 415, 511], "correspond": [1, 6, 28, 43, 53, 70, 84, 85, 91, 96, 98, 102, 109, 111, 112, 114, 119, 121, 138, 142, 167, 176, 191, 193, 212, 225, 226, 238, 247, 259, 273, 277, 320, 325, 326, 329, 340, 348, 353, 358, 360, 362, 363, 374, 375, 392, 394, 395, 400, 407, 424, 428, 429, 434, 444, 467, 479], "cospeci": 304, "cost": [269, 275, 331, 480], "costli": 0, "could": [1, 20, 62, 109, 111, 112, 119, 123, 136, 139, 141, 143, 259, 264, 277, 296, 298, 299, 300, 301, 304, 321, 338, 387, 506], "count": [0, 3, 20, 21, 24, 27, 29, 32, 44, 45, 46, 47, 48, 49, 50, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 71, 72, 73, 74, 75, 76, 77, 78, 79, 80, 81, 82, 84, 85, 86, 87, 90, 105, 108, 111, 112, 118, 121, 211, 212, 233, 237, 239, 241, 255, 256, 259, 264, 304, 326, 332, 339, 340, 341, 348, 362, 378, 382, 388, 409, 411, 413, 414, 444, 479, 483, 506], "counts2": 340, "counts_001": 336, "counts_010": 336, "counts_100": 336, "counts_interv": [336, 339, 340], "coupl": 151, "covari": [70, 327], "cover": [151, 248, 511], "coverag": [44, 52, 56, 62, 106, 107], "cprofil": 513, "cran": [273, 296, 297, 298, 299, 300], "crd": 111, "creat": [1, 3, 4, 5, 6, 7, 11, 14, 15, 16, 19, 20, 21, 24, 25, 26, 28, 30, 31, 32, 33, 93, 110, 111, 114, 116, 118, 120, 128, 130, 140, 145, 146, 149, 151, 152, 153, 157, 169, 170, 171, 174, 183, 184, 186, 195, 215, 218, 221, 223, 228, 243, 244, 249, 251, 252, 259, 268, 276, 281, 283, 284, 287, 293, 295, 302, 304, 310, 319, 321, 322, 342, 348, 355, 356, 362, 363, 365, 366, 368, 373, 374, 379, 380, 381, 383, 384, 386, 387, 389, 394, 395, 397, 399, 406, 410, 431, 451, 456, 457, 458, 459, 460, 480, 487, 496, 498, 506, 508, 511, 513], "create_d": [342, 399], "create_format": [123, 125, 126, 127], "creation": [358, 392, 393, 506], "creation_d": [392, 393], "credibl": 264, "criteria": [156, 165, 180, 338, 426, 453, 454, 471], "critic": [336, 337, 339, 340, 405], "critiqu": [51, 75], "crop": 122, "cross": 113, "cross_refer": 110, "csc": [342, 392], "csc_matrix": 392, "csr": [342, 392], "csr_matrix": 392, "csv": [106, 115, 506], "ctaa": 113, "ctaacccccttttctcaga": 0, "ctagctagta": 110, "ctataaaaaa": 113, "ctattatact": 110, "ctc": 245, "ctcaaaagtc": 245, "ctcaaaattc": 110, "ctcttctagt": 110, "ctgtttgtta": 110, "cttcatgtat": 110, "cttccaattt": 110, "cttgacatag": 110, "cttgatgata": 110, "cuaa": 113, "cual": 120, "cuauaaaaaa": 113, "cucumel": [412, 482], "cug": 193, "cuguuuguua": 110, "cultur": 339, "cumbersom": 120, "cumul": [60, 80, 108, 109, 331], "cup": [413, 415], "cuppini": 55, "curat": 122, "curr": 409, "current": [73, 104, 106, 109, 110, 111, 112, 113, 118, 120, 121, 122, 151, 155, 176, 177, 189, 194, 226, 248, 259, 286, 298, 317, 323, 325, 358, 392, 406, 407, 408, 409, 416, 417, 420, 421, 424, 426, 427, 431, 432, 433, 436, 437, 438, 441, 442, 443, 461, 462, 463, 465, 482, 483, 485, 505], "curti": 1, "curv": [55, 60, 67, 326, 336, 339, 340], "custom": [0, 1, 74, 122, 184, 191, 195, 215, 221, 231, 321, 331, 358, 386, 392, 408, 409, 412, 415, 458, 463, 473, 482, 485, 493, 508], "custom_metr": 231, "customiz": 412, "customsequ": 195, "cutoff": [259, 479], "cuucauguau": 110, "cuugacauag": 110, "cw": 121, "cy": 215, "cyanogen": 110, "cystein": 215, "cytokin": 339, "cytophagia": [430, 467], "cytosin": [184, 221], "czech": 405, "d": [1, 19, 20, 44, 45, 46, 47, 48, 49, 50, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 71, 72, 73, 74, 75, 76, 77, 78, 79, 80, 81, 84, 85, 86, 106, 107, 113, 116, 117, 184, 215, 221, 249, 256, 257, 258, 259, 262, 263, 264, 265, 266, 267, 269, 270, 271, 272, 273, 274, 275, 276, 278, 283, 289, 295, 296, 297, 298, 299, 300, 304, 310, 314, 317, 320, 321, 330, 339, 340, 341, 342, 349, 364, 365, 385, 399, 401, 403, 405, 406, 407, 408, 409, 411, 412, 413, 414, 415, 416, 417, 418, 421, 422, 424, 425, 426, 427, 433, 435, 436, 439, 440, 441, 442, 443, 445, 447, 448, 449, 450, 455, 456, 457, 458, 459, 460, 461, 462, 463, 465, 466, 468, 469, 470, 471, 472, 473, 475, 479, 480, 482, 483, 484, 485, 506, 508, 511, 513], "d1": [122, 508], "d136": 122, "d143": 122, "d2": 508, "d3": 508, "d_": [66, 77], "d_1": 412, "d_2": 412, "d_a": 373, "d_b": 373, "d_d": 116, "d_w": 80, "d_x": 298, "d_y": 298, "da": 256, "daili": 122, "danger": 1, "dash": 120, "data": [1, 3, 20, 29, 53, 55, 67, 70, 82, 84, 85, 86, 87, 90, 100, 103, 105, 106, 109, 110, 112, 114, 115, 117, 119, 120, 121, 122, 145, 148, 162, 173, 176, 177, 184, 195, 215, 221, 228, 247, 256, 257, 258, 259, 260, 263, 264, 266, 268, 269, 273, 275, 277, 285, 291, 297, 304, 305, 308, 313, 315, 318, 319, 321, 323, 325, 326, 330, 331, 333, 336, 338, 339, 340, 342, 343, 345, 348, 353, 355, 356, 357, 358, 359, 360, 362, 363, 364, 365, 366, 368, 369, 374, 377, 379, 380, 381, 382, 384, 386, 387, 389, 390, 391, 392, 394, 395, 396, 397, 400, 416, 429, 480, 482, 483, 484, 485, 486, 495, 501, 505, 506, 507, 508, 513], "data_fh": 357, "data_fram": 297, "data_pump": 359, "data_typ": [358, 392], "databas": [106, 107, 110, 113, 120, 122, 149, 429], "datafram": [1, 20, 86, 100, 106, 107, 122, 162, 169, 174, 175, 176, 183, 184, 215, 221, 228, 259, 264, 278, 287, 289, 296, 297, 299, 300, 301, 305, 310, 317, 319, 320, 321, 325, 326, 332, 333, 338, 339, 346, 375, 391, 429, 430, 488, 508], "datapoint": 67, "dataset": [87, 104, 109, 256, 264, 319, 326, 331, 358, 392], "datatyp": [104, 318], "date": [110, 358, 359, 392, 393], "datetim": [392, 393], "dayhoff": 248, "db": 111, "db_xref": [110, 113], "dbsourc": 110, "dbxref": [113, 114], "ddbj": 113, "ddl": [358, 392], "ddof": [269, 275, 330, 334], "de": [110, 121, 413], "deal": [109, 110, 144, 256, 268, 331, 506], "debug": [44, 501, 502, 513], "debug_post_st": 513, "debug_pre_st": 513, "debug_runtim": 513, "debug_trac": 513, "decemb": 112, "decid": 513, "decim": [116, 120, 489], "decis": 413, "declar": [117, 120], "decod": [112, 145], "decomposit": [70, 87, 103, 256, 300, 331], "decompress": 145, "decor": [123, 125, 126, 127, 151, 195, 479, 487, 492, 493, 497, 498, 499, 501, 503, 504], "decreas": 318, "deem": 326, "deep": [20, 45, 151, 228, 279, 288, 400, 417, 420, 473], "deepcopi": [20, 474], "deeper": [84, 85], "def": [108, 123, 125, 126, 127, 195, 231, 413, 513], "default": [0, 1, 6, 10, 11, 19, 20, 21, 22, 24, 29, 31, 34, 35, 36, 37, 39, 40, 44, 48, 53, 58, 60, 67, 70, 71, 72, 74, 81, 82, 86, 94, 106, 111, 113, 114, 115, 116, 118, 119, 120, 123, 124, 125, 127, 131, 133, 156, 159, 162, 165, 176, 180, 184, 188, 189, 190, 191, 193, 194, 195, 207, 215, 220, 221, 225, 226, 227, 231, 235, 245, 246, 257, 258, 259, 264, 265, 266, 268, 277, 278, 281, 283, 286, 290, 293, 297, 298, 300, 301, 302, 310, 318, 321, 323, 324, 330, 331, 333, 334, 341, 342, 348, 353, 356, 358, 363, 365, 368, 369, 370, 372, 373, 376, 378, 379, 380, 381, 382, 386, 388, 392, 393, 394, 395, 397, 398, 401, 402, 406, 408, 409, 410, 411, 412, 413, 414, 415, 416, 417, 418, 420, 421, 422, 423, 433, 435, 436, 440, 441, 443, 445, 446, 447, 448, 449, 450, 452, 453, 454, 456, 457, 458, 459, 460, 462, 463, 465, 468, 469, 470, 471, 472, 473, 475, 476, 477, 478, 479, 480, 481, 482, 483, 485, 488, 489, 493, 495, 501, 504, 506, 508, 511, 513], "default_column": 106, "default_gap_char": [22, 23, 29, 184, 195, 215, 221], "default_missing_schem": [176, 181], "default_rng": [336, 339, 340, 496], "default_write_format": [20, 96, 97, 127, 151, 176, 228, 277, 320, 342, 400], "defaultdict": 374, "defer": 151, "defin": [1, 5, 9, 20, 29, 31, 37, 40, 44, 45, 46, 47, 49, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 63, 64, 65, 66, 67, 70, 71, 72, 73, 74, 75, 77, 80, 81, 90, 111, 112, 113, 114, 116, 117, 118, 119, 120, 122, 123, 124, 149, 151, 155, 176, 184, 191, 192, 195, 207, 209, 215, 221, 228, 231, 236, 237, 245, 247, 248, 250, 255, 257, 258, 262, 263, 265, 266, 267, 270, 271, 272, 277, 283, 298, 301, 321, 336, 356, 358, 373, 381, 392, 397, 400, 413, 416, 437, 462, 463, 474, 477, 478, 480, 481, 484, 488, 502, 506, 508, 511, 513], "definit": [1, 20, 22, 49, 96, 97, 109, 110, 111, 112, 113, 114, 122, 174, 184, 187, 188, 189, 191, 193, 194, 195, 197, 198, 199, 202, 203, 205, 206, 208, 210, 214, 215, 221, 224, 225, 226, 229, 248, 358, 392, 480, 481, 498, 508, 512, 513], "definite_char": [184, 195, 215, 221], "deflin": 111, "degap": [211, 212, 508], "degener": [20, 22, 23, 96, 97, 109, 110, 111, 112, 113, 114, 174, 184, 187, 188, 189, 191, 193, 194, 195, 196, 197, 199, 202, 203, 205, 206, 207, 208, 210, 211, 212, 214, 215, 221, 224, 225, 226, 229, 248, 508], "degenerate_char": 195, "degenerate_map": [184, 195, 199, 215, 221, 508], "degenerate_mod": 23, "degre": [43, 49, 70, 108, 264, 269, 275, 330, 331, 337, 339], "deiman": 121, "del": [6, 10, 20, 115, 171, 174, 207, 319], "delet": [10, 20, 151, 160, 171, 174, 409, 410, 419, 453, 454], "delgado": [256, 273], "delim": 353, "delimit": [114, 115, 117, 119, 122, 276, 353, 357, 360, 394], "delta": [70, 268, 330], "demograph": 507, "demonstr": [123, 171, 172, 174, 175, 496], "dempqsv": 245, "demultiplex": 318, "den": 273, "dendrogram": [412, 416], "denomin": [257, 273], "denominator_col": 257, "denominator_idx": [257, 258], "denot": [49, 70, 75, 79, 80, 111, 259, 264, 296, 299, 300], "dens": [105, 348, 351, 356, 359, 368, 369, 370, 379, 390, 391, 399], "densiti": 395, "dep": 336, "depend": [11, 48, 51, 52, 53, 58, 70, 82, 84, 85, 86, 111, 112, 121, 125, 126, 127, 145, 212, 277, 298, 302, 314, 331, 358, 479, 501, 502, 506, 511, 513], "deprec": [41, 42, 53, 70, 79, 84, 85, 90, 195, 205, 206, 259, 268, 410, 412, 414, 420, 439, 453, 454, 460, 464, 468, 474, 480, 487], "depth": [70, 319, 336, 339, 340, 409, 433, 440, 447, 448, 449, 469, 511], "deriv": [36, 37, 39, 40, 51, 110, 228, 235, 265, 266, 273, 339, 480], "derives_from": 114, "desc": 228, "descend": [32, 70, 158, 400, 407, 408, 409, 417, 433, 434, 439, 443, 453, 454, 462, 463, 465, 468, 469, 481, 511], "descending_branch_length": 468, "describ": [0, 1, 11, 23, 35, 38, 43, 45, 46, 49, 52, 53, 56, 57, 59, 61, 62, 63, 64, 65, 70, 71, 75, 84, 85, 90, 105, 110, 111, 112, 113, 114, 117, 118, 120, 121, 176, 181, 228, 235, 238, 269, 275, 276, 285, 292, 298, 304, 331, 332, 348, 354, 358, 392, 393, 407, 413, 434, 457, 477, 478, 480, 481, 507, 508, 511], "descript": [19, 44, 53, 60, 66, 77, 82, 84, 85, 86, 104, 106, 111, 112, 113, 114, 116, 118, 120, 122, 148, 162, 171, 173, 277, 392, 479, 508, 511], "description_newline_replac": [111, 112], "descriptor": [113, 332], "deseri": [276, 320], "design": [1, 87, 104, 105, 110, 120, 176, 276, 338, 400], "desir": [55, 61, 106, 115, 375, 387, 459, 513], "desper": [477, 478, 481], "destin": 228, "detach": [3, 452], "detail": [3, 11, 14, 19, 20, 28, 29, 41, 42, 61, 62, 70, 87, 89, 90, 91, 95, 96, 97, 98, 99, 110, 111, 112, 113, 114, 118, 119, 121, 122, 123, 124, 128, 148, 149, 151, 160, 162, 171, 173, 174, 176, 184, 191, 194, 195, 209, 215, 221, 228, 247, 264, 277, 291, 294, 296, 297, 298, 299, 300, 301, 304, 306, 307, 309, 310, 312, 314, 316, 317, 318, 320, 321, 325, 326, 331, 333, 338, 339, 340, 341, 342, 400, 402, 406, 413, 415, 423, 424, 425, 435, 446, 450, 452, 453, 454, 456, 457, 458, 459, 470, 471, 472, 475, 480, 482, 483, 485, 486, 491, 492, 501, 503, 504, 506], "detect": [111, 113, 120, 138, 142, 259, 298, 340, 345], "determin": [1, 20, 53, 58, 70, 72, 82, 84, 85, 86, 115, 123, 134, 135, 145, 161, 162, 164, 168, 172, 175, 176, 177, 178, 191, 202, 203, 204, 205, 213, 217, 228, 259, 277, 300, 304, 318, 331, 336, 338, 339, 342, 348, 407, 413, 415, 469, 479, 513], "determinist": [54, 296, 300], "devdoc": 496, "develop": [1, 11, 87, 90, 110, 120, 125, 126, 127, 259, 505, 513], "deviat": [297, 330, 333, 334, 337, 409], "df": [106, 107, 122, 264, 287, 296, 297, 300, 321, 337, 391, 447, 448, 449, 469], "di": [55, 508], "diag": 370, "diagnos": 513, "diagon": [104, 293, 295, 370], "diagram": 149, "diamet": 441, "dict": [19, 20, 25, 30, 31, 33, 34, 35, 36, 37, 38, 39, 40, 41, 42, 93, 94, 110, 113, 126, 136, 138, 139, 141, 142, 143, 149, 152, 156, 157, 159, 171, 176, 181, 184, 186, 188, 189, 190, 195, 209, 215, 218, 220, 221, 223, 225, 226, 227, 228, 233, 237, 243, 246, 247, 249, 252, 284, 286, 290, 298, 301, 314, 322, 323, 324, 343, 344, 358, 359, 360, 363, 373, 374, 381, 383, 392, 397, 398, 408, 429, 430, 434, 444, 451, 463, 466, 476, 501, 508, 513], "dict_of_metadata": 344, "dictionari": [25, 31, 33, 42, 121, 122, 124, 149, 151, 152, 156, 171, 172, 228, 249, 252, 286, 298, 323, 356, 429], "did": [44, 111, 119, 136, 141, 146, 513], "didn": [111, 513], "diet": 338, "differ": [0, 1, 20, 22, 23, 25, 35, 36, 37, 48, 53, 60, 71, 75, 77, 84, 85, 107, 109, 111, 112, 118, 121, 122, 123, 162, 188, 191, 213, 225, 228, 229, 230, 231, 234, 239, 240, 241, 242, 244, 254, 259, 264, 276, 277, 296, 299, 300, 304, 309, 317, 319, 325, 326, 331, 333, 339, 340, 395, 407, 408, 411, 412, 413, 414, 415, 416, 480, 482, 483, 485, 488, 489, 506, 508, 511], "differenti": [20, 259, 264], "difficult": 1, "digit": 120, "dim": 109, "dimens": [20, 96, 97, 109, 117, 118, 257, 261, 265, 266, 277, 300, 320, 321, 331, 332], "dimension": [1, 102, 109, 258, 270, 271, 272, 277, 285, 292, 319, 325, 332, 333, 339, 340, 384, 509], "direct": [120, 122, 326, 408, 440, 447, 448, 449, 450, 463, 473, 474, 475], "direct_io": [353, 393, 394], "direction": 489, "directli": [20, 21, 24, 120, 184, 191, 215, 221, 228, 253, 259, 304, 393, 394, 442, 472, 496, 501, 513], "dirichilet": 264, "dirichlet": 264, "disabl": [1, 53, 82, 84, 85, 86, 331, 431, 480, 513], "disallow": [116, 121, 298], "disallow_negative_branch_length": 480, "discard": [113, 298, 356], "disconnect": [402, 452], "discov": [1, 73, 419], "discoveri": 1, "discrep": 49, "discret": 79, "discuss": [70, 74, 84, 85, 120, 513], "diseas": [259, 298, 346], "disjoint": [349, 479], "disjointiderror": [345, 349], "disk": [111, 176, 277], "dism": 269, "disperison": 300, "dispers": 300, "displai": [110, 191, 233, 244, 301, 320, 331, 493], "disrupt": [185, 200, 216, 222, 508], "dissimilar": [83, 86, 115, 269, 276, 277, 278, 279, 280, 281, 282, 283, 285, 286, 288, 289, 412, 413, 415, 416], "dissimilaritymatrix": [104, 115, 247, 269, 276, 291, 302], "dist": [433, 441], "dist_f": [409, 412], "distanc": [1, 19, 70, 83, 84, 85, 86, 87, 89, 90, 101, 104, 115, 116, 239, 241, 247, 257, 269, 303, 304, 321, 325, 326, 328, 331, 333, 400, 409, 411, 412, 413, 414, 415, 416, 421, 433, 435, 441, 445, 456, 457, 458, 477, 478, 480, 481, 482, 483, 484, 485, 511], "distance_filt": 19, "distance_matrix": [296, 297, 299, 300, 328, 331], "distancematrix": [86, 87, 90, 101, 104, 115, 253, 269, 276, 277, 286, 287, 296, 297, 298, 299, 300, 301, 302, 304, 321, 331, 412, 416, 477, 478, 480, 481, 482, 483, 484, 485], "distant": [433, 441], "distantli": 458, "distinct": [22, 68, 79, 254, 276, 417], "distinguish": [18, 49, 70, 416], "distort": 256, "distribut": [43, 52, 60, 110, 264, 270, 302, 331, 336, 337, 339, 340, 388, 412], "div": 122, "diverg": [1, 416], "divers": [276, 341, 468, 505], "divid": [108, 273, 328, 330, 334, 348], "divis": [191, 273, 334, 407], "dj": 111, "dm": [104, 276, 277, 278, 283, 286, 287, 289, 295, 296, 297, 300, 301, 321, 477, 478, 480, 481, 482, 483, 484, 485], "dm1": 301, "dm2": 301, "dm_fh": 276, "dm_from_np": 276, "dmp": 429, "dna": [0, 3, 8, 20, 21, 22, 24, 25, 27, 28, 29, 31, 32, 33, 36, 39, 41, 108, 110, 111, 112, 113, 114, 118, 119, 121, 174, 175, 191, 195, 196, 197, 198, 199, 200, 201, 202, 203, 204, 205, 206, 208, 209, 210, 211, 212, 213, 214, 216, 221, 222, 224, 228, 229, 235, 245, 277, 506, 508], "dna_seq": [110, 111, 113], "dnaful": 248, "do": [1, 20, 21, 24, 67, 102, 104, 109, 111, 118, 120, 123, 145, 184, 215, 221, 228, 242, 254, 259, 298, 301, 310, 333, 342, 356, 379, 388, 405, 410, 424, 459, 511, 513], "do_someth": 513, "do_something_awesom": 513, "do_something_els": 513, "doc": [86, 108, 110, 111, 118, 120, 149, 176, 181, 277, 285, 291, 292, 392, 479, 496, 506], "docstr": [148, 162, 173, 493, 497], "doctest": 358, "document": [1, 20, 89, 105, 111, 113, 118, 119, 259, 321, 342, 358, 392, 399, 506, 510], "doe": [20, 21, 22, 24, 29, 32, 41, 53, 70, 106, 108, 109, 111, 112, 114, 116, 118, 121, 145, 164, 178, 191, 193, 229, 248, 254, 276, 285, 286, 294, 296, 298, 300, 310, 323, 331, 339, 340, 352, 374, 375, 392, 406, 426, 427, 446, 460, 462, 467, 472, 479, 481, 482, 485, 488, 497, 498, 506], "doesn": [29, 111, 120, 181, 193, 270, 274, 325, 335, 456, 457, 458, 473, 512], "doi": [19, 41, 110, 112, 269, 275, 477, 478, 480, 481], "domain": [121, 215, 429, 467], "domin": [45, 51, 58, 59, 64, 75, 76, 77, 80], "dominance_": 43, "domrachev": 122, "don": [1, 19, 29, 111, 120, 211, 212, 257, 259, 301, 333, 340, 407, 457], "done": [23, 259, 300, 308, 313, 315, 342], "donor": [402, 423, 435], "doubl": [44, 47, 62, 69, 136, 141, 325, 331], "doubleton": [1, 47, 48, 50, 52, 69], "doubt": 120, "down": 400, "download": [110, 113, 122], "dqyhrykedvgimkdqnmdsyrfsiswprilpkgklsgginhegikyynnli": 110, "dr": 110, "draw": [264, 336, 338, 339, 340, 403], "draw_mod": [336, 340], "drawn": [264, 302, 336, 339, 340], "driver": [1, 51], "drop": [149, 151, 177, 228, 301, 319, 326, 356, 453, 454, 479], "drop_all_miss": 177, "drop_all_uniqu": 177, "drop_missing_valu": [165, 168], "drop_zero_vari": 177, "dt": 110, "dt_rich": 348, "dtype": [0, 1, 8, 20, 21, 22, 23, 24, 27, 28, 29, 31, 32, 108, 109, 111, 112, 118, 119, 121, 174, 176, 183, 196, 197, 198, 201, 206, 210, 214, 219, 228, 229, 240, 242, 245, 259, 277, 295, 296, 300, 319, 342, 372, 376, 390, 399, 466, 508], "due": [43, 116, 155, 268, 297, 300, 326, 339, 481, 484], "dump": [122, 511, 513], "dunn": 110, "duplic": [20, 29, 90, 112, 120, 121, 155, 245, 280, 416, 419, 494], "duplicatenodeerror": [53, 70, 82, 84, 85, 86, 416, 419], "duplicateregistrationerror": [125, 126, 127], "dure": [29, 111, 149, 229, 300, 373, 393, 394, 410, 415, 419, 431, 473, 475, 482, 483, 485, 495], "dx": 55, "e": [0, 1, 19, 20, 23, 27, 32, 49, 54, 55, 56, 57, 58, 59, 60, 65, 66, 70, 71, 72, 73, 74, 75, 77, 79, 84, 85, 86, 87, 90, 106, 107, 108, 110, 111, 112, 113, 115, 116, 117, 118, 119, 120, 121, 122, 123, 149, 154, 162, 172, 176, 181, 182, 193, 215, 217, 219, 224, 228, 229, 232, 233, 247, 254, 259, 264, 273, 274, 276, 277, 278, 283, 289, 291, 295, 296, 297, 298, 299, 300, 321, 328, 329, 338, 339, 341, 349, 353, 358, 375, 388, 392, 401, 403, 405, 406, 407, 408, 409, 412, 413, 415, 416, 417, 418, 421, 422, 424, 425, 426, 427, 431, 433, 435, 436, 439, 440, 441, 442, 443, 445, 447, 448, 449, 450, 455, 456, 457, 458, 459, 461, 462, 463, 465, 466, 467, 468, 469, 470, 471, 472, 473, 475, 479, 480, 482, 483, 485, 489, 494, 501, 506, 508, 511, 513], "e1004075": [269, 275], "e157": 70, "e_": [265, 266], "e_1": [265, 266], "e_d": 77, "e_h": 71, "e_i": 266, "e_matrix": 329, "each": [0, 1, 3, 4, 5, 6, 9, 14, 16, 19, 20, 22, 23, 27, 28, 31, 35, 36, 37, 38, 39, 40, 41, 53, 67, 82, 84, 85, 86, 87, 90, 91, 108, 109, 110, 111, 112, 113, 114, 115, 116, 117, 118, 120, 121, 122, 149, 151, 152, 176, 182, 184, 189, 194, 195, 199, 209, 215, 221, 226, 228, 229, 233, 235, 237, 247, 254, 259, 261, 264, 268, 270, 271, 272, 273, 276, 277, 280, 281, 293, 296, 297, 298, 299, 300, 301, 304, 305, 306, 307, 309, 310, 311, 312, 316, 317, 318, 319, 320, 321, 326, 327, 329, 330, 331, 333, 336, 339, 340, 348, 356, 358, 369, 375, 377, 389, 392, 395, 400, 407, 408, 409, 412, 413, 416, 417, 440, 441, 448, 449, 456, 457, 458, 463, 469, 473, 479, 482, 483, 484, 485, 496, 498, 506, 508, 513], "earlier": 513, "earth": 87, "earthmicrobiom": 87, "easi": [111, 112, 120], "easier": [20, 149, 247], "easili": [115, 508], "ebi": [35, 38, 110, 113, 149], "ec_numb": 110, "ecoli": [107, 345], "ecolog": [1, 51, 319, 326], "ecologi": [1, 51, 53, 54, 58, 63, 64, 75, 80, 259, 296, 297, 298, 299, 319, 325, 326, 331, 332, 333, 468], "ecologist": 325, "ed": [55, 109], "edg": [116, 304, 325, 400, 403, 412, 466, 477, 478, 481, 484], "edgel": 264, "edit": [120, 298, 431], "editor": 111, "edu": [11, 44, 48, 108, 111, 116, 118, 479], "educ": [0, 338], "edward": 113, "eeb": [44, 48], "eeeee": 121, "eeeeeeee": 121, "eeeeeeeeeeh": 121, "eeeeeeeehhh": 121, "ef": 413, "effect": [19, 41, 43, 49, 51, 58, 59, 74, 84, 85, 120, 145, 245, 278, 336, 338, 339, 340, 487, 493], "effici": [0, 3, 115, 294, 331, 407, 408, 409, 462, 463, 473, 480, 482, 483, 485], "effort": 113, "eg": 149, "egozcu": [256, 265, 266, 269, 273, 275], "eh": 53, "eifcyilkinitilqfsitengmnefndatlpveeallntyridyyyrhlyi": 110, "eigendecomposit": [300, 331], "eigenvalu": [300, 320, 325, 331, 333], "eigenvector": [326, 331], "eigh": [300, 331], "eight": 340, "eigval": [117, 320], "either": [1, 20, 29, 31, 35, 36, 37, 70, 106, 120, 121, 125, 126, 127, 176, 195, 212, 235, 255, 298, 300, 318, 321, 323, 325, 330, 338, 340, 346, 347, 373, 381, 389, 408, 412, 413, 415, 456, 479, 481], "elem": [358, 392], "element": [6, 19, 115, 145, 247, 261, 265, 266, 277, 281, 293, 317, 321, 325, 329, 330, 334, 337, 339, 340, 341, 342, 358, 361, 377, 392, 407, 462, 494, 498], "elementwis": 328, "elev": [297, 472], "ellaps": 400, "elong": 470, "els": [12, 13, 116, 123, 126, 136, 141, 208, 228, 327, 356, 380, 395, 409], "elsevi": [298, 319, 325, 326, 332, 333], "elsewher": [53, 82, 84, 85, 86], "emb": [96, 97], "embed": [319, 505], "embedding_ptr": 109, "embeddingvector": [99, 100, 101, 102, 103], "embl": [113, 122, 149, 186, 190, 218, 220, 223, 227, 243, 246], "embl_gen": 110, "embl_str": 110, "emboss": [35, 38], "emboss_needl": 35, "emboss_wat": 38, "embptr": 109, "embryophyta": 110, "emdptr": 109, "emorg": 107, "emperor": 321, "emploi": 48, "empti": [11, 20, 54, 107, 111, 114, 118, 134, 135, 172, 174, 233, 259, 280, 338, 342, 367, 381, 384, 385, 407, 462, 467, 488, 506], "en": [43, 51, 58, 59, 111, 112, 121, 480], "ena": [110, 113], "enabl": [3, 256, 392, 431, 501, 513], "encod": [3, 10, 92, 104, 111, 112, 119, 123, 124, 145, 162, 176, 273, 319], "encode_miss": [169, 170, 183], "encount": [1, 51, 75, 120, 421, 422, 424, 433], "encourag": 339, "end": [0, 11, 19, 20, 35, 36, 37, 38, 39, 40, 41, 96, 106, 107, 110, 111, 112, 113, 114, 121, 122, 149, 151, 152, 158, 193, 230, 234, 402, 423, 457, 473, 493, 499], "endpoint": [340, 416], "enforc": [111, 176, 228], "engel": 65, "engin": 501, "english": [116, 298], "enough": [51, 111, 116, 340], "enrol": 340, "ens_": 51, "ens_pi": 51, "ensur": [1, 19, 23, 53, 84, 85, 123, 184, 215, 221, 261, 264, 268, 277, 291, 336, 388, 406, 439, 488, 496], "entail": [53, 82, 84, 85, 86], "entir": [1, 6, 7, 19, 20, 171, 184, 215, 221, 228, 342, 392, 396, 400, 402, 417, 424, 425, 427, 439, 453, 454, 493, 496, 506], "entiti": [79, 95, 149, 392], "entrez": 122, "entri": [55, 104, 105, 110, 122, 277, 318, 353, 356, 378, 379, 394, 395, 399], "entropi": [23, 58, 72, 74, 81], "enumer": 19, "env": [297, 352], "environ": [44, 84, 85, 270, 326, 390], "environment": [70, 297, 319, 326, 331, 332], "enzym": 67, "eq": [328, 329], "equal": [1, 3, 6, 20, 23, 42, 43, 44, 58, 79, 84, 85, 86, 111, 149, 151, 162, 176, 191, 228, 247, 254, 270, 277, 296, 298, 299, 300, 302, 304, 318, 325, 330, 334, 339, 340, 341, 342, 354, 415, 479, 480, 482, 485, 488, 489], "equat": [47, 48, 54, 67, 298, 415], "equit": [43, 71, 77], "equival": [20, 51, 53, 58, 59, 70, 72, 74, 112, 120, 189, 194, 211, 214, 226, 228, 233, 244, 254, 259, 277, 278, 289, 298, 319, 331, 411, 413, 414, 420, 468, 469, 482, 483, 485, 508], "erb": [269, 275], "eredi": 55, "erik": [19, 41], "error": [1, 23, 53, 67, 70, 82, 84, 85, 86, 111, 112, 118, 120, 123, 145, 155, 176, 182, 245, 296, 298, 300, 336, 340, 397, 419, 421, 422, 433, 459, 490, 506], "escap": 116, "especi": [104, 111, 120, 304, 333], "essenti": [113, 416], "esti": 52, "estim": [19, 43, 44, 47, 48, 52, 54, 56, 60, 61, 62, 67, 73, 264, 330, 338, 339, 340, 457, 477, 478, 481, 484], "estrang": 116, "esty_ci": 56, "et": [259, 304, 342, 399], "etc": [30, 34, 55, 93, 94, 111, 112, 120, 136, 138, 139, 141, 142, 143, 149, 157, 159, 186, 190, 218, 220, 223, 227, 243, 246, 247, 284, 290, 322, 324, 331, 333, 375, 383, 398, 451, 476, 507, 508], "euclidean": [101, 256, 276, 297, 325, 331, 333, 412, 415, 482], "euclidian": 331, "eudicotyledon": 110, "eukaryota": 110, "euryarchaeota": [430, 467], "evalu": [53, 70, 106, 107, 228, 276, 297, 318, 336, 409, 457, 484, 511, 513], "evaul": 123, "even": [20, 35, 36, 37, 57, 58, 65, 71, 77, 111, 116, 193, 296, 300, 340, 453, 454, 463], "evenli": [270, 321], "everi": [44, 120, 122, 177, 247, 258, 270, 271, 272, 273, 274, 286, 301, 323, 406, 409, 427, 434, 436, 472], "evid": [110, 116], "evmltdiprlhindpimk": 121, "evoltuion": [477, 478], "evolut": [111, 116, 118, 303, 304, 405, 415, 416, 477, 478, 479, 480, 481], "evolutionari": [53, 247, 248, 400, 412, 415, 416, 422, 468], "ex": 513, "exact": [53, 70, 82, 84, 85, 86, 120, 149, 229, 331, 506], "exactli": [20, 21, 24, 28, 38, 39, 40, 111, 112, 118, 123, 169, 176, 191, 228, 274, 321, 400, 403, 407, 436, 437, 472], "examin": [501, 513], "exampl": [0, 1, 3, 4, 5, 6, 8, 9, 10, 16, 18, 20, 21, 22, 23, 24, 25, 27, 28, 29, 31, 32, 33, 53, 84, 85, 86, 96, 97, 115, 120, 123, 125, 126, 127, 146, 149, 151, 153, 158, 171, 172, 174, 175, 176, 184, 185, 187, 188, 189, 191, 192, 193, 194, 195, 196, 197, 198, 199, 200, 201, 202, 203, 204, 205, 206, 208, 210, 211, 212, 213, 214, 215, 216, 217, 219, 221, 222, 224, 225, 226, 228, 229, 230, 231, 232, 233, 234, 235, 236, 237, 238, 239, 240, 241, 242, 244, 245, 247, 248, 249, 251, 254, 255, 257, 258, 259, 260, 261, 262, 263, 264, 265, 266, 267, 268, 269, 270, 271, 272, 273, 274, 275, 277, 278, 283, 286, 287, 289, 295, 296, 297, 298, 299, 300, 301, 302, 303, 304, 318, 321, 331, 338, 339, 340, 341, 345, 346, 347, 348, 349, 351, 352, 353, 355, 356, 357, 358, 359, 360, 362, 363, 364, 365, 366, 368, 369, 370, 371, 372, 373, 374, 375, 376, 379, 380, 381, 382, 384, 386, 387, 388, 389, 390, 391, 392, 394, 395, 397, 401, 402, 403, 405, 406, 407, 408, 409, 411, 412, 413, 414, 415, 416, 417, 418, 421, 422, 423, 424, 425, 426, 427, 429, 430, 432, 433, 435, 436, 437, 438, 439, 440, 441, 442, 443, 445, 446, 447, 448, 449, 450, 452, 453, 454, 455, 456, 457, 458, 459, 460, 461, 462, 463, 465, 466, 467, 468, 469, 470, 471, 472, 473, 475, 477, 478, 479, 480, 481, 482, 483, 484, 485, 488, 490, 496, 500, 506, 507, 508, 509, 511, 513], "example_protein_embed": 109, "example_t": [105, 351, 370, 371, 372, 375, 376, 390, 391], "exce": [111, 118, 331, 435], "exceed": 120, "excel": [112, 120], "except": [1, 111, 116, 117, 118, 120, 126, 193, 280, 299, 326, 417, 461, 473, 479, 502, 512], "exchang": 481, "excit": 513, "exclud": [119, 273, 293, 295, 412, 413, 415, 473], "exclude_absent_taxa": 414, "exclude_attr": 473, "exclus": [123, 149, 151, 152, 230, 234, 259], "execut": [123, 307, 314, 501, 504, 513], "exercis": 338, "exhibit": 325, "exist": [0, 31, 44, 49, 105, 116, 123, 125, 126, 127, 134, 135, 193, 247, 248, 276, 281, 293, 298, 301, 321, 352, 358, 364, 410, 423, 435, 446, 452, 459, 462, 473, 495, 504, 508], "exon": [114, 149, 174, 221, 228, 238], "exp": [58, 74, 258, 263, 269, 275], "expand": [304, 375, 467], "expect": [1, 87, 106, 123, 133, 184, 215, 221, 264, 265, 266, 276, 304, 325, 326, 333, 348, 357, 358, 373, 392, 466, 513], "expens": 342, "experi": [0, 73, 110, 113, 120, 259, 264, 339], "experienc": 340, "experiment": [110, 507], "explain": [113, 114, 117, 305, 310, 317, 319, 320, 325, 331, 333], "explan": [325, 326], "explanatori": [304, 319, 320, 326, 333], "explic": 413, "explicit": [112, 400], "explicitli": [20, 70, 118, 120, 245, 319, 409, 413, 415, 431, 453, 454, 463], "explor": [1, 83, 319], "exploratori": 1, "expon": [72, 81, 116, 272], "exponenti": [58, 74], "export": 120, "expos": [358, 496], "express": [80, 208, 232, 264, 269, 275, 339, 508], "extend": [0, 19, 21, 29, 35, 36, 37, 38, 39, 40, 53, 339, 402, 479, 482, 483, 485, 506], "extens": [110, 120], "extern": 116, "extinct": 53, "extra": [122, 123, 296, 297, 299, 300, 314], "extract": [264, 276, 277, 296, 300, 326, 405, 508], "extrapol": [61, 62, 336], "extrem": 298, "f": [1, 19, 29, 45, 61, 70, 87, 105, 106, 107, 109, 112, 116, 119, 121, 122, 146, 215, 298, 299, 300, 326, 329, 336, 339, 347, 348, 358, 381, 384, 392, 394, 395, 401, 403, 405, 406, 407, 408, 409, 412, 413, 415, 416, 417, 418, 421, 422, 424, 425, 426, 427, 433, 439, 440, 441, 442, 443, 445, 447, 448, 449, 455, 456, 457, 458, 459, 461, 462, 463, 465, 468, 469, 470, 471, 472, 473, 475, 479, 482, 483, 485, 511], "f_1": [44, 47, 52, 56, 73], "f_2": [47, 52], "f_i": 44, "f_onewai": 259, "fabacea": 110, "fabal": 110, "fabid": 110, "facili": 409, "facilit": [53, 84, 85, 87, 104, 291, 319, 336, 409, 419], "fact": 193, "factor": [70, 84, 85, 296, 299, 304, 326, 340, 412], "factori": [123, 125, 126, 127, 130, 140], "fail": [53, 54, 70, 82, 84, 85, 86, 155, 300, 336, 501, 513], "fail_callback": [501, 513], "fail_f": 513, "failur": [44, 501, 513], "fairli": 304, "faith": [1, 53, 70, 276, 468], "faith_pd": [1, 70, 468], "fall": [55, 60, 70, 85, 318], "fals": [1, 12, 13, 19, 20, 21, 22, 24, 27, 28, 32, 35, 36, 37, 47, 48, 49, 51, 59, 70, 74, 75, 76, 82, 84, 85, 86, 96, 97, 106, 109, 110, 111, 112, 113, 114, 116, 119, 125, 126, 127, 145, 146, 149, 151, 153, 154, 165, 168, 169, 170, 171, 172, 174, 175, 177, 183, 184, 187, 188, 189, 191, 193, 194, 195, 196, 197, 198, 199, 201, 202, 203, 204, 205, 206, 207, 208, 210, 212, 213, 214, 215, 217, 219, 221, 224, 225, 226, 228, 229, 233, 235, 236, 237, 238, 239, 240, 241, 242, 244, 245, 259, 264, 269, 275, 277, 278, 286, 293, 294, 298, 301, 304, 305, 306, 309, 310, 316, 323, 331, 333, 336, 338, 339, 341, 348, 355, 356, 359, 367, 368, 369, 370, 378, 379, 381, 385, 388, 390, 391, 392, 395, 397, 401, 403, 407, 408, 411, 412, 413, 414, 415, 416, 417, 418, 421, 422, 426, 431, 432, 433, 436, 437, 438, 441, 443, 445, 452, 453, 454, 456, 457, 458, 459, 462, 463, 465, 467, 468, 469, 471, 473, 477, 478, 480, 481, 482, 483, 484, 485, 487, 489, 493, 501, 504, 508, 511, 513], "famili": 1, "far": 325, "farri": 457, "farthest": 457, "fasffbf": 112, "fast": [53, 84, 85, 300, 305, 331, 373, 477, 478, 481], "fasta": [20, 30, 34, 112, 114, 119, 186, 190, 218, 220, 223, 227, 228, 243, 246, 506], "fasta_fl": 111, "fasta_format": 111, "faster": [1, 53, 84, 85, 87, 189, 194, 226, 233], "fastnni": 481, "fastq": [30, 34, 119, 186, 190, 218, 220, 223, 227, 243, 246, 506], "fastq_format": 112, "favor": 41, "fc": 264, "fd": [53, 500], "fdr_bh": [259, 264], "featur": [1, 55, 68, 103, 105, 111, 114, 120, 121, 149, 151, 153, 155, 156, 158, 160, 176, 184, 215, 221, 228, 256, 259, 264, 273, 320, 323, 325, 326, 332, 333, 388, 431, 489, 507, 508, 509], "feature_t": 113, "fecal": 340, "federhen": 122, "fee": [111, 118], "felsenstein": [111, 118, 415, 511], "fernand": 264, "fernandez": [256, 268], "ferr": 113, "fetch": [151, 388, 511], "fetureid": 120, "few": [20, 43, 53, 84, 85, 87, 358, 392, 506, 511, 513], "fewer": [44, 118, 339, 340], "fff": 112, "ffffx": 112, "ffllssssyi": 191, "fglfmeqlttgdysksmrrivknrlpkfskfesslvngsfdfiginyysssi": 110, "fh": [106, 107, 108, 111, 112, 113, 114, 118, 119, 121, 122, 123, 125, 126, 127], "field": [1, 107, 112, 119, 191, 319, 358, 392], "fifth": 111, "fig": [1, 283, 321], "figur": [283, 321, 486], "file": [30, 34, 93, 94, 104, 105, 106, 107, 108, 109, 112, 114, 115, 116, 117, 118, 119, 120, 121, 122, 123, 126, 130, 136, 138, 139, 140, 141, 142, 143, 144, 145, 146, 147, 157, 159, 176, 181, 186, 190, 218, 220, 223, 227, 243, 246, 259, 276, 283, 284, 290, 308, 313, 315, 321, 322, 324, 338, 342, 345, 346, 347, 348, 349, 353, 357, 358, 360, 364, 373, 379, 381, 382, 383, 386, 387, 392, 393, 394, 395, 398, 399, 405, 451, 476, 495, 500, 511], "fileformaterror": 123, "filehandl": [30, 34, 93, 94, 123, 125, 126, 127, 136, 138, 139, 141, 142, 143, 145, 146, 157, 159, 186, 190, 218, 220, 223, 227, 243, 246, 284, 290, 322, 324, 383, 398, 451, 476], "filenam": 495, "filepath": [30, 34, 93, 94, 136, 138, 139, 141, 142, 143, 145, 157, 159, 181, 186, 190, 218, 220, 223, 227, 243, 246, 284, 290, 301, 322, 324, 383, 398, 451, 476], "filesentinel": [123, 125, 127], "filter": [19, 23, 41, 119, 163, 164, 176, 177, 178, 197, 301, 346, 347, 388, 467, 513], "filter_column": 178, "filter_f": 467, "filter_fn": 356, "filter_id": [165, 177, 180], "final": [121, 304, 348, 393, 394, 445, 513], "find": [0, 54, 185, 196, 198, 200, 201, 206, 216, 219, 222, 234, 235, 240, 242, 297, 300, 304, 326, 340, 369, 401, 407, 410, 419, 421, 422, 425, 426, 427, 431, 432, 433, 435, 437, 438, 439, 442, 445, 455, 461, 462, 470, 473, 475, 481, 494], "find_al": [419, 424, 426], "find_by_func": [424, 425], "find_by_id": [404, 424, 425, 426], "find_motif": [235, 508], "find_with_regex": [235, 508], "fine": 395, "finit": [49, 51, 59, 75, 76], "firmicut": [375, 429, 430, 467], "first": [1, 3, 18, 19, 20, 35, 36, 37, 38, 39, 40, 41, 44, 53, 84, 85, 91, 96, 109, 111, 112, 113, 114, 115, 116, 117, 118, 120, 121, 122, 123, 127, 153, 158, 188, 189, 193, 225, 228, 234, 235, 257, 258, 259, 264, 270, 277, 296, 298, 309, 317, 319, 327, 331, 336, 339, 353, 364, 394, 405, 407, 419, 424, 425, 431, 434, 440, 447, 448, 449, 467, 469, 472, 493, 497, 502, 506, 511, 513], "fish": 319, "fisher": 54, "fit": [67, 264, 318, 320, 333, 512], "five": [111, 122, 259, 283, 477, 478, 480, 481], "fix": [61, 115, 118], "fl": 111, "flag": [122, 511], "flat": [113, 235], "flatfil": 110, "flatten": 330, "flexibl": 400, "flip": 473, "float": [23, 27, 35, 36, 37, 38, 39, 40, 41, 42, 45, 46, 49, 51, 53, 54, 55, 56, 57, 58, 59, 60, 61, 63, 64, 65, 66, 67, 70, 71, 72, 73, 74, 75, 77, 80, 81, 82, 84, 85, 86, 87, 90, 104, 106, 113, 115, 116, 120, 176, 183, 211, 212, 231, 239, 241, 251, 254, 255, 259, 264, 268, 272, 275, 276, 277, 281, 293, 298, 300, 302, 304, 307, 314, 321, 331, 337, 339, 340, 341, 342, 358, 359, 361, 362, 373, 389, 392, 400, 408, 411, 412, 413, 414, 415, 421, 422, 433, 435, 441, 456, 458, 463, 466, 468, 479, 488], "float32": [104, 109, 300, 390], "float64": [1, 29, 104, 109, 229, 259, 295, 300, 319, 358, 392], "flush": 145, "fmet": 193, "fn": 495, "focu": 123, "focus": [176, 333], "fold": [264, 506], "folder": 495, "follow": [1, 20, 29, 41, 48, 53, 54, 70, 84, 85, 106, 107, 108, 109, 110, 111, 112, 113, 114, 115, 116, 117, 118, 119, 120, 121, 122, 123, 149, 171, 172, 174, 175, 176, 184, 215, 221, 228, 248, 257, 258, 259, 262, 263, 265, 266, 267, 270, 272, 273, 276, 277, 296, 297, 298, 300, 301, 305, 321, 325, 340, 404, 449, 450, 496, 501, 506, 511, 513], "foo": [114, 120, 151, 228, 342, 348, 349, 358, 359, 374, 384, 392, 394, 395, 500, 513], "foobar": [349, 513], "foral": [262, 263], "foraminifera": 45, "ford": 70, "form": [1, 20, 35, 147, 277, 291, 295, 343, 344, 353, 357, 394, 458, 463, 466], "formal": [112, 122, 256], "format": [3, 11, 16, 30, 34, 93, 94, 128, 129, 130, 131, 132, 133, 134, 135, 136, 137, 138, 139, 140, 141, 142, 143, 148, 149, 157, 159, 173, 176, 181, 186, 190, 191, 208, 218, 220, 223, 227, 243, 246, 277, 284, 285, 290, 291, 292, 294, 308, 313, 315, 322, 324, 336, 339, 340, 342, 353, 357, 358, 359, 360, 383, 390, 392, 393, 394, 398, 399, 400, 403, 405, 429, 451, 476, 480, 486, 510, 511], "format_f": 392, "format_nam": [131, 132, 133], "format_object": 129, "format_url": 359, "format_vers": [105, 342, 358, 392, 399], "formatidentificationwarn": [136, 141], "former": [247, 425], "formula": [55, 300], "forum": 120, "forward": [1, 189, 191, 193, 194, 226], "fould": [411, 413, 414, 415, 483, 485], "found": [19, 79, 105, 107, 110, 111, 112, 113, 116, 118, 121, 136, 139, 141, 143, 245, 280, 297, 298, 300, 340, 358, 392, 416, 424, 425, 426, 427, 439, 459, 460, 468, 479], "foundat": 112, "four": [20, 112, 121, 184, 215, 221, 259, 321, 409, 498], "fourment": [416, 422], "fourth": [3, 72], "fr": 479, "frac": [44, 45, 46, 47, 49, 51, 52, 54, 55, 56, 57, 58, 59, 60, 63, 64, 65, 66, 67, 71, 72, 73, 77, 80, 81, 257, 258, 262, 267, 268, 270, 271, 272, 273, 298, 333], "fraction": [45, 255, 331, 340, 361, 511], "fraction_diff": 231, "fraction_sam": 231, "frame": [100, 106, 107, 189, 191, 193, 194, 226, 264, 297, 429], "framework": [70, 256, 478, 481], "free": [122, 501, 513], "freedom": [264, 269, 275, 330, 337], "freq": [233, 237], "frequenc": [1, 23, 27, 43, 44, 56, 211, 212, 237, 239, 241, 336, 338, 340, 400, 405], "frequent": [342, 409], "friedman": 259, "friedmanchisquar": 259, "from": [0, 1, 2, 3, 4, 5, 6, 7, 8, 9, 10, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 25, 26, 27, 28, 29, 30, 31, 32, 33, 35, 36, 37, 38, 39, 40, 49, 51, 53, 60, 70, 74, 79, 80, 84, 85, 93, 96, 97, 105, 106, 107, 108, 109, 110, 111, 112, 113, 114, 115, 116, 117, 118, 119, 120, 121, 122, 123, 125, 126, 127, 136, 137, 141, 149, 150, 151, 153, 154, 157, 162, 163, 169, 170, 171, 172, 174, 175, 176, 181, 182, 183, 184, 185, 186, 187, 188, 189, 191, 193, 194, 195, 196, 197, 198, 199, 200, 201, 202, 203, 204, 205, 206, 208, 210, 211, 212, 213, 214, 215, 216, 217, 218, 219, 221, 222, 223, 224, 225, 226, 228, 229, 230, 231, 232, 233, 234, 235, 236, 237, 238, 239, 240, 241, 242, 243, 244, 245, 247, 248, 249, 251, 252, 254, 255, 257, 258, 259, 260, 261, 262, 263, 264, 265, 266, 267, 268, 269, 270, 271, 272, 273, 274, 275, 276, 277, 278, 281, 283, 284, 286, 287, 289, 293, 295, 296, 297, 298, 300, 301, 302, 304, 305, 306, 318, 319, 321, 322, 325, 326, 328, 329, 331, 336, 338, 339, 340, 341, 345, 346, 347, 348, 349, 351, 352, 355, 356, 357, 358, 359, 360, 362, 363, 364, 365, 366, 368, 369, 370, 371, 372, 373, 374, 375, 376, 379, 380, 381, 382, 383, 384, 385, 386, 387, 388, 389, 390, 391, 392, 394, 395, 397, 400, 401, 402, 403, 404, 405, 406, 407, 408, 409, 410, 411, 412, 413, 414, 415, 416, 417, 418, 419, 421, 422, 423, 424, 425, 426, 427, 428, 429, 430, 432, 433, 435, 436, 437, 438, 439, 440, 441, 442, 443, 444, 445, 446, 447, 448, 449, 450, 451, 452, 453, 454, 455, 456, 457, 458, 459, 460, 461, 462, 463, 465, 466, 467, 468, 469, 470, 471, 472, 473, 474, 475, 477, 478, 479, 480, 481, 482, 483, 484, 485, 490, 496, 497, 500, 501, 508, 511, 513], "from_": 278, "from_dict": [33, 296, 300, 305, 321, 338, 339], "from_hdf5": 392, "from_iter": 253, "from_ncbi": [191, 193, 194, 225, 226], "from_path_seq": 7, "from_tabular": [3, 8], "from_taxdump": 430, "from_taxonomi": [429, 467], "front": [158, 273], "frontier": 70, "frozenset": [407, 408, 409, 462, 463], "fsvd": [300, 331], "ft_current": 149, "ftp": [110, 122, 149], "full": [61, 62, 108, 109, 259, 342, 348, 370, 408, 427, 495], "full_genome_avail": [356, 381], "fulli": [3, 70, 113, 506], "fun": 513, "func": [360, 384, 409, 426, 453, 454, 471, 492, 503, 504], "function": [1, 35, 36, 37, 43, 53, 54, 61, 62, 67, 69, 84, 85, 86, 87, 90, 111, 112, 119, 124, 125, 126, 127, 131, 132, 133, 149, 151, 153, 184, 191, 215, 221, 231, 247, 254, 256, 257, 258, 259, 262, 263, 264, 265, 266, 273, 281, 286, 293, 297, 298, 299, 300, 301, 302, 305, 318, 323, 326, 331, 335, 338, 339, 340, 342, 348, 353, 356, 358, 360, 373, 381, 384, 386, 392, 393, 394, 395, 399, 403, 409, 412, 415, 426, 453, 454, 460, 467, 468, 471, 480, 482, 483, 484, 485, 487, 488, 489, 490, 491, 492, 493, 495, 496, 497, 498, 499, 501, 503, 504, 506, 507, 508, 511, 512], "functionfor": 302, "funtion": 209, "further": [20, 123, 176, 339, 409, 453, 454, 511], "furthest": 441, "futher": 123, "futur": [53, 70, 84, 85, 111, 480], "fuzzi": [114, 149, 150, 151, 152, 153, 228], "g": [0, 1, 19, 20, 23, 24, 29, 37, 40, 55, 60, 67, 70, 87, 90, 106, 108, 110, 111, 112, 113, 115, 116, 117, 118, 120, 122, 123, 149, 162, 176, 181, 184, 201, 211, 212, 215, 221, 228, 229, 230, 232, 233, 235, 247, 248, 251, 254, 259, 264, 273, 276, 277, 291, 295, 296, 297, 299, 300, 321, 331, 339, 340, 358, 375, 388, 392, 401, 406, 407, 409, 412, 416, 418, 425, 431, 440, 447, 448, 449, 450, 456, 457, 458, 459, 461, 462, 463, 467, 468, 469, 471, 472, 473, 475, 479, 482, 501, 506, 508, 511, 513], "g1": 300, "g2": 300, "g_m": 262, "ga": [228, 508], "gaa": 508, "gaagcaatgc": 110, "gaagttgagt": 110, "gaatcaagcc": 110, "gabor": [19, 41], "gac": 236, "gacccgcuuu": 508, "gacg": 236, "gacgtt": [203, 204], "gag": 245, "gagatagagt": 110, "gagcccgggc": [111, 118], "gagccgtggc": [111, 118], "gagcggaggc": 110, "gaggacttcg": 110, "gaggtattgg": 110, "gagrctc": 245, "gain": [176, 276, 331], "gair": 111, "gairaagccttggc": 118, "gamma": 44, "gap": [0, 3, 4, 6, 8, 10, 14, 15, 19, 20, 22, 23, 27, 29, 35, 36, 37, 38, 39, 40, 96, 97, 106, 107, 108, 109, 110, 111, 112, 113, 114, 118, 174, 184, 185, 187, 188, 189, 191, 193, 194, 195, 197, 199, 200, 204, 207, 210, 211, 212, 214, 215, 216, 221, 222, 224, 225, 226, 228, 229, 235, 245, 254, 467, 508, 513], "gap_char": [184, 195, 197, 215, 221], "gap_charact": 245, "gap_extend_penalti": [19, 35, 36, 37, 38, 39, 40], "gap_mod": 23, "gap_open_penalti": [19, 35, 36, 37, 38, 39, 40], "gapopen": [106, 107], "garbag": 145, "gardnerella": 340, "garrison": [19, 41], "gascuel": [477, 478, 480, 481], "gaston": 53, "gataccttca": 110, "gatcacttga": 110, "gatcttcccc": 110, "gatgcaacac": 110, "gather": [289, 511], "gattattcta": 110, "gattttcgag": 110, "gauu": [240, 242], "gb": [107, 113], "gb_str": 113, "gbk": 113, "gc": [20, 22, 110, 111, 112, 113, 114, 122, 174, 184, 187, 191, 194, 197, 199, 210, 212, 214, 221, 224, 229, 508], "gc_content": 212, "gc_frequenc": 211, "gcaattttca": 110, "gcacatccct": 113, "gcacaucccu": 113, "gcagaagctg": 110, "gcagatgtg": 255, "gcatgcatgc": 114, "gcatggtcat": 110, "gcaugcaucugcauacguacguacgcaugca": 108, "gcaugcaucugcauacguacguacgcaugcagucgauacauacguacgucgguacgu": 108, "gcaugcaucugcauacguacguacgcaugcauca": 108, "gccaaaccca": 110, "gcccagtagcttcccaatatgagagcatcaattgtagatcgggcc": 0, "gccccccuuu": 508, "gcgtatagtt": 110, "gcgtgcctaaggtatgcaag": 0, "gctaactaggctcccttctacccctctcagaga": 0, "gctgccgaga": 110, "gctgttattt": 110, "gcttcatctt": 110, "gen": [114, 513], "gen1": 114, "gen2": 114, "gena": 149, "genbank": [110, 114, 122, 186, 190, 218, 220, 223, 227, 243, 246], "gender": [276, 338, 339], "gene": [1, 114, 149, 151, 153, 156, 184, 228, 264, 269, 275, 342, 399, 507], "gene_nam": 149, "genea": 345, "geneb": 345, "gener": [1, 5, 9, 10, 18, 21, 24, 35, 41, 42, 43, 58, 61, 62, 63, 70, 72, 81, 87, 109, 112, 113, 114, 116, 121, 122, 125, 127, 131, 133, 136, 141, 144, 184, 209, 221, 228, 232, 235, 236, 247, 256, 264, 276, 294, 296, 297, 298, 299, 300, 301, 302, 304, 318, 320, 321, 325, 331, 336, 338, 339, 340, 341, 358, 368, 369, 377, 381, 392, 412, 428, 460, 469, 474, 482, 496, 506, 508, 512], "generated_bi": [342, 359, 392, 393, 399], "generatortyp": [368, 370, 381], "genet": [111, 116, 118, 122, 188, 189, 191, 192, 193, 194, 225, 226, 303, 416, 422, 479, 508], "genetic_cod": [225, 226], "geneticcod": [189, 225, 226, 508], "genom": [1, 11, 151], "genpept": 113, "gentil": 273, "genu": [1, 122], "geologi": 256, "geometr": [260, 262, 264, 273, 300], "geometri": [256, 258, 262, 263, 266], "geq": 333, "gerald": 273, "get": [20, 42, 105, 109, 120, 145, 146, 150, 151, 191, 192, 276, 298, 318, 326, 356, 363, 364, 365, 366, 372, 374, 376, 378, 379, 397, 418, 486, 496, 506], "get_alpha_diversity_metr": [1, 82, 89], "get_beta_diversity_metr": [1, 86, 88, 90], "get_column": 180, "get_id": [163, 164, 168, 178, 179], "get_max_dist": 441, "get_nam": 248, "get_trajectori": 305, "get_value_by_id": 351, "getaaafhwqaaf": 119, "getvalu": [108, 111, 112, 113, 114, 118, 121, 276], "gff": 114, "gff3": [113, 151, 157, 159, 186, 190, 243, 246], "gff_str": 114, "gfgmvinn": 121, "gfp": 508, "gfv": 121, "gg": [185, 200, 216, 222, 230], "gg_otu_1": [358, 359], "gg_otu_2": 359, "gg_otu_3": 359, "gg_otu_4": 359, "gg_otu_5": 359, "gga": 508, "ggaa": 229, "ggacugaa": 508, "ggag": [185, 200, 216, 222], "ggattgttta": 110, "ggca": 0, "ggctaacggt": 110, "ggg": 508, "ggggagg": [185, 200, 216, 222], "gggtttttac": 110, "ggt": [121, 244], "ggta": 0, "ggtaccaacg": 244, "ggtacgcaag": 0, "ggtc": 197, "ggtccattc": 197, "ggtggtttct": 110, "ggtgtttagc": 110, "ggtt": 352, "ggu": 228, "gguc": [228, 231, 239, 240, 241, 242], "ggucg": [228, 230], "ggucguaaagga": 228, "ggucgugaag": 228, "ggucgugaagga": 228, "gi": [106, 107, 113], "giaro": 413, "gibb": [81, 416, 422], "gigasci": [321, 342, 399], "gilk": 304, "gini": [55, 75], "gish": [106, 107], "github": [11, 321], "give": [1, 116, 325, 326, 333, 342, 399, 456], "given": [1, 4, 5, 6, 16, 20, 30, 34, 44, 55, 58, 60, 67, 73, 77, 81, 82, 86, 87, 90, 93, 94, 101, 111, 112, 116, 117, 120, 125, 127, 134, 135, 136, 138, 141, 142, 154, 157, 159, 186, 190, 218, 220, 223, 227, 243, 245, 246, 273, 281, 284, 290, 293, 297, 298, 301, 322, 324, 326, 330, 331, 335, 337, 339, 363, 365, 373, 381, 383, 397, 398, 407, 413, 415, 421, 422, 425, 451, 456, 458, 473, 474, 475, 476, 478, 500, 501, 503, 513], "gkp1137": 112, "glahn": [256, 269, 275], "gln": 215, "global": [0, 35, 36, 37], "global_pairwise_align": [36, 37, 38, 39, 40], "global_pairwise_align_nucelotid": [35, 37, 38, 39, 40], "global_pairwise_align_nucleotid": 0, "global_pairwise_align_protein": [35, 36, 38, 39, 40], "gloor": 264, "glossari": 23, "glu": 215, "glucosidas": 110, "glutam": 215, "glutamin": 215, "glx": 215, "gly": 215, "glycin": [23, 215], "glycosyl": [216, 235, 508], "gme": 477, "go": [340, 388, 511, 513], "goa": 110, "goal": [120, 464, 506], "goldman": 70, "gonzalez": 321, "good": [43, 52, 56, 331], "goods_coverag": [52, 73], "googl": 120, "gorilla": [111, 118], "gorlick": 121, "goto": 112, "gotten": 20, "gouet": [61, 62], "gov": [23, 36, 37, 39, 40, 106, 107, 111, 113, 119, 122, 191, 192], "gower": 331, "gracilibacteria": 191, "gradient": [55, 319, 325, 326, 331, 333], "gradientanova": [306, 309, 316, 317], "gradientanovaresult": 311, "graft": 470, "gram": [265, 266], "grammar": [195, 228], "grammaredsequ": [20, 21, 24, 25, 35, 38, 108, 111, 118, 121, 184, 215, 221, 508], "grant": [111, 118], "graph": 400, "graphic": [416, 422], "great": 43, "greater": [111, 151, 228, 264, 296, 298, 299, 300, 301, 304, 339, 340, 341, 364], "greedi": [477, 478], "grei": 321, "group": [1, 79, 120, 208, 256, 259, 264, 273, 278, 296, 299, 300, 305, 306, 307, 311, 314, 315, 316, 319, 338, 339, 340, 343, 358, 363, 381, 392, 462, 463, 484, 501, 507, 511], "group1": 296, "group2": 296, "group3": 296, "group_md": 343, "group_observation_md": 363, "groupbi": 339, "groupresult": 307, "growth": [264, 339], "gsi": 273, "gt": [8, 20, 28, 56], "gt10": 110, "gtaacctgag": 110, "gtaag": 3, "gtacct": [108, 118], "gtagaggacc": 110, "gtagct": [108, 118], "gtatct": 118, "gtcgaa": [108, 118], "gtt": 236, "gttaatgcca": 110, "gttactcaac": 110, "gttcggcctc": 110, "gttgaccaat": 110, "gttgggatta": 110, "gtttatccaa": 110, "guaaccugag": 110, "guanin": [184, 221], "guarante": [29, 62, 120, 184, 199, 215, 221, 277, 302], "guc": 228, "gucgauacauacguacgucgguacgu": 108, "gucgauacauacguacgucguacguacgu": 108, "guess": [67, 111, 136, 141], "guidanc": 506, "gunnerida": 110, "gut": [1, 120, 321], "gytai": 121, "gzip": [145, 392], "h": [19, 44, 45, 49, 51, 57, 58, 59, 70, 71, 73, 74, 75, 77, 81, 111, 118, 121, 146, 184, 215, 221, 406, 418, 450, 456, 457, 459, 462, 463, 468, 472, 473, 475, 479, 511], "h5grp": [358, 392], "h5py": [358, 392], "h_": 259, "h_0": 55, "h_b": 46, "h_i": 55, "h_n": 55, "ha": [1, 3, 19, 20, 22, 35, 36, 37, 42, 90, 96, 97, 104, 105, 106, 107, 108, 109, 110, 111, 112, 113, 114, 115, 116, 117, 118, 119, 120, 121, 122, 123, 138, 142, 145, 161, 168, 172, 174, 175, 176, 181, 184, 187, 188, 189, 191, 193, 194, 195, 197, 199, 205, 206, 210, 214, 215, 221, 224, 225, 226, 228, 229, 261, 276, 318, 325, 327, 338, 339, 340, 348, 356, 373, 400, 406, 407, 408, 413, 431, 432, 435, 436, 437, 453, 454, 456, 459, 472, 475, 479, 480, 484, 493, 496, 497, 498, 501, 508, 511], "habitat": 326, "had": [20, 53, 84, 85, 296, 300, 340], "half": [60, 270, 407], "halko": 331, "halobacteria": [430, 467], "ham": [231, 276, 508], "hamadi": [53, 84, 85], "hand": [1, 331], "handbook": 111, "handi": [501, 513], "handl": [20, 23, 29, 111, 112, 119, 121, 122, 123, 124, 125, 127, 145, 176, 181, 193, 194, 259, 298, 300, 301, 336, 342, 348, 373, 382, 400, 412, 468, 500, 506, 513], "handler": [124, 136, 139, 141, 143, 145], "happen": [20, 116, 235, 433, 441, 479, 513], "hard": [53, 82, 84, 85, 86], "hardcod": 52, "harm": 270, "has_cach": [409, 410, 419], "has_children": [437, 438], "has_definit": [196, 198, 203, 205, 206], "has_degener": [198, 202, 205], "has_gap": 201, "has_metadata": 171, "has_missing_valu": [163, 165], "has_nuc_pattern": 513, "has_positional_metadata": 174, "has_stop": 219, "hashabl": [20, 318, 407, 408, 462, 463, 504], "hashlib": 500, "hasn": [228, 395], "have": [0, 1, 10, 19, 20, 22, 25, 27, 28, 29, 41, 43, 53, 60, 71, 77, 84, 85, 100, 101, 102, 103, 106, 107, 108, 110, 111, 112, 113, 114, 115, 116, 117, 118, 119, 120, 121, 123, 145, 149, 151, 176, 177, 182, 193, 199, 228, 229, 235, 251, 259, 274, 276, 277, 298, 304, 305, 308, 310, 313, 315, 318, 321, 325, 326, 327, 330, 331, 333, 334, 336, 338, 339, 340, 341, 356, 358, 373, 374, 375, 388, 392, 397, 400, 404, 405, 406, 407, 416, 423, 424, 436, 456, 457, 458, 462, 466, 467, 472, 473, 477, 478, 481, 482, 485, 488, 497, 511, 513], "hcdt": 81, "hdf5": [104, 105, 109, 342, 358, 392, 399], "hdfgroup": 104, "hdist": 304, "he": 0, "header": [106, 107, 108, 112, 113, 115, 117, 120, 162, 176, 180, 353, 357], "header_kei": [353, 394], "header_valu": [353, 394], "heagawghe": 0, "health": [259, 338, 339], "healthi": [338, 339, 340], "heatmap": 283, "height": [416, 421, 480], "heip": [57, 65], "heip_": 71, "held": 388, "hello": 228, "help": [120, 122, 458], "helper": [488, 489, 511], "henc": 298, "henikoff": [37, 40, 248], "here": [0, 1, 20, 23, 44, 48, 53, 60, 67, 77, 82, 83, 84, 85, 86, 87, 88, 89, 105, 109, 110, 113, 118, 123, 125, 127, 146, 235, 259, 264, 304, 333, 358, 392, 477, 480, 481, 506, 511], "hernand": 273, "heterogen": 332, "heuer": 112, "heurist": [19, 331], "hexdigest": 500, "hgc": 122, "hi": 215, "hidden": 122, "hierarch": [122, 256, 273, 400, 412, 416, 484], "hierarchi": [348, 416, 428, 429, 441, 511], "high": [53, 84, 85, 111, 112, 264, 319, 321, 325, 331, 430, 509], "higher": [23, 43, 247, 259, 264, 503], "highest": [19, 116], "highest_prior": 503, "highli": [3, 23], "highlight": 112, "hill": [59, 70, 72, 74], "histidin": 215, "histor": [1, 191], "histori": [53, 340, 416], "hit": 107, "hoc": 336, "hochberg": [259, 264], "hoffmann": 70, "hold": [291, 311, 318, 338, 389, 419, 504], "hollow": [86, 104, 277, 293, 294, 302], "holm": [259, 264], "hommola": 304, "homogen": [300, 325, 333], "homolog": 247, "horizont": 29, "host": [122, 304], "host_dist": 304, "hot": 319, "hotton": 122, "hous": 338, "how": [20, 28, 29, 67, 111, 113, 120, 145, 162, 176, 193, 194, 207, 229, 235, 269, 275, 298, 331, 336, 338, 339, 340, 342, 354, 373, 399, 506, 513], "howev": [1, 20, 53, 54, 70, 82, 84, 85, 86, 111, 115, 116, 120, 122, 184, 215, 221, 228, 256, 264, 300, 304, 319, 331, 342, 395, 400, 407, 408, 413, 415, 416, 422, 463, 468, 480, 482, 483, 485, 492], "hsp": [106, 107], "hstack": [338, 339], "ht": 11, "htm": 297, "html": [23, 60, 105, 106, 108, 111, 113, 116, 118, 121, 149, 277, 285, 291, 292, 296, 297, 298, 299, 300, 321, 342, 358, 392, 399, 479, 496], "http": [11, 19, 23, 35, 36, 37, 38, 39, 40, 41, 43, 44, 48, 60, 87, 104, 105, 106, 107, 108, 110, 111, 112, 113, 116, 118, 119, 120, 121, 122, 176, 181, 191, 192, 269, 273, 275, 277, 285, 291, 292, 296, 297, 298, 299, 300, 321, 342, 358, 359, 392, 399, 479, 480, 496, 500], "huerta": 405, "hugh": 110, "human": [104, 111, 112, 115, 116, 117, 477, 478, 481, 490], "hundr": [1, 87], "hurlbert": [51, 75], "hwang": 44, "hydrogenosom": 122, "hypothesi": [256, 259, 264, 298, 301, 304, 336], "hypothet": 149, "h\u00e9bert": 273, "i": [0, 1, 3, 6, 10, 11, 18, 19, 20, 21, 22, 23, 24, 25, 27, 28, 29, 30, 32, 34, 35, 36, 37, 38, 39, 40, 41, 42, 43, 44, 45, 46, 47, 48, 49, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 71, 72, 73, 74, 75, 76, 77, 79, 80, 81, 82, 84, 85, 86, 87, 90, 91, 93, 94, 103, 104, 105, 106, 107, 108, 109, 110, 111, 112, 113, 114, 115, 116, 117, 118, 119, 120, 121, 122, 124, 125, 126, 127, 130, 131, 133, 136, 138, 139, 140, 141, 142, 143, 145, 149, 150, 151, 152, 153, 154, 155, 157, 159, 160, 162, 171, 172, 174, 176, 181, 182, 184, 185, 186, 187, 188, 189, 190, 191, 193, 194, 195, 196, 197, 198, 199, 200, 201, 205, 206, 207, 208, 209, 210, 211, 213, 214, 215, 216, 218, 219, 220, 221, 222, 223, 224, 226, 227, 228, 229, 230, 231, 233, 234, 235, 236, 237, 238, 239, 240, 241, 242, 243, 244, 245, 246, 247, 254, 255, 256, 257, 258, 259, 261, 262, 263, 264, 265, 266, 267, 268, 269, 270, 271, 272, 273, 274, 275, 276, 277, 278, 280, 282, 283, 284, 285, 288, 289, 290, 291, 292, 293, 294, 295, 296, 297, 298, 299, 300, 302, 304, 308, 310, 313, 315, 316, 317, 318, 319, 320, 321, 322, 323, 324, 325, 326, 327, 329, 330, 331, 332, 333, 334, 336, 337, 338, 339, 340, 341, 342, 345, 348, 349, 352, 353, 355, 356, 357, 358, 364, 367, 368, 369, 370, 373, 374, 375, 381, 382, 383, 384, 385, 388, 389, 392, 393, 394, 395, 396, 397, 398, 399, 400, 402, 403, 404, 405, 407, 408, 409, 410, 411, 412, 413, 414, 415, 416, 417, 418, 419, 420, 421, 422, 424, 425, 426, 427, 429, 431, 433, 434, 435, 436, 437, 438, 439, 440, 441, 443, 444, 445, 447, 448, 449, 450, 451, 452, 453, 454, 456, 457, 458, 459, 460, 462, 463, 465, 466, 467, 468, 469, 470, 471, 472, 473, 474, 475, 476, 477, 478, 479, 480, 481, 482, 483, 484, 485, 487, 488, 489, 490, 491, 492, 493, 494, 495, 496, 497, 498, 500, 501, 502, 503, 504, 505, 506, 508, 511, 512, 513], "id": [0, 1, 20, 31, 32, 53, 70, 82, 84, 85, 86, 87, 90, 91, 100, 104, 106, 107, 108, 109, 110, 111, 112, 113, 114, 115, 117, 118, 119, 120, 121, 122, 149, 162, 164, 165, 167, 169, 170, 171, 172, 176, 177, 178, 180, 182, 183, 188, 189, 191, 192, 193, 194, 225, 226, 228, 247, 269, 276, 277, 278, 280, 281, 282, 286, 287, 289, 291, 293, 294, 295, 296, 297, 298, 299, 300, 301, 302, 310, 317, 320, 321, 323, 338, 339, 340, 342, 344, 345, 346, 347, 348, 349, 351, 352, 353, 355, 356, 357, 358, 359, 362, 364, 366, 368, 373, 374, 375, 379, 381, 382, 386, 387, 388, 391, 392, 394, 395, 396, 397, 404, 416, 417, 427, 428, 429, 430, 434, 466, 480, 482, 483, 484, 485, 508], "id1": 120, "id2": 120, "id3": 120, "id_": [348, 356, 381, 395], "id_count": 176, "id_head": [169, 170, 180, 182, 183], "id_i": 370, "id_index": 466, "id_j": 370, "id_list": 428, "id_map": 397, "id_pair": 90, "id_whitespace_replac": [111, 112], "idea": 339, "ideal": 123, "ident": [1, 106, 107, 116, 120, 277, 291, 304, 412, 413, 452, 473, 482, 511], "identif": 38, "identifi": [20, 32, 82, 86, 87, 90, 104, 108, 111, 112, 113, 114, 115, 118, 121, 122, 156, 176, 185, 216, 222, 276, 301, 336, 340, 366, 374, 397, 412, 441, 482, 483, 485, 506], "idptr": 109, "ids_to_keep": [164, 178, 356], "idx": 245, "ie": 212, "igkeeiqqrl": 109, "ignor": [19, 23, 44, 53, 84, 85, 107, 108, 110, 111, 112, 115, 116, 120, 123, 177, 185, 193, 194, 200, 216, 222, 232, 280, 296, 297, 298, 299, 300, 331, 338, 339, 381, 392, 412, 442, 477, 481, 489, 501, 508, 511, 513], "ignore_axis_label": 489, "ignore_direction": 489, "ignore_metadata": 28, "ignore_method_nam": 489, "ignore_non": 381, "ignore_self": 412, "ii": 336, "iii": 61, "ij": 298, "il": 215, "illumina": [112, 119], "illumina1": [112, 119], "illumina_1": 119, "illustr": [228, 296, 300], "iloc": 20, "ilr": [256, 266, 274], "ilr_inv": 274, "im": [114, 151, 153], "im1": 153, "im2": 153, "imagin": 116, "immedi": [111, 118, 434], "immut": [228, 508], "implement": [0, 1, 35, 38, 43, 44, 48, 53, 60, 77, 83, 84, 85, 88, 89, 112, 116, 120, 123, 125, 126, 127, 128, 145, 176, 273, 319, 325, 326, 332, 393, 394, 464, 477, 479, 481], "impli": [23, 145, 304, 408], "implicit": 373, "implicitli": [105, 109, 400], "import": [0, 1, 3, 4, 5, 6, 8, 9, 10, 16, 18, 20, 21, 22, 24, 25, 27, 28, 29, 31, 32, 33, 49, 53, 70, 84, 85, 96, 97, 105, 106, 107, 108, 109, 110, 111, 112, 113, 114, 115, 116, 117, 118, 119, 120, 121, 122, 123, 125, 126, 127, 149, 151, 153, 171, 172, 174, 175, 184, 185, 187, 188, 189, 191, 193, 194, 195, 196, 197, 198, 199, 200, 201, 202, 203, 204, 205, 206, 208, 210, 211, 212, 213, 214, 215, 216, 217, 219, 221, 222, 224, 225, 226, 228, 229, 230, 231, 232, 233, 234, 235, 236, 237, 238, 239, 240, 241, 242, 244, 245, 247, 248, 249, 251, 254, 255, 257, 258, 259, 260, 261, 262, 263, 264, 265, 266, 267, 268, 269, 270, 271, 272, 273, 274, 275, 276, 278, 283, 286, 287, 289, 295, 296, 297, 298, 300, 301, 304, 305, 318, 319, 321, 336, 338, 339, 340, 341, 345, 346, 347, 348, 349, 351, 352, 355, 356, 357, 358, 359, 360, 362, 363, 364, 365, 366, 368, 369, 370, 371, 372, 373, 374, 375, 376, 379, 380, 381, 382, 384, 386, 387, 388, 389, 390, 391, 392, 394, 395, 401, 402, 403, 405, 406, 407, 408, 409, 411, 412, 413, 414, 415, 416, 417, 418, 421, 422, 423, 424, 425, 426, 427, 429, 430, 432, 433, 435, 436, 437, 438, 439, 440, 441, 442, 443, 445, 446, 447, 448, 449, 450, 452, 453, 454, 455, 456, 457, 458, 459, 460, 461, 462, 463, 465, 466, 467, 468, 469, 470, 471, 472, 473, 475, 477, 478, 479, 480, 481, 482, 483, 484, 485, 490, 500, 506, 508, 511, 513], "import_modul": 123, "impos": [53, 84, 85], "improv": [28, 116, 118, 184, 215, 221, 293, 412, 431], "impur": 75, "imput": [256, 268], "inaccuraci": 331, "incid": 304, "includ": [1, 20, 23, 28, 30, 34, 42, 43, 53, 70, 72, 81, 84, 85, 89, 90, 108, 109, 110, 111, 112, 115, 116, 117, 118, 120, 121, 148, 157, 159, 162, 173, 176, 180, 182, 186, 187, 188, 189, 190, 193, 194, 195, 197, 211, 212, 215, 218, 220, 221, 223, 224, 225, 226, 227, 228, 235, 243, 245, 246, 247, 248, 259, 276, 277, 284, 286, 290, 293, 295, 296, 297, 299, 300, 301, 305, 320, 321, 322, 323, 324, 326, 331, 332, 340, 348, 353, 383, 390, 391, 396, 398, 400, 401, 403, 408, 415, 416, 421, 425, 433, 435, 436, 440, 442, 443, 445, 447, 448, 449, 451, 456, 457, 458, 459, 462, 463, 465, 467, 468, 469, 476, 485, 506, 507, 508, 509, 511, 512], "include_collapsed_metadata": 348, "include_end": 445, "include_ful": 463, "include_root": 421, "include_self": [401, 409, 433, 440, 443, 447, 448, 449, 462, 465, 468, 469, 511], "include_stem": 468, "include_tip": [408, 415, 463, 485], "inclus": [145, 149, 151, 152, 230, 234, 297], "incom": [402, 405, 435], "incomplet": [43, 184, 195, 215, 221, 228], "inconsist": 249, "incorpor": [1, 70, 255], "incorrect": 1, "incorrectli": 357, "increas": [264, 276, 277, 301, 302, 304, 318, 336, 339, 348, 395], "increment": [404, 482, 483, 485], "incub": 339, "ind": [336, 340], "inde": 304, "independ": [74, 189, 194, 226, 304, 307, 311, 373, 407, 412, 415, 469], "index": [0, 1, 5, 6, 9, 11, 20, 21, 24, 25, 29, 31, 32, 33, 35, 36, 37, 38, 39, 40, 41, 45, 46, 49, 51, 55, 57, 58, 59, 60, 63, 64, 66, 71, 72, 74, 75, 76, 77, 80, 81, 82, 91, 100, 108, 109, 111, 118, 119, 121, 166, 169, 170, 174, 175, 176, 183, 228, 257, 258, 259, 264, 276, 277, 287, 295, 296, 297, 298, 299, 300, 305, 310, 317, 320, 321, 338, 342, 346, 348, 358, 374, 375, 378, 391, 392, 434, 435, 446, 466, 479, 488], "indexerror": [342, 364, 446], "indic": [1, 3, 6, 10, 13, 20, 44, 47, 48, 65, 70, 90, 104, 111, 112, 120, 123, 149, 151, 161, 162, 172, 175, 176, 185, 191, 196, 198, 200, 201, 202, 203, 204, 205, 206, 216, 217, 219, 222, 228, 232, 235, 240, 242, 244, 245, 247, 259, 264, 274, 296, 298, 299, 300, 304, 318, 320, 321, 331, 338, 358, 392, 426, 428, 453, 454, 471, 487, 493, 497, 503, 504, 511, 513], "indicatd": 513, "indirectli": 457, "indiscern": 291, "individu": [1, 3, 43, 44, 45, 46, 49, 52, 53, 54, 56, 60, 63, 64, 65, 66, 67, 71, 73, 75, 77, 80, 84, 85, 104, 109, 111, 176, 247, 259, 331, 338, 342, 413, 431, 513], "indptr": [358, 392], "ineffici": 342, "inekmtlva": 109, "inequ": [20, 149, 151, 162, 176, 191, 228, 291, 331, 482, 485], "inf": [10, 54, 120, 460], "infeas": 111, "infect": 340, "infer": [30, 93, 113, 120, 136, 141, 157, 181, 186, 218, 223, 243, 284, 322, 383, 451, 483, 485, 495, 506], "infern": 121, "infin": [58, 72, 81, 120], "infinit": [49, 460], "infinitum": 116, "influenc": 58, "info": [19, 41, 151, 160, 305, 314], "inform": [19, 23, 30, 34, 46, 63, 70, 72, 74, 93, 94, 106, 107, 108, 110, 111, 112, 113, 119, 120, 122, 149, 157, 159, 186, 190, 218, 220, 223, 227, 243, 246, 284, 290, 307, 314, 319, 322, 324, 333, 339, 340, 342, 348, 383, 398, 399, 408, 451, 463, 476, 501, 506, 507, 508, 513], "infti": [58, 72, 81], "ingroup": 458, "inher": [256, 304], "inherit": [3, 11, 14, 19, 20, 91, 95, 96, 97, 98, 99, 122, 124, 128, 148, 149, 151, 160, 162, 171, 173, 174, 176, 184, 191, 195, 209, 215, 221, 228, 247, 277, 291, 306, 307, 309, 310, 312, 314, 316, 317, 320, 342, 349, 400, 486, 491, 492, 501, 503, 504], "inidic": [12, 19], "initi": [67, 111, 339, 401, 440, 443, 445, 447, 448, 449, 465, 469, 480, 481, 502], "initialize_st": 513, "inlin": 120, "inner": [29, 116, 182, 229, 249], "inosin": 184, "inplac": [331, 356, 379, 380, 382, 385, 395, 397, 456, 457, 458, 459, 480, 481], "input": [35, 36, 37, 38, 39, 40, 41, 53, 70, 82, 84, 85, 86, 111, 122, 125, 127, 145, 146, 151, 153, 193, 194, 231, 244, 253, 259, 264, 274, 277, 297, 298, 318, 321, 325, 326, 328, 331, 332, 341, 357, 423, 470, 477, 478, 479, 480, 481, 482, 483, 484, 485, 505, 508], "input_is_dens": 359, "insdc": [110, 113, 149, 162, 176, 181], "insensit": [120, 248, 259, 264], "insert": [116, 152, 406, 456, 458], "insert_length": 406, "insid": [113, 116], "insight": [84, 85], "insignific": 1, "inspir": 506, "instanc": [30, 34, 61, 62, 93, 94, 109, 123, 127, 131, 133, 134, 135, 136, 141, 151, 156, 157, 159, 186, 190, 218, 220, 223, 227, 229, 243, 246, 248, 254, 255, 264, 277, 284, 290, 291, 294, 296, 298, 299, 300, 301, 302, 304, 311, 318, 321, 322, 324, 331, 338, 339, 340, 341, 345, 349, 375, 383, 398, 400, 412, 439, 451, 460, 468, 476, 479, 491, 492, 496, 506, 511, 513], "instanti": [19, 110, 123, 195, 209, 513], "instead": [1, 20, 27, 72, 110, 111, 113, 120, 123, 124, 125, 126, 127, 154, 162, 166, 233, 235, 237, 239, 241, 245, 277, 296, 298, 300, 302, 330, 339, 340, 390, 391, 400, 408, 410, 412, 413, 415, 416, 417, 420, 421, 422, 431, 441, 456, 457, 460, 463, 468, 473, 474, 482, 483, 484, 485, 506], "institut": 112, "instruct": 510, "instrument": 111, "int": [3, 4, 5, 6, 9, 10, 11, 14, 16, 19, 20, 27, 32, 35, 36, 37, 38, 39, 40, 42, 44, 45, 46, 47, 48, 49, 50, 51, 52, 53, 54, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 71, 72, 73, 74, 75, 76, 77, 78, 79, 80, 81, 82, 86, 87, 90, 106, 113, 114, 119, 126, 145, 149, 151, 152, 156, 176, 185, 191, 192, 200, 212, 216, 222, 225, 226, 228, 230, 232, 234, 235, 236, 237, 239, 241, 244, 251, 255, 257, 258, 264, 269, 275, 282, 294, 296, 298, 299, 300, 301, 302, 304, 310, 317, 318, 321, 326, 330, 331, 333, 334, 337, 338, 339, 340, 341, 348, 358, 364, 366, 388, 392, 400, 406, 412, 418, 427, 434, 435, 444, 446, 456, 458, 460, 472, 479, 482, 489, 490, 496, 500, 503], "int32": [358, 392], "int64": [20, 22, 29, 174, 197, 210, 214, 228, 358, 392, 508], "integ": [1, 19, 82, 86, 104, 106, 109, 111, 112, 115, 116, 117, 118, 119, 176, 228, 259, 264, 276, 277, 296, 299, 300, 301, 302, 317, 331, 336, 341, 404, 412, 460, 482, 483, 485, 496], "intend": [1, 61, 62, 120, 184, 195, 215, 318, 321, 488, 489], "intens": 339, "interablemetadata": 153, "interact": [304, 510], "interchang": [477, 478, 480, 481], "interconnect": 400, "interest": [1, 120, 228, 259, 276, 304, 325, 333, 339, 439, 458, 513], "interfac": [20, 83, 120, 171, 172, 174, 175, 247, 296, 297, 298, 299, 409, 479, 506], "interface_class": 497, "interleav": [118, 121], "intermedi": 406, "intern": [32, 105, 113, 116, 274, 400, 403, 405, 413, 419, 424, 425, 434, 436, 439, 444, 448, 450, 453, 454, 459, 462, 463, 467, 468, 469, 470, 471, 472, 506, 511], "internet": [111, 122], "interpret": [1, 23, 49, 53, 73, 75, 82, 84, 85, 86, 104, 116, 120, 162, 176, 256, 325, 326, 333, 359, 480], "interpro": 110, "interquantil": 60, "interrog": 501, "intersect": [229, 373, 417], "interspecif": [51, 75], "interv": [43, 48, 52, 61, 110, 113, 114, 151, 152, 153, 154, 155, 156, 158, 160, 161, 184, 187, 210, 215, 221, 228, 264, 337], "interval_metadata": [113, 114, 149, 151, 153, 156, 160, 161, 184, 195, 215, 221, 228], "intervalmetadata": [114, 149, 150, 160, 184, 215, 221, 228], "intracellular": 121, "introduc": [44, 55, 108, 111, 256, 496], "introduct": 496, "intron": [221, 238], "intvl": 151, "inv_simpson": [51, 58, 72], "invalid": [1, 27, 29, 53, 70, 82, 84, 85, 86, 111, 181, 184, 215, 221, 297, 298, 321, 342, 399, 409], "invalidate_cach": 410, "invent": 112, "invers": [23, 49, 51, 58, 59, 72, 258, 263, 266, 271], "inverse_shannon_uncertainti": 23, "invert": [235, 356], "investig": 1, "invok": 409, "involv": [43, 70, 257], "inward": 60, "io": [1, 11, 30, 34, 84, 85, 93, 94, 157, 159, 186, 190, 218, 220, 223, 227, 243, 246, 276, 284, 290, 321, 322, 324, 357, 360, 383, 398, 400, 429, 451, 476, 500, 505, 511], "io_registri": [123, 125, 127], "ionom": 273, "ioregistri": [123, 506], "ipr001360": 110, "ipr013781": 110, "ipr017853": 110, "ipr033132": 110, "ipyparallel": 87, "ipython": 320, "irrelev": [35, 36, 37, 415], "irsairagsnvkgfyawsfldcnewfagftvrfglnfvd": 110, "is_ascii": 247, "is_bifurc": 406, "is_binary_format": 124, "is_circular": 114, "is_reverse_compl": 214, "is_root": [432, 438, 511], "is_tip": [409, 432, 437, 511], "is_zero_bas": 13, "ism": [53, 84, 85], "isn": [20, 21, 24, 29, 55, 120, 121, 146, 149, 265, 266, 375], "isnapshgnakpsystnpmtnisfekhgiplgpraasiwiyvypymfiqedf": 110, "iso": [358, 392], "isoleucin": 215, "isometr": [256, 257, 258, 265, 266], "isometri": [262, 263, 265, 266], "isomorph": [116, 262, 263, 265, 266], "issu": [110, 111, 112, 120, 126, 480, 506], "isubsampl": 341, "item": [35, 36, 37, 38, 39, 40, 41, 121, 228, 233, 244, 278, 289, 318, 341, 352, 388, 466, 467, 501, 502, 513], "iter": [20, 24, 28, 35, 36, 37, 38, 39, 40, 41, 42, 82, 86, 87, 90, 100, 101, 102, 103, 109, 119, 149, 152, 153, 154, 156, 164, 178, 228, 229, 232, 235, 244, 245, 247, 251, 259, 278, 280, 281, 289, 293, 297, 300, 301, 318, 321, 339, 340, 342, 348, 349, 356, 357, 358, 369, 370, 373, 381, 387, 395, 400, 408, 409, 417, 420, 423, 430, 435, 439, 443, 456, 457, 458, 459, 460, 463, 465, 468, 494, 500, 501, 504, 511, 513], "iter_": [370, 501], "iter_km": 233, "its": [1, 6, 20, 21, 22, 24, 25, 28, 29, 35, 36, 37, 58, 110, 111, 112, 113, 116, 117, 121, 123, 127, 145, 149, 151, 161, 172, 175, 176, 182, 184, 209, 221, 228, 233, 237, 248, 260, 277, 297, 320, 325, 327, 330, 331, 335, 356, 400, 402, 407, 408, 409, 417, 433, 435, 449, 452, 453, 454, 456, 457, 458, 462, 463, 464, 467, 469, 472, 479, 480, 482, 483, 484, 485, 487, 495, 498, 499, 506, 511], "itself": [95, 96, 97, 98, 99, 111, 118, 122, 137, 146, 149, 184, 191, 215, 221, 228, 247, 304, 320, 356, 380, 395, 400, 408, 409, 412, 461, 463, 482, 485, 508], "itypeerror": 86, "iupac": [111, 112, 118, 119, 184, 191, 193, 212, 215, 221, 228, 508], "iv": [60, 70], "j": [35, 37, 38, 40, 43, 51, 53, 56, 57, 67, 70, 71, 84, 85, 104, 106, 107, 111, 112, 113, 121, 122, 215, 248, 256, 264, 265, 266, 267, 268, 269, 273, 275, 278, 289, 298, 299, 300, 326, 331, 370, 412, 415, 416, 422, 450, 457, 459, 468, 472, 477, 478, 479, 481, 482], "j00123": 113, "j04373": 121, "jag": 375, "jaim": 405, "januari": 72, "je": 304, "jet": 1, "jim": 112, "jj": [269, 275], "joe": 118, "join": [28, 106, 107, 112, 119, 121, 122, 182, 229, 349, 416, 445, 467, 477, 478, 479, 480], "joint": 113, "joseph": [111, 118, 511], "jost": [58, 70, 74], "journal": [19, 41, 44, 47, 54, 70, 71, 74, 77, 81, 113, 269, 275, 296, 331, 413], "json": [342, 359, 393, 399], "json_obj": 359, "json_tabl": 359, "juli": [19, 41], "june": 116, "jupyt": 321, "just": [60, 61, 62, 67, 123, 342, 353, 370, 373, 394, 459, 472, 491, 506, 511, 513], "justif": 60, "jyzox": 112, "k": [19, 43, 44, 49, 56, 59, 70, 71, 72, 74, 75, 76, 77, 81, 87, 184, 215, 221, 233, 236, 237, 247, 248, 255, 273, 297, 304, 413, 415, 436, 450, 460, 466, 468, 472, 479, 483], "k_": 336, "k__a": 348, "ka": 112, "kan": 122, "kannan": 122, "kansa": 484, "karsch": 122, "keemei": 120, "keep": [109, 113, 120, 154, 228, 318, 346, 347, 356, 368, 373, 459, 473], "keep_spac": 111, "kegg_pathwai": [358, 375, 392], "kei": [11, 20, 21, 24, 25, 31, 42, 110, 111, 113, 121, 152, 156, 172, 184, 199, 215, 221, 228, 238, 244, 281, 293, 348, 352, 375, 397, 408, 444, 463, 466, 479, 513], "kellei": [84, 85], "kempton": 60, "kendalltau": 298, "kept": [79, 113, 259, 268, 410, 412, 414, 416, 421, 439, 441, 453, 454, 460, 468, 480], "kestrel": 121, "keto": 184, "keyerror": [300, 375], "keyword": [41, 110, 113, 115, 126, 136, 138, 139, 141, 142, 143, 156, 188, 189, 225, 226, 238], "kf": 415, "khovanskaya": 122, "kill": 270, "kind": 325, "kinet": 67, "kingdom": [106, 107, 122], "kit": 505, "kj": 53, "klein": 113, "kmer": [236, 237, 255], "kmer_frequ": 233, "knight": [51, 53, 84, 85, 321], "know": [1, 19, 53, 84, 85, 108, 111, 118, 121, 123, 259, 336, 506], "knowledg": [456, 506], "known": [44, 75, 116, 136, 141, 273, 274, 326, 331, 422, 447, 449, 484, 508], "kortlev": 121, "kqlaaargqr": 109, "kr": 296, "kruskal": [259, 339, 340], "kuhner": 415, "kuo": 44, "kva": [189, 194, 226], "kw": 110, "kwarg": [30, 34, 41, 82, 86, 87, 90, 91, 93, 94, 95, 96, 97, 98, 99, 125, 127, 130, 136, 138, 139, 140, 141, 142, 143, 146, 147, 157, 159, 186, 188, 189, 190, 218, 220, 223, 225, 226, 227, 243, 246, 247, 284, 290, 317, 322, 324, 342, 360, 383, 398, 451, 476, 501, 506], "kwarg1": 123, "kz": 112, "l": [19, 45, 46, 53, 58, 60, 61, 70, 74, 80, 110, 112, 122, 193, 215, 273, 298, 319, 325, 326, 332, 333, 413, 415, 467, 468, 483, 485], "l1": 20, "l2": 20, "l3": 20, "l_1": 415, "l_2": 415, "lab": [321, 339], "label": [20, 21, 24, 25, 29, 31, 32, 33, 108, 111, 113, 118, 120, 121, 273, 276, 283, 296, 297, 299, 300, 301, 320, 321, 381, 405, 415, 485, 489], "labor": 339, "lafond": 273, "lahaeavhvyktkyqayqkgkigitlvsnwlmplddnsipdikaaersldfq": 110, "lambda": [110, 318, 336, 339, 340, 348, 356, 360, 381, 384, 386, 395, 409, 426, 453, 454, 471, 479, 513], "lane": 119, "lane_numb": 119, "langl": [265, 267], "languag": [2, 96, 109], "lapoint": [273, 412, 482], "larg": [19, 54, 60, 84, 85, 104, 111, 118, 268, 297, 300, 331, 333, 339, 358, 403, 412, 459, 482, 506], "larger": [23, 58, 339, 413, 506], "largest": [19, 80, 331, 369, 382], "last": [22, 96, 110, 118, 193, 228, 235, 298, 319, 513], "latent": [96, 98, 102, 103, 331], "later": [112, 338], "latter": [1, 43, 247, 420, 425, 482, 483, 485], "law": 52, "layout": 113, "lb": 112, "lca": [53, 70, 405, 416, 458, 468], "ldot": [257, 258, 262, 263, 265, 266, 270, 271, 272], "lead": [53, 82, 84, 85, 86, 111, 112, 115], "leaf": [400, 477, 478, 481], "learn": [342, 399], "least": [67, 116, 120, 161, 172, 175, 176, 185, 200, 216, 222, 259, 298, 321, 339, 340, 432, 478, 513], "leav": [60, 110, 207, 356, 379, 453, 454], "lee": [19, 41, 44], "leesleyqqf": 109, "left": [20, 29, 44, 74, 116, 182, 257, 258, 262, 267, 270, 271, 272, 273, 405, 434, 447, 449, 488, 489, 511], "left_child_id": 466, "leftmost": 122, "legaci": [106, 107, 111, 496], "legal": 145, "legend": 321, "legendr": [298, 319, 325, 326, 328, 329, 332, 333], "len": [19, 20, 228, 248, 302, 340, 417, 445, 479, 513], "length": [0, 1, 3, 4, 5, 6, 9, 10, 14, 18, 19, 20, 21, 22, 24, 28, 35, 36, 37, 53, 70, 84, 85, 96, 97, 100, 101, 102, 103, 104, 106, 107, 109, 110, 111, 112, 113, 114, 115, 118, 119, 121, 151, 153, 174, 184, 187, 188, 189, 191, 193, 194, 195, 197, 199, 207, 210, 211, 212, 214, 215, 221, 224, 225, 226, 228, 229, 230, 233, 235, 236, 237, 239, 240, 241, 242, 245, 254, 255, 259, 264, 281, 293, 296, 299, 300, 304, 330, 331, 339, 340, 358, 392, 400, 406, 408, 409, 412, 415, 416, 421, 422, 433, 435, 441, 450, 456, 457, 458, 463, 466, 468, 470, 471, 472, 473, 475, 477, 478, 480, 481, 482, 485, 508, 511, 513], "lengtherror": 457, "leq": 256, "less": [19, 44, 53, 62, 84, 85, 87, 118, 120, 236, 237, 255, 298, 301, 318, 325, 333, 341, 348, 388, 407, 444, 482, 483, 485, 490], "lesser": 70, "let": [1, 20, 111, 112, 114, 118, 119, 121, 149, 151, 228, 244, 259, 298, 318, 335, 336, 339, 340, 369, 506, 508, 511, 513], "letter": [51, 53, 111, 113, 215], "leu": 215, "leucin": 215, "level": [32, 61, 116, 145, 176, 259, 338, 339, 429, 440, 492, 497, 508], "levelord": [447, 448, 449, 469], "leven": 300, "lewi": 70, "lexicograph": 407, "lexicon": [111, 112, 118], "lfc_result": 264, "li": 70, "librari": [19, 41, 84, 85, 111, 505, 506], "libreria": 55, "licens": 505, "life": 53, "like": [1, 20, 35, 36, 37, 87, 111, 113, 114, 115, 117, 120, 123, 238, 247, 276, 302, 304, 308, 310, 313, 314, 315, 317, 333, 339, 340, 353, 357, 360, 364, 393, 394, 409, 491, 500, 506, 513], "likelihood": 247, "likelyhood": [330, 334], "likewis": [29, 70, 121], "limit": [1, 20, 52, 106, 116, 117, 118, 338, 339, 480], "limits_": [262, 263, 266, 267, 273], "linalg": 335, "linamaras": 110, "line": [55, 108, 110, 111, 112, 113, 114, 115, 117, 118, 119, 120, 121, 122, 145, 339, 357, 360, 403, 493, 506], "lineag": [122, 339, 430, 462, 467, 468], "lineage_map": 430, "linear": [55, 110, 113, 320, 326], "link": [86, 150, 176, 297, 304, 400], "linkag": [340, 428, 484], "linkage_matrix": 428, "linnean": 70, "linux": 364, "lipman": [106, 107, 111], "list": [1, 18, 41, 53, 70, 84, 85, 88, 89, 100, 106, 110, 111, 112, 113, 114, 117, 120, 121, 122, 123, 134, 135, 145, 149, 151, 191, 228, 244, 250, 274, 276, 277, 280, 298, 300, 301, 307, 310, 312, 316, 320, 336, 338, 339, 340, 348, 352, 356, 357, 358, 360, 369, 375, 381, 386, 387, 392, 400, 401, 409, 416, 423, 425, 428, 439, 442, 445, 460, 461, 466, 467, 479, 480, 482, 483, 484, 485, 498, 506, 513], "liter": 116, "literatur": [1, 49, 74, 340], "live": [1, 155], "lkwh": [189, 194, 226], "ll": [1, 53, 84, 85, 111, 297, 298, 301, 319, 336, 339, 340, 511, 513], "lladser": [61, 62, 84, 85], "lladser_ci": 62, "lladser_p": 61, "ln": [46, 54, 60, 63, 257, 259, 262, 267, 273], "load": [0, 109, 111, 112, 117, 119, 120, 176, 248, 259, 276, 277, 296, 297, 300, 301, 358, 495, 500, 506], "loc": [20, 228, 259, 339], "local": [0, 38, 39, 40, 106, 107, 113], "local_pairwise_align": [35, 36, 37, 39, 40], "local_pairwise_align_nucleotid": [35, 36, 37, 38, 40], "local_pairwise_align_protein": [0, 35, 36, 37, 38, 39], "local_pairwise_align_ssw": [0, 35, 36, 37, 38, 39, 40], "locat": [19, 30, 34, 93, 94, 110, 116, 121, 131, 132, 133, 149, 157, 159, 185, 186, 190, 200, 216, 218, 220, 222, 223, 227, 232, 243, 246, 284, 290, 322, 324, 377, 383, 398, 424, 425, 451, 456, 458, 476, 488, 512], "loci": 19, "locu": [110, 113, 122], "log": [63, 71, 72, 257, 258, 259, 262, 263, 264, 265, 266, 269, 275], "log2": 264, "log_b": [72, 74], "logarithm": [71, 72, 74, 256, 259], "logic": [3, 123, 501], "logratio": 256, "long": [108, 111, 118, 120, 185, 200, 216, 222, 257, 297, 317, 325], "long_method_nam": [320, 489], "longer": [20, 111, 118, 256, 340, 453, 454], "look": [20, 42, 115, 117, 118, 123, 156, 225, 226, 244, 259, 277, 321, 338, 339, 340, 353, 409, 504, 511, 513], "lookup": [35, 36, 37, 38, 39, 40, 131, 132, 133, 277, 298, 301, 407, 408, 409, 410, 419, 424, 425, 431, 434, 462, 463, 466, 501], "lookup_id": [277, 282], "loop": 111, "loos": [1, 304], "lorenz": 55, "lose": [331, 480], "loss": [53, 304], "lost": [20, 331], "lot": 325, "love": [342, 399], "lovel": [269, 275], "low": [62, 319, 331, 339, 388, 430], "lower": [43, 60, 61, 111, 118, 149, 151, 176, 259, 264, 293, 295, 298, 318, 319, 340], "lower_bound": [48, 52, 61, 151], "lower_quantil": 60, "lowercas": [19, 110, 111, 112, 113, 119, 184, 195, 215, 221, 228, 229], "lowest": [53, 70, 416, 439, 458, 468, 478], "lowest_common_ancestor": 439, "lozupon": [53, 84, 85], "lq": 60, "lrn": 447, "lsmat": [277, 284, 290], "luca": 405, "ly": 215, "lysin": 215, "m": [18, 19, 38, 44, 51, 53, 58, 70, 84, 85, 106, 107, 110, 112, 118, 122, 184, 191, 193, 215, 221, 248, 264, 297, 300, 304, 321, 325, 326, 331, 332, 333, 335, 338, 358, 364, 392, 412, 415, 416, 422, 480], "m24803": 121, "m24804": 121, "m_shape": 335, "ma": [6, 10, 44, 245], "machin": 119, "machine_nam": 119, "macklaim": 264, "macrophag": 339, "madden": 111, "made": [20, 67, 160, 171, 174, 228, 259, 277, 291, 318, 348, 424, 425, 450], "magnitud": [67, 264, 298, 300, 331], "magnoliophyta": 110, "magnuson": 70, "magurran": [60, 66], "mai": [1, 11, 19, 20, 23, 31, 49, 53, 62, 74, 107, 110, 111, 112, 113, 115, 116, 118, 120, 121, 122, 123, 126, 134, 135, 145, 149, 155, 176, 180, 181, 184, 195, 215, 221, 228, 233, 247, 254, 259, 276, 277, 280, 296, 298, 300, 304, 318, 325, 331, 336, 338, 339, 340, 341, 348, 400, 407, 408, 409, 410, 415, 416, 419, 429, 431, 439, 442, 472, 480, 495, 496, 499, 501, 506, 508], "main": 162, "mainli": [305, 319], "maintain": [111, 116, 123, 294, 325, 326, 336, 339], "major": [22, 43, 74, 184, 195, 215, 221, 256, 295, 358, 392, 479], "make": [20, 23, 29, 58, 111, 116, 120, 123, 176, 191, 254, 277, 296, 300, 340, 407, 408, 463, 464, 466, 467, 487, 492, 496, 501, 513], "mam": 122, "manag": [145, 146, 147, 506], "mandal": 259, "manhattan": [412, 415], "mani": [1, 20, 44, 69, 89, 116, 120, 247, 256, 259, 304, 325, 331, 339, 340, 348, 400, 506, 513], "manipul": [0, 120, 171, 172, 174, 175, 176, 228, 256, 276, 358, 400, 409, 431, 472, 475, 480, 481], "mann": 259, "manner": [22, 111, 118, 197, 228, 298], "mannwhitneyu": 259, "mantel": [1, 276, 301, 304], "manual": [44, 48, 60, 120, 479], "map": [1, 25, 31, 87, 124, 128, 176, 181, 184, 195, 209, 215, 221, 286, 298, 301, 304, 305, 310, 317, 321, 323, 338, 340, 348, 381, 397, 408, 430, 434, 463, 508], "map_async": 87, "map_f": 87, "map_to_length": [408, 463], "mapper": [286, 323], "mappingproxytyp": 176, "mar": [35, 38, 57], "marchand": 273, "margalef": 66, "marguerat": [269, 275], "margush": 479, "marin": 297, "mark": [110, 113, 121, 493, 513], "marrow": 339, "marth": [19, 41], "marti": [299, 300], "martin": [256, 268], "martinsson": 331, "mask": [6, 10, 19, 245, 269, 275], "mask_auto": 19, "mask_gap": 245, "mask_length": 19, "maskedarrai": [6, 10], "mat": [247, 248, 249, 251, 257, 258, 260, 261, 262, 263, 265, 266, 268, 269, 416], "match": [0, 18, 19, 20, 21, 24, 29, 36, 39, 42, 106, 111, 112, 120, 145, 146, 165, 169, 170, 176, 180, 182, 183, 185, 193, 200, 208, 216, 222, 228, 232, 239, 241, 242, 251, 277, 296, 298, 300, 301, 336, 338, 339, 340, 412, 413, 415, 416, 425, 427, 485, 508, 513], "match_frequ": [241, 508], "match_scor": [19, 36, 39, 42], "matevz": 273, "math": 73, "mathbb": [257, 258, 259, 262, 263, 265, 266], "mathemat": [49, 72, 74, 84, 256, 319, 405, 413, 415, 479, 483, 485], "mathemt": 85, "matplotlib": [283, 320, 321], "matric": [1, 37, 40, 104, 115, 215, 247, 248, 250, 276, 277, 297, 298, 301, 303, 304, 327, 331, 333, 412, 457], "matrix": [1, 19, 42, 82, 86, 87, 90, 91, 101, 245, 247, 248, 249, 251, 252, 257, 258, 259, 260, 261, 262, 263, 265, 266, 267, 268, 269, 270, 271, 272, 273, 274, 277, 278, 279, 280, 281, 282, 283, 286, 288, 289, 291, 293, 294, 295, 296, 297, 298, 299, 300, 301, 302, 304, 319, 321, 323, 325, 327, 328, 329, 331, 332, 333, 335, 337, 342, 348, 358, 359, 362, 377, 384, 388, 390, 391, 392, 399, 412, 416, 428, 477, 478, 480, 481, 482, 483, 484, 485, 510], "matrix_data": [342, 399], "matrix_element_typ": 359, "matrix_rank": 335, "matsen": 70, "matter": [120, 149, 153, 277], "matthew": 479, "matto": 273, "max": [19, 44, 45, 58, 67, 72, 339, 340, 369], "max_count": [336, 339, 340], "max_i": 80, "max_sample_count": 369, "max_width": 111, "maxdist": 422, "maxim": [19, 70, 297, 326], "maxima": 372, "maximum": [71, 80, 111, 112, 259, 264, 297, 310, 318, 326, 330, 334, 339, 340, 372, 412, 415, 433, 441], "mccoi": 70, "mcdonald": [342, 399], "mcentyr": 111, "mci": 508, "mcintosh": [64, 65], "mcintosh_": 64, "mcintosh_d": 65, "mcmorri": 479, "mcmurrough": 264, "md": [111, 344, 352, 356, 381, 395], "md5": [110, 500], "md_i": 370, "md_j": 370, "mdfivaifalfvissftitstnaveastlldignlsr": 110, "me": 481, "mean": [20, 114, 116, 123, 145, 149, 151, 156, 184, 211, 212, 256, 259, 262, 264, 273, 278, 289, 314, 317, 325, 329, 330, 331, 334, 336, 337, 339, 340, 358, 392, 409, 484, 506, 511], "meaning": [19, 21, 24, 29, 331, 508], "meaningless": 20, "meanwhil": 496, "measur": [1, 49, 51, 57, 58, 59, 60, 61, 62, 65, 66, 69, 70, 71, 72, 74, 75, 77, 84, 85, 247, 256, 259, 269, 275, 276, 325, 338, 339, 400, 405, 412, 413, 416, 441, 507], "mechan": [496, 501, 513], "media": 339, "median": [259, 300], "medic": 110, "medlin": 121, "meepqsdpsv": 245, "meet": [41, 120, 156, 180, 181, 426, 453, 454, 471], "member": [136, 141, 497, 499, 501, 504, 513], "membership": 123, "meme_v4": 108, "memo": [20, 151, 160, 171, 174, 228, 400, 473], "memori": [3, 55, 108, 109, 111, 112, 113, 118, 119, 121, 176, 276, 301, 318, 331, 342, 399, 480, 500, 506], "mengyao": [19, 41], "menhinick": 63, "menopaus": 340, "menten": 67, "mention": 116, "merg": 176, "merged_t": 373, "messag": [1, 53, 82, 84, 85, 86, 307, 314, 331, 490, 493, 506], "met": [1, 215, 504], "met_neg": 340, "met_po": 340, "meta": [120, 338, 339], "metabolit": [1, 340, 342, 399, 507], "metadata": [0, 1, 20, 21, 22, 24, 28, 29, 31, 32, 105, 108, 110, 111, 112, 113, 114, 118, 119, 184, 187, 188, 189, 191, 193, 194, 195, 197, 199, 210, 214, 215, 221, 224, 225, 226, 228, 229, 238, 244, 281, 293, 297, 305, 307, 310, 312, 314, 317, 321, 333, 336, 338, 339, 340, 342, 343, 344, 346, 347, 348, 352, 353, 356, 358, 359, 360, 363, 368, 373, 375, 381, 390, 391, 392, 394, 395, 396, 505, 508, 509], "metadata_f": 348, "metadata_field": [358, 392], "metadata_formatt": [353, 394], "metadata_i": 370, "metadata_j": 370, "metadata_map": [305, 306, 309, 310, 316, 317], "metadatacolumn": [148, 173, 176, 179], "metadatafileerror": 181, "metag": 345, "metagenom": 345, "metatdata": 110, "metdata": [228, 373], "methionin": [193, 215], "method": [0, 1, 3, 10, 11, 14, 19, 20, 23, 29, 30, 34, 35, 55, 82, 84, 86, 87, 90, 91, 93, 94, 95, 96, 97, 98, 99, 105, 109, 117, 120, 124, 128, 148, 149, 151, 152, 157, 159, 160, 162, 171, 173, 174, 176, 184, 186, 189, 190, 191, 192, 194, 195, 209, 214, 215, 218, 220, 221, 223, 226, 227, 228, 229, 233, 243, 246, 247, 256, 259, 264, 268, 273, 276, 277, 284, 290, 291, 294, 296, 297, 298, 299, 300, 301, 302, 306, 307, 308, 309, 310, 312, 313, 314, 315, 316, 317, 318, 320, 321, 322, 324, 325, 326, 331, 342, 382, 383, 392, 398, 400, 402, 403, 404, 405, 406, 407, 408, 409, 410, 412, 413, 415, 416, 417, 419, 422, 423, 424, 425, 426, 427, 431, 435, 436, 439, 441, 450, 451, 452, 453, 454, 457, 458, 459, 460, 462, 463, 464, 468, 469, 470, 472, 473, 474, 475, 476, 478, 479, 480, 484, 486, 487, 491, 492, 493, 498, 499, 500, 501, 502, 504, 508, 511, 513], "metodologica": 55, "metric": [23, 44, 49, 53, 54, 58, 70, 82, 83, 84, 85, 86, 87, 88, 89, 90, 101, 112, 231, 255, 281, 291, 293, 331, 411, 412, 414, 415, 416, 468, 482, 483, 485, 508], "metricspac": 291, "mgc": 122, "mi": 18, "micha": 67, "michael": 112, "michen": 484, "microbi": [53, 61, 62, 70, 84, 85, 259, 296, 297, 299, 300, 321], "microbiol": [84, 85], "microbiom": [1, 70, 87, 259, 264], "microsoft": 120, "mid": 457, "middl": [60, 155], "midpoint": [435, 456, 457, 458, 480], "mieadkvahvqvgnnleh": 121, "might": [1, 55, 115, 117, 297, 338, 339, 340, 506], "miller": [106, 107], "million": 87, "mimick": 506, "min": [70, 72, 77, 340], "min_count": [336, 339, 340], "min_group_s": 348, "min_length": [185, 200, 216, 222, 235, 508], "minim": [116, 481], "minima": 376, "minimize_scalar": 54, "minimum": [53, 70, 77, 122, 212, 235, 259, 300, 318, 339, 340, 348, 376, 477, 478, 480, 481], "mininum": 264, "minor": [107, 358, 392], "minter": [0, 20, 21, 24, 31, 32, 108, 118], "minu": [23, 81, 113, 121, 316], "mirror": 264, "misc_bind": 113, "mislead": [23, 90], "mismatch": [0, 18, 19, 36, 39, 42, 106, 107, 239, 240, 241, 251, 298], "mismatch_frequ": [239, 508], "mismatch_scor": [19, 36, 39, 42], "miss": [106, 111, 120, 121, 162, 163, 165, 166, 168, 169, 170, 176, 177, 181, 183, 229, 256, 268, 297, 321, 338, 339, 408, 416, 441, 463, 468, 513], "missing_as_zero": [421, 422, 433], "missing_schem": [148, 162, 173], "missingiderror": [277, 278, 280, 282, 289], "missingnodeerror": [53, 70, 82, 84, 85, 86, 416, 424, 425, 427, 439, 444, 460, 468], "mit": 108, "mitochondri": [122, 188, 192, 225], "mix": 120, "mixin": 209, "mizrachi": 122, "ml": 67, "mmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmm": 191, "mn": 66, "moac": 106, "mock": 111, "mock_fl": 111, "mode": [23, 123, 145, 193, 286, 323, 340, 348, 436, 456, 457, 458, 469, 501], "model": [2, 60, 61, 62, 67, 96, 109, 248, 256, 264, 276, 340, 400], "moder": 298, "modif": [151, 304], "modifi": [32, 111, 113, 121, 184, 215, 221, 228, 294, 317, 332, 356, 395, 406, 459, 460, 472], "modul": [0, 1, 2, 109, 121, 123, 144, 253, 256, 276, 305, 319, 336, 487, 495, 498, 499, 500, 506, 507, 508, 509, 510, 511, 513], "mol": [35, 38, 106, 107, 110, 113], "mol_typ": [110, 113], "molbev": 480, "molecul": [110, 111, 113, 228, 247, 508], "molecular": [38, 304, 405, 415, 480, 508], "moment": [110, 298, 513], "monkei": [477, 478, 481], "monophylet": 458, "monoton": [276, 277, 301, 302], "mont": 336, "month": 122, "mooer": 70, "more": [0, 1, 20, 22, 23, 24, 30, 34, 35, 41, 44, 49, 55, 58, 82, 89, 93, 94, 107, 110, 111, 112, 116, 117, 118, 119, 120, 121, 138, 142, 149, 157, 159, 168, 176, 182, 186, 190, 202, 203, 204, 205, 215, 217, 218, 220, 223, 227, 243, 246, 256, 259, 261, 264, 276, 277, 284, 290, 294, 296, 297, 298, 299, 300, 301, 304, 311, 318, 321, 322, 324, 325, 326, 333, 339, 340, 342, 348, 364, 383, 398, 399, 406, 407, 409, 429, 436, 441, 451, 459, 472, 476, 479, 506, 511, 512], "mosaic": 121, "most": [22, 43, 45, 54, 70, 104, 108, 111, 112, 115, 116, 118, 120, 122, 193, 228, 298, 318, 333, 336, 433, 434, 436, 441, 472, 479, 480, 511], "mostli": [120, 121], "motif": [185, 200, 216, 222, 508], "motif_slic": [185, 200, 216, 222], "motif_typ": [185, 200, 216, 222], "motiv": 87, "move": 402, "mpl": [188, 189, 191, 193, 194, 225, 226], "mpr": 457, "mpt": [188, 225], "mqhvsapvfvfectrlai": 121, "mrna": 110, "msa": [0, 3, 7, 8, 20, 21, 22, 24, 25, 26, 27, 28, 29, 31, 32, 33, 108, 111, 112, 118, 121], "msa1": 29, "msa2": 29, "msa_copi": 20, "msg": 493, "msl072": 480, "mtcraqliavprassla": 121, "mu": 336, "mu_": 336, "much": [0, 1, 53, 84, 85, 116, 506], "mullikin": 112, "multi": [20, 259, 506], "multi_replac": 259, "multifurc": [116, 436, 511], "multiindex": [20, 32, 295], "multimod": 325, "multinomi": [264, 388], "multipl": [0, 20, 28, 53, 58, 72, 84, 85, 108, 110, 111, 112, 113, 114, 116, 122, 149, 153, 228, 247, 256, 259, 264, 268, 304, 319, 333, 339, 348, 409, 433, 467, 468, 479, 496, 506, 511], "multiple_comparisons_correct": 259, "multipletest": [259, 264], "multipli": [70, 412], "multiplicative_replac": 268, "multivari": [257, 296, 297, 299, 300, 325, 326, 331, 505], "must": [6, 19, 20, 21, 24, 29, 30, 34, 53, 55, 70, 84, 85, 86, 87, 90, 93, 94, 101, 106, 108, 111, 112, 115, 116, 117, 118, 120, 121, 126, 156, 157, 159, 176, 180, 182, 184, 186, 188, 190, 215, 218, 220, 221, 223, 225, 227, 228, 229, 231, 238, 243, 246, 259, 264, 274, 277, 280, 284, 286, 290, 296, 297, 298, 299, 300, 302, 304, 308, 313, 315, 318, 321, 322, 323, 324, 325, 330, 339, 340, 341, 348, 356, 357, 364, 373, 381, 383, 393, 394, 395, 398, 412, 435, 451, 458, 460, 467, 472, 476, 479, 480, 482, 485, 487, 488, 490, 500, 501, 504, 513], "mutabl": [55, 228, 492, 508], "mutant": 113, "mutat": [247, 248, 400], "my": 508, "my_obj": 506, "myclass": 499, "myeloid": 339, "myer": [106, 107], "myformat": [123, 125, 126, 127], "myformat2": [125, 126, 127], "myformat_read": [125, 127], "myformat_sniff": 126, "myobject": [125, 127], "n": [1, 19, 45, 46, 49, 52, 54, 55, 56, 60, 63, 64, 65, 66, 67, 70, 73, 80, 104, 106, 107, 108, 111, 112, 113, 117, 118, 119, 121, 122, 123, 125, 126, 127, 145, 146, 184, 215, 216, 221, 235, 245, 264, 268, 276, 298, 301, 304, 318, 325, 326, 327, 330, 331, 332, 333, 334, 336, 340, 341, 358, 364, 388, 392, 409, 417, 426, 434, 441, 442, 460, 461, 467, 479, 480, 490, 508], "n1": 360, "n4": 360, "n_": [44, 45, 60], "n_column": 302, "n_compon": [257, 258, 260, 261, 262, 263, 265, 266, 267, 268, 269, 270, 271, 272, 275], "n_composit": [257, 258, 260, 261, 262, 263, 265, 266, 267, 268, 269, 270, 271, 272], "n_featur": [102, 273], "n_i": [46, 49, 64, 65], "n_ob": 390, "n_object": 102, "n_pack": 3, "n_partit": 273, "n_posit": [4, 6, 8, 10, 15], "n_row": 302, "n_segment": [3, 5, 9, 14], "n_seq": [4, 5, 6, 8, 9, 10, 15], "n_sequenc": [3, 4], "n_var": 390, "na": [120, 357], "naess": 273, "name": [1, 20, 30, 34, 53, 70, 79, 84, 85, 93, 94, 106, 107, 112, 113, 114, 116, 117, 119, 120, 121, 123, 124, 131, 132, 133, 137, 138, 142, 149, 157, 159, 162, 169, 170, 176, 179, 181, 182, 183, 186, 190, 191, 192, 218, 220, 223, 227, 238, 243, 246, 247, 248, 250, 259, 264, 268, 269, 274, 284, 290, 296, 297, 299, 300, 305, 307, 314, 320, 321, 322, 324, 348, 353, 383, 391, 394, 398, 400, 401, 402, 403, 405, 407, 408, 409, 410, 412, 414, 415, 416, 419, 421, 423, 424, 425, 426, 427, 429, 431, 433, 439, 440, 441, 442, 443, 444, 445, 447, 448, 449, 450, 451, 453, 454, 456, 457, 458, 459, 460, 461, 462, 465, 466, 467, 468, 469, 472, 473, 476, 479, 480, 482, 485, 487, 495, 497, 506, 511], "name_txt": 122, "named_gc": 191, "namedtemporaryfil": 145, "nan": [10, 23, 27, 29, 62, 106, 120, 162, 165, 166, 168, 169, 170, 176, 177, 183, 229, 233, 254, 255, 296, 297, 298, 299, 300, 301, 304, 321, 338, 339, 466, 488], "nan_length_valu": 466, "nanmean": 340, "naohisa": 112, "nar": 112, "nasanfta": 235, "nat": 113, "natal": 273, "nation": [111, 122, 248], "nativ": [1, 285, 331], "natl": [37, 40], "natsort": 386, "natur": [49, 59, 60, 75, 77, 176, 184, 209, 221, 386, 478, 506], "naturalist": 457, "navig": 400, "nb": 146, "nbk21097": 111, "nbk279675": 106, "nbk279682": 107, "nc": 146, "ncbi": [36, 37, 39, 40, 106, 107, 111, 113, 122, 188, 189, 191, 192, 193, 194, 225, 226, 429, 508], "ncbiinsight": 122, "ncifcrf": 23, "ncrna": 228, "nd": 357, "ndarrai": [8, 9, 10, 27, 86, 95, 96, 97, 98, 99, 102, 184, 196, 198, 201, 206, 213, 215, 219, 221, 228, 230, 231, 234, 239, 240, 241, 242, 245, 247, 257, 258, 260, 261, 262, 263, 265, 266, 267, 268, 270, 271, 272, 273, 277, 285, 292, 294, 304, 334, 341, 351, 390, 428, 434], "ndmin": 409, "ne2": 110, "nearbi": 19, "nearest": [477, 478, 480, 481], "nearli": [35, 36, 37], "necessari": [29, 106, 118, 151, 184, 195, 215, 221, 228, 256, 277, 296, 297, 298, 300, 308, 313, 315, 436, 495, 506], "necessarili": [21, 24, 29, 117, 228, 233, 341], "nee": 53, "need": [1, 20, 21, 24, 28, 53, 84, 85, 87, 104, 109, 114, 116, 123, 145, 151, 156, 195, 259, 264, 265, 266, 274, 296, 297, 299, 300, 301, 318, 319, 326, 333, 336, 339, 340, 358, 409, 473, 477, 478, 482, 483, 485, 488, 489, 501, 513], "needl": 35, "needleman": [0, 35, 36, 37], "neg": [1, 19, 36, 39, 42, 55, 120, 193, 261, 268, 291, 300, 325, 326, 331, 336, 340, 480, 482, 485, 496], "negat": 154, "neglig": 1, "nei": 480, "neighbor": [113, 461, 477, 478, 480, 481], "neighbour_join": 480, "neither": [20, 31, 146, 323, 384, 460, 469], "nellangiqpfvtlfhwdlpqvledeyggflnsgvindfrdytdlcfkefgd": 110, "nep": 496, "neq": 336, "nest": [116, 276, 298, 375, 390, 408, 463, 511], "never": [111, 121, 464], "new": [0, 21, 24, 30, 31, 32, 46, 57, 61, 62, 73, 84, 93, 122, 125, 126, 127, 130, 140, 151, 157, 160, 171, 174, 182, 184, 186, 195, 197, 215, 218, 221, 223, 228, 229, 243, 244, 277, 284, 286, 294, 298, 299, 301, 302, 322, 323, 326, 334, 356, 379, 380, 382, 383, 385, 387, 395, 396, 397, 412, 417, 420, 451, 456, 457, 458, 460, 473, 474, 475, 477, 478, 480, 481, 496, 508, 511, 513], "new_fasta_fh": 111, "new_fh": 112, "new_qual_fh": 111, "new_root": 475, "new_tabl": [356, 379, 386], "new_taxdump": 122, "new_tre": 473, "newcastl": 110, "newick": [53, 84, 85, 358, 363, 392, 400, 405, 451, 476, 480, 506, 511], "newick_doc": 116, "newicktre": 116, "newlin": [111, 116, 118, 123, 124, 136, 138, 141, 142, 145], "next": [1, 53, 61, 62, 84, 85, 110, 116, 123, 228, 259, 317, 325, 440, 460, 479, 511, 513], "nh": 121, "nhx": 121, "nich": 326, "nident": [106, 107], "nih": [36, 37, 39, 40, 106, 107, 111, 113, 119, 122, 191, 192], "nj": [416, 477, 484], "nlm": [36, 37, 39, 40, 106, 107, 111, 113, 122, 191, 192], "nlr": 449, "nni": 480, "nnz": [342, 358, 392, 399], "no_gap": 235, "node": [1, 53, 84, 85, 274, 400, 401, 402, 404, 405, 406, 407, 408, 409, 410, 413, 415, 416, 417, 418, 419, 421, 422, 423, 424, 425, 426, 427, 429, 431, 432, 433, 434, 435, 436, 437, 438, 439, 440, 441, 442, 443, 444, 445, 446, 447, 448, 449, 450, 452, 453, 454, 456, 457, 458, 459, 461, 462, 463, 465, 466, 467, 468, 469, 470, 471, 472, 473, 474, 475, 477, 478, 479, 480, 481, 506, 511], "node_1": 445, "node_2": 445, "node_c": 442, "node_count": 409, "node_id": [427, 434, 466], "node_info": 116, "nodes_new": 122, "nodes_slim": 122, "nolengtherror": [421, 422, 433], "nomenclatur": [184, 195, 215, 221, 228], "non": [20, 47, 55, 106, 108, 110, 114, 120, 149, 184, 195, 205, 206, 207, 215, 247, 256, 257, 258, 259, 261, 264, 268, 270, 271, 272, 291, 296, 299, 300, 304, 325, 331, 336, 342, 358, 373, 392, 395, 407, 413, 416, 443, 482, 485, 496, 508], "non_tip": [465, 469, 479, 511], "noncanon": 207, "noncanonical_char": [195, 215], "nonconcept": [51, 75], "nondegenerate_char": 195, "nondestruct": 497, "none": [4, 11, 16, 18, 19, 20, 21, 23, 24, 30, 31, 32, 34, 36, 37, 39, 40, 41, 53, 61, 62, 67, 70, 71, 72, 74, 82, 84, 85, 86, 87, 93, 94, 106, 111, 115, 123, 124, 125, 127, 131, 132, 133, 136, 138, 141, 142, 145, 149, 151, 152, 154, 156, 157, 159, 160, 162, 171, 174, 176, 177, 180, 181, 184, 185, 186, 190, 195, 200, 208, 215, 216, 218, 220, 221, 222, 223, 227, 228, 230, 231, 232, 233, 234, 243, 245, 246, 259, 264, 265, 266, 268, 269, 277, 281, 283, 284, 290, 291, 293, 294, 296, 297, 298, 299, 300, 301, 302, 304, 306, 309, 310, 316, 318, 320, 321, 322, 324, 327, 330, 331, 334, 335, 337, 338, 339, 340, 341, 342, 348, 352, 353, 358, 359, 360, 363, 368, 373, 374, 381, 383, 384, 388, 392, 393, 394, 395, 398, 399, 400, 405, 406, 408, 409, 412, 413, 415, 416, 419, 421, 429, 431, 435, 439, 442, 446, 451, 452, 456, 457, 458, 460, 463, 464, 466, 467, 468, 472, 473, 474, 475, 476, 479, 480, 482, 483, 485, 487, 491, 493, 496, 501, 504, 508, 511, 513], "nonlinear": 67, "nonmatch": [298, 301], "nonneg": 111, "nonparametr": [52, 256, 268], "nonscalar": 20, "nonzero": [105, 356, 361, 372, 376, 378, 379, 395, 399], "noparenterror": [421, 435], "noqa": 358, "nor": [20, 21, 24, 31, 115, 118, 277, 323, 384, 460], "norm": [306, 309, 316, 317, 348], "normal": [52, 85, 112, 113, 162, 176, 296, 331, 332, 333, 336, 337, 339, 340, 348, 379, 409], "not_non": [504, 513], "notabl": [112, 412, 415], "notat": [58, 116, 120, 215], "note": [3, 6, 7, 11, 18, 19, 20, 21, 22, 23, 24, 25, 27, 28, 29, 31, 32, 35, 36, 37, 38, 39, 40, 41, 43, 44, 45, 46, 47, 48, 49, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 71, 72, 73, 74, 75, 76, 77, 79, 80, 81, 84, 85, 87, 89, 105, 109, 110, 111, 112, 113, 114, 116, 118, 119, 120, 149, 151, 155, 160, 171, 174, 176, 180, 182, 184, 187, 188, 189, 191, 192, 193, 194, 195, 197, 199, 209, 211, 214, 215, 221, 224, 225, 226, 228, 229, 233, 235, 245, 247, 248, 254, 255, 259, 264, 265, 266, 268, 269, 273, 274, 275, 277, 278, 285, 288, 289, 291, 292, 294, 296, 297, 298, 299, 300, 301, 304, 318, 321, 325, 326, 331, 332, 333, 334, 339, 340, 341, 342, 348, 349, 357, 358, 364, 373, 375, 388, 390, 391, 392, 399, 400, 402, 403, 404, 405, 406, 407, 408, 409, 410, 411, 412, 413, 414, 415, 416, 417, 419, 420, 422, 423, 424, 425, 426, 427, 429, 431, 433, 435, 436, 437, 439, 440, 441, 443, 446, 447, 448, 449, 450, 452, 453, 454, 456, 457, 458, 459, 460, 462, 463, 465, 466, 467, 468, 469, 470, 472, 473, 474, 475, 477, 478, 479, 480, 481, 482, 483, 484, 485, 487, 488, 490, 493, 495, 496, 498, 499, 500, 508, 511, 513], "notebook": [320, 506], "noth": [32, 145, 182, 208, 501], "notic": [1, 20, 111, 116, 118, 340, 477, 478, 513], "notifi": 298, "notimplementederror": [325, 326], "notion": [72, 298], "notredam": [269, 275], "notstart": 120, "nov": [37, 40, 110, 321], "novel": 259, "novemb": 480, "now": [1, 60, 110, 111, 113, 118, 228, 256, 259, 297, 318, 319, 336, 339, 340, 395, 412, 511, 513], "np": [4, 5, 6, 10, 23, 27, 53, 62, 70, 84, 85, 96, 97, 106, 165, 168, 176, 177, 184, 196, 198, 201, 206, 213, 215, 219, 221, 228, 230, 231, 233, 234, 239, 240, 241, 242, 245, 247, 254, 255, 257, 258, 260, 261, 262, 263, 265, 266, 267, 268, 269, 270, 271, 272, 273, 275, 276, 296, 298, 299, 300, 301, 302, 304, 305, 319, 321, 331, 335, 336, 338, 339, 340, 341, 345, 346, 347, 348, 349, 351, 352, 355, 356, 362, 363, 364, 365, 366, 368, 369, 372, 373, 374, 376, 379, 380, 381, 382, 384, 386, 387, 388, 389, 390, 394, 395, 397, 409, 412, 460, 479, 482, 488, 496], "np_286546": 106, "npd": 70, "nrte": 235, "ns_": 67, "nt": 149, "nuc": [245, 247, 248], "nuc_pattern": 513, "nuccor": 113, "nucl": 112, "nucleic": [118, 122, 184, 195, 215, 221, 228], "nucleobas": [184, 221], "nucleotid": [0, 19, 36, 39, 107, 110, 111, 112, 113, 184, 209, 210, 213, 214, 221, 245, 247, 248, 513], "null": [116, 259, 264, 304, 336, 395], "num_interval_featur": 151, "num_it": [336, 339, 340], "num_object": 302, "num_repeat": 67, "num_run": [339, 340], "number": [1, 3, 20, 21, 24, 43, 44, 45, 46, 47, 49, 50, 51, 52, 53, 54, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 71, 72, 73, 74, 75, 77, 78, 79, 80, 81, 84, 85, 86, 104, 106, 108, 110, 111, 113, 116, 118, 119, 121, 122, 145, 149, 151, 152, 176, 228, 230, 233, 239, 241, 247, 249, 258, 259, 264, 268, 270, 271, 272, 273, 277, 296, 297, 298, 299, 300, 301, 302, 304, 310, 317, 318, 326, 330, 331, 333, 334, 336, 337, 339, 340, 341, 342, 348, 358, 362, 364, 378, 388, 392, 400, 405, 407, 409, 412, 413, 415, 416, 418, 421, 422, 433, 441, 456, 458, 460, 482, 483, 485, 488, 489, 496], "number_of_dimens": [300, 331], "numer": [1, 10, 54, 60, 106, 115, 120, 122, 173, 176, 177, 181, 183, 273, 297, 298, 310, 319, 321, 325, 326, 332, 333, 340, 480, 489], "numeric_onli": 1, "numericmetadatacolumn": [162, 176, 179], "numpi": [1, 4, 5, 6, 86, 96, 97, 102, 257, 258, 260, 261, 262, 263, 265, 266, 267, 268, 269, 270, 271, 272, 273, 275, 276, 277, 285, 292, 302, 304, 305, 310, 314, 317, 319, 336, 338, 339, 340, 341, 345, 346, 347, 348, 349, 352, 355, 356, 362, 363, 364, 365, 366, 368, 369, 373, 374, 378, 379, 380, 381, 382, 384, 386, 387, 388, 389, 392, 394, 395, 409, 412, 460, 496, 508], "nutrient": 273, "nwnnnnnn": [202, 205], "o": [29, 30, 34, 58, 70, 93, 94, 110, 111, 112, 119, 121, 157, 159, 186, 190, 215, 218, 220, 223, 227, 243, 246, 284, 290, 322, 324, 364, 383, 398, 451, 476, 477, 478, 480, 481, 506, 512], "o1": [346, 347, 349, 352, 355, 356, 362, 363, 364, 365, 366, 368, 369, 373, 374, 375, 379, 380, 381, 382, 384, 386, 387, 388, 389, 391, 394, 395, 397], "o2": [346, 347, 349, 352, 355, 356, 362, 363, 364, 365, 366, 368, 369, 373, 374, 375, 379, 380, 381, 382, 384, 386, 387, 388, 389, 391, 394, 395, 397], "o3": [346, 347, 349, 355, 364, 369, 373, 382], "o31698": 121, "o31699": 121, "o4": [346, 347, 349, 364, 382], "o5": [349, 364], "o83071": 121, "ob": [1, 47, 58, 79, 81, 390], "obesrvation_metadata_f": 373, "obf": 112, "obj": [95, 123, 127, 139, 143, 491, 492, 513], "object": [0, 1, 2, 3, 7, 11, 19, 20, 21, 24, 25, 28, 29, 31, 32, 34, 35, 36, 37, 38, 39, 40, 41, 87, 90, 91, 94, 100, 101, 102, 103, 104, 105, 106, 107, 108, 109, 110, 111, 112, 113, 114, 115, 116, 117, 118, 119, 120, 121, 122, 123, 136, 137, 139, 141, 143, 148, 149, 150, 151, 152, 153, 154, 155, 156, 159, 160, 161, 162, 164, 167, 171, 172, 173, 174, 175, 176, 178, 181, 182, 183, 184, 190, 208, 213, 215, 220, 221, 227, 228, 229, 230, 231, 232, 233, 234, 239, 240, 241, 242, 246, 253, 254, 259, 276, 277, 280, 281, 283, 290, 291, 293, 296, 297, 299, 300, 301, 302, 308, 313, 315, 324, 325, 326, 331, 332, 333, 342, 347, 357, 358, 359, 360, 385, 390, 392, 393, 394, 397, 398, 400, 412, 416, 417, 424, 425, 445, 456, 466, 473, 475, 476, 477, 478, 480, 481, 484, 486, 488, 489, 500, 501, 504, 506, 508, 511, 513], "obs_id": [362, 364, 369], "obs_map": 360, "obs_phi": 348, "observ": [1, 43, 53, 56, 58, 67, 69, 79, 81, 84, 85, 90, 105, 228, 233, 245, 259, 304, 319, 336, 339, 340, 342, 343, 344, 345, 346, 347, 348, 349, 351, 352, 353, 355, 356, 357, 358, 359, 360, 362, 363, 364, 365, 366, 368, 369, 370, 371, 372, 373, 374, 375, 376, 378, 379, 380, 381, 382, 384, 385, 386, 387, 388, 389, 390, 391, 392, 394, 395, 396, 397, 399, 407, 433, 441, 444, 479, 510, 513], "observation_column_nam": [353, 394], "observation_group_metadata": [342, 363], "observation_id": [342, 369, 377, 382], "observation_index": 342, "observation_metadata": 342, "observation_metadata_f": 373, "observed_char": [228, 233], "observed_featur": 79, "observed_otu": 79, "obsolet": [118, 431], "obtain": [54, 176, 228, 248, 259, 276, 278, 289, 295, 296, 298, 300, 331], "obviou": 116, "oc": 110, "occur": [19, 107, 111, 112, 115, 116, 138, 142, 145, 228, 234, 331, 340], "occurr": [50, 78, 202, 203, 204, 205, 217, 230, 424], "oct": [111, 113], "odot": [266, 272], "off": [60, 184, 215, 221, 270, 339, 479, 488, 513], "offer": [501, 506], "offici": 105, "offset": [112, 113], "often": [1, 53, 82, 86, 110, 111, 113, 276, 304, 326, 331, 336, 433, 441, 495], "oh": 505, "oiko": [58, 74], "ol": [53, 477, 478, 481], "old": [79, 259, 268, 397, 410, 412, 414, 416, 421, 439, 441, 453, 454, 460, 468, 480], "older": 118, "om": [342, 399], "omic": 256, "ominu": 271, "omit": [4, 16, 116, 176, 181, 276, 388, 429, 467, 470, 479, 482, 483, 485, 506], "ommit": 119, "onc": [56, 111, 123, 506], "one": [0, 1, 20, 21, 22, 23, 24, 29, 35, 36, 37, 43, 53, 54, 55, 57, 60, 70, 71, 82, 84, 85, 95, 97, 99, 110, 111, 112, 113, 114, 116, 117, 118, 120, 121, 122, 123, 126, 138, 142, 153, 156, 158, 161, 168, 169, 172, 175, 176, 193, 202, 203, 204, 205, 215, 217, 228, 229, 247, 259, 277, 281, 293, 295, 297, 298, 300, 301, 302, 304, 305, 306, 319, 327, 330, 331, 338, 339, 340, 345, 348, 373, 384, 400, 403, 407, 408, 409, 412, 413, 415, 429, 432, 433, 437, 441, 442, 444, 450, 456, 457, 458, 459, 460, 462, 463, 472, 473, 480, 497, 506, 511, 513], "one_to_mani": 348, "one_to_many_md_kei": 348, "one_to_many_mod": 348, "ones": [4, 8, 15, 326, 339, 373], "onli": [0, 1, 19, 20, 29, 56, 57, 61, 70, 71, 90, 95, 97, 99, 108, 110, 111, 112, 113, 115, 116, 117, 118, 120, 121, 122, 123, 145, 151, 156, 162, 165, 166, 176, 177, 182, 184, 185, 191, 200, 215, 216, 221, 222, 228, 229, 247, 256, 259, 270, 280, 286, 291, 293, 294, 295, 296, 300, 301, 318, 319, 323, 326, 331, 333, 338, 339, 340, 346, 347, 348, 356, 358, 370, 395, 406, 408, 410, 411, 412, 413, 414, 415, 417, 418, 424, 433, 441, 450, 459, 460, 463, 469, 492, 496, 504, 506, 511, 513], "onlin": [60, 112], "ons": 120, "onto": [123, 332, 479], "ontologi": [114, 400], "ontology_term": 114, "open": [0, 30, 34, 35, 36, 37, 38, 39, 40, 87, 93, 94, 106, 107, 111, 112, 123, 125, 127, 136, 138, 139, 141, 142, 143, 146, 147, 149, 157, 159, 186, 190, 218, 220, 223, 227, 243, 246, 284, 290, 322, 324, 358, 383, 394, 398, 451, 476, 500, 505, 506], "open_fil": 500, "open_filehandl": 506, "oper": [1, 3, 20, 21, 24, 29, 84, 106, 111, 116, 154, 184, 211, 212, 215, 221, 228, 258, 270, 271, 272, 276, 277, 292, 298, 299, 331, 343, 344, 346, 347, 348, 352, 358, 371, 375, 384, 385, 386, 387, 388, 389, 392, 395, 408, 413, 415, 416, 429, 431, 436, 441, 450, 456, 457, 458, 463, 473, 475, 479, 480, 482, 483, 485, 501, 506, 508], "operon": 149, "opinion": 55, "oplu": 270, "oppos": [301, 513], "optim": [1, 11, 19, 54, 82, 84, 85, 86, 300, 422, 468, 480, 482, 483, 485], "optimal_alignment_scor": 11, "option": [4, 6, 10, 14, 16, 19, 20, 21, 23, 24, 27, 28, 29, 30, 31, 32, 34, 35, 36, 37, 39, 40, 41, 42, 44, 47, 48, 49, 51, 53, 58, 59, 60, 61, 62, 67, 70, 71, 72, 74, 75, 76, 81, 82, 84, 85, 86, 87, 90, 93, 94, 96, 100, 101, 102, 103, 108, 109, 111, 112, 117, 118, 120, 121, 122, 124, 125, 126, 127, 136, 138, 139, 141, 142, 143, 145, 149, 151, 152, 156, 157, 158, 159, 165, 169, 170, 176, 177, 180, 181, 183, 184, 185, 186, 190, 191, 192, 193, 194, 200, 207, 210, 212, 215, 216, 218, 220, 221, 222, 223, 225, 226, 227, 228, 229, 230, 231, 232, 233, 234, 235, 236, 237, 239, 241, 243, 245, 246, 255, 259, 264, 265, 266, 268, 277, 278, 280, 281, 283, 284, 286, 290, 293, 294, 296, 297, 298, 299, 300, 301, 302, 304, 310, 318, 321, 322, 323, 324, 326, 327, 330, 331, 333, 334, 337, 338, 339, 340, 341, 343, 344, 345, 348, 349, 351, 352, 355, 356, 358, 363, 364, 365, 368, 369, 370, 371, 372, 373, 376, 378, 379, 380, 381, 382, 383, 385, 386, 387, 388, 389, 390, 391, 392, 393, 394, 395, 397, 398, 400, 401, 402, 406, 408, 409, 410, 411, 412, 413, 414, 415, 416, 417, 418, 421, 422, 423, 429, 431, 433, 435, 436, 440, 441, 442, 443, 445, 446, 447, 448, 449, 450, 451, 452, 453, 454, 456, 457, 458, 459, 460, 462, 463, 465, 466, 467, 468, 469, 470, 471, 472, 473, 475, 476, 477, 478, 479, 480, 481, 482, 483, 484, 485, 487, 488, 489, 493, 496, 500, 501, 504, 508, 513], "or_f": 117, "oral": 1, "orcutt": 248, "ord_r": 117, "order": [1, 19, 20, 25, 28, 29, 32, 58, 59, 72, 74, 81, 82, 86, 104, 106, 111, 115, 116, 117, 118, 121, 153, 164, 176, 178, 182, 184, 189, 191, 194, 199, 215, 221, 226, 228, 233, 245, 259, 264, 274, 277, 278, 280, 289, 294, 295, 296, 297, 298, 299, 300, 301, 304, 325, 334, 338, 339, 358, 378, 386, 387, 392, 400, 404, 416, 436, 440, 443, 447, 448, 449, 465, 466, 479, 480, 488, 511, 513], "ordin": [1, 103, 300, 489, 490], "ordinari": 478, "ordination_result": 319, "ordinationresult": [103, 117, 300, 325, 326, 331, 332, 333, 489], "org": [19, 41, 43, 87, 104, 105, 111, 112, 113, 118, 120, 121, 176, 181, 269, 273, 275, 277, 285, 291, 292, 296, 297, 298, 299, 300, 321, 342, 358, 359, 392, 399, 480, 496], "organ": [1, 110, 113, 122], "organis": 113, "orient": [305, 321, 338, 358, 392, 456, 506], "origin": [1, 3, 6, 9, 10, 20, 35, 37, 38, 40, 45, 46, 49, 52, 53, 56, 57, 58, 59, 63, 64, 65, 70, 71, 72, 74, 75, 81, 84, 85, 87, 108, 109, 111, 116, 118, 119, 166, 169, 170, 183, 228, 229, 296, 297, 298, 299, 300, 304, 325, 331, 333, 341, 348, 356, 379, 395, 402, 412, 413, 415, 417, 456, 457, 458, 460, 479, 480, 511, 513], "orthogon": [265, 266], "ortholog": [342, 399], "orthonorm": [265, 266, 273, 274], "orthornorm": 265, "ostel": 111, "other": [0, 1, 6, 19, 20, 29, 53, 69, 74, 87, 110, 111, 112, 113, 115, 116, 118, 120, 121, 122, 145, 149, 151, 155, 160, 162, 171, 172, 174, 175, 176, 182, 184, 191, 211, 212, 213, 215, 221, 228, 231, 239, 240, 241, 242, 244, 247, 253, 259, 264, 276, 277, 291, 300, 319, 321, 325, 326, 331, 338, 340, 342, 345, 349, 354, 369, 373, 400, 407, 411, 412, 413, 414, 415, 422, 424, 445, 472, 473, 475, 488, 501, 502, 506, 507, 508, 511, 513], "other_vertebr": 107, "otherwis": [18, 19, 20, 21, 24, 32, 47, 48, 111, 113, 116, 119, 120, 145, 162, 168, 245, 277, 280, 294, 301, 342, 351, 355, 367, 373, 379, 382, 413, 468, 508], "otu": [1, 120, 342, 345, 346, 347, 348, 349, 353, 357, 358, 359, 364, 369, 373, 379, 381, 382, 386, 387, 392, 394, 395, 399], "otu1": 353, "otu2": 353, "otu_id": [53, 70, 84, 85], "otuid": 120, "our": [1, 20, 55, 112, 120, 123, 126, 146, 235, 319, 336, 339, 340, 341, 508, 513], "out": [20, 23, 109, 119, 120, 123, 163, 321, 356, 388, 513], "out_f": [308, 313, 315], "out_fh": 276, "outcom": [73, 339, 472], "outer": [28, 29, 229, 249], "outfmt": [106, 107], "outgroup": 458, "output": [2, 29, 106, 107, 109, 116, 118, 119, 121, 238, 264, 296, 300, 301, 310, 326, 342, 348, 353, 393, 394, 407, 467, 480, 496, 505, 513], "outsid": [112, 149, 155, 233], "over": [20, 28, 87, 111, 112, 119, 120, 121, 228, 247, 264, 302, 311, 336, 337, 342, 345, 348, 349, 368, 369, 370, 372, 375, 376, 381, 384, 388, 395, 400, 440, 443, 447, 448, 449, 465, 469, 511], "overal": [342, 399, 440, 447, 448, 449, 480], "overhead": [318, 358], "overlap": [60, 156, 182, 236, 237, 255, 264, 278, 373, 412, 482], "overrid": [19, 36, 39, 70, 124, 125, 126, 127, 136, 141, 181, 413, 415, 450, 513], "overridden": [19, 20, 113, 497], "override_skip_babp": 19, "overrideerror": 497, "overriden": [125, 126, 127], "overview": 480, "own": [21, 24, 29, 104, 111, 117, 121, 123], "owner": [491, 492], "oxfordjourn": 112, "oxtobi": 110, "p": [1, 19, 41, 53, 58, 64, 65, 70, 72, 215, 259, 264, 273, 276, 296, 298, 299, 300, 301, 304, 319, 325, 326, 327, 331, 332, 333, 336, 339, 340, 388], "p26204": 110, "p__b": 348, "p__c": 348, "p_adjust": [259, 264], "p_i": [49, 51, 58, 59, 72, 74, 75, 81], "p_valu": [1, 298, 304], "pack": 3, "packag": [19, 41, 43, 83, 108, 111, 116, 118, 264, 273, 276, 296, 297, 298, 299, 300, 303, 325, 326, 333, 484, 496, 511, 512], "pad": [29, 118, 229], "page": [55, 259, 480, 506, 511], "pair": [0, 1, 18, 35, 36, 37, 39, 42, 84, 85, 86, 90, 110, 112, 113, 114, 116, 121, 149, 152, 156, 172, 247, 255, 259, 277, 278, 289, 293, 295, 301, 336, 412, 413, 416, 441, 482, 483, 484, 485, 508], "pairwis": [14, 15, 16, 18, 86, 87, 90, 101, 256, 259, 269, 281, 293, 301, 304, 348, 370, 422, 480, 511], "pairwise_dist": 86, "pairwise_func": 86, "pam": [215, 247, 248], "pam250": 248, "pam30": 248, "pam70": 248, "pancoro": 110, "panda": [1, 20, 32, 86, 100, 106, 107, 122, 162, 169, 170, 175, 176, 183, 184, 215, 221, 259, 264, 287, 295, 296, 297, 299, 300, 301, 305, 310, 317, 319, 321, 338, 339, 346, 375, 391, 429, 488, 508], "paper": 120, "papilionoidea": 110, "par_dist": 304, "parallel": [55, 87], "param": 498, "paramet": [1, 3, 4, 5, 6, 7, 10, 11, 14, 15, 16, 18, 19, 20, 21, 23, 24, 25, 27, 28, 29, 30, 31, 32, 34, 35, 36, 37, 38, 39, 40, 41, 42, 43, 44, 45, 46, 47, 48, 49, 50, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 71, 72, 73, 74, 75, 76, 77, 78, 79, 80, 81, 82, 84, 85, 86, 87, 90, 91, 93, 94, 95, 96, 97, 98, 99, 100, 101, 102, 103, 123, 124, 125, 126, 127, 129, 131, 132, 133, 134, 135, 136, 137, 138, 139, 141, 142, 143, 145, 149, 151, 152, 153, 154, 155, 156, 157, 158, 159, 162, 164, 165, 167, 169, 170, 176, 177, 178, 179, 180, 181, 182, 183, 184, 185, 186, 188, 189, 190, 191, 192, 193, 194, 200, 207, 208, 210, 212, 213, 215, 216, 218, 220, 221, 222, 223, 225, 226, 227, 228, 229, 230, 231, 232, 233, 234, 235, 236, 237, 238, 239, 240, 241, 242, 243, 244, 245, 246, 247, 248, 249, 251, 254, 255, 257, 258, 259, 260, 261, 262, 263, 264, 265, 266, 267, 268, 269, 270, 271, 272, 273, 274, 275, 277, 278, 280, 281, 282, 283, 284, 286, 289, 290, 293, 294, 296, 297, 298, 299, 300, 301, 302, 304, 308, 310, 313, 315, 317, 318, 321, 322, 323, 324, 325, 326, 327, 330, 331, 332, 333, 334, 336, 337, 338, 339, 340, 341, 342, 343, 344, 345, 346, 347, 348, 349, 351, 352, 355, 356, 357, 358, 359, 360, 362, 363, 364, 365, 366, 368, 369, 370, 371, 372, 373, 374, 375, 376, 378, 379, 380, 381, 382, 383, 384, 385, 386, 387, 388, 389, 390, 391, 392, 393, 394, 395, 397, 398, 400, 401, 402, 403, 406, 408, 409, 410, 411, 412, 413, 414, 415, 416, 417, 418, 421, 422, 423, 424, 425, 426, 427, 428, 429, 430, 433, 435, 436, 439, 440, 441, 442, 443, 444, 445, 446, 447, 448, 449, 450, 451, 452, 453, 454, 456, 457, 458, 459, 460, 462, 463, 465, 466, 467, 468, 469, 470, 471, 472, 473, 474, 475, 476, 477, 478, 479, 480, 481, 482, 483, 484, 485, 487, 488, 489, 490, 492, 493, 494, 495, 496, 497, 498, 500, 501, 502, 503, 504, 513], "parametr": [47, 256, 259, 296, 299], "params_alias": 487, "params_guess": 67, "paramt": 331, "parasit": 304, "pardi": 70, "parent": [110, 114, 116, 122, 228, 273, 400, 402, 405, 407, 413, 423, 426, 435, 437, 442, 446, 447, 450, 452, 456, 457, 458, 461, 462, 466, 470, 473, 474, 475, 487, 497, 511], "parent_tax_id": [122, 429], "parenthes": 511, "parenthesi": 116, "parker": [45, 58], "pars": [111, 112, 113, 115, 123, 357, 358, 359, 360, 506], "parse_biom_t": 358, "parse_f": 358, "parser": [114, 116, 506], "part": [106, 111, 113, 116, 119, 253, 257, 273, 318, 381, 501, 511], "partial": [19, 70, 155, 342], "partial_beta_divers": 87, "partialdistancematrix": 87, "particip": 340, "particuarli": 111, "particular": [1, 400, 424, 513], "particularli": [409, 506], "partit": [256, 273, 274, 348, 407], "pass": [1, 20, 24, 30, 31, 34, 41, 82, 86, 87, 88, 89, 93, 94, 106, 108, 111, 113, 118, 119, 121, 125, 126, 127, 130, 136, 138, 139, 140, 141, 142, 143, 145, 157, 159, 184, 185, 186, 190, 191, 193, 200, 215, 216, 218, 220, 221, 222, 223, 227, 228, 231, 233, 243, 244, 246, 277, 284, 290, 293, 294, 298, 301, 310, 322, 324, 339, 369, 382, 383, 398, 451, 476, 504, 506, 511, 513], "passthrough": 32, "password": 123, "path": [3, 4, 5, 6, 7, 8, 9, 10, 14, 15, 16, 18, 26, 105, 109, 111, 112, 119, 145, 181, 348, 400, 401, 412, 422, 468, 482, 495, 506], "path_2": 445, "path_dist": 412, "pathwai": [342, 348, 399], "patrist": [416, 422, 441], "pattern": [20, 122, 208, 232, 319, 408, 415, 463, 508, 513], "paw": [215, 217, 219], "pawhea": 0, "pawlowski": [256, 269, 275], "pc": [1, 305, 321], "pca": [325, 331, 333], "pcbi": [269, 275], "pcoa": [1, 117, 300, 320, 321, 332], "pcoa_result": 321, "pcr": 340, "pd": [1, 20, 24, 32, 53, 70, 82, 100, 106, 107, 122, 162, 174, 175, 228, 259, 264, 276, 278, 287, 289, 295, 296, 297, 300, 305, 319, 320, 321, 325, 333, 338, 339, 346, 375, 391, 429, 430, 468, 488], "pd_": 70, "pdf": [11, 119], "pdist": [1, 83, 86, 89, 101, 304], "pearson": [111, 298, 301, 304, 412, 415], "pearsonr": [298, 304, 336], "peerj": 70, "penal": [35, 36, 37], "penalize_terminal_gap": [35, 36, 37], "penalti": [0, 19, 35, 36, 37, 38, 39, 40], "penni": 412, "pentapetala": 110, "per": [3, 14, 29, 106, 107, 119, 121, 184, 215, 221, 228, 264, 301, 304, 318, 333, 339, 340, 389, 403, 409, 500], "percent": [106, 508], "percentag": [106, 256], "percentil": 259, "percentile_df": 259, "perfect": [319, 326], "perform": [0, 1, 3, 19, 20, 28, 29, 41, 53, 67, 82, 84, 85, 86, 87, 103, 111, 112, 120, 149, 182, 184, 189, 194, 215, 221, 226, 228, 256, 257, 258, 259, 261, 262, 263, 264, 265, 266, 269, 270, 271, 272, 274, 275, 277, 291, 292, 293, 301, 304, 305, 306, 309, 316, 317, 319, 331, 333, 334, 340, 341, 342, 348, 379, 382, 388, 412, 417, 427, 431, 440, 447, 448, 449, 456, 457, 458, 460, 473, 474, 477, 478, 480, 481, 484, 488, 506], "period": 120, "periton": 339, "perm_stat": 304, "permanova": [296, 300], "permdisp2": 300, "permiss": [111, 116, 118], "permit": [3, 116, 126], "permut": [1, 149, 296, 298, 299, 300, 301, 304], "perplex": [58, 74], "perspect": [70, 472], "pertain": 303, "perturb": [256, 271], "petchei": 53, "peter": 112, "pfam": 121, "pgc": 122, "ph": 297, "phagocyt": 339, "phase": [113, 114], "phe": 215, "phenylalanin": 215, "php": 111, "phred": [111, 112], "phred_offset": [112, 119], "phydiv": 53, "phylip": [30, 34, 111, 116, 479, 506, 511], "phylip_multiple_alignment_format": 118, "phylipformaterror": 118, "phylo": 118, "phylochip": [53, 84, 85], "phylogenet": [1, 53, 70, 84, 85, 116, 118, 276, 304, 400, 413, 416, 424, 436, 457, 468, 472, 477, 478, 480, 481, 483, 484, 505, 508], "phylogeni": [118, 303, 304, 415, 477, 478, 481], "phylum": 429, "physic": [81, 332, 340], "pick": [19, 339], "pident": [106, 107], "pie": [51, 75], "piec": 513, "pielou": [71, 77], "pielou_": 57, "piet": 326, "pig": [477, 478, 481], "pii": 108, "ping": [19, 41], "pipe": 122, "pirrung": 321, "pisc": 60, "pitfal": 23, "pizetti": 55, "place": [32, 116, 121, 182, 193, 318, 331, 334, 356, 379, 382, 392, 395, 409, 425, 431, 434, 456, 457, 458, 459, 460, 470, 472, 475, 480, 481, 489], "placebo": [259, 264], "placement": [407, 480], "plain": [108, 111, 112, 113, 116, 118, 119], "plan": 120, "planetmath": 291, "plankton": 45, "plant": [80, 110, 273], "plastid": 122, "pleas": [20, 30, 34, 93, 94, 111, 119, 157, 159, 186, 190, 218, 220, 223, 227, 243, 246, 284, 290, 322, 324, 383, 398, 451, 476, 506, 510], "pleij": 121, "plm": [2, 109], "pln": [110, 122], "plo": [19, 41, 61, 62, 269, 275], "ploson": [19, 41], "plot": [1, 320], "plottabl": 486, "plu": [122, 184, 215, 221], "plug": 496, "plugin": 120, "plural": [1, 147], "pm": 52, "pmid": [121, 298, 477, 478, 480, 481], "png": [320, 486], "point": [23, 55, 60, 62, 104, 108, 120, 123, 126, 149, 176, 238, 244, 245, 247, 248, 300, 306, 309, 317, 319, 321, 339, 340, 435, 457, 488, 495], "poisson": [61, 62], "polici": 496, "polymeras": 121, "polytomi": 436, "pone": [19, 41], "pool": 44, "poorli": [304, 331], "pop": [450, 452, 453, 454], "popul": [43, 47, 54, 56, 79, 119, 121, 238, 270, 302, 336, 340], "port": 120, "portal": 122, "portion": 298, "pos_idx": 20, "pos_rat": 340, "posit": [0, 3, 4, 5, 6, 7, 9, 14, 16, 19, 20, 21, 22, 23, 24, 25, 27, 28, 29, 32, 35, 36, 37, 38, 39, 40, 41, 42, 106, 107, 108, 111, 112, 113, 116, 118, 119, 120, 121, 174, 175, 184, 185, 187, 188, 189, 193, 194, 196, 197, 198, 199, 200, 201, 206, 210, 214, 215, 216, 219, 221, 222, 224, 225, 226, 228, 229, 230, 232, 234, 235, 238, 239, 240, 241, 242, 244, 256, 257, 258, 259, 268, 298, 304, 317, 320, 331, 336, 337, 339, 340, 342, 362, 375, 407, 408, 435, 446, 456, 460, 472, 473, 475, 508], "positional_metadata": [20, 22, 28, 29, 111, 121, 174, 175, 184, 195, 197, 210, 214, 215, 221, 228, 229, 238, 244, 508], "possess": 497, "possibl": [1, 19, 20, 71, 77, 81, 111, 112, 120, 121, 155, 189, 191, 194, 199, 226, 297, 301, 339, 479], "post": [118, 336, 340, 448], "posterior": [264, 400], "postmenopaus": 340, "postord": [404, 409, 424, 440, 443, 448, 449, 465, 469, 511], "potenti": [111, 235, 318, 331, 453, 454, 513], "pound": [120, 176], "power": [256, 264, 342, 399, 506], "pp": [54, 66, 72, 326, 415, 485], "ppo": [106, 107], "practic": [1, 29, 70, 111, 112, 119, 318, 419, 424], "pre": [208, 232, 247, 248, 250, 340, 408, 448], "pre_and_postord": [440, 447, 449, 469], "pre_rat": 340, "prealloc": 501, "preced": [19, 108, 116, 118], "precis": 480, "precomput": 335, "predefin": [114, 231], "predict": [61, 62, 121, 339], "preemptiv": 20, "prefer": [23, 82, 86, 112, 325, 326, 506], "prefer_self": 373, "prefix": 122, "preliminari": 339, "premenopaus": 340, "preorder": [440, 447, 448, 469, 511], "prepar": 120, "preq1": 113, "presenc": [48, 70, 191, 193, 340, 380, 431], "present": [20, 22, 23, 53, 84, 85, 106, 109, 111, 117, 120, 121, 151, 176, 184, 193, 196, 197, 198, 201, 206, 210, 214, 215, 219, 221, 233, 234, 259, 280, 296, 297, 299, 300, 310, 320, 331, 340, 348, 357, 358, 397, 402, 406, 423, 431, 435, 442, 446, 450, 452, 453, 454, 459, 463, 470, 471, 472, 475, 479, 480, 511], "preserv": [111, 116, 176, 319, 325, 326, 331, 402, 412], "preset": [412, 415, 482, 485], "press": [46, 72], "presum": 111, "prev": 409, "prevent": 19, "previou": [1, 35, 36, 37, 38, 39, 40, 228, 296, 298, 300, 409, 412, 480], "previous": [0, 238, 244, 513], "pri": 122, "primari": [123, 508], "primer": 297, "princip": [1, 300, 321, 325, 331, 332], "principl": [336, 477, 478, 481], "print": [0, 1, 28, 53, 84, 85, 108, 111, 112, 113, 114, 116, 118, 119, 121, 171, 189, 194, 199, 226, 228, 235, 245, 276, 286, 298, 304, 305, 318, 336, 339, 340, 345, 346, 347, 348, 349, 352, 356, 362, 364, 365, 369, 370, 371, 372, 373, 376, 379, 380, 381, 382, 386, 387, 388, 394, 395, 397, 401, 402, 403, 406, 407, 408, 409, 412, 413, 415, 416, 417, 418, 423, 425, 427, 429, 430, 432, 435, 437, 438, 439, 440, 443, 445, 446, 447, 448, 449, 450, 453, 454, 456, 457, 458, 459, 460, 462, 463, 465, 466, 467, 468, 469, 470, 471, 472, 473, 475, 477, 478, 479, 480, 481, 482, 483, 484, 485, 508, 511, 513], "printabl": [112, 119], "prior": [193, 256, 298, 301, 388, 406, 429, 435, 456, 457, 458, 460, 501, 502, 513], "prioriti": [70, 503, 513], "privat": [113, 403], "prng": 318, "pro": 215, "prob": [20, 22, 28], "probabl": [49, 51, 61, 62, 72, 73, 75, 264, 305, 307, 318, 325, 336, 340, 400], "problem": [120, 259, 477, 481], "problemat": [120, 466], "proc": [37, 40], "procedur": [300, 412, 482, 506], "proceed": [72, 248, 415, 485], "process": [87, 111, 121, 155, 264, 333, 393, 394, 501, 513], "process_func": 360, "processor": 513, "prod": [262, 273], "prod_": 74, "produc": [43, 106, 107, 118, 119, 125, 235, 325, 333, 407, 480, 484], "product": [0, 149, 267, 298], "program": [115, 116, 120, 122, 416, 422], "progress": 297, "prohibit": [473, 474, 475], "project": [87, 112, 257, 273, 296, 297, 298, 299, 300, 332], "prolin": 215, "promis": 259, "pronounc": [342, 399, 505], "prop_expl": [305, 306, 309, 310, 316, 317], "propag": 228, "proper": 458, "properli": [116, 145], "properti": [3, 20, 108, 118, 122, 149, 160, 162, 171, 174, 176, 182, 191, 195, 228, 247, 277, 281, 291, 293, 331, 336, 405, 409, 436, 450, 492, 507], "proport": [43, 49, 51, 55, 56, 58, 59, 67, 70, 72, 74, 75, 81, 117, 212, 254, 256, 257, 259, 260, 261, 262, 265, 266, 267, 268, 269, 270, 271, 272, 275, 296, 298, 299, 305, 310, 317, 320, 325, 331, 333, 411, 413, 414, 483], "proportion": [269, 275], "proportion_explain": [319, 320], "propos": [43, 74], "prot": 110, "protein": [0, 2, 19, 20, 23, 35, 37, 40, 41, 96, 97, 106, 108, 109, 110, 111, 112, 113, 118, 119, 121, 188, 189, 191, 193, 194, 195, 225, 226, 228, 235, 245, 248, 339, 508], "protein_from_dna": 508, "protein_from_rna": 508, "protein_id": 110, "proteinembed": 109, "proteinvector": 109, "provid": [0, 1, 2, 15, 18, 19, 20, 21, 23, 24, 31, 36, 39, 41, 43, 53, 60, 61, 62, 70, 82, 83, 84, 85, 86, 106, 109, 111, 112, 116, 118, 120, 121, 122, 123, 125, 127, 136, 138, 141, 142, 144, 146, 167, 176, 181, 182, 221, 228, 233, 235, 238, 245, 247, 256, 264, 276, 277, 281, 289, 293, 294, 296, 297, 298, 299, 300, 301, 302, 304, 305, 310, 318, 319, 320, 321, 327, 331, 336, 338, 339, 340, 341, 342, 343, 351, 353, 356, 358, 363, 365, 366, 371, 372, 374, 376, 381, 382, 388, 392, 393, 395, 397, 399, 408, 409, 410, 412, 421, 424, 425, 429, 439, 444, 456, 460, 463, 466, 468, 472, 479, 480, 481, 482, 496, 501, 506, 507, 508, 509, 510, 511, 512, 513], "proxim": 319, "prune": [406, 436, 453, 454, 459, 470, 471, 472], "psa": [35, 38], "pseudo": 299, "pseudocount": [256, 259, 264], "pseudoknot": 121, "pub": [110, 122, 149], "public": [70, 112, 321], "publish": [112, 121, 412], "pubm": [110, 113, 171, 228], "pull": [111, 497], "pure": 0, "purin": [184, 185, 200, 216, 222, 508], "purpos": [0, 1, 41, 44, 120, 122, 191, 336, 408, 422, 513], "put": [58, 228], "pvalu": [264, 336, 339, 340], "pwmantel": 298, "pwr": 339, "pwr_001": 336, "pwr_010": 336, "pwr_100": 336, "pwr_est": 340, "pwr_est2": 340, "py": [112, 123], "pycog": [53, 84, 85, 479], "pyl": 215, "pyrimidin": [184, 185, 222], "pyrosequenc": [53, 84, 85], "pyrrolysin": 215, "python": [0, 1, 11, 228, 276, 291, 298, 492, 505, 506, 508], "q": [19, 58, 60, 72, 81, 107, 215, 326, 327], "q2": 120, "q2cli": 120, "qacc": [106, 107], "qaccver": [106, 107], "qcov": [106, 107], "qcovhsp": [106, 107], "qd": 58, "qend": [106, 107], "qframe": [106, 107], "qgi": [106, 107], "qh": [72, 81], "qiim": [53, 84, 85, 120, 176], "qiime2": [120, 176, 181], "qiita": 120, "qiu": 304, "qlen": [106, 107], "qseq": [106, 107, 186, 218, 223, 243], "qseqid": [106, 107], "qstart": [106, 107], "quadrat": 72, "qual": 112, "qual_fl": 111, "qualifi": [110, 113], "qualit": [84, 85, 321], "qualiti": [111, 119, 174, 175, 184, 197, 210, 214, 215, 221, 228, 321, 508], "quantifi": [1, 416], "quantil": [60, 264], "quantit": [70, 84, 85, 325, 340], "quantiti": 85, "quartil": 60, "queri": [0, 11, 18, 19, 41, 106, 107, 151, 180, 228], "query1": 107, "query_begin": 11, "query_end": 11, "query_sequ": [0, 11, 19], "quick": [277, 292, 321, 325], "quit": 513, "quot": 116, "qvalu": 264, "r": [1, 19, 53, 54, 60, 61, 62, 63, 64, 70, 84, 85, 112, 113, 122, 145, 184, 215, 221, 248, 256, 257, 258, 262, 263, 264, 265, 266, 273, 296, 297, 298, 299, 300, 304, 321, 325, 326, 333, 347, 412, 413, 415, 416, 477, 478, 481, 483, 484, 485], "r1": 508, "r2": 508, "r2d0c0545a225": 481, "r3": 508, "r4": 508, "r5": 508, "r_i": 273, "r_m": 298, "ra": [110, 121], "raaijmak": 67, "raimon": 273, "rais": [20, 21, 23, 24, 27, 29, 31, 33, 44, 53, 54, 55, 70, 82, 84, 85, 86, 90, 102, 111, 112, 118, 123, 125, 126, 127, 136, 138, 139, 141, 142, 143, 155, 164, 178, 181, 182, 185, 193, 195, 200, 213, 216, 222, 228, 229, 230, 231, 233, 234, 236, 237, 239, 240, 241, 242, 245, 248, 249, 254, 255, 261, 268, 274, 277, 278, 280, 281, 282, 286, 289, 293, 296, 297, 298, 300, 301, 310, 317, 318, 321, 323, 325, 326, 331, 333, 339, 340, 341, 342, 343, 345, 349, 351, 352, 356, 357, 358, 363, 364, 365, 366, 369, 370, 371, 372, 374, 375, 376, 382, 384, 385, 388, 395, 397, 399, 409, 412, 416, 419, 421, 422, 424, 425, 427, 429, 433, 435, 439, 444, 446, 457, 458, 459, 460, 468, 470, 487, 488, 489, 490, 492, 497], "rand": [96, 97], "random": [52, 54, 61, 62, 67, 96, 97, 104, 264, 294, 296, 298, 299, 300, 301, 302, 304, 318, 326, 331, 336, 338, 339, 340, 341, 388, 412, 460, 482, 496], "random_fn": 302, "randomli": [49, 75, 294, 296, 298, 299, 302, 318, 341, 388, 412, 460, 482], "randomst": [61, 62, 264, 294, 296, 298, 299, 300, 301, 318, 338, 339, 340, 341, 496], "rang": [49, 58, 60, 71, 72, 81, 85, 112, 113, 120, 175, 197, 210, 214, 233, 235, 247, 296, 297, 321, 340, 364, 369, 388, 412, 413, 415, 434, 436, 456, 513], "rangeindex": [20, 21, 24, 31, 118, 174], "rangle_a": [265, 267], "rank": [1, 60, 80, 122, 259, 296, 297, 298, 335, 382, 429, 430], "rapid": [104, 111, 434], "rapidli": 513, "rare": [44, 58, 340], "rare_threshold": 44, "rarefact": [67, 388], "rat": [477, 478, 481], "rate": [44, 247, 336, 415], "rather": [1, 60, 116, 247, 256, 304, 412, 417, 439, 462], "ratio": [61, 71, 77, 257, 258, 259, 262, 263, 265, 266, 269, 275, 340], "rational": 335, "raw": [106, 308, 313], "raw_f": [308, 313, 315], "raxml": 118, "rbwpd_": 70, "rc": [121, 210, 283, 321], "rda": [117, 320, 325, 326], "re": [0, 1, 21, 24, 29, 53, 82, 84, 85, 86, 105, 108, 111, 112, 118, 121, 184, 195, 208, 215, 221, 228, 232, 301, 325, 333, 335, 336, 340, 345, 388, 407, 408, 466, 472, 473, 475, 477, 478, 480, 482, 483, 485, 511, 513], "reach": 118, "read": [1, 19, 20, 34, 53, 84, 85, 94, 105, 106, 107, 108, 109, 112, 114, 115, 116, 117, 118, 119, 121, 122, 125, 126, 127, 134, 138, 142, 145, 146, 159, 162, 176, 181, 184, 189, 190, 191, 193, 194, 215, 220, 221, 226, 227, 228, 246, 274, 276, 290, 301, 324, 347, 398, 401, 403, 405, 406, 407, 408, 409, 411, 412, 413, 414, 415, 416, 417, 418, 421, 422, 424, 425, 426, 427, 429, 432, 433, 435, 436, 437, 438, 439, 440, 441, 442, 443, 445, 446, 447, 448, 449, 450, 452, 453, 454, 455, 456, 457, 458, 459, 460, 461, 462, 463, 465, 466, 468, 469, 470, 471, 472, 473, 475, 476, 479, 481, 482, 483, 485, 492, 511], "read_numb": 119, "read_sequ": 11, "readabl": [104, 111, 112, 115, 116, 117, 118, 145, 490], "reader": [30, 93, 104, 105, 106, 107, 108, 109, 110, 112, 115, 116, 117, 118, 119, 120, 121, 122, 123, 124, 126, 131, 136, 138, 141, 142, 157, 186, 218, 223, 243, 284, 322, 383, 451, 506], "readi": [0, 123], "reading_fram": [189, 191, 193, 194, 226], "readlin": [125, 145], "real": [20, 28, 111, 112, 119, 256, 257, 258, 262, 263, 265, 266, 270, 271, 272, 480], "realiti": 20, "realli": 1, "rearrang": [475, 481], "rearranged": 481, "reason": [1, 20, 54, 67, 110, 116, 339, 358], "reassign": [31, 118, 298], "reassign_index": [20, 21, 24, 32, 33, 118], "reca": 156, "recal": 116, "recapitul": 304, "recaptur": 44, "receiv": [123, 124, 126, 233, 479], "recent": [118, 193, 228, 298], "receptor": 339, "reciev": 20, "recipi": [402, 423, 435], "reciproc": [59, 340], "recod": 23, "recogn": [120, 375, 385], "recommend": [1, 60, 70, 118, 121, 184, 195, 215, 221, 228, 259, 276, 321, 325, 333, 339, 413, 496], "recomput": [21, 24, 29], "reconstruct": [477, 478, 480, 481, 484, 508], "record": [107, 110, 111, 112, 113, 114, 119], "rectangl": 55, "recurs": [116, 403, 473, 474, 475], "red": 283, "redefin": [298, 492], "reduc": [87, 300, 318, 331, 348, 459, 480], "reduce_f": 87, "reduct": 319, "redund": [277, 285, 291, 333, 474], "redundant_form": 269, "reeder": [61, 62], "ref": 106, "refer": [1, 11, 18, 19, 20, 23, 35, 36, 37, 38, 39, 40, 41, 44, 45, 46, 47, 48, 49, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 70, 71, 72, 73, 74, 75, 77, 80, 81, 84, 85, 87, 149, 184, 191, 192, 195, 215, 221, 228, 247, 248, 257, 258, 259, 264, 268, 269, 273, 275, 277, 285, 291, 292, 296, 297, 298, 299, 300, 304, 321, 325, 326, 331, 332, 333, 342, 358, 392, 399, 405, 412, 413, 415, 416, 417, 422, 431, 441, 457, 468, 475, 477, 478, 479, 480, 481, 482, 483, 484, 485, 496, 498, 510], "reference_sequ": 11, "refin": [408, 459, 463, 468, 477], "reflect": [145, 304, 456], "regard": 264, "regardless": [19, 22, 28, 29, 121, 176, 182, 193, 251, 302, 331, 407, 408, 412, 424, 425, 463], "regex": [208, 232], "region": [114, 149, 151, 235], "regist": [34, 94, 123, 124, 125, 126, 127, 130, 138, 140, 142, 159, 190, 220, 227, 246, 290, 324, 398, 409, 431, 476, 499, 506], "register_alias": [487, 498], "registri": [30, 34, 93, 94, 105, 109, 111, 112, 119, 157, 159, 186, 190, 218, 220, 223, 227, 243, 246, 284, 290, 322, 324, 383, 398, 451, 476, 506], "regress": [256, 298, 333, 340], "regsistri": [130, 140], "regular": [105, 109, 116, 208, 232, 508], "reid": 264, "reject": [259, 264, 336], "rel": [27, 43, 70, 105, 110, 113, 164, 178, 182, 211, 212, 233, 237, 239, 241, 269, 275, 292, 412, 461, 488, 497, 503, 508], "relat": [1, 53, 54, 64, 70, 84, 85, 87, 110, 111, 115, 121, 276, 295, 325, 326, 333, 358, 392, 412, 416, 458, 468], "relationship": [1, 70, 116, 256, 325, 326, 333, 336, 340, 348, 477, 478, 480, 481, 484, 506, 509], "relax": 118, "releas": [53, 70, 84, 85, 110, 122, 480], "relev": [1, 19, 113, 264, 339, 348, 358, 392, 431, 459, 480, 508], "reli": [69, 120, 184, 215, 221], "reliabl": 264, "reload": 112, "remain": [31, 111, 407, 408, 412, 458, 475, 480], "remaind": [111, 348], "rememb": [20, 120, 149], "remot": 113, "remov": [23, 41, 53, 70, 84, 85, 96, 111, 115, 118, 137, 154, 163, 197, 207, 352, 381, 385, 423, 435, 446, 450, 453, 454, 456, 457, 458, 459, 464, 470, 472, 473, 480, 508], "remove_by_func": [446, 450, 452, 454, 459], "remove_delet": 453, "remove_empti": 381, "remove_format": [125, 127], "renam": [79, 113, 195, 205, 206, 259, 268, 410, 412, 414, 416, 421, 439, 441, 453, 454, 460, 468, 473, 480], "renyi": [58, 81], "reorder": [298, 301], "repeat": [1, 112, 336, 494], "repeatedli": 336, "repect": 111, "repen": 110, "replac": [1, 10, 42, 49, 67, 111, 184, 187, 207, 215, 221, 224, 247, 256, 268, 318, 334, 341, 388, 395, 408, 415, 416, 441, 463, 466, 468, 493, 497], "report": [70, 120, 126, 264, 304, 333], "repres": [1, 3, 4, 6, 8, 14, 15, 18, 20, 22, 43, 49, 51, 53, 56, 58, 59, 67, 72, 74, 75, 81, 84, 85, 87, 95, 96, 97, 98, 99, 101, 104, 105, 106, 107, 110, 111, 115, 116, 118, 120, 121, 122, 149, 152, 162, 176, 184, 195, 215, 221, 228, 245, 247, 265, 266, 273, 274, 277, 278, 281, 289, 293, 304, 319, 321, 331, 336, 342, 348, 359, 384, 389, 393, 400, 408, 409, 463, 467, 477, 478, 479, 480, 508, 511], "represent": [0, 1, 3, 14, 92, 95, 97, 98, 99, 104, 105, 111, 116, 120, 151, 191, 238, 274, 277, 303, 320, 342, 348, 358, 394, 399, 466, 467, 506, 511], "reprint": 55, "reproduc": [29, 53, 84, 85, 336, 496], "reproduct": 340, "request": [111, 179, 278, 289, 345, 352, 364, 375, 495, 506], "requir": [19, 53, 61, 62, 70, 84, 85, 104, 107, 108, 111, 114, 118, 121, 122, 156, 176, 181, 188, 193, 194, 225, 274, 276, 291, 298, 304, 318, 330, 338, 342, 348, 357, 409, 419, 457, 458, 480, 481, 498, 501, 506, 508, 513], "reroot": [400, 407, 456, 457, 458], "rerrang": 475, "rerun": 298, "res_metadata": 346, "res_tabl": [346, 347], "res_tre": 347, "resampl": 388, "research": [1, 122, 298], "resembl": [111, 409], "reserv": [118, 120], "reset": [20, 21, 24, 31, 456, 457, 458], "reset_index": [21, 24], "reshap": [364, 369], "resid": 318, "residu": [23, 96, 109, 333], "resolv": [87, 90, 120, 304], "resourc": [70, 120, 122, 145], "respect": [1, 20, 47, 111, 114, 117, 120, 122, 125, 126, 127, 136, 139, 141, 143, 145, 176, 228, 233, 251, 259, 273, 278, 281, 289, 293, 295, 304, 319, 320, 346, 347, 368, 369, 370, 389, 412, 413, 415, 496], "respons": [30, 34, 93, 94, 157, 159, 186, 190, 218, 220, 223, 227, 243, 246, 284, 290, 308, 313, 315, 319, 322, 324, 326, 333, 383, 398, 439, 451, 476], "restrict": [20, 53, 84, 85, 118, 162, 176, 482, 485, 508], "result": [1, 11, 19, 20, 23, 25, 29, 35, 36, 37, 53, 54, 60, 73, 82, 84, 85, 86, 90, 103, 106, 107, 111, 120, 123, 145, 153, 180, 182, 184, 197, 210, 214, 215, 221, 229, 245, 259, 264, 267, 268, 270, 293, 296, 298, 299, 300, 301, 302, 305, 307, 308, 309, 311, 312, 313, 314, 315, 316, 318, 320, 321, 325, 326, 331, 333, 336, 341, 348, 349, 370, 373, 381, 388, 392, 394, 408, 409, 412, 415, 416, 424, 426, 442, 459, 463, 466, 467, 468, 472, 479, 480, 489, 496, 506, 508, 513], "result_constructor": 480, "retain": [29, 164, 177, 178, 229, 244, 280, 318, 331, 348, 388, 397, 456, 457, 458], "retriev": [20, 165, 167, 171, 174, 176, 179, 180, 228, 291, 358, 362, 364], "return": [0, 1, 4, 5, 6, 7, 8, 9, 10, 11, 12, 14, 15, 16, 18, 19, 20, 22, 23, 25, 27, 29, 30, 32, 33, 35, 36, 37, 38, 39, 40, 41, 42, 44, 45, 46, 47, 48, 49, 50, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 71, 72, 73, 74, 75, 76, 77, 78, 79, 80, 81, 82, 84, 85, 86, 87, 88, 89, 90, 91, 93, 95, 100, 101, 102, 103, 106, 114, 123, 124, 125, 126, 130, 131, 132, 133, 134, 135, 136, 138, 139, 140, 141, 142, 143, 145, 149, 151, 152, 153, 157, 160, 161, 162, 163, 164, 165, 166, 167, 168, 169, 170, 171, 172, 174, 175, 176, 177, 178, 179, 180, 181, 182, 183, 184, 185, 186, 187, 188, 191, 192, 193, 195, 196, 197, 198, 200, 201, 202, 203, 204, 205, 206, 207, 208, 209, 210, 211, 212, 213, 214, 215, 216, 217, 218, 219, 221, 222, 223, 224, 225, 228, 229, 230, 231, 233, 234, 237, 238, 239, 240, 241, 242, 243, 244, 245, 247, 248, 249, 250, 251, 252, 254, 255, 257, 258, 259, 260, 261, 262, 263, 264, 265, 266, 267, 268, 269, 270, 271, 272, 273, 274, 275, 277, 278, 279, 280, 281, 282, 283, 284, 285, 287, 288, 289, 292, 293, 294, 295, 296, 297, 298, 299, 300, 301, 302, 304, 311, 318, 320, 321, 322, 325, 326, 327, 330, 331, 332, 333, 334, 336, 337, 338, 339, 340, 341, 342, 346, 347, 348, 350, 351, 353, 355, 356, 357, 358, 359, 360, 361, 362, 363, 364, 365, 366, 367, 368, 369, 370, 371, 372, 373, 374, 375, 376, 377, 378, 379, 380, 381, 382, 383, 384, 385, 386, 387, 388, 389, 390, 391, 392, 393, 394, 395, 396, 397, 400, 401, 403, 407, 408, 409, 411, 412, 413, 414, 415, 416, 417, 418, 420, 421, 422, 424, 425, 426, 427, 428, 429, 430, 431, 432, 433, 434, 437, 438, 439, 441, 442, 444, 445, 446, 451, 452, 453, 454, 455, 456, 457, 458, 459, 461, 462, 463, 466, 467, 468, 469, 471, 472, 473, 474, 475, 477, 478, 479, 480, 481, 482, 483, 484, 485, 486, 490, 491, 492, 494, 495, 496, 497, 500, 504, 506, 508, 513], "return_cod": 245, "reus": [19, 335, 431], "reveal": [319, 480], "revers": [20, 28, 32, 123, 189, 191, 193, 194, 210, 213, 214, 224, 226, 228, 296, 300, 386, 508, 513], "reverse_compl": [210, 213, 508], "reverse_transcrib": 188, "review": 405, "revisit": 273, "rf": [189, 194, 226, 413, 415, 483], "rf_dist": 413, "rfam": 121, "rho": 297, "riboswitch": [113, 149], "rice": 112, "rich": [1, 47, 53, 58, 63, 66, 67, 70, 79, 81], "rich_sparse_otu_table_hdf5": 358, "right": [20, 29, 44, 74, 116, 182, 256, 257, 258, 262, 267, 270, 271, 272, 273, 434, 447, 449, 488, 489, 513], "right_child_id": 466, "rightarrow": [257, 258, 262, 263, 265, 266], "risk": 340, "rl": [110, 121], "rm": [121, 306, 316], "rn": [110, 121], "rna": [0, 20, 36, 39, 41, 108, 110, 111, 112, 113, 118, 119, 121, 184, 187, 188, 189, 191, 193, 194, 195, 209, 228, 229, 264, 508], "rna_seq": [110, 113], "rng": [336, 339, 340, 496], "robbin": 56, "robinson": [411, 413, 414, 415, 483, 485], "robust": [70, 120, 269, 275, 300, 304], "rohlf": [412, 416], "role": [121, 247, 339], "rome": 55, "root": [1, 3, 53, 66, 70, 84, 85, 116, 122, 274, 331, 400, 401, 402, 403, 405, 406, 407, 408, 410, 412, 413, 414, 415, 416, 417, 419, 421, 422, 423, 424, 425, 426, 427, 429, 431, 433, 436, 437, 439, 440, 441, 442, 445, 447, 448, 449, 450, 456, 457, 458, 459, 461, 462, 463, 466, 467, 469, 470, 472, 473, 474, 475, 477, 478, 479, 480, 481, 482, 483, 485, 511], "root_at": [457, 472, 474, 475], "root_at_midpoint": 480, "root_nam": [456, 457, 458, 473], "rosid": 110, "roughli": 67, "round": [53, 60, 67, 84, 85, 298, 336, 339, 412, 415, 460, 468], "roundtrip": [105, 109], "roundtripp": 176, "routin": 291, "row": [1, 3, 20, 82, 86, 87, 90, 91, 95, 96, 97, 98, 99, 100, 104, 105, 109, 118, 149, 176, 247, 258, 259, 261, 264, 265, 266, 268, 270, 271, 272, 273, 276, 277, 282, 294, 295, 296, 297, 298, 299, 300, 301, 304, 320, 325, 326, 329, 333, 339, 340, 342, 353, 358, 359, 364, 368, 369, 370, 384, 385, 392, 394, 488], "rozan": 273, "rp": 110, "rpd": 70, "rpd_": 70, "rrna": [1, 264], "rt": [110, 121], "rtol": 488, "rubbbbrbcefgh": 119, "rule": [44, 111, 118, 120, 121, 479], "run": [1, 3, 53, 82, 84, 85, 86, 112, 119, 120, 185, 200, 216, 222, 259, 296, 297, 298, 300, 301, 304, 311, 321, 508, 513], "run_numb": 119, "runtim": [111, 184, 215, 221, 501, 513], "runtimeerror": 54, "rvrywstlnepwvfsnsgyalgtnapgrcsasnvakpgdsgtgpyivthnqi": 110, "rvsrv": 121, "rx": 110, "rykmbdhvn": [211, 212], "r\u00e9nyi": 72, "s1": [0, 1, 184, 213, 215, 221, 228, 229, 230, 231, 234, 239, 240, 241, 242, 259, 264, 296, 300, 345, 346, 347, 349, 351, 352, 355, 356, 362, 363, 364, 365, 366, 368, 370, 373, 374, 379, 380, 381, 382, 384, 386, 387, 388, 389, 391, 394, 395, 397], "s12064": [269, 275], "s2": [0, 1, 229, 231, 259, 264, 296, 300, 345, 346, 347, 349, 352, 355, 356, 362, 363, 364, 365, 366, 368, 370, 373, 374, 379, 380, 381, 382, 384, 386, 387, 388, 389, 391, 394, 395, 397], "s3": [259, 264, 296, 300, 345, 346, 347, 349, 355, 356, 363, 364, 365, 366, 370, 373, 374, 380, 381, 382, 384, 386, 387, 388, 389, 391, 394, 395, 397], "s4": [259, 264, 296, 300, 346, 347, 349, 355, 364], "s46826": 110, "s5": [259, 264, 296, 300, 349, 364], "s6": [259, 264, 300, 349], "s7": [300, 349], "s8": 349, "s9": 349, "s_": [1, 44, 47, 58, 60, 67, 79, 81], "s_1": [413, 415], "s_2": [413, 415], "s_i": 273, "sa": 121, "sacc": [106, 107], "saccver": [106, 107], "safe": [1, 53, 82, 84, 85, 86, 120, 331, 403], "safe_char": 116, "saga": [151, 153, 228], "sagb": [151, 153], "sagc": 151, "sai": [149, 151, 340], "saitou": 480, "sallacc": [106, 107], "sallgi": [106, 107], "sallseqid": [106, 107], "salltitl": [106, 107], "salmo": [111, 118], "salvemini": 55, "sam": 11, "sam_id": 369, "same": [1, 20, 22, 23, 24, 27, 29, 31, 43, 49, 53, 58, 60, 70, 71, 77, 84, 85, 100, 101, 102, 103, 109, 111, 112, 113, 114, 116, 119, 121, 123, 151, 158, 162, 164, 177, 178, 182, 188, 191, 193, 197, 199, 207, 210, 214, 225, 228, 229, 231, 235, 239, 240, 241, 242, 248, 254, 255, 259, 264, 277, 279, 280, 281, 286, 288, 293, 294, 296, 297, 298, 299, 300, 301, 304, 318, 323, 325, 326, 330, 331, 333, 339, 340, 341, 342, 348, 356, 379, 395, 407, 408, 412, 413, 425, 460, 475, 477, 479, 480, 488, 497, 508, 511], "samp_id": [362, 364], "sampl": [1, 43, 44, 45, 46, 49, 51, 52, 53, 54, 55, 56, 57, 58, 59, 61, 62, 63, 64, 65, 66, 67, 70, 71, 72, 73, 74, 75, 76, 77, 79, 80, 81, 82, 83, 84, 85, 86, 87, 90, 103, 104, 105, 120, 176, 256, 259, 264, 277, 296, 297, 299, 300, 306, 310, 316, 317, 318, 320, 321, 323, 325, 326, 331, 332, 333, 336, 338, 339, 340, 343, 344, 345, 346, 347, 348, 349, 351, 352, 355, 356, 357, 358, 360, 362, 363, 364, 365, 366, 368, 369, 370, 371, 372, 373, 374, 375, 376, 378, 379, 381, 382, 384, 385, 386, 387, 388, 389, 390, 391, 392, 394, 395, 396, 397, 412, 482, 489, 509], "sample1": [353, 359], "sample2": [353, 359], "sample3": 359, "sample4": 359, "sample5": 359, "sample6": 359, "sample_constraint": 320, "sample_count": [339, 340], "sample_gen": 369, "sample_group_metadata": 342, "sample_id": [342, 369, 377, 382], "sample_index": 342, "sample_map": 360, "sample_md": 1, "sample_metadata": [120, 176, 342, 352], "sample_metadata_f": 373, "sample_nam": 120, "sample_typ": [356, 381], "samplea": 318, "sampleb": 318, "samplec": 318, "sampleid": [120, 357], "samplemetadata": 120, "samplerecord": 113, "samtool": 11, "samv1": 11, "sanger": 112, "sapien": 111, "sapiensaccggttggc": 118, "satisfi": [123, 156, 331, 338, 504], "save": [19, 151, 176, 181, 277, 308, 313, 315, 408], "sb": 35, "sbc": 121, "sbjct": 107, "sbjctframe": 107, "sblastnam": [106, 107], "sbp": 273, "scalar": [20, 48, 245, 247, 267, 272, 276, 277, 321, 372, 376], "scale": [51, 297, 325, 326, 327, 333, 412, 415], "scale_i": 333, "scandinavian": 47, "scatter": 321, "scatterplot": [320, 321], "scenario": [109, 259, 472], "scheme": [122, 145, 166, 169, 170, 176, 181, 183, 283], "schmidt": [265, 266], "schneider": 23, "schoch": 122, "school": 110, "schwartz": 248, "sci": [37, 40, 107, 273], "scienc": [45, 46, 53, 108, 111, 248, 326, 413, 484], "sciencedirect": 108, "scientif": [106, 120, 291, 319, 331], "sciki": 111, "scikit": [0, 1, 30, 34, 35, 38, 41, 42, 53, 84, 85, 86, 87, 88, 89, 90, 93, 94, 105, 106, 107, 108, 110, 111, 112, 116, 117, 118, 119, 121, 122, 157, 159, 171, 172, 174, 175, 186, 188, 189, 190, 191, 193, 194, 218, 220, 223, 225, 226, 227, 243, 246, 253, 284, 290, 319, 322, 324, 383, 398, 400, 451, 472, 476, 496, 508, 512], "scipi": [1, 54, 83, 86, 89, 101, 254, 259, 264, 274, 277, 285, 291, 292, 295, 297, 298, 304, 336, 339, 340, 351, 382, 392, 412, 415, 416, 428, 441, 482, 484, 485], "scomnam": [106, 107], "scope": [53, 513], "score": [0, 11, 19, 23, 35, 36, 37, 38, 39, 40, 41, 42, 48, 106, 107, 111, 113, 114, 119, 228, 247, 249, 251, 320, 333, 415, 508], "score_filt": 19, "score_onli": 19, "score_s": 19, "sdr": 60, "sdrhelp": 60, "se": 121, "sea": 45, "search": [20, 35, 106, 107, 111, 156, 165, 180, 185, 200, 216, 222, 234, 277, 326, 351, 363, 366, 374, 397, 400, 410, 419, 424, 425, 426, 427, 431, 440, 447, 448, 449, 469, 494, 508], "sec": 215, "second": [1, 18, 19, 20, 35, 36, 37, 38, 39, 40, 41, 109, 112, 118, 123, 127, 149, 153, 191, 259, 277, 340, 407, 408, 434, 467, 506, 513], "secondari": [340, 359], "section": [29, 111, 112, 117, 120, 121, 176, 191, 228, 297, 298, 325, 326, 506], "sediment": 45, "see": [1, 28, 29, 30, 34, 41, 53, 61, 62, 70, 82, 84, 85, 86, 87, 89, 90, 93, 94, 107, 110, 111, 112, 116, 118, 119, 120, 122, 123, 148, 157, 159, 162, 173, 176, 186, 190, 191, 194, 218, 220, 223, 227, 228, 231, 243, 246, 264, 265, 266, 277, 284, 290, 294, 296, 297, 298, 299, 300, 301, 304, 318, 319, 321, 322, 324, 331, 333, 335, 336, 338, 339, 340, 341, 342, 373, 383, 398, 399, 402, 406, 413, 415, 416, 423, 424, 425, 435, 446, 450, 451, 452, 453, 454, 456, 457, 458, 459, 468, 470, 471, 472, 475, 476, 482, 485, 496, 506, 507, 513], "seed": [61, 62, 264, 294, 296, 298, 299, 300, 301, 302, 304, 318, 331, 336, 338, 339, 340, 341, 388, 412, 460, 482, 496], "seem": 339, "seen": [110, 113, 340], "segment": [3, 5, 9, 14, 55], "select": [20, 49, 70, 75, 120, 264, 300, 338, 339, 388, 460, 462, 478, 496], "selenocystein": 215, "self": [11, 91, 95, 125, 127, 140, 141, 142, 143, 151, 155, 160, 171, 174, 214, 228, 277, 278, 279, 288, 289, 323, 342, 345, 349, 353, 364, 370, 372, 373, 376, 385, 388, 394, 397, 400, 401, 402, 405, 407, 408, 409, 413, 415, 417, 420, 421, 422, 423, 424, 425, 433, 435, 439, 442, 444, 445, 446, 452, 455, 456, 461, 462, 463, 465, 466, 467, 468, 470, 473, 474, 475, 501, 502, 511, 513], "self_aft": 469, "self_befor": 469, "semi": 116, "semicolon": [111, 114], "send": [106, 107], "sens": [326, 340, 467], "sensit": [111, 120, 238], "sep": 110, "separ": [1, 106, 107, 109, 111, 112, 114, 115, 116, 117, 118, 120, 300, 302, 326, 357, 360, 407, 412], "seq": [0, 3, 8, 18, 20, 25, 26, 31, 32, 33, 35, 36, 37, 38, 39, 40, 106, 107, 108, 111, 112, 114, 118, 119, 171, 172, 174, 175, 189, 194, 195, 199, 208, 210, 214, 226, 228, 233, 244, 245, 264, 318, 513], "seq1": [0, 20, 21, 24, 31, 35, 36, 37, 38, 39, 40, 108, 111, 112, 118, 121, 254, 255], "seq2": [0, 20, 21, 24, 31, 35, 36, 37, 38, 39, 40, 111, 112, 121, 254, 255], "seq3": [20, 24, 111, 118], "seq4": 111, "seq5": 111, "seq_1": 114, "seq_2": 114, "seq_gen": 506, "seq_gener": 199, "seq_id": 114, "seq_idx": 20, "seq_num": [111, 112, 113, 114, 119], "seqid": 114, "seqr": 113, "sequenc": [1, 3, 4, 5, 6, 9, 10, 11, 14, 16, 18, 19, 20, 21, 22, 24, 25, 26, 27, 28, 29, 31, 32, 33, 35, 36, 37, 38, 39, 40, 41, 95, 96, 97, 98, 99, 106, 107, 108, 109, 110, 112, 113, 114, 119, 122, 149, 151, 153, 171, 172, 174, 264, 277, 302, 318, 340, 505, 506, 513], "sequence1": 41, "sequence2": 41, "sequenceprocessor": 513, "sequencevector": [97, 100], "sequenti": [80, 109, 111, 112, 118, 273, 274, 321, 470], "ser": 215, "seri": [1, 32, 82, 114, 148, 162, 166, 170, 173, 259, 264, 295, 296, 297, 299, 300, 305, 320, 336], "serial": [115, 176, 276, 320, 506], "serin": 215, "serv": [0, 122, 319, 321, 456, 458, 499], "server": [35, 36, 37, 38, 39, 40, 122], "set": [4, 13, 16, 19, 20, 22, 25, 28, 29, 53, 70, 84, 85, 90, 111, 113, 115, 118, 124, 145, 151, 154, 160, 165, 171, 174, 180, 182, 184, 195, 215, 221, 228, 229, 233, 235, 238, 245, 248, 256, 268, 283, 289, 304, 318, 331, 333, 336, 338, 339, 340, 348, 349, 356, 388, 390, 404, 407, 408, 409, 412, 413, 415, 417, 423, 431, 435, 446, 452, 456, 457, 458, 462, 463, 468, 473, 475, 479, 480, 482, 483, 485, 492, 494, 508, 513], "set1": 321, "set_index": 429, "setminu": 413, "setter": 150, "setup": 513, "seven": 259, "sever": [53, 116, 118, 336], "sex": [338, 339], "sffaaa": 112, "sfprgfifgagssayqfegavneggrgpsiwdtfthkypekirdgsnaditv": 110, "sframe": [106, 107], "sg": [189, 194, 226], "sgc": [193, 194], "sgi": [106, 107], "shallow": [20, 151, 160, 171, 174, 228, 400, 417, 473], "shannon": [23, 57, 58, 71, 72, 81], "shannon_entropi": 23, "shape": [3, 4, 5, 6, 8, 9, 10, 14, 15, 16, 20, 25, 102, 104, 117, 257, 258, 260, 261, 262, 263, 265, 266, 267, 268, 269, 270, 271, 272, 273, 275, 277, 298, 327, 330, 341, 342, 358, 359, 392, 399], "share": [19, 29, 44, 171, 172, 174, 175, 182, 228, 229, 319, 411, 412, 413, 414, 415, 416, 482, 483, 485, 511], "shared_by_al": [482, 483, 485], "shared_onli": 414, "shear": 450, "sheet": 120, "shift": 153, "shkolniski": 331, "short": 513, "short_cicruit": 501, "short_circuit": 501, "short_method_nam": [320, 489], "shorter": 118, "should": [1, 19, 23, 42, 43, 49, 53, 54, 67, 70, 79, 82, 83, 84, 85, 86, 106, 113, 117, 120, 122, 123, 125, 126, 127, 149, 151, 164, 176, 178, 184, 191, 207, 215, 221, 231, 235, 236, 237, 255, 257, 258, 259, 269, 275, 292, 298, 300, 304, 318, 325, 326, 332, 333, 336, 339, 340, 343, 344, 353, 388, 394, 397, 407, 408, 416, 429, 435, 456, 457, 458, 463, 469, 473, 475, 480, 496, 497], "shouldn": 326, "show": [1, 151, 336, 511], "show_intern": 403, "shown": [149, 259, 325], "shrink": 264, "shtml": 111, "shuffl": [412, 482], "shuffle_f": [412, 460], "shuffler": [412, 460, 482], "siam": 331, "sibl": [116, 229, 400], "side": [70, 298, 301, 304, 407, 408, 472], "sidewai": 400, "sigh": 505, "sign": [120, 259, 489], "signatur": [87, 146, 348, 358, 392], "signific": [1, 120, 259, 264, 296, 298, 299, 300, 301, 304, 339, 340], "significance_test": 259, "significantli": [1, 28, 259, 296, 299, 300, 431], "silent": [53, 84, 85, 364, 410], "silpl": 193, "simd": [19, 41], "similar": [35, 36, 37, 38, 39, 40, 83, 107, 110, 111, 112, 115, 118, 120, 123, 228, 247, 296, 297, 298, 299, 300, 319, 326, 331, 333, 339, 340, 412, 415, 508, 511], "similarli": [0, 1, 20, 111, 508], "simpl": [106, 107, 111, 112, 116, 120, 121, 123, 130, 140, 270, 297, 304, 480, 506, 511], "simpler": 0, "simplex": [257, 265, 266, 273], "simpli": [20, 23, 29, 79, 123, 191, 285, 331, 336, 513], "simplifi": 55, "simpson": [49, 51, 58, 59, 72, 76, 77, 81], "simpson_": 76, "simul": [256, 336, 339, 340, 415], "simultan": [331, 468], "sinc": [1, 20, 21, 24, 32, 41, 42, 55, 90, 110, 111, 113, 118, 120, 122, 149, 193, 228, 233, 259, 298, 336, 340, 420, 464, 474, 480, 483, 492, 513], "singl": [1, 20, 21, 24, 31, 53, 61, 62, 69, 84, 85, 87, 109, 110, 111, 112, 113, 116, 118, 119, 120, 121, 148, 149, 151, 153, 162, 173, 176, 208, 228, 233, 235, 247, 259, 273, 304, 337, 348, 349, 358, 373, 400, 406, 407, 415, 436, 450, 453, 454, 458, 459, 462, 468, 485, 504, 506, 511, 513], "singleton": [1, 44, 47, 48, 52, 54, 56, 69, 73, 78, 123], "singular": [1, 103, 300, 331, 335, 504], "sinica": 44, "site": [1, 113, 117, 235, 319, 320, 321, 331], "site0": 117, "site1": [117, 319], "site10": 319, "site2": [117, 319], "site3": [117, 319], "site4": [117, 319], "site5": [117, 319], "site6": [117, 319], "site7": [117, 319], "site8": [117, 319], "site9": [117, 319], "sitemap": 113, "situat": [1, 321, 338, 407], "six": [117, 189, 191, 194, 226, 259], "sixth": [415, 485], "size": [20, 51, 264, 277, 296, 297, 298, 300, 317, 318, 321, 330, 336, 338, 339, 340, 348, 358, 392, 477, 481, 484, 500], "sk": 120, "sk_read": 506, "skbio": [120, 505], "skbio_func1": 496, "skbio_func2": 496, "skin": [1, 321], "skip": [235, 296, 298, 299, 300, 304, 358, 410], "skip_subregion": 114, "sklearn": 86, "slen": [106, 107], "slice": [20, 185, 200, 216, 222, 228, 232, 235, 244, 276, 277, 342, 400, 508], "slightli": [35, 60, 300, 480], "slope": 60, "slow": [1, 53, 82, 84, 85, 86], "slower": 0, "sm": 245, "small": [1, 49, 115, 121, 256, 268, 331, 333], "smaller": [58, 79, 235, 301, 407, 408], "smallest": [80, 118, 339, 340, 382], "smith": [0, 19, 38, 39, 40, 41, 304], "snif": 506, "sniff": 506, "sniffer": [104, 105, 106, 107, 108, 109, 110, 111, 112, 113, 114, 115, 116, 117, 118, 119, 120, 121, 122, 123, 124, 132, 136, 138, 141, 142, 506], "sniffer_funct": 124, "so": [1, 3, 11, 23, 35, 36, 37, 38, 39, 40, 42, 53, 82, 84, 85, 86, 111, 116, 120, 123, 145, 146, 151, 211, 212, 298, 316, 319, 325, 326, 327, 333, 336, 338, 339, 340, 390, 479, 480, 482, 506, 511, 513], "sob": [1, 43, 58, 68, 69, 81], "societi": 70, "softwar": [1, 111, 112, 120, 393, 505], "sokal": [412, 416, 484], "sole": [120, 177], "solexa": 112, "solut": 54, "solv": [54, 336], "some": [1, 19, 43, 53, 55, 67, 70, 96, 111, 113, 116, 119, 120, 125, 126, 127, 149, 155, 184, 215, 221, 258, 270, 271, 272, 326, 331, 336, 339, 409, 412, 415, 439, 450, 459, 468, 501, 511, 513], "someformat": 506, "someskbioclass": [123, 506], "someth": [30, 34, 93, 94, 123, 126, 136, 138, 139, 141, 142, 143, 157, 159, 186, 190, 218, 220, 223, 227, 243, 246, 284, 290, 322, 324, 353, 383, 398, 451, 476, 513], "sometim": [49, 111, 113, 120, 326, 506], "somewhat": 304, "sonnhamm": 121, "soppos": 110, "sort": [25, 29, 88, 89, 149, 151, 199, 233, 245, 310, 316, 318, 348, 387, 388, 407, 408, 462, 463, 466, 467, 479, 508, 513], "sort_categori": [305, 306, 309, 310, 316], "sort_f": 386, "sort_index": 32, "sorted_t": 387, "sourc": [3, 4, 5, 6, 7, 8, 9, 10, 14, 15, 16, 17, 18, 20, 21, 22, 23, 24, 25, 26, 27, 28, 29, 30, 31, 32, 33, 34, 35, 36, 37, 38, 39, 40, 41, 42, 44, 45, 46, 47, 48, 49, 50, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 71, 72, 73, 74, 75, 76, 77, 78, 79, 80, 81, 82, 84, 85, 86, 87, 88, 89, 90, 91, 92, 93, 94, 95, 96, 97, 98, 99, 100, 101, 102, 103, 110, 111, 113, 114, 124, 125, 126, 127, 128, 129, 130, 131, 132, 133, 134, 135, 136, 137, 138, 139, 140, 141, 142, 143, 145, 146, 147, 148, 149, 150, 151, 152, 153, 154, 155, 156, 157, 158, 159, 160, 161, 162, 163, 164, 165, 166, 167, 168, 169, 170, 171, 172, 173, 174, 175, 176, 177, 178, 179, 180, 181, 182, 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, 193, 194, 195, 196, 197, 198, 199, 200, 201, 202, 203, 204, 205, 206, 207, 208, 209, 210, 211, 212, 213, 214, 215, 216, 217, 218, 219, 220, 221, 222, 223, 224, 225, 226, 227, 228, 229, 230, 231, 232, 233, 234, 235, 236, 237, 238, 239, 240, 241, 242, 243, 244, 245, 246, 247, 248, 249, 250, 251, 252, 254, 255, 257, 258, 259, 260, 261, 262, 263, 264, 265, 266, 267, 268, 269, 270, 271, 272, 273, 274, 275, 277, 278, 279, 280, 281, 282, 283, 284, 285, 286, 287, 288, 289, 290, 291, 292, 293, 294, 295, 296, 297, 298, 299, 300, 301, 302, 304, 306, 307, 308, 309, 310, 311, 312, 313, 314, 315, 316, 317, 318, 320, 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, 331, 332, 333, 334, 335, 337, 338, 339, 340, 341, 342, 343, 344, 345, 346, 347, 348, 349, 350, 351, 352, 353, 354, 355, 356, 357, 358, 359, 360, 361, 362, 363, 364, 365, 366, 367, 368, 369, 370, 371, 372, 373, 374, 375, 376, 377, 378, 379, 380, 381, 382, 383, 384, 385, 386, 387, 388, 389, 390, 391, 392, 393, 394, 395, 396, 397, 398, 399, 400, 401, 402, 403, 404, 405, 406, 407, 408, 409, 410, 411, 412, 413, 414, 415, 416, 417, 418, 419, 420, 421, 422, 423, 424, 425, 426, 427, 428, 429, 430, 431, 432, 433, 434, 435, 436, 437, 438, 439, 440, 441, 442, 443, 444, 445, 446, 447, 448, 449, 450, 451, 452, 453, 454, 455, 456, 457, 458, 459, 460, 461, 462, 463, 464, 465, 466, 467, 468, 469, 470, 471, 472, 473, 474, 475, 476, 477, 478, 479, 480, 481, 482, 483, 484, 485, 486, 487, 488, 489, 490, 491, 492, 493, 494, 495, 496, 497, 498, 499, 500, 501, 502, 503, 504, 505], "space": [1, 102, 111, 116, 118, 120, 121, 151, 153, 256, 257, 258, 262, 263, 265, 266, 310, 319, 320, 321, 325, 332, 348], "spaitial": 300, "span": [7, 53, 70, 87, 111, 113, 116, 149, 156, 348, 458], "spars": [105, 265, 266, 274, 325, 333, 342, 351, 358, 368, 369, 370, 390, 392], "sparse_vector": 348, "sparsedatafram": 391, "spatial": [1, 83, 86, 89, 101, 254, 277, 285, 291, 292, 295, 300, 412, 415, 482, 485], "spearman": [1, 297, 298, 301], "spearmanr": [297, 298], "spec": [11, 176], "specfi": 513, "speci": [1, 43, 44, 51, 53, 56, 58, 59, 60, 65, 70, 74, 75, 79, 80, 81, 117, 122, 264, 270, 319, 326, 331, 333], "special": [3, 11, 14, 19, 20, 72, 81, 91, 95, 96, 97, 98, 99, 115, 123, 124, 128, 148, 149, 151, 160, 162, 171, 173, 174, 176, 184, 191, 195, 209, 215, 221, 228, 247, 277, 291, 306, 307, 309, 310, 312, 314, 316, 317, 320, 342, 358, 392, 400, 486, 491, 492, 501, 503, 504], "speciat": 304, "specie1": 319, "specie2": 319, "specie3": 319, "specie4": 319, "specie5": 319, "specie6": 319, "specie7": 319, "specie8": 319, "specie9": 319, "species0": 117, "species1": 117, "species2": 117, "species3": 117, "species4": 117, "species5": 117, "species6": 117, "species7": 117, "species8": 117, "species_a": 405, "species_divers": 43, "species_even": 43, "species_rich": 43, "speciesa": 405, "specif": [48, 53, 60, 82, 84, 85, 86, 87, 90, 123, 156, 162, 228, 304, 310, 311, 339, 340, 342, 348, 358, 392, 400, 410, 413, 460, 472, 497, 506, 512, 513], "specifi": [20, 27, 29, 70, 90, 96, 106, 108, 109, 111, 112, 113, 114, 115, 118, 121, 122, 123, 145, 149, 151, 154, 156, 180, 181, 184, 185, 188, 192, 193, 195, 200, 215, 216, 221, 222, 225, 228, 233, 238, 257, 258, 259, 264, 265, 266, 268, 274, 277, 278, 280, 282, 283, 286, 289, 296, 297, 298, 299, 300, 304, 317, 321, 323, 330, 331, 337, 342, 345, 348, 358, 362, 364, 385, 392, 410, 412, 413, 416, 435, 456, 457, 460, 467, 468, 473, 474, 475, 479, 482, 496, 501, 503, 504, 513], "speed": [151, 331], "spermatophyta": 110, "sph": 11, "sphingobacteria": [430, 467], "split": [20, 111, 112, 118, 121, 407], "spmatrix": [342, 351], "spreadsheet": [115, 120], "sqcup": [53, 70], "sqlite": 180, "sqrt": [52, 64, 65, 66, 273, 333, 412, 415], "squar": [66, 67, 86, 116, 247, 277, 291, 328, 412, 415, 478, 482], "squareform": [277, 295], "sr1": 191, "srava": 121, "ss": [121, 388], "ss_con": 121, "sscinam": [106, 107], "sseq": [106, 107], "sseqid": [106, 107], "sskingdom": [106, 107], "sstart": [106, 107], "sstrand": [106, 107], "ssw": [11, 19, 41], "stabl": [278, 289, 404, 433, 441, 496], "stackoverflow": 500, "stai": 120, "stale": 151, "stamataki": 405, "stand": [212, 298], "standalon": 111, "standard": [111, 112, 114, 116, 120, 188, 189, 191, 193, 194, 225, 226, 245, 256, 259, 277, 297, 298, 327, 330, 333, 334, 409, 506, 508], "standard_norm": [336, 339, 340], "standardis": 51, "staphylococcu": 345, "start": [0, 3, 4, 5, 6, 7, 9, 10, 12, 13, 14, 16, 18, 19, 20, 21, 24, 31, 35, 36, 37, 38, 39, 40, 41, 96, 106, 107, 110, 113, 114, 115, 116, 118, 121, 122, 149, 152, 158, 174, 191, 193, 194, 230, 234, 277, 301, 302, 336, 339, 340, 368, 400, 404, 475, 513], "start_end_posit": 0, "stat": [0, 1, 3, 20, 21, 22, 24, 28, 29, 32, 67, 96, 97, 101, 103, 104, 108, 109, 110, 111, 112, 113, 114, 115, 117, 118, 119, 121, 174, 184, 187, 188, 189, 191, 193, 194, 195, 197, 199, 210, 214, 215, 221, 224, 225, 226, 228, 229, 247, 253, 382, 505, 508], "state": [3, 4, 5, 6, 8, 9, 10, 14, 17, 18, 70, 108, 118, 120, 145, 501, 502, 504, 513], "static": [195, 357, 360], "statis": [296, 299], "statist": [1, 44, 47, 52, 60, 67, 72, 73, 81, 257, 259, 264, 296, 298, 299, 300, 301, 304, 319, 325, 326, 330, 336, 339, 340, 478, 484, 505], "statistica": [44, 55], "statsmodel": [259, 264, 336], "statu": [3, 14, 338, 339, 487, 493], "staxid": [106, 107], "std": [110, 330, 334, 339], "steel": [412, 480], "steep": 325, "step": [1, 20, 21, 24, 31, 53, 82, 84, 85, 86, 118, 123, 174, 329], "still": [20, 116, 117, 145, 150, 259, 264, 268, 298, 452, 472], "stimat": 334, "stitl": [106, 107], "stochast": 496, "stockholm": [30, 34], "stockholm_format": 121, "stombaugh": [84, 85], "stool": 340, "stop": [20, 21, 24, 31, 44, 96, 97, 109, 118, 174, 188, 189, 191, 193, 194, 215, 217, 225, 226, 230, 234, 342, 399, 405, 501, 508], "stop_char": 215, "storag": [151, 390], "store": [2, 20, 28, 104, 105, 106, 107, 108, 109, 110, 111, 112, 113, 115, 116, 117, 118, 119, 120, 121, 122, 149, 151, 171, 172, 174, 175, 176, 183, 184, 195, 215, 221, 228, 276, 277, 285, 291, 301, 307, 312, 314, 320, 325, 326, 331, 333, 348, 358, 392, 400, 507, 508], "str": [11, 16, 18, 19, 20, 30, 34, 42, 82, 86, 87, 88, 89, 90, 91, 93, 94, 95, 96, 97, 98, 99, 101, 106, 113, 114, 121, 124, 131, 132, 133, 136, 137, 138, 139, 141, 142, 143, 145, 157, 159, 162, 164, 167, 176, 177, 178, 179, 180, 181, 184, 185, 186, 190, 191, 195, 199, 200, 207, 213, 215, 216, 218, 220, 221, 222, 223, 227, 228, 230, 231, 232, 233, 234, 236, 238, 239, 240, 241, 242, 243, 244, 245, 246, 248, 250, 259, 264, 269, 274, 277, 278, 280, 282, 283, 284, 289, 290, 296, 297, 299, 300, 301, 302, 307, 310, 312, 314, 320, 321, 322, 323, 324, 331, 338, 339, 342, 345, 348, 351, 352, 353, 355, 357, 358, 362, 366, 374, 382, 383, 390, 392, 393, 394, 398, 400, 403, 407, 408, 409, 410, 412, 415, 416, 424, 425, 435, 439, 451, 456, 457, 458, 459, 462, 463, 468, 473, 475, 476, 479, 482, 483, 485, 486, 487, 490, 493, 495], "straight": 1, "straightforward": [120, 508], "strand": [106, 107, 113, 114, 121, 149, 187, 188, 189, 224], "stranded": 113, "strategi": [256, 268, 480], "stream": [111, 114], "strength": 1, "streptophyta": 110, "strict": [29, 118, 229, 280, 286, 298, 301, 304, 323, 348, 397, 436, 459], "strict_match": [338, 339], "stricter": [116, 488], "strictli": [111, 259, 264, 274, 406], "string": [1, 3, 11, 14, 16, 18, 19, 20, 82, 86, 87, 90, 92, 98, 99, 104, 108, 109, 111, 112, 116, 118, 120, 121, 169, 170, 176, 183, 191, 208, 228, 232, 233, 238, 244, 245, 247, 259, 264, 276, 277, 281, 293, 296, 299, 300, 302, 320, 321, 353, 356, 382, 393, 394, 397, 400, 403, 467, 480, 490, 511], "stringifi": 342, "stringio": [1, 84, 85, 106, 107, 108, 110, 111, 112, 113, 114, 116, 117, 118, 119, 121, 122, 145, 276, 357, 360, 506, 511], "strip": 405, "stripe": [19, 41], "stripedsmithwaterman": [0, 41], "strong": [1, 184, 296, 298, 304], "struct": [11, 113], "structur": [3, 84, 85, 107, 109, 113, 116, 122, 248, 277, 296, 297, 304, 319, 342, 348, 358, 392, 399, 400, 463, 501], "studi": [1, 53, 120, 176, 256, 259, 319, 325, 333, 340, 458], "style": [256, 473, 474, 475], "su": 121, "sub": [113, 114, 149, 341], "subclass": [29, 100, 101, 102, 103, 108, 111, 118, 121, 123, 162, 228, 229, 247, 276, 277, 302, 479, 501], "subfold": 495, "subject": [1, 106, 107, 120, 456, 457, 473, 507, 513], "subject1": 107, "subject2": 107, "sublist": 340, "submit": [110, 111, 340], "submodul": 123, "suboptim": [11, 19], "suboptimal_alignment_scor": 11, "subsampl": [67, 318, 336, 339, 340, 341, 412, 482], "subsample_count": [67, 318], "subsample_paired_pow": 340, "subsample_pow": 336, "subseq": [228, 235], "subsequ": [38, 108, 111, 120, 228, 230, 234, 235, 256, 419, 431, 480, 501, 508], "subset": [53, 70, 84, 85, 90, 104, 110, 297, 358, 364, 388, 407, 408, 409, 413, 414, 415, 458, 459, 468, 511], "subset_with_metadata": 358, "subsitut": 245, "substitut": [19, 35, 36, 37, 38, 39, 40, 42, 115, 215, 245, 247, 248, 249, 250, 251, 252, 256, 508], "substitution_matrix": [19, 35, 36, 37, 38, 39, 40], "substitutionmatrix": [42, 245, 508], "substract": [35, 36, 37, 38, 39, 40, 329], "substrat": 319, "substrate_cor": 319, "substrate_oth": 319, "substrate_sand": 319, "subtili": 121, "subtract": [19, 317], "subtre": [116, 122, 406, 408, 413, 415, 416, 417, 426, 427, 436, 439, 441, 463, 477, 481, 484, 511], "success": [501, 513], "success_callback": [501, 513], "success_f": 513, "successfulli": 405, "suffic": [482, 485], "suffix": 43, "sugar": 20, "suggest": [19, 126, 136, 138, 141, 142, 331, 339], "suit": 326, "sum": [44, 53, 64, 65, 67, 70, 109, 153, 233, 258, 262, 263, 267, 340, 341, 368, 369, 373, 378, 388, 409, 412, 415, 416, 421, 422, 433, 441, 466, 478, 480, 482, 485, 500], "sum_": [46, 49, 51, 53, 55, 58, 59, 70, 72, 74, 75, 81, 256, 258, 270, 271, 272, 298, 415], "summar": 259, "summari": [20, 259, 277, 378], "super": [106, 107], "superkingdom": 122, "superset": [53, 70, 84, 85, 296, 300], "supplementari": [112, 259], "suppli": [19, 106, 111, 119, 136, 141, 177, 231, 253, 340, 348], "support": [1, 2, 23, 30, 34, 55, 145, 148, 157, 159, 173, 176, 177, 184, 186, 190, 215, 218, 220, 221, 223, 227, 243, 246, 247, 248, 259, 264, 284, 290, 298, 320, 322, 324, 331, 336, 342, 348, 375, 383, 398, 400, 405, 435, 451, 456, 457, 458, 471, 473, 475, 476, 479, 492, 496, 501, 504, 509, 510, 511, 512, 513], "support_attr": 479, "support_valu": 479, "suppos": [106, 107, 110, 111, 112, 113, 116, 119, 121, 270, 336, 340], "suppress": [122, 296, 300, 301, 431], "suppress_sequ": [11, 19, 41], "sure": [293, 340, 513], "surfac": 416, "surpass": 118, "surround": [116, 264], "survei": 1, "sv": 110, "svd": [103, 335], "svg": [320, 486], "sw": [19, 338], "swab": 1, "swiss": 110, "switch": [302, 342, 412, 460], "sy": [146, 499], "symbiont": 304, "symbol": [23, 111], "symmetr": [1, 247, 276, 277, 291, 293, 298, 302, 304, 325, 413, 482, 483, 485], "symmetri": [276, 277, 291, 293, 294], "symposium": 72, "symptom": 340, "syn": 113, "synonym": [1, 122], "syntact": 20, "syntax": 20, "synthesi": 121, "synthet": 113, "system": [30, 34, 63, 74, 93, 94, 120, 122, 123, 151, 157, 159, 186, 190, 218, 220, 223, 227, 243, 246, 284, 290, 322, 324, 339, 364, 383, 398, 400, 451, 476], "systemat": [70, 412, 482, 484], "t": [1, 8, 19, 20, 21, 23, 24, 25, 28, 29, 33, 41, 51, 53, 55, 70, 82, 84, 85, 86, 110, 111, 112, 113, 114, 115, 117, 119, 120, 121, 122, 146, 149, 181, 184, 187, 193, 202, 203, 204, 205, 211, 212, 215, 221, 224, 228, 230, 231, 233, 239, 240, 241, 242, 247, 251, 257, 259, 264, 265, 266, 269, 270, 274, 277, 301, 325, 326, 331, 333, 335, 338, 340, 345, 353, 358, 359, 375, 382, 392, 395, 407, 456, 457, 458, 465, 466, 473, 479, 491, 506, 508, 512, 513], "t0": [106, 107, 114, 117, 119, 276], "t1": [106, 107, 117, 119, 122, 276, 357, 456], "t10": [114, 117], "t100": [106, 107], "t10596": 107, "t1217": 107, "t1233": 107, "t131567": 122, "t1566": 107, "t161": 106, "t2": [117, 119, 357, 360, 456], "t2130": 107, "t2214": 107, "t3": [119, 357, 360], "t30": [114, 119], "t329": 106, "t330": 106, "t335928": 122, "t34": 119, "t35": 119, "t3e": [106, 107], "t4": 117, "t42": 107, "t44": 107, "t5": 360, "t50": 114, "t5565": 107, "t5587": 107, "t5671": 107, "t6": 360, "t6821": 107, "t6928": 107, "t6e": 107, "t80": 114, "t811": 107, "t8468": 107, "t8552": 107, "t8e": 107, "t9": 117, "t90": 114, "t94": 107, "t96": 114, "t99": 106, "t9e": 106, "t_1": [412, 413, 415], "t_2": [412, 413, 415], "t_a": 373, "t_b": 373, "ta": [276, 508], "taaactatta": 110, "taaactccgg": 110, "taacaatcct": 110, "taacatatac": 112, "taacgtta": [187, 224], "taagactaaa": 110, "taatgaatgg": 110, "tab": [106, 107, 114, 115, 116, 117, 119, 120, 122, 352, 357, 360, 394], "tabl": [1, 82, 86, 105, 112, 113, 120, 122, 180, 188, 189, 191, 192, 193, 194, 225, 226, 259, 264, 319, 325, 326, 332, 333, 419, 424, 425, 431, 501, 505, 507, 508], "table2": 395, "table3": 395, "table_id": [192, 342, 399], "tableexcept": [342, 384, 397, 399], "tabular": [3, 7, 20, 26, 106, 107, 120, 122, 176], "tabularmsa": [0, 3, 7, 8, 14, 35, 36, 37, 38, 39, 40, 41, 108, 112, 118, 121, 151, 506], "tac": 119, "tacatcgttt": 110, "tacatgtgta": 110, "taccaggcat": 110, "tacccggt": 508, "tacctaagtt": 110, "tacg": 119, "tacgta": 119, "tae000111": 107, "tae000171": 107, "tae000174": 107, "tae000425": 107, "tag": [114, 121, 199, 208, 273], "tagagattaattgccactgccaaaattctg": 0, "tagattacag": 110, "taggttgatc": 110, "tagtgaatgg": 110, "take": [1, 86, 118, 123, 125, 126, 127, 162, 231, 244, 259, 281, 291, 293, 297, 298, 302, 316, 325, 333, 336, 337, 343, 344, 353, 373, 386, 394, 395, 409, 412, 415, 480, 482, 485, 501, 511, 513], "taken": [1, 106, 107, 111, 118, 121, 122, 259, 304, 500], "target": [0, 1, 11, 19, 41, 52, 114, 278, 289, 456], "target_begin": 11, "target_end_optim": 11, "target_end_suboptim": 11, "target_sequ": [0, 11, 19], "task": 506, "tata": 232, "tataa": 232, "tatattagca": 110, "tatctaactg": 110, "tatgtatata": 112, "tatgtatatataacatatacatatatacatacata": 112, "tau": 259, "tax": 107, "tax_id": [122, 429], "taxa": [1, 43, 44, 45, 46, 49, 50, 51, 52, 53, 54, 56, 57, 58, 59, 60, 63, 65, 66, 67, 69, 70, 71, 72, 73, 74, 75, 77, 78, 79, 80, 81, 82, 84, 85, 86, 87, 90, 120, 122, 259, 326, 340, 400, 407, 408, 411, 412, 413, 414, 415, 416, 458, 459, 462, 463, 468, 477, 478, 480, 481, 482, 483, 484, 485], "taxdump": 429, "taxdump_readm": 122, "taxid": 122, "taxon": [1, 44, 45, 46, 49, 51, 53, 57, 58, 59, 64, 65, 70, 71, 72, 73, 74, 75, 80, 81, 84, 85, 110, 113, 342, 399, 408, 409, 412, 415, 416, 429, 430, 458, 462, 463, 468, 485, 511], "taxonom": [1, 84, 430], "taxonomi": [106, 116, 120, 122, 191, 192, 348, 349, 358, 375, 392, 400, 429, 430, 467], "taxonomy_0": [375, 390], "taxonomy_1": [375, 390], "taylor": 60, "tb": [276, 357, 360], "tc": [276, 357, 360], "tcaaaagaaa": 110, "tcatttagga": 119, "tcc": 0, "tccacaaatg": 110, "tccagaaaaa": 110, "tcg": 208, "tcga": 245, "tcggagcagt": 110, "tcgggcasdgca": 119, "tcgggcattgca": 119, "tcgtatagat": 110, "tctacccctctcagaga": 0, "tctataagattccgcatgcgttacttataagatgtctcaacgg": 0, "tctcaatctc": 110, "tctcaga": 0, "tcttaacata": 110, "tcttcagcat": 110, "tcttgctcat": 110, "tctttgcttc": 110, "technic": [74, 116], "techniqu": [1, 54, 256, 325, 326, 509], "teh": [342, 399], "tell": 259, "temorg": 107, "temperatur": 339, "tempfil": 145, "temporari": 348, "temporaryfil": 145, "ten": 1, "tend": 120, "tensor": [91, 95], "ter": [215, 326], "term": [1, 23, 43, 49, 70, 105, 113, 162, 166, 176, 304, 319, 400, 480, 482], "termin": [110, 188, 193, 225, 415, 485], "test": [1, 20, 70, 123, 149, 151, 162, 176, 191, 228, 256, 259, 264, 276, 296, 298, 299, 300, 301, 303, 304, 311, 336, 339, 340, 354, 488, 489, 495], "test2": 340, "test_tabl": [357, 360], "texon": 114, "text": [46, 49, 64, 65, 80, 106, 108, 110, 111, 112, 113, 114, 115, 116, 117, 118, 119, 120, 122, 123, 125, 126, 127, 145, 176, 276, 308, 313, 315, 413, 415], "textiobas": [124, 125, 126, 127, 145], "textiowrapp": 145, "tf": 38, "tgaaggatca": 110, "tgaattcaac": 110, "tgca": 119, "tgene": 114, "tgenu": 122, "tgetaaafhwqaaf": 119, "tgg": [199, 208], "tggaacaatt": 110, "tggattaaaa": 110, "tggattctgc": 149, "tggtgcacct": 110, "tggtgctgga": 110, "tgi": 106, "tgtaataaat": 110, "tgtacacta": 3, "th": [46, 49, 64, 65, 73, 80, 273], "than": [0, 1, 19, 22, 23, 43, 44, 53, 60, 62, 79, 84, 85, 111, 116, 118, 121, 138, 142, 151, 176, 184, 189, 194, 213, 215, 221, 226, 228, 230, 231, 233, 234, 235, 236, 237, 239, 240, 241, 242, 247, 255, 256, 259, 261, 264, 276, 294, 296, 298, 299, 300, 304, 318, 325, 326, 333, 339, 340, 341, 364, 369, 388, 406, 407, 409, 412, 417, 429, 439, 441, 444, 462, 472, 473, 490, 506, 511], "thank": [184, 209, 221], "thei": [0, 1, 20, 23, 28, 44, 82, 86, 106, 110, 111, 112, 113, 114, 115, 116, 118, 120, 121, 122, 123, 149, 158, 184, 191, 210, 221, 228, 235, 256, 277, 280, 296, 297, 298, 299, 300, 301, 305, 320, 321, 325, 331, 336, 349, 358, 392, 405, 416, 423, 435, 439, 442, 453, 454, 456, 457, 458, 469, 488, 513], "them": [1, 18, 55, 113, 118, 120, 149, 151, 153, 154, 207, 228, 298, 310, 330, 331, 333, 407, 416, 422, 433, 441, 480, 482, 483, 485, 501, 506], "themselv": [462, 507, 508], "theorem": [61, 62], "theoret": [71, 77], "theori": [23, 46, 63, 72, 74, 269, 275], "therebi": 319, "therefor": [1, 21, 24, 29, 49, 51, 53, 60, 70, 75, 84, 85, 90, 120, 176, 247, 259, 331, 402, 413, 415, 416, 439, 448, 452, 462], "thermoplasmata": [430, 467], "theta": [70, 259], "thi": [0, 1, 2, 3, 10, 11, 14, 19, 20, 21, 22, 23, 24, 28, 29, 30, 31, 32, 33, 34, 35, 36, 37, 38, 39, 40, 41, 42, 43, 49, 53, 54, 55, 60, 61, 62, 67, 69, 70, 82, 83, 84, 85, 86, 87, 89, 90, 93, 94, 96, 104, 105, 106, 107, 108, 109, 110, 111, 112, 113, 114, 115, 116, 117, 118, 119, 120, 121, 122, 123, 124, 125, 126, 127, 130, 138, 140, 142, 144, 145, 146, 149, 150, 151, 152, 153, 154, 155, 156, 157, 159, 160, 162, 164, 169, 170, 171, 174, 176, 177, 178, 181, 182, 183, 184, 186, 189, 190, 191, 192, 193, 194, 195, 208, 209, 211, 212, 213, 214, 215, 218, 220, 221, 223, 226, 227, 228, 229, 230, 231, 233, 234, 235, 236, 237, 239, 240, 241, 242, 243, 244, 245, 246, 247, 253, 254, 255, 256, 257, 258, 259, 262, 263, 264, 265, 266, 267, 268, 270, 271, 272, 274, 276, 277, 284, 285, 287, 290, 291, 294, 295, 296, 297, 298, 300, 302, 303, 304, 305, 318, 319, 321, 322, 324, 326, 331, 332, 333, 336, 338, 339, 340, 345, 348, 349, 356, 358, 364, 373, 379, 382, 383, 388, 392, 393, 397, 398, 400, 402, 403, 404, 405, 406, 407, 408, 409, 410, 411, 412, 413, 414, 415, 416, 417, 419, 421, 422, 423, 424, 425, 426, 427, 429, 431, 433, 434, 435, 436, 439, 441, 450, 451, 452, 453, 454, 456, 457, 458, 459, 460, 462, 463, 464, 466, 467, 468, 469, 470, 472, 473, 474, 475, 476, 477, 478, 479, 480, 481, 482, 483, 485, 487, 488, 489, 490, 493, 495, 496, 497, 498, 499, 500, 501, 502, 504, 506, 507, 508, 509, 510, 511, 512, 513], "thing": [20, 513], "third": [270, 276, 434, 513], "those": [1, 83, 120, 176, 182, 304, 318, 325, 340, 368, 450, 460, 477, 478, 480, 501, 508], "though": [20, 55, 111, 112, 118, 119, 120, 259, 292, 296, 300, 370, 482, 485, 513], "thought": 300, "thr": 215, "thraustochytrium": 192, "three": [1, 3, 20, 69, 118, 122, 270, 276, 291, 301, 319, 321, 339, 340, 348, 349, 395, 413, 436, 456, 468, 472, 513], "threonin": 215, "threshold": [44, 331, 488], "through": [1, 20, 35, 36, 37, 109, 120, 130, 140, 277, 409, 424, 513], "throughout": [1, 115, 191, 192, 339, 512], "throughput": [53, 84, 85, 111, 112, 264, 321, 339], "thrown": 126, "thu": [1, 111, 112, 116, 120, 164, 178, 228, 233, 277, 291, 296, 298, 300, 304], "thymin": [110, 113, 184, 187, 224], "ti": [22, 45, 382, 479], "tid": 114, "tie": [407, 433, 441], "tile": 119, "tile_numb": 119, "till": 122, "time": [1, 19, 21, 24, 53, 67, 77, 84, 85, 87, 111, 112, 120, 247, 265, 266, 273, 292, 296, 297, 298, 299, 301, 305, 309, 317, 333, 336, 339, 340, 342, 348, 379, 388, 400, 409, 460, 493, 506, 513], "timestamp": 392, "tip": [1, 53, 70, 84, 85, 400, 401, 403, 405, 407, 408, 409, 412, 416, 418, 419, 422, 424, 425, 433, 438, 439, 440, 441, 443, 444, 447, 448, 449, 457, 459, 460, 462, 463, 467, 468, 469, 470, 472, 479, 480, 482, 506, 511], "tip_": 461, "tip_a": [422, 455], "tip_count": 444, "tip_d": 422, "tip_list": 464, "tip_nam": 409, "tip_subset": 468, "tip_tip_dist": 416, "tipnam": 439, "tissue_typ": 110, "titl": [1, 106, 107, 113, 121, 283, 321, 493], "tjflkafnkkghvm": 119, "tmgc": 192, "tn": 121, "tno": 122, "to_": 278, "to_data_fram": 295, "to_datafram": [170, 176], "to_dict": 25, "to_hdf5": 358, "to_seri": 169, "toarrai": 274, "tobacco": 340, "togeth": [29, 110, 111, 113, 121, 259, 348, 373, 501], "token": 96, "tol": 335, "toler": [335, 488], "tolosana": [256, 273], "ton": 1, "tongu": 1, "too": [62, 331, 345], "tool": [35, 38, 106, 107, 111, 118, 120, 122, 321, 326], "toolkit": 405, "top": [259, 429], "topolog": [404, 407, 408, 413, 463], "topologi": [407, 408, 413, 472, 473, 475, 478, 480, 481, 511], "total": [45, 46, 49, 52, 53, 54, 56, 58, 63, 64, 65, 66, 67, 73, 80, 104, 106, 120, 151, 233, 277, 297, 348, 468], "total_length": 409, "toward": [401, 484], "tparent": 114, "traceback": [106, 118, 193, 228, 298], "tracheophyta": 110, "track": [109, 110], "tracker": [111, 126], "tract": 340, "trail": [111, 112, 115], "trajectori": [305, 306, 307, 308, 309, 310, 311, 312, 313, 314, 315, 316, 317], "trajectory_categori": [305, 306, 309, 310, 316], "trajectory_result": 305, "tranform": 395, "tranpos": 390, "transcrib": [110, 113, 188, 189, 224, 508], "transcript": 149, "transect": 319, "transfer": [435, 472, 473], "transform": [125, 127, 235, 257, 258, 262, 263, 265, 266, 269, 274, 325, 331, 333, 342, 360, 382], "translat": [110, 113, 116, 122, 145, 187, 189, 191, 194, 215, 224, 226, 508], "translate_six_fram": [187, 188, 193, 224, 225], "transloc": 339, "transpar": [120, 145, 506], "transpos": [277, 390], "trapezoid": 55, "trascrib": 110, "traver": 511, "travers": [400, 404, 408, 409, 417, 424, 427, 440, 443, 447, 448, 449, 465, 511], "traves": 409, "tre361": 110, "treat": [20, 21, 22, 23, 24, 111, 115, 120, 176, 184, 207, 215, 221, 228, 238, 254, 339, 412], "treatment": [162, 259, 264, 305, 339, 346], "treatment_stat": 339, "tree": [1, 53, 70, 84, 85, 116, 121, 122, 151, 274, 347, 363, 505, 506], "tree1": [411, 412, 413, 414, 415, 511], "tree2": [407, 408, 411, 412, 413, 414, 415, 511], "tree3": 511, "tree_copi": 417, "tree_copy_nod": 417, "tree_nod": 417, "tree_node_class": 479, "treeerror": [457, 458], "treenod": [1, 53, 70, 84, 85, 116, 274, 347, 477, 478, 479, 480, 481, 482, 483, 484, 485, 506, 511], "trg": [199, 208], "tri": 370, "triangl": [291, 293, 295, 298, 331, 370, 413, 482, 485], "triangular": 298, "trifoliea": 110, "trifolium": 110, "trifuc": 472, "trifurc": [53, 84, 85, 116], "trim": 193, "tripleton": 1, "trivial": 413, "trp": 215, "trubbbbrbcefgh": 119, "true": [1, 11, 12, 13, 19, 20, 21, 22, 24, 25, 27, 28, 32, 33, 35, 36, 37, 43, 47, 48, 49, 51, 53, 54, 58, 59, 67, 70, 74, 75, 76, 79, 82, 84, 85, 86, 87, 90, 96, 97, 100, 101, 102, 103, 106, 109, 110, 111, 112, 113, 114, 116, 119, 124, 125, 126, 127, 136, 141, 145, 146, 149, 151, 153, 158, 165, 168, 171, 172, 174, 175, 177, 184, 187, 188, 189, 191, 193, 194, 195, 196, 197, 198, 199, 201, 202, 203, 204, 205, 206, 207, 208, 210, 211, 212, 213, 214, 215, 217, 219, 221, 224, 225, 226, 228, 229, 233, 236, 237, 238, 239, 240, 241, 242, 244, 245, 247, 255, 259, 264, 265, 266, 269, 276, 277, 278, 280, 286, 291, 293, 294, 296, 298, 300, 301, 304, 310, 312, 323, 330, 331, 333, 334, 338, 339, 341, 342, 348, 351, 355, 356, 358, 359, 367, 368, 369, 370, 374, 378, 379, 380, 381, 382, 385, 386, 388, 390, 391, 392, 395, 397, 401, 402, 403, 405, 406, 407, 408, 409, 410, 411, 412, 413, 414, 415, 416, 417, 418, 420, 421, 422, 423, 426, 431, 432, 433, 435, 437, 438, 440, 441, 445, 446, 447, 448, 449, 450, 452, 453, 454, 455, 456, 457, 458, 459, 462, 463, 465, 467, 468, 469, 470, 471, 472, 473, 475, 477, 478, 479, 480, 481, 482, 483, 484, 485, 487, 493, 501, 502, 504, 508, 511, 513], "truncat": [112, 277, 320, 513], "trust": 112, "truth": 228, "truthi": 228, "try": [340, 341], "tryptophan": [23, 215], "tsalli": 72, "tsuperkingdom": 122, "tsv": [115, 120, 176, 181, 360, 394], "tsv_fh": 360, "tt": [22, 235], "tta": 237, "ttacatatta": 110, "ttacgcttaaac": 111, "ttactattac": 110, "ttactgttcg": 110, "ttagctcatt": 110, "ttattaaaag": 110, "ttattgtagc": 110, "ttattttttt": 110, "ttcaatttgg": 110, "ttcatt": [210, 213, 214], "ttcatttgat": 110, "ttccagtaga": 110, "ttctactctt": 110, "ttctgcaatc": 110, "ttest_ind": [259, 264], "ttest_rel": 259, "ttgaatactt": 110, "ttgagaatac": 110, "ttgg": 348, "ttggccaaga": 110, "ttgtaactct": 110, "ttgttgtacc": 110, "ttjflkafnkkghvm": 119, "tttattggta": 110, "tttcctcgtg": 110, "tttgaattaa": 110, "tttgcaggct": 110, "ttttcattgg": 110, "ttttggactg": 110, "ttttggatta": 110, "tttttaggcc": 110, "tttttttaaaaaaa": 513, "tupl": [20, 35, 36, 37, 38, 39, 40, 41, 48, 52, 61, 67, 69, 90, 114, 126, 149, 152, 156, 182, 188, 189, 225, 226, 247, 277, 302, 342, 343, 348, 358, 359, 375, 388, 392, 409, 430, 441, 466, 467, 498], "ture": 56, "turkei": [111, 118], "turn": [3, 184, 215, 221, 333, 488, 513], "turnip": 121, "tutori": [120, 123, 176, 181], "twice": [20, 340, 448, 469], "two": [0, 1, 3, 35, 36, 37, 38, 39, 40, 41, 44, 49, 70, 75, 84, 85, 106, 107, 111, 112, 113, 114, 116, 118, 119, 122, 149, 151, 153, 158, 184, 215, 221, 228, 229, 231, 235, 239, 241, 247, 254, 255, 256, 259, 261, 264, 270, 273, 274, 276, 277, 278, 281, 285, 293, 296, 297, 298, 299, 300, 301, 302, 304, 326, 331, 336, 339, 340, 345, 348, 358, 373, 392, 400, 406, 407, 408, 409, 411, 412, 413, 414, 415, 416, 422, 431, 436, 441, 456, 457, 472, 479, 480, 481, 482, 483, 485, 489, 493, 506, 508, 511], "txt": [110, 120, 122], "tygert": 331, "tyne": 110, "type": [1, 19, 20, 21, 22, 24, 61, 71, 77, 86, 90, 100, 101, 102, 103, 104, 108, 109, 111, 112, 113, 114, 115, 118, 121, 122, 125, 127, 131, 133, 134, 135, 136, 141, 145, 148, 162, 173, 176, 177, 181, 185, 191, 197, 199, 200, 210, 213, 214, 216, 222, 228, 229, 230, 231, 234, 239, 240, 241, 242, 244, 254, 255, 276, 277, 279, 288, 297, 300, 302, 319, 325, 326, 333, 336, 338, 342, 343, 349, 358, 359, 373, 392, 399, 409, 423, 431, 466, 479, 488, 491, 492], "typeerror": [20, 21, 24, 29, 82, 136, 138, 141, 142, 213, 228, 229, 230, 231, 233, 234, 239, 240, 241, 242, 254, 255, 297, 298, 300, 339, 340, 375, 409], "typic": [35, 36, 37, 38, 39, 40, 42, 95, 97, 99, 111, 112, 119, 120, 121, 149, 151, 331, 431, 456, 507], "tyr": 215, "tyrosin": 215, "u": [1, 37, 40, 53, 61, 64, 84, 85, 110, 111, 113, 122, 187, 215, 221, 224, 228, 259, 262, 263, 274, 298, 335, 340, 347, 508, 513], "u1": [1, 53, 84, 85], "u2": [1, 53, 84, 85], "u3": [1, 53, 84, 85], "u4": [1, 53, 84, 85], "u5": [1, 53, 84, 85], "u6": [1, 53, 84, 85], "u7": [1, 53, 84, 85], "u8": [53, 84, 85], "u_count": [53, 84, 85], "u_i": 259, "uaacguua": [187, 224], "uaaguucucgaucucuaaaaucg": 121, "uaaguucucgaucuuuaaaaucg": 121, "uagguugauc": 110, "uc": 508, "ucagucagucagucagucagucagucagucagucagucagucagucagucagucagucagucag": 191, "uccacaaaug": 110, "uconn": [44, 48], "ugaguucucgaucucuaaaaucg": 121, "ugaguucucuaucucuaaaaucg": 121, "uint8": [3, 8, 14, 111, 112, 119, 184, 213, 215, 221, 228, 230, 231, 234, 239, 240, 241, 242, 245], "uk": [35, 38, 57, 110, 113, 149, 256], "ulcl": 61, "ulcu": 61, "ultrametr": 416, "umich": 11, "un": 116, "unabl": 124, "unalign": [35, 36, 37, 38, 39, 40, 41, 508], "unbias": 484, "unbound": [151, 155], "uncach": [402, 406, 423, 431, 435, 446, 450, 452, 453, 454, 459, 470, 471, 472, 475], "uncertainti": [23, 264, 304], "unclear": 60, "unconstrain": 326, "uncorrect": [47, 48], "uncov": [61, 62, 509], "undefin": [120, 338, 339], "under": [55, 86, 111, 184, 215, 221, 228, 259, 310, 339, 348, 406, 408, 409, 412, 415, 427, 482, 485, 505], "underli": [0, 3, 96, 98, 99, 145, 193, 228, 254, 319, 336, 342, 400, 463, 508], "underlii": 3, "underpow": 336, "underscor": [116, 118], "understand": [120, 259], "understood": [30, 34, 93, 94, 116, 136, 138, 139, 141, 142, 143, 157, 159, 186, 190, 218, 220, 223, 227, 243, 246, 284, 290, 322, 324, 383, 398, 451, 476], "unequ": [44, 191, 247, 415], "unescap": 116, "uneven": [43, 80], "unfortun": [20, 112, 339], "ungap": 235, "ungapped_subsequ": 235, "unicod": [104, 120, 145], "unifi": [58, 264], "uniform": [1, 302], "uniformli": [7, 18], "unifrac": [1, 53, 70, 84, 85, 87, 90], "unimod": [326, 331], "union": [349, 373], "uniprotkb": 110, "uniq": 245, "uniqu": [1, 29, 33, 106, 111, 115, 116, 120, 121, 122, 177, 182, 245, 255, 276, 300, 321, 348, 375, 404, 412, 413, 415, 419, 424, 439, 481, 482, 483, 485], "unit": [1, 3, 84, 113, 123, 247, 331, 333, 334, 412, 413, 415, 430, 488, 489, 512], "unitcorr": [412, 415], "univers": [72, 110, 111, 118, 120, 124, 484], "unix": 122, "unknown": [23, 61, 62, 113, 149, 185, 200, 216, 222, 318, 382], "unknownaxiserror": [343, 345, 351, 352, 356, 363, 365, 366, 369, 370, 371, 372, 374, 375, 376, 384, 385, 395, 397], "unknowniderror": [366, 374], "unless": [19, 20, 28, 47, 119, 409, 465, 473, 501], "unlik": [121, 318, 477, 478, 480, 498], "unmask": 19, "unnam": 506, "unnecessari": 29, "unobserv": [43, 73], "unord": [400, 407, 408, 462, 463], "unpack": [8, 17, 471], "unpack_by_func": 470, "unpair": 116, "unpermut": [296, 298, 299], "unread": 145, "unrecogn": [343, 345, 351, 356, 363, 365, 366, 371, 372, 374, 376, 395, 397], "unrecognizedformaterror": [136, 138, 139, 141, 142, 143], "unresolv": 90, "unroot": [53, 70, 84, 85, 116, 400, 407, 408, 411, 413, 415, 428, 456, 463, 473, 474, 475, 480, 483, 485], "unrooted_copi": [417, 456, 457, 474, 475], "unrooted_mov": [456, 473], "unset": 20, "unshar": [29, 413], "unsign": [318, 444], "unsolv": 259, "unstabl": 90, "unsupport": [120, 215], "until": [151, 273, 419], "untouch": [356, 379], "untreat": 339, "unweight": [1, 70, 84, 85, 334, 484], "unweighted_unifrac": [1, 85], "unwrit": 145, "unzip": 381, "up": [20, 23, 42, 108, 118, 120, 121, 145, 151, 153, 225, 226, 261, 268, 270, 271, 272, 277, 298, 318, 340, 348, 400, 409, 450, 457, 504, 511], "upd": 70, "upd_": 70, "updat": [110, 111, 122, 151, 155, 171, 174, 228, 397], "updated_t": 397, "upgma": [416, 480], "upon": 110, "upper": [19, 60, 61, 111, 118, 149, 151, 153, 155, 293, 295, 298, 370], "upper_bound": [48, 52, 61, 151, 153], "upper_quantil": 60, "uppercas": [184, 215, 221, 228], "upsk": 121, "uq": 60, "uracil": [110, 113, 187, 221, 224], "urinari": 340, "url": [30, 93, 136, 138, 139, 141, 142, 143, 145, 157, 186, 218, 223, 243, 284, 322, 358, 383, 392, 451], "urn": [61, 62], "us": [1, 6, 11, 16, 19, 20, 21, 22, 23, 24, 25, 28, 29, 31, 35, 36, 37, 47, 48, 49, 53, 54, 60, 67, 69, 70, 71, 72, 74, 82, 84, 85, 86, 87, 90, 96, 101, 104, 105, 106, 108, 109, 111, 112, 113, 114, 115, 116, 118, 119, 120, 122, 123, 124, 125, 126, 127, 134, 135, 138, 142, 145, 151, 153, 162, 169, 170, 171, 172, 174, 175, 176, 180, 181, 183, 184, 188, 189, 191, 192, 193, 194, 195, 215, 221, 225, 226, 228, 229, 231, 235, 238, 244, 245, 247, 253, 254, 256, 257, 258, 259, 264, 265, 266, 268, 274, 276, 277, 281, 291, 293, 295, 296, 297, 298, 299, 300, 301, 302, 304, 305, 306, 309, 310, 312, 316, 317, 319, 321, 325, 331, 335, 336, 337, 338, 339, 340, 348, 353, 354, 356, 379, 382, 384, 386, 387, 390, 392, 393, 403, 405, 406, 408, 409, 412, 413, 415, 416, 417, 420, 421, 422, 429, 431, 433, 450, 452, 456, 459, 460, 462, 463, 466, 474, 477, 478, 479, 480, 481, 482, 483, 484, 485, 488, 489, 490, 496, 497, 501, 504, 508, 511, 512, 513], "usag": [299, 496], "use_length": [412, 416, 421, 422, 433, 441, 482], "usefulli": 479, "user": [1, 23, 61, 62, 83, 106, 120, 122, 123, 124, 125, 126, 127, 136, 139, 141, 143, 207, 259, 264, 294, 296, 298, 299, 300, 301, 304, 318, 326, 331, 338, 339, 340, 341, 439, 473, 496, 508], "usrman": 110, "usual": [1, 43, 79, 110, 113, 120, 122, 247, 331, 405, 416, 442, 456, 457, 458, 473], "ut": 508, "uti": 340, "util": [1, 30, 34, 93, 94, 122, 125, 127, 157, 159, 186, 190, 191, 192, 195, 218, 220, 223, 227, 243, 246, 284, 290, 322, 324, 358, 373, 381, 383, 386, 392, 398, 419, 451, 476, 478, 505, 506], "uu": 84, "uuagcucauu": 110, "uuauuguagc": 110, "uuauuuuuuu": 110, "uucuacucuu": 110, "uugagaauac": 110, "uuugaauuaa": 110, "uuuuccccaaaagggguuuuccccaaaagggguuuuccccaaaagggguuuuccccaaaagggg": 191, "uuuuuuuuuuuuuuuuccccccccccccccccaaaaaaaaaaaaaaaagggggggggggggggg": 191, "v": [19, 84, 85, 162, 176, 184, 215, 221, 228, 256, 269, 273, 275, 338, 339, 466], "v2": 105, "v_count": [84, 85], "vagin": 340, "vaginali": 340, "val": [215, 356], "val_i": 370, "val_j": 370, "valdar": 23, "valid": [35, 38, 53, 70, 82, 84, 85, 86, 87, 90, 100, 101, 102, 103, 109, 111, 112, 116, 118, 176, 181, 184, 195, 215, 221, 245, 269, 275, 277, 291, 293, 342, 358, 382, 392, 508, 513], "valin": 215, "valu": [1, 3, 5, 6, 9, 10, 20, 23, 35, 36, 37, 38, 39, 40, 42, 44, 55, 57, 67, 71, 74, 80, 82, 85, 103, 104, 106, 107, 109, 110, 111, 112, 113, 114, 115, 120, 121, 145, 149, 150, 152, 156, 160, 162, 163, 165, 166, 167, 168, 169, 170, 171, 172, 174, 176, 177, 181, 182, 183, 184, 210, 214, 215, 221, 228, 229, 238, 244, 247, 256, 259, 261, 264, 268, 269, 270, 271, 272, 275, 278, 289, 296, 297, 298, 299, 300, 301, 302, 304, 308, 310, 313, 315, 318, 321, 325, 326, 330, 331, 333, 335, 336, 337, 338, 339, 340, 342, 343, 348, 356, 357, 358, 362, 368, 369, 372, 376, 378, 379, 382, 386, 388, 389, 395, 397, 400, 405, 407, 408, 412, 416, 417, 456, 457, 462, 463, 466, 472, 475, 477, 478, 481, 484, 488, 489, 492, 501, 503, 504, 513], "valueerror": [20, 21, 23, 24, 27, 29, 31, 33, 44, 53, 55, 70, 82, 84, 85, 86, 90, 102, 136, 141, 164, 178, 182, 185, 193, 195, 200, 216, 222, 228, 229, 230, 233, 234, 236, 237, 239, 240, 241, 242, 245, 248, 249, 254, 255, 261, 268, 274, 281, 286, 293, 297, 298, 300, 301, 310, 317, 318, 321, 323, 325, 326, 333, 339, 340, 341, 357, 358, 382, 388, 412, 416, 429, 435, 444, 459, 460, 470, 490], "van": 273, "vanveeeeaw": 109, "var": [297, 390], "vari": [1, 300, 336, 338, 339, 480], "variabl": [55, 103, 104, 228, 244, 259, 297, 300, 319, 320, 321, 326, 331, 332, 333, 336, 338, 339, 501, 504, 513], "varianc": [48, 177, 269, 275, 297, 299, 300, 319, 327, 330, 331, 334, 339], "variant": [1, 53, 70, 119, 122, 247, 415, 482, 484, 485], "variat": [44, 298, 326], "varieti": 115, "variou": [1, 3, 43, 117, 176, 276, 320, 336, 400, 409, 496, 509, 512], "vazquez": 321, "ve": [1, 111, 112, 340, 511], "vec": 337, "vector": [3, 20, 27, 44, 45, 46, 47, 48, 49, 50, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 71, 72, 73, 74, 75, 76, 77, 78, 79, 80, 81, 82, 84, 85, 95, 96, 97, 98, 99, 100, 101, 102, 103, 109, 115, 185, 191, 196, 198, 200, 201, 206, 216, 219, 222, 235, 238, 240, 242, 244, 245, 256, 257, 258, 259, 264, 265, 266, 270, 271, 272, 275, 276, 277, 291, 296, 299, 300, 312, 326, 331, 340, 341, 342, 348, 381, 385, 388, 395, 412, 415, 466, 482, 485], "vegan": [296, 297, 298, 299, 300, 325, 326, 333], "vellend": 70, "ver": [107, 487, 493, 498], "verdonschot": 326, "veri": [1, 35, 36, 37, 60, 111, 116, 123, 270, 358, 412, 482, 506], "verifi": [110, 123, 136, 141], "versa": [116, 304, 379], "versatil": [319, 400], "version": [1, 41, 42, 47, 48, 53, 61, 62, 70, 74, 79, 82, 84, 85, 86, 90, 104, 106, 108, 109, 110, 113, 114, 118, 126, 199, 207, 208, 259, 268, 273, 294, 296, 298, 299, 300, 301, 302, 304, 318, 331, 338, 339, 340, 342, 353, 356, 358, 379, 388, 392, 394, 399, 402, 403, 406, 407, 408, 409, 410, 411, 412, 413, 414, 415, 416, 417, 420, 421, 422, 423, 431, 433, 435, 436, 439, 441, 445, 446, 450, 452, 453, 454, 456, 457, 458, 459, 460, 462, 463, 464, 468, 470, 471, 472, 473, 474, 475, 480, 481, 482, 483, 485, 487, 490, 493, 496, 508], "versu": [71, 77, 84, 85], "vertic": 400, "veschi": 55, "vi": [415, 485], "via": [21, 24, 31, 44, 61, 62, 111, 118, 191, 231, 256, 296, 298, 299, 348, 388, 404], "vice": [116, 304, 379], "viceroi": [44, 48], "view": [110, 381], "viewer": 405, "violat": [264, 408, 436, 480], "viral": 121, "virgilio": 55, "viridiplanta": 110, "virol": 121, "viru": 121, "visit": [440, 443, 447, 448, 449, 465, 469, 473], "visual": [1, 319, 321, 400], "vlen": [358, 392], "vocabulari": [113, 114, 162, 169, 170, 176, 183], "vol": 72, "volatil": 305, "volum": [72, 480], "vqhklrah": 121, "vrt": 122, "w": [19, 23, 44, 45, 52, 67, 70, 80, 106, 107, 108, 145, 184, 215, 221, 259, 273, 392, 394], "wa": [1, 11, 20, 35, 38, 44, 45, 46, 49, 52, 53, 55, 56, 57, 58, 59, 63, 64, 65, 70, 71, 72, 74, 75, 81, 82, 84, 85, 86, 87, 108, 111, 112, 116, 118, 145, 166, 169, 170, 183, 193, 228, 235, 259, 269, 273, 275, 298, 312, 330, 331, 338, 340, 412, 413, 452, 457, 464, 479, 480, 487, 496, 506, 511, 513], "wai": [0, 1, 111, 112, 116, 118, 121, 123, 149, 181, 207, 247, 259, 298, 336, 348, 358, 392, 506, 511], "wakefield": 479, "walk": [473, 474, 475, 511, 513], "walli": [259, 339, 340], "wan": [19, 41], "want": [35, 36, 37, 110, 111, 113, 151, 336, 338, 339, 340, 506], "warn": [112, 120, 300, 331, 487, 493, 498, 512], "warn_neg_eigv": [300, 331], "washington": [111, 116, 118, 479], "wasn": [20, 112], "water": 38, "waterman": [0, 19, 38, 39, 40, 41], "we": [0, 1, 19, 20, 21, 23, 24, 53, 60, 67, 70, 84, 85, 87, 105, 106, 107, 108, 109, 110, 111, 112, 113, 114, 115, 117, 118, 119, 120, 121, 123, 146, 149, 151, 193, 228, 233, 235, 244, 259, 264, 269, 275, 276, 296, 297, 298, 300, 301, 304, 305, 319, 321, 325, 333, 335, 336, 338, 339, 340, 345, 358, 388, 479, 506, 511, 513], "weak": 184, "weaker": 304, "web": [19, 35, 38, 41, 108, 122, 296, 297, 298, 299, 300], "webfeat": 113, "webpag": 113, "websit": 23, "week": 340, "weight": [1, 53, 58, 70, 84, 85, 116, 305, 306, 309, 310, 312, 316, 330, 334, 412, 415, 479, 482, 484, 485], "weighted_unifrac": [1, 84], "welcom": 111, "well": [0, 20, 112, 120, 123, 176, 228, 264, 276, 277, 297, 299, 300, 304, 320, 326, 358, 400, 479, 506, 511, 512], "wellcom": 112, "were": [1, 20, 37, 40, 53, 60, 82, 84, 85, 86, 116, 118, 119, 228, 235, 296, 298, 300, 321, 331, 339, 340, 409, 410, 450, 513], "wf": [112, 513], "what": [1, 53, 70, 82, 84, 85, 86, 116, 120, 123, 124, 134, 135, 139, 143, 156, 235, 304, 318, 339, 345, 348, 358, 381, 392, 511, 513], "whatev": 123, "when": [1, 11, 19, 20, 21, 23, 24, 29, 32, 35, 36, 37, 44, 49, 54, 57, 59, 70, 71, 75, 77, 87, 90, 104, 106, 108, 111, 112, 113, 114, 115, 116, 118, 119, 120, 121, 123, 125, 126, 127, 136, 138, 139, 141, 142, 143, 145, 151, 153, 160, 171, 174, 176, 177, 181, 184, 185, 195, 200, 211, 212, 215, 216, 221, 222, 228, 229, 232, 238, 254, 259, 276, 296, 298, 299, 300, 302, 304, 308, 313, 315, 325, 331, 333, 337, 338, 339, 340, 341, 342, 348, 358, 388, 399, 409, 412, 413, 415, 421, 422, 431, 433, 441, 459, 463, 468, 480, 482, 487, 489, 490, 493, 497, 501, 506, 511, 513], "whenev": 112, "where": [1, 3, 5, 9, 11, 42, 44, 45, 46, 47, 49, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 63, 64, 65, 66, 67, 70, 71, 72, 73, 74, 75, 77, 80, 81, 86, 87, 90, 91, 102, 104, 109, 111, 115, 116, 117, 120, 121, 123, 180, 196, 198, 201, 206, 219, 232, 234, 235, 240, 242, 244, 247, 257, 258, 259, 261, 262, 263, 264, 265, 266, 268, 270, 271, 272, 273, 277, 298, 304, 318, 321, 330, 332, 333, 334, 336, 340, 341, 356, 358, 375, 387, 392, 397, 400, 412, 413, 415, 424, 425, 426, 453, 454, 456, 458, 467, 471, 472, 475, 477, 484, 495, 511, 513], "where_values_miss": 165, "wherea": [105, 286, 318, 323, 407, 413, 435, 468, 473, 475], "wherev": 334, "whether": [12, 20, 47, 48, 53, 70, 114, 123, 145, 161, 162, 169, 170, 172, 175, 176, 183, 191, 202, 203, 204, 205, 217, 228, 235, 236, 237, 247, 255, 259, 269, 275, 277, 296, 298, 299, 300, 320, 333, 334, 355, 356, 358, 367, 392, 395, 401, 402, 406, 407, 408, 409, 410, 411, 412, 413, 414, 415, 416, 417, 421, 422, 423, 432, 433, 435, 436, 437, 438, 441, 443, 445, 446, 450, 452, 453, 454, 456, 457, 458, 459, 462, 463, 465, 468, 469, 470, 471, 472, 473, 475, 477, 478, 481, 482, 483, 485], "which": [1, 3, 4, 6, 8, 11, 15, 20, 35, 36, 37, 44, 49, 53, 58, 70, 75, 79, 84, 85, 87, 106, 108, 109, 111, 113, 114, 115, 116, 117, 118, 120, 121, 122, 123, 124, 125, 126, 127, 128, 131, 133, 134, 135, 136, 141, 171, 176, 184, 193, 212, 215, 221, 228, 229, 230, 234, 235, 238, 245, 256, 257, 258, 259, 264, 277, 278, 296, 299, 300, 304, 323, 326, 330, 331, 336, 337, 338, 339, 340, 346, 347, 348, 349, 353, 356, 372, 375, 376, 378, 384, 385, 389, 392, 394, 400, 408, 409, 410, 412, 413, 415, 416, 420, 431, 453, 454, 455, 458, 460, 463, 466, 467, 472, 474, 479, 480, 482, 483, 484, 485, 491, 492, 496, 497, 501, 504, 506, 508, 511, 513], "while": [0, 1, 104, 110, 111, 112, 113, 118, 149, 191, 228, 259, 300, 310, 317, 319, 321, 338, 342, 399, 400, 412, 415, 419, 481, 501, 507, 508, 513], "white": 110, "whitespac": [111, 112, 115, 117, 121], "whitnei": 259, "who": [116, 340], "whole": [121, 329, 337, 352, 372, 376, 378, 385, 389], "whose": [113, 119, 120, 282, 297, 298, 334, 351, 366, 374, 386, 419], "why": 51, "wide": [1, 29, 70, 229, 436], "width": [111, 115, 118], "wiener": 74, "wiki": [11, 43, 111, 112, 118, 121, 480], "wikipedia": [43, 111, 112, 121, 480, 511], "wilcoxon": 259, "wild": 207, "wildcard": [184, 195, 207, 215, 221, 245], "wildcard_char": [184, 195, 215, 221, 245], "wilei": 256, "william": 54, "window": 317, "window_s": 317, "wish": [120, 511], "with_mean": [330, 334], "with_replac": 388, "with_std": [330, 334], "within": [1, 23, 43, 70, 80, 87, 104, 107, 111, 112, 116, 118, 120, 121, 176, 184, 215, 221, 228, 247, 256, 264, 278, 300, 301, 314, 319, 320, 321, 338, 339, 348, 377, 400, 402, 408, 409, 410, 413, 419, 424, 425, 427, 431, 434, 458, 462, 463, 488, 492, 504, 511, 513], "within_captur": 208, "without": [20, 21, 24, 29, 31, 49, 67, 85, 107, 116, 118, 120, 121, 228, 256, 318, 321, 340, 341, 353, 370, 388, 394, 400, 415, 421, 422, 433, 467, 477, 478, 481, 500, 501, 506], "wllllpppphhqqrrrriiimttttnnkkssrrvvvvaaaaddeegggg": 191, "woman": 340, "women": 340, "won": [1, 82, 84, 85, 86, 112, 149, 326, 465, 506], "word": [0, 20, 110, 111, 113, 116, 121, 156, 237], "work": [1, 19, 20, 87, 111, 118, 120, 123, 176, 184, 209, 215, 221, 276, 298, 326, 340, 364, 373, 505, 506, 507, 508, 510, 511], "workflow": 505, "world": [20, 480], "worri": [116, 342, 399], "would": [3, 20, 23, 53, 55, 58, 60, 84, 85, 108, 111, 114, 116, 118, 120, 121, 123, 176, 229, 235, 270, 273, 278, 304, 338, 339, 409, 467, 479], "wpgma": 484, "wprintgc": [191, 192], "wr": [111, 304], "wrap": [11, 118, 121, 504], "wrapper": [19, 41, 61, 62, 488], "wrf": [415, 485], "wrf_dist": 415, "writabl": [145, 149], "write": [30, 93, 105, 108, 109, 110, 112, 114, 115, 116, 118, 121, 123, 125, 127, 135, 145, 157, 186, 218, 223, 243, 276, 284, 308, 313, 315, 322, 383, 392, 393, 394, 451, 490], "write_fil": 506, "writeabl": [3, 20, 228, 277, 506], "writer": [34, 94, 104, 105, 106, 107, 108, 109, 110, 112, 113, 115, 116, 117, 118, 119, 120, 121, 122, 123, 124, 133, 139, 143, 145, 159, 190, 220, 227, 246, 290, 324, 398, 476, 506], "written": [108, 111, 112, 116, 118, 176, 353, 393, 394, 479, 506, 511], "wu": [70, 85], "wu_dm": 1, "wu_pc": 1, "wunsch": [0, 35, 36, 37], "www": [19, 35, 38, 41, 60, 87, 104, 106, 107, 108, 110, 111, 112, 113, 118, 122, 191, 192, 297], "x": [18, 19, 55, 105, 112, 119, 195, 215, 245, 256, 257, 258, 260, 261, 262, 263, 265, 266, 267, 268, 270, 271, 272, 273, 275, 286, 298, 301, 304, 319, 320, 321, 325, 326, 327, 333, 336, 339, 340, 348, 356, 360, 369, 374, 379, 384, 386, 390, 392, 394, 395, 399, 407, 426, 435, 445, 453, 454, 466, 471, 482, 483, 485, 500, 513], "x00": 146, "x01": 146, "x03": 146, "x0c": 146, "x108": 146, "x1c": 146, "x2": 407, "x56734": 110, "x86": 146, "x89": 146, "x8b": 146, "x9ah3m": 146, "x9c": 146, "x_": [256, 257, 273, 336, 340], "x_1": [257, 258, 262, 263, 270, 271, 272], "x_d": [257, 258, 262, 263, 270, 271, 272], "x_i": [258, 262, 267, 270, 271, 272, 273], "x_j": 267, "xa6": 146, "xaa": 215, "xb7": 146, "xb9": 146, "xc1": 146, "xc4": 146, "xle": 215, "xx": 110, "xxxxxx": 195, "xyz": 108, "y": [19, 44, 55, 112, 119, 184, 215, 221, 267, 270, 271, 275, 286, 298, 301, 304, 319, 321, 326, 327, 331, 332, 333, 338, 374, 384, 392, 394, 395, 407, 466, 482, 485], "y2": 407, "y_": [258, 340], "y_1": [258, 270, 271], "y_2": 258, "y_d": [270, 271], "y_i": 267, "y_j": 267, "yang": 44, "ye": [104, 105, 106, 107, 108, 109, 110, 111, 112, 113, 114, 115, 116, 117, 118, 119, 120, 121, 122], "yeast": [188, 225], "yeild": 300, "yellow": 121, "yet": [116, 122, 123], "yiel": 465, "yield": [20, 28, 111, 156, 185, 189, 194, 199, 200, 216, 222, 226, 228, 232, 235, 236, 300, 368, 369, 370, 377, 381, 426, 440, 443, 447, 448, 449, 460, 465, 467, 469, 501, 506, 513], "york": 46, "you": [1, 19, 35, 36, 37, 53, 82, 84, 85, 86, 87, 106, 108, 111, 112, 114, 118, 120, 121, 123, 150, 151, 153, 155, 156, 184, 215, 221, 228, 247, 293, 296, 300, 333, 338, 339, 340, 387, 431, 496, 506, 508, 511, 513], "your": [19, 29, 53, 82, 84, 85, 86, 112, 120, 123, 151, 300, 339, 506, 511, 513], "yy": 112, "z": [19, 29, 52, 120, 215, 301, 321, 368, 407, 466], "z3": [362, 368], "zero": [3, 4, 7, 8, 15, 16, 44, 54, 90, 104, 149, 152, 176, 182, 233, 259, 261, 264, 268, 269, 270, 271, 272, 275, 277, 296, 297, 298, 299, 300, 301, 304, 325, 331, 334, 339, 341, 342, 358, 385, 388, 392, 395, 480, 482, 485, 513], "zero_index": [19, 41], "zhao": [19, 41], "zip": 352, "zp_02903423": 106, "zscore": 48, "zxx": 112, "\u00e9": 273, "\u00f8": 70}, "titles": ["Sequence Alignments (skbio.alignment)", "Community Diversity (skbio.diversity)", "Biological Embeddings (skbio.embedding)", "skbio.alignment.AlignPath", "skbio.alignment.AlignPath.from_bits", "skbio.alignment.AlignPath.from_coordinates", "skbio.alignment.AlignPath.from_indices", "skbio.alignment.AlignPath.from_tabular", "skbio.alignment.AlignPath.to_bits", "skbio.alignment.AlignPath.to_coordinates", "skbio.alignment.AlignPath.to_indices", "skbio.alignment.AlignmentStructure", "skbio.alignment.AlignmentStructure.is_zero_based", "skbio.alignment.AlignmentStructure.set_zero_based", "skbio.alignment.PairAlignPath", "skbio.alignment.PairAlignPath.from_bits", "skbio.alignment.PairAlignPath.from_cigar", "skbio.alignment.PairAlignPath.to_bits", "skbio.alignment.PairAlignPath.to_cigar", "skbio.alignment.StripedSmithWaterman", "skbio.alignment.TabularMSA", "skbio.alignment.TabularMSA.append", "skbio.alignment.TabularMSA.consensus", "skbio.alignment.TabularMSA.conservation", "skbio.alignment.TabularMSA.extend", "skbio.alignment.TabularMSA.from_dict", "skbio.alignment.TabularMSA.from_path_seqs", "skbio.alignment.TabularMSA.gap_frequencies", "skbio.alignment.TabularMSA.iter_positions", "skbio.alignment.TabularMSA.join", "skbio.alignment.TabularMSA.read", "skbio.alignment.TabularMSA.reassign_index", "skbio.alignment.TabularMSA.sort", "skbio.alignment.TabularMSA.to_dict", "skbio.alignment.TabularMSA.write", "skbio.alignment.global_pairwise_align", "skbio.alignment.global_pairwise_align_nucleotide", "skbio.alignment.global_pairwise_align_protein", "skbio.alignment.local_pairwise_align", "skbio.alignment.local_pairwise_align_nucleotide", "skbio.alignment.local_pairwise_align_protein", "skbio.alignment.local_pairwise_align_ssw", "skbio.alignment.make_identity_substitution_matrix", "Alpha diversity measures (skbio.diversity.alpha)", "skbio.diversity.alpha.ace", "skbio.diversity.alpha.berger_parker_d", "skbio.diversity.alpha.brillouin_d", "skbio.diversity.alpha.chao1", "skbio.diversity.alpha.chao1_ci", "skbio.diversity.alpha.dominance", "skbio.diversity.alpha.doubles", "skbio.diversity.alpha.enspie", "skbio.diversity.alpha.esty_ci", "skbio.diversity.alpha.faith_pd", "skbio.diversity.alpha.fisher_alpha", "skbio.diversity.alpha.gini_index", "skbio.diversity.alpha.goods_coverage", "skbio.diversity.alpha.heip_e", "skbio.diversity.alpha.hill", "skbio.diversity.alpha.inv_simpson", "skbio.diversity.alpha.kempton_taylor_q", "skbio.diversity.alpha.lladser_ci", "skbio.diversity.alpha.lladser_pe", "skbio.diversity.alpha.margalef", "skbio.diversity.alpha.mcintosh_d", "skbio.diversity.alpha.mcintosh_e", "skbio.diversity.alpha.menhinick", "skbio.diversity.alpha.michaelis_menten_fit", "skbio.diversity.alpha.observed_features", "skbio.diversity.alpha.osd", "skbio.diversity.alpha.phydiv", "skbio.diversity.alpha.pielou_e", "skbio.diversity.alpha.renyi", "skbio.diversity.alpha.robbins", "skbio.diversity.alpha.shannon", "skbio.diversity.alpha.simpson", "skbio.diversity.alpha.simpson_d", "skbio.diversity.alpha.simpson_e", "skbio.diversity.alpha.singles", "skbio.diversity.alpha.sobs", "skbio.diversity.alpha.strong", "skbio.diversity.alpha.tsallis", "skbio.diversity.alpha_diversity", "Beta diversity measures (skbio.diversity.beta)", "skbio.diversity.beta.unweighted_unifrac", "skbio.diversity.beta.weighted_unifrac", "skbio.diversity.beta_diversity", "skbio.diversity.block_beta_diversity", "skbio.diversity.get_alpha_diversity_metrics", "skbio.diversity.get_beta_diversity_metrics", "skbio.diversity.partial_beta_diversity", "skbio.embedding.Embedding", "skbio.embedding.Embedding.bytes", "skbio.embedding.Embedding.read", "skbio.embedding.Embedding.write", "skbio.embedding.EmbeddingVector", "skbio.embedding.ProteinEmbedding", "skbio.embedding.ProteinVector", "skbio.embedding.SequenceEmbedding", "skbio.embedding.SequenceVector", "skbio.embedding.embed_vec_to_dataframe", "skbio.embedding.embed_vec_to_distances", "skbio.embedding.embed_vec_to_numpy", "skbio.embedding.embed_vec_to_ordination", "Simple binary dissimilarity matrix format (skbio.io.format.binary_dm)", "BIOM-Format (skbio.io.format.biom)", "BLAST+6 format (skbio.io.format.blast6)", "BLAST+7 format (skbio.io.format.blast7)", "Clustal format (skbio.io.format.clustal)", "Embedding format (skbio.io.format.embed).", "EMBL format (skbio.io.format.embl)", "FASTA/QUAL format (skbio.io.format.fasta)", "FASTQ format (skbio.io.format.fastq)", "GenBank format (skbio.io.format.genbank)", "GFF3 format (skbio.io.format.gff3)", "Labeled square matrix format (skbio.io.format.lsmat)", "Newick format (skbio.io.format.newick)", "Ordination results format (skbio.io.format.ordination)", "PHYLIP multiple sequence alignment format (skbio.io.format.phylip)", "QSeq format (skbio.io.format.qseq)", "Format Support", "Stockholm format (skbio.io.format.stockholm)", "Taxdump format (skbio.io.format.taxdump)", "I/O Registry (skbio.io.registry)", "skbio.io.registry.Format", "skbio.io.registry.Format.reader", "skbio.io.registry.Format.sniffer", "skbio.io.registry.Format.writer", "skbio.io.registry.IORegistry", "skbio.io.registry.IORegistry.add_format", "skbio.io.registry.IORegistry.create_format", "skbio.io.registry.IORegistry.get_reader", "skbio.io.registry.IORegistry.get_sniffer", "skbio.io.registry.IORegistry.get_writer", "skbio.io.registry.IORegistry.list_read_formats", "skbio.io.registry.IORegistry.list_write_formats", "skbio.io.registry.IORegistry.read", "skbio.io.registry.IORegistry.remove_format", "skbio.io.registry.IORegistry.sniff", "skbio.io.registry.IORegistry.write", "skbio.io.registry.create_format", "skbio.io.registry.read", "skbio.io.registry.sniff", "skbio.io.registry.write", "I/O utilities (skbio.io.util)", "skbio.io.util.open", "skbio.io.util.open_file", "skbio.io.util.open_files", "skbio.metadata.CategoricalMetadataColumn", "skbio.metadata.Interval", "skbio.metadata.Interval.drop", "skbio.metadata.IntervalMetadata", "skbio.metadata.IntervalMetadata.add", "skbio.metadata.IntervalMetadata.concat", "skbio.metadata.IntervalMetadata.drop", "skbio.metadata.IntervalMetadata.merge", "skbio.metadata.IntervalMetadata.query", "skbio.metadata.IntervalMetadata.read", "skbio.metadata.IntervalMetadata.sort", "skbio.metadata.IntervalMetadata.write", "skbio.metadata.IntervalMetadataMixin", "skbio.metadata.IntervalMetadataMixin.has_interval_metadata", "skbio.metadata.MetadataColumn", "skbio.metadata.MetadataColumn.drop_missing_values", "skbio.metadata.MetadataColumn.filter_ids", "skbio.metadata.MetadataColumn.get_ids", "skbio.metadata.MetadataColumn.get_missing", "skbio.metadata.MetadataColumn.get_value", "skbio.metadata.MetadataColumn.has_missing_values", "skbio.metadata.MetadataColumn.to_dataframe", "skbio.metadata.MetadataColumn.to_series", "skbio.metadata.MetadataMixin", "skbio.metadata.MetadataMixin.has_metadata", "skbio.metadata.NumericMetadataColumn", "skbio.metadata.PositionalMetadataMixin", "skbio.metadata.PositionalMetadataMixin.has_positional_metadata", "skbio.metadata.SampleMetadata", "skbio.metadata.SampleMetadata.filter_columns", "skbio.metadata.SampleMetadata.filter_ids", "skbio.metadata.SampleMetadata.get_column", "skbio.metadata.SampleMetadata.get_ids", "skbio.metadata.SampleMetadata.load", "skbio.metadata.SampleMetadata.merge", "skbio.metadata.SampleMetadata.to_dataframe", "skbio.sequence.DNA", "skbio.sequence.DNA.find_motifs", "skbio.sequence.DNA.read", "skbio.sequence.DNA.transcribe", "skbio.sequence.DNA.translate", "skbio.sequence.DNA.translate_six_frames", "skbio.sequence.DNA.write", "skbio.sequence.GeneticCode", "skbio.sequence.GeneticCode.from_ncbi", "skbio.sequence.GeneticCode.translate", "skbio.sequence.GeneticCode.translate_six_frames", "skbio.sequence.GrammaredSequence", "skbio.sequence.GrammaredSequence.definites", "skbio.sequence.GrammaredSequence.degap", "skbio.sequence.GrammaredSequence.degenerates", "skbio.sequence.GrammaredSequence.expand_degenerates", "skbio.sequence.GrammaredSequence.find_motifs", "skbio.sequence.GrammaredSequence.gaps", "skbio.sequence.GrammaredSequence.has_definites", "skbio.sequence.GrammaredSequence.has_degenerates", "skbio.sequence.GrammaredSequence.has_gaps", "skbio.sequence.GrammaredSequence.has_nondegenerates", "skbio.sequence.GrammaredSequence.nondegenerates", "skbio.sequence.GrammaredSequence.to_definites", "skbio.sequence.GrammaredSequence.to_regex", "skbio.sequence.NucleotideMixin", "skbio.sequence.NucleotideMixin.complement", "skbio.sequence.NucleotideMixin.gc_content", "skbio.sequence.NucleotideMixin.gc_frequency", "skbio.sequence.NucleotideMixin.is_reverse_complement", "skbio.sequence.NucleotideMixin.reverse_complement", "skbio.sequence.Protein", "skbio.sequence.Protein.find_motifs", "skbio.sequence.Protein.has_stops", "skbio.sequence.Protein.read", "skbio.sequence.Protein.stops", "skbio.sequence.Protein.write", "skbio.sequence.RNA", "skbio.sequence.RNA.find_motifs", "skbio.sequence.RNA.read", "skbio.sequence.RNA.reverse_transcribe", "skbio.sequence.RNA.translate", "skbio.sequence.RNA.translate_six_frames", "skbio.sequence.RNA.write", "skbio.sequence.Sequence", "skbio.sequence.Sequence.concat", "skbio.sequence.Sequence.count", "skbio.sequence.Sequence.distance", "skbio.sequence.Sequence.find_with_regex", "skbio.sequence.Sequence.frequencies", "skbio.sequence.Sequence.index", "skbio.sequence.Sequence.iter_contiguous", "skbio.sequence.Sequence.iter_kmers", "skbio.sequence.Sequence.kmer_frequencies", "skbio.sequence.Sequence.lowercase", "skbio.sequence.Sequence.match_frequency", "skbio.sequence.Sequence.matches", "skbio.sequence.Sequence.mismatch_frequency", "skbio.sequence.Sequence.mismatches", "skbio.sequence.Sequence.read", "skbio.sequence.Sequence.replace", "skbio.sequence.Sequence.to_indices", "skbio.sequence.Sequence.write", "skbio.sequence.SubstitutionMatrix", "skbio.sequence.SubstitutionMatrix.by_name", "skbio.sequence.SubstitutionMatrix.from_dict", "skbio.sequence.SubstitutionMatrix.get_names", "skbio.sequence.SubstitutionMatrix.identity", "skbio.sequence.SubstitutionMatrix.to_dict", "Sequence distance metrics (skbio.sequence.distance)", "skbio.sequence.distance.hamming", "skbio.sequence.distance.kmer_distance", "Composition Statistics (skbio.stats.composition)", "skbio.stats.composition.alr", "skbio.stats.composition.alr_inv", "skbio.stats.composition.ancom", "skbio.stats.composition.centralize", "skbio.stats.composition.closure", "skbio.stats.composition.clr", "skbio.stats.composition.clr_inv", "skbio.stats.composition.dirmult_ttest", "skbio.stats.composition.ilr", "skbio.stats.composition.ilr_inv", "skbio.stats.composition.inner", "skbio.stats.composition.multi_replace", "skbio.stats.composition.pairwise_vlr", "skbio.stats.composition.perturb", "skbio.stats.composition.perturb_inv", "skbio.stats.composition.power", "skbio.stats.composition.sbp_basis", "skbio.stats.composition.tree_basis", "skbio.stats.composition.vlr", "Distance matrix-based statistics (skbio.stats.distance)", "skbio.stats.distance.DissimilarityMatrix", "skbio.stats.distance.DissimilarityMatrix.between", "skbio.stats.distance.DissimilarityMatrix.copy", "skbio.stats.distance.DissimilarityMatrix.filter", "skbio.stats.distance.DissimilarityMatrix.from_iterable", "skbio.stats.distance.DissimilarityMatrix.index", "skbio.stats.distance.DissimilarityMatrix.plot", "skbio.stats.distance.DissimilarityMatrix.read", "skbio.stats.distance.DissimilarityMatrix.redundant_form", "skbio.stats.distance.DissimilarityMatrix.rename", "skbio.stats.distance.DissimilarityMatrix.to_data_frame", "skbio.stats.distance.DissimilarityMatrix.transpose", "skbio.stats.distance.DissimilarityMatrix.within", "skbio.stats.distance.DissimilarityMatrix.write", "skbio.stats.distance.DistanceMatrix", "skbio.stats.distance.DistanceMatrix.condensed_form", "skbio.stats.distance.DistanceMatrix.from_iterable", "skbio.stats.distance.DistanceMatrix.permute", "skbio.stats.distance.DistanceMatrix.to_series", "skbio.stats.distance.anosim", "skbio.stats.distance.bioenv", "skbio.stats.distance.mantel", "skbio.stats.distance.permanova", "skbio.stats.distance.permdisp", "skbio.stats.distance.pwmantel", "skbio.stats.distance.randdm", "Evolutionary statistics (skbio.stats.evolve)", "skbio.stats.evolve.hommola_cospeciation", "Gradient analyses (skbio.stats.gradient)", "skbio.stats.gradient.AverageGradientANOVA", "skbio.stats.gradient.CategoryResults", "skbio.stats.gradient.CategoryResults.to_files", "skbio.stats.gradient.FirstDifferenceGradientANOVA", "skbio.stats.gradient.GradientANOVA", "skbio.stats.gradient.GradientANOVA.get_trajectories", "skbio.stats.gradient.GradientANOVAResults", "skbio.stats.gradient.GradientANOVAResults.to_files", "skbio.stats.gradient.GroupResults", "skbio.stats.gradient.GroupResults.to_files", "skbio.stats.gradient.TrajectoryGradientANOVA", "skbio.stats.gradient.WindowDifferenceGradientANOVA", "skbio.stats.isubsample", "Ordination methods (skbio.stats.ordination)", "skbio.stats.ordination.OrdinationResults", "skbio.stats.ordination.OrdinationResults.plot", "skbio.stats.ordination.OrdinationResults.read", "skbio.stats.ordination.OrdinationResults.rename", "skbio.stats.ordination.OrdinationResults.write", "skbio.stats.ordination.ca", "skbio.stats.ordination.cca", "skbio.stats.ordination.corr", "skbio.stats.ordination.e_matrix", "skbio.stats.ordination.f_matrix", "skbio.stats.ordination.mean_and_std", "skbio.stats.ordination.pcoa", "skbio.stats.ordination.pcoa_biplot", "skbio.stats.ordination.rda", "skbio.stats.ordination.scale", "skbio.stats.ordination.svd_rank", "Empirical Power Estimation (skbio.stats.power)", "skbio.stats.power.confidence_bound", "skbio.stats.power.paired_subsamples", "skbio.stats.power.subsample_paired_power", "skbio.stats.power.subsample_power", "skbio.stats.subsample_counts", "skbio.table.Table", "skbio.table.Table.add_group_metadata", "skbio.table.Table.add_metadata", "skbio.table.Table.align_to", "skbio.table.Table.align_to_dataframe", "skbio.table.Table.align_tree", "skbio.table.Table.collapse", "skbio.table.Table.concat", "skbio.table.Table.copy", "skbio.table.Table.data", "skbio.table.Table.del_metadata", "skbio.table.Table.delimited_self", "skbio.table.Table.descriptive_equality", "skbio.table.Table.exists", "skbio.table.Table.filter", "skbio.table.Table.from_adjacency", "skbio.table.Table.from_hdf5", "skbio.table.Table.from_json", "skbio.table.Table.from_tsv", "skbio.table.Table.get_table_density", "skbio.table.Table.get_value_by_ids", "skbio.table.Table.group_metadata", "skbio.table.Table.head", "skbio.table.Table.ids", "skbio.table.Table.index", "skbio.table.Table.is_empty", "skbio.table.Table.iter", "skbio.table.Table.iter_data", "skbio.table.Table.iter_pairwise", "skbio.table.Table.length", "skbio.table.Table.max", "skbio.table.Table.merge", "skbio.table.Table.metadata", "skbio.table.Table.metadata_to_dataframe", "skbio.table.Table.min", "skbio.table.Table.nonzero", "skbio.table.Table.nonzero_counts", "skbio.table.Table.norm", "skbio.table.Table.pa", "skbio.table.Table.partition", "skbio.table.Table.rankdata", "skbio.table.Table.read", "skbio.table.Table.reduce", "skbio.table.Table.remove_empty", "skbio.table.Table.sort", "skbio.table.Table.sort_order", "skbio.table.Table.subsample", "skbio.table.Table.sum", "skbio.table.Table.to_anndata", "skbio.table.Table.to_dataframe", "skbio.table.Table.to_hdf5", "skbio.table.Table.to_json", "skbio.table.Table.to_tsv", "skbio.table.Table.transform", "skbio.table.Table.transpose", "skbio.table.Table.update_ids", "skbio.table.Table.write", "skbio.table.example_table", "skbio.tree.TreeNode", "skbio.tree.TreeNode.ancestors", "skbio.tree.TreeNode.append", "skbio.tree.TreeNode.ascii_art", "skbio.tree.TreeNode.assign_ids", "skbio.tree.TreeNode.assign_supports", "skbio.tree.TreeNode.bifurcate", "skbio.tree.TreeNode.bipart", "skbio.tree.TreeNode.biparts", "skbio.tree.TreeNode.cache_attr", "skbio.tree.TreeNode.clear_caches", "skbio.tree.TreeNode.compare_biparts", "skbio.tree.TreeNode.compare_cophenet", "skbio.tree.TreeNode.compare_rfd", "skbio.tree.TreeNode.compare_subsets", "skbio.tree.TreeNode.compare_wrfd", "skbio.tree.TreeNode.cophenet", "skbio.tree.TreeNode.copy", "skbio.tree.TreeNode.count", "skbio.tree.TreeNode.create_caches", "skbio.tree.TreeNode.deepcopy", "skbio.tree.TreeNode.depth", "skbio.tree.TreeNode.distance", "skbio.tree.TreeNode.extend", "skbio.tree.TreeNode.find", "skbio.tree.TreeNode.find_all", "skbio.tree.TreeNode.find_by_func", "skbio.tree.TreeNode.find_by_id", "skbio.tree.TreeNode.from_linkage_matrix", "skbio.tree.TreeNode.from_taxdump", "skbio.tree.TreeNode.from_taxonomy", "skbio.tree.TreeNode.has_caches", "skbio.tree.TreeNode.has_children", "skbio.tree.TreeNode.height", "skbio.tree.TreeNode.index_tree", "skbio.tree.TreeNode.insert", "skbio.tree.TreeNode.is_bifurcating", "skbio.tree.TreeNode.is_root", "skbio.tree.TreeNode.is_tip", "skbio.tree.TreeNode.lca", "skbio.tree.TreeNode.levelorder", "skbio.tree.TreeNode.maxdist", "skbio.tree.TreeNode.neighbors", "skbio.tree.TreeNode.non_tips", "skbio.tree.TreeNode.observed_node_counts", "skbio.tree.TreeNode.path", "skbio.tree.TreeNode.pop", "skbio.tree.TreeNode.postorder", "skbio.tree.TreeNode.pre_and_postorder", "skbio.tree.TreeNode.preorder", "skbio.tree.TreeNode.prune", "skbio.tree.TreeNode.read", "skbio.tree.TreeNode.remove", "skbio.tree.TreeNode.remove_by_func", "skbio.tree.TreeNode.remove_deleted", "skbio.tree.TreeNode.root", "skbio.tree.TreeNode.root_at", "skbio.tree.TreeNode.root_at_midpoint", "skbio.tree.TreeNode.root_by_outgroup", "skbio.tree.TreeNode.shear", "skbio.tree.TreeNode.shuffle", "skbio.tree.TreeNode.siblings", "skbio.tree.TreeNode.subset", "skbio.tree.TreeNode.subsets", "skbio.tree.TreeNode.subtree", "skbio.tree.TreeNode.tips", "skbio.tree.TreeNode.to_array", "skbio.tree.TreeNode.to_taxonomy", "skbio.tree.TreeNode.total_length", "skbio.tree.TreeNode.traverse", "skbio.tree.TreeNode.unpack", "skbio.tree.TreeNode.unpack_by_func", "skbio.tree.TreeNode.unroot", "skbio.tree.TreeNode.unrooted_copy", "skbio.tree.TreeNode.unrooted_deepcopy", "skbio.tree.TreeNode.unrooted_move", "skbio.tree.TreeNode.write", "skbio.tree.bme", "skbio.tree.gme", "skbio.tree.majority_rule", "skbio.tree.nj", "skbio.tree.nni", "skbio.tree.path_dists", "skbio.tree.rf_dists", "skbio.tree.upgma", "skbio.tree.wrf_dists", "skbio.util.PlottableMixin", "skbio.util.aliased", "skbio.util.assert_data_frame_almost_equal", "skbio.util.assert_ordination_results_equal", "skbio.util.cardinal_to_ordinal", "skbio.util.classonlymethod", "skbio.util.classproperty", "skbio.util.deprecated", "skbio.util.find_duplicates", "skbio.util.get_data_path", "skbio.util.get_rng", "skbio.util.overrides", "skbio.util.params_aliased", "skbio.util.register_aliases", "skbio.util.safe_md5", "skbio.workflow.Workflow", "skbio.workflow.Workflow.initialize_state", "skbio.workflow.method", "skbio.workflow.requires", "Home", "Input and Output (skbio.io)", "Metadata (skbio.metadata)", "Biological Sequences (skbio.sequence)", "Multivariate Statistics (skbio.stats)", "Data Table (skbio.table)", "Trees and Phylogenetics (skbio.tree)", "Utilities for Developers (skbio.util)", "Workflow construction (skbio.workflow)"], "titleterms": {"0": 505, "3": 505, "6": [106, 505], "7": 107, "abstract": [507, 508], "abund": 256, "ac": 44, "ad": 116, "add": 152, "add_format": 129, "add_group_metadata": 343, "add_metadata": 344, "advanc": 116, "algorithm": 0, "alias": 487, "align": [0, 3, 4, 5, 6, 7, 8, 9, 10, 11, 12, 13, 14, 15, 16, 17, 18, 19, 20, 21, 22, 23, 24, 25, 26, 27, 28, 29, 30, 31, 32, 33, 34, 35, 36, 37, 38, 39, 40, 41, 42, 108, 118, 121], "align_to": 345, "align_to_datafram": 346, "align_tre": 347, "alignmentstructur": [11, 12, 13], "alignpath": [3, 4, 5, 6, 7, 8, 9, 10], "alpha": [1, 43, 44, 45, 46, 47, 48, 49, 50, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 71, 72, 73, 74, 75, 76, 77, 78, 79, 80, 81], "alpha_divers": 82, "alr": 257, "alr_inv": 258, "analys": 305, "analysi": [256, 319], "ancestor": 401, "ancom": 259, "anosim": 296, "append": [21, 402], "applic": 116, "argument": 123, "arithmet": 256, "ascii_art": 403, "assert_data_frame_almost_equ": 488, "assert_ordination_results_equ": 489, "assign_id": 404, "assign_support": 405, "averagegradientanova": 306, "base": 276, "basi": 256, "basic": 116, "befor": [110, 113], "berger_parker_d": 45, "beta": [1, 83, 84, 85], "beta_divers": 86, "between": 278, "bifurc": 406, "binari": 104, "binary_dm": 104, "bio": [123, 505, 506], "bioenv": 297, "biolog": [2, 508], "biom": [105, 510], "bipart": [407, 408], "blast": [106, 107], "blast6": 106, "blast7": 107, "block_beta_divers": 87, "bme": 477, "brillouin_d": 46, "by_nam": 248, "byte": 92, "ca": 325, "cache_attr": 409, "calcul": 508, "can": 506, "canon": 319, "cardinal_to_ordin": 490, "categor": 276, "categoricalmetadatacolumn": 148, "categoryresult": [307, 308], "caveat": 116, "cca": 326, "central": 260, "chao1": 47, "chao1_ci": 48, "charact": 120, "class": [123, 276, 305, 507, 508, 513], "classonlymethod": 491, "classproperti": 492, "clear_cach": 410, "closur": 261, "clr": 262, "clr_inv": 263, "clustal": 108, "collaps": 348, "column": [106, 107, 120, 507], "comment": [116, 120], "commun": 1, "compare_bipart": 411, "compare_cophenet": 412, "compare_rfd": 413, "compare_subset": 414, "compare_wrfd": 415, "comparison": [276, 511], "complement": 210, "composit": [256, 257, 258, 259, 260, 261, 262, 263, 264, 265, 266, 267, 268, 269, 270, 271, 272, 273, 274, 275, 509], "concat": [153, 229, 349], "condensed_form": 292, "confidence_bound": 337, "consensu": 22, "conserv": 23, "construct": [256, 511, 513], "continu": 276, "cophenet": 416, "cophylogenet": 303, "copi": [279, 350, 417], "corr": 327, "correl": 256, "correspond": 319, "count": [1, 230, 418], "coverag": 43, "creat": 123, "create_cach": 419, "create_format": [130, 140], "custom": 506, "data": [0, 111, 276, 351, 509, 510], "decor": [512, 513], "deepcopi": 420, "definit": 196, "degap": 197, "degener": 198, "del_metadata": 352, "delimited_self": 353, "deprec": [0, 493], "depth": 421, "descriptive_equ": 354, "dev": 505, "develop": [506, 512], "differenti": 256, "dirmult_ttest": 264, "dissimilar": 104, "dissimilaritymatrix": [277, 278, 279, 280, 281, 282, 283, 284, 285, 286, 287, 288, 289, 290], "distanc": [231, 253, 254, 255, 276, 277, 278, 279, 280, 281, 282, 283, 284, 285, 286, 287, 288, 289, 290, 291, 292, 293, 294, 295, 296, 297, 298, 299, 300, 301, 302, 422, 508, 509], "distancematrix": [291, 292, 293, 294, 295], "divers": [1, 43, 44, 45, 46, 47, 48, 49, 50, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 71, 72, 73, 74, 75, 76, 77, 78, 79, 80, 81, 82, 83, 84, 85, 86, 87, 88, 89, 90], "divis": 122, "dmp": 122, "dna": [184, 185, 186, 187, 188, 189, 190], "document": 505, "domin": [43, 49], "doubl": 50, "drop": [150, 154], "drop_missing_valu": 163, "e_matrix": 328, "emb": 109, "embed": [2, 91, 92, 93, 94, 95, 96, 97, 98, 99, 100, 101, 102, 103, 109], "embed_vec_to_datafram": 100, "embed_vec_to_dist": 101, "embed_vec_to_numpi": 102, "embed_vec_to_ordin": 103, "embeddingvector": 95, "embl": 110, "empir": 336, "empti": 120, "enspi": 51, "estim": 336, "esty_ci": 52, "even": 43, "evolutionari": 303, "evolv": [303, 304], "exampl": [105, 106, 107, 108, 109, 110, 111, 112, 113, 114, 116, 117, 118, 119, 121, 122, 276, 305, 319, 336, 510], "example_t": 399, "except": [123, 276, 506, 511], "exist": 355, "expand_degener": 199, "explan": 116, "extend": [24, 423], "f_matrix": 329, "faith_pd": 53, "fasta": 111, "fastq": 112, "featur": [110, 113], "fh": 110, "file": [110, 111, 113, 506], "filter": [280, 356], "filter_column": 177, "filter_id": [164, 178], "find": 424, "find_al": 425, "find_by_func": 426, "find_by_id": 427, "find_dupl": 494, "find_motif": [185, 200, 216, 222], "find_with_regex": 232, "firstdifferencegradientanova": 309, "fisher_alpha": 54, "footer": 121, "formal": 116, "format": [104, 105, 106, 107, 108, 109, 110, 111, 112, 113, 114, 115, 116, 117, 118, 119, 120, 121, 122, 123, 124, 125, 126, 127, 506], "frequenc": 233, "from": 506, "from_adjac": 357, "from_bit": [4, 15], "from_cigar": 16, "from_coordin": 5, "from_dict": [25, 249], "from_hdf5": 358, "from_indic": 6, "from_iter": [281, 293], "from_json": 359, "from_linkage_matrix": 428, "from_ncbi": 192, "from_path_seq": 26, "from_tabular": 7, "from_taxdump": 429, "from_taxonomi": 430, "from_tsv": 360, "ft": 110, "function": [0, 83, 123, 144, 253, 276, 303, 319, 336], "g": 121, "gap": 201, "gap_frequ": 27, "gc": 121, "gc_content": 211, "gc_frequenc": 212, "genbank": 113, "gencod": 122, "gener": [110, 111, 119], "geneticcod": [191, 192, 193, 194], "get_alpha_diversity_metr": 88, "get_beta_diversity_metr": 89, "get_column": 179, "get_data_path": 495, "get_id": [165, 180], "get_miss": 166, "get_nam": 250, "get_read": 131, "get_rng": 496, "get_sniff": 132, "get_table_dens": 361, "get_trajectori": 311, "get_valu": 167, "get_value_by_id": 362, "get_writ": 133, "gf": 121, "gff3": 114, "gini_index": 55, "global_pairwise_align": 35, "global_pairwise_align_nucleotid": 36, "global_pairwise_align_protein": 37, "gme": 478, "goods_coverag": 56, "gr": 121, "gradient": [305, 306, 307, 308, 309, 310, 311, 312, 313, 314, 315, 316, 317], "gradientanova": [310, 311], "gradientanovaresult": [312, 313], "grammar": 116, "grammaredsequ": [195, 196, 197, 198, 199, 200, 201, 202, 203, 204, 205, 206, 207, 208], "group_metadata": 363, "groupresult": [314, 315], "ham": 254, "handl": 256, "has_cach": 431, "has_children": 432, "has_definit": 202, "has_degener": 203, "has_gap": 204, "has_interval_metadata": 161, "has_metadata": 172, "has_missing_valu": 168, "has_nondegener": 205, "has_positional_metadata": 175, "has_stop": 217, "head": 364, "header": [110, 111, 118, 121], "height": 433, "heip_": 57, "hill": 58, "hommola_cospeci": 304, "i": [123, 144], "id": 365, "ident": 251, "identifi": 120, "ilr": 265, "ilr_inv": 266, "index": [234, 282, 366], "index_tre": 434, "inform": 116, "initialize_st": 502, "inlin": 116, "inner": 267, "input": [1, 506], "insert": 435, "interv": [149, 150, 507], "intervalmetadata": [151, 152, 153, 154, 155, 156, 157, 158, 159], "intervalmetadatamixin": [160, 161], "introduct": 1, "inv_simpson": 59, "io": [104, 105, 106, 107, 108, 109, 110, 111, 112, 113, 114, 115, 116, 117, 118, 119, 121, 122, 123, 124, 125, 126, 127, 128, 129, 130, 131, 132, 133, 134, 135, 136, 137, 138, 139, 140, 141, 142, 143, 144, 145, 146, 147, 506], "ioregistri": [128, 129, 130, 131, 132, 133, 134, 135, 136, 137, 138, 139], "is_bifurc": 436, "is_empti": 367, "is_reverse_compl": 213, "is_root": 437, "is_tip": 438, "is_zero_bas": 12, "isubsampl": 318, "iter": 368, "iter_contigu": 235, "iter_data": 369, "iter_km": 236, "iter_pairwis": 370, "iter_posit": 28, "join": 29, "kempton_taylor_q": 60, "keyword": 123, "kind": 506, "kmer_dist": 255, "kmer_frequ": 237, "label": [115, 116], "lca": 439, "lead": 120, "length": [116, 371], "level": 110, "levelord": 440, "list_read_format": 134, "list_write_format": 135, "lladser_ci": 61, "lladser_p": 62, "load": 181, "local_pairwise_align": 38, "local_pairwise_align_nucleotid": 39, "local_pairwise_align_protein": 40, "local_pairwise_align_ssw": 41, "locat": 113, "log": 256, "lowercas": 238, "lsmat": 115, "majority_rul": 479, "make_identity_substitution_matrix": 42, "mantel": 298, "margalef": 63, "match": 240, "match_frequ": 239, "matrix": [104, 115, 276, 509], "max": 372, "maxdist": 441, "mcintosh_": 65, "mcintosh_d": 64, "mean_and_std": 330, "measur": [43, 83], "menhinick": 66, "merg": [155, 182, 373], "metadata": [120, 121, 148, 149, 150, 151, 152, 153, 154, 155, 156, 157, 158, 159, 160, 161, 162, 163, 164, 165, 166, 167, 168, 169, 170, 171, 172, 173, 174, 175, 176, 177, 178, 179, 180, 181, 182, 183, 374, 507], "metadata_to_datafram": 375, "metadatacolumn": [162, 163, 164, 165, 166, 167, 168, 169, 170], "metadatamixin": [171, 172], "method": [303, 319, 503, 509], "metric": [1, 43, 253], "michaelis_menten_fit": 67, "min": 376, "miscellan": 512, "mismatch": 242, "mismatch_frequ": 241, "multi": 111, "multi_replac": 268, "multidimension": 319, "multipl": [118, 121], "multivari": 509, "name": 122, "neighbor": 442, "new": 123, "newick": 116, "nj": 480, "nni": 481, "node": [116, 122], "non_tip": 443, "nondegener": 206, "nonzero": 377, "nonzero_count": 378, "norm": 379, "nucleotidemixin": [209, 210, 211, 212, 213, 214], "number": 120, "numericmetadatacolumn": 173, "o": [123, 144], "observed_featur": 68, "observed_node_count": 444, "onli": 119, "open": 145, "open_fil": [146, 147], "oper": [256, 511], "optim": 0, "ordin": [117, 319, 320, 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, 331, 332, 333, 334, 335, 509], "ordinationresult": [320, 321, 322, 323, 324], "origin": 113, "osd": 69, "other": 509, "output": 506, "overrid": 497, "pa": 380, "pairalignpath": [14, 15, 16, 17, 18], "paired_subsampl": 338, "pairwise_vlr": 269, "paramet": [106, 108, 111, 112, 113, 114, 115, 116, 118, 119, 121, 122], "params_alias": 498, "partial_beta_divers": 90, "partit": 381, "path": 445, "path_dist": 482, "pcoa": 331, "pcoa_biplot": 332, "permanova": 299, "permdisp": 300, "permut": 294, "perturb": 270, "perturb_inv": 271, "phydiv": 70, "phylip": 118, "phylogenet": 511, "pielou_": 71, "plot": [283, 321, 512], "plottablemixin": 486, "pop": 446, "positionalmetadatamixin": [174, 175], "postord": 447, "power": [272, 336, 337, 338, 339, 340], "pre_and_postord": 448, "preorder": 449, "product": 110, "protein": [215, 216, 217, 218, 219, 220], "proteinembed": 96, "proteinvector": 97, "prune": 450, "pwmantel": 301, "qseq": 119, "qual": 111, "qualiti": 112, "queri": 156, "randdm": 302, "rankdata": 382, "ratio": 256, "rda": 333, "read": [30, 93, 110, 111, 113, 136, 141, 157, 186, 218, 223, 243, 284, 322, 383, 451, 506], "reader": [111, 113, 114, 125], "rearrang": 511, "reassign_index": 31, "recommend": 120, "reduc": 384, "redundant_form": 285, "refer": [43, 104, 105, 106, 107, 108, 110, 111, 112, 113, 114, 116, 118, 119, 121, 122, 256, 276, 319], "register_alias": 499, "registri": [123, 124, 125, 126, 127, 128, 129, 130, 131, 132, 133, 134, 135, 136, 137, 138, 139, 140, 141, 142, 143], "remov": 452, "remove_by_func": 453, "remove_delet": 454, "remove_empti": 385, "remove_format": 137, "renam": [286, 323], "renyi": 72, "replac": 244, "requir": [120, 504], "reserv": 123, "result": [117, 319], "reverse_compl": 214, "reverse_transcrib": 224, "rf_dist": 483, "rich": 43, "rna": [221, 222, 223, 224, 225, 226, 227], "robbin": 73, "root": 455, "root_at": 456, "root_at_midpoint": 457, "root_by_outgroup": 458, "row": 120, "rule": 116, "safe_md5": 500, "sampl": 507, "samplemetadata": [176, 177, 178, 179, 180, 181, 182, 183], "sbp_basi": 273, "scale": [319, 334], "scikit": [123, 505, 506], "score": 112, "section": [108, 110, 113, 118], "sequenc": [0, 111, 118, 121, 184, 185, 186, 187, 188, 189, 190, 191, 192, 193, 194, 195, 196, 197, 198, 199, 200, 201, 202, 203, 204, 205, 206, 207, 208, 209, 210, 211, 212, 213, 214, 215, 216, 217, 218, 219, 220, 221, 222, 223, 224, 225, 226, 227, 228, 229, 230, 231, 232, 233, 234, 235, 236, 237, 238, 239, 240, 241, 242, 243, 244, 245, 246, 247, 248, 249, 250, 251, 252, 253, 254, 255, 508], "sequenceembed": 98, "sequencevector": 99, "set_zero_bas": 13, "shannon": 74, "shear": 459, "shuffl": 460, "sibl": 461, "simpl": 104, "simpson": 75, "simpson_": 77, "simpson_d": 76, "singl": 78, "skbio": [0, 1, 2, 3, 4, 5, 6, 7, 8, 9, 10, 11, 12, 13, 14, 15, 16, 17, 18, 19, 20, 21, 22, 23, 24, 25, 26, 27, 28, 29, 30, 31, 32, 33, 34, 35, 36, 37, 38, 39, 40, 41, 42, 43, 44, 45, 46, 47, 48, 49, 50, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 71, 72, 73, 74, 75, 76, 77, 78, 79, 80, 81, 82, 83, 84, 85, 86, 87, 88, 89, 90, 91, 92, 93, 94, 95, 96, 97, 98, 99, 100, 101, 102, 103, 104, 105, 106, 107, 108, 109, 110, 111, 112, 113, 114, 115, 116, 117, 118, 119, 121, 122, 123, 124, 125, 126, 127, 128, 129, 130, 131, 132, 133, 134, 135, 136, 137, 138, 139, 140, 141, 142, 143, 144, 145, 146, 147, 148, 149, 150, 151, 152, 153, 154, 155, 156, 157, 158, 159, 160, 161, 162, 163, 164, 165, 166, 167, 168, 169, 170, 171, 172, 173, 174, 175, 176, 177, 178, 179, 180, 181, 182, 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, 193, 194, 195, 196, 197, 198, 199, 200, 201, 202, 203, 204, 205, 206, 207, 208, 209, 210, 211, 212, 213, 214, 215, 216, 217, 218, 219, 220, 221, 222, 223, 224, 225, 226, 227, 228, 229, 230, 231, 232, 233, 234, 235, 236, 237, 238, 239, 240, 241, 242, 243, 244, 245, 246, 247, 248, 249, 250, 251, 252, 253, 254, 255, 256, 257, 258, 259, 260, 261, 262, 263, 264, 265, 266, 267, 268, 269, 270, 271, 272, 273, 274, 275, 276, 277, 278, 279, 280, 281, 282, 283, 284, 285, 286, 287, 288, 289, 290, 291, 292, 293, 294, 295, 296, 297, 298, 299, 300, 301, 302, 303, 304, 305, 306, 307, 308, 309, 310, 311, 312, 313, 314, 315, 316, 317, 318, 319, 320, 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, 331, 332, 333, 334, 335, 336, 337, 338, 339, 340, 341, 342, 343, 344, 345, 346, 347, 348, 349, 350, 351, 352, 353, 354, 355, 356, 357, 358, 359, 360, 361, 362, 363, 364, 365, 366, 367, 368, 369, 370, 371, 372, 373, 374, 375, 376, 377, 378, 379, 380, 381, 382, 383, 384, 385, 386, 387, 388, 389, 390, 391, 392, 393, 394, 395, 396, 397, 398, 399, 400, 401, 402, 403, 404, 405, 406, 407, 408, 409, 410, 411, 412, 413, 414, 415, 416, 417, 418, 419, 420, 421, 422, 423, 424, 425, 426, 427, 428, 429, 430, 431, 432, 433, 434, 435, 436, 437, 438, 439, 440, 441, 442, 443, 444, 445, 446, 447, 448, 449, 450, 451, 452, 453, 454, 455, 456, 457, 458, 459, 460, 461, 462, 463, 464, 465, 466, 467, 468, 469, 470, 471, 472, 473, 474, 475, 476, 477, 478, 479, 480, 481, 482, 483, 484, 485, 486, 487, 488, 489, 490, 491, 492, 493, 494, 495, 496, 497, 498, 499, 500, 501, 502, 503, 504, 506, 507, 508, 509, 510, 511, 512, 513], "slow": 0, "sniff": [138, 142], "sniffer": 126, "sob": 79, "sort": [32, 158, 386], "sort_ord": 387, "specif": [104, 105, 106, 107, 108, 109, 110, 111, 112, 113, 114, 115, 116, 117, 118, 119, 120, 121, 122], "specifi": 1, "sq": 110, "squar": 115, "stat": [256, 257, 258, 259, 260, 261, 262, 263, 264, 265, 266, 267, 268, 269, 270, 271, 272, 273, 274, 275, 276, 277, 278, 279, 280, 281, 282, 283, 284, 285, 286, 287, 288, 289, 290, 291, 292, 293, 294, 295, 296, 297, 298, 299, 300, 301, 302, 303, 304, 305, 306, 307, 308, 309, 310, 311, 312, 313, 314, 315, 316, 317, 318, 319, 320, 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, 331, 332, 333, 334, 335, 336, 337, 338, 339, 340, 341, 509], "statist": [256, 276, 303, 509], "stockholm": 121, "stop": 219, "stream": 506, "string": 113, "stripedsmithwaterman": 19, "strong": 80, "structur": [0, 276, 511], "subsampl": [388, 509], "subsample_count": 341, "subsample_paired_pow": 339, "subsample_pow": 340, "subset": [462, 463], "substitutionmatrix": [247, 248, 249, 250, 251, 252], "subtre": 464, "sum": 389, "support": [104, 105, 106, 107, 108, 109, 110, 111, 112, 113, 114, 115, 116, 117, 118, 119, 120, 121, 122, 506], "svd_rank": 335, "symbol": 116, "tabl": [342, 343, 344, 345, 346, 347, 348, 349, 350, 351, 352, 353, 354, 355, 356, 357, 358, 359, 360, 361, 362, 363, 364, 365, 366, 367, 368, 369, 370, 371, 372, 373, 374, 375, 376, 377, 378, 379, 380, 381, 382, 383, 384, 385, 386, 387, 388, 389, 390, 391, 392, 393, 394, 395, 396, 397, 398, 399, 510], "tabularmsa": [20, 21, 22, 23, 24, 25, 26, 27, 28, 29, 30, 31, 32, 33, 34, 111], "taxdump": 122, "test": 512, "tip": 465, "to_anndata": 390, "to_arrai": 466, "to_bit": [8, 17], "to_cigar": 18, "to_coordin": 9, "to_data_fram": 287, "to_datafram": [169, 183, 391], "to_definit": 207, "to_dict": [33, 252], "to_fil": [308, 313, 315], "to_hdf5": 392, "to_indic": [10, 245], "to_json": 393, "to_regex": 208, "to_seri": [170, 295], "to_taxonomi": 467, "to_tsv": 394, "total_length": 468, "trail": 120, "trajectorygradientanova": 316, "transcrib": 187, "transform": [256, 395], "translat": [188, 193, 225], "translate_six_fram": [189, 194, 226], "transpos": [288, 396], "travers": 469, "tree": [400, 401, 402, 403, 404, 405, 406, 407, 408, 409, 410, 411, 412, 413, 414, 415, 416, 417, 418, 419, 420, 421, 422, 423, 424, 425, 426, 427, 428, 429, 430, 431, 432, 433, 434, 435, 436, 437, 438, 439, 440, 441, 442, 443, 444, 445, 446, 447, 448, 449, 450, 451, 452, 453, 454, 455, 456, 457, 458, 459, 460, 461, 462, 463, 464, 465, 466, 467, 468, 469, 470, 471, 472, 473, 474, 475, 476, 477, 478, 479, 480, 481, 482, 483, 484, 485, 511], "tree_basi": 274, "treenod": [400, 401, 402, 403, 404, 405, 406, 407, 408, 409, 410, 411, 412, 413, 414, 415, 416, 417, 418, 419, 420, 421, 422, 423, 424, 425, 426, 427, 428, 429, 430, 431, 432, 433, 434, 435, 436, 437, 438, 439, 440, 441, 442, 443, 444, 445, 446, 447, 448, 449, 450, 451, 452, 453, 454, 455, 456, 457, 458, 459, 460, 461, 462, 463, 464, 465, 466, 467, 468, 469, 470, 471, 472, 473, 474, 475, 476], "tsalli": 81, "tutori": [0, 1, 506, 508, 511, 513], "type": [2, 106, 107, 120, 508], "unpack": 470, "unpack_by_func": 471, "unroot": 472, "unrooted_copi": 473, "unrooted_deepcopi": 474, "unrooted_mov": 475, "unweighted_unifrac": 84, "update_id": 397, "upgma": 484, "us": [0, 110, 506], "util": [2, 144, 145, 146, 147, 319, 486, 487, 488, 489, 490, 491, 492, 493, 494, 495, 496, 497, 498, 499, 500, 508, 511, 512], "valid": [1, 120], "variabl": 276, "variant": 112, "vector": [1, 2], "vlr": 275, "warn": 506, "weighted_unifrac": 85, "what": 506, "whitespac": [116, 120], "windowdifferencegradientanova": 317, "within": 289, "workflow": [501, 502, 503, 504, 513], "wrf_dist": 485, "write": [34, 94, 111, 113, 139, 143, 159, 190, 220, 227, 246, 290, 324, 398, 476, 506], "writer": [111, 114, 127], "zero": 256}}) \ No newline at end of file +Search.setIndex({"alltitles": {"Abstract classes": [[507, "abstract-classes"], [508, "abstract-classes"]], "Adding Node Information": [[116, "adding-node-information"]], "Advanced Label and Length Rules": [[116, "advanced-label-and-length-rules"]], "Alignment Section": [[108, "alignment-section"], [118, "alignment-section"]], "Alignment algorithms": [[0, "alignment-algorithms"]], "Alignment data structure": [[0, "alignment-data-structure"]], "Alignment structure": [[0, "alignment-structure"]], "Alpha diversity": [[1, "alpha-diversity"]], "Alpha diversity measures (skbio.diversity.alpha)": [[43, null]], "Application of Rules": [[116, "application-of-rules"]], "Arithmetic operations": [[256, "arithmetic-operations"]], "BIOM table": [[510, "biom-table"]], "BIOM-Format (skbio.io.format.biom)": [[105, null]], "BLAST Column Types": [[106, "blast-column-types"], [107, "blast-column-types"]], "BLAST+6 format (skbio.io.format.blast6)": [[106, null]], "BLAST+7 format (skbio.io.format.blast7)": [[107, null]], "Basic Symbols": [[116, "basic-symbols"]], "Basis construction": [[256, "basis-construction"]], "Beta diversity": [[1, "beta-diversity"]], "Beta diversity measures (skbio.diversity.beta)": [[83, null]], "Biological Embeddings (skbio.embedding)": [[2, null]], "Biological Sequences (skbio.sequence)": [[508, null]], "Canonical analysis": [[319, "canonical-analysis"]], "Categorical Variable Stats": [[276, "categorical-variable-stats"]], "Caveats": [[116, "caveats"]], "Classes": [[123, "classes"], [276, "classes"], [305, "classes"], [513, "classes"]], "Clustal format (skbio.io.format.clustal)": [[108, null]], "Column Types": [[120, "column-types"]], "Comments and Empty Rows": [[120, "comments-and-empty-rows"]], "Community Diversity (skbio.diversity)": [[1, null]], "Composition Statistics (skbio.stats.composition)": [[256, null]], "Composition statistics": [[509, "composition-statistics"]], "Continuous Variable Stats": [[276, "continuous-variable-stats"]], "Cophylogenetic methods": [[303, "cophylogenetic-methods"]], "Correlation analysis": [[256, "correlation-analysis"]], "Correspondence analysis": [[319, "correspondence-analysis"]], "Count vectors": [[1, "count-vectors"]], "Coverage metrics": [[43, "coverage-metrics"]], "Creating a new format for scikit-bio": [[123, "creating-a-new-format-for-scikit-bio"]], "Data Table (skbio.table)": [[510, null]], "Data structures": [[276, "data-structures"]], "Data subsampling": [[509, "data-subsampling"]], "Decorators": [[512, "decorators"], [513, "decorators"]], "Deprecated functionality": [[0, "deprecated-functionality"]], "Develop custom formats": [[506, "develop-custom-formats"]], "Differential abundance": [[256, "differential-abundance"]], "Distance Matrix Comparisons": [[276, "distance-matrix-comparisons"]], "Distance calculation": [[508, "distance-calculation"]], "Distance matrix statistics": [[509, "distance-matrix-statistics"]], "Distance matrix-based statistics (skbio.stats.distance)": [[276, null]], "Distance-based statistics": [[276, "distance-based-statistics"]], "Diversity metrics": [[43, "diversity-metrics"]], "Dominance metrics": [[43, "dominance-metrics"]], "EMBL format (skbio.io.format.embl)": [[110, null]], "Embedding format (skbio.io.format.embed).": [[109, null]], "Embedding types": [[2, "embedding-types"]], "Embedding vector types": [[2, "embedding-vector-types"]], "Embedding vector utilities": [[2, "embedding-vector-utilities"]], "Empirical Power Estimation (skbio.stats.power)": [[336, null]], "Evenness metrics": [[43, "evenness-metrics"]], "Evolutionary statistics (skbio.stats.evolve)": [[303, null]], "Example data": [[510, "example-data"]], "Examples": [[105, "examples"], [106, "examples"], [107, "examples"], [108, "examples"], [109, "examples"], [110, "examples"], [111, "examples"], [112, "examples"], [113, "examples"], [114, "examples"], [116, "examples"], [117, "examples"], [118, "examples"], [119, "examples"], [121, "examples"], [122, "examples"], [276, "examples"], [305, "examples"], [319, "examples"], [336, "examples"]], "Exceptions": [[123, "exceptions"], [276, "exceptions"], [511, "exceptions"]], "Exceptions and warnings": [[506, "exceptions-and-warnings"]], "Explanation": [[116, "explanation"]], "FASTA Format": [[111, "fasta-format"]], "FASTA/QUAL format (skbio.io.format.fasta)": [[111, null]], "FASTQ format (skbio.io.format.fastq)": [[112, null]], "FEATURES section": [[113, "features-section"]], "FT section": [[110, "ft-section"]], "Feature Level Products": [[110, "feature-level-products"]], "Footer": [[121, "footer"]], "Formal Grammar": [[116, "formal-grammar"]], "Format Parameters": [[106, "format-parameters"], [108, "format-parameters"], [111, "format-parameters"], [112, "format-parameters"], [113, "format-parameters"], [114, "format-parameters"], [115, "format-parameters"], [116, "format-parameters"], [118, "format-parameters"], [119, "format-parameters"], [121, "format-parameters"], [122, "format-parameters"]], "Format Specification": [[104, "format-specification"], [105, "format-specification"], [106, "format-specification"], [107, "format-specification"], [108, "format-specification"], [109, "format-specification"], [110, "format-specification"], [111, "format-specification"], [112, "format-specification"], [113, "format-specification"], [114, "format-specification"], [115, "format-specification"], [116, "format-specification"], [117, "format-specification"], [118, "format-specification"], [119, "format-specification"], [120, "format-specification"], [121, "format-specification"], [122, "format-specification"]], "Format Support": [[104, "format-support"], [105, "format-support"], [106, "format-support"], [107, "format-support"], [108, "format-support"], [109, "format-support"], [110, "format-support"], [111, "format-support"], [112, "format-support"], [113, "format-support"], [114, "format-support"], [115, "format-support"], [116, "format-support"], [117, "format-support"], [118, "format-support"], [119, "format-support"], [120, null], [121, "format-support"], [122, "format-support"]], "Functions": [[83, "functions"], [123, "functions"], [144, "functions"], [253, "functions"], [276, "functions"], [303, "functions"], [336, "functions"]], "GC metadata": [[121, "gc-metadata"]], "GF metadata": [[121, "gf-metadata"]], "GFF3 format (skbio.io.format.gff3)": [[114, null]], "GR metadata": [[121, "gr-metadata"]], "GS metadata": [[121, "gs-metadata"]], "GenBank format (skbio.io.format.genbank)": [[113, null]], "Generator and TabularMSA Reader Parameters": [[111, "generator-and-tabularmsa-reader-parameters"]], "Generators Only": [[119, "generators-only"]], "Gradient analyses (skbio.stats.gradient)": [[305, null]], "Header": [[121, "header"]], "Header Section": [[118, "header-section"]], "I/O Registry (skbio.io.registry)": [[123, null]], "I/O utilities (skbio.io.util)": [[144, null]], "Identifier Column": [[120, "identifier-column"]], "Inline Comments": [[116, "inline-comments"]], "Input and Output (skbio.io)": [[506, null]], "Input validation": [[1, "input-validation"]], "Interval metadata": [[507, "interval-metadata"]], "Introduction": [[1, "introduction"]], "Labeled square matrix format (skbio.io.format.lsmat)": [[115, null]], "Leading and trailing whitespace characters": [[120, "leading-and-trailing-whitespace-characters"]], "Location string": [[113, "location-string"]], "Log-ratio transformation": [[256, "log-ratio-transformation"]], "Metadata": [[121, "metadata"]], "Metadata (skbio.metadata)": [[507, null]], "Metadata Columns": [[120, "metadata-columns"]], "Metadata Formatting Requirements": [[120, "metadata-formatting-requirements"]], "Metadata Validation": [[120, "metadata-validation"]], "Metadata columns": [[507, "metadata-columns"]], "Miscellaneous utilities": [[512, "miscellaneous-utilities"]], "Multidimensional scaling": [[319, "multidimensional-scaling"]], "Multiple Sequence Alignment": [[121, "multiple-sequence-alignment"]], "Multivariate Statistics (skbio.stats)": [[509, null]], "Newick format (skbio.io.format.newick)": [[116, null]], "Number Formatting": [[120, "number-formatting"]], "ORIGIN section": [[113, "origin-section"]], "Ordination methods": [[509, "ordination-methods"]], "Ordination methods (skbio.stats.ordination)": [[319, null]], "Ordination results": [[319, "ordination-results"]], "Ordination results format (skbio.io.format.ordination)": [[117, null]], "Other statistical methods": [[509, "other-statistical-methods"]], "PHYLIP multiple sequence alignment format (skbio.io.format.phylip)": [[118, null]], "Plotting utilities": [[512, "plotting-utilities"]], "QSeq format (skbio.io.format.qseq)": [[119, null]], "QUAL File Parameter (Readers and Writers)": [[111, "qual-file-parameter-readers-and-writers"]], "QUAL Format": [[111, "qual-format"]], "Quality Score Variants": [[112, "quality-score-variants"]], "Read/write files": [[506, "read-write-files"]], "Reader-specific Parameters": [[111, "reader-specific-parameters"], [113, "reader-specific-parameters"], [114, "reader-specific-parameters"]], "Reading EMBL Files": [[110, "reading-embl-files"]], "Reading EMBL Files using generators": [[110, "reading-embl-files-using-generators"]], "Reading and Writing FASTA Files": [[111, "reading-and-writing-fasta-files"]], "Reading and Writing FASTA/QUAL Files": [[111, "reading-and-writing-fasta-qual-files"]], "Reading and Writing GenBank Files": [[113, "reading-and-writing-genbank-files"]], "Reading files into scikit-bio": [[506, "reading-files-into-scikit-bio"]], "Reading multi-FASTA Files": [[111, "reading-multi-fasta-files"]], "Recommendations for Identifiers": [[120, "recommendations-for-identifiers"]], "References": [[43, "references"], [104, "references"], [105, "references"], [106, "references"], [107, "references"], [108, "references"], [110, "references"], [111, "references"], [112, "references"], [113, "references"], [114, "references"], [116, "references"], [118, "references"], [119, "references"], [121, "references"], [122, "references"], [256, "references"], [276, "references"], [319, "references"]], "Reserved Keyword Arguments": [[123, "reserved-keyword-arguments"]], "Richness metrics": [[43, "richness-metrics"]], "SQ section": [[110, "sq-section"]], "Sample metadata": [[507, "sample-metadata"]], "Sections before FEATURES": [[113, "sections-before-features"]], "Sections before FH (Feature Header)": [[110, "sections-before-fh-feature-header"]], "Sequence Alignments (skbio.alignment)": [[0, null]], "Sequence Data": [[111, "sequence-data"]], "Sequence Header": [[111, "sequence-header"]], "Sequence Reader Parameters": [[111, "sequence-reader-parameters"]], "Sequence distance metrics (skbio.sequence.distance)": [[253, null]], "Sequence types": [[508, "sequence-types"]], "Sequence utilities": [[508, "sequence-utilities"]], "Simple binary dissimilarity matrix format (skbio.io.format.binary_dm)": [[104, null]], "Specifying a diversity metric": [[1, "specifying-a-diversity-metric"]], "Stockholm format (skbio.io.format.stockholm)": [[121, null]], "Streaming files with read and write": [[506, "streaming-files-with-read-and-write"]], "Supported file formats": [[506, "supported-file-formats"]], "Taxdump format (skbio.io.format.taxdump)": [[122, null]], "Testing utilities": [[512, "testing-utilities"]], "Tree Comparison": [[511, "tree-comparison"]], "Tree Construction": [[511, "tree-construction"]], "Tree Rearrangement": [[511, "tree-rearrangement"]], "Tree structure and operations": [[511, "tree-structure-and-operations"]], "Tree utilities": [[511, "tree-utilities"]], "Trees and Phylogenetics (skbio.tree)": [[511, null]], "Tutorial": [[0, "tutorial"], [1, "tutorial"], [506, "tutorial"], [508, "tutorial"], [511, "tutorial"], [513, "tutorial"]], "Using the optimized alignment algorithm": [[0, "using-the-optimized-alignment-algorithm"]], "Using the slow alignment algorithm": [[0, "using-the-slow-alignment-algorithm"]], "Utilities for Developers (skbio.util)": [[512, null]], "Utility functions": [[319, "utility-functions"]], "What kinds of files scikit-bio can use": [[506, "what-kinds-of-files-scikit-bio-can-use"]], "Whitespace": [[116, "whitespace"]], "Workflow construction (skbio.workflow)": [[513, null]], "Writer-specific Parameters": [[111, "writer-specific-parameters"], [114, "writer-specific-parameters"]], "Writing files from scikit-bio": [[506, "writing-files-from-scikit-bio"]], "Zero handling": [[256, "zero-handling"]], "division.dmp": [[122, "division-dmp"]], "gencode.dmp": [[122, "gencode-dmp"]], "names.dmp": [[122, "names-dmp"]], "nodes.dmp": [[122, "nodes-dmp"]], "scikit-bio 0.6.3-dev documentation": [[505, null]], "skbio.alignment.AlignPath": [[3, null]], "skbio.alignment.AlignPath.from_bits": [[4, null]], "skbio.alignment.AlignPath.from_coordinates": [[5, null]], "skbio.alignment.AlignPath.from_indices": [[6, null]], "skbio.alignment.AlignPath.from_tabular": [[7, null]], "skbio.alignment.AlignPath.to_bits": [[8, null]], "skbio.alignment.AlignPath.to_coordinates": [[9, null]], "skbio.alignment.AlignPath.to_indices": [[10, null]], "skbio.alignment.AlignmentStructure": [[11, null]], "skbio.alignment.AlignmentStructure.is_zero_based": [[12, null]], "skbio.alignment.AlignmentStructure.set_zero_based": [[13, null]], "skbio.alignment.PairAlignPath": [[14, null]], "skbio.alignment.PairAlignPath.from_bits": [[15, null]], "skbio.alignment.PairAlignPath.from_cigar": [[16, null]], "skbio.alignment.PairAlignPath.to_bits": [[17, null]], "skbio.alignment.PairAlignPath.to_cigar": [[18, null]], "skbio.alignment.StripedSmithWaterman": [[19, null]], "skbio.alignment.TabularMSA": [[20, null]], "skbio.alignment.TabularMSA.append": [[21, null]], "skbio.alignment.TabularMSA.consensus": [[22, null]], "skbio.alignment.TabularMSA.conservation": [[23, null]], "skbio.alignment.TabularMSA.extend": [[24, null]], "skbio.alignment.TabularMSA.from_dict": [[25, null]], "skbio.alignment.TabularMSA.from_path_seqs": [[26, null]], "skbio.alignment.TabularMSA.gap_frequencies": [[27, null]], "skbio.alignment.TabularMSA.iter_positions": [[28, null]], "skbio.alignment.TabularMSA.join": [[29, null]], "skbio.alignment.TabularMSA.read": [[30, null]], "skbio.alignment.TabularMSA.reassign_index": [[31, null]], "skbio.alignment.TabularMSA.sort": [[32, null]], "skbio.alignment.TabularMSA.to_dict": [[33, null]], "skbio.alignment.TabularMSA.write": [[34, null]], "skbio.alignment.global_pairwise_align": [[35, null]], "skbio.alignment.global_pairwise_align_nucleotide": [[36, null]], "skbio.alignment.global_pairwise_align_protein": [[37, null]], "skbio.alignment.local_pairwise_align": [[38, null]], "skbio.alignment.local_pairwise_align_nucleotide": [[39, null]], "skbio.alignment.local_pairwise_align_protein": [[40, null]], "skbio.alignment.local_pairwise_align_ssw": [[41, null]], "skbio.alignment.make_identity_substitution_matrix": [[42, null]], "skbio.diversity.alpha.ace": [[44, null]], "skbio.diversity.alpha.berger_parker_d": [[45, null]], "skbio.diversity.alpha.brillouin_d": [[46, null]], "skbio.diversity.alpha.chao1": [[47, null]], "skbio.diversity.alpha.chao1_ci": [[48, null]], "skbio.diversity.alpha.dominance": [[49, null]], "skbio.diversity.alpha.doubles": [[50, null]], "skbio.diversity.alpha.enspie": [[51, null]], "skbio.diversity.alpha.esty_ci": [[52, null]], "skbio.diversity.alpha.faith_pd": [[53, null]], "skbio.diversity.alpha.fisher_alpha": [[54, null]], "skbio.diversity.alpha.gini_index": [[55, null]], "skbio.diversity.alpha.goods_coverage": [[56, null]], "skbio.diversity.alpha.heip_e": [[57, null]], "skbio.diversity.alpha.hill": [[58, null]], "skbio.diversity.alpha.inv_simpson": [[59, null]], "skbio.diversity.alpha.kempton_taylor_q": [[60, null]], "skbio.diversity.alpha.lladser_ci": [[61, null]], "skbio.diversity.alpha.lladser_pe": [[62, null]], "skbio.diversity.alpha.margalef": [[63, null]], "skbio.diversity.alpha.mcintosh_d": [[64, null]], "skbio.diversity.alpha.mcintosh_e": [[65, null]], "skbio.diversity.alpha.menhinick": [[66, null]], "skbio.diversity.alpha.michaelis_menten_fit": [[67, null]], "skbio.diversity.alpha.observed_features": [[68, null]], "skbio.diversity.alpha.osd": [[69, null]], "skbio.diversity.alpha.phydiv": [[70, null]], "skbio.diversity.alpha.pielou_e": [[71, null]], "skbio.diversity.alpha.renyi": [[72, null]], "skbio.diversity.alpha.robbins": [[73, null]], "skbio.diversity.alpha.shannon": [[74, null]], "skbio.diversity.alpha.simpson": [[75, null]], "skbio.diversity.alpha.simpson_d": [[76, null]], "skbio.diversity.alpha.simpson_e": [[77, null]], "skbio.diversity.alpha.singles": [[78, null]], "skbio.diversity.alpha.sobs": [[79, null]], "skbio.diversity.alpha.strong": [[80, null]], "skbio.diversity.alpha.tsallis": [[81, null]], "skbio.diversity.alpha_diversity": [[82, null]], "skbio.diversity.beta.unweighted_unifrac": [[84, null]], "skbio.diversity.beta.weighted_unifrac": [[85, null]], "skbio.diversity.beta_diversity": [[86, null]], "skbio.diversity.block_beta_diversity": [[87, null]], "skbio.diversity.get_alpha_diversity_metrics": [[88, null]], "skbio.diversity.get_beta_diversity_metrics": [[89, null]], "skbio.diversity.partial_beta_diversity": [[90, null]], "skbio.embedding.Embedding": [[91, null]], "skbio.embedding.Embedding.bytes": [[92, null]], "skbio.embedding.Embedding.read": [[93, null]], "skbio.embedding.Embedding.write": [[94, null]], "skbio.embedding.EmbeddingVector": [[95, null]], "skbio.embedding.ProteinEmbedding": [[96, null]], "skbio.embedding.ProteinVector": [[97, null]], "skbio.embedding.SequenceEmbedding": [[98, null]], "skbio.embedding.SequenceVector": [[99, null]], "skbio.embedding.embed_vec_to_dataframe": [[100, null]], "skbio.embedding.embed_vec_to_distances": [[101, null]], "skbio.embedding.embed_vec_to_numpy": [[102, null]], "skbio.embedding.embed_vec_to_ordination": [[103, null]], "skbio.io.registry.Format": [[124, null]], "skbio.io.registry.Format.reader": [[125, null]], "skbio.io.registry.Format.sniffer": [[126, null]], "skbio.io.registry.Format.writer": [[127, null]], "skbio.io.registry.IORegistry": [[128, null]], "skbio.io.registry.IORegistry.add_format": [[129, null]], "skbio.io.registry.IORegistry.create_format": [[130, null]], "skbio.io.registry.IORegistry.get_reader": [[131, null]], "skbio.io.registry.IORegistry.get_sniffer": [[132, null]], "skbio.io.registry.IORegistry.get_writer": [[133, null]], "skbio.io.registry.IORegistry.list_read_formats": [[134, null]], "skbio.io.registry.IORegistry.list_write_formats": [[135, null]], "skbio.io.registry.IORegistry.read": [[136, null]], "skbio.io.registry.IORegistry.remove_format": [[137, null]], "skbio.io.registry.IORegistry.sniff": [[138, null]], "skbio.io.registry.IORegistry.write": [[139, null]], "skbio.io.registry.create_format": [[140, null]], "skbio.io.registry.read": [[141, null]], "skbio.io.registry.sniff": [[142, null]], "skbio.io.registry.write": [[143, null]], "skbio.io.util.open": [[145, null]], "skbio.io.util.open_file": [[146, null]], "skbio.io.util.open_files": [[147, null]], "skbio.metadata.CategoricalMetadataColumn": [[148, null]], "skbio.metadata.Interval": [[149, null]], "skbio.metadata.Interval.drop": [[150, null]], "skbio.metadata.IntervalMetadata": [[151, null]], "skbio.metadata.IntervalMetadata.add": [[152, null]], "skbio.metadata.IntervalMetadata.concat": [[153, null]], "skbio.metadata.IntervalMetadata.drop": [[154, null]], "skbio.metadata.IntervalMetadata.merge": [[155, null]], "skbio.metadata.IntervalMetadata.query": [[156, null]], "skbio.metadata.IntervalMetadata.read": [[157, null]], "skbio.metadata.IntervalMetadata.sort": [[158, null]], "skbio.metadata.IntervalMetadata.write": [[159, null]], "skbio.metadata.IntervalMetadataMixin": [[160, null]], "skbio.metadata.IntervalMetadataMixin.has_interval_metadata": [[161, null]], "skbio.metadata.MetadataColumn": [[162, null]], "skbio.metadata.MetadataColumn.drop_missing_values": [[163, null]], "skbio.metadata.MetadataColumn.filter_ids": [[164, null]], "skbio.metadata.MetadataColumn.get_ids": [[165, null]], "skbio.metadata.MetadataColumn.get_missing": [[166, null]], "skbio.metadata.MetadataColumn.get_value": [[167, null]], "skbio.metadata.MetadataColumn.has_missing_values": [[168, null]], "skbio.metadata.MetadataColumn.to_dataframe": [[169, null]], "skbio.metadata.MetadataColumn.to_series": [[170, null]], "skbio.metadata.MetadataMixin": [[171, null]], "skbio.metadata.MetadataMixin.has_metadata": [[172, null]], "skbio.metadata.NumericMetadataColumn": [[173, null]], "skbio.metadata.PositionalMetadataMixin": [[174, null]], "skbio.metadata.PositionalMetadataMixin.has_positional_metadata": [[175, null]], "skbio.metadata.SampleMetadata": [[176, null]], "skbio.metadata.SampleMetadata.filter_columns": [[177, null]], "skbio.metadata.SampleMetadata.filter_ids": [[178, null]], "skbio.metadata.SampleMetadata.get_column": [[179, null]], "skbio.metadata.SampleMetadata.get_ids": [[180, null]], "skbio.metadata.SampleMetadata.load": [[181, null]], "skbio.metadata.SampleMetadata.merge": [[182, null]], "skbio.metadata.SampleMetadata.to_dataframe": [[183, null]], "skbio.sequence.DNA": [[184, null]], "skbio.sequence.DNA.find_motifs": [[185, null]], "skbio.sequence.DNA.read": [[186, null]], "skbio.sequence.DNA.transcribe": [[187, null]], "skbio.sequence.DNA.translate": [[188, null]], "skbio.sequence.DNA.translate_six_frames": [[189, null]], "skbio.sequence.DNA.write": [[190, null]], "skbio.sequence.GeneticCode": [[191, null]], "skbio.sequence.GeneticCode.from_ncbi": [[192, null]], "skbio.sequence.GeneticCode.translate": [[193, null]], "skbio.sequence.GeneticCode.translate_six_frames": [[194, null]], "skbio.sequence.GrammaredSequence": [[195, null]], "skbio.sequence.GrammaredSequence.definites": [[196, null]], "skbio.sequence.GrammaredSequence.degap": [[197, null]], "skbio.sequence.GrammaredSequence.degenerates": [[198, null]], "skbio.sequence.GrammaredSequence.expand_degenerates": [[199, null]], "skbio.sequence.GrammaredSequence.find_motifs": [[200, null]], "skbio.sequence.GrammaredSequence.gaps": [[201, null]], "skbio.sequence.GrammaredSequence.has_definites": [[202, null]], "skbio.sequence.GrammaredSequence.has_degenerates": [[203, null]], "skbio.sequence.GrammaredSequence.has_gaps": [[204, null]], "skbio.sequence.GrammaredSequence.has_nondegenerates": [[205, null]], "skbio.sequence.GrammaredSequence.nondegenerates": [[206, null]], "skbio.sequence.GrammaredSequence.to_definites": [[207, null]], "skbio.sequence.GrammaredSequence.to_regex": [[208, null]], "skbio.sequence.NucleotideMixin": [[209, null]], "skbio.sequence.NucleotideMixin.complement": [[210, null]], "skbio.sequence.NucleotideMixin.gc_content": [[211, null]], "skbio.sequence.NucleotideMixin.gc_frequency": [[212, null]], "skbio.sequence.NucleotideMixin.is_reverse_complement": [[213, null]], "skbio.sequence.NucleotideMixin.reverse_complement": [[214, null]], "skbio.sequence.Protein": [[215, null]], "skbio.sequence.Protein.find_motifs": [[216, null]], "skbio.sequence.Protein.has_stops": [[217, null]], "skbio.sequence.Protein.read": [[218, null]], "skbio.sequence.Protein.stops": [[219, null]], "skbio.sequence.Protein.write": [[220, null]], "skbio.sequence.RNA": [[221, null]], "skbio.sequence.RNA.find_motifs": [[222, null]], "skbio.sequence.RNA.read": [[223, null]], "skbio.sequence.RNA.reverse_transcribe": [[224, null]], "skbio.sequence.RNA.translate": [[225, null]], "skbio.sequence.RNA.translate_six_frames": [[226, null]], "skbio.sequence.RNA.write": [[227, null]], "skbio.sequence.Sequence": [[228, null]], "skbio.sequence.Sequence.concat": [[229, null]], "skbio.sequence.Sequence.count": [[230, null]], "skbio.sequence.Sequence.distance": [[231, null]], "skbio.sequence.Sequence.find_with_regex": [[232, null]], "skbio.sequence.Sequence.frequencies": [[233, null]], "skbio.sequence.Sequence.index": [[234, null]], "skbio.sequence.Sequence.iter_contiguous": [[235, null]], "skbio.sequence.Sequence.iter_kmers": [[236, null]], "skbio.sequence.Sequence.kmer_frequencies": [[237, null]], "skbio.sequence.Sequence.lowercase": [[238, null]], "skbio.sequence.Sequence.match_frequency": [[239, null]], "skbio.sequence.Sequence.matches": [[240, null]], "skbio.sequence.Sequence.mismatch_frequency": [[241, null]], "skbio.sequence.Sequence.mismatches": [[242, null]], "skbio.sequence.Sequence.read": [[243, null]], "skbio.sequence.Sequence.replace": [[244, null]], "skbio.sequence.Sequence.to_indices": [[245, null]], "skbio.sequence.Sequence.write": [[246, null]], "skbio.sequence.SubstitutionMatrix": [[247, null]], "skbio.sequence.SubstitutionMatrix.by_name": [[248, null]], "skbio.sequence.SubstitutionMatrix.from_dict": [[249, null]], "skbio.sequence.SubstitutionMatrix.get_names": [[250, null]], "skbio.sequence.SubstitutionMatrix.identity": [[251, null]], "skbio.sequence.SubstitutionMatrix.to_dict": [[252, null]], "skbio.sequence.distance.hamming": [[254, null]], "skbio.sequence.distance.kmer_distance": [[255, null]], "skbio.stats.composition.alr": [[257, null]], "skbio.stats.composition.alr_inv": [[258, null]], "skbio.stats.composition.ancom": [[259, null]], "skbio.stats.composition.centralize": [[260, null]], "skbio.stats.composition.closure": [[261, null]], "skbio.stats.composition.clr": [[262, null]], "skbio.stats.composition.clr_inv": [[263, null]], "skbio.stats.composition.dirmult_ttest": [[264, null]], "skbio.stats.composition.ilr": [[265, null]], "skbio.stats.composition.ilr_inv": [[266, null]], "skbio.stats.composition.inner": [[267, null]], "skbio.stats.composition.multi_replace": [[268, null]], "skbio.stats.composition.pairwise_vlr": [[269, null]], "skbio.stats.composition.perturb": [[270, null]], "skbio.stats.composition.perturb_inv": [[271, null]], "skbio.stats.composition.power": [[272, null]], "skbio.stats.composition.sbp_basis": [[273, null]], "skbio.stats.composition.tree_basis": [[274, null]], "skbio.stats.composition.vlr": [[275, null]], "skbio.stats.distance.DissimilarityMatrix": [[277, null]], "skbio.stats.distance.DissimilarityMatrix.between": [[278, null]], "skbio.stats.distance.DissimilarityMatrix.copy": [[279, null]], "skbio.stats.distance.DissimilarityMatrix.filter": [[280, null]], "skbio.stats.distance.DissimilarityMatrix.from_iterable": [[281, null]], "skbio.stats.distance.DissimilarityMatrix.index": [[282, null]], "skbio.stats.distance.DissimilarityMatrix.plot": [[283, null]], "skbio.stats.distance.DissimilarityMatrix.read": [[284, null]], "skbio.stats.distance.DissimilarityMatrix.redundant_form": [[285, null]], "skbio.stats.distance.DissimilarityMatrix.rename": [[286, null]], "skbio.stats.distance.DissimilarityMatrix.to_data_frame": [[287, null]], "skbio.stats.distance.DissimilarityMatrix.transpose": [[288, null]], "skbio.stats.distance.DissimilarityMatrix.within": [[289, null]], "skbio.stats.distance.DissimilarityMatrix.write": [[290, null]], "skbio.stats.distance.DistanceMatrix": [[291, null]], "skbio.stats.distance.DistanceMatrix.condensed_form": [[292, null]], "skbio.stats.distance.DistanceMatrix.from_iterable": [[293, null]], "skbio.stats.distance.DistanceMatrix.permute": [[294, null]], "skbio.stats.distance.DistanceMatrix.to_series": [[295, null]], "skbio.stats.distance.anosim": [[296, null]], "skbio.stats.distance.bioenv": [[297, null]], "skbio.stats.distance.mantel": [[298, null]], "skbio.stats.distance.permanova": [[299, null]], "skbio.stats.distance.permdisp": [[300, null]], "skbio.stats.distance.pwmantel": [[301, null]], "skbio.stats.distance.randdm": [[302, null]], "skbio.stats.evolve.hommola_cospeciation": [[304, null]], "skbio.stats.gradient.AverageGradientANOVA": [[306, null]], "skbio.stats.gradient.CategoryResults": [[307, null]], "skbio.stats.gradient.CategoryResults.to_files": [[308, null]], "skbio.stats.gradient.FirstDifferenceGradientANOVA": [[309, null]], "skbio.stats.gradient.GradientANOVA": [[310, null]], "skbio.stats.gradient.GradientANOVA.get_trajectories": [[311, null]], "skbio.stats.gradient.GradientANOVAResults": [[312, null]], "skbio.stats.gradient.GradientANOVAResults.to_files": [[313, null]], "skbio.stats.gradient.GroupResults": [[314, null]], "skbio.stats.gradient.GroupResults.to_files": [[315, null]], "skbio.stats.gradient.TrajectoryGradientANOVA": [[316, null]], "skbio.stats.gradient.WindowDifferenceGradientANOVA": [[317, null]], "skbio.stats.isubsample": [[318, null]], "skbio.stats.ordination.OrdinationResults": [[320, null]], "skbio.stats.ordination.OrdinationResults.plot": [[321, null]], "skbio.stats.ordination.OrdinationResults.read": [[322, null]], "skbio.stats.ordination.OrdinationResults.rename": [[323, null]], "skbio.stats.ordination.OrdinationResults.write": [[324, null]], "skbio.stats.ordination.ca": [[325, null]], "skbio.stats.ordination.cca": [[326, null]], "skbio.stats.ordination.corr": [[327, null]], "skbio.stats.ordination.e_matrix": [[328, null]], "skbio.stats.ordination.f_matrix": [[329, null]], "skbio.stats.ordination.mean_and_std": [[330, null]], "skbio.stats.ordination.pcoa": [[331, null]], "skbio.stats.ordination.pcoa_biplot": [[332, null]], "skbio.stats.ordination.rda": [[333, null]], "skbio.stats.ordination.scale": [[334, null]], "skbio.stats.ordination.svd_rank": [[335, null]], "skbio.stats.power.confidence_bound": [[337, null]], "skbio.stats.power.paired_subsamples": [[338, null]], "skbio.stats.power.subsample_paired_power": [[339, null]], "skbio.stats.power.subsample_power": [[340, null]], "skbio.stats.subsample_counts": [[341, null]], "skbio.table.Table": [[342, null]], "skbio.table.Table.add_group_metadata": [[343, null]], "skbio.table.Table.add_metadata": [[344, null]], "skbio.table.Table.align_to": [[345, null]], "skbio.table.Table.align_to_dataframe": [[346, null]], "skbio.table.Table.align_tree": [[347, null]], "skbio.table.Table.collapse": [[348, null]], "skbio.table.Table.concat": [[349, null]], "skbio.table.Table.copy": [[350, null]], "skbio.table.Table.data": [[351, null]], "skbio.table.Table.del_metadata": [[352, null]], "skbio.table.Table.delimited_self": [[353, null]], "skbio.table.Table.descriptive_equality": [[354, null]], "skbio.table.Table.exists": [[355, null]], "skbio.table.Table.filter": [[356, null]], "skbio.table.Table.from_adjacency": [[357, null]], "skbio.table.Table.from_hdf5": [[358, null]], "skbio.table.Table.from_json": [[359, null]], "skbio.table.Table.from_tsv": [[360, null]], "skbio.table.Table.get_table_density": [[361, null]], "skbio.table.Table.get_value_by_ids": [[362, null]], "skbio.table.Table.group_metadata": [[363, null]], "skbio.table.Table.head": [[364, null]], "skbio.table.Table.ids": [[365, null]], "skbio.table.Table.index": [[366, null]], "skbio.table.Table.is_empty": [[367, null]], "skbio.table.Table.iter": [[368, null]], "skbio.table.Table.iter_data": [[369, null]], "skbio.table.Table.iter_pairwise": [[370, null]], "skbio.table.Table.length": [[371, null]], "skbio.table.Table.max": [[372, null]], "skbio.table.Table.merge": [[373, null]], "skbio.table.Table.metadata": [[374, null]], "skbio.table.Table.metadata_to_dataframe": [[375, null]], "skbio.table.Table.min": [[376, null]], "skbio.table.Table.nonzero": [[377, null]], "skbio.table.Table.nonzero_counts": [[378, null]], "skbio.table.Table.norm": [[379, null]], "skbio.table.Table.pa": [[380, null]], "skbio.table.Table.partition": [[381, null]], "skbio.table.Table.rankdata": [[382, null]], "skbio.table.Table.read": [[383, null]], "skbio.table.Table.reduce": [[384, null]], "skbio.table.Table.remove_empty": [[385, null]], "skbio.table.Table.sort": [[386, null]], "skbio.table.Table.sort_order": [[387, null]], "skbio.table.Table.subsample": [[388, null]], "skbio.table.Table.sum": [[389, null]], "skbio.table.Table.to_anndata": [[390, null]], "skbio.table.Table.to_dataframe": [[391, null]], "skbio.table.Table.to_hdf5": [[392, null]], "skbio.table.Table.to_json": [[393, null]], "skbio.table.Table.to_tsv": [[394, null]], "skbio.table.Table.transform": [[395, null]], "skbio.table.Table.transpose": [[396, null]], "skbio.table.Table.update_ids": [[397, null]], "skbio.table.Table.write": [[398, null]], "skbio.table.example_table": [[399, null]], "skbio.tree.TreeNode": [[400, null]], "skbio.tree.TreeNode.ancestors": [[401, null]], "skbio.tree.TreeNode.append": [[402, null]], "skbio.tree.TreeNode.ascii_art": [[403, null]], "skbio.tree.TreeNode.assign_ids": [[404, null]], "skbio.tree.TreeNode.assign_supports": [[405, null]], "skbio.tree.TreeNode.bifurcate": [[406, null]], "skbio.tree.TreeNode.bipart": [[407, null]], "skbio.tree.TreeNode.biparts": [[408, null]], "skbio.tree.TreeNode.cache_attr": [[409, null]], "skbio.tree.TreeNode.clear_caches": [[410, null]], "skbio.tree.TreeNode.compare_biparts": [[411, null]], "skbio.tree.TreeNode.compare_cophenet": [[412, null]], "skbio.tree.TreeNode.compare_rfd": [[413, null]], "skbio.tree.TreeNode.compare_subsets": [[414, null]], "skbio.tree.TreeNode.compare_wrfd": [[415, null]], "skbio.tree.TreeNode.cophenet": [[416, null]], "skbio.tree.TreeNode.copy": [[417, null]], "skbio.tree.TreeNode.count": [[418, null]], "skbio.tree.TreeNode.create_caches": [[419, null]], "skbio.tree.TreeNode.deepcopy": [[420, null]], "skbio.tree.TreeNode.depth": [[421, null]], "skbio.tree.TreeNode.distance": [[422, null]], "skbio.tree.TreeNode.extend": [[423, null]], "skbio.tree.TreeNode.find": [[424, null]], "skbio.tree.TreeNode.find_all": [[425, null]], "skbio.tree.TreeNode.find_by_func": [[426, null]], "skbio.tree.TreeNode.find_by_id": [[427, null]], "skbio.tree.TreeNode.from_linkage_matrix": [[428, null]], "skbio.tree.TreeNode.from_taxdump": [[429, null]], "skbio.tree.TreeNode.from_taxonomy": [[430, null]], "skbio.tree.TreeNode.has_caches": [[431, null]], "skbio.tree.TreeNode.has_children": [[432, null]], "skbio.tree.TreeNode.height": [[433, null]], "skbio.tree.TreeNode.index_tree": [[434, null]], "skbio.tree.TreeNode.insert": [[435, null]], "skbio.tree.TreeNode.is_bifurcating": [[436, null]], "skbio.tree.TreeNode.is_root": [[437, null]], "skbio.tree.TreeNode.is_tip": [[438, null]], "skbio.tree.TreeNode.lca": [[439, null]], "skbio.tree.TreeNode.levelorder": [[440, null]], "skbio.tree.TreeNode.maxdist": [[441, null]], "skbio.tree.TreeNode.neighbors": [[442, null]], "skbio.tree.TreeNode.non_tips": [[443, null]], "skbio.tree.TreeNode.observed_node_counts": [[444, null]], "skbio.tree.TreeNode.path": [[445, null]], "skbio.tree.TreeNode.pop": [[446, null]], "skbio.tree.TreeNode.postorder": [[447, null]], "skbio.tree.TreeNode.pre_and_postorder": [[448, null]], "skbio.tree.TreeNode.preorder": [[449, null]], "skbio.tree.TreeNode.prune": [[450, null]], "skbio.tree.TreeNode.read": [[451, null]], "skbio.tree.TreeNode.remove": [[452, null]], "skbio.tree.TreeNode.remove_by_func": [[453, null]], "skbio.tree.TreeNode.remove_deleted": [[454, null]], "skbio.tree.TreeNode.root": [[455, null]], "skbio.tree.TreeNode.root_at": [[456, null]], "skbio.tree.TreeNode.root_at_midpoint": [[457, null]], "skbio.tree.TreeNode.root_by_outgroup": [[458, null]], "skbio.tree.TreeNode.shear": [[459, null]], "skbio.tree.TreeNode.shuffle": [[460, null]], "skbio.tree.TreeNode.siblings": [[461, null]], "skbio.tree.TreeNode.subset": [[462, null]], "skbio.tree.TreeNode.subsets": [[463, null]], "skbio.tree.TreeNode.subtree": [[464, null]], "skbio.tree.TreeNode.tips": [[465, null]], "skbio.tree.TreeNode.to_array": [[466, null]], "skbio.tree.TreeNode.to_taxonomy": [[467, null]], "skbio.tree.TreeNode.total_length": [[468, null]], "skbio.tree.TreeNode.traverse": [[469, null]], "skbio.tree.TreeNode.unpack": [[470, null]], "skbio.tree.TreeNode.unpack_by_func": [[471, null]], "skbio.tree.TreeNode.unroot": [[472, null]], "skbio.tree.TreeNode.unrooted_copy": [[473, null]], "skbio.tree.TreeNode.unrooted_deepcopy": [[474, null]], "skbio.tree.TreeNode.unrooted_move": [[475, null]], "skbio.tree.TreeNode.write": [[476, null]], "skbio.tree.bme": [[477, null]], "skbio.tree.gme": [[478, null]], "skbio.tree.majority_rule": [[479, null]], "skbio.tree.nj": [[480, null]], "skbio.tree.nni": [[481, null]], "skbio.tree.path_dists": [[482, null]], "skbio.tree.rf_dists": [[483, null]], "skbio.tree.upgma": [[484, null]], "skbio.tree.wrf_dists": [[485, null]], "skbio.util.PlottableMixin": [[486, null]], "skbio.util.aliased": [[487, null]], "skbio.util.assert_data_frame_almost_equal": [[488, null]], "skbio.util.assert_ordination_results_equal": [[489, null]], "skbio.util.cardinal_to_ordinal": [[490, null]], "skbio.util.classonlymethod": [[491, null]], "skbio.util.classproperty": [[492, null]], "skbio.util.deprecated": [[493, null]], "skbio.util.find_duplicates": [[494, null]], "skbio.util.get_data_path": [[495, null]], "skbio.util.get_rng": [[496, null]], "skbio.util.overrides": [[497, null]], "skbio.util.params_aliased": [[498, null]], "skbio.util.register_aliases": [[499, null]], "skbio.util.safe_md5": [[500, null]], "skbio.workflow.Workflow": [[501, null]], "skbio.workflow.Workflow.initialize_state": [[502, null]], "skbio.workflow.method": [[503, null]], "skbio.workflow.requires": [[504, null]]}, "docnames": ["alignment", "diversity", "embedding", "generated/skbio.alignment.AlignPath", "generated/skbio.alignment.AlignPath.from_bits", "generated/skbio.alignment.AlignPath.from_coordinates", "generated/skbio.alignment.AlignPath.from_indices", "generated/skbio.alignment.AlignPath.from_tabular", "generated/skbio.alignment.AlignPath.to_bits", "generated/skbio.alignment.AlignPath.to_coordinates", "generated/skbio.alignment.AlignPath.to_indices", "generated/skbio.alignment.AlignmentStructure", "generated/skbio.alignment.AlignmentStructure.is_zero_based", "generated/skbio.alignment.AlignmentStructure.set_zero_based", "generated/skbio.alignment.PairAlignPath", "generated/skbio.alignment.PairAlignPath.from_bits", "generated/skbio.alignment.PairAlignPath.from_cigar", "generated/skbio.alignment.PairAlignPath.to_bits", "generated/skbio.alignment.PairAlignPath.to_cigar", "generated/skbio.alignment.StripedSmithWaterman", "generated/skbio.alignment.TabularMSA", "generated/skbio.alignment.TabularMSA.append", "generated/skbio.alignment.TabularMSA.consensus", "generated/skbio.alignment.TabularMSA.conservation", "generated/skbio.alignment.TabularMSA.extend", "generated/skbio.alignment.TabularMSA.from_dict", "generated/skbio.alignment.TabularMSA.from_path_seqs", "generated/skbio.alignment.TabularMSA.gap_frequencies", "generated/skbio.alignment.TabularMSA.iter_positions", "generated/skbio.alignment.TabularMSA.join", "generated/skbio.alignment.TabularMSA.read", "generated/skbio.alignment.TabularMSA.reassign_index", "generated/skbio.alignment.TabularMSA.sort", "generated/skbio.alignment.TabularMSA.to_dict", "generated/skbio.alignment.TabularMSA.write", "generated/skbio.alignment.global_pairwise_align", "generated/skbio.alignment.global_pairwise_align_nucleotide", "generated/skbio.alignment.global_pairwise_align_protein", "generated/skbio.alignment.local_pairwise_align", "generated/skbio.alignment.local_pairwise_align_nucleotide", "generated/skbio.alignment.local_pairwise_align_protein", "generated/skbio.alignment.local_pairwise_align_ssw", "generated/skbio.alignment.make_identity_substitution_matrix", "generated/skbio.diversity.alpha", "generated/skbio.diversity.alpha.ace", "generated/skbio.diversity.alpha.berger_parker_d", "generated/skbio.diversity.alpha.brillouin_d", "generated/skbio.diversity.alpha.chao1", "generated/skbio.diversity.alpha.chao1_ci", "generated/skbio.diversity.alpha.dominance", "generated/skbio.diversity.alpha.doubles", "generated/skbio.diversity.alpha.enspie", "generated/skbio.diversity.alpha.esty_ci", "generated/skbio.diversity.alpha.faith_pd", "generated/skbio.diversity.alpha.fisher_alpha", "generated/skbio.diversity.alpha.gini_index", "generated/skbio.diversity.alpha.goods_coverage", "generated/skbio.diversity.alpha.heip_e", "generated/skbio.diversity.alpha.hill", "generated/skbio.diversity.alpha.inv_simpson", "generated/skbio.diversity.alpha.kempton_taylor_q", "generated/skbio.diversity.alpha.lladser_ci", "generated/skbio.diversity.alpha.lladser_pe", "generated/skbio.diversity.alpha.margalef", "generated/skbio.diversity.alpha.mcintosh_d", "generated/skbio.diversity.alpha.mcintosh_e", "generated/skbio.diversity.alpha.menhinick", "generated/skbio.diversity.alpha.michaelis_menten_fit", "generated/skbio.diversity.alpha.observed_features", "generated/skbio.diversity.alpha.osd", "generated/skbio.diversity.alpha.phydiv", "generated/skbio.diversity.alpha.pielou_e", "generated/skbio.diversity.alpha.renyi", "generated/skbio.diversity.alpha.robbins", "generated/skbio.diversity.alpha.shannon", "generated/skbio.diversity.alpha.simpson", "generated/skbio.diversity.alpha.simpson_d", "generated/skbio.diversity.alpha.simpson_e", "generated/skbio.diversity.alpha.singles", "generated/skbio.diversity.alpha.sobs", "generated/skbio.diversity.alpha.strong", "generated/skbio.diversity.alpha.tsallis", "generated/skbio.diversity.alpha_diversity", "generated/skbio.diversity.beta", "generated/skbio.diversity.beta.unweighted_unifrac", "generated/skbio.diversity.beta.weighted_unifrac", "generated/skbio.diversity.beta_diversity", "generated/skbio.diversity.block_beta_diversity", "generated/skbio.diversity.get_alpha_diversity_metrics", "generated/skbio.diversity.get_beta_diversity_metrics", "generated/skbio.diversity.partial_beta_diversity", "generated/skbio.embedding.Embedding", "generated/skbio.embedding.Embedding.bytes", "generated/skbio.embedding.Embedding.read", "generated/skbio.embedding.Embedding.write", "generated/skbio.embedding.EmbeddingVector", "generated/skbio.embedding.ProteinEmbedding", "generated/skbio.embedding.ProteinVector", "generated/skbio.embedding.SequenceEmbedding", "generated/skbio.embedding.SequenceVector", "generated/skbio.embedding.embed_vec_to_dataframe", "generated/skbio.embedding.embed_vec_to_distances", "generated/skbio.embedding.embed_vec_to_numpy", "generated/skbio.embedding.embed_vec_to_ordination", "generated/skbio.io.format.binary_dm", "generated/skbio.io.format.biom", "generated/skbio.io.format.blast6", "generated/skbio.io.format.blast7", "generated/skbio.io.format.clustal", "generated/skbio.io.format.embed", "generated/skbio.io.format.embl", "generated/skbio.io.format.fasta", "generated/skbio.io.format.fastq", "generated/skbio.io.format.genbank", "generated/skbio.io.format.gff3", "generated/skbio.io.format.lsmat", "generated/skbio.io.format.newick", "generated/skbio.io.format.ordination", "generated/skbio.io.format.phylip", "generated/skbio.io.format.qseq", "generated/skbio.io.format.sample_metadata", "generated/skbio.io.format.stockholm", "generated/skbio.io.format.taxdump", "generated/skbio.io.registry", "generated/skbio.io.registry.Format", "generated/skbio.io.registry.Format.reader", "generated/skbio.io.registry.Format.sniffer", "generated/skbio.io.registry.Format.writer", "generated/skbio.io.registry.IORegistry", "generated/skbio.io.registry.IORegistry.add_format", "generated/skbio.io.registry.IORegistry.create_format", "generated/skbio.io.registry.IORegistry.get_reader", "generated/skbio.io.registry.IORegistry.get_sniffer", "generated/skbio.io.registry.IORegistry.get_writer", "generated/skbio.io.registry.IORegistry.list_read_formats", "generated/skbio.io.registry.IORegistry.list_write_formats", "generated/skbio.io.registry.IORegistry.read", "generated/skbio.io.registry.IORegistry.remove_format", "generated/skbio.io.registry.IORegistry.sniff", "generated/skbio.io.registry.IORegistry.write", "generated/skbio.io.registry.create_format", "generated/skbio.io.registry.read", "generated/skbio.io.registry.sniff", "generated/skbio.io.registry.write", "generated/skbio.io.util", "generated/skbio.io.util.open", "generated/skbio.io.util.open_file", "generated/skbio.io.util.open_files", "generated/skbio.metadata.CategoricalMetadataColumn", "generated/skbio.metadata.Interval", "generated/skbio.metadata.Interval.drop", "generated/skbio.metadata.IntervalMetadata", "generated/skbio.metadata.IntervalMetadata.add", "generated/skbio.metadata.IntervalMetadata.concat", "generated/skbio.metadata.IntervalMetadata.drop", "generated/skbio.metadata.IntervalMetadata.merge", "generated/skbio.metadata.IntervalMetadata.query", "generated/skbio.metadata.IntervalMetadata.read", "generated/skbio.metadata.IntervalMetadata.sort", "generated/skbio.metadata.IntervalMetadata.write", "generated/skbio.metadata.IntervalMetadataMixin", "generated/skbio.metadata.IntervalMetadataMixin.has_interval_metadata", "generated/skbio.metadata.MetadataColumn", "generated/skbio.metadata.MetadataColumn.drop_missing_values", "generated/skbio.metadata.MetadataColumn.filter_ids", "generated/skbio.metadata.MetadataColumn.get_ids", "generated/skbio.metadata.MetadataColumn.get_missing", "generated/skbio.metadata.MetadataColumn.get_value", "generated/skbio.metadata.MetadataColumn.has_missing_values", "generated/skbio.metadata.MetadataColumn.to_dataframe", "generated/skbio.metadata.MetadataColumn.to_series", "generated/skbio.metadata.MetadataMixin", "generated/skbio.metadata.MetadataMixin.has_metadata", "generated/skbio.metadata.NumericMetadataColumn", "generated/skbio.metadata.PositionalMetadataMixin", "generated/skbio.metadata.PositionalMetadataMixin.has_positional_metadata", "generated/skbio.metadata.SampleMetadata", "generated/skbio.metadata.SampleMetadata.filter_columns", "generated/skbio.metadata.SampleMetadata.filter_ids", "generated/skbio.metadata.SampleMetadata.get_column", "generated/skbio.metadata.SampleMetadata.get_ids", "generated/skbio.metadata.SampleMetadata.load", "generated/skbio.metadata.SampleMetadata.merge", "generated/skbio.metadata.SampleMetadata.to_dataframe", "generated/skbio.sequence.DNA", "generated/skbio.sequence.DNA.find_motifs", "generated/skbio.sequence.DNA.read", "generated/skbio.sequence.DNA.transcribe", "generated/skbio.sequence.DNA.translate", "generated/skbio.sequence.DNA.translate_six_frames", "generated/skbio.sequence.DNA.write", "generated/skbio.sequence.GeneticCode", "generated/skbio.sequence.GeneticCode.from_ncbi", "generated/skbio.sequence.GeneticCode.translate", "generated/skbio.sequence.GeneticCode.translate_six_frames", "generated/skbio.sequence.GrammaredSequence", "generated/skbio.sequence.GrammaredSequence.definites", "generated/skbio.sequence.GrammaredSequence.degap", "generated/skbio.sequence.GrammaredSequence.degenerates", "generated/skbio.sequence.GrammaredSequence.expand_degenerates", "generated/skbio.sequence.GrammaredSequence.find_motifs", "generated/skbio.sequence.GrammaredSequence.gaps", "generated/skbio.sequence.GrammaredSequence.has_definites", "generated/skbio.sequence.GrammaredSequence.has_degenerates", "generated/skbio.sequence.GrammaredSequence.has_gaps", "generated/skbio.sequence.GrammaredSequence.has_nondegenerates", "generated/skbio.sequence.GrammaredSequence.nondegenerates", "generated/skbio.sequence.GrammaredSequence.to_definites", "generated/skbio.sequence.GrammaredSequence.to_regex", "generated/skbio.sequence.NucleotideMixin", "generated/skbio.sequence.NucleotideMixin.complement", "generated/skbio.sequence.NucleotideMixin.gc_content", "generated/skbio.sequence.NucleotideMixin.gc_frequency", "generated/skbio.sequence.NucleotideMixin.is_reverse_complement", "generated/skbio.sequence.NucleotideMixin.reverse_complement", "generated/skbio.sequence.Protein", "generated/skbio.sequence.Protein.find_motifs", "generated/skbio.sequence.Protein.has_stops", "generated/skbio.sequence.Protein.read", "generated/skbio.sequence.Protein.stops", "generated/skbio.sequence.Protein.write", "generated/skbio.sequence.RNA", "generated/skbio.sequence.RNA.find_motifs", "generated/skbio.sequence.RNA.read", "generated/skbio.sequence.RNA.reverse_transcribe", "generated/skbio.sequence.RNA.translate", "generated/skbio.sequence.RNA.translate_six_frames", "generated/skbio.sequence.RNA.write", "generated/skbio.sequence.Sequence", "generated/skbio.sequence.Sequence.concat", "generated/skbio.sequence.Sequence.count", "generated/skbio.sequence.Sequence.distance", "generated/skbio.sequence.Sequence.find_with_regex", "generated/skbio.sequence.Sequence.frequencies", "generated/skbio.sequence.Sequence.index", "generated/skbio.sequence.Sequence.iter_contiguous", "generated/skbio.sequence.Sequence.iter_kmers", "generated/skbio.sequence.Sequence.kmer_frequencies", "generated/skbio.sequence.Sequence.lowercase", "generated/skbio.sequence.Sequence.match_frequency", "generated/skbio.sequence.Sequence.matches", "generated/skbio.sequence.Sequence.mismatch_frequency", "generated/skbio.sequence.Sequence.mismatches", "generated/skbio.sequence.Sequence.read", "generated/skbio.sequence.Sequence.replace", "generated/skbio.sequence.Sequence.to_indices", "generated/skbio.sequence.Sequence.write", "generated/skbio.sequence.SubstitutionMatrix", "generated/skbio.sequence.SubstitutionMatrix.by_name", "generated/skbio.sequence.SubstitutionMatrix.from_dict", "generated/skbio.sequence.SubstitutionMatrix.get_names", "generated/skbio.sequence.SubstitutionMatrix.identity", "generated/skbio.sequence.SubstitutionMatrix.to_dict", "generated/skbio.sequence.distance", "generated/skbio.sequence.distance.hamming", "generated/skbio.sequence.distance.kmer_distance", "generated/skbio.stats.composition", "generated/skbio.stats.composition.alr", "generated/skbio.stats.composition.alr_inv", "generated/skbio.stats.composition.ancom", "generated/skbio.stats.composition.centralize", "generated/skbio.stats.composition.closure", "generated/skbio.stats.composition.clr", "generated/skbio.stats.composition.clr_inv", "generated/skbio.stats.composition.dirmult_ttest", "generated/skbio.stats.composition.ilr", "generated/skbio.stats.composition.ilr_inv", "generated/skbio.stats.composition.inner", "generated/skbio.stats.composition.multi_replace", "generated/skbio.stats.composition.pairwise_vlr", "generated/skbio.stats.composition.perturb", "generated/skbio.stats.composition.perturb_inv", "generated/skbio.stats.composition.power", "generated/skbio.stats.composition.sbp_basis", "generated/skbio.stats.composition.tree_basis", "generated/skbio.stats.composition.vlr", "generated/skbio.stats.distance", "generated/skbio.stats.distance.DissimilarityMatrix", "generated/skbio.stats.distance.DissimilarityMatrix.between", "generated/skbio.stats.distance.DissimilarityMatrix.copy", "generated/skbio.stats.distance.DissimilarityMatrix.filter", "generated/skbio.stats.distance.DissimilarityMatrix.from_iterable", "generated/skbio.stats.distance.DissimilarityMatrix.index", "generated/skbio.stats.distance.DissimilarityMatrix.plot", "generated/skbio.stats.distance.DissimilarityMatrix.read", "generated/skbio.stats.distance.DissimilarityMatrix.redundant_form", "generated/skbio.stats.distance.DissimilarityMatrix.rename", "generated/skbio.stats.distance.DissimilarityMatrix.to_data_frame", "generated/skbio.stats.distance.DissimilarityMatrix.transpose", "generated/skbio.stats.distance.DissimilarityMatrix.within", "generated/skbio.stats.distance.DissimilarityMatrix.write", "generated/skbio.stats.distance.DistanceMatrix", "generated/skbio.stats.distance.DistanceMatrix.condensed_form", "generated/skbio.stats.distance.DistanceMatrix.from_iterable", "generated/skbio.stats.distance.DistanceMatrix.permute", "generated/skbio.stats.distance.DistanceMatrix.to_series", "generated/skbio.stats.distance.anosim", "generated/skbio.stats.distance.bioenv", "generated/skbio.stats.distance.mantel", "generated/skbio.stats.distance.permanova", "generated/skbio.stats.distance.permdisp", "generated/skbio.stats.distance.pwmantel", "generated/skbio.stats.distance.randdm", "generated/skbio.stats.evolve", "generated/skbio.stats.evolve.hommola_cospeciation", "generated/skbio.stats.gradient", "generated/skbio.stats.gradient.AverageGradientANOVA", "generated/skbio.stats.gradient.CategoryResults", "generated/skbio.stats.gradient.CategoryResults.to_files", "generated/skbio.stats.gradient.FirstDifferenceGradientANOVA", "generated/skbio.stats.gradient.GradientANOVA", "generated/skbio.stats.gradient.GradientANOVA.get_trajectories", "generated/skbio.stats.gradient.GradientANOVAResults", "generated/skbio.stats.gradient.GradientANOVAResults.to_files", "generated/skbio.stats.gradient.GroupResults", "generated/skbio.stats.gradient.GroupResults.to_files", "generated/skbio.stats.gradient.TrajectoryGradientANOVA", "generated/skbio.stats.gradient.WindowDifferenceGradientANOVA", "generated/skbio.stats.isubsample", "generated/skbio.stats.ordination", "generated/skbio.stats.ordination.OrdinationResults", "generated/skbio.stats.ordination.OrdinationResults.plot", "generated/skbio.stats.ordination.OrdinationResults.read", "generated/skbio.stats.ordination.OrdinationResults.rename", "generated/skbio.stats.ordination.OrdinationResults.write", "generated/skbio.stats.ordination.ca", "generated/skbio.stats.ordination.cca", "generated/skbio.stats.ordination.corr", "generated/skbio.stats.ordination.e_matrix", "generated/skbio.stats.ordination.f_matrix", "generated/skbio.stats.ordination.mean_and_std", "generated/skbio.stats.ordination.pcoa", "generated/skbio.stats.ordination.pcoa_biplot", "generated/skbio.stats.ordination.rda", "generated/skbio.stats.ordination.scale", "generated/skbio.stats.ordination.svd_rank", "generated/skbio.stats.power", "generated/skbio.stats.power.confidence_bound", "generated/skbio.stats.power.paired_subsamples", "generated/skbio.stats.power.subsample_paired_power", "generated/skbio.stats.power.subsample_power", "generated/skbio.stats.subsample_counts", "generated/skbio.table.Table", "generated/skbio.table.Table.add_group_metadata", "generated/skbio.table.Table.add_metadata", "generated/skbio.table.Table.align_to", "generated/skbio.table.Table.align_to_dataframe", "generated/skbio.table.Table.align_tree", "generated/skbio.table.Table.collapse", "generated/skbio.table.Table.concat", "generated/skbio.table.Table.copy", "generated/skbio.table.Table.data", "generated/skbio.table.Table.del_metadata", "generated/skbio.table.Table.delimited_self", "generated/skbio.table.Table.descriptive_equality", "generated/skbio.table.Table.exists", "generated/skbio.table.Table.filter", "generated/skbio.table.Table.from_adjacency", "generated/skbio.table.Table.from_hdf5", "generated/skbio.table.Table.from_json", "generated/skbio.table.Table.from_tsv", "generated/skbio.table.Table.get_table_density", "generated/skbio.table.Table.get_value_by_ids", "generated/skbio.table.Table.group_metadata", "generated/skbio.table.Table.head", "generated/skbio.table.Table.ids", "generated/skbio.table.Table.index", "generated/skbio.table.Table.is_empty", "generated/skbio.table.Table.iter", "generated/skbio.table.Table.iter_data", "generated/skbio.table.Table.iter_pairwise", "generated/skbio.table.Table.length", "generated/skbio.table.Table.max", "generated/skbio.table.Table.merge", "generated/skbio.table.Table.metadata", "generated/skbio.table.Table.metadata_to_dataframe", "generated/skbio.table.Table.min", "generated/skbio.table.Table.nonzero", "generated/skbio.table.Table.nonzero_counts", "generated/skbio.table.Table.norm", "generated/skbio.table.Table.pa", "generated/skbio.table.Table.partition", "generated/skbio.table.Table.rankdata", "generated/skbio.table.Table.read", "generated/skbio.table.Table.reduce", "generated/skbio.table.Table.remove_empty", "generated/skbio.table.Table.sort", "generated/skbio.table.Table.sort_order", "generated/skbio.table.Table.subsample", "generated/skbio.table.Table.sum", "generated/skbio.table.Table.to_anndata", "generated/skbio.table.Table.to_dataframe", "generated/skbio.table.Table.to_hdf5", "generated/skbio.table.Table.to_json", "generated/skbio.table.Table.to_tsv", "generated/skbio.table.Table.transform", "generated/skbio.table.Table.transpose", "generated/skbio.table.Table.update_ids", "generated/skbio.table.Table.write", "generated/skbio.table.example_table", "generated/skbio.tree.TreeNode", "generated/skbio.tree.TreeNode.ancestors", "generated/skbio.tree.TreeNode.append", "generated/skbio.tree.TreeNode.ascii_art", "generated/skbio.tree.TreeNode.assign_ids", "generated/skbio.tree.TreeNode.assign_supports", "generated/skbio.tree.TreeNode.bifurcate", "generated/skbio.tree.TreeNode.bipart", "generated/skbio.tree.TreeNode.biparts", "generated/skbio.tree.TreeNode.cache_attr", "generated/skbio.tree.TreeNode.clear_caches", "generated/skbio.tree.TreeNode.compare_biparts", "generated/skbio.tree.TreeNode.compare_cophenet", "generated/skbio.tree.TreeNode.compare_rfd", "generated/skbio.tree.TreeNode.compare_subsets", "generated/skbio.tree.TreeNode.compare_wrfd", "generated/skbio.tree.TreeNode.cophenet", "generated/skbio.tree.TreeNode.copy", "generated/skbio.tree.TreeNode.count", "generated/skbio.tree.TreeNode.create_caches", "generated/skbio.tree.TreeNode.deepcopy", "generated/skbio.tree.TreeNode.depth", "generated/skbio.tree.TreeNode.distance", "generated/skbio.tree.TreeNode.extend", "generated/skbio.tree.TreeNode.find", "generated/skbio.tree.TreeNode.find_all", "generated/skbio.tree.TreeNode.find_by_func", "generated/skbio.tree.TreeNode.find_by_id", "generated/skbio.tree.TreeNode.from_linkage_matrix", "generated/skbio.tree.TreeNode.from_taxdump", "generated/skbio.tree.TreeNode.from_taxonomy", "generated/skbio.tree.TreeNode.has_caches", "generated/skbio.tree.TreeNode.has_children", "generated/skbio.tree.TreeNode.height", "generated/skbio.tree.TreeNode.index_tree", "generated/skbio.tree.TreeNode.insert", "generated/skbio.tree.TreeNode.is_bifurcating", "generated/skbio.tree.TreeNode.is_root", "generated/skbio.tree.TreeNode.is_tip", "generated/skbio.tree.TreeNode.lca", "generated/skbio.tree.TreeNode.levelorder", "generated/skbio.tree.TreeNode.maxdist", "generated/skbio.tree.TreeNode.neighbors", "generated/skbio.tree.TreeNode.non_tips", "generated/skbio.tree.TreeNode.observed_node_counts", "generated/skbio.tree.TreeNode.path", "generated/skbio.tree.TreeNode.pop", "generated/skbio.tree.TreeNode.postorder", "generated/skbio.tree.TreeNode.pre_and_postorder", "generated/skbio.tree.TreeNode.preorder", "generated/skbio.tree.TreeNode.prune", "generated/skbio.tree.TreeNode.read", "generated/skbio.tree.TreeNode.remove", "generated/skbio.tree.TreeNode.remove_by_func", "generated/skbio.tree.TreeNode.remove_deleted", "generated/skbio.tree.TreeNode.root", "generated/skbio.tree.TreeNode.root_at", "generated/skbio.tree.TreeNode.root_at_midpoint", "generated/skbio.tree.TreeNode.root_by_outgroup", "generated/skbio.tree.TreeNode.shear", "generated/skbio.tree.TreeNode.shuffle", "generated/skbio.tree.TreeNode.siblings", "generated/skbio.tree.TreeNode.subset", "generated/skbio.tree.TreeNode.subsets", "generated/skbio.tree.TreeNode.subtree", "generated/skbio.tree.TreeNode.tips", "generated/skbio.tree.TreeNode.to_array", "generated/skbio.tree.TreeNode.to_taxonomy", "generated/skbio.tree.TreeNode.total_length", "generated/skbio.tree.TreeNode.traverse", "generated/skbio.tree.TreeNode.unpack", "generated/skbio.tree.TreeNode.unpack_by_func", "generated/skbio.tree.TreeNode.unroot", "generated/skbio.tree.TreeNode.unrooted_copy", "generated/skbio.tree.TreeNode.unrooted_deepcopy", "generated/skbio.tree.TreeNode.unrooted_move", "generated/skbio.tree.TreeNode.write", "generated/skbio.tree.bme", "generated/skbio.tree.gme", "generated/skbio.tree.majority_rule", "generated/skbio.tree.nj", "generated/skbio.tree.nni", "generated/skbio.tree.path_dists", "generated/skbio.tree.rf_dists", "generated/skbio.tree.upgma", "generated/skbio.tree.wrf_dists", "generated/skbio.util.PlottableMixin", "generated/skbio.util.aliased", "generated/skbio.util.assert_data_frame_almost_equal", "generated/skbio.util.assert_ordination_results_equal", "generated/skbio.util.cardinal_to_ordinal", "generated/skbio.util.classonlymethod", "generated/skbio.util.classproperty", "generated/skbio.util.deprecated", "generated/skbio.util.find_duplicates", "generated/skbio.util.get_data_path", "generated/skbio.util.get_rng", "generated/skbio.util.overrides", "generated/skbio.util.params_aliased", "generated/skbio.util.register_aliases", "generated/skbio.util.safe_md5", "generated/skbio.workflow.Workflow", "generated/skbio.workflow.Workflow.initialize_state", "generated/skbio.workflow.method", "generated/skbio.workflow.requires", "index", "io", "metadata", "sequence", "stats", "table", "tree", "util", "workflow"], "envversion": {"sphinx": 64, "sphinx.domains.c": 3, "sphinx.domains.changeset": 1, "sphinx.domains.citation": 1, "sphinx.domains.cpp": 9, "sphinx.domains.index": 1, "sphinx.domains.javascript": 3, "sphinx.domains.math": 2, "sphinx.domains.python": 4, "sphinx.domains.rst": 2, "sphinx.domains.std": 2, "sphinx.ext.intersphinx": 1}, "filenames": ["alignment.rst", "diversity.rst", "embedding.rst", "generated/skbio.alignment.AlignPath.rst", "generated/skbio.alignment.AlignPath.from_bits.rst", "generated/skbio.alignment.AlignPath.from_coordinates.rst", "generated/skbio.alignment.AlignPath.from_indices.rst", "generated/skbio.alignment.AlignPath.from_tabular.rst", "generated/skbio.alignment.AlignPath.to_bits.rst", "generated/skbio.alignment.AlignPath.to_coordinates.rst", "generated/skbio.alignment.AlignPath.to_indices.rst", "generated/skbio.alignment.AlignmentStructure.rst", "generated/skbio.alignment.AlignmentStructure.is_zero_based.rst", "generated/skbio.alignment.AlignmentStructure.set_zero_based.rst", "generated/skbio.alignment.PairAlignPath.rst", "generated/skbio.alignment.PairAlignPath.from_bits.rst", "generated/skbio.alignment.PairAlignPath.from_cigar.rst", "generated/skbio.alignment.PairAlignPath.to_bits.rst", "generated/skbio.alignment.PairAlignPath.to_cigar.rst", "generated/skbio.alignment.StripedSmithWaterman.rst", "generated/skbio.alignment.TabularMSA.rst", "generated/skbio.alignment.TabularMSA.append.rst", "generated/skbio.alignment.TabularMSA.consensus.rst", "generated/skbio.alignment.TabularMSA.conservation.rst", "generated/skbio.alignment.TabularMSA.extend.rst", "generated/skbio.alignment.TabularMSA.from_dict.rst", "generated/skbio.alignment.TabularMSA.from_path_seqs.rst", "generated/skbio.alignment.TabularMSA.gap_frequencies.rst", "generated/skbio.alignment.TabularMSA.iter_positions.rst", "generated/skbio.alignment.TabularMSA.join.rst", "generated/skbio.alignment.TabularMSA.read.rst", "generated/skbio.alignment.TabularMSA.reassign_index.rst", "generated/skbio.alignment.TabularMSA.sort.rst", "generated/skbio.alignment.TabularMSA.to_dict.rst", "generated/skbio.alignment.TabularMSA.write.rst", "generated/skbio.alignment.global_pairwise_align.rst", "generated/skbio.alignment.global_pairwise_align_nucleotide.rst", "generated/skbio.alignment.global_pairwise_align_protein.rst", "generated/skbio.alignment.local_pairwise_align.rst", "generated/skbio.alignment.local_pairwise_align_nucleotide.rst", "generated/skbio.alignment.local_pairwise_align_protein.rst", "generated/skbio.alignment.local_pairwise_align_ssw.rst", "generated/skbio.alignment.make_identity_substitution_matrix.rst", "generated/skbio.diversity.alpha.rst", "generated/skbio.diversity.alpha.ace.rst", "generated/skbio.diversity.alpha.berger_parker_d.rst", "generated/skbio.diversity.alpha.brillouin_d.rst", "generated/skbio.diversity.alpha.chao1.rst", "generated/skbio.diversity.alpha.chao1_ci.rst", "generated/skbio.diversity.alpha.dominance.rst", "generated/skbio.diversity.alpha.doubles.rst", "generated/skbio.diversity.alpha.enspie.rst", "generated/skbio.diversity.alpha.esty_ci.rst", "generated/skbio.diversity.alpha.faith_pd.rst", "generated/skbio.diversity.alpha.fisher_alpha.rst", "generated/skbio.diversity.alpha.gini_index.rst", "generated/skbio.diversity.alpha.goods_coverage.rst", "generated/skbio.diversity.alpha.heip_e.rst", "generated/skbio.diversity.alpha.hill.rst", "generated/skbio.diversity.alpha.inv_simpson.rst", "generated/skbio.diversity.alpha.kempton_taylor_q.rst", "generated/skbio.diversity.alpha.lladser_ci.rst", "generated/skbio.diversity.alpha.lladser_pe.rst", "generated/skbio.diversity.alpha.margalef.rst", "generated/skbio.diversity.alpha.mcintosh_d.rst", "generated/skbio.diversity.alpha.mcintosh_e.rst", "generated/skbio.diversity.alpha.menhinick.rst", "generated/skbio.diversity.alpha.michaelis_menten_fit.rst", "generated/skbio.diversity.alpha.observed_features.rst", "generated/skbio.diversity.alpha.osd.rst", "generated/skbio.diversity.alpha.phydiv.rst", "generated/skbio.diversity.alpha.pielou_e.rst", "generated/skbio.diversity.alpha.renyi.rst", "generated/skbio.diversity.alpha.robbins.rst", "generated/skbio.diversity.alpha.shannon.rst", "generated/skbio.diversity.alpha.simpson.rst", "generated/skbio.diversity.alpha.simpson_d.rst", "generated/skbio.diversity.alpha.simpson_e.rst", "generated/skbio.diversity.alpha.singles.rst", "generated/skbio.diversity.alpha.sobs.rst", "generated/skbio.diversity.alpha.strong.rst", "generated/skbio.diversity.alpha.tsallis.rst", "generated/skbio.diversity.alpha_diversity.rst", "generated/skbio.diversity.beta.rst", "generated/skbio.diversity.beta.unweighted_unifrac.rst", "generated/skbio.diversity.beta.weighted_unifrac.rst", "generated/skbio.diversity.beta_diversity.rst", "generated/skbio.diversity.block_beta_diversity.rst", "generated/skbio.diversity.get_alpha_diversity_metrics.rst", "generated/skbio.diversity.get_beta_diversity_metrics.rst", "generated/skbio.diversity.partial_beta_diversity.rst", "generated/skbio.embedding.Embedding.rst", "generated/skbio.embedding.Embedding.bytes.rst", "generated/skbio.embedding.Embedding.read.rst", "generated/skbio.embedding.Embedding.write.rst", "generated/skbio.embedding.EmbeddingVector.rst", "generated/skbio.embedding.ProteinEmbedding.rst", "generated/skbio.embedding.ProteinVector.rst", "generated/skbio.embedding.SequenceEmbedding.rst", "generated/skbio.embedding.SequenceVector.rst", "generated/skbio.embedding.embed_vec_to_dataframe.rst", "generated/skbio.embedding.embed_vec_to_distances.rst", "generated/skbio.embedding.embed_vec_to_numpy.rst", "generated/skbio.embedding.embed_vec_to_ordination.rst", "generated/skbio.io.format.binary_dm.rst", "generated/skbio.io.format.biom.rst", "generated/skbio.io.format.blast6.rst", "generated/skbio.io.format.blast7.rst", "generated/skbio.io.format.clustal.rst", "generated/skbio.io.format.embed.rst", "generated/skbio.io.format.embl.rst", "generated/skbio.io.format.fasta.rst", "generated/skbio.io.format.fastq.rst", "generated/skbio.io.format.genbank.rst", "generated/skbio.io.format.gff3.rst", "generated/skbio.io.format.lsmat.rst", "generated/skbio.io.format.newick.rst", "generated/skbio.io.format.ordination.rst", "generated/skbio.io.format.phylip.rst", "generated/skbio.io.format.qseq.rst", "generated/skbio.io.format.sample_metadata.rst", "generated/skbio.io.format.stockholm.rst", "generated/skbio.io.format.taxdump.rst", "generated/skbio.io.registry.rst", "generated/skbio.io.registry.Format.rst", "generated/skbio.io.registry.Format.reader.rst", "generated/skbio.io.registry.Format.sniffer.rst", "generated/skbio.io.registry.Format.writer.rst", "generated/skbio.io.registry.IORegistry.rst", "generated/skbio.io.registry.IORegistry.add_format.rst", "generated/skbio.io.registry.IORegistry.create_format.rst", "generated/skbio.io.registry.IORegistry.get_reader.rst", "generated/skbio.io.registry.IORegistry.get_sniffer.rst", "generated/skbio.io.registry.IORegistry.get_writer.rst", "generated/skbio.io.registry.IORegistry.list_read_formats.rst", "generated/skbio.io.registry.IORegistry.list_write_formats.rst", "generated/skbio.io.registry.IORegistry.read.rst", "generated/skbio.io.registry.IORegistry.remove_format.rst", "generated/skbio.io.registry.IORegistry.sniff.rst", "generated/skbio.io.registry.IORegistry.write.rst", "generated/skbio.io.registry.create_format.rst", "generated/skbio.io.registry.read.rst", "generated/skbio.io.registry.sniff.rst", "generated/skbio.io.registry.write.rst", "generated/skbio.io.util.rst", "generated/skbio.io.util.open.rst", "generated/skbio.io.util.open_file.rst", "generated/skbio.io.util.open_files.rst", "generated/skbio.metadata.CategoricalMetadataColumn.rst", "generated/skbio.metadata.Interval.rst", "generated/skbio.metadata.Interval.drop.rst", "generated/skbio.metadata.IntervalMetadata.rst", "generated/skbio.metadata.IntervalMetadata.add.rst", "generated/skbio.metadata.IntervalMetadata.concat.rst", "generated/skbio.metadata.IntervalMetadata.drop.rst", "generated/skbio.metadata.IntervalMetadata.merge.rst", "generated/skbio.metadata.IntervalMetadata.query.rst", "generated/skbio.metadata.IntervalMetadata.read.rst", "generated/skbio.metadata.IntervalMetadata.sort.rst", "generated/skbio.metadata.IntervalMetadata.write.rst", "generated/skbio.metadata.IntervalMetadataMixin.rst", "generated/skbio.metadata.IntervalMetadataMixin.has_interval_metadata.rst", "generated/skbio.metadata.MetadataColumn.rst", "generated/skbio.metadata.MetadataColumn.drop_missing_values.rst", "generated/skbio.metadata.MetadataColumn.filter_ids.rst", "generated/skbio.metadata.MetadataColumn.get_ids.rst", "generated/skbio.metadata.MetadataColumn.get_missing.rst", "generated/skbio.metadata.MetadataColumn.get_value.rst", "generated/skbio.metadata.MetadataColumn.has_missing_values.rst", "generated/skbio.metadata.MetadataColumn.to_dataframe.rst", "generated/skbio.metadata.MetadataColumn.to_series.rst", "generated/skbio.metadata.MetadataMixin.rst", "generated/skbio.metadata.MetadataMixin.has_metadata.rst", "generated/skbio.metadata.NumericMetadataColumn.rst", "generated/skbio.metadata.PositionalMetadataMixin.rst", "generated/skbio.metadata.PositionalMetadataMixin.has_positional_metadata.rst", "generated/skbio.metadata.SampleMetadata.rst", "generated/skbio.metadata.SampleMetadata.filter_columns.rst", "generated/skbio.metadata.SampleMetadata.filter_ids.rst", "generated/skbio.metadata.SampleMetadata.get_column.rst", "generated/skbio.metadata.SampleMetadata.get_ids.rst", "generated/skbio.metadata.SampleMetadata.load.rst", "generated/skbio.metadata.SampleMetadata.merge.rst", "generated/skbio.metadata.SampleMetadata.to_dataframe.rst", "generated/skbio.sequence.DNA.rst", "generated/skbio.sequence.DNA.find_motifs.rst", "generated/skbio.sequence.DNA.read.rst", "generated/skbio.sequence.DNA.transcribe.rst", "generated/skbio.sequence.DNA.translate.rst", "generated/skbio.sequence.DNA.translate_six_frames.rst", "generated/skbio.sequence.DNA.write.rst", "generated/skbio.sequence.GeneticCode.rst", "generated/skbio.sequence.GeneticCode.from_ncbi.rst", "generated/skbio.sequence.GeneticCode.translate.rst", "generated/skbio.sequence.GeneticCode.translate_six_frames.rst", "generated/skbio.sequence.GrammaredSequence.rst", "generated/skbio.sequence.GrammaredSequence.definites.rst", "generated/skbio.sequence.GrammaredSequence.degap.rst", "generated/skbio.sequence.GrammaredSequence.degenerates.rst", "generated/skbio.sequence.GrammaredSequence.expand_degenerates.rst", "generated/skbio.sequence.GrammaredSequence.find_motifs.rst", "generated/skbio.sequence.GrammaredSequence.gaps.rst", "generated/skbio.sequence.GrammaredSequence.has_definites.rst", "generated/skbio.sequence.GrammaredSequence.has_degenerates.rst", "generated/skbio.sequence.GrammaredSequence.has_gaps.rst", "generated/skbio.sequence.GrammaredSequence.has_nondegenerates.rst", "generated/skbio.sequence.GrammaredSequence.nondegenerates.rst", "generated/skbio.sequence.GrammaredSequence.to_definites.rst", "generated/skbio.sequence.GrammaredSequence.to_regex.rst", "generated/skbio.sequence.NucleotideMixin.rst", "generated/skbio.sequence.NucleotideMixin.complement.rst", "generated/skbio.sequence.NucleotideMixin.gc_content.rst", "generated/skbio.sequence.NucleotideMixin.gc_frequency.rst", "generated/skbio.sequence.NucleotideMixin.is_reverse_complement.rst", "generated/skbio.sequence.NucleotideMixin.reverse_complement.rst", "generated/skbio.sequence.Protein.rst", "generated/skbio.sequence.Protein.find_motifs.rst", "generated/skbio.sequence.Protein.has_stops.rst", "generated/skbio.sequence.Protein.read.rst", "generated/skbio.sequence.Protein.stops.rst", "generated/skbio.sequence.Protein.write.rst", "generated/skbio.sequence.RNA.rst", "generated/skbio.sequence.RNA.find_motifs.rst", "generated/skbio.sequence.RNA.read.rst", "generated/skbio.sequence.RNA.reverse_transcribe.rst", "generated/skbio.sequence.RNA.translate.rst", "generated/skbio.sequence.RNA.translate_six_frames.rst", "generated/skbio.sequence.RNA.write.rst", "generated/skbio.sequence.Sequence.rst", "generated/skbio.sequence.Sequence.concat.rst", "generated/skbio.sequence.Sequence.count.rst", "generated/skbio.sequence.Sequence.distance.rst", "generated/skbio.sequence.Sequence.find_with_regex.rst", "generated/skbio.sequence.Sequence.frequencies.rst", "generated/skbio.sequence.Sequence.index.rst", "generated/skbio.sequence.Sequence.iter_contiguous.rst", "generated/skbio.sequence.Sequence.iter_kmers.rst", "generated/skbio.sequence.Sequence.kmer_frequencies.rst", "generated/skbio.sequence.Sequence.lowercase.rst", "generated/skbio.sequence.Sequence.match_frequency.rst", "generated/skbio.sequence.Sequence.matches.rst", "generated/skbio.sequence.Sequence.mismatch_frequency.rst", "generated/skbio.sequence.Sequence.mismatches.rst", "generated/skbio.sequence.Sequence.read.rst", "generated/skbio.sequence.Sequence.replace.rst", "generated/skbio.sequence.Sequence.to_indices.rst", "generated/skbio.sequence.Sequence.write.rst", "generated/skbio.sequence.SubstitutionMatrix.rst", "generated/skbio.sequence.SubstitutionMatrix.by_name.rst", "generated/skbio.sequence.SubstitutionMatrix.from_dict.rst", "generated/skbio.sequence.SubstitutionMatrix.get_names.rst", "generated/skbio.sequence.SubstitutionMatrix.identity.rst", "generated/skbio.sequence.SubstitutionMatrix.to_dict.rst", "generated/skbio.sequence.distance.rst", "generated/skbio.sequence.distance.hamming.rst", "generated/skbio.sequence.distance.kmer_distance.rst", "generated/skbio.stats.composition.rst", "generated/skbio.stats.composition.alr.rst", "generated/skbio.stats.composition.alr_inv.rst", "generated/skbio.stats.composition.ancom.rst", "generated/skbio.stats.composition.centralize.rst", "generated/skbio.stats.composition.closure.rst", "generated/skbio.stats.composition.clr.rst", "generated/skbio.stats.composition.clr_inv.rst", "generated/skbio.stats.composition.dirmult_ttest.rst", "generated/skbio.stats.composition.ilr.rst", "generated/skbio.stats.composition.ilr_inv.rst", "generated/skbio.stats.composition.inner.rst", "generated/skbio.stats.composition.multi_replace.rst", "generated/skbio.stats.composition.pairwise_vlr.rst", "generated/skbio.stats.composition.perturb.rst", "generated/skbio.stats.composition.perturb_inv.rst", "generated/skbio.stats.composition.power.rst", "generated/skbio.stats.composition.sbp_basis.rst", "generated/skbio.stats.composition.tree_basis.rst", "generated/skbio.stats.composition.vlr.rst", "generated/skbio.stats.distance.rst", "generated/skbio.stats.distance.DissimilarityMatrix.rst", "generated/skbio.stats.distance.DissimilarityMatrix.between.rst", "generated/skbio.stats.distance.DissimilarityMatrix.copy.rst", "generated/skbio.stats.distance.DissimilarityMatrix.filter.rst", "generated/skbio.stats.distance.DissimilarityMatrix.from_iterable.rst", "generated/skbio.stats.distance.DissimilarityMatrix.index.rst", "generated/skbio.stats.distance.DissimilarityMatrix.plot.rst", "generated/skbio.stats.distance.DissimilarityMatrix.read.rst", "generated/skbio.stats.distance.DissimilarityMatrix.redundant_form.rst", "generated/skbio.stats.distance.DissimilarityMatrix.rename.rst", "generated/skbio.stats.distance.DissimilarityMatrix.to_data_frame.rst", "generated/skbio.stats.distance.DissimilarityMatrix.transpose.rst", "generated/skbio.stats.distance.DissimilarityMatrix.within.rst", "generated/skbio.stats.distance.DissimilarityMatrix.write.rst", "generated/skbio.stats.distance.DistanceMatrix.rst", "generated/skbio.stats.distance.DistanceMatrix.condensed_form.rst", "generated/skbio.stats.distance.DistanceMatrix.from_iterable.rst", "generated/skbio.stats.distance.DistanceMatrix.permute.rst", "generated/skbio.stats.distance.DistanceMatrix.to_series.rst", "generated/skbio.stats.distance.anosim.rst", "generated/skbio.stats.distance.bioenv.rst", "generated/skbio.stats.distance.mantel.rst", "generated/skbio.stats.distance.permanova.rst", "generated/skbio.stats.distance.permdisp.rst", "generated/skbio.stats.distance.pwmantel.rst", "generated/skbio.stats.distance.randdm.rst", "generated/skbio.stats.evolve.rst", "generated/skbio.stats.evolve.hommola_cospeciation.rst", "generated/skbio.stats.gradient.rst", "generated/skbio.stats.gradient.AverageGradientANOVA.rst", "generated/skbio.stats.gradient.CategoryResults.rst", "generated/skbio.stats.gradient.CategoryResults.to_files.rst", "generated/skbio.stats.gradient.FirstDifferenceGradientANOVA.rst", "generated/skbio.stats.gradient.GradientANOVA.rst", "generated/skbio.stats.gradient.GradientANOVA.get_trajectories.rst", "generated/skbio.stats.gradient.GradientANOVAResults.rst", "generated/skbio.stats.gradient.GradientANOVAResults.to_files.rst", "generated/skbio.stats.gradient.GroupResults.rst", "generated/skbio.stats.gradient.GroupResults.to_files.rst", "generated/skbio.stats.gradient.TrajectoryGradientANOVA.rst", "generated/skbio.stats.gradient.WindowDifferenceGradientANOVA.rst", "generated/skbio.stats.isubsample.rst", "generated/skbio.stats.ordination.rst", "generated/skbio.stats.ordination.OrdinationResults.rst", "generated/skbio.stats.ordination.OrdinationResults.plot.rst", "generated/skbio.stats.ordination.OrdinationResults.read.rst", "generated/skbio.stats.ordination.OrdinationResults.rename.rst", "generated/skbio.stats.ordination.OrdinationResults.write.rst", "generated/skbio.stats.ordination.ca.rst", "generated/skbio.stats.ordination.cca.rst", "generated/skbio.stats.ordination.corr.rst", "generated/skbio.stats.ordination.e_matrix.rst", "generated/skbio.stats.ordination.f_matrix.rst", "generated/skbio.stats.ordination.mean_and_std.rst", "generated/skbio.stats.ordination.pcoa.rst", "generated/skbio.stats.ordination.pcoa_biplot.rst", "generated/skbio.stats.ordination.rda.rst", "generated/skbio.stats.ordination.scale.rst", "generated/skbio.stats.ordination.svd_rank.rst", "generated/skbio.stats.power.rst", "generated/skbio.stats.power.confidence_bound.rst", "generated/skbio.stats.power.paired_subsamples.rst", "generated/skbio.stats.power.subsample_paired_power.rst", "generated/skbio.stats.power.subsample_power.rst", "generated/skbio.stats.subsample_counts.rst", "generated/skbio.table.Table.rst", "generated/skbio.table.Table.add_group_metadata.rst", "generated/skbio.table.Table.add_metadata.rst", "generated/skbio.table.Table.align_to.rst", "generated/skbio.table.Table.align_to_dataframe.rst", "generated/skbio.table.Table.align_tree.rst", "generated/skbio.table.Table.collapse.rst", "generated/skbio.table.Table.concat.rst", "generated/skbio.table.Table.copy.rst", "generated/skbio.table.Table.data.rst", "generated/skbio.table.Table.del_metadata.rst", "generated/skbio.table.Table.delimited_self.rst", "generated/skbio.table.Table.descriptive_equality.rst", "generated/skbio.table.Table.exists.rst", "generated/skbio.table.Table.filter.rst", "generated/skbio.table.Table.from_adjacency.rst", "generated/skbio.table.Table.from_hdf5.rst", "generated/skbio.table.Table.from_json.rst", "generated/skbio.table.Table.from_tsv.rst", "generated/skbio.table.Table.get_table_density.rst", "generated/skbio.table.Table.get_value_by_ids.rst", "generated/skbio.table.Table.group_metadata.rst", "generated/skbio.table.Table.head.rst", "generated/skbio.table.Table.ids.rst", "generated/skbio.table.Table.index.rst", "generated/skbio.table.Table.is_empty.rst", "generated/skbio.table.Table.iter.rst", "generated/skbio.table.Table.iter_data.rst", "generated/skbio.table.Table.iter_pairwise.rst", "generated/skbio.table.Table.length.rst", "generated/skbio.table.Table.max.rst", "generated/skbio.table.Table.merge.rst", "generated/skbio.table.Table.metadata.rst", "generated/skbio.table.Table.metadata_to_dataframe.rst", "generated/skbio.table.Table.min.rst", "generated/skbio.table.Table.nonzero.rst", "generated/skbio.table.Table.nonzero_counts.rst", "generated/skbio.table.Table.norm.rst", "generated/skbio.table.Table.pa.rst", "generated/skbio.table.Table.partition.rst", "generated/skbio.table.Table.rankdata.rst", "generated/skbio.table.Table.read.rst", "generated/skbio.table.Table.reduce.rst", "generated/skbio.table.Table.remove_empty.rst", "generated/skbio.table.Table.sort.rst", "generated/skbio.table.Table.sort_order.rst", "generated/skbio.table.Table.subsample.rst", "generated/skbio.table.Table.sum.rst", "generated/skbio.table.Table.to_anndata.rst", "generated/skbio.table.Table.to_dataframe.rst", "generated/skbio.table.Table.to_hdf5.rst", "generated/skbio.table.Table.to_json.rst", "generated/skbio.table.Table.to_tsv.rst", "generated/skbio.table.Table.transform.rst", "generated/skbio.table.Table.transpose.rst", "generated/skbio.table.Table.update_ids.rst", "generated/skbio.table.Table.write.rst", "generated/skbio.table.example_table.rst", "generated/skbio.tree.TreeNode.rst", "generated/skbio.tree.TreeNode.ancestors.rst", "generated/skbio.tree.TreeNode.append.rst", "generated/skbio.tree.TreeNode.ascii_art.rst", "generated/skbio.tree.TreeNode.assign_ids.rst", "generated/skbio.tree.TreeNode.assign_supports.rst", "generated/skbio.tree.TreeNode.bifurcate.rst", "generated/skbio.tree.TreeNode.bipart.rst", "generated/skbio.tree.TreeNode.biparts.rst", "generated/skbio.tree.TreeNode.cache_attr.rst", "generated/skbio.tree.TreeNode.clear_caches.rst", "generated/skbio.tree.TreeNode.compare_biparts.rst", "generated/skbio.tree.TreeNode.compare_cophenet.rst", "generated/skbio.tree.TreeNode.compare_rfd.rst", "generated/skbio.tree.TreeNode.compare_subsets.rst", "generated/skbio.tree.TreeNode.compare_wrfd.rst", "generated/skbio.tree.TreeNode.cophenet.rst", "generated/skbio.tree.TreeNode.copy.rst", "generated/skbio.tree.TreeNode.count.rst", "generated/skbio.tree.TreeNode.create_caches.rst", "generated/skbio.tree.TreeNode.deepcopy.rst", "generated/skbio.tree.TreeNode.depth.rst", "generated/skbio.tree.TreeNode.distance.rst", "generated/skbio.tree.TreeNode.extend.rst", "generated/skbio.tree.TreeNode.find.rst", "generated/skbio.tree.TreeNode.find_all.rst", "generated/skbio.tree.TreeNode.find_by_func.rst", "generated/skbio.tree.TreeNode.find_by_id.rst", "generated/skbio.tree.TreeNode.from_linkage_matrix.rst", "generated/skbio.tree.TreeNode.from_taxdump.rst", "generated/skbio.tree.TreeNode.from_taxonomy.rst", "generated/skbio.tree.TreeNode.has_caches.rst", "generated/skbio.tree.TreeNode.has_children.rst", "generated/skbio.tree.TreeNode.height.rst", "generated/skbio.tree.TreeNode.index_tree.rst", "generated/skbio.tree.TreeNode.insert.rst", "generated/skbio.tree.TreeNode.is_bifurcating.rst", "generated/skbio.tree.TreeNode.is_root.rst", "generated/skbio.tree.TreeNode.is_tip.rst", "generated/skbio.tree.TreeNode.lca.rst", "generated/skbio.tree.TreeNode.levelorder.rst", "generated/skbio.tree.TreeNode.maxdist.rst", "generated/skbio.tree.TreeNode.neighbors.rst", "generated/skbio.tree.TreeNode.non_tips.rst", "generated/skbio.tree.TreeNode.observed_node_counts.rst", "generated/skbio.tree.TreeNode.path.rst", "generated/skbio.tree.TreeNode.pop.rst", "generated/skbio.tree.TreeNode.postorder.rst", "generated/skbio.tree.TreeNode.pre_and_postorder.rst", "generated/skbio.tree.TreeNode.preorder.rst", "generated/skbio.tree.TreeNode.prune.rst", "generated/skbio.tree.TreeNode.read.rst", "generated/skbio.tree.TreeNode.remove.rst", "generated/skbio.tree.TreeNode.remove_by_func.rst", "generated/skbio.tree.TreeNode.remove_deleted.rst", "generated/skbio.tree.TreeNode.root.rst", "generated/skbio.tree.TreeNode.root_at.rst", "generated/skbio.tree.TreeNode.root_at_midpoint.rst", "generated/skbio.tree.TreeNode.root_by_outgroup.rst", "generated/skbio.tree.TreeNode.shear.rst", "generated/skbio.tree.TreeNode.shuffle.rst", "generated/skbio.tree.TreeNode.siblings.rst", "generated/skbio.tree.TreeNode.subset.rst", "generated/skbio.tree.TreeNode.subsets.rst", "generated/skbio.tree.TreeNode.subtree.rst", "generated/skbio.tree.TreeNode.tips.rst", "generated/skbio.tree.TreeNode.to_array.rst", "generated/skbio.tree.TreeNode.to_taxonomy.rst", "generated/skbio.tree.TreeNode.total_length.rst", "generated/skbio.tree.TreeNode.traverse.rst", "generated/skbio.tree.TreeNode.unpack.rst", "generated/skbio.tree.TreeNode.unpack_by_func.rst", "generated/skbio.tree.TreeNode.unroot.rst", "generated/skbio.tree.TreeNode.unrooted_copy.rst", "generated/skbio.tree.TreeNode.unrooted_deepcopy.rst", "generated/skbio.tree.TreeNode.unrooted_move.rst", "generated/skbio.tree.TreeNode.write.rst", "generated/skbio.tree.bme.rst", "generated/skbio.tree.gme.rst", "generated/skbio.tree.majority_rule.rst", "generated/skbio.tree.nj.rst", "generated/skbio.tree.nni.rst", "generated/skbio.tree.path_dists.rst", "generated/skbio.tree.rf_dists.rst", "generated/skbio.tree.upgma.rst", "generated/skbio.tree.wrf_dists.rst", "generated/skbio.util.PlottableMixin.rst", "generated/skbio.util.aliased.rst", "generated/skbio.util.assert_data_frame_almost_equal.rst", "generated/skbio.util.assert_ordination_results_equal.rst", "generated/skbio.util.cardinal_to_ordinal.rst", "generated/skbio.util.classonlymethod.rst", "generated/skbio.util.classproperty.rst", "generated/skbio.util.deprecated.rst", "generated/skbio.util.find_duplicates.rst", "generated/skbio.util.get_data_path.rst", "generated/skbio.util.get_rng.rst", "generated/skbio.util.overrides.rst", "generated/skbio.util.params_aliased.rst", "generated/skbio.util.register_aliases.rst", "generated/skbio.util.safe_md5.rst", "generated/skbio.workflow.Workflow.rst", "generated/skbio.workflow.Workflow.initialize_state.rst", "generated/skbio.workflow.method.rst", "generated/skbio.workflow.requires.rst", "index.rst", "io.rst", "metadata.rst", "sequence.rst", "stats.rst", "table.rst", "tree.rst", "util.rst", "workflow.rst"], "indexentries": {"__bool__() (skbio.alignment.tabularmsa method)": [[20, "skbio.alignment.TabularMSA.__bool__", false]], "__bool__() (skbio.sequence.sequence method)": [[228, "skbio.sequence.Sequence.__bool__", false]], "__call__() (skbio.alignment.stripedsmithwaterman method)": [[19, "skbio.alignment.StripedSmithWaterman.__call__", false]], "__call__() (skbio.workflow.method method)": [[503, "skbio.workflow.method.__call__", false]], "__call__() (skbio.workflow.requires method)": [[504, "skbio.workflow.requires.__call__", false]], "__call__() (skbio.workflow.workflow method)": [[501, "skbio.workflow.Workflow.__call__", false]], "__contains__() (skbio.alignment.tabularmsa method)": [[20, "skbio.alignment.TabularMSA.__contains__", false]], "__contains__() (skbio.sequence.sequence method)": [[228, "skbio.sequence.Sequence.__contains__", false]], "__contains__() (skbio.stats.distance.dissimilaritymatrix method)": [[277, "skbio.stats.distance.DissimilarityMatrix.__contains__", false]], "__copy__() (skbio.alignment.tabularmsa method)": [[20, "skbio.alignment.TabularMSA.__copy__", false]], "__copy__() (skbio.metadata.intervalmetadata method)": [[151, "skbio.metadata.IntervalMetadata.__copy__", false]], "__copy__() (skbio.metadata.intervalmetadatamixin method)": [[160, "skbio.metadata.IntervalMetadataMixin.__copy__", false]], "__copy__() (skbio.metadata.metadatamixin method)": [[171, "skbio.metadata.MetadataMixin.__copy__", false]], "__copy__() (skbio.metadata.positionalmetadatamixin method)": [[174, "skbio.metadata.PositionalMetadataMixin.__copy__", false]], "__copy__() (skbio.sequence.sequence method)": [[228, "skbio.sequence.Sequence.__copy__", false]], "__copy__() (skbio.tree.treenode method)": [[400, "skbio.tree.TreeNode.__copy__", false]], "__deepcopy__() (skbio.alignment.tabularmsa method)": [[20, "skbio.alignment.TabularMSA.__deepcopy__", false]], "__deepcopy__() (skbio.metadata.intervalmetadata method)": [[151, "skbio.metadata.IntervalMetadata.__deepcopy__", false]], "__deepcopy__() (skbio.metadata.intervalmetadatamixin method)": [[160, "skbio.metadata.IntervalMetadataMixin.__deepcopy__", false]], "__deepcopy__() (skbio.metadata.metadatamixin method)": [[171, "skbio.metadata.MetadataMixin.__deepcopy__", false]], "__deepcopy__() (skbio.metadata.positionalmetadatamixin method)": [[174, "skbio.metadata.PositionalMetadataMixin.__deepcopy__", false]], "__deepcopy__() (skbio.sequence.sequence method)": [[228, "skbio.sequence.Sequence.__deepcopy__", false]], "__deepcopy__() (skbio.tree.treenode method)": [[400, "skbio.tree.TreeNode.__deepcopy__", false]], "__eq__() (skbio.alignment.tabularmsa method)": [[20, "skbio.alignment.TabularMSA.__eq__", false]], "__eq__() (skbio.metadata.interval method)": [[149, "skbio.metadata.Interval.__eq__", false]], "__eq__() (skbio.metadata.intervalmetadata method)": [[151, "skbio.metadata.IntervalMetadata.__eq__", false]], "__eq__() (skbio.metadata.intervalmetadatamixin method)": [[160, "skbio.metadata.IntervalMetadataMixin.__eq__", false]], "__eq__() (skbio.metadata.metadatacolumn method)": [[162, "skbio.metadata.MetadataColumn.__eq__", false]], "__eq__() (skbio.metadata.metadatamixin method)": [[171, "skbio.metadata.MetadataMixin.__eq__", false]], "__eq__() (skbio.metadata.positionalmetadatamixin method)": [[174, "skbio.metadata.PositionalMetadataMixin.__eq__", false]], "__eq__() (skbio.metadata.samplemetadata method)": [[176, "skbio.metadata.SampleMetadata.__eq__", false]], "__eq__() (skbio.sequence.geneticcode method)": [[191, "skbio.sequence.GeneticCode.__eq__", false]], "__eq__() (skbio.sequence.sequence method)": [[228, "skbio.sequence.Sequence.__eq__", false]], "__eq__() (skbio.stats.distance.dissimilaritymatrix method)": [[277, "skbio.stats.distance.DissimilarityMatrix.__eq__", false]], "__eq__() (skbio.table.table method)": [[342, "skbio.table.Table.__eq__", false]], "__get__() (skbio.util.classonlymethod method)": [[491, "skbio.util.classonlymethod.__get__", false]], "__get__() (skbio.util.classproperty method)": [[492, "skbio.util.classproperty.__get__", false]], "__getitem__() (skbio.alignment.alignmentstructure method)": [[11, "skbio.alignment.AlignmentStructure.__getitem__", false]], "__getitem__() (skbio.alignment.tabularmsa method)": [[20, "skbio.alignment.TabularMSA.__getitem__", false]], "__getitem__() (skbio.sequence.sequence method)": [[228, "skbio.sequence.Sequence.__getitem__", false]], "__getitem__() (skbio.stats.distance.dissimilaritymatrix method)": [[277, "skbio.stats.distance.DissimilarityMatrix.__getitem__", false]], "__getitem__() (skbio.table.table method)": [[342, "skbio.table.Table.__getitem__", false]], "__getitem__() (skbio.tree.treenode method)": [[400, "skbio.tree.TreeNode.__getitem__", false]], "__iter__() (skbio.alignment.tabularmsa method)": [[20, "skbio.alignment.TabularMSA.__iter__", false]], "__iter__() (skbio.sequence.sequence method)": [[228, "skbio.sequence.Sequence.__iter__", false]], "__iter__() (skbio.table.table method)": [[342, "skbio.table.Table.__iter__", false]], "__iter__() (skbio.tree.treenode method)": [[400, "skbio.tree.TreeNode.__iter__", false]], "__len__() (skbio.alignment.tabularmsa method)": [[20, "skbio.alignment.TabularMSA.__len__", false]], "__len__() (skbio.sequence.sequence method)": [[228, "skbio.sequence.Sequence.__len__", false]], "__len__() (skbio.tree.treenode method)": [[400, "skbio.tree.TreeNode.__len__", false]], "__ne__() (skbio.alignment.tabularmsa method)": [[20, "skbio.alignment.TabularMSA.__ne__", false]], "__ne__() (skbio.metadata.interval method)": [[149, "skbio.metadata.Interval.__ne__", false]], "__ne__() (skbio.metadata.intervalmetadata method)": [[151, "skbio.metadata.IntervalMetadata.__ne__", false]], "__ne__() (skbio.metadata.intervalmetadatamixin method)": [[160, "skbio.metadata.IntervalMetadataMixin.__ne__", false]], "__ne__() (skbio.metadata.metadatacolumn method)": [[162, "skbio.metadata.MetadataColumn.__ne__", false]], "__ne__() (skbio.metadata.metadatamixin method)": [[171, "skbio.metadata.MetadataMixin.__ne__", false]], "__ne__() (skbio.metadata.positionalmetadatamixin method)": [[174, "skbio.metadata.PositionalMetadataMixin.__ne__", false]], "__ne__() (skbio.metadata.samplemetadata method)": [[176, "skbio.metadata.SampleMetadata.__ne__", false]], "__ne__() (skbio.sequence.geneticcode method)": [[191, "skbio.sequence.GeneticCode.__ne__", false]], "__ne__() (skbio.sequence.sequence method)": [[228, "skbio.sequence.Sequence.__ne__", false]], "__ne__() (skbio.stats.distance.dissimilaritymatrix method)": [[277, "skbio.stats.distance.DissimilarityMatrix.__ne__", false]], "__ne__() (skbio.table.table method)": [[342, "skbio.table.Table.__ne__", false]], "__reversed__() (skbio.alignment.tabularmsa method)": [[20, "skbio.alignment.TabularMSA.__reversed__", false]], "__reversed__() (skbio.sequence.sequence method)": [[228, "skbio.sequence.Sequence.__reversed__", false]], "__set__() (skbio.util.classproperty method)": [[492, "skbio.util.classproperty.__set__", false]], "__setstate__() (skbio.alignment.alignmentstructure method)": [[11, "skbio.alignment.AlignmentStructure.__setstate__", false]], "__setstate__() (skbio.alignment.stripedsmithwaterman method)": [[19, "skbio.alignment.StripedSmithWaterman.__setstate__", false]], "__str__() (skbio.alignment.alignmentstructure method)": [[11, "skbio.alignment.AlignmentStructure.__str__", false]], "__str__() (skbio.alignment.alignpath method)": [[3, "skbio.alignment.AlignPath.__str__", false]], "__str__() (skbio.alignment.pairalignpath method)": [[14, "skbio.alignment.PairAlignPath.__str__", false]], "__str__() (skbio.alignment.tabularmsa method)": [[20, "skbio.alignment.TabularMSA.__str__", false]], "__str__() (skbio.embedding.embedding method)": [[91, "skbio.embedding.Embedding.__str__", false]], "__str__() (skbio.embedding.embeddingvector method)": [[95, "skbio.embedding.EmbeddingVector.__str__", false]], "__str__() (skbio.embedding.sequenceembedding method)": [[98, "skbio.embedding.SequenceEmbedding.__str__", false]], "__str__() (skbio.sequence.geneticcode method)": [[191, "skbio.sequence.GeneticCode.__str__", false]], "__str__() (skbio.sequence.sequence method)": [[228, "skbio.sequence.Sequence.__str__", false]], "__str__() (skbio.stats.distance.dissimilaritymatrix method)": [[277, "skbio.stats.distance.DissimilarityMatrix.__str__", false]], "__str__() (skbio.stats.ordination.ordinationresults method)": [[320, "skbio.stats.ordination.OrdinationResults.__str__", false]], "__str__() (skbio.table.table method)": [[342, "skbio.table.Table.__str__", false]], "__str__() (skbio.tree.treenode method)": [[400, "skbio.tree.TreeNode.__str__", false]], "ace() (in module skbio.diversity.alpha)": [[44, "skbio.diversity.alpha.ace", false]], "add() (skbio.metadata.intervalmetadata method)": [[152, "skbio.metadata.IntervalMetadata.add", false]], "add_format() (skbio.io.registry.ioregistry method)": [[129, "skbio.io.registry.IORegistry.add_format", false]], "add_group_metadata() (skbio.table.table method)": [[343, "skbio.table.Table.add_group_metadata", false]], "add_metadata() (skbio.table.table method)": [[344, "skbio.table.Table.add_metadata", false]], "aliased() (in module skbio.util)": [[487, "skbio.util.aliased", false]], "align_to() (skbio.table.table method)": [[345, "skbio.table.Table.align_to", false]], "align_to_dataframe() (skbio.table.table method)": [[346, "skbio.table.Table.align_to_dataframe", false]], "align_tree() (skbio.table.table method)": [[347, "skbio.table.Table.align_tree", false]], "aligned_query_sequence (skbio.alignment.alignmentstructure attribute)": [[11, "skbio.alignment.AlignmentStructure.aligned_query_sequence", false]], "aligned_target_sequence (skbio.alignment.alignmentstructure attribute)": [[11, "skbio.alignment.AlignmentStructure.aligned_target_sequence", false]], "alignmentstructure (class in skbio.alignment)": [[11, "skbio.alignment.AlignmentStructure", false]], "alignpath (class in skbio.alignment)": [[3, "skbio.alignment.AlignPath", false]], "alpha_diversity() (in module skbio.diversity)": [[82, "skbio.diversity.alpha_diversity", false]], "alphabet (skbio.sequence.grammaredsequence attribute)": [[195, "skbio.sequence.GrammaredSequence.alphabet", false]], "alphabet (skbio.sequence.protein attribute)": [[215, "skbio.sequence.Protein.alphabet", false]], "alphabet (skbio.sequence.substitutionmatrix attribute)": [[247, "skbio.sequence.SubstitutionMatrix.alphabet", false]], "alr() (in module skbio.stats.composition)": [[257, "skbio.stats.composition.alr", false]], "alr_inv() (in module skbio.stats.composition)": [[258, "skbio.stats.composition.alr_inv", false]], "ancestors() (skbio.tree.treenode method)": [[401, "skbio.tree.TreeNode.ancestors", false]], "ancom() (in module skbio.stats.composition)": [[259, "skbio.stats.composition.ancom", false]], "anosim() (in module skbio.stats.distance)": [[296, "skbio.stats.distance.anosim", false]], "append() (skbio.alignment.tabularmsa method)": [[21, "skbio.alignment.TabularMSA.append", false]], "append() (skbio.tree.treenode method)": [[402, "skbio.tree.TreeNode.append", false]], "ascii_art() (skbio.tree.treenode method)": [[403, "skbio.tree.TreeNode.ascii_art", false]], "assert_data_frame_almost_equal() (in module skbio.util)": [[488, "skbio.util.assert_data_frame_almost_equal", false]], "assert_ordination_results_equal() (in module skbio.util)": [[489, "skbio.util.assert_ordination_results_equal", false]], "assign_ids() (skbio.tree.treenode method)": [[404, "skbio.tree.TreeNode.assign_ids", false]], "assign_supports() (skbio.tree.treenode method)": [[405, "skbio.tree.TreeNode.assign_supports", false]], "averagegradientanova (class in skbio.stats.gradient)": [[306, "skbio.stats.gradient.AverageGradientANOVA", false]], "berger_parker_d() (in module skbio.diversity.alpha)": [[45, "skbio.diversity.alpha.berger_parker_d", false]], "beta_diversity() (in module skbio.diversity)": [[86, "skbio.diversity.beta_diversity", false]], "between() (skbio.stats.distance.dissimilaritymatrix method)": [[278, "skbio.stats.distance.DissimilarityMatrix.between", false]], "bifurcate() (skbio.tree.treenode method)": [[406, "skbio.tree.TreeNode.bifurcate", false]], "bioenv() (in module skbio.stats.distance)": [[297, "skbio.stats.distance.bioenv", false]], "bipart() (skbio.tree.treenode method)": [[407, "skbio.tree.TreeNode.bipart", false]], "biparts() (skbio.tree.treenode method)": [[408, "skbio.tree.TreeNode.biparts", false]], "block_beta_diversity() (in module skbio.diversity)": [[87, "skbio.diversity.block_beta_diversity", false]], "bme() (in module skbio.tree)": [[477, "skbio.tree.bme", false]], "bounds (skbio.metadata.interval attribute)": [[149, "skbio.metadata.Interval.bounds", false]], "brillouin_d() (in module skbio.diversity.alpha)": [[46, "skbio.diversity.alpha.brillouin_d", false]], "by_name() (skbio.sequence.substitutionmatrix class method)": [[248, "skbio.sequence.SubstitutionMatrix.by_name", false]], "bytes() (skbio.embedding.embedding method)": [[92, "skbio.embedding.Embedding.bytes", false]], "ca() (in module skbio.stats.ordination)": [[325, "skbio.stats.ordination.ca", false]], "cache_attr() (skbio.tree.treenode method)": [[409, "skbio.tree.TreeNode.cache_attr", false]], "cardinal_to_ordinal() (in module skbio.util)": [[490, "skbio.util.cardinal_to_ordinal", false]], "categoricalmetadatacolumn (class in skbio.metadata)": [[148, "skbio.metadata.CategoricalMetadataColumn", false]], "categoryresults (class in skbio.stats.gradient)": [[307, "skbio.stats.gradient.CategoryResults", false]], "cca() (in module skbio.stats.ordination)": [[326, "skbio.stats.ordination.cca", false]], "centralize() (in module skbio.stats.composition)": [[260, "skbio.stats.composition.centralize", false]], "chao1() (in module skbio.diversity.alpha)": [[47, "skbio.diversity.alpha.chao1", false]], "chao1_ci() (in module skbio.diversity.alpha)": [[48, "skbio.diversity.alpha.chao1_ci", false]], "cigar (skbio.alignment.alignmentstructure attribute)": [[11, "skbio.alignment.AlignmentStructure.cigar", false]], "classonlymethod (class in skbio.util)": [[491, "skbio.util.classonlymethod", false]], "classproperty (class in skbio.util)": [[492, "skbio.util.classproperty", false]], "clear_caches() (skbio.tree.treenode method)": [[410, "skbio.tree.TreeNode.clear_caches", false]], "closure() (in module skbio.stats.composition)": [[261, "skbio.stats.composition.closure", false]], "clr() (in module skbio.stats.composition)": [[262, "skbio.stats.composition.clr", false]], "clr_inv() (in module skbio.stats.composition)": [[263, "skbio.stats.composition.clr_inv", false]], "collapse() (skbio.table.table method)": [[348, "skbio.table.Table.collapse", false]], "column_count (skbio.metadata.samplemetadata attribute)": [[176, "skbio.metadata.SampleMetadata.column_count", false]], "columns (skbio.metadata.samplemetadata attribute)": [[176, "skbio.metadata.SampleMetadata.columns", false]], "compare_biparts() (skbio.tree.treenode method)": [[411, "skbio.tree.TreeNode.compare_biparts", false]], "compare_cophenet() (skbio.tree.treenode method)": [[412, "skbio.tree.TreeNode.compare_cophenet", false]], "compare_rfd() (skbio.tree.treenode method)": [[413, "skbio.tree.TreeNode.compare_rfd", false]], "compare_subsets() (skbio.tree.treenode method)": [[414, "skbio.tree.TreeNode.compare_subsets", false]], "compare_wrfd() (skbio.tree.treenode method)": [[415, "skbio.tree.TreeNode.compare_wrfd", false]], "complement() (skbio.sequence.nucleotidemixin method)": [[210, "skbio.sequence.NucleotideMixin.complement", false]], "complement_map (skbio.sequence.dna attribute)": [[184, "skbio.sequence.DNA.complement_map", false]], "complement_map (skbio.sequence.nucleotidemixin attribute)": [[209, "skbio.sequence.NucleotideMixin.complement_map", false]], "complement_map (skbio.sequence.rna attribute)": [[221, "skbio.sequence.RNA.complement_map", false]], "concat() (skbio.metadata.intervalmetadata class method)": [[153, "skbio.metadata.IntervalMetadata.concat", false]], "concat() (skbio.sequence.sequence class method)": [[229, "skbio.sequence.Sequence.concat", false]], "concat() (skbio.table.table method)": [[349, "skbio.table.Table.concat", false]], "condensed_form() (skbio.stats.distance.distancematrix method)": [[292, "skbio.stats.distance.DistanceMatrix.condensed_form", false]], "confidence_bound() (in module skbio.stats.power)": [[337, "skbio.stats.power.confidence_bound", false]], "consensus() (skbio.alignment.tabularmsa method)": [[22, "skbio.alignment.TabularMSA.consensus", false]], "conservation() (skbio.alignment.tabularmsa method)": [[23, "skbio.alignment.TabularMSA.conservation", false]], "cophenet() (skbio.tree.treenode method)": [[416, "skbio.tree.TreeNode.cophenet", false]], "copy() (skbio.stats.distance.dissimilaritymatrix method)": [[279, "skbio.stats.distance.DissimilarityMatrix.copy", false]], "copy() (skbio.table.table method)": [[350, "skbio.table.Table.copy", false]], "copy() (skbio.tree.treenode method)": [[417, "skbio.tree.TreeNode.copy", false]], "corr() (in module skbio.stats.ordination)": [[327, "skbio.stats.ordination.corr", false]], "count() (skbio.sequence.sequence method)": [[230, "skbio.sequence.Sequence.count", false]], "count() (skbio.tree.treenode method)": [[418, "skbio.tree.TreeNode.count", false]], "create_caches() (skbio.tree.treenode method)": [[419, "skbio.tree.TreeNode.create_caches", false]], "create_format() (in module skbio.io.registry)": [[140, "skbio.io.registry.create_format", false]], "create_format() (skbio.io.registry.ioregistry method)": [[130, "skbio.io.registry.IORegistry.create_format", false]], "data (skbio.stats.distance.dissimilaritymatrix attribute)": [[277, "skbio.stats.distance.DissimilarityMatrix.data", false]], "data() (skbio.table.table method)": [[351, "skbio.table.Table.data", false]], "deepcopy() (skbio.tree.treenode method)": [[420, "skbio.tree.TreeNode.deepcopy", false]], "default_gap_char (skbio.sequence.dna attribute)": [[184, "skbio.sequence.DNA.default_gap_char", false]], "default_gap_char (skbio.sequence.grammaredsequence attribute)": [[195, "skbio.sequence.GrammaredSequence.default_gap_char", false]], "default_gap_char (skbio.sequence.protein attribute)": [[215, "skbio.sequence.Protein.default_gap_char", false]], "default_gap_char (skbio.sequence.rna attribute)": [[221, "skbio.sequence.RNA.default_gap_char", false]], "default_write_format (skbio.alignment.tabularmsa attribute)": [[20, "skbio.alignment.TabularMSA.default_write_format", false]], "default_write_format (skbio.embedding.proteinembedding attribute)": [[96, "skbio.embedding.ProteinEmbedding.default_write_format", false]], "default_write_format (skbio.embedding.proteinvector attribute)": [[97, "skbio.embedding.ProteinVector.default_write_format", false]], "default_write_format (skbio.metadata.intervalmetadata attribute)": [[151, "skbio.metadata.IntervalMetadata.default_write_format", false]], "default_write_format (skbio.metadata.samplemetadata attribute)": [[176, "skbio.metadata.SampleMetadata.default_write_format", false]], "default_write_format (skbio.sequence.sequence attribute)": [[228, "skbio.sequence.Sequence.default_write_format", false]], "default_write_format (skbio.stats.distance.dissimilaritymatrix attribute)": [[277, "skbio.stats.distance.DissimilarityMatrix.default_write_format", false]], "default_write_format (skbio.stats.ordination.ordinationresults attribute)": [[320, "skbio.stats.ordination.OrdinationResults.default_write_format", false]], "default_write_format (skbio.table.table attribute)": [[342, "skbio.table.Table.default_write_format", false]], "default_write_format (skbio.tree.treenode attribute)": [[400, "skbio.tree.TreeNode.default_write_format", false]], "definite_chars (skbio.sequence.dna attribute)": [[184, "skbio.sequence.DNA.definite_chars", false]], "definite_chars (skbio.sequence.grammaredsequence attribute)": [[195, "skbio.sequence.GrammaredSequence.definite_chars", false]], "definite_chars (skbio.sequence.protein attribute)": [[215, "skbio.sequence.Protein.definite_chars", false]], "definite_chars (skbio.sequence.rna attribute)": [[221, "skbio.sequence.RNA.definite_chars", false]], "definites() (skbio.sequence.grammaredsequence method)": [[196, "skbio.sequence.GrammaredSequence.definites", false]], "degap() (skbio.sequence.grammaredsequence method)": [[197, "skbio.sequence.GrammaredSequence.degap", false]], "degenerate_chars (skbio.sequence.grammaredsequence attribute)": [[195, "skbio.sequence.GrammaredSequence.degenerate_chars", false]], "degenerate_map (skbio.sequence.dna attribute)": [[184, "skbio.sequence.DNA.degenerate_map", false]], "degenerate_map (skbio.sequence.grammaredsequence attribute)": [[195, "skbio.sequence.GrammaredSequence.degenerate_map", false]], "degenerate_map (skbio.sequence.protein attribute)": [[215, "skbio.sequence.Protein.degenerate_map", false]], "degenerate_map (skbio.sequence.rna attribute)": [[221, "skbio.sequence.RNA.degenerate_map", false]], "degenerates() (skbio.sequence.grammaredsequence method)": [[198, "skbio.sequence.GrammaredSequence.degenerates", false]], "del_metadata() (skbio.table.table method)": [[352, "skbio.table.Table.del_metadata", false]], "delimited_self() (skbio.table.table method)": [[353, "skbio.table.Table.delimited_self", false]], "deprecated() (in module skbio.util)": [[493, "skbio.util.deprecated", false]], "depth() (skbio.tree.treenode method)": [[421, "skbio.tree.TreeNode.depth", false]], "descriptive_equality() (skbio.table.table method)": [[354, "skbio.table.Table.descriptive_equality", false]], "dirmult_ttest() (in module skbio.stats.composition)": [[264, "skbio.stats.composition.dirmult_ttest", false]], "dissimilaritymatrix (class in skbio.stats.distance)": [[277, "skbio.stats.distance.DissimilarityMatrix", false]], "distance() (skbio.sequence.sequence method)": [[231, "skbio.sequence.Sequence.distance", false]], "distance() (skbio.tree.treenode method)": [[422, "skbio.tree.TreeNode.distance", false]], "distancematrix (class in skbio.stats.distance)": [[291, "skbio.stats.distance.DistanceMatrix", false]], "dna (class in skbio.sequence)": [[184, "skbio.sequence.DNA", false]], "dominance() (in module skbio.diversity.alpha)": [[49, "skbio.diversity.alpha.dominance", false]], "doubles() (in module skbio.diversity.alpha)": [[50, "skbio.diversity.alpha.doubles", false]], "drop() (skbio.metadata.interval method)": [[150, "skbio.metadata.Interval.drop", false]], "drop() (skbio.metadata.intervalmetadata method)": [[154, "skbio.metadata.IntervalMetadata.drop", false]], "drop_missing_values() (skbio.metadata.metadatacolumn method)": [[163, "skbio.metadata.MetadataColumn.drop_missing_values", false]], "dropped (skbio.metadata.interval attribute)": [[149, "skbio.metadata.Interval.dropped", false]], "dtype (skbio.alignment.tabularmsa attribute)": [[20, "skbio.alignment.TabularMSA.dtype", false]], "dtype (skbio.stats.distance.dissimilaritymatrix attribute)": [[277, "skbio.stats.distance.DissimilarityMatrix.dtype", false]], "dtype (skbio.table.table attribute)": [[342, "skbio.table.Table.dtype", false]], "e_matrix() (in module skbio.stats.ordination)": [[328, "skbio.stats.ordination.e_matrix", false]], "embed_vec_to_dataframe() (in module skbio.embedding)": [[100, "skbio.embedding.embed_vec_to_dataframe", false]], "embed_vec_to_distances() (in module skbio.embedding)": [[101, "skbio.embedding.embed_vec_to_distances", false]], "embed_vec_to_numpy() (in module skbio.embedding)": [[102, "skbio.embedding.embed_vec_to_numpy", false]], "embed_vec_to_ordination() (in module skbio.embedding)": [[103, "skbio.embedding.embed_vec_to_ordination", false]], "embedding (class in skbio.embedding)": [[91, "skbio.embedding.Embedding", false]], "embedding (skbio.embedding.embedding attribute)": [[91, "skbio.embedding.Embedding.embedding", false]], "embedding (skbio.embedding.embeddingvector attribute)": [[95, "skbio.embedding.EmbeddingVector.embedding", false]], "embeddingvector (class in skbio.embedding)": [[95, "skbio.embedding.EmbeddingVector", false]], "enspie() (in module skbio.diversity.alpha)": [[51, "skbio.diversity.alpha.enspie", false]], "esty_ci() (in module skbio.diversity.alpha)": [[52, "skbio.diversity.alpha.esty_ci", false]], "example_table (in module skbio.table)": [[399, "skbio.table.example_table", false]], "exists() (skbio.table.table method)": [[355, "skbio.table.Table.exists", false]], "expand_degenerates() (skbio.sequence.grammaredsequence method)": [[199, "skbio.sequence.GrammaredSequence.expand_degenerates", false]], "extend() (skbio.alignment.tabularmsa method)": [[24, "skbio.alignment.TabularMSA.extend", false]], "extend() (skbio.tree.treenode method)": [[423, "skbio.tree.TreeNode.extend", false]], "f_matrix() (in module skbio.stats.ordination)": [[329, "skbio.stats.ordination.f_matrix", false]], "faith_pd() (in module skbio.diversity.alpha)": [[53, "skbio.diversity.alpha.faith_pd", false]], "filter() (skbio.stats.distance.dissimilaritymatrix method)": [[280, "skbio.stats.distance.DissimilarityMatrix.filter", false]], "filter() (skbio.table.table method)": [[356, "skbio.table.Table.filter", false]], "filter_columns() (skbio.metadata.samplemetadata method)": [[177, "skbio.metadata.SampleMetadata.filter_columns", false]], "filter_ids() (skbio.metadata.metadatacolumn method)": [[164, "skbio.metadata.MetadataColumn.filter_ids", false]], "filter_ids() (skbio.metadata.samplemetadata method)": [[178, "skbio.metadata.SampleMetadata.filter_ids", false]], "find() (skbio.tree.treenode method)": [[424, "skbio.tree.TreeNode.find", false]], "find_all() (skbio.tree.treenode method)": [[425, "skbio.tree.TreeNode.find_all", false]], "find_by_func() (skbio.tree.treenode method)": [[426, "skbio.tree.TreeNode.find_by_func", false]], "find_by_id() (skbio.tree.treenode method)": [[427, "skbio.tree.TreeNode.find_by_id", false]], "find_duplicates() (in module skbio.util)": [[494, "skbio.util.find_duplicates", false]], "find_motifs() (skbio.sequence.dna method)": [[185, "skbio.sequence.DNA.find_motifs", false]], "find_motifs() (skbio.sequence.grammaredsequence method)": [[200, "skbio.sequence.GrammaredSequence.find_motifs", false]], "find_motifs() (skbio.sequence.protein method)": [[216, "skbio.sequence.Protein.find_motifs", false]], "find_motifs() (skbio.sequence.rna method)": [[222, "skbio.sequence.RNA.find_motifs", false]], "find_with_regex() (skbio.sequence.sequence method)": [[232, "skbio.sequence.Sequence.find_with_regex", false]], "firstdifferencegradientanova (class in skbio.stats.gradient)": [[309, "skbio.stats.gradient.FirstDifferenceGradientANOVA", false]], "fisher_alpha() (in module skbio.diversity.alpha)": [[54, "skbio.diversity.alpha.fisher_alpha", false]], "format (class in skbio.io.registry)": [[124, "skbio.io.registry.Format", false]], "frequencies() (skbio.sequence.sequence method)": [[233, "skbio.sequence.Sequence.frequencies", false]], "from_adjacency() (skbio.table.table static method)": [[357, "skbio.table.Table.from_adjacency", false]], "from_bits() (skbio.alignment.alignpath class method)": [[4, "skbio.alignment.AlignPath.from_bits", false]], "from_bits() (skbio.alignment.pairalignpath class method)": [[15, "skbio.alignment.PairAlignPath.from_bits", false]], "from_cigar() (skbio.alignment.pairalignpath class method)": [[16, "skbio.alignment.PairAlignPath.from_cigar", false]], "from_coordinates() (skbio.alignment.alignpath class method)": [[5, "skbio.alignment.AlignPath.from_coordinates", false]], "from_dict() (skbio.alignment.tabularmsa class method)": [[25, "skbio.alignment.TabularMSA.from_dict", false]], "from_dict() (skbio.sequence.substitutionmatrix class method)": [[249, "skbio.sequence.SubstitutionMatrix.from_dict", false]], "from_hdf5() (skbio.table.table class method)": [[358, "skbio.table.Table.from_hdf5", false]], "from_indices() (skbio.alignment.alignpath class method)": [[6, "skbio.alignment.AlignPath.from_indices", false]], "from_iterable() (skbio.stats.distance.dissimilaritymatrix class method)": [[281, "skbio.stats.distance.DissimilarityMatrix.from_iterable", false]], "from_iterable() (skbio.stats.distance.distancematrix class method)": [[293, "skbio.stats.distance.DistanceMatrix.from_iterable", false]], "from_json() (skbio.table.table class method)": [[359, "skbio.table.Table.from_json", false]], "from_linkage_matrix() (skbio.tree.treenode class method)": [[428, "skbio.tree.TreeNode.from_linkage_matrix", false]], "from_ncbi() (skbio.sequence.geneticcode class method)": [[192, "skbio.sequence.GeneticCode.from_ncbi", false]], "from_path_seqs() (skbio.alignment.tabularmsa class method)": [[26, "skbio.alignment.TabularMSA.from_path_seqs", false]], "from_tabular() (skbio.alignment.alignpath class method)": [[7, "skbio.alignment.AlignPath.from_tabular", false]], "from_taxdump() (skbio.tree.treenode class method)": [[429, "skbio.tree.TreeNode.from_taxdump", false]], "from_taxonomy() (skbio.tree.treenode class method)": [[430, "skbio.tree.TreeNode.from_taxonomy", false]], "from_tsv() (skbio.table.table static method)": [[360, "skbio.table.Table.from_tsv", false]], "fuzzy (skbio.metadata.interval attribute)": [[149, "skbio.metadata.Interval.fuzzy", false]], "gap_chars (skbio.sequence.dna attribute)": [[184, "skbio.sequence.DNA.gap_chars", false]], "gap_chars (skbio.sequence.grammaredsequence attribute)": [[195, "skbio.sequence.GrammaredSequence.gap_chars", false]], "gap_chars (skbio.sequence.protein attribute)": [[215, "skbio.sequence.Protein.gap_chars", false]], "gap_chars (skbio.sequence.rna attribute)": [[221, "skbio.sequence.RNA.gap_chars", false]], "gap_frequencies() (skbio.alignment.tabularmsa method)": [[27, "skbio.alignment.TabularMSA.gap_frequencies", false]], "gaps() (skbio.sequence.grammaredsequence method)": [[201, "skbio.sequence.GrammaredSequence.gaps", false]], "gc_content() (skbio.sequence.nucleotidemixin method)": [[211, "skbio.sequence.NucleotideMixin.gc_content", false]], "gc_frequency() (skbio.sequence.nucleotidemixin method)": [[212, "skbio.sequence.NucleotideMixin.gc_frequency", false]], "geneticcode (class in skbio.sequence)": [[191, "skbio.sequence.GeneticCode", false]], "get_alpha_diversity_metrics() (in module skbio.diversity)": [[88, "skbio.diversity.get_alpha_diversity_metrics", false]], "get_beta_diversity_metrics() (in module skbio.diversity)": [[89, "skbio.diversity.get_beta_diversity_metrics", false]], "get_column() (skbio.metadata.samplemetadata method)": [[179, "skbio.metadata.SampleMetadata.get_column", false]], "get_data_path() (in module skbio.util)": [[495, "skbio.util.get_data_path", false]], "get_ids() (skbio.metadata.metadatacolumn method)": [[165, "skbio.metadata.MetadataColumn.get_ids", false]], "get_ids() (skbio.metadata.samplemetadata method)": [[180, "skbio.metadata.SampleMetadata.get_ids", false]], "get_missing() (skbio.metadata.metadatacolumn method)": [[166, "skbio.metadata.MetadataColumn.get_missing", false]], "get_names() (skbio.sequence.substitutionmatrix class method)": [[250, "skbio.sequence.SubstitutionMatrix.get_names", false]], "get_reader() (skbio.io.registry.ioregistry method)": [[131, "skbio.io.registry.IORegistry.get_reader", false]], "get_rng() (in module skbio.util)": [[496, "skbio.util.get_rng", false]], "get_sniffer() (skbio.io.registry.ioregistry method)": [[132, "skbio.io.registry.IORegistry.get_sniffer", false]], "get_table_density() (skbio.table.table method)": [[361, "skbio.table.Table.get_table_density", false]], "get_trajectories() (skbio.stats.gradient.gradientanova method)": [[311, "skbio.stats.gradient.GradientANOVA.get_trajectories", false]], "get_value() (skbio.metadata.metadatacolumn method)": [[167, "skbio.metadata.MetadataColumn.get_value", false]], "get_value_by_ids() (skbio.table.table method)": [[362, "skbio.table.Table.get_value_by_ids", false]], "get_writer() (skbio.io.registry.ioregistry method)": [[133, "skbio.io.registry.IORegistry.get_writer", false]], "gini_index() (in module skbio.diversity.alpha)": [[55, "skbio.diversity.alpha.gini_index", false]], "global_pairwise_align() (in module skbio.alignment)": [[35, "skbio.alignment.global_pairwise_align", false]], "global_pairwise_align_nucleotide() (in module skbio.alignment)": [[36, "skbio.alignment.global_pairwise_align_nucleotide", false]], "global_pairwise_align_protein() (in module skbio.alignment)": [[37, "skbio.alignment.global_pairwise_align_protein", false]], "gme() (in module skbio.tree)": [[478, "skbio.tree.gme", false]], "goods_coverage() (in module skbio.diversity.alpha)": [[56, "skbio.diversity.alpha.goods_coverage", false]], "gradientanova (class in skbio.stats.gradient)": [[310, "skbio.stats.gradient.GradientANOVA", false]], "gradientanovaresults (class in skbio.stats.gradient)": [[312, "skbio.stats.gradient.GradientANOVAResults", false]], "grammaredsequence (class in skbio.sequence)": [[195, "skbio.sequence.GrammaredSequence", false]], "group_metadata() (skbio.table.table method)": [[363, "skbio.table.Table.group_metadata", false]], "groupresults (class in skbio.stats.gradient)": [[314, "skbio.stats.gradient.GroupResults", false]], "hamming() (in module skbio.sequence.distance)": [[254, "skbio.sequence.distance.hamming", false]], "has_caches() (skbio.tree.treenode method)": [[431, "skbio.tree.TreeNode.has_caches", false]], "has_children() (skbio.tree.treenode method)": [[432, "skbio.tree.TreeNode.has_children", false]], "has_definites() (skbio.sequence.grammaredsequence method)": [[202, "skbio.sequence.GrammaredSequence.has_definites", false]], "has_degenerates() (skbio.sequence.grammaredsequence method)": [[203, "skbio.sequence.GrammaredSequence.has_degenerates", false]], "has_gaps() (skbio.sequence.grammaredsequence method)": [[204, "skbio.sequence.GrammaredSequence.has_gaps", false]], "has_interval_metadata() (skbio.metadata.intervalmetadatamixin method)": [[161, "skbio.metadata.IntervalMetadataMixin.has_interval_metadata", false]], "has_metadata() (skbio.metadata.metadatamixin method)": [[172, "skbio.metadata.MetadataMixin.has_metadata", false]], "has_missing_values() (skbio.metadata.metadatacolumn method)": [[168, "skbio.metadata.MetadataColumn.has_missing_values", false]], "has_nondegenerates() (skbio.sequence.grammaredsequence method)": [[205, "skbio.sequence.GrammaredSequence.has_nondegenerates", false]], "has_positional_metadata() (skbio.metadata.positionalmetadatamixin method)": [[175, "skbio.metadata.PositionalMetadataMixin.has_positional_metadata", false]], "has_stops() (skbio.sequence.protein method)": [[217, "skbio.sequence.Protein.has_stops", false]], "head() (skbio.table.table method)": [[364, "skbio.table.Table.head", false]], "height() (skbio.tree.treenode method)": [[433, "skbio.tree.TreeNode.height", false]], "heip_e() (in module skbio.diversity.alpha)": [[57, "skbio.diversity.alpha.heip_e", false]], "highest_priority (skbio.workflow.method attribute)": [[503, "skbio.workflow.method.highest_priority", false]], "hill() (in module skbio.diversity.alpha)": [[58, "skbio.diversity.alpha.hill", false]], "hommola_cospeciation() (in module skbio.stats.evolve)": [[304, "skbio.stats.evolve.hommola_cospeciation", false]], "identity() (skbio.sequence.substitutionmatrix class method)": [[251, "skbio.sequence.SubstitutionMatrix.identity", false]], "ids (skbio.embedding.embedding attribute)": [[91, "skbio.embedding.Embedding.ids", false]], "ids (skbio.stats.distance.dissimilaritymatrix attribute)": [[277, "skbio.stats.distance.DissimilarityMatrix.ids", false]], "ids() (skbio.table.table method)": [[365, "skbio.table.Table.ids", false]], "iloc (skbio.alignment.tabularmsa attribute)": [[20, "skbio.alignment.TabularMSA.iloc", false]], "ilr() (in module skbio.stats.composition)": [[265, "skbio.stats.composition.ilr", false]], "ilr_inv() (in module skbio.stats.composition)": [[266, "skbio.stats.composition.ilr_inv", false]], "index (skbio.alignment.tabularmsa attribute)": [[20, "skbio.alignment.TabularMSA.index", false]], "index() (skbio.sequence.sequence method)": [[234, "skbio.sequence.Sequence.index", false]], "index() (skbio.stats.distance.dissimilaritymatrix method)": [[282, "skbio.stats.distance.DissimilarityMatrix.index", false]], "index() (skbio.table.table method)": [[366, "skbio.table.Table.index", false]], "index_tree() (skbio.tree.treenode method)": [[434, "skbio.tree.TreeNode.index_tree", false]], "initialize_state() (skbio.workflow.workflow method)": [[502, "skbio.workflow.Workflow.initialize_state", false]], "inner() (in module skbio.stats.composition)": [[267, "skbio.stats.composition.inner", false]], "insert() (skbio.tree.treenode method)": [[435, "skbio.tree.TreeNode.insert", false]], "interval (class in skbio.metadata)": [[149, "skbio.metadata.Interval", false]], "interval_metadata (skbio.metadata.intervalmetadatamixin attribute)": [[160, "skbio.metadata.IntervalMetadataMixin.interval_metadata", false]], "intervalmetadata (class in skbio.metadata)": [[151, "skbio.metadata.IntervalMetadata", false]], "intervalmetadatamixin (class in skbio.metadata)": [[160, "skbio.metadata.IntervalMetadataMixin", false]], "inv_simpson() (in module skbio.diversity.alpha)": [[59, "skbio.diversity.alpha.inv_simpson", false]], "ioregistry (class in skbio.io.registry)": [[128, "skbio.io.registry.IORegistry", false]], "is_ascii (skbio.sequence.substitutionmatrix attribute)": [[247, "skbio.sequence.SubstitutionMatrix.is_ascii", false]], "is_bifurcating() (skbio.tree.treenode method)": [[436, "skbio.tree.TreeNode.is_bifurcating", false]], "is_binary_format (skbio.io.registry.format attribute)": [[124, "skbio.io.registry.Format.is_binary_format", false]], "is_empty() (skbio.table.table method)": [[367, "skbio.table.Table.is_empty", false]], "is_reverse_complement() (skbio.sequence.nucleotidemixin method)": [[213, "skbio.sequence.NucleotideMixin.is_reverse_complement", false]], "is_root() (skbio.tree.treenode method)": [[437, "skbio.tree.TreeNode.is_root", false]], "is_tip() (skbio.tree.treenode method)": [[438, "skbio.tree.TreeNode.is_tip", false]], "is_zero_based() (skbio.alignment.alignmentstructure method)": [[12, "skbio.alignment.AlignmentStructure.is_zero_based", false]], "isubsample() (in module skbio.stats)": [[318, "skbio.stats.isubsample", false]], "iter() (skbio.table.table method)": [[368, "skbio.table.Table.iter", false]], "iter_contiguous() (skbio.sequence.sequence method)": [[235, "skbio.sequence.Sequence.iter_contiguous", false]], "iter_data() (skbio.table.table method)": [[369, "skbio.table.Table.iter_data", false]], "iter_kmers() (skbio.sequence.sequence method)": [[236, "skbio.sequence.Sequence.iter_kmers", false]], "iter_pairwise() (skbio.table.table method)": [[370, "skbio.table.Table.iter_pairwise", false]], "iter_positions() (skbio.alignment.tabularmsa method)": [[28, "skbio.alignment.TabularMSA.iter_positions", false]], "join() (skbio.alignment.tabularmsa method)": [[29, "skbio.alignment.TabularMSA.join", false]], "kempton_taylor_q() (in module skbio.diversity.alpha)": [[60, "skbio.diversity.alpha.kempton_taylor_q", false]], "kmer_distance() (in module skbio.sequence.distance)": [[255, "skbio.sequence.distance.kmer_distance", false]], "kmer_frequencies() (skbio.sequence.sequence method)": [[237, "skbio.sequence.Sequence.kmer_frequencies", false]], "lca() (skbio.tree.treenode method)": [[439, "skbio.tree.TreeNode.lca", false]], "length() (skbio.table.table method)": [[371, "skbio.table.Table.length", false]], "lengths (skbio.alignment.alignpath attribute)": [[3, "skbio.alignment.AlignPath.lengths", false]], "levelorder() (skbio.tree.treenode method)": [[440, "skbio.tree.TreeNode.levelorder", false]], "list_read_formats() (skbio.io.registry.ioregistry method)": [[134, "skbio.io.registry.IORegistry.list_read_formats", false]], "list_write_formats() (skbio.io.registry.ioregistry method)": [[135, "skbio.io.registry.IORegistry.list_write_formats", false]], "lladser_ci() (in module skbio.diversity.alpha)": [[61, "skbio.diversity.alpha.lladser_ci", false]], "lladser_pe() (in module skbio.diversity.alpha)": [[62, "skbio.diversity.alpha.lladser_pe", false]], "load() (skbio.metadata.samplemetadata class method)": [[181, "skbio.metadata.SampleMetadata.load", false]], "loc (skbio.alignment.tabularmsa attribute)": [[20, "skbio.alignment.TabularMSA.loc", false]], "local_pairwise_align() (in module skbio.alignment)": [[38, "skbio.alignment.local_pairwise_align", false]], "local_pairwise_align_nucleotide() (in module skbio.alignment)": [[39, "skbio.alignment.local_pairwise_align_nucleotide", false]], "local_pairwise_align_protein() (in module skbio.alignment)": [[40, "skbio.alignment.local_pairwise_align_protein", false]], "local_pairwise_align_ssw() (in module skbio.alignment)": [[41, "skbio.alignment.local_pairwise_align_ssw", false]], "lower_bound (skbio.metadata.intervalmetadata attribute)": [[151, "skbio.metadata.IntervalMetadata.lower_bound", false]], "lowercase() (skbio.sequence.sequence method)": [[238, "skbio.sequence.Sequence.lowercase", false]], "majority_rule() (in module skbio.tree)": [[479, "skbio.tree.majority_rule", false]], "make_identity_substitution_matrix() (in module skbio.alignment)": [[42, "skbio.alignment.make_identity_substitution_matrix", false]], "mantel() (in module skbio.stats.distance)": [[298, "skbio.stats.distance.mantel", false]], "margalef() (in module skbio.diversity.alpha)": [[63, "skbio.diversity.alpha.margalef", false]], "match_frequency() (skbio.sequence.sequence method)": [[239, "skbio.sequence.Sequence.match_frequency", false]], "matches() (skbio.sequence.sequence method)": [[240, "skbio.sequence.Sequence.matches", false]], "matrix_data (skbio.table.table attribute)": [[342, "skbio.table.Table.matrix_data", false]], "max() (skbio.table.table method)": [[372, "skbio.table.Table.max", false]], "maxdist() (skbio.tree.treenode method)": [[441, "skbio.tree.TreeNode.maxdist", false]], "mcintosh_d() (in module skbio.diversity.alpha)": [[64, "skbio.diversity.alpha.mcintosh_d", false]], "mcintosh_e() (in module skbio.diversity.alpha)": [[65, "skbio.diversity.alpha.mcintosh_e", false]], "mean_and_std() (in module skbio.stats.ordination)": [[330, "skbio.stats.ordination.mean_and_std", false]], "menhinick() (in module skbio.diversity.alpha)": [[66, "skbio.diversity.alpha.menhinick", false]], "merge() (skbio.metadata.intervalmetadata method)": [[155, "skbio.metadata.IntervalMetadata.merge", false]], "merge() (skbio.metadata.samplemetadata method)": [[182, "skbio.metadata.SampleMetadata.merge", false]], "merge() (skbio.table.table method)": [[373, "skbio.table.Table.merge", false]], "metadata (skbio.metadata.interval attribute)": [[149, "skbio.metadata.Interval.metadata", false]], "metadata (skbio.metadata.metadatamixin attribute)": [[171, "skbio.metadata.MetadataMixin.metadata", false]], "metadata() (skbio.table.table method)": [[374, "skbio.table.Table.metadata", false]], "metadata_to_dataframe() (skbio.table.table method)": [[375, "skbio.table.Table.metadata_to_dataframe", false]], "metadatacolumn (class in skbio.metadata)": [[162, "skbio.metadata.MetadataColumn", false]], "metadatamixin (class in skbio.metadata)": [[171, "skbio.metadata.MetadataMixin", false]], "method (class in skbio.workflow)": [[503, "skbio.workflow.method", false]], "michaelis_menten_fit() (in module skbio.diversity.alpha)": [[67, "skbio.diversity.alpha.michaelis_menten_fit", false]], "min() (skbio.table.table method)": [[376, "skbio.table.Table.min", false]], "mismatch_frequency() (skbio.sequence.sequence method)": [[241, "skbio.sequence.Sequence.mismatch_frequency", false]], "mismatches() (skbio.sequence.sequence method)": [[242, "skbio.sequence.Sequence.mismatches", false]], "missing_scheme (skbio.metadata.metadatacolumn attribute)": [[162, "skbio.metadata.MetadataColumn.missing_scheme", false]], "module": [[0, "module-skbio.alignment", false], [1, "module-skbio.diversity", false], [2, "module-skbio.embedding", false], [43, "module-skbio.diversity.alpha", false], [83, "module-skbio.diversity.beta", false], [104, "module-skbio.io.format.binary_dm", false], [105, "module-skbio.io.format.biom", false], [106, "module-skbio.io.format.blast6", false], [107, "module-skbio.io.format.blast7", false], [108, "module-skbio.io.format.clustal", false], [109, "module-skbio.io.format.embed", false], [110, "module-skbio.io.format.embl", false], [111, "module-skbio.io.format.fasta", false], [112, "module-skbio.io.format.fastq", false], [113, "module-skbio.io.format.genbank", false], [114, "module-skbio.io.format.gff3", false], [115, "module-skbio.io.format.lsmat", false], [116, "module-skbio.io.format.newick", false], [117, "module-skbio.io.format.ordination", false], [118, "module-skbio.io.format.phylip", false], [119, "module-skbio.io.format.qseq", false], [120, "module-skbio.io.format.sample_metadata", false], [121, "module-skbio.io.format.stockholm", false], [122, "module-skbio.io.format.taxdump", false], [123, "module-skbio.io.registry", false], [144, "module-skbio.io.util", false], [253, "module-skbio.sequence.distance", false], [256, "module-skbio.stats.composition", false], [276, "module-skbio.stats.distance", false], [303, "module-skbio.stats.evolve", false], [305, "module-skbio.stats.gradient", false], [319, "module-skbio.stats.ordination", false], [336, "module-skbio.stats.power", false], [506, "module-skbio.io", false], [507, "module-skbio.metadata", false], [508, "module-skbio.sequence", false], [509, "module-skbio.stats", false], [510, "module-skbio.table", false], [511, "module-skbio.tree", false], [512, "module-skbio.util", false], [513, "module-skbio.workflow", false]], "multi_replace() (in module skbio.stats.composition)": [[268, "skbio.stats.composition.multi_replace", false]], "name (skbio.io.registry.format attribute)": [[124, "skbio.io.registry.Format.name", false]], "name (skbio.metadata.metadatacolumn attribute)": [[162, "skbio.metadata.MetadataColumn.name", false]], "name (skbio.sequence.geneticcode attribute)": [[191, "skbio.sequence.GeneticCode.name", false]], "neighbors() (skbio.tree.treenode method)": [[442, "skbio.tree.TreeNode.neighbors", false]], "nj() (in module skbio.tree)": [[480, "skbio.tree.nj", false]], "nni() (in module skbio.tree)": [[481, "skbio.tree.nni", false]], "nnz (skbio.table.table attribute)": [[342, "skbio.table.Table.nnz", false]], "non_tips() (skbio.tree.treenode method)": [[443, "skbio.tree.TreeNode.non_tips", false]], "noncanonical_chars (skbio.sequence.grammaredsequence attribute)": [[195, "skbio.sequence.GrammaredSequence.noncanonical_chars", false]], "noncanonical_chars (skbio.sequence.protein attribute)": [[215, "skbio.sequence.Protein.noncanonical_chars", false]], "nondegenerate_chars (skbio.sequence.grammaredsequence attribute)": [[195, "skbio.sequence.GrammaredSequence.nondegenerate_chars", false]], "nondegenerates() (skbio.sequence.grammaredsequence method)": [[206, "skbio.sequence.GrammaredSequence.nondegenerates", false]], "nonzero() (skbio.table.table method)": [[377, "skbio.table.Table.nonzero", false]], "nonzero_counts() (skbio.table.table method)": [[378, "skbio.table.Table.nonzero_counts", false]], "norm() (skbio.table.table method)": [[379, "skbio.table.Table.norm", false]], "nucleotidemixin (class in skbio.sequence)": [[209, "skbio.sequence.NucleotideMixin", false]], "num_interval_features (skbio.metadata.intervalmetadata attribute)": [[151, "skbio.metadata.IntervalMetadata.num_interval_features", false]], "numericmetadatacolumn (class in skbio.metadata)": [[173, "skbio.metadata.NumericMetadataColumn", false]], "observed_chars (skbio.sequence.sequence attribute)": [[228, "skbio.sequence.Sequence.observed_chars", false]], "observed_features() (in module skbio.diversity.alpha)": [[68, "skbio.diversity.alpha.observed_features", false]], "observed_node_counts() (skbio.tree.treenode method)": [[444, "skbio.tree.TreeNode.observed_node_counts", false]], "open() (in module skbio.io.util)": [[145, "skbio.io.util.open", false]], "open_file() (in module skbio.io.util)": [[146, "skbio.io.util.open_file", false]], "open_files() (in module skbio.io.util)": [[147, "skbio.io.util.open_files", false]], "optimal_alignment_score (skbio.alignment.alignmentstructure attribute)": [[11, "skbio.alignment.AlignmentStructure.optimal_alignment_score", false]], "ordinationresults (class in skbio.stats.ordination)": [[320, "skbio.stats.ordination.OrdinationResults", false]], "osd() (in module skbio.diversity.alpha)": [[69, "skbio.diversity.alpha.osd", false]], "overrides() (in module skbio.util)": [[497, "skbio.util.overrides", false]], "pa() (skbio.table.table method)": [[380, "skbio.table.Table.pa", false]], "pairalignpath (class in skbio.alignment)": [[14, "skbio.alignment.PairAlignPath", false]], "paired_subsamples() (in module skbio.stats.power)": [[338, "skbio.stats.power.paired_subsamples", false]], "pairwise_vlr() (in module skbio.stats.composition)": [[269, "skbio.stats.composition.pairwise_vlr", false]], "params_aliased() (in module skbio.util)": [[498, "skbio.util.params_aliased", false]], "partial_beta_diversity() (in module skbio.diversity)": [[90, "skbio.diversity.partial_beta_diversity", false]], "partition() (skbio.table.table method)": [[381, "skbio.table.Table.partition", false]], "path() (skbio.tree.treenode method)": [[445, "skbio.tree.TreeNode.path", false]], "path_dists() (in module skbio.tree)": [[482, "skbio.tree.path_dists", false]], "pcoa() (in module skbio.stats.ordination)": [[331, "skbio.stats.ordination.pcoa", false]], "pcoa_biplot() (in module skbio.stats.ordination)": [[332, "skbio.stats.ordination.pcoa_biplot", false]], "permanova() (in module skbio.stats.distance)": [[299, "skbio.stats.distance.permanova", false]], "permdisp() (in module skbio.stats.distance)": [[300, "skbio.stats.distance.permdisp", false]], "permute() (skbio.stats.distance.distancematrix method)": [[294, "skbio.stats.distance.DistanceMatrix.permute", false]], "perturb() (in module skbio.stats.composition)": [[270, "skbio.stats.composition.perturb", false]], "perturb_inv() (in module skbio.stats.composition)": [[271, "skbio.stats.composition.perturb_inv", false]], "phydiv() (in module skbio.diversity.alpha)": [[70, "skbio.diversity.alpha.phydiv", false]], "pielou_e() (in module skbio.diversity.alpha)": [[71, "skbio.diversity.alpha.pielou_e", false]], "plot() (skbio.stats.distance.dissimilaritymatrix method)": [[283, "skbio.stats.distance.DissimilarityMatrix.plot", false]], "plot() (skbio.stats.ordination.ordinationresults method)": [[321, "skbio.stats.ordination.OrdinationResults.plot", false]], "plottablemixin (class in skbio.util)": [[486, "skbio.util.PlottableMixin", false]], "png (skbio.util.plottablemixin attribute)": [[486, "skbio.util.PlottableMixin.png", false]], "pop() (skbio.tree.treenode method)": [[446, "skbio.tree.TreeNode.pop", false]], "positional_metadata (skbio.metadata.positionalmetadatamixin attribute)": [[174, "skbio.metadata.PositionalMetadataMixin.positional_metadata", false]], "positionalmetadatamixin (class in skbio.metadata)": [[174, "skbio.metadata.PositionalMetadataMixin", false]], "postorder() (skbio.tree.treenode method)": [[447, "skbio.tree.TreeNode.postorder", false]], "power() (in module skbio.stats.composition)": [[272, "skbio.stats.composition.power", false]], "pre_and_postorder() (skbio.tree.treenode method)": [[448, "skbio.tree.TreeNode.pre_and_postorder", false]], "preorder() (skbio.tree.treenode method)": [[449, "skbio.tree.TreeNode.preorder", false]], "protein (class in skbio.sequence)": [[215, "skbio.sequence.Protein", false]], "proteinembedding (class in skbio.embedding)": [[96, "skbio.embedding.ProteinEmbedding", false]], "proteinvector (class in skbio.embedding)": [[97, "skbio.embedding.ProteinVector", false]], "prune() (skbio.tree.treenode method)": [[450, "skbio.tree.TreeNode.prune", false]], "pwmantel() (in module skbio.stats.distance)": [[301, "skbio.stats.distance.pwmantel", false]], "query() (skbio.metadata.intervalmetadata method)": [[156, "skbio.metadata.IntervalMetadata.query", false]], "query_begin (skbio.alignment.alignmentstructure attribute)": [[11, "skbio.alignment.AlignmentStructure.query_begin", false]], "query_end (skbio.alignment.alignmentstructure attribute)": [[11, "skbio.alignment.AlignmentStructure.query_end", false]], "query_sequence (skbio.alignment.alignmentstructure attribute)": [[11, "skbio.alignment.AlignmentStructure.query_sequence", false]], "randdm() (in module skbio.stats.distance)": [[302, "skbio.stats.distance.randdm", false]], "rankdata() (skbio.table.table method)": [[382, "skbio.table.Table.rankdata", false]], "rda() (in module skbio.stats.ordination)": [[333, "skbio.stats.ordination.rda", false]], "read() (in module skbio.io.registry)": [[141, "skbio.io.registry.read", false]], "read() (skbio.alignment.tabularmsa method)": [[30, "skbio.alignment.TabularMSA.read", false]], "read() (skbio.embedding.embedding method)": [[93, "skbio.embedding.Embedding.read", false]], "read() (skbio.io.registry.ioregistry method)": [[136, "skbio.io.registry.IORegistry.read", false]], "read() (skbio.metadata.intervalmetadata method)": [[157, "skbio.metadata.IntervalMetadata.read", false]], "read() (skbio.sequence.dna method)": [[186, "skbio.sequence.DNA.read", false]], "read() (skbio.sequence.protein method)": [[218, "skbio.sequence.Protein.read", false]], "read() (skbio.sequence.rna method)": [[223, "skbio.sequence.RNA.read", false]], "read() (skbio.sequence.sequence method)": [[243, "skbio.sequence.Sequence.read", false]], "read() (skbio.stats.distance.dissimilaritymatrix method)": [[284, "skbio.stats.distance.DissimilarityMatrix.read", false]], "read() (skbio.stats.ordination.ordinationresults method)": [[322, "skbio.stats.ordination.OrdinationResults.read", false]], "read() (skbio.table.table method)": [[383, "skbio.table.Table.read", false]], "read() (skbio.tree.treenode method)": [[451, "skbio.tree.TreeNode.read", false]], "reader() (skbio.io.registry.format method)": [[125, "skbio.io.registry.Format.reader", false]], "readers (skbio.io.registry.format attribute)": [[124, "skbio.io.registry.Format.readers", false]], "reading_frames (skbio.sequence.geneticcode attribute)": [[191, "skbio.sequence.GeneticCode.reading_frames", false]], "reassign_index() (skbio.alignment.tabularmsa method)": [[31, "skbio.alignment.TabularMSA.reassign_index", false]], "reduce() (skbio.table.table method)": [[384, "skbio.table.Table.reduce", false]], "redundant_form() (skbio.stats.distance.dissimilaritymatrix method)": [[285, "skbio.stats.distance.DissimilarityMatrix.redundant_form", false]], "register_aliases() (in module skbio.util)": [[499, "skbio.util.register_aliases", false]], "remove() (skbio.tree.treenode method)": [[452, "skbio.tree.TreeNode.remove", false]], "remove_by_func() (skbio.tree.treenode method)": [[453, "skbio.tree.TreeNode.remove_by_func", false]], "remove_deleted() (skbio.tree.treenode method)": [[454, "skbio.tree.TreeNode.remove_deleted", false]], "remove_empty() (skbio.table.table method)": [[385, "skbio.table.Table.remove_empty", false]], "remove_format() (skbio.io.registry.ioregistry method)": [[137, "skbio.io.registry.IORegistry.remove_format", false]], "rename() (skbio.stats.distance.dissimilaritymatrix method)": [[286, "skbio.stats.distance.DissimilarityMatrix.rename", false]], "rename() (skbio.stats.ordination.ordinationresults method)": [[323, "skbio.stats.ordination.OrdinationResults.rename", false]], "renyi() (in module skbio.diversity.alpha)": [[72, "skbio.diversity.alpha.renyi", false]], "replace() (skbio.sequence.sequence method)": [[244, "skbio.sequence.Sequence.replace", false]], "requires (class in skbio.workflow)": [[504, "skbio.workflow.requires", false]], "residues (skbio.embedding.proteinembedding attribute)": [[96, "skbio.embedding.ProteinEmbedding.residues", false]], "reverse_complement() (skbio.sequence.nucleotidemixin method)": [[214, "skbio.sequence.NucleotideMixin.reverse_complement", false]], "reverse_transcribe() (skbio.sequence.rna method)": [[224, "skbio.sequence.RNA.reverse_transcribe", false]], "rf_dists() (in module skbio.tree)": [[483, "skbio.tree.rf_dists", false]], "rna (class in skbio.sequence)": [[221, "skbio.sequence.RNA", false]], "robbins() (in module skbio.diversity.alpha)": [[73, "skbio.diversity.alpha.robbins", false]], "root() (skbio.tree.treenode method)": [[455, "skbio.tree.TreeNode.root", false]], "root_at() (skbio.tree.treenode method)": [[456, "skbio.tree.TreeNode.root_at", false]], "root_at_midpoint() (skbio.tree.treenode method)": [[457, "skbio.tree.TreeNode.root_at_midpoint", false]], "root_by_outgroup() (skbio.tree.treenode method)": [[458, "skbio.tree.TreeNode.root_by_outgroup", false]], "safe_md5() (in module skbio.util)": [[500, "skbio.util.safe_md5", false]], "samplemetadata (class in skbio.metadata)": [[176, "skbio.metadata.SampleMetadata", false]], "sbp_basis() (in module skbio.stats.composition)": [[273, "skbio.stats.composition.sbp_basis", false]], "scale() (in module skbio.stats.ordination)": [[334, "skbio.stats.ordination.scale", false]], "scores (skbio.sequence.substitutionmatrix attribute)": [[247, "skbio.sequence.SubstitutionMatrix.scores", false]], "sequence (class in skbio.sequence)": [[228, "skbio.sequence.Sequence", false]], "sequence (skbio.embedding.sequenceembedding attribute)": [[98, "skbio.embedding.SequenceEmbedding.sequence", false]], "sequence (skbio.embedding.sequencevector attribute)": [[99, "skbio.embedding.SequenceVector.sequence", false]], "sequenceembedding (class in skbio.embedding)": [[98, "skbio.embedding.SequenceEmbedding", false]], "sequencevector (class in skbio.embedding)": [[99, "skbio.embedding.SequenceVector", false]], "set_zero_based() (skbio.alignment.alignmentstructure method)": [[13, "skbio.alignment.AlignmentStructure.set_zero_based", false]], "shannon() (in module skbio.diversity.alpha)": [[74, "skbio.diversity.alpha.shannon", false]], "shape (skbio.alignment.alignpath attribute)": [[3, "skbio.alignment.AlignPath.shape", false]], "shape (skbio.alignment.tabularmsa attribute)": [[20, "skbio.alignment.TabularMSA.shape", false]], "shape (skbio.stats.distance.dissimilaritymatrix attribute)": [[277, "skbio.stats.distance.DissimilarityMatrix.shape", false]], "shape (skbio.table.table attribute)": [[342, "skbio.table.Table.shape", false]], "shear() (skbio.tree.treenode method)": [[459, "skbio.tree.TreeNode.shear", false]], "shuffle() (skbio.tree.treenode method)": [[460, "skbio.tree.TreeNode.shuffle", false]], "siblings() (skbio.tree.treenode method)": [[461, "skbio.tree.TreeNode.siblings", false]], "simpson() (in module skbio.diversity.alpha)": [[75, "skbio.diversity.alpha.simpson", false]], "simpson_d() (in module skbio.diversity.alpha)": [[76, "skbio.diversity.alpha.simpson_d", false]], "simpson_e() (in module skbio.diversity.alpha)": [[77, "skbio.diversity.alpha.simpson_e", false]], "singles() (in module skbio.diversity.alpha)": [[78, "skbio.diversity.alpha.singles", false]], "size (skbio.stats.distance.dissimilaritymatrix attribute)": [[277, "skbio.stats.distance.DissimilarityMatrix.size", false]], "skbio.alignment": [[0, "module-skbio.alignment", false]], "skbio.diversity": [[1, "module-skbio.diversity", false]], "skbio.diversity.alpha": [[43, "module-skbio.diversity.alpha", false]], "skbio.diversity.beta": [[83, "module-skbio.diversity.beta", false]], "skbio.embedding": [[2, "module-skbio.embedding", false]], "skbio.io": [[506, "module-skbio.io", false]], "skbio.io.format.binary_dm": [[104, "module-skbio.io.format.binary_dm", false]], "skbio.io.format.biom": [[105, "module-skbio.io.format.biom", false]], "skbio.io.format.blast6": [[106, "module-skbio.io.format.blast6", false]], "skbio.io.format.blast7": [[107, "module-skbio.io.format.blast7", false]], "skbio.io.format.clustal": [[108, "module-skbio.io.format.clustal", false]], "skbio.io.format.embed": [[109, "module-skbio.io.format.embed", false]], "skbio.io.format.embl": [[110, "module-skbio.io.format.embl", false]], "skbio.io.format.fasta": [[111, "module-skbio.io.format.fasta", false]], "skbio.io.format.fastq": [[112, "module-skbio.io.format.fastq", false]], "skbio.io.format.genbank": [[113, "module-skbio.io.format.genbank", false]], "skbio.io.format.gff3": [[114, "module-skbio.io.format.gff3", false]], "skbio.io.format.lsmat": [[115, "module-skbio.io.format.lsmat", false]], "skbio.io.format.newick": [[116, "module-skbio.io.format.newick", false]], "skbio.io.format.ordination": [[117, "module-skbio.io.format.ordination", false]], "skbio.io.format.phylip": [[118, "module-skbio.io.format.phylip", false]], "skbio.io.format.qseq": [[119, "module-skbio.io.format.qseq", false]], "skbio.io.format.sample_metadata": [[120, "module-skbio.io.format.sample_metadata", false]], "skbio.io.format.stockholm": [[121, "module-skbio.io.format.stockholm", false]], "skbio.io.format.taxdump": [[122, "module-skbio.io.format.taxdump", false]], "skbio.io.registry": [[123, "module-skbio.io.registry", false]], "skbio.io.util": [[144, "module-skbio.io.util", false]], "skbio.metadata": [[507, "module-skbio.metadata", false]], "skbio.sequence": [[508, "module-skbio.sequence", false]], "skbio.sequence.distance": [[253, "module-skbio.sequence.distance", false]], "skbio.stats": [[509, "module-skbio.stats", false]], "skbio.stats.composition": [[256, "module-skbio.stats.composition", false]], "skbio.stats.distance": [[276, "module-skbio.stats.distance", false]], "skbio.stats.evolve": [[303, "module-skbio.stats.evolve", false]], "skbio.stats.gradient": [[305, "module-skbio.stats.gradient", false]], "skbio.stats.ordination": [[319, "module-skbio.stats.ordination", false]], "skbio.stats.power": [[336, "module-skbio.stats.power", false]], "skbio.table": [[510, "module-skbio.table", false]], "skbio.tree": [[511, "module-skbio.tree", false]], "skbio.util": [[512, "module-skbio.util", false]], "skbio.workflow": [[513, "module-skbio.workflow", false]], "sniff() (in module skbio.io.registry)": [[142, "skbio.io.registry.sniff", false]], "sniff() (skbio.io.registry.ioregistry method)": [[138, "skbio.io.registry.IORegistry.sniff", false]], "sniffer() (skbio.io.registry.format method)": [[126, "skbio.io.registry.Format.sniffer", false]], "sniffer_function (skbio.io.registry.format attribute)": [[124, "skbio.io.registry.Format.sniffer_function", false]], "sobs() (in module skbio.diversity.alpha)": [[79, "skbio.diversity.alpha.sobs", false]], "sort() (skbio.alignment.tabularmsa method)": [[32, "skbio.alignment.TabularMSA.sort", false]], "sort() (skbio.metadata.intervalmetadata method)": [[158, "skbio.metadata.IntervalMetadata.sort", false]], "sort() (skbio.table.table method)": [[386, "skbio.table.Table.sort", false]], "sort_order() (skbio.table.table method)": [[387, "skbio.table.Table.sort_order", false]], "starts (skbio.alignment.alignpath attribute)": [[3, "skbio.alignment.AlignPath.starts", false]], "states (skbio.alignment.alignpath attribute)": [[3, "skbio.alignment.AlignPath.states", false]], "stop_chars (skbio.sequence.protein attribute)": [[215, "skbio.sequence.Protein.stop_chars", false]], "stops() (skbio.sequence.protein method)": [[219, "skbio.sequence.Protein.stops", false]], "stripedsmithwaterman (class in skbio.alignment)": [[19, "skbio.alignment.StripedSmithWaterman", false]], "strong() (in module skbio.diversity.alpha)": [[80, "skbio.diversity.alpha.strong", false]], "suboptimal_alignment_score (skbio.alignment.alignmentstructure attribute)": [[11, "skbio.alignment.AlignmentStructure.suboptimal_alignment_score", false]], "subsample() (skbio.table.table method)": [[388, "skbio.table.Table.subsample", false]], "subsample_counts() (in module skbio.stats)": [[341, "skbio.stats.subsample_counts", false]], "subsample_paired_power() (in module skbio.stats.power)": [[339, "skbio.stats.power.subsample_paired_power", false]], "subsample_power() (in module skbio.stats.power)": [[340, "skbio.stats.power.subsample_power", false]], "subset() (skbio.tree.treenode method)": [[462, "skbio.tree.TreeNode.subset", false]], "subsets() (skbio.tree.treenode method)": [[463, "skbio.tree.TreeNode.subsets", false]], "substitutionmatrix (class in skbio.sequence)": [[247, "skbio.sequence.SubstitutionMatrix", false]], "subtree() (skbio.tree.treenode method)": [[464, "skbio.tree.TreeNode.subtree", false]], "sum() (skbio.table.table method)": [[389, "skbio.table.Table.sum", false]], "svd_rank() (in module skbio.stats.ordination)": [[335, "skbio.stats.ordination.svd_rank", false]], "svg (skbio.util.plottablemixin attribute)": [[486, "skbio.util.PlottableMixin.svg", false]], "t (skbio.stats.distance.dissimilaritymatrix attribute)": [[277, "skbio.stats.distance.DissimilarityMatrix.T", false]], "table (class in skbio.table)": [[342, "skbio.table.Table", false]], "tabularmsa (class in skbio.alignment)": [[20, "skbio.alignment.TabularMSA", false]], "target_begin (skbio.alignment.alignmentstructure attribute)": [[11, "skbio.alignment.AlignmentStructure.target_begin", false]], "target_end_optimal (skbio.alignment.alignmentstructure attribute)": [[11, "skbio.alignment.AlignmentStructure.target_end_optimal", false]], "target_end_suboptimal (skbio.alignment.alignmentstructure attribute)": [[11, "skbio.alignment.AlignmentStructure.target_end_suboptimal", false]], "target_sequence (skbio.alignment.alignmentstructure attribute)": [[11, "skbio.alignment.AlignmentStructure.target_sequence", false]], "tips() (skbio.tree.treenode method)": [[465, "skbio.tree.TreeNode.tips", false]], "to_anndata() (skbio.table.table method)": [[390, "skbio.table.Table.to_anndata", false]], "to_array() (skbio.tree.treenode method)": [[466, "skbio.tree.TreeNode.to_array", false]], "to_bits() (skbio.alignment.alignpath method)": [[8, "skbio.alignment.AlignPath.to_bits", false]], "to_bits() (skbio.alignment.pairalignpath method)": [[17, "skbio.alignment.PairAlignPath.to_bits", false]], "to_cigar() (skbio.alignment.pairalignpath method)": [[18, "skbio.alignment.PairAlignPath.to_cigar", false]], "to_coordinates() (skbio.alignment.alignpath method)": [[9, "skbio.alignment.AlignPath.to_coordinates", false]], "to_data_frame() (skbio.stats.distance.dissimilaritymatrix method)": [[287, "skbio.stats.distance.DissimilarityMatrix.to_data_frame", false]], "to_dataframe() (skbio.metadata.metadatacolumn method)": [[169, "skbio.metadata.MetadataColumn.to_dataframe", false]], "to_dataframe() (skbio.metadata.samplemetadata method)": [[183, "skbio.metadata.SampleMetadata.to_dataframe", false]], "to_dataframe() (skbio.table.table method)": [[391, "skbio.table.Table.to_dataframe", false]], "to_definites() (skbio.sequence.grammaredsequence method)": [[207, "skbio.sequence.GrammaredSequence.to_definites", false]], "to_dict() (skbio.alignment.tabularmsa method)": [[33, "skbio.alignment.TabularMSA.to_dict", false]], "to_dict() (skbio.sequence.substitutionmatrix method)": [[252, "skbio.sequence.SubstitutionMatrix.to_dict", false]], "to_files() (skbio.stats.gradient.categoryresults method)": [[308, "skbio.stats.gradient.CategoryResults.to_files", false]], "to_files() (skbio.stats.gradient.gradientanovaresults method)": [[313, "skbio.stats.gradient.GradientANOVAResults.to_files", false]], "to_files() (skbio.stats.gradient.groupresults method)": [[315, "skbio.stats.gradient.GroupResults.to_files", false]], "to_hdf5() (skbio.table.table method)": [[392, "skbio.table.Table.to_hdf5", false]], "to_indices() (skbio.alignment.alignpath method)": [[10, "skbio.alignment.AlignPath.to_indices", false]], "to_indices() (skbio.sequence.sequence method)": [[245, "skbio.sequence.Sequence.to_indices", false]], "to_json() (skbio.table.table method)": [[393, "skbio.table.Table.to_json", false]], "to_regex() (skbio.sequence.grammaredsequence method)": [[208, "skbio.sequence.GrammaredSequence.to_regex", false]], "to_series() (skbio.metadata.metadatacolumn method)": [[170, "skbio.metadata.MetadataColumn.to_series", false]], "to_series() (skbio.stats.distance.distancematrix method)": [[295, "skbio.stats.distance.DistanceMatrix.to_series", false]], "to_taxonomy() (skbio.tree.treenode method)": [[467, "skbio.tree.TreeNode.to_taxonomy", false]], "to_tsv() (skbio.table.table method)": [[394, "skbio.table.Table.to_tsv", false]], "total_length() (skbio.tree.treenode method)": [[468, "skbio.tree.TreeNode.total_length", false]], "trajectorygradientanova (class in skbio.stats.gradient)": [[316, "skbio.stats.gradient.TrajectoryGradientANOVA", false]], "transcribe() (skbio.sequence.dna method)": [[187, "skbio.sequence.DNA.transcribe", false]], "transform() (skbio.table.table method)": [[395, "skbio.table.Table.transform", false]], "translate() (skbio.sequence.dna method)": [[188, "skbio.sequence.DNA.translate", false]], "translate() (skbio.sequence.geneticcode method)": [[193, "skbio.sequence.GeneticCode.translate", false]], "translate() (skbio.sequence.rna method)": [[225, "skbio.sequence.RNA.translate", false]], "translate_six_frames() (skbio.sequence.dna method)": [[189, "skbio.sequence.DNA.translate_six_frames", false]], "translate_six_frames() (skbio.sequence.geneticcode method)": [[194, "skbio.sequence.GeneticCode.translate_six_frames", false]], "translate_six_frames() (skbio.sequence.rna method)": [[226, "skbio.sequence.RNA.translate_six_frames", false]], "transpose() (skbio.stats.distance.dissimilaritymatrix method)": [[288, "skbio.stats.distance.DissimilarityMatrix.transpose", false]], "transpose() (skbio.table.table method)": [[396, "skbio.table.Table.transpose", false]], "traverse() (skbio.tree.treenode method)": [[469, "skbio.tree.TreeNode.traverse", false]], "tree_basis() (in module skbio.stats.composition)": [[274, "skbio.stats.composition.tree_basis", false]], "treenode (class in skbio.tree)": [[400, "skbio.tree.TreeNode", false]], "tsallis() (in module skbio.diversity.alpha)": [[81, "skbio.diversity.alpha.tsallis", false]], "type (skbio.metadata.categoricalmetadatacolumn attribute)": [[148, "skbio.metadata.CategoricalMetadataColumn.type", false]], "type (skbio.metadata.metadatacolumn attribute)": [[162, "skbio.metadata.MetadataColumn.type", false]], "type (skbio.metadata.numericmetadatacolumn attribute)": [[173, "skbio.metadata.NumericMetadataColumn.type", false]], "unpack() (skbio.tree.treenode method)": [[470, "skbio.tree.TreeNode.unpack", false]], "unpack_by_func() (skbio.tree.treenode method)": [[471, "skbio.tree.TreeNode.unpack_by_func", false]], "unroot() (skbio.tree.treenode method)": [[472, "skbio.tree.TreeNode.unroot", false]], "unrooted_copy() (skbio.tree.treenode method)": [[473, "skbio.tree.TreeNode.unrooted_copy", false]], "unrooted_deepcopy() (skbio.tree.treenode method)": [[474, "skbio.tree.TreeNode.unrooted_deepcopy", false]], "unrooted_move() (skbio.tree.treenode method)": [[475, "skbio.tree.TreeNode.unrooted_move", false]], "unweighted_unifrac() (in module skbio.diversity.beta)": [[84, "skbio.diversity.beta.unweighted_unifrac", false]], "update_ids() (skbio.table.table method)": [[397, "skbio.table.Table.update_ids", false]], "upgma() (in module skbio.tree)": [[484, "skbio.tree.upgma", false]], "upper_bound (skbio.metadata.intervalmetadata attribute)": [[151, "skbio.metadata.IntervalMetadata.upper_bound", false]], "values (skbio.sequence.sequence attribute)": [[228, "skbio.sequence.Sequence.values", false]], "vector (skbio.embedding.embeddingvector attribute)": [[95, "skbio.embedding.EmbeddingVector.vector", false]], "vlr() (in module skbio.stats.composition)": [[275, "skbio.stats.composition.vlr", false]], "weighted_unifrac() (in module skbio.diversity.beta)": [[85, "skbio.diversity.beta.weighted_unifrac", false]], "wildcard_char (skbio.sequence.dna attribute)": [[184, "skbio.sequence.DNA.wildcard_char", false]], "wildcard_char (skbio.sequence.grammaredsequence attribute)": [[195, "skbio.sequence.GrammaredSequence.wildcard_char", false]], "wildcard_char (skbio.sequence.protein attribute)": [[215, "skbio.sequence.Protein.wildcard_char", false]], "wildcard_char (skbio.sequence.rna attribute)": [[221, "skbio.sequence.RNA.wildcard_char", false]], "windowdifferencegradientanova (class in skbio.stats.gradient)": [[317, "skbio.stats.gradient.WindowDifferenceGradientANOVA", false]], "within() (skbio.stats.distance.dissimilaritymatrix method)": [[289, "skbio.stats.distance.DissimilarityMatrix.within", false]], "workflow (class in skbio.workflow)": [[501, "skbio.workflow.Workflow", false]], "wrf_dists() (in module skbio.tree)": [[485, "skbio.tree.wrf_dists", false]], "write() (in module skbio.io.registry)": [[143, "skbio.io.registry.write", false]], "write() (skbio.alignment.tabularmsa method)": [[34, "skbio.alignment.TabularMSA.write", false]], "write() (skbio.embedding.embedding method)": [[94, "skbio.embedding.Embedding.write", false]], "write() (skbio.io.registry.ioregistry method)": [[139, "skbio.io.registry.IORegistry.write", false]], "write() (skbio.metadata.intervalmetadata method)": [[159, "skbio.metadata.IntervalMetadata.write", false]], "write() (skbio.sequence.dna method)": [[190, "skbio.sequence.DNA.write", false]], "write() (skbio.sequence.protein method)": [[220, "skbio.sequence.Protein.write", false]], "write() (skbio.sequence.rna method)": [[227, "skbio.sequence.RNA.write", false]], "write() (skbio.sequence.sequence method)": [[246, "skbio.sequence.Sequence.write", false]], "write() (skbio.stats.distance.dissimilaritymatrix method)": [[290, "skbio.stats.distance.DissimilarityMatrix.write", false]], "write() (skbio.stats.ordination.ordinationresults method)": [[324, "skbio.stats.ordination.OrdinationResults.write", false]], "write() (skbio.table.table method)": [[398, "skbio.table.Table.write", false]], "write() (skbio.tree.treenode method)": [[476, "skbio.tree.TreeNode.write", false]], "writer() (skbio.io.registry.format method)": [[127, "skbio.io.registry.Format.writer", false]], "writers (skbio.io.registry.format attribute)": [[124, "skbio.io.registry.Format.writers", false]]}, "objects": {"skbio": [[0, 0, 0, "-", "alignment"], [1, 0, 0, "-", "diversity"], [2, 0, 0, "-", "embedding"], [506, 0, 0, "-", "io"], [507, 0, 0, "-", "metadata"], [508, 0, 0, "-", "sequence"], [509, 0, 0, "-", "stats"], [510, 0, 0, "-", "table"], [511, 0, 0, "-", "tree"], [512, 0, 0, "-", "util"], [513, 0, 0, "-", "workflow"]], "skbio.alignment": [[3, 1, 1, "", "AlignPath"], [11, 1, 1, "", "AlignmentStructure"], [14, 1, 1, "", "PairAlignPath"], [19, 1, 1, "", "StripedSmithWaterman"], [20, 1, 1, "", "TabularMSA"], [35, 4, 1, "", "global_pairwise_align"], [36, 4, 1, "", "global_pairwise_align_nucleotide"], [37, 4, 1, "", "global_pairwise_align_protein"], [38, 4, 1, "", "local_pairwise_align"], [39, 4, 1, "", "local_pairwise_align_nucleotide"], [40, 4, 1, "", "local_pairwise_align_protein"], [41, 4, 1, "", "local_pairwise_align_ssw"], [42, 4, 1, "", "make_identity_substitution_matrix"]], "skbio.alignment.AlignPath": [[3, 2, 1, "", "__str__"], [4, 2, 1, "", "from_bits"], [5, 2, 1, "", "from_coordinates"], [6, 2, 1, "", "from_indices"], [7, 2, 1, "", "from_tabular"], [3, 3, 1, "", "lengths"], [3, 3, 1, "", "shape"], [3, 3, 1, "", "starts"], [3, 3, 1, "", "states"], [8, 2, 1, "", "to_bits"], [9, 2, 1, "", "to_coordinates"], [10, 2, 1, "", "to_indices"]], "skbio.alignment.AlignmentStructure": [[11, 2, 1, "", "__getitem__"], [11, 2, 1, "", "__setstate__"], [11, 2, 1, "", "__str__"], [11, 3, 1, "", "aligned_query_sequence"], [11, 3, 1, "", "aligned_target_sequence"], [11, 3, 1, "", "cigar"], [12, 2, 1, "", "is_zero_based"], [11, 3, 1, "", "optimal_alignment_score"], [11, 3, 1, "", "query_begin"], [11, 3, 1, "", "query_end"], [11, 3, 1, "", "query_sequence"], [13, 2, 1, "", "set_zero_based"], [11, 3, 1, "", "suboptimal_alignment_score"], [11, 3, 1, "", "target_begin"], [11, 3, 1, "", "target_end_optimal"], [11, 3, 1, "", "target_end_suboptimal"], [11, 3, 1, "", "target_sequence"]], "skbio.alignment.PairAlignPath": [[14, 2, 1, "", "__str__"], [15, 2, 1, "", "from_bits"], [16, 2, 1, "", "from_cigar"], [17, 2, 1, "", "to_bits"], [18, 2, 1, "", "to_cigar"]], "skbio.alignment.StripedSmithWaterman": [[19, 2, 1, "", "__call__"], [19, 2, 1, "", "__setstate__"]], "skbio.alignment.TabularMSA": [[20, 2, 1, "", "__bool__"], [20, 2, 1, "", "__contains__"], [20, 2, 1, "", "__copy__"], [20, 2, 1, "", "__deepcopy__"], [20, 2, 1, "", "__eq__"], [20, 2, 1, "", "__getitem__"], [20, 2, 1, "", "__iter__"], [20, 2, 1, "", "__len__"], [20, 2, 1, "", "__ne__"], [20, 2, 1, "", "__reversed__"], [20, 2, 1, "", "__str__"], [21, 2, 1, "", "append"], [22, 2, 1, "", "consensus"], [23, 2, 1, "", "conservation"], [20, 3, 1, "", "default_write_format"], [20, 3, 1, "", "dtype"], [24, 2, 1, "", "extend"], [25, 2, 1, "", "from_dict"], [26, 2, 1, "", "from_path_seqs"], [27, 2, 1, "", "gap_frequencies"], [20, 3, 1, "", "iloc"], [20, 3, 1, "", "index"], [28, 2, 1, "", "iter_positions"], [29, 2, 1, "", "join"], [20, 3, 1, "", "loc"], [30, 2, 1, "", "read"], [31, 2, 1, "", "reassign_index"], [20, 3, 1, "", "shape"], [32, 2, 1, "", "sort"], [33, 2, 1, "", "to_dict"], [34, 2, 1, "", "write"]], "skbio.diversity": [[43, 0, 0, "-", "alpha"], [82, 4, 1, "", "alpha_diversity"], [83, 0, 0, "-", "beta"], [86, 4, 1, "", "beta_diversity"], [87, 4, 1, "", "block_beta_diversity"], [88, 4, 1, "", "get_alpha_diversity_metrics"], [89, 4, 1, "", "get_beta_diversity_metrics"], [90, 4, 1, "", "partial_beta_diversity"]], "skbio.diversity.alpha": [[44, 4, 1, "", "ace"], [45, 4, 1, "", "berger_parker_d"], [46, 4, 1, "", "brillouin_d"], [47, 4, 1, "", "chao1"], [48, 4, 1, "", "chao1_ci"], [49, 4, 1, "", "dominance"], [50, 4, 1, "", "doubles"], [51, 4, 1, "", "enspie"], [52, 4, 1, "", "esty_ci"], [53, 4, 1, "", "faith_pd"], [54, 4, 1, "", "fisher_alpha"], [55, 4, 1, "", "gini_index"], [56, 4, 1, "", "goods_coverage"], [57, 4, 1, "", "heip_e"], [58, 4, 1, "", "hill"], [59, 4, 1, "", "inv_simpson"], [60, 4, 1, "", "kempton_taylor_q"], [61, 4, 1, "", "lladser_ci"], [62, 4, 1, "", "lladser_pe"], [63, 4, 1, "", "margalef"], [64, 4, 1, "", "mcintosh_d"], [65, 4, 1, "", "mcintosh_e"], [66, 4, 1, "", "menhinick"], [67, 4, 1, "", "michaelis_menten_fit"], [68, 4, 1, "", "observed_features"], [69, 4, 1, "", "osd"], [70, 4, 1, "", "phydiv"], [71, 4, 1, "", "pielou_e"], [72, 4, 1, "", "renyi"], [73, 4, 1, "", "robbins"], [74, 4, 1, "", "shannon"], [75, 4, 1, "", "simpson"], [76, 4, 1, "", "simpson_d"], [77, 4, 1, "", "simpson_e"], [78, 4, 1, "", "singles"], [79, 4, 1, "", "sobs"], [80, 4, 1, "", "strong"], [81, 4, 1, "", "tsallis"]], "skbio.diversity.beta": [[84, 4, 1, "", "unweighted_unifrac"], [85, 4, 1, "", "weighted_unifrac"]], "skbio.embedding": [[91, 1, 1, "", "Embedding"], [95, 1, 1, "", "EmbeddingVector"], [96, 1, 1, "", "ProteinEmbedding"], [97, 1, 1, "", "ProteinVector"], [98, 1, 1, "", "SequenceEmbedding"], [99, 1, 1, "", "SequenceVector"], [100, 4, 1, "", "embed_vec_to_dataframe"], [101, 4, 1, "", "embed_vec_to_distances"], [102, 4, 1, "", "embed_vec_to_numpy"], [103, 4, 1, "", "embed_vec_to_ordination"]], "skbio.embedding.Embedding": [[91, 2, 1, "", "__str__"], [92, 2, 1, "", "bytes"], [91, 3, 1, "", "embedding"], [91, 3, 1, "", "ids"], [93, 2, 1, "", "read"], [94, 2, 1, "", "write"]], "skbio.embedding.EmbeddingVector": [[95, 2, 1, "", "__str__"], [95, 3, 1, "", "embedding"], [95, 3, 1, "", "vector"]], "skbio.embedding.ProteinEmbedding": [[96, 3, 1, "", "default_write_format"], [96, 3, 1, "", "residues"]], "skbio.embedding.ProteinVector": [[97, 3, 1, "", "default_write_format"]], "skbio.embedding.SequenceEmbedding": [[98, 2, 1, "", "__str__"], [98, 3, 1, "", "sequence"]], "skbio.embedding.SequenceVector": [[99, 3, 1, "", "sequence"]], "skbio.io": [[123, 0, 0, "-", "registry"], [144, 0, 0, "-", "util"]], "skbio.io.format": [[104, 0, 0, "-", "binary_dm"], [105, 0, 0, "-", "biom"], [106, 0, 0, "-", "blast6"], [107, 0, 0, "-", "blast7"], [108, 0, 0, "-", "clustal"], [109, 0, 0, "-", "embed"], [110, 0, 0, "-", "embl"], [111, 0, 0, "-", "fasta"], [112, 0, 0, "-", "fastq"], [113, 0, 0, "-", "genbank"], [114, 0, 0, "-", "gff3"], [115, 0, 0, "-", "lsmat"], [116, 0, 0, "-", "newick"], [117, 0, 0, "-", "ordination"], [118, 0, 0, "-", "phylip"], [119, 0, 0, "-", "qseq"], [120, 0, 0, "-", "sample_metadata"], [121, 0, 0, "-", "stockholm"], [122, 0, 0, "-", "taxdump"]], "skbio.io.registry": [[124, 1, 1, "", "Format"], [128, 1, 1, "", "IORegistry"], [140, 4, 1, "", "create_format"], [141, 4, 1, "", "read"], [142, 4, 1, "", "sniff"], [143, 4, 1, "", "write"]], "skbio.io.registry.Format": [[124, 3, 1, "", "is_binary_format"], [124, 3, 1, "", "name"], [125, 2, 1, "", "reader"], [124, 3, 1, "", "readers"], [126, 2, 1, "", "sniffer"], [124, 3, 1, "", "sniffer_function"], [127, 2, 1, "", "writer"], [124, 3, 1, "", "writers"]], "skbio.io.registry.IORegistry": [[129, 2, 1, "", "add_format"], [130, 2, 1, "", "create_format"], [131, 2, 1, "", "get_reader"], [132, 2, 1, "", "get_sniffer"], [133, 2, 1, "", "get_writer"], [134, 2, 1, "", "list_read_formats"], [135, 2, 1, "", "list_write_formats"], [136, 2, 1, "", "read"], [137, 2, 1, "", "remove_format"], [138, 2, 1, "", "sniff"], [139, 2, 1, "", "write"]], "skbio.io.util": [[145, 4, 1, "", "open"], [146, 4, 1, "", "open_file"], [147, 4, 1, "", "open_files"]], "skbio.metadata": [[148, 1, 1, "", "CategoricalMetadataColumn"], [149, 1, 1, "", "Interval"], [151, 1, 1, "", "IntervalMetadata"], [160, 1, 1, "", "IntervalMetadataMixin"], [162, 1, 1, "", "MetadataColumn"], [171, 1, 1, "", "MetadataMixin"], [173, 1, 1, "", "NumericMetadataColumn"], [174, 1, 1, "", "PositionalMetadataMixin"], [176, 1, 1, "", "SampleMetadata"]], "skbio.metadata.CategoricalMetadataColumn": [[148, 3, 1, "", "type"]], "skbio.metadata.Interval": [[149, 2, 1, "", "__eq__"], [149, 2, 1, "", "__ne__"], [149, 3, 1, "", "bounds"], [150, 2, 1, "", "drop"], [149, 3, 1, "", "dropped"], [149, 3, 1, "", "fuzzy"], [149, 3, 1, "", "metadata"]], "skbio.metadata.IntervalMetadata": [[151, 2, 1, "", "__copy__"], [151, 2, 1, "", "__deepcopy__"], [151, 2, 1, "", "__eq__"], [151, 2, 1, "", "__ne__"], [152, 2, 1, "", "add"], [153, 2, 1, "", "concat"], [151, 3, 1, "", "default_write_format"], [154, 2, 1, "", "drop"], [151, 3, 1, "", "lower_bound"], [155, 2, 1, "", "merge"], [151, 3, 1, "", "num_interval_features"], [156, 2, 1, "", "query"], [157, 2, 1, "", "read"], [158, 2, 1, "", "sort"], [151, 3, 1, "", "upper_bound"], [159, 2, 1, "", "write"]], "skbio.metadata.IntervalMetadataMixin": [[160, 2, 1, "", "__copy__"], [160, 2, 1, "", "__deepcopy__"], [160, 2, 1, "", "__eq__"], [160, 2, 1, "", "__ne__"], [161, 2, 1, "", "has_interval_metadata"], [160, 3, 1, "", "interval_metadata"]], "skbio.metadata.MetadataColumn": [[162, 2, 1, "", "__eq__"], [162, 2, 1, "", "__ne__"], [163, 2, 1, "", "drop_missing_values"], [164, 2, 1, "", "filter_ids"], [165, 2, 1, "", "get_ids"], [166, 2, 1, "", "get_missing"], [167, 2, 1, "", "get_value"], [168, 2, 1, "", "has_missing_values"], [162, 3, 1, "", "missing_scheme"], [162, 3, 1, "", "name"], [169, 2, 1, "", "to_dataframe"], [170, 2, 1, "", "to_series"], [162, 3, 1, "", "type"]], "skbio.metadata.MetadataMixin": [[171, 2, 1, "", "__copy__"], [171, 2, 1, "", "__deepcopy__"], [171, 2, 1, "", "__eq__"], [171, 2, 1, "", "__ne__"], [172, 2, 1, "", "has_metadata"], [171, 3, 1, "", "metadata"]], "skbio.metadata.NumericMetadataColumn": [[173, 3, 1, "", "type"]], "skbio.metadata.PositionalMetadataMixin": [[174, 2, 1, "", "__copy__"], [174, 2, 1, "", "__deepcopy__"], [174, 2, 1, "", "__eq__"], [174, 2, 1, "", "__ne__"], [175, 2, 1, "", "has_positional_metadata"], [174, 3, 1, "", "positional_metadata"]], "skbio.metadata.SampleMetadata": [[176, 2, 1, "", "__eq__"], [176, 2, 1, "", "__ne__"], [176, 3, 1, "", "column_count"], [176, 3, 1, "", "columns"], [176, 3, 1, "", "default_write_format"], [177, 2, 1, "", "filter_columns"], [178, 2, 1, "", "filter_ids"], [179, 2, 1, "", "get_column"], [180, 2, 1, "", "get_ids"], [181, 2, 1, "", "load"], [182, 2, 1, "", "merge"], [183, 2, 1, "", "to_dataframe"]], "skbio.sequence": [[184, 1, 1, "", "DNA"], [191, 1, 1, "", "GeneticCode"], [195, 1, 1, "", "GrammaredSequence"], [209, 1, 1, "", "NucleotideMixin"], [215, 1, 1, "", "Protein"], [221, 1, 1, "", "RNA"], [228, 1, 1, "", "Sequence"], [247, 1, 1, "", "SubstitutionMatrix"], [253, 0, 0, "-", "distance"]], "skbio.sequence.DNA": [[184, 3, 1, "", "complement_map"], [184, 3, 1, "", "default_gap_char"], [184, 3, 1, "", "definite_chars"], [184, 3, 1, "", "degenerate_map"], [185, 2, 1, "", "find_motifs"], [184, 3, 1, "", "gap_chars"], [186, 2, 1, "", "read"], [187, 2, 1, "", "transcribe"], [188, 2, 1, "", "translate"], [189, 2, 1, "", "translate_six_frames"], [184, 3, 1, "", "wildcard_char"], [190, 2, 1, "", "write"]], "skbio.sequence.GeneticCode": [[191, 2, 1, "", "__eq__"], [191, 2, 1, "", "__ne__"], [191, 2, 1, "", "__str__"], [192, 2, 1, "", "from_ncbi"], [191, 3, 1, "", "name"], [191, 3, 1, "", "reading_frames"], [193, 2, 1, "", "translate"], [194, 2, 1, "", "translate_six_frames"]], "skbio.sequence.GrammaredSequence": [[195, 3, 1, "", "alphabet"], [195, 3, 1, "", "default_gap_char"], [195, 3, 1, "", "definite_chars"], [196, 2, 1, "", "definites"], [197, 2, 1, "", "degap"], [195, 3, 1, "", "degenerate_chars"], [195, 3, 1, "", "degenerate_map"], [198, 2, 1, "", "degenerates"], [199, 2, 1, "", "expand_degenerates"], [200, 2, 1, "", "find_motifs"], [195, 3, 1, "", "gap_chars"], [201, 2, 1, "", "gaps"], [202, 2, 1, "", "has_definites"], [203, 2, 1, "", "has_degenerates"], [204, 2, 1, "", "has_gaps"], [205, 2, 1, "", "has_nondegenerates"], [195, 3, 1, "", "noncanonical_chars"], [195, 3, 1, "", "nondegenerate_chars"], [206, 2, 1, "", "nondegenerates"], [207, 2, 1, "", "to_definites"], [208, 2, 1, "", "to_regex"], [195, 3, 1, "", "wildcard_char"]], "skbio.sequence.NucleotideMixin": [[210, 2, 1, "", "complement"], [209, 3, 1, "", "complement_map"], [211, 2, 1, "", "gc_content"], [212, 2, 1, "", "gc_frequency"], [213, 2, 1, "", "is_reverse_complement"], [214, 2, 1, "", "reverse_complement"]], "skbio.sequence.Protein": [[215, 3, 1, "", "alphabet"], [215, 3, 1, "", "default_gap_char"], [215, 3, 1, "", "definite_chars"], [215, 3, 1, "", "degenerate_map"], [216, 2, 1, "", "find_motifs"], [215, 3, 1, "", "gap_chars"], [217, 2, 1, "", "has_stops"], [215, 3, 1, "", "noncanonical_chars"], [218, 2, 1, "", "read"], [215, 3, 1, "", "stop_chars"], [219, 2, 1, "", "stops"], [215, 3, 1, "", "wildcard_char"], [220, 2, 1, "", "write"]], "skbio.sequence.RNA": [[221, 3, 1, "", "complement_map"], [221, 3, 1, "", "default_gap_char"], [221, 3, 1, "", "definite_chars"], [221, 3, 1, "", "degenerate_map"], [222, 2, 1, "", "find_motifs"], [221, 3, 1, "", "gap_chars"], [223, 2, 1, "", "read"], [224, 2, 1, "", "reverse_transcribe"], [225, 2, 1, "", "translate"], [226, 2, 1, "", "translate_six_frames"], [221, 3, 1, "", "wildcard_char"], [227, 2, 1, "", "write"]], "skbio.sequence.Sequence": [[228, 2, 1, "", "__bool__"], [228, 2, 1, "", "__contains__"], [228, 2, 1, "", "__copy__"], [228, 2, 1, "", "__deepcopy__"], [228, 2, 1, "", "__eq__"], [228, 2, 1, "", "__getitem__"], [228, 2, 1, "", "__iter__"], [228, 2, 1, "", "__len__"], [228, 2, 1, "", "__ne__"], [228, 2, 1, "", "__reversed__"], [228, 2, 1, "", "__str__"], [229, 2, 1, "", "concat"], [230, 2, 1, "", "count"], [228, 3, 1, "", "default_write_format"], [231, 2, 1, "", "distance"], [232, 2, 1, "", "find_with_regex"], [233, 2, 1, "", "frequencies"], [234, 2, 1, "", "index"], [235, 2, 1, "", "iter_contiguous"], [236, 2, 1, "", "iter_kmers"], [237, 2, 1, "", "kmer_frequencies"], [238, 2, 1, "", "lowercase"], [239, 2, 1, "", "match_frequency"], [240, 2, 1, "", "matches"], [241, 2, 1, "", "mismatch_frequency"], [242, 2, 1, "", "mismatches"], [228, 3, 1, "", "observed_chars"], [243, 2, 1, "", "read"], [244, 2, 1, "", "replace"], [245, 2, 1, "", "to_indices"], [228, 3, 1, "", "values"], [246, 2, 1, "", "write"]], "skbio.sequence.SubstitutionMatrix": [[247, 3, 1, "", "alphabet"], [248, 2, 1, "", "by_name"], [249, 2, 1, "", "from_dict"], [250, 2, 1, "", "get_names"], [251, 2, 1, "", "identity"], [247, 3, 1, "", "is_ascii"], [247, 3, 1, "", "scores"], [252, 2, 1, "", "to_dict"]], "skbio.sequence.distance": [[254, 4, 1, "", "hamming"], [255, 4, 1, "", "kmer_distance"]], "skbio.stats": [[256, 0, 0, "-", "composition"], [276, 0, 0, "-", "distance"], [303, 0, 0, "-", "evolve"], [305, 0, 0, "-", "gradient"], [318, 4, 1, "", "isubsample"], [319, 0, 0, "-", "ordination"], [336, 0, 0, "-", "power"], [341, 4, 1, "", "subsample_counts"]], "skbio.stats.composition": [[257, 4, 1, "", "alr"], [258, 4, 1, "", "alr_inv"], [259, 4, 1, "", "ancom"], [260, 4, 1, "", "centralize"], [261, 4, 1, "", "closure"], [262, 4, 1, "", "clr"], [263, 4, 1, "", "clr_inv"], [264, 4, 1, "", "dirmult_ttest"], [265, 4, 1, "", "ilr"], [266, 4, 1, "", "ilr_inv"], [267, 4, 1, "", "inner"], [268, 4, 1, "", "multi_replace"], [269, 4, 1, "", "pairwise_vlr"], [270, 4, 1, "", "perturb"], [271, 4, 1, "", "perturb_inv"], [272, 4, 1, "", "power"], [273, 4, 1, "", "sbp_basis"], [274, 4, 1, "", "tree_basis"], [275, 4, 1, "", "vlr"]], "skbio.stats.distance": [[277, 1, 1, "", "DissimilarityMatrix"], [291, 1, 1, "", "DistanceMatrix"], [296, 4, 1, "", "anosim"], [297, 4, 1, "", "bioenv"], [298, 4, 1, "", "mantel"], [299, 4, 1, "", "permanova"], [300, 4, 1, "", "permdisp"], [301, 4, 1, "", "pwmantel"], [302, 4, 1, "", "randdm"]], "skbio.stats.distance.DissimilarityMatrix": [[277, 3, 1, "", "T"], [277, 2, 1, "", "__contains__"], [277, 2, 1, "", "__eq__"], [277, 2, 1, "", "__getitem__"], [277, 2, 1, "", "__ne__"], [277, 2, 1, "", "__str__"], [278, 2, 1, "", "between"], [279, 2, 1, "", "copy"], [277, 3, 1, "", "data"], [277, 3, 1, "", "default_write_format"], [277, 3, 1, "", "dtype"], [280, 2, 1, "", "filter"], [281, 2, 1, "", "from_iterable"], [277, 3, 1, "", "ids"], [282, 2, 1, "", "index"], [283, 2, 1, "", "plot"], [284, 2, 1, "", "read"], [285, 2, 1, "", "redundant_form"], [286, 2, 1, "", "rename"], [277, 3, 1, "", "shape"], [277, 3, 1, "", "size"], [287, 2, 1, "", "to_data_frame"], [288, 2, 1, "", "transpose"], [289, 2, 1, "", "within"], [290, 2, 1, "", "write"]], "skbio.stats.distance.DistanceMatrix": [[292, 2, 1, "", "condensed_form"], [293, 2, 1, "", "from_iterable"], [294, 2, 1, "", "permute"], [295, 2, 1, "", "to_series"]], "skbio.stats.evolve": [[304, 4, 1, "", "hommola_cospeciation"]], "skbio.stats.gradient": [[306, 1, 1, "", "AverageGradientANOVA"], [307, 1, 1, "", "CategoryResults"], [309, 1, 1, "", "FirstDifferenceGradientANOVA"], [310, 1, 1, "", "GradientANOVA"], [312, 1, 1, "", "GradientANOVAResults"], [314, 1, 1, "", "GroupResults"], [316, 1, 1, "", "TrajectoryGradientANOVA"], [317, 1, 1, "", "WindowDifferenceGradientANOVA"]], "skbio.stats.gradient.CategoryResults": [[308, 2, 1, "", "to_files"]], "skbio.stats.gradient.GradientANOVA": [[311, 2, 1, "", "get_trajectories"]], "skbio.stats.gradient.GradientANOVAResults": [[313, 2, 1, "", "to_files"]], "skbio.stats.gradient.GroupResults": [[315, 2, 1, "", "to_files"]], "skbio.stats.ordination": [[320, 1, 1, "", "OrdinationResults"], [325, 4, 1, "", "ca"], [326, 4, 1, "", "cca"], [327, 4, 1, "", "corr"], [328, 4, 1, "", "e_matrix"], [329, 4, 1, "", "f_matrix"], [330, 4, 1, "", "mean_and_std"], [331, 4, 1, "", "pcoa"], [332, 4, 1, "", "pcoa_biplot"], [333, 4, 1, "", "rda"], [334, 4, 1, "", "scale"], [335, 4, 1, "", "svd_rank"]], "skbio.stats.ordination.OrdinationResults": [[320, 2, 1, "", "__str__"], [320, 3, 1, "", "default_write_format"], [321, 2, 1, "", "plot"], [322, 2, 1, "", "read"], [323, 2, 1, "", "rename"], [324, 2, 1, "", "write"]], "skbio.stats.power": [[337, 4, 1, "", "confidence_bound"], [338, 4, 1, "", "paired_subsamples"], [339, 4, 1, "", "subsample_paired_power"], [340, 4, 1, "", "subsample_power"]], "skbio.table": [[342, 1, 1, "", "Table"], [399, 5, 1, "", "example_table"]], "skbio.table.Table": [[342, 2, 1, "", "__eq__"], [342, 2, 1, "", "__getitem__"], [342, 2, 1, "", "__iter__"], [342, 2, 1, "", "__ne__"], [342, 2, 1, "", "__str__"], [343, 2, 1, "", "add_group_metadata"], [344, 2, 1, "", "add_metadata"], [345, 2, 1, "", "align_to"], [346, 2, 1, "", "align_to_dataframe"], [347, 2, 1, "", "align_tree"], [348, 2, 1, "", "collapse"], [349, 2, 1, "", "concat"], [350, 2, 1, "", "copy"], [351, 2, 1, "", "data"], [342, 3, 1, "", "default_write_format"], [352, 2, 1, "", "del_metadata"], [353, 2, 1, "", "delimited_self"], [354, 2, 1, "", "descriptive_equality"], [342, 3, 1, "", "dtype"], [355, 2, 1, "", "exists"], [356, 2, 1, "", "filter"], [357, 2, 1, "", "from_adjacency"], [358, 2, 1, "", "from_hdf5"], [359, 2, 1, "", "from_json"], [360, 2, 1, "", "from_tsv"], [361, 2, 1, "", "get_table_density"], [362, 2, 1, "", "get_value_by_ids"], [363, 2, 1, "", "group_metadata"], [364, 2, 1, "", "head"], [365, 2, 1, "", "ids"], [366, 2, 1, "", "index"], [367, 2, 1, "", "is_empty"], [368, 2, 1, "", "iter"], [369, 2, 1, "", "iter_data"], [370, 2, 1, "", "iter_pairwise"], [371, 2, 1, "", "length"], [342, 3, 1, "", "matrix_data"], [372, 2, 1, "", "max"], [373, 2, 1, "", "merge"], [374, 2, 1, "", "metadata"], [375, 2, 1, "", "metadata_to_dataframe"], [376, 2, 1, "", "min"], [342, 3, 1, "", "nnz"], [377, 2, 1, "", "nonzero"], [378, 2, 1, "", "nonzero_counts"], [379, 2, 1, "", "norm"], [380, 2, 1, "", "pa"], [381, 2, 1, "", "partition"], [382, 2, 1, "", "rankdata"], [383, 2, 1, "", "read"], [384, 2, 1, "", "reduce"], [385, 2, 1, "", "remove_empty"], [342, 3, 1, "", "shape"], [386, 2, 1, "", "sort"], [387, 2, 1, "", "sort_order"], [388, 2, 1, "", "subsample"], [389, 2, 1, "", "sum"], [390, 2, 1, "", "to_anndata"], [391, 2, 1, "", "to_dataframe"], [392, 2, 1, "", "to_hdf5"], [393, 2, 1, "", "to_json"], [394, 2, 1, "", "to_tsv"], [395, 2, 1, "", "transform"], [396, 2, 1, "", "transpose"], [397, 2, 1, "", "update_ids"], [398, 2, 1, "", "write"]], "skbio.tree": [[400, 1, 1, "", "TreeNode"], [477, 4, 1, "", "bme"], [478, 4, 1, "", "gme"], [479, 4, 1, "", "majority_rule"], [480, 4, 1, "", "nj"], [481, 4, 1, "", "nni"], [482, 4, 1, "", "path_dists"], [483, 4, 1, "", "rf_dists"], [484, 4, 1, "", "upgma"], [485, 4, 1, "", "wrf_dists"]], "skbio.tree.TreeNode": [[400, 2, 1, "", "__copy__"], [400, 2, 1, "", "__deepcopy__"], [400, 2, 1, "", "__getitem__"], [400, 2, 1, "", "__iter__"], [400, 2, 1, "", "__len__"], [400, 2, 1, "", "__str__"], [401, 2, 1, "", "ancestors"], [402, 2, 1, "", "append"], [403, 2, 1, "", "ascii_art"], [404, 2, 1, "", "assign_ids"], [405, 2, 1, "", "assign_supports"], [406, 2, 1, "", "bifurcate"], [407, 2, 1, "", "bipart"], [408, 2, 1, "", "biparts"], [409, 2, 1, "", "cache_attr"], [410, 2, 1, "", "clear_caches"], [411, 2, 1, "", "compare_biparts"], [412, 2, 1, "", "compare_cophenet"], [413, 2, 1, "", "compare_rfd"], [414, 2, 1, "", "compare_subsets"], [415, 2, 1, "", "compare_wrfd"], [416, 2, 1, "", "cophenet"], [417, 2, 1, "", "copy"], [418, 2, 1, "", "count"], [419, 2, 1, "", "create_caches"], [420, 2, 1, "", "deepcopy"], [400, 3, 1, "", "default_write_format"], [421, 2, 1, "", "depth"], [422, 2, 1, "", "distance"], [423, 2, 1, "", "extend"], [424, 2, 1, "", "find"], [425, 2, 1, "", "find_all"], [426, 2, 1, "", "find_by_func"], [427, 2, 1, "", "find_by_id"], [428, 2, 1, "", "from_linkage_matrix"], [429, 2, 1, "", "from_taxdump"], [430, 2, 1, "", "from_taxonomy"], [431, 2, 1, "", "has_caches"], [432, 2, 1, "", "has_children"], [433, 2, 1, "", "height"], [434, 2, 1, "", "index_tree"], [435, 2, 1, "", "insert"], [436, 2, 1, "", "is_bifurcating"], [437, 2, 1, "", "is_root"], [438, 2, 1, "", "is_tip"], [439, 2, 1, "", "lca"], [440, 2, 1, "", "levelorder"], [441, 2, 1, "", "maxdist"], [442, 2, 1, "", "neighbors"], [443, 2, 1, "", "non_tips"], [444, 2, 1, "", "observed_node_counts"], [445, 2, 1, "", "path"], [446, 2, 1, "", "pop"], [447, 2, 1, "", "postorder"], [448, 2, 1, "", "pre_and_postorder"], [449, 2, 1, "", "preorder"], [450, 2, 1, "", "prune"], [451, 2, 1, "", "read"], [452, 2, 1, "", "remove"], [453, 2, 1, "", "remove_by_func"], [454, 2, 1, "", "remove_deleted"], [455, 2, 1, "", "root"], [456, 2, 1, "", "root_at"], [457, 2, 1, "", "root_at_midpoint"], [458, 2, 1, "", "root_by_outgroup"], [459, 2, 1, "", "shear"], [460, 2, 1, "", "shuffle"], [461, 2, 1, "", "siblings"], [462, 2, 1, "", "subset"], [463, 2, 1, "", "subsets"], [464, 2, 1, "", "subtree"], [465, 2, 1, "", "tips"], [466, 2, 1, "", "to_array"], [467, 2, 1, "", "to_taxonomy"], [468, 2, 1, "", "total_length"], [469, 2, 1, "", "traverse"], [470, 2, 1, "", "unpack"], [471, 2, 1, "", "unpack_by_func"], [472, 2, 1, "", "unroot"], [473, 2, 1, "", "unrooted_copy"], [474, 2, 1, "", "unrooted_deepcopy"], [475, 2, 1, "", "unrooted_move"], [476, 2, 1, "", "write"]], "skbio.util": [[486, 1, 1, "", "PlottableMixin"], [487, 4, 1, "", "aliased"], [488, 4, 1, "", "assert_data_frame_almost_equal"], [489, 4, 1, "", "assert_ordination_results_equal"], [490, 4, 1, "", "cardinal_to_ordinal"], [491, 1, 1, "", "classonlymethod"], [492, 1, 1, "", "classproperty"], [493, 4, 1, "", "deprecated"], [494, 4, 1, "", "find_duplicates"], [495, 4, 1, "", "get_data_path"], [496, 4, 1, "", "get_rng"], [497, 4, 1, "", "overrides"], [498, 4, 1, "", "params_aliased"], [499, 4, 1, "", "register_aliases"], [500, 4, 1, "", "safe_md5"]], "skbio.util.PlottableMixin": [[486, 3, 1, "", "png"], [486, 3, 1, "", "svg"]], "skbio.util.classonlymethod": [[491, 2, 1, "", "__get__"]], "skbio.util.classproperty": [[492, 2, 1, "", "__get__"], [492, 2, 1, "", "__set__"]], "skbio.workflow": [[501, 1, 1, "", "Workflow"], [503, 1, 1, "", "method"], [504, 1, 1, "", "requires"]], "skbio.workflow.Workflow": [[501, 2, 1, "", "__call__"], [502, 2, 1, "", "initialize_state"]], "skbio.workflow.method": [[503, 2, 1, "", "__call__"], [503, 3, 1, "", "highest_priority"]], "skbio.workflow.requires": [[504, 2, 1, "", "__call__"]]}, "objnames": {"0": ["py", "module", "Python module"], "1": ["py", "class", "Python class"], "2": ["py", "method", "Python method"], "3": ["py", "attribute", "Python attribute"], "4": ["py", "function", "Python function"], "5": ["py", "data", "Python data"]}, "objtypes": {"0": "py:module", "1": "py:class", "2": "py:method", "3": "py:attribute", "4": "py:function", "5": "py:data"}, "terms": {"": [0, 1, 3, 11, 15, 19, 20, 21, 22, 23, 24, 28, 29, 31, 35, 36, 37, 40, 44, 46, 49, 51, 52, 53, 54, 56, 57, 58, 59, 60, 63, 65, 66, 67, 70, 71, 72, 74, 75, 76, 77, 79, 80, 81, 82, 84, 85, 87, 88, 89, 106, 107, 111, 112, 114, 115, 116, 117, 118, 119, 120, 121, 122, 149, 151, 153, 169, 170, 171, 172, 174, 175, 176, 180, 181, 183, 184, 185, 187, 188, 189, 191, 193, 194, 195, 196, 197, 198, 199, 200, 201, 202, 203, 204, 205, 206, 211, 212, 215, 216, 217, 219, 221, 222, 224, 225, 226, 228, 230, 231, 232, 234, 235, 236, 237, 238, 239, 240, 241, 242, 244, 245, 248, 254, 257, 258, 259, 262, 263, 265, 266, 269, 273, 275, 277, 278, 280, 289, 296, 297, 298, 299, 300, 302, 308, 313, 315, 318, 321, 325, 326, 327, 333, 335, 336, 338, 339, 340, 348, 356, 364, 369, 384, 387, 402, 408, 409, 412, 415, 416, 423, 434, 435, 439, 452, 457, 460, 461, 463, 468, 472, 479, 496, 504, 506, 508, 511, 513], "0": [0, 1, 3, 4, 5, 6, 8, 9, 10, 11, 12, 13, 14, 15, 16, 18, 19, 20, 21, 22, 24, 27, 28, 29, 31, 41, 42, 44, 49, 53, 54, 55, 57, 58, 60, 61, 62, 70, 71, 72, 74, 79, 81, 84, 85, 90, 96, 97, 105, 106, 107, 108, 109, 110, 111, 112, 113, 114, 115, 116, 117, 118, 119, 120, 121, 122, 145, 153, 174, 184, 185, 187, 188, 189, 191, 193, 194, 195, 197, 199, 200, 205, 206, 208, 210, 211, 212, 214, 215, 216, 221, 222, 224, 225, 226, 228, 229, 230, 231, 233, 237, 239, 241, 245, 247, 248, 249, 254, 255, 256, 257, 258, 259, 260, 261, 262, 263, 264, 265, 266, 267, 268, 269, 270, 271, 272, 273, 274, 275, 276, 277, 278, 283, 286, 287, 289, 294, 295, 296, 297, 298, 299, 300, 301, 302, 304, 305, 310, 318, 319, 321, 326, 330, 331, 334, 336, 337, 338, 339, 340, 341, 342, 345, 346, 347, 348, 349, 351, 355, 356, 359, 362, 363, 364, 365, 366, 368, 369, 373, 374, 379, 380, 381, 382, 384, 386, 387, 388, 389, 391, 392, 394, 395, 397, 399, 402, 404, 405, 406, 407, 408, 409, 410, 411, 412, 413, 414, 415, 416, 417, 420, 421, 422, 423, 425, 431, 433, 435, 436, 439, 441, 445, 446, 450, 452, 453, 454, 456, 457, 458, 459, 460, 462, 463, 464, 466, 468, 470, 471, 472, 473, 474, 475, 477, 478, 479, 480, 481, 482, 483, 484, 485, 490, 496, 503, 506, 508, 511, 513], "00": [1, 20, 106, 107, 111, 114, 117, 174, 187, 224, 229, 508], "000": 87, "000000": 1, "000000e": [106, 107], "000123": 120, "000532": 319, "00064": 340, "001": [259, 336], "001562": 319, "00176": 339, "0019": 496, "0031": 305, "007022633956606": 305, "007446": 264, "0082138": [19, 41], "01": [117, 300, 331, 336], "0118478282382": 305, "0123": 120, "0123456789": 149, "012631": 319, "015": [269, 275], "02": [117, 122, 259, 477, 478, 481], "020131": 264, "0220": [269, 275], "0225": 305, "029747": 319, "03": 117, "0301": 305, "03296": 300, "0341": 305, "036910": 264, "0378111988903307": 108, "039": 339, "03t14": 359, "04": 117, "043888": 264, "044": 336, "044805": 319, "048219": 264, "05": [1, 117, 259, 264, 304, 336, 337, 339, 340, 488], "053": 339, "057": 339, "06": [117, 340, 359], "0625": 268, "0633": 305, "065613": 264, "068310": 264, "069": 339, "07": 117, "072": 336, "0721": 305, "076": 336, "08": [117, 120], "083071": 121, "0874": 305, "0898": 305, "09": 117, "09392265": 1, "09861229": 257, "0i": 259, "0th": [375, 490], "1": [0, 1, 3, 4, 5, 6, 8, 9, 10, 11, 13, 14, 15, 18, 19, 20, 21, 22, 23, 24, 27, 28, 29, 31, 35, 36, 37, 38, 39, 40, 41, 43, 44, 45, 46, 47, 48, 49, 50, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 71, 72, 73, 74, 75, 76, 77, 78, 79, 80, 81, 84, 85, 87, 104, 105, 106, 107, 108, 110, 111, 112, 113, 114, 115, 116, 117, 118, 119, 120, 121, 122, 125, 126, 149, 151, 153, 156, 158, 174, 184, 185, 188, 189, 191, 192, 193, 194, 195, 200, 207, 210, 214, 215, 216, 221, 222, 225, 226, 228, 229, 230, 233, 235, 236, 237, 241, 245, 247, 248, 249, 251, 255, 256, 257, 258, 259, 260, 261, 262, 263, 264, 265, 266, 267, 268, 269, 270, 271, 272, 273, 275, 276, 277, 278, 283, 285, 286, 287, 289, 291, 292, 295, 296, 297, 298, 299, 300, 301, 302, 304, 310, 314, 317, 318, 319, 321, 325, 326, 330, 331, 332, 333, 334, 336, 338, 339, 340, 341, 342, 345, 346, 347, 348, 349, 352, 355, 356, 358, 359, 362, 363, 364, 365, 366, 368, 369, 373, 374, 376, 379, 380, 381, 382, 384, 386, 387, 388, 389, 391, 392, 394, 395, 397, 399, 405, 409, 412, 413, 415, 416, 421, 422, 425, 429, 430, 433, 435, 441, 446, 457, 460, 466, 467, 468, 470, 471, 472, 477, 478, 479, 480, 481, 482, 483, 484, 485, 490, 493, 496, 508, 511, 513], "10": [19, 23, 41, 44, 61, 62, 74, 96, 97, 107, 110, 111, 112, 113, 114, 116, 117, 118, 149, 151, 156, 184, 185, 195, 200, 215, 216, 221, 222, 228, 259, 264, 269, 275, 300, 319, 336, 339, 340, 342, 345, 348, 349, 353, 369, 373, 477, 478, 480, 481, 513], "100": [1, 106, 107, 111, 114, 156, 259, 264, 340, 364, 388, 513], "1000": [156, 318], "1004": 305, "1004075": [269, 275], "100548": 319, "1007": [110, 269, 275], "101": 264, "10136628": 262, "102": 264, "1024": 109, "103": 264, "104": [121, 264], "1048576": 500, "104937": 319, "1055": 305, "10596": 107, "106": 457, "106652702761034136": [477, 478, 481], "1089": [477, 478, 481], "10915": [37, 40, 248], "10919": [37, 40, 248], "1093": [112, 480], "10937312": 1, "11": [0, 16, 19, 37, 40, 41, 47, 52, 53, 106, 110, 117, 119, 174, 184, 221, 232, 259, 264, 269, 275, 305, 319, 326, 333, 340, 345, 348, 349, 369, 415, 480, 482], "110": 264, "1115": 64, "112": 382, "1126": 64, "113": [58, 74, 336], "1131255": 500, "114": 106, "1154": 305, "116": 305, "1167": 326, "117": 296, "11704769": 265, "117693430600200007": 53, "1179": 326, "119": [415, 485], "11th": 118, "12": [1, 110, 117, 228, 259, 264, 269, 348, 349, 382, 508], "120": [114, 264], "120492524415": 511, "1215": 305, "123": [120, 171, 318, 339, 340], "12345": [111, 171, 228], "12487758": [477, 478, 481], "126": [112, 412, 415, 485], "128": 264, "13": [0, 48, 71, 77, 107, 111, 117, 119, 184, 195, 215, 221, 228, 259, 264, 319, 336, 348, 349, 392, 412, 482], "131": [71, 77, 413, 483], "131567": 122, "1345": 45, "1347": 45, "135": [107, 269, 275], "1371": [19, 41, 269, 275], "139": 121, "14": [1, 48, 60, 70, 110, 112, 117, 185, 197, 200, 216, 222, 259, 264, 305, 336, 349, 416, 422], "1409": 484, "14092516": 266, "141": [70, 412], "14131": 412, "142857": 301, "14285714": 271, "142857142857": 379, "143": 296, "1435": 111, "1438": 484, "144": 77, "1457": 304, "1468": 304, "147": [38, 413, 483], "1495": 110, "149855": 111, "1499": 110, "15": [19, 37, 40, 60, 107, 117, 120, 305, 336, 339, 340, 349, 416, 485], "1535": 405, "1542": [107, 405], "156": 55, "1566": 107, "1576": [84, 85], "15800534": 106, "1585": [84, 85], "16": [1, 51, 70, 108, 111, 112, 113, 117, 118, 210, 214, 232, 264, 321, 340, 345, 349, 415, 416, 441, 485], "16025641": 1, "161": 106, "16247744": 260, "1627907": 1, "163": [49, 59, 75, 77], "16441": 415, "164998": 264, "165": 70, "168": 45, "169": [84, 85], "17": [51, 53, 84, 85, 110, 117, 184, 221, 319, 336, 349, 496], "170768970": 106, "172": [84, 85], "1740": 110, "17445763": 260, "1767": 112, "1771": 112, "1786181": 107, "18": [107, 117, 121, 296, 336, 415, 477, 478, 481, 508], "1800": 110, "1814": 41, "182343": 264, "1859": 110, "1875": 268, "18761279": 260, "19": [1, 110, 117, 336, 340, 348, 477, 478, 481, 482, 496], "1907511": 110, "1912": 55, "1913": 42, "192": 121, "19234468": 113, "193": 44, "194": 70, "1943": 54, "1948": 74, "1949": [49, 59, 75, 77], "195": 38, "1953": [43, 56], "1955": 55, "1956": 46, "1958": [63, 484], "1961": 72, "1962": [412, 416], "1966": [71, 77, 331], "1967": [64, 298], "1968": 73, "1970": [35, 45], "1971": [51, 75], "1972": 457, "1973": 58, "1974": [57, 65], "1976": 60, "1978": 248, "1979": [415, 485], "1981": [38, 413, 479, 483], "1983": 52, "1984": [47, 184, 195, 215, 221, 228], "1985": [111, 184, 195, 215, 221, 228], "1986": [111, 116, 118, 326], "1987": [67, 480], "1988": 81, "199": 113, "1990": [106, 107, 110], "1991": 110, "1992": [37, 40, 44, 53, 70, 248, 276], "1993": [44, 296, 297, 412], "1994": 415, "1995": 326, "1997": [53, 121, 412, 480, 482], "1998": [60, 319, 325, 326, 328, 329, 332, 333], "1d": [20, 27, 74, 82, 95, 96, 97, 98, 99, 184, 185, 196, 198, 200, 201, 206, 213, 215, 216, 219, 221, 222, 228, 230, 231, 232, 234, 235, 239, 240, 241, 242, 244, 245], "1e": [107, 116, 488], "1e51ca3a5450c43524b9185c236cc5cc": 110, "1e9": 120, "1st": [20, 316, 490], "1x1": 118, "2": [0, 1, 3, 4, 5, 6, 9, 10, 11, 16, 18, 19, 20, 21, 22, 23, 25, 27, 28, 29, 31, 35, 36, 37, 38, 39, 40, 43, 44, 47, 49, 51, 53, 55, 58, 59, 60, 61, 62, 64, 65, 67, 70, 72, 74, 75, 77, 81, 84, 85, 86, 105, 106, 107, 108, 110, 111, 112, 113, 114, 116, 117, 118, 119, 120, 121, 122, 126, 151, 153, 156, 158, 174, 176, 184, 185, 189, 191, 193, 194, 200, 210, 212, 214, 216, 222, 226, 228, 229, 230, 232, 233, 234, 235, 237, 245, 247, 248, 251, 256, 257, 258, 259, 260, 261, 262, 263, 264, 265, 267, 268, 269, 270, 271, 272, 273, 275, 276, 277, 278, 283, 287, 289, 291, 295, 296, 297, 298, 299, 300, 301, 302, 304, 305, 318, 319, 321, 325, 326, 328, 331, 333, 336, 338, 339, 340, 341, 342, 345, 346, 347, 348, 349, 352, 353, 356, 358, 359, 364, 371, 372, 373, 376, 379, 382, 388, 390, 391, 392, 395, 397, 399, 405, 409, 412, 413, 415, 416, 417, 420, 421, 422, 423, 427, 429, 430, 433, 435, 441, 456, 457, 458, 460, 466, 467, 468, 470, 471, 472, 473, 474, 475, 479, 480, 482, 483, 484, 485, 490, 493, 496, 506, 508, 511, 513], "20": [0, 3, 117, 174, 215, 259, 264, 321, 328, 336, 339, 340, 364], "200": [113, 264], "2000": [44, 340, 480], "2001": 299, "2002": [23, 53, 70, 80, 107, 111, 477, 478, 481], "2003": [111, 256], "2004": 66, "2005": [84, 110], "2006": [53, 58, 74, 300, 416, 422, 480], "2007": [70, 84, 85], "2008": [111, 118], "2009": [112, 113, 304], "201": [44, 264], "2010": [53, 84, 85, 112], "2011": [61, 62, 70, 84, 85, 331], "2012": [70, 113, 122, 298, 342, 399], "2013": [19, 41, 51, 70, 273, 321, 413], "2014": [19, 41, 106, 118, 264, 273, 359], "2015": [23, 256, 259, 269, 275], "2016": [70, 269, 275], "2017": 405, "2018": 122, "202": 264, "2020": 122, "2022": 122, "2024": 120, "203": 264, "20309816": 305, "204": 336, "205": 297, "206": 336, "207": 70, "209": [110, 113, 298], "21": [110, 117, 259, 269, 275, 329, 348, 364, 395, 481], "210": 44, "2106": 70, "2107852473": 267, "2113": 70, "2130": 107, "21383822": 263, "215": [106, 107], "217": 44, "21712454": 321, "2186": 305, "219": [107, 110, 297], "22": [37, 40, 117, 122, 248, 259, 364, 508], "220": 298, "22054469": 266, "2208": 305, "2214": 107, "227": [44, 111], "23": [1, 117, 120, 121, 192, 259, 348, 364, 413, 480, 508], "23059566": 272, "23632778": 263, "2364": 305, "237": [43, 56, 80], "238327": 319, "239": 479, "23e": 120, "24": [0, 107, 117, 248, 359, 364], "24270353": 1, "245": 300, "246": [44, 80, 121], "24714631": 272, "25": [0, 1, 27, 38, 53, 60, 70, 84, 85, 87, 110, 116, 117, 187, 191, 211, 224, 231, 233, 237, 241, 259, 270, 296, 297, 300, 305, 336, 339, 340, 379, 484, 508], "2500": 340, "253": 300, "255": [19, 247, 326], "256": 73, "257": 73, "25737316": 272, "2580": 331, "259": 121, "2594": 331, "25th": 259, "26": [51, 107, 116, 259, 299, 304, 321], "260656459": 113, "26118259": 263, "262": 60, "264": [43, 56], "26433692": 1, "26488486": 272, "265": 47, "27": [0, 53, 74, 84, 85, 107, 215, 269, 298, 485], "270": 47, "272": 339, "2761": 305, "278": 53, "28": [0, 70, 117], "285714": 300, "28571429": 271, "28865141": 263, "289": 326, "28ecologi": 43, "29": [43, 110, 112, 113, 336], "293463": 264, "29597001": 305, "29672718": 266, "2_": 44, "2a": 118, "2b": 55, "2d": [19, 35, 36, 37, 38, 39, 40, 59, 82, 86, 87, 90, 95, 97, 99, 247, 249, 252, 267, 302, 327, 334], "2e": 120, "2f_2": 47, "2m5p3d1i": [16, 18], "2nd": [20, 316, 368, 490], "2nf_2": 52, "2x2": [1, 115, 373, 379], "2x3": [355, 356, 362, 363, 365, 366, 368, 374, 380, 381, 384, 386, 387, 389, 394, 395, 397], "3": [1, 3, 4, 5, 6, 9, 10, 18, 19, 20, 21, 22, 24, 27, 28, 29, 31, 32, 35, 39, 43, 44, 52, 53, 56, 61, 62, 63, 70, 74, 80, 84, 85, 96, 105, 106, 107, 108, 110, 111, 112, 113, 114, 116, 117, 118, 119, 120, 121, 122, 149, 151, 153, 158, 174, 185, 188, 189, 191, 193, 194, 199, 200, 210, 214, 215, 216, 222, 225, 226, 228, 229, 230, 236, 237, 239, 244, 245, 255, 256, 257, 258, 260, 262, 263, 264, 265, 266, 267, 269, 270, 271, 272, 275, 277, 278, 283, 287, 289, 294, 295, 296, 297, 298, 299, 300, 301, 302, 304, 305, 306, 309, 310, 316, 318, 319, 320, 321, 325, 326, 331, 336, 338, 339, 340, 341, 345, 346, 347, 348, 349, 351, 352, 355, 356, 359, 362, 363, 364, 365, 366, 368, 369, 371, 373, 374, 376, 379, 380, 381, 382, 384, 386, 387, 388, 389, 390, 391, 392, 394, 395, 397, 399, 402, 406, 407, 408, 409, 410, 411, 412, 413, 414, 415, 416, 417, 421, 422, 423, 429, 430, 431, 433, 435, 436, 439, 441, 445, 446, 450, 452, 453, 454, 456, 457, 458, 459, 460, 462, 463, 464, 466, 467, 468, 470, 471, 472, 473, 475, 480, 482, 483, 484, 485, 490, 496, 508, 511, 513], "30": [0, 107, 113, 114, 117, 119, 339, 340, 369], "3021": [184, 195, 215, 221, 228], "30216948": 260, "3030": [184, 195, 215, 221, 228], "30409883": 262, "306": [412, 482], "30870431": 1, "30927835": 1, "31": 107, "312": [121, 412, 482], "314": 110, "32": [117, 299, 336], "32495488": 260, "325": 331, "32630": 113, "329": 106, "33": [20, 22, 53, 84, 85, 112, 199, 264, 297, 300, 331, 336, 339, 412, 416, 508], "330": 106, "33333333333333331": 1, "335928": 122, "338": [331, 336], "34": [113, 119, 405, 477, 478, 481], "34180297": 266, "343": 113, "344": 113, "3447015": 480, "345": 248, "34891526": 260, "34989": 111, "35": [1, 110, 112, 113, 119, 256, 340, 477, 478, 481], "3519": 305, "352": 248, "354": 305, "355": [110, 305], "356": 305, "36": [63, 117, 120, 269, 275], "363": [58, 74], "36463": 121, "36514837": 273, "37": [84, 121], "3716": 305, "375": [58, 74, 268], "379": 74, "379593": 500, "38": [0, 106, 112, 117, 484], "38629436": 257, "388": 340, "3899": 110, "39": [73, 111, 117, 273, 336], "392": 336, "3937": 45, "397": 336, "3e": [106, 107, 336, 340], "3f": 304, "3k1v_a": 113, "3rd": [298, 316, 490, 513], "3x2": 373, "3x3": [276, 298, 301, 302, 482, 485], "4": [0, 1, 3, 5, 9, 20, 21, 24, 25, 29, 42, 43, 44, 51, 53, 56, 70, 72, 75, 84, 85, 110, 111, 113, 116, 117, 118, 120, 121, 122, 149, 151, 153, 158, 174, 175, 184, 188, 189, 191, 194, 210, 214, 225, 226, 228, 229, 233, 236, 245, 247, 248, 257, 258, 259, 260, 261, 262, 263, 264, 265, 267, 268, 271, 272, 273, 275, 278, 283, 289, 295, 296, 298, 304, 319, 325, 326, 331, 333, 336, 341, 345, 346, 347, 349, 352, 353, 359, 363, 364, 373, 382, 386, 387, 391, 392, 409, 412, 413, 415, 416, 421, 422, 429, 430, 433, 435, 441, 457, 460, 466, 467, 468, 470, 471, 479, 482, 483, 485, 496, 508, 511], "40": [1, 43, 56, 111, 120, 122, 273, 338, 340, 359, 364, 412, 416], "400": 297, "402": 53, "403": [106, 107], "40824829": [273, 274], "41": [111, 117, 364], "410": [106, 107], "4140": 305, "4148": [49, 59, 75, 77], "416": 336, "42": [1, 29, 54, 111, 117, 118, 120, 184, 221, 231, 296, 297, 300, 304, 336, 340, 355, 356, 362, 363, 364, 365, 366, 368, 374, 380, 381, 382, 384, 389, 394, 395, 397, 412, 460, 496], "423": 74, "42512039": 1, "427": 58, "42857143": 271, "43": [29, 67, 117, 364, 384, 389, 479], "431": 70, "432": 58, "4375": 268, "44": [1, 71, 300, 364, 479], "443": 35, "444": 70, "45": [1, 117, 120, 336, 340], "450": 297, "456": 325, "459": 415, "45995501": 321, "46": [117, 299, 336, 368, 384, 389, 412, 482], "4603377592": 114, "4603378712": 114, "4604421736": 114, "462339": 264, "466911": 319, "467481": 264, "46774194": 1, "468": 415, "4693": 111, "47": [117, 389], "479": 81, "48": [35, 64, 336], "480232": 264, "487": 81, "49": [0, 114, 117], "4hh": 110, "4x4": [296, 297, 416, 483], "5": [0, 1, 3, 5, 6, 9, 10, 18, 19, 22, 29, 36, 39, 41, 43, 48, 53, 55, 70, 84, 85, 87, 90, 105, 107, 110, 111, 112, 113, 116, 118, 121, 122, 149, 185, 193, 195, 200, 205, 206, 210, 211, 212, 214, 216, 222, 228, 229, 230, 233, 237, 245, 248, 254, 259, 264, 268, 270, 276, 278, 289, 295, 296, 297, 300, 301, 304, 319, 326, 331, 336, 339, 340, 341, 342, 345, 346, 347, 348, 349, 359, 364, 372, 373, 382, 391, 395, 399, 405, 409, 412, 414, 415, 416, 418, 421, 422, 429, 430, 433, 435, 441, 445, 457, 460, 466, 467, 468, 477, 478, 479, 480, 481, 482, 484, 485, 488, 511], "50": [1, 20, 37, 40, 111, 114, 117, 174, 229, 259, 264, 305, 321, 339, 340, 356, 508], "500": [339, 340], "5007512": 321, "50th": [111, 259], "512": 336, "5192213": 482, "52": [51, 75, 81, 117, 339], "52199973": 305, "528243": 264, "53": [35, 117, 331, 336, 413, 483], "530": 297, "533729": 264, "5338": 53, "54": [57, 58, 85, 111, 477, 478, 481], "547": 72, "54772256": 273, "55": [117, 197, 300, 305, 477, 478, 481], "55152525": 121, "555": 57, "556061": 264, "5565": 107, "557": 57, "5587": 107, "56": [70, 197], "560": 65, "562": 72, "5671": 107, "57": [107, 117, 326, 369], "577": [51, 75], "58": [54, 117], "581": 110, "586": [51, 75], "59": 112, "5917809": 262, "594590": 264, "595": 336, "5990": 121, "5996": 121, "5e": 120, "5f": [339, 340], "6": [1, 3, 4, 5, 6, 9, 10, 24, 43, 47, 48, 53, 61, 62, 70, 73, 74, 79, 84, 85, 107, 110, 111, 112, 113, 120, 121, 122, 195, 210, 214, 229, 232, 233, 244, 245, 259, 261, 266, 268, 269, 271, 289, 294, 295, 296, 298, 299, 300, 301, 302, 304, 318, 319, 331, 336, 338, 339, 340, 345, 348, 349, 359, 364, 373, 379, 382, 402, 405, 406, 407, 408, 409, 410, 411, 412, 413, 414, 415, 416, 417, 420, 421, 422, 423, 430, 431, 433, 435, 436, 439, 441, 445, 446, 450, 452, 453, 454, 456, 457, 458, 459, 460, 462, 463, 464, 466, 467, 468, 470, 471, 472, 473, 474, 475, 479, 480, 482, 483, 485, 496, 508], "60": [108, 109, 110, 114, 305, 339, 364], "601277": 264, "6018555": 298, "606e": 336, "607": 305, "609": 110, "61": [117, 300, 336, 364], "619": 121, "62": [53, 84, 85, 108, 109, 112, 300, 364, 477, 478, 481, 508], "6212": 121, "6216": 305, "6234": 121, "627677": 264, "63": [107, 117, 364], "634": 305, "636": 336, "64": [1, 87, 112, 120, 191, 364, 471], "641": 121, "645": 457, "65": 305, "65463348": 321, "66": [111, 113, 117, 199, 296, 300, 508], "6666666666666666": 511, "668": 457, "669": 413, "67": [111, 113, 117, 199, 210, 214, 326, 508], "670816": 300, "68": [113, 305], "6821": 107, "68235294": 1, "68339802": 265, "684": [340, 413], "687": [477, 478, 481], "688": [49, 59, 75, 77, 340], "69": 117, "6913": 305, "692": 53, "6928": 107, "69314718": 257, "694": 53, "6e": 107, "6x6": [1, 300], "7": [1, 38, 48, 70, 87, 111, 112, 113, 121, 122, 149, 151, 153, 158, 184, 193, 221, 228, 229, 264, 289, 297, 298, 300, 301, 304, 319, 336, 342, 345, 348, 349, 382, 399, 409, 412, 417, 430, 456, 457, 464, 466, 467, 473, 480, 482, 485, 489, 508], "70": 117, "702656": 264, "704": 336, "705": [477, 478, 481], "70710678": [273, 274], "707221": 264, "71": [63, 84, 117, 121], "7113092": 482, "71131": 412, "712": 339, "714286": 297, "71597633": 1, "72": 70, "73": [84, 85], "735": 336, "74": 117, "74166": 415, "75": [1, 27, 53, 60, 84, 85, 239, 259, 276, 297, 300, 336, 379, 382, 471, 484], "750792": 264, "7559": 298, "755929": 301, "75th": 259, "76": [66, 70, 111, 117], "77": [66, 300], "7715": 305, "771517": 297, "77549923": 1, "7768362": 265, "78": [117, 471], "78142077": 1, "783e": 340, "78787879": 1, "79": [111, 114, 117], "793": 67, "79451346": 262, "796": 336, "8": [0, 1, 4, 41, 106, 107, 112, 113, 118, 121, 122, 126, 158, 187, 195, 224, 229, 233, 244, 269, 275, 289, 297, 304, 319, 336, 340, 341, 345, 348, 349, 353, 382, 409, 412, 415, 430, 467, 468, 480, 482, 485, 508, 511], "80": [44, 111, 319, 339, 340, 364, 405, 471, 513], "803": 67, "80332382": 321, "81": 364, "810": 297, "811": 107, "81521739": 1, "81649658": [273, 274], "818": 60, "82": [107, 108, 121, 364], "820": 60, "8228": 84, "8235": 84, "82857143": 1, "82967033": 1, "83": [105, 364, 399], "8304": 305, "832": 304, "84": 364, "844": 336, "8468": 107, "85": [110, 117, 340, 471], "8547619": 1, "8552": 107, "857142857143": 379, "85714286": 1, "86": [184, 221], "86111111": 1, "86666667": 1, "86813187": 1, "87": [44, 117], "874": 340, "87434209": 482, "87709497": 1, "87777778": 1, "88": [121, 300], "884420": 359, "884498": 264, "888": 336, "889": 336, "89": [37, 40, 113, 248], "89285714": 1, "898": 340, "8e": 107, "9": [1, 106, 107, 108, 111, 114, 117, 120, 121, 145, 149, 151, 184, 185, 195, 197, 200, 215, 216, 221, 222, 228, 259, 264, 304, 305, 319, 325, 326, 328, 329, 332, 333, 336, 340, 345, 348, 349, 409, 416, 418, 430, 467, 468, 477, 478, 479, 480, 481, 508], "90": [23, 114, 264, 513], "900": 156, "905": 52, "909": 107, "912": 52, "916": 336, "91769271": 321, "92": 297, "9223372036854775807": 503, "9223489": 121, "922404392093": 1, "9230769230": 255, "93": 112, "936": 336, "939336": 1, "94": [107, 117], "948": 336, "95": [48, 52, 53, 61, 112, 117, 405], "951": 457, "952": 339, "95224719": 1, "96": [48, 114], "964": [336, 340], "97": [117, 264], "978387": 264, "984": 336, "98435423": 1, "986": 340, "98796148": 1, "99": [106, 107, 110, 117, 296, 300, 304, 382], "991987": 264, "996": 336, "999": [1, 228, 296, 298, 299, 300, 301, 304], "999887756453524252": 121, "9e": 106, "A": [1, 18, 19, 20, 25, 27, 28, 29, 30, 33, 35, 37, 40, 44, 47, 52, 53, 54, 55, 57, 58, 60, 61, 62, 66, 70, 72, 74, 84, 85, 87, 93, 101, 102, 103, 104, 106, 108, 110, 111, 112, 113, 115, 116, 118, 119, 120, 121, 130, 134, 135, 140, 147, 148, 149, 152, 156, 157, 173, 176, 184, 186, 191, 195, 197, 204, 209, 215, 218, 221, 223, 228, 233, 243, 245, 247, 248, 251, 256, 257, 258, 259, 260, 261, 262, 263, 264, 265, 266, 267, 268, 269, 270, 271, 272, 273, 275, 276, 277, 278, 281, 283, 284, 286, 288, 289, 291, 293, 294, 296, 297, 298, 299, 300, 301, 302, 304, 307, 310, 314, 318, 320, 321, 322, 323, 326, 331, 333, 338, 339, 340, 341, 342, 346, 347, 348, 352, 357, 358, 359, 360, 368, 375, 381, 383, 384, 385, 386, 387, 388, 391, 392, 393, 395, 400, 405, 407, 408, 412, 415, 417, 420, 426, 427, 428, 434, 437, 442, 451, 453, 454, 456, 457, 458, 462, 463, 468, 471, 472, 473, 474, 479, 482, 483, 484, 485, 486, 493, 496, 504, 506, 511, 513], "AS": 121, "AT": [22, 111, 112, 118], "And": [114, 184, 215, 270, 508], "As": [1, 110, 113, 116, 120, 228, 277, 285, 298, 300, 326, 424, 506, 513], "At": [120, 123, 348], "Be": 228, "But": [427, 458], "By": [29, 60, 70, 82, 86, 111, 113, 120, 259, 302, 330, 334, 358, 370, 413, 458, 462, 481, 501], "For": [1, 20, 23, 30, 34, 41, 70, 93, 94, 107, 108, 109, 110, 111, 112, 113, 114, 115, 116, 117, 118, 119, 120, 121, 123, 151, 156, 157, 158, 159, 176, 184, 186, 190, 195, 215, 218, 220, 221, 223, 227, 228, 243, 246, 248, 259, 264, 284, 290, 296, 297, 298, 299, 300, 302, 304, 306, 316, 321, 322, 324, 325, 326, 331, 336, 338, 339, 340, 342, 348, 353, 354, 375, 383, 388, 398, 399, 405, 407, 408, 413, 416, 451, 462, 463, 476, 479, 481, 496, 506, 508, 511], "IF": 375, "IN": 121, "If": [1, 4, 6, 10, 11, 16, 18, 19, 20, 21, 23, 24, 27, 28, 29, 30, 31, 32, 33, 35, 36, 37, 39, 41, 44, 47, 48, 49, 51, 53, 54, 55, 59, 61, 67, 70, 74, 75, 76, 82, 84, 85, 86, 87, 90, 93, 96, 100, 101, 102, 103, 106, 109, 111, 114, 115, 116, 117, 118, 119, 120, 121, 123, 124, 125, 126, 127, 131, 133, 136, 138, 141, 142, 145, 149, 150, 151, 157, 158, 164, 165, 166, 176, 177, 178, 181, 182, 184, 185, 186, 193, 195, 197, 200, 208, 210, 212, 213, 214, 215, 216, 218, 221, 222, 223, 225, 226, 228, 229, 230, 231, 233, 234, 235, 236, 237, 238, 239, 240, 241, 242, 243, 245, 248, 249, 254, 255, 259, 261, 264, 265, 266, 268, 274, 277, 278, 280, 281, 282, 283, 284, 286, 289, 293, 294, 296, 297, 298, 299, 300, 301, 302, 304, 310, 312, 317, 318, 320, 321, 322, 323, 325, 326, 327, 330, 331, 333, 334, 336, 337, 338, 339, 340, 341, 342, 343, 345, 348, 349, 351, 352, 353, 356, 357, 358, 359, 363, 364, 365, 366, 368, 369, 370, 371, 372, 373, 374, 375, 376, 378, 379, 381, 382, 383, 384, 385, 388, 389, 390, 391, 392, 393, 394, 395, 397, 402, 405, 407, 408, 409, 412, 413, 415, 416, 418, 419, 421, 422, 424, 425, 427, 429, 431, 433, 435, 439, 444, 446, 450, 451, 456, 457, 458, 459, 460, 462, 463, 465, 466, 467, 468, 469, 470, 472, 473, 474, 475, 479, 480, 482, 483, 484, 485, 487, 488, 489, 490, 492, 496, 497, 506], "In": [1, 3, 19, 20, 23, 53, 70, 72, 84, 85, 87, 111, 112, 113, 114, 116, 118, 122, 176, 184, 193, 212, 215, 221, 247, 256, 259, 264, 276, 297, 298, 304, 318, 325, 326, 336, 340, 345, 400, 405, 407, 409, 415, 416, 424, 436, 456, 457, 458, 459, 472, 479, 481, 485, 506, 508, 511, 513], "It": [1, 3, 19, 41, 42, 43, 49, 53, 54, 56, 58, 59, 60, 67, 70, 72, 74, 75, 79, 81, 105, 106, 108, 111, 112, 113, 114, 116, 118, 120, 122, 126, 137, 149, 151, 152, 153, 155, 156, 158, 184, 195, 205, 206, 215, 221, 224, 259, 262, 264, 268, 276, 294, 298, 299, 302, 304, 308, 309, 313, 315, 317, 325, 326, 330, 333, 336, 339, 340, 356, 395, 400, 408, 409, 413, 416, 422, 440, 447, 448, 449, 463, 464, 473, 475, 480, 481, 482, 485, 488, 496, 500, 504, 508], "Its": [7, 333], "NOT": [19, 145], "No": [20, 48, 106, 107, 110, 119, 122, 151, 228, 298], "Not": [112, 184, 245, 300], "ONE": [19, 41], "OR": 20, "Of": 113, "On": [72, 331, 413], "One": [53, 118, 123, 182, 264, 292, 407, 409, 410, 413, 416, 431, 442, 480, 482, 483, 485, 506], "Or": [409, 506], "That": [71, 77, 116, 238, 417, 453, 454, 463], "The": [0, 1, 3, 4, 5, 6, 7, 11, 15, 16, 18, 19, 21, 22, 23, 24, 25, 29, 30, 34, 35, 36, 37, 38, 39, 40, 41, 42, 43, 44, 47, 48, 51, 53, 54, 55, 56, 58, 59, 60, 67, 70, 71, 73, 74, 75, 77, 79, 80, 82, 84, 85, 86, 87, 88, 89, 90, 91, 93, 94, 95, 96, 97, 98, 99, 101, 104, 105, 106, 107, 108, 109, 110, 111, 112, 113, 114, 115, 116, 117, 118, 119, 120, 121, 122, 123, 124, 125, 126, 127, 129, 131, 132, 133, 134, 135, 136, 137, 138, 139, 141, 142, 143, 145, 146, 149, 151, 152, 153, 154, 155, 156, 157, 159, 162, 164, 169, 170, 171, 172, 174, 175, 176, 177, 178, 180, 181, 182, 183, 186, 189, 190, 191, 192, 193, 194, 197, 210, 214, 218, 220, 221, 223, 226, 227, 228, 229, 230, 231, 233, 234, 235, 236, 237, 243, 245, 246, 247, 254, 255, 256, 257, 258, 259, 261, 262, 263, 264, 265, 266, 268, 270, 272, 273, 274, 277, 278, 281, 284, 289, 290, 291, 292, 293, 294, 295, 296, 297, 298, 299, 300, 302, 304, 305, 307, 310, 312, 314, 317, 318, 320, 322, 324, 325, 326, 330, 331, 332, 333, 336, 337, 338, 339, 340, 342, 343, 344, 345, 346, 347, 348, 349, 352, 355, 357, 358, 360, 361, 362, 363, 364, 365, 368, 370, 371, 372, 373, 374, 375, 376, 378, 379, 381, 382, 383, 384, 385, 386, 387, 388, 389, 392, 394, 395, 396, 398, 399, 400, 401, 402, 404, 406, 407, 408, 409, 410, 411, 412, 413, 414, 415, 416, 417, 418, 419, 421, 422, 423, 424, 425, 426, 427, 429, 430, 431, 433, 434, 435, 436, 439, 440, 441, 442, 443, 446, 447, 448, 449, 450, 451, 452, 453, 454, 455, 456, 457, 458, 459, 460, 461, 462, 463, 465, 466, 468, 469, 472, 473, 475, 476, 477, 479, 480, 481, 482, 483, 484, 485, 488, 492, 495, 496, 497, 501, 506, 508, 511, 513], "Then": [1, 3, 259, 270, 305, 319], "There": [1, 29, 54, 67, 107, 113, 116, 119, 199, 291, 339, 340, 348, 373, 400, 472, 475, 506, 511, 513], "These": [0, 1, 20, 22, 43, 53, 84, 85, 113, 116, 120, 121, 122, 162, 171, 172, 174, 175, 253, 301, 303, 320, 332, 338, 342, 373, 406, 407, 436], "To": [1, 20, 53, 84, 85, 111, 112, 113, 116, 119, 120, 123, 145, 176, 184, 215, 221, 259, 264, 291, 295, 296, 298, 300, 304, 336, 405, 472, 487, 506, 513], "Will": [27, 139, 143, 145, 279, 288, 320, 341], "With": [106, 256, 268, 496], "_": [44, 108, 111, 112, 116, 121, 153, 228, 276, 298, 380, 481], "_1": 116, "__": 113, "____________1______________2_________": 121, "________________": 121, "____________________": 121, "__bool__": [20, 228], "__call__": [19, 501, 503, 504], "__contains__": [20, 228, 277], "__copy__": [20, 151, 160, 171, 174, 228, 400], "__deepcopy__": [20, 151, 160, 171, 174, 228, 400], "__eq__": [20, 149, 151, 160, 162, 171, 174, 176, 191, 228, 277, 342], "__get__": [491, 492], "__getitem__": [11, 20, 228, 277, 342, 400], "__init__": [123, 125, 127], "__iter__": [20, 28, 228, 342, 400], "__len__": [20, 228, 400], "__locat": 113, "__name__": 499, "__ne__": [20, 149, 151, 160, 162, 171, 174, 176, 191, 228, 277, 342], "__reversed__": [20, 28, 228], "__set__": 492, "__setstate__": [11, 19], "__str__": [3, 11, 14, 20, 91, 95, 98, 191, 228, 277, 320, 342, 400], "_block_comput": 87, "_ci": 43, "_dna": 20, "_except": 118, "_interval_tre": 151, "_io": [105, 109], "_is_stale_tre": 151, "_leaf_index": 434, "_myformat_sniff": 123, "_myformat_to_some_skbio_class": 123, "_not_": 348, "_rebuild_tre": 151, "_setup_debug_trac": 502, "_some_skbio_class_to_myformat": 123, "_tree": 479, "aT": 112, "a_1": 116, "aa": [28, 111, 113, 118, 191], "aaa": [121, 235], "aaaaaaaaa": 110, "aaaaaaaaaa": 110, "aaaaaaattttttt": 513, "aaaaaactctctaaactcactaaggctctctacccctcttcagagaagtcga": 0, "aaaaaccgat": 110, "aaaataaata": 110, "aaacaaacca": 110, "aaaccattgc": [111, 118], "aaacccttgc": [111, 118], "aaacccttgccg": 111, "aaacccttgccggtacgcttaaaccattgccggtacgcttaa": 111, "aaacccttgccgttacgcttaaaccgaggccgggacactcat": 111, "aaaccgaggc": [111, 118], "aaagataggc": 110, "aaatatggat": 110, "aaatcctatg": 110, "aac": 119, "aacaaatgca": 110, "aacaacagga": 110, "aacaccaaacttctccacc": 112, "aacaccaaacttctccaccacgtgagctacaaaag": 112, "aaccttatca": 110, "aacga": 228, "aacgaaggcg": 110, "aacgac": 228, "aactttgtag": 110, "aagaactttc": 110, "aagaggttac": 110, "aagcctggtg": 110, "aagccttggc": 111, "aagccttggcagtgcagggtgagccgtgg": 111, "aagccttggcagtgcagggtgagccgtggccgggcacggtat": 111, "aagctngggc": [111, 118], "aagctngggcatttcagggtgagcccgggcaatacagggtat": 111, "aagga": 228, "aaggaatcaa": 110, "aaggaatttg": 110, "aagtaa": 210, "aagtatttgg": 110, "aagtcttaga": 110, "aagtcttttt": 110, "aagttgttag": 110, "aagucuuuuu": 110, "aata": 119, "aataaac": 119, "aataagtgca": 110, "aatacagggt": [111, 118], "aatataccggttataa": 232, "aatatggatt": 110, "aatgaa": [210, 213, 214], "aatgtt": 213, "aatt": 348, "aattaaataa": 110, "aattctggat": 110, "aattg": 513, "aattgccggac": 513, "aattgg": 318, "aauauggauu": 110, "ab": [112, 195, 413], "ab07acbb1e496801937adfa772424bf7": 500, "ababacac": 195, "abbrevi": [122, 320], "abc": [108, 171, 195, 209, 228, 413, 482, 484, 485], "abcd": [413, 480, 483], "abcdef": 1, "abcf": 413, "abil": [116, 506], "abl": [20, 24, 87, 184, 215, 221, 228, 259, 339, 402, 506], "about": [1, 30, 34, 67, 93, 94, 108, 111, 112, 116, 120, 121, 123, 148, 151, 157, 159, 160, 162, 173, 176, 186, 190, 218, 220, 223, 227, 243, 246, 254, 284, 290, 319, 322, 324, 333, 339, 340, 348, 378, 383, 398, 451, 476, 482, 483, 485, 507, 508], "abov": [0, 1, 3, 29, 49, 111, 113, 117, 118, 119, 120, 121, 123, 125, 127, 184, 215, 221, 228, 276, 296, 298, 300, 304, 407, 456, 458, 463, 508], "absenc": [48, 340, 380, 431], "absent": [245, 331, 415], "absolut": [256, 264, 298, 388, 415, 473, 495], "abstract": [160, 162, 171, 174, 195, 209], "abund": [1, 43, 44, 45, 53, 55, 58, 60, 67, 70, 80, 82, 84, 85, 86, 87, 90, 105, 259, 264, 319, 325, 326, 332, 333, 340, 382, 388], "abx": 338, "ac": [20, 22, 24, 27, 29, 31, 32, 35, 38, 110, 112, 113, 121, 149, 201, 508], "aca": [236, 237], "acaatcaaat": 110, "acac": [203, 236], "acacatttatta": 237, "acacgacgtt": [204, 234, 236], "acad": [37, 40], "academ": 46, "academi": 248, "acagaattga": 110, "acaggttggc": [111, 118], "acata": 112, "acatggcaat": 110, "acatgggata": 110, "acc": [0, 107, 508], "accaatattt": 110, "accaatttga": 110, "acccc": 0, "acceler": 431, "accept": [1, 20, 31, 87, 188, 189, 225, 226, 244, 248, 253, 259, 298, 302, 304, 336, 339, 340, 412, 423, 426, 453, 454, 460, 467, 468, 471, 504], "acces": 106, "access": [11, 20, 104, 110, 111, 113, 122, 171, 172, 174, 175, 176, 191, 276, 480, 492], "accgaat": 184, "accgaau": 221, "accgggta": 508, "accggttggc": 111, "accggttggccgttcagggtacaggttggccgttcagggtaa": 111, "accgttcg": 121, "accgttgta": [108, 118], "accguuaguc": 508, "accommod": 149, "accompani": [111, 277], "accomplish": [1, 256, 506], "accord": [49, 53, 184, 215, 221, 330, 334, 386, 387, 478], "accordingli": [473, 475], "account": [49, 96, 208, 310, 325, 333, 340, 415, 511], "accu_dist": 409, "accumul": [63, 66, 409], "accumulate_to_ancestor": 421, "accur": [49, 55, 61, 62, 477, 478, 480, 481], "accuraci": 331, "acdefghikl": [96, 97], "acdfnasanftacgnpnrtesl": 235, "acg": [20, 27, 28, 29, 31, 32, 119, 121, 234, 236], "acga": [20, 21, 24, 228], "acgaactatt": 110, "acggggaggcggag": [185, 200, 216, 222], "acgggu": 508, "acgt": [20, 21, 24, 25, 33, 171, 172, 174, 175, 211, 212, 213, 228, 229, 238, 247, 251], "acgta": 119, "acgtac": 119, "acgtacgt": 211, "acgtgagctacaaaag": 112, "acgtgccta": 0, "acgtgcctaggtacgcaag": 0, "acgtggaa": 229, "acgtn": 245, "acgtu": 42, "achiev": [70, 456, 457, 464, 473, 506, 508], "acid": [35, 37, 40, 110, 111, 112, 115, 118, 122, 184, 191, 193, 195, 215, 221, 228, 245, 247, 248], "acquir": 339, "across": [7, 27, 70, 111, 112, 118, 151, 182, 259, 264, 298, 339, 349, 458, 468, 479, 482, 483, 485], "act": [0, 29, 125, 126, 127], "actaaggctc": 0, "actaaggctcctaacccccttttctcaga": 0, "actaaggctctct": 0, "actaaggctctctacccctctcagaga": 0, "actacattcg": 110, "actatacgga": 110, "actcat": 111, "action": 162, "activ": 505, "acttagtt": 211, "actual": [71, 77, 120, 123, 298], "acwgn": [196, 198, 206], "ad": [19, 35, 36, 37, 38, 39, 40, 61, 62, 111, 121, 152, 209, 228, 259, 264, 294, 296, 298, 299, 300, 301, 304, 318, 326, 329, 331, 338, 339, 340, 348, 373, 402, 406, 407, 408, 409, 410, 411, 412, 413, 414, 415, 416, 417, 421, 422, 423, 431, 433, 435, 436, 441, 445, 446, 450, 452, 453, 454, 456, 457, 458, 459, 462, 463, 468, 470, 471, 472, 473, 475, 480, 482, 483, 485, 493, 496, 498, 501, 511], "adapt": 479, "adata": 390, "add": [1, 36, 39, 120, 121, 123, 129, 149, 151, 153, 155, 228, 261, 268, 270, 271, 272, 343, 344, 348, 368, 389, 402, 423], "add_format": [125, 127], "addit": [1, 30, 34, 41, 42, 53, 83, 84, 85, 89, 93, 94, 110, 111, 112, 113, 114, 118, 119, 120, 157, 159, 176, 184, 186, 190, 215, 218, 220, 221, 223, 227, 243, 246, 247, 256, 257, 258, 259, 276, 284, 290, 291, 322, 324, 383, 398, 400, 406, 415, 423, 424, 425, 451, 468, 476, 479, 480, 501, 506], "addition": [1, 20, 105, 116, 145, 151, 387, 472, 508, 511], "additon": 111, "address": [259, 506], "adef": 413, "adenin": [184, 221], "adequ": 339, "adher": 120, "adiv_faith_pd": 1, "adiv_sob": 1, "adjac": [235, 357], "adjust": 70, "adoni": 299, "adopt": [70, 245], "advanc": [1, 20, 496], "advantag": [70, 291, 501], "advis": [84, 85, 90], "ae000111": 107, "ae000171": 107, "ae000174": 107, "ae000394": 107, "ae000425": 107, "af031394": 107, "af035635": 121, "af178031": 107, "af178032": 107, "af178033": 107, "affect": [111, 116, 191, 228, 296, 300, 472], "aforement": 122, "after": [19, 21, 24, 35, 36, 37, 111, 112, 120, 121, 122, 123, 151, 155, 182, 264, 269, 270, 297, 298, 301, 304, 340, 419, 448, 450, 459, 469], "ag": [20, 21, 24, 27, 276, 338, 339], "agaagacc": 233, "agaagctatg": 110, "agaagctctt": 110, "agaagcuaug": 110, "agacatcacg": 110, "agagcatgcg": 110, "agaggttcta": 113, "agagguucua": 113, "agagttgaag": 118, "agagttgaaggtatct": [108, 118], "again": [1, 20, 111, 112, 176, 273, 379], "against": [20, 35, 38, 112, 149, 151, 191, 228, 259, 304, 346, 347], "agatataaag": 110, "agatcttttg": 110, "agatgagtat": 110, "agctttctgc": 110, "agg": 508, "aggaccttat": 110, "aggctc": 0, "aggctcccttctacccctctcagaga": 0, "agggaaagtt": 110, "agggctggct": 110, "agggga": 508, "agggta": 254, "agglom": 480, "aggreg": 513, "aggtacccta": 110, "aggtgcagta": 110, "agre": [136, 141, 407], "agtactctaa": 110, "agtgcagggt": [111, 118], "aguauucugccacuguaagaa": 193, "aguc": [231, 239, 241], "ahead": 513, "aiacaqkm": 121, "aim": 319, "ainsworth": 297, "aitchison": [256, 257, 258, 262, 263, 265, 266, 273], "aitchson": 267, "al": [259, 304, 342, 399], "ala": 215, "alanin": [23, 215], "aldex2": 264, "alexandro": 405, "algorithm": [35, 38, 113, 296, 297, 298, 300, 305, 306, 307, 309, 310, 312, 314, 316, 317, 325, 326, 331, 333, 415, 477, 478, 480, 481], "alia": [11, 51, 53, 68, 70, 76, 79, 84, 85, 114, 247, 259, 268, 285, 410, 412, 414, 416, 421, 439, 441, 453, 454, 460, 468, 480, 487, 498], "alias": [498, 499], "alic": 228, "alig": 13, "align": [106, 107, 111, 112, 149, 151, 228, 247, 345, 346, 347, 505, 506, 508], "aligned_query_sequ": [0, 11], "aligned_target_sequ": [0, 11], "alignmentstructur": 19, "alignpath": 14, "all": [1, 19, 20, 22, 23, 29, 35, 36, 37, 42, 44, 53, 54, 55, 67, 70, 71, 77, 80, 82, 84, 85, 86, 87, 100, 101, 102, 103, 104, 106, 108, 109, 110, 111, 112, 113, 114, 115, 117, 118, 120, 121, 122, 123, 124, 130, 140, 149, 151, 153, 155, 156, 165, 171, 172, 174, 175, 180, 182, 184, 193, 197, 199, 208, 215, 221, 228, 229, 233, 235, 244, 247, 248, 251, 259, 261, 264, 268, 270, 271, 272, 273, 276, 278, 281, 286, 289, 293, 295, 296, 297, 298, 299, 300, 301, 309, 310, 317, 318, 319, 321, 323, 330, 331, 339, 340, 341, 348, 349, 352, 356, 389, 397, 401, 404, 405, 406, 407, 408, 409, 412, 415, 416, 417, 422, 425, 426, 440, 442, 447, 448, 453, 454, 460, 461, 462, 463, 468, 472, 473, 475, 479, 482, 483, 485, 501], "all_char": 116, "allow": [106, 111, 112, 116, 118, 119, 120, 123, 145, 151, 176, 184, 215, 221, 229, 233, 256, 277, 278, 296, 297, 299, 300, 301, 305, 331, 342, 348, 399, 412, 467, 477, 478, 501, 513], "allow_edge_estim": [477, 478, 481], "allow_empti": 467, "allow_overlap": 278, "allvltkt": 121, "almost": 488, "alon": [116, 297], "along": [20, 115, 174, 321, 330, 331, 365, 386, 397], "alpha": [82, 88, 259, 336, 337, 341], "alpha_divers": [1, 43, 53, 70, 86, 88], "alpha_pwr": [336, 339, 340], "alphabet": [0, 32, 42, 88, 89, 106, 111, 184, 191, 195, 215, 221, 228, 245, 247, 248, 249, 251, 254, 508], "alphanumer": 120, "alr": 258, "alreadi": [116, 121, 123, 125, 126, 127, 228, 277, 298, 456, 458, 472], "also": [0, 1, 20, 22, 23, 49, 53, 75, 83, 84, 85, 86, 95, 97, 99, 110, 111, 112, 113, 114, 115, 116, 118, 120, 121, 122, 123, 124, 151, 176, 193, 212, 228, 235, 244, 245, 247, 259, 273, 274, 276, 296, 297, 298, 300, 304, 319, 326, 333, 336, 339, 340, 353, 358, 370, 400, 416, 422, 441, 447, 449, 473, 481, 484, 488, 504, 506, 508, 513], "altern": [31, 51, 75, 122, 123, 193, 207, 256, 269, 275, 281, 293, 298, 301, 304, 331, 336, 429, 496, 499], "although": [70, 304, 339, 349, 405, 407, 408], "altschul": [106, 107], "alwai": [1, 19, 20, 110, 113, 116, 118, 120, 126, 145, 149, 152, 176, 182, 193, 277, 373, 435, 456, 457, 458, 492, 513], "amar": 113, "ambigu": [138, 142, 184, 209, 221], "amen": 257, "american": [44, 457], "amino": [35, 37, 40, 110, 111, 115, 184, 191, 193, 215, 245, 247, 248], "amino_acid": 191, "among": [1, 49, 70, 101, 113, 256, 289, 306, 326, 333, 412, 413, 433, 441, 480, 482, 483, 485, 509], "amount": [301, 400, 468, 513], "amplicon": [1, 345], "amsterdam": [319, 325, 326, 332, 333], "an": [0, 1, 3, 4, 5, 6, 7, 8, 9, 10, 11, 17, 19, 20, 21, 22, 23, 24, 26, 27, 28, 29, 31, 34, 35, 36, 37, 41, 51, 53, 54, 56, 64, 67, 68, 72, 73, 76, 79, 81, 82, 84, 85, 86, 90, 94, 100, 101, 102, 103, 104, 105, 106, 107, 108, 109, 110, 111, 112, 113, 114, 115, 116, 117, 118, 120, 121, 122, 123, 124, 125, 126, 127, 131, 133, 134, 135, 136, 139, 141, 143, 145, 146, 149, 151, 152, 153, 155, 156, 158, 159, 161, 166, 167, 172, 174, 175, 176, 182, 185, 190, 191, 193, 195, 200, 209, 216, 220, 221, 222, 227, 228, 229, 239, 241, 244, 245, 246, 247, 251, 259, 262, 263, 265, 266, 268, 270, 273, 274, 276, 277, 278, 280, 281, 285, 289, 290, 292, 293, 296, 298, 299, 300, 302, 304, 311, 314, 318, 319, 320, 324, 330, 331, 336, 338, 339, 340, 341, 342, 343, 344, 345, 351, 352, 355, 356, 357, 358, 363, 365, 366, 368, 371, 372, 373, 374, 376, 378, 379, 389, 392, 395, 396, 397, 398, 399, 400, 402, 403, 405, 407, 408, 409, 410, 412, 414, 416, 417, 419, 420, 421, 422, 424, 427, 428, 433, 439, 441, 444, 450, 453, 454, 456, 457, 458, 459, 460, 462, 463, 466, 468, 470, 472, 473, 474, 475, 476, 477, 478, 479, 480, 481, 482, 483, 485, 487, 491, 492, 494, 495, 496, 500, 501, 504, 506, 508, 511, 513], "analog": 70, "analogu": 300, "analys": [53, 84, 85, 296, 431, 436, 480, 509], "analysi": [1, 53, 67, 84, 85, 111, 118, 257, 259, 264, 273, 296, 299, 300, 305, 306, 308, 309, 313, 315, 316, 317, 321, 325, 326, 331, 332, 333, 336, 339, 340, 400, 431], "analyt": 54, "analyz": [1, 256, 326, 339], "ancacwwgacgtt": [202, 203, 205], "ancestor": [53, 70, 229, 400, 409, 416, 421, 439, 458, 468], "ancestr": [53, 401, 421, 439], "ancom_df": 259, "anderson": [299, 300], "ani": [1, 10, 19, 20, 22, 23, 29, 31, 41, 42, 45, 79, 80, 111, 113, 115, 116, 120, 121, 125, 126, 127, 138, 142, 145, 149, 151, 155, 156, 164, 176, 178, 181, 184, 215, 221, 228, 247, 254, 259, 261, 264, 298, 300, 301, 305, 310, 314, 325, 330, 331, 336, 338, 339, 353, 358, 382, 392, 394, 400, 402, 405, 409, 410, 416, 419, 423, 431, 432, 433, 435, 441, 452, 466, 479, 496, 501, 502, 504, 506, 511, 513], "anim": 54, "ann": [52, 73], "anndata": 390, "annot": [110, 113, 114, 120, 151], "announc": 120, "anosim": [1, 299, 300], "anoth": [1, 20, 21, 29, 53, 84, 85, 113, 115, 116, 149, 151, 155, 158, 162, 176, 191, 228, 231, 240, 242, 247, 277, 304, 345, 402, 422, 445], "anova": [259, 299, 307, 311], "answer": 500, "anti": [1, 296], "antibiot": [270, 338], "anticip": 513, "anyon": 120, "anyth": [1, 111, 112, 119, 123, 228, 392, 501, 502, 504, 513], "anytim": 120, "anywher": [115, 116, 120, 259], "apart": [441, 457], "api": [111, 176, 253], "app": 119, "appear": [1, 44, 106, 118, 120, 121, 280, 297, 326, 336, 342, 472, 484], "append": [0, 24, 118, 123, 228, 423, 435, 493], "appl": [84, 85], "appli": [0, 1, 19, 20, 23, 82, 85, 86, 87, 90, 110, 111, 116, 120, 122, 151, 162, 171, 172, 174, 175, 184, 215, 221, 228, 247, 256, 281, 293, 294, 298, 301, 305, 325, 339, 352, 373, 379, 382, 388, 395, 402, 407, 408, 409, 413, 417, 423, 435, 462, 463, 480, 487, 498, 499, 501, 513], "applic": [19, 23, 35, 41, 176, 319, 409, 421, 422, 433, 459, 468, 513], "approach": [264, 298, 339, 417, 420], "appropri": [1, 104, 115, 145, 229, 259, 506, 511], "approx": 336, "approxim": [333, 336], "aqfvdhwkel": 109, "aquat": 326, "ar": [0, 1, 3, 19, 20, 22, 23, 27, 28, 29, 30, 31, 33, 34, 35, 36, 37, 38, 39, 40, 41, 42, 44, 47, 48, 49, 53, 54, 60, 61, 62, 70, 82, 84, 85, 86, 87, 89, 90, 93, 94, 100, 101, 102, 103, 104, 106, 107, 108, 109, 110, 111, 112, 113, 114, 115, 116, 117, 118, 119, 120, 121, 122, 123, 125, 126, 127, 130, 136, 140, 141, 145, 149, 151, 153, 155, 157, 158, 159, 162, 164, 165, 176, 177, 178, 180, 181, 182, 184, 186, 187, 188, 189, 190, 191, 192, 193, 194, 195, 199, 202, 203, 204, 205, 210, 215, 217, 218, 220, 221, 223, 224, 225, 226, 227, 228, 229, 233, 239, 240, 241, 242, 243, 244, 245, 246, 247, 248, 249, 254, 255, 256, 257, 259, 261, 264, 265, 266, 268, 270, 271, 272, 273, 276, 277, 281, 284, 285, 289, 290, 291, 293, 294, 295, 296, 297, 298, 299, 300, 301, 302, 304, 307, 310, 317, 318, 319, 320, 321, 322, 324, 325, 326, 329, 330, 331, 333, 334, 336, 338, 339, 340, 342, 348, 349, 352, 354, 358, 364, 373, 375, 383, 385, 386, 387, 388, 390, 391, 392, 397, 398, 399, 400, 404, 405, 407, 408, 409, 411, 412, 413, 415, 416, 417, 419, 421, 422, 427, 429, 431, 433, 435, 436, 439, 442, 443, 444, 451, 452, 453, 454, 456, 457, 458, 459, 460, 461, 463, 465, 466, 467, 468, 469, 472, 473, 475, 476, 479, 480, 481, 484, 488, 489, 492, 494, 496, 501, 503, 504, 506, 508, 511, 513], "arang": [364, 369], "arbitrari": [20, 22, 25, 115, 120, 121, 184, 215, 221, 228, 318, 358, 392, 408, 482, 483, 485, 501, 508], "arbitrarili": [479, 496, 513], "archaea": [429, 430, 467], "archiv": [122, 500], "area": [1, 55], "arg": [123, 130, 140, 188, 189, 215, 225, 226, 342], "arginin": 215, "argument": [19, 20, 30, 31, 34, 41, 93, 94, 115, 125, 126, 127, 130, 136, 138, 139, 140, 141, 142, 143, 157, 159, 186, 188, 189, 190, 218, 220, 223, 225, 226, 227, 238, 243, 246, 247, 257, 281, 284, 290, 293, 322, 324, 342, 383, 398, 409, 451, 476, 501, 504], "argumentoverridewarn": [136, 141], "aris": [466, 479], "arithmet": 484, "armidal": [415, 485], "around": [61, 62, 87, 111, 118, 121, 247, 260, 298, 337, 506, 511], "arrai": [1, 3, 4, 5, 6, 8, 9, 10, 15, 17, 19, 23, 27, 53, 70, 84, 85, 95, 96, 97, 99, 102, 111, 117, 184, 196, 198, 201, 206, 210, 214, 215, 219, 221, 228, 240, 242, 245, 247, 249, 251, 257, 258, 260, 261, 262, 263, 265, 266, 267, 268, 269, 270, 271, 272, 273, 274, 276, 277, 285, 292, 302, 304, 305, 310, 314, 317, 319, 330, 334, 336, 337, 338, 339, 340, 341, 345, 346, 347, 348, 349, 351, 352, 365, 368, 372, 376, 378, 382, 384, 388, 389, 392, 395, 409, 434, 466, 479, 508], "arrang": [319, 480], "array_lik": [1, 3, 4, 5, 6, 14, 15, 16, 20, 44, 45, 46, 47, 48, 49, 50, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 71, 72, 73, 74, 75, 76, 77, 78, 79, 80, 81, 82, 86, 87, 90, 91, 95, 96, 97, 98, 99, 185, 200, 216, 222, 228, 232, 235, 244, 257, 258, 260, 261, 262, 263, 265, 266, 267, 268, 269, 270, 271, 272, 273, 275, 277, 296, 298, 299, 300, 301, 304, 327, 330, 334, 337, 340, 341], "articl": [19, 41, 108], "artifact": [28, 35, 36, 37], "artifici": [113, 319], "asarrai": [277, 355, 356, 362, 363, 365, 366, 368, 373, 374, 379, 380, 381, 384, 386, 387, 389, 394, 395, 397], "ascend": [32, 158], "ascii": [112, 119, 120, 123, 245, 247, 403, 511], "ascii_art": [116, 347, 401, 406, 407, 408, 409, 412, 413, 415, 425, 429, 430, 435, 440, 443, 445, 447, 448, 449, 450, 456, 457, 458, 459, 462, 463, 465, 468, 469, 472, 477, 478, 480, 481, 484, 511], "ask": 126, "asn": 215, "asp": 215, "asparagin": 215, "aspart": 215, "aspect": 501, "ass": 57, "assai": 339, "assembl": 110, "assert": 489, "assert_frame_equ": 488, "assertionerror": [488, 489], "assess": [70, 80, 296, 298, 299, 300, 304, 408, 463], "assign": [23, 31, 42, 82, 86, 118, 120, 149, 228, 244, 251, 259, 264, 296, 299, 300, 318, 340, 404, 405, 406, 409, 427, 431, 477, 478, 481, 484], "assign_id": 427, "assign_support": 471, "assist": [120, 513], "associ": [1, 20, 44, 70, 112, 120, 121, 122, 124, 131, 132, 133, 149, 152, 154, 156, 165, 167, 176, 184, 215, 221, 228, 297, 304, 318, 330, 334, 337, 338, 339, 348, 351, 358, 373, 390, 392, 421, 422, 427, 433, 506], "asst": [211, 212], "assum": [1, 44, 53, 55, 63, 66, 84, 85, 108, 111, 112, 115, 117, 125, 127, 176, 187, 188, 189, 228, 264, 276, 277, 293, 304, 305, 326, 330, 336, 337, 339, 340, 388, 473, 475], "assumpt": [67, 116, 254, 259, 264, 424, 425, 463, 480], "asv": 1, "asx": 215, "asymmetr": [247, 277], "asymptot": 67, "ataaatcacg": 110, "ataacgttgg": 110, "ataagggatg": 110, "atacaaccat": 110, "atactcccaa": 110, "atagacc": 513, "atagcatacc": 110, "atagttacac": 110, "atatatacat": 112, "atatatat": 318, "atatatgttt": 110, "atatgaacaaa": 513, "atattacaac": 110, "atcaaaaggg": 110, "atcaccgcta": 110, "atcactgaaa": 110, "atcataacta": 110, "atccatatat": 110, "atcggcgat": 255, "atgagccatg": 110, "atgc": 352, "atgcactagg": 110, "atgcatgcat": 114, "atgcatgcatgcatgcatgcatgcatgcatgcatgcatgc": 114, "atgcatgcatgcatgcatgcatgcatgcatgcatgcatgcatgcatgcatgcatgcatgc": 114, "atgccactttaa": [188, 189], "atgccccttc": 110, "atggca": 318, "atggcc": 318, "atggcg": 318, "atggct": 318, "atggtatgaa": 110, "atgtgtatttga": 508, "atgttgtagt": 110, "atl": [189, 194, 226], "atla": 248, "atom": [358, 392], "att": 197, "attach": [405, 409, 410, 419, 431, 472], "attagaaaga": 110, "attcgttgtg": 110, "attctggaac": 110, "attempt": [111, 120, 145, 405, 424], "attr": [114, 358, 392, 410, 466], "attr_1": 466, "attr_n": 466, "attribut": [3, 11, 14, 20, 31, 91, 95, 96, 97, 98, 99, 104, 109, 110, 111, 113, 114, 117, 119, 120, 121, 124, 148, 149, 150, 151, 156, 160, 162, 171, 173, 174, 176, 184, 191, 195, 209, 215, 221, 228, 245, 247, 277, 278, 289, 291, 307, 312, 314, 320, 332, 339, 342, 358, 392, 399, 400, 404, 409, 410, 417, 431, 435, 456, 457, 458, 466, 473, 475, 479, 486, 489, 491, 492, 503, 508], "attribute_nam": 466, "attributeerror": [228, 492], "atttcagggt": [111, 118], "aucauaacua": 110, "aug": 111, "augccacuuuaa": [191, 194, 225, 226], "auguguauuu": 508, "austral": 299, "australia": [415, 485], "australian": [296, 415, 485], "auth": 123, "author": [70, 113, 121, 228, 259], "auto": [145, 245], "autom": 409, "automat": [19, 21, 24, 29, 30, 34, 93, 94, 115, 119, 120, 130, 140, 149, 157, 159, 186, 190, 218, 220, 223, 227, 238, 243, 246, 276, 284, 290, 320, 322, 324, 383, 398, 409, 413, 419, 431, 435, 451, 456, 457, 458, 476, 506], "auxilari": 123, "av": 305, "avail": [1, 86, 106, 111, 112, 113, 117, 120, 122, 134, 135, 191, 192, 245, 248, 291, 296, 297, 298, 299, 300, 310, 336, 340, 358, 392, 472, 506, 513], "averag": [260, 264, 305, 306, 330, 334, 382, 412, 477, 479, 481, 482, 484], "averagegradientanova": 305, "avg": 305, "avoid": [19, 109, 120, 121, 123, 155, 319, 334, 472], "aw": [0, 70], "awar": [23, 70, 120, 228], "awesom": 513, "awgh": 0, "ax": [20, 306, 309, 310, 316, 319, 321, 325, 326, 342, 345, 352, 373], "axes3d": 321, "axi": [20, 27, 55, 91, 115, 174, 247, 310, 317, 320, 321, 330, 337, 340, 342, 343, 344, 345, 346, 347, 348, 349, 351, 352, 355, 356, 358, 363, 365, 366, 368, 369, 370, 371, 372, 373, 374, 375, 376, 378, 379, 381, 382, 384, 385, 386, 387, 388, 389, 392, 395, 397, 489], "axis_label": [1, 321], "axis_len": 174, "b": [1, 19, 20, 25, 29, 31, 32, 33, 53, 54, 55, 67, 70, 74, 90, 112, 115, 116, 120, 146, 184, 215, 221, 228, 248, 249, 264, 274, 276, 277, 278, 283, 286, 287, 289, 295, 297, 298, 318, 321, 338, 339, 346, 348, 349, 352, 356, 381, 392, 401, 403, 405, 406, 407, 408, 409, 411, 412, 413, 414, 415, 416, 417, 418, 421, 422, 424, 425, 426, 427, 432, 433, 435, 436, 437, 438, 439, 440, 441, 442, 443, 445, 446, 447, 448, 449, 450, 452, 453, 454, 455, 456, 457, 458, 459, 460, 461, 462, 463, 465, 466, 468, 469, 470, 471, 472, 473, 475, 479, 480, 482, 483, 484, 485, 500, 506, 508, 511], "b1": [259, 264], "b2": [259, 264], "b3": [259, 264], "b4": [259, 264], "b5": [259, 264], "b6": [259, 264], "b7": [259, 264], "b_b": 116, "b_i": [80, 273], "ba": 121, "babp": 19, "bacilli": [430, 467], "bacillu": 121, "back": [20, 70, 109, 111, 114, 139, 143, 169, 170, 183, 401, 448, 511], "backward": [53, 70, 84, 85, 120], "bacteri": 259, "bacteria": [340, 375, 429, 430, 467], "bacteroidet": [375, 429, 430, 467], "baeza": 321, "baker": 53, "balanc": [70, 273, 477, 481], "band": 19, "bar": [120, 349, 374, 384, 394, 395, 500, 513], "barcod": [346, 348, 352], "barker": 70, "barlow": 273, "basal": 472, "base": [1, 3, 4, 11, 14, 16, 29, 36, 39, 43, 44, 47, 48, 52, 53, 60, 66, 67, 70, 71, 72, 74, 77, 84, 85, 105, 106, 111, 113, 117, 119, 120, 149, 152, 162, 176, 179, 184, 195, 209, 215, 221, 228, 235, 277, 296, 298, 299, 300, 304, 310, 325, 326, 333, 336, 338, 339, 340, 342, 348, 356, 388, 399, 412, 413, 415, 426, 477, 478, 479, 480, 481, 482, 483, 485, 500, 508, 509, 511, 513], "base1": 191, "base2": 191, "base3": 191, "basi": [265, 266, 273, 274], "basic": [35, 55, 106, 107, 304, 320, 321, 358, 392], "baz": [349, 500], "bb": 338, "bbb": 112, "bbf": 112, "bbx": 112, "bc": 413, "bc_dm": 1, "bct": 122, "becam": [116, 493], "becaus": [1, 20, 23, 28, 29, 53, 84, 85, 106, 111, 112, 113, 116, 118, 119, 120, 123, 176, 184, 193, 209, 221, 228, 235, 259, 298, 326, 331, 333, 335, 338, 407, 419, 462, 467, 474, 482], "becom": [1, 3, 54, 111, 112, 116, 120, 151, 348, 375, 421, 431, 456, 473, 475], "been": [0, 20, 35, 36, 37, 42, 43, 90, 111, 112, 113, 118, 138, 142, 145, 176, 181, 195, 205, 206, 228, 235, 298, 304, 358, 392, 397, 407, 408, 480, 496], "befor": [1, 23, 111, 115, 120, 121, 193, 211, 212, 270, 297, 298, 340, 348, 416, 425, 440, 447, 448, 456, 457, 458, 469, 480, 511, 513], "begin": [11, 19, 110, 111, 112, 113, 117, 120, 121, 126, 149, 176, 193, 340], "behav": [20, 184, 215, 221, 298], "behavior": [29, 35, 36, 37, 111, 112, 113, 120, 145, 171, 172, 174, 175, 193, 228, 245, 296, 298, 300, 412, 415, 420, 456, 457, 458, 462, 473, 480, 513], "being": [1, 19, 21, 23, 24, 35, 36, 37, 53, 82, 86, 111, 112, 118, 122, 176, 182, 273, 300, 304, 318, 339, 348, 392, 412, 457, 497, 506, 508], "bell": 74, "belong": [19, 45, 49, 75, 114, 259, 264, 296, 299, 300, 348], "below": [108, 111, 112, 116, 118, 120, 121, 122, 176, 191, 195, 228, 297, 298, 321, 325, 339, 358, 388, 392, 408, 409, 413, 415, 416, 417, 436, 439, 441, 450, 459, 463, 493], "benefit": 264, "benjamini": [259, 264], "berger": [45, 58], "berkelei": 72, "besid": 481, "best": [19, 35, 36, 37, 38, 39, 40, 61, 62, 256, 297], "beta": [86, 87, 89, 110], "beta_divers": [1, 82, 84, 85, 87, 89, 90], "betadisp": 300, "bethesda": 111, "better": [111, 325, 326, 506], "between": [1, 3, 19, 36, 39, 54, 55, 58, 61, 71, 72, 80, 81, 84, 85, 86, 90, 104, 111, 112, 113, 115, 118, 121, 122, 151, 158, 229, 231, 239, 240, 241, 242, 247, 253, 254, 255, 259, 264, 273, 276, 277, 281, 291, 293, 296, 297, 298, 299, 300, 301, 303, 304, 310, 325, 326, 327, 331, 333, 336, 339, 340, 342, 373, 411, 412, 413, 414, 415, 416, 417, 422, 435, 441, 443, 456, 458, 465, 477, 478, 480, 481, 482, 483, 485, 506, 508, 511], "bf": 440, "bf00039495": 110, "bh": [259, 264], "bia": [47, 48, 264], "bias": [47, 48, 264], "bias_correct": [47, 48], "bifurc": [116, 274, 428, 436], "big_fil": 506, "bigoplu": 266, "bin": [318, 348, 381], "bin_": 318, "bin_f": [318, 348], "binari": [123, 124, 125, 126, 127, 145, 273, 274, 304, 325, 333, 378, 400, 436, 481, 500], "binary_dm": [284, 290], "binomi": [339, 340], "bio": [0, 1, 30, 34, 35, 38, 41, 42, 53, 84, 85, 86, 87, 88, 89, 90, 93, 94, 105, 106, 107, 108, 110, 111, 112, 116, 117, 118, 119, 121, 122, 157, 159, 171, 172, 174, 175, 186, 188, 189, 190, 191, 193, 194, 218, 220, 223, 225, 226, 227, 243, 246, 253, 284, 290, 297, 319, 322, 324, 383, 398, 400, 451, 472, 476, 496, 508, 512], "biocor": [84, 85, 321], "biodivers": [1, 43, 51, 53, 70], "bioinformat": [53, 70, 112, 118, 120, 405, 506], "biol": [35, 38, 53, 57, 70, 106, 107, 110, 113, 269, 275, 477, 478, 481], "biolog": [1, 20, 28, 35, 36, 37, 66, 70, 71, 77, 79, 91, 95, 98, 99, 111, 112, 114, 116, 119, 149, 185, 196, 197, 198, 199, 200, 201, 202, 203, 204, 205, 206, 216, 222, 228, 247, 339, 342, 359, 399, 480, 505, 509, 510], "biologi": [70, 71, 77, 193, 304, 405, 412, 415, 416, 422, 424, 479, 480, 482], "biom": [120, 342, 345, 346, 347, 348, 349, 351, 352, 355, 356, 357, 358, 359, 360, 362, 363, 364, 365, 366, 368, 369, 370, 371, 372, 373, 374, 375, 376, 379, 380, 381, 382, 383, 384, 386, 387, 388, 389, 390, 391, 392, 393, 394, 395, 397, 398, 399], "biom_format": [342, 399], "biom_open": [358, 392], "biometr": [67, 300], "biometrika": [43, 44, 56, 331], "bioperl": [112, 118], "biopython": [3, 112], "biosci": [269, 275], "bioscienc": [413, 483], "biotechnologi": [111, 122], "biotit": 3, "biowulf": 119, "biparit": [415, 485], "bipart": [411, 462, 463], "bipartit": [407, 408, 411, 413, 415, 483, 485], "biplot": [117, 325, 333], "biplot_scor": [320, 489], "bit": [3, 4, 8, 14, 15, 17, 106, 107, 120], "bit_arr": 4, "bitscor": [106, 107], "bitting": 70, "biz": 349, "blackwel": 66, "blank": [111, 112, 116, 117, 118, 120, 148, 162, 173, 176, 181, 283], "blast": [36, 37, 39, 40, 111], "blast6": 107, "blastcgihelp": 111, "blastedbio": 106, "blastn": 107, "blastp": 107, "block": [37, 40, 87, 248, 412, 415, 500], "block_siz": 500, "blocksiz": 87, "blogspot": 106, "blosum": [37, 40, 215, 247, 248], "blosum45": 248, "blosum50": 248, "blosum62": [247, 248], "blosum80": 248, "blosum90": 248, "bmc": [416, 422], "bme": [480, 481], "bmi": 340, "bnni": 481, "bob": 228, "bodi": [1, 321], "body_sit": [1, 321], "bogdanowicz": 413, "boilerpl": 123, "bologna": 55, "boltzmann": 81, "bone": 339, "bonferroni": [259, 264], "boniferroni": [259, 264], "boogaart": 273, "book": [106, 107, 111], "bool": [12, 19, 20, 21, 24, 27, 28, 32, 35, 36, 37, 47, 48, 49, 51, 53, 59, 70, 74, 75, 76, 82, 84, 85, 86, 87, 90, 96, 100, 101, 102, 103, 125, 126, 127, 136, 141, 149, 151, 152, 154, 158, 161, 162, 165, 168, 169, 170, 172, 174, 175, 176, 177, 183, 184, 185, 191, 196, 198, 200, 201, 202, 203, 204, 205, 206, 207, 208, 210, 212, 213, 215, 216, 217, 219, 221, 222, 228, 229, 232, 233, 235, 236, 237, 239, 240, 241, 242, 244, 245, 247, 255, 259, 265, 266, 269, 275, 277, 278, 280, 286, 294, 298, 300, 301, 304, 310, 312, 323, 330, 331, 333, 334, 338, 339, 341, 348, 351, 355, 356, 358, 359, 367, 368, 369, 370, 378, 379, 380, 381, 382, 385, 390, 391, 392, 395, 397, 401, 402, 403, 406, 408, 409, 410, 411, 412, 413, 414, 415, 416, 417, 418, 421, 422, 423, 431, 432, 433, 435, 436, 437, 438, 440, 441, 443, 445, 446, 447, 448, 449, 450, 452, 453, 454, 456, 457, 458, 459, 462, 463, 465, 467, 468, 469, 470, 471, 472, 473, 475, 477, 478, 480, 481, 482, 483, 484, 485, 487, 489, 493, 501], "boolean": [20, 85, 111, 114, 119, 149, 184, 185, 196, 198, 200, 201, 206, 215, 216, 219, 221, 222, 228, 235, 238, 240, 242, 244, 293, 356, 388], "bootstrap": 400, "both": [20, 22, 29, 31, 42, 47, 48, 49, 53, 70, 104, 105, 106, 107, 109, 111, 112, 118, 120, 122, 136, 141, 156, 193, 262, 263, 265, 266, 276, 277, 281, 293, 294, 295, 297, 298, 299, 300, 331, 342, 345, 348, 352, 358, 373, 388, 392, 402, 407, 408, 423, 435, 439, 460, 463, 469, 481, 484, 506, 508], "bound": [60, 61, 113, 114, 123, 149, 150, 151, 152, 153, 155, 156, 228, 259, 264, 337, 340], "bound_moieti": 113, "bowden": [184, 195, 215, 221, 228], "boxplot": 1, "bp": [110, 113], "braak": 326, "bracket": [80, 116], "brai": 1, "branch": [1, 53, 70, 85, 274, 400, 405, 406, 407, 408, 409, 412, 413, 415, 416, 421, 422, 433, 435, 441, 442, 450, 456, 457, 458, 462, 463, 466, 468, 470, 472, 473, 475, 477, 478, 480, 482, 485, 511], "branch_attr": [435, 456, 457, 458, 473, 475], "braycurti": 1, "breadth": 440, "break": [184, 215, 221], "bren": 273, "brillouin": 46, "broader": 319, "broadinstitut": 111, "broken": [22, 479], "brows": 110, "bsd": 505, "bt": [112, 369], "btop": [106, 107], "buf_siz": 318, "buffer": [123, 145, 318], "buffer_s": 123, "bufferedrandom": 145, "bufferedread": [124, 125, 126, 145], "bufferedwrit": [124, 127, 145], "bui": 505, "build": [16, 151, 273, 393, 480], "buildilrbas": 273, "built": 506, "bulletin": [479, 484], "busi": 123, "bwpd_": 70, "by_id": 388, "by_nam": [245, 247, 250], "bypass": [53, 82, 84, 85, 86], "byte": [3, 145, 244, 486], "byteio": [105, 109], "bytesio": [105, 109, 145, 146, 500], "bz2": 145, "bzh91ai": 146, "b\u00e4hler": [269, 275], "c": [1, 8, 11, 19, 20, 22, 28, 29, 31, 32, 41, 44, 53, 54, 55, 56, 57, 70, 71, 74, 77, 81, 84, 85, 90, 110, 111, 112, 116, 118, 120, 121, 122, 127, 184, 197, 211, 212, 215, 221, 228, 233, 247, 249, 251, 256, 258, 263, 269, 270, 271, 272, 274, 275, 276, 278, 283, 287, 289, 295, 297, 298, 321, 331, 332, 338, 339, 346, 348, 349, 401, 403, 405, 406, 407, 408, 409, 411, 412, 413, 414, 415, 416, 417, 418, 421, 422, 424, 425, 426, 427, 432, 433, 435, 436, 437, 438, 439, 440, 441, 442, 443, 445, 446, 447, 448, 449, 450, 452, 453, 454, 455, 456, 457, 458, 459, 460, 461, 462, 463, 465, 466, 468, 469, 470, 471, 472, 473, 475, 479, 480, 482, 483, 484, 485, 508, 511], "c_": 44, "ca": [3, 8, 23, 117, 320, 326, 333], "caa40058": 110, "caaatgtgaa": 110, "caacgtggcc": 110, "caaggaagat": 110, "caagggctgc": 110, "cabcacc": 112, "cac": [204, 236], "cacaattact": 110, "cacaauuacu": 110, "cach": [402, 406, 409, 410, 417, 419, 423, 424, 425, 426, 427, 431, 435, 446, 450, 452, 453, 454, 456, 457, 458, 459, 460, 470, 471, 472, 473, 475], "cache_attr": [410, 431], "cache_attrnam": 409, "cache_typ": 409, "cag": 3, "caggcc": 513, "cagttgaagc": 110, "cagtttgatg": 110, "caguugaagc": 110, "caguuugaug": 110, "cajo": 326, "calcul": [3, 19, 43, 44, 45, 46, 47, 48, 49, 50, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 71, 72, 73, 74, 75, 76, 77, 78, 79, 80, 81, 84, 85, 87, 90, 101, 104, 211, 212, 259, 264, 267, 274, 275, 296, 297, 298, 299, 300, 304, 309, 310, 317, 330, 331, 334, 337, 339, 340, 372, 376, 388, 409, 411, 412, 413, 414, 415, 416, 421, 422, 433, 468, 481, 482, 483, 485], "california": 72, "call": [1, 29, 53, 54, 61, 62, 84, 85, 108, 111, 118, 121, 123, 145, 149, 193, 211, 228, 229, 232, 244, 294, 297, 298, 318, 326, 336, 356, 403, 404, 409, 410, 419, 424, 425, 427, 431, 443, 450, 459, 465, 472, 474, 487, 491, 493, 495, 496, 499, 501, 502, 506, 513], "callabl": [19, 20, 21, 24, 31, 82, 86, 87, 90, 101, 259, 281, 286, 293, 302, 323, 409, 412, 415, 426, 453, 454, 460, 471, 482, 485], "callback": [501, 513], "caller": [30, 34, 93, 94, 157, 159, 186, 190, 218, 220, 223, 227, 243, 246, 284, 290, 308, 313, 315, 322, 324, 383, 396, 398, 451, 476], "calucul": 300, "can": [0, 1, 6, 19, 20, 28, 31, 35, 36, 37, 41, 42, 43, 49, 53, 54, 70, 73, 75, 82, 84, 85, 86, 88, 89, 90, 95, 96, 97, 99, 105, 106, 108, 109, 110, 111, 112, 113, 114, 115, 116, 118, 120, 121, 122, 123, 124, 137, 145, 149, 150, 151, 156, 160, 171, 174, 176, 185, 191, 200, 216, 222, 228, 229, 231, 235, 244, 247, 248, 253, 256, 259, 264, 273, 276, 277, 291, 296, 297, 298, 300, 301, 302, 305, 319, 321, 325, 330, 331, 332, 333, 336, 338, 339, 340, 342, 345, 349, 358, 370, 373, 382, 392, 395, 400, 406, 407, 408, 409, 410, 412, 413, 415, 422, 423, 431, 436, 453, 454, 456, 457, 458, 460, 462, 463, 464, 466, 468, 473, 479, 480, 482, 483, 485, 487, 490, 491, 492, 496, 498, 501, 504, 508, 511, 513], "cancer": 298, "candid": [191, 340], "cannot": [6, 19, 20, 21, 24, 111, 112, 115, 116, 120, 136, 138, 141, 142, 145, 176, 184, 195, 209, 221, 229, 259, 296, 297, 298, 299, 300, 318, 321, 338, 340, 424, 427, 439, 460, 506], "canon": [184, 195, 207, 215, 221, 247, 326, 333, 342, 399, 505], "capabl": [20, 400], "captur": 208, "cardin": 490, "care": [1, 23, 111, 113], "carlo": 336, "carol": 228, "casava": 119, "casava_ug_15011196b": 119, "case": [1, 23, 35, 36, 37, 45, 72, 81, 87, 105, 109, 111, 116, 118, 120, 122, 124, 176, 182, 184, 212, 221, 238, 245, 248, 259, 264, 277, 298, 304, 325, 330, 331, 332, 340, 405, 409, 412, 459, 472, 479, 501, 506, 511], "cast": [1, 116, 176, 229, 276, 277, 302, 321, 374], "cat": [237, 338, 339], "catacctca": 3, "catatttgct": 110, "catcgatcgatcgatgcatgcatgcatg": 111, "catcgtc": 111, "categor": [120, 148, 176, 177, 181, 183, 296, 299, 319, 321], "categori": [1, 120, 121, 305, 306, 307, 308, 310, 311, 312, 314, 315, 316, 317, 319, 321, 336, 338, 339, 343, 348, 392, 507], "categoricalmetadatacolumn": [162, 176, 179], "categoryresult": 312, "catttagga": 119, "catttgaaaa": 110, "cauauuugcu": 110, "caugcaucguacguacgcaugac": 108, "caus": [19, 120, 145, 193, 480], "caution": [90, 431], "cautiou": 407, "cauucguacguacgcaugac": 108, "caveat": [111, 256], "cb": [121, 338], "cc": [20, 121, 191, 244], "cca": [117, 319, 320, 325, 333], "cca1": 319, "cca2": 319, "cca3": 319, "cca4": 319, "cca5": 319, "cca6": 319, "cca7": 319, "cca8": 319, "cca9": 319, "ccaatggtac": 110, "ccaggtcgat": 110, "ccc": 228, "cccataaata": 110, "cccc": 235, "ccccchhhhhhhhhhhhh": 121, "ccchhhhhhhhhhhhhhh": 121, "cccttaggtc": 110, "ccg": 31, "ccggac": 513, "ccgggcacggtat": 111, "ccgwllllpppphhqqrrrriiimttttnnkkssrrvvvvaaaaddeegggg": 191, "ccora": 326, "ccyt": 112, "cd": [35, 110, 113, 193], "cde": 122, "cdef": 413, "ceil": 388, "cell": [120, 339], "cell_lin": 339, "center": [111, 122, 260, 297, 325, 327, 331, 334], "centr": [256, 262, 263, 329], "centroid": 300, "cepa": 405, "certain": [53, 64, 82, 84, 85, 86, 136, 139, 141, 143, 176, 184, 215, 221, 254, 426, 431, 453, 454, 471], "cg": [22, 228, 244], "cga": 236, "cgac": 108, "cgagc": 228, "cgaggccgggac": 111, "cgatgtc": 111, "cgatgtcgatcgatcgatcgatcag": 111, "cgau": 108, "cgcgaugcaugcau": 108, "cgggacactc": [111, 118], "cgggcacggt": [111, 118], "cgggcasdgca": 119, "cgggcattgca": 119, "cggtacgctt": [111, 118], "cggtcgtaacgcgta": 3, "cggtcgtcac": 3, "cgi": [36, 37, 39, 40, 191, 192], "cgt": 236, "cgtcacttat": 110, "cgtcgt": 8, "cgtcgtgc": 8, "cgttacgctt": [111, 118], "cgttcagggt": [111, 118], "cgttta": 254, "cgugcaugcau": 108, "chain": [113, 497], "challeng": [53, 480], "chanc": [247, 304, 388], "chang": [60, 74, 79, 111, 150, 151, 193, 228, 248, 259, 264, 268, 296, 302, 318, 395, 407, 409, 410, 412, 413, 414, 416, 417, 421, 422, 423, 439, 441, 453, 454, 456, 457, 460, 468, 473, 480, 496, 497, 513], "chao": [44, 47, 70], "chao1": 48, "chao1_ci": 47, "chapter": [111, 332], "char": [208, 233], "charact": [3, 4, 6, 8, 10, 11, 14, 15, 19, 20, 22, 23, 27, 29, 42, 95, 96, 97, 98, 99, 106, 107, 108, 111, 112, 115, 116, 117, 118, 119, 121, 122, 123, 176, 184, 185, 191, 193, 195, 196, 197, 198, 200, 201, 202, 203, 204, 205, 206, 207, 209, 211, 212, 215, 216, 217, 219, 221, 222, 228, 233, 238, 244, 245, 247, 249, 251, 254, 358, 392, 508], "character": 264, "charg": [111, 118], "charlson": 70, "chase": 51, "check": [19, 112, 126, 136, 141, 149, 151, 155, 265, 266, 276, 277, 291, 305, 325, 326, 339, 355, 367, 407, 408, 431, 432, 436, 437, 438, 462, 463, 488, 489, 495, 513], "check_length": 513, "checksum": 500, "chemic": [247, 340], "chen": [44, 70], "chf": [189, 194, 226], "chi": [325, 326], "chichest": 256, "chicken": [477, 478, 481], "child": [116, 151, 229, 273, 400, 402, 406, 416, 432, 436, 446, 450, 452, 453, 454, 459, 470, 472, 511], "child1": [402, 423], "child2": [402, 423], "child_index": 466, "children": [116, 274, 400, 402, 406, 409, 413, 423, 425, 432, 435, 436, 442, 446, 447, 448, 449, 452, 456, 461, 469, 472], "chimp": [111, 118], "chisquar": 340, "chiu": 70, "choic": [21, 24, 115, 331, 433, 441, 472], "choos": [53, 120, 326, 336], "chosen": [244, 268, 297, 321, 333, 341, 496], "christoph": 112, "chunk": [118, 506], "ci": [43, 61, 264], "ci_typ": 61, "cigar": [3, 11, 16, 18, 19], "circuit": 513, "circumst": [55, 215, 339], "citat": 122, "citi": [412, 415], "cityblock": [412, 415, 485], "ciufo": 122, "cl": [125, 127, 131, 133, 134, 135, 195, 491, 492, 499], "clade": [400, 402, 407, 409, 413, 416, 450, 452, 453, 454, 458, 459, 462, 463, 479, 511], "clade_s": 409, "cladogenesi": 304, "claim": [138, 142], "clarifi": 53, "clariti": 116, "clark": [296, 297], "class": [3, 11, 14, 19, 20, 42, 44, 47, 91, 95, 96, 97, 98, 99, 104, 105, 106, 107, 108, 109, 110, 111, 112, 113, 114, 115, 116, 117, 118, 119, 120, 121, 122, 124, 125, 127, 128, 131, 133, 134, 135, 148, 149, 151, 160, 162, 171, 172, 173, 174, 175, 176, 184, 191, 195, 209, 215, 221, 228, 229, 247, 259, 277, 291, 306, 307, 309, 310, 312, 314, 316, 317, 320, 342, 353, 356, 379, 394, 399, 400, 409, 479, 486, 487, 491, 492, 497, 498, 499, 501, 503, 504, 506], "classic": 122, "classif": [122, 321], "classmethod": [4, 5, 6, 7, 15, 16, 25, 26, 153, 181, 192, 229, 248, 249, 250, 251, 281, 293, 358, 359, 428, 429, 430, 491], "classproperti": 195, "claus": 180, "clean": [145, 450], "cleanup": [125, 127], "clear": [119, 402, 406, 423, 431, 435, 446, 450, 452, 453, 454, 456, 457, 458, 459, 460, 470, 471, 472, 475], "clear_cach": [409, 419, 431], "clinic": [340, 507], "clip_head": 96, "clip_tail": 96, "clip_to_zero": 480, "clone": 110, "clone_lib": 110, "close": [30, 34, 43, 54, 93, 94, 111, 112, 116, 118, 121, 145, 146, 157, 159, 176, 186, 190, 193, 218, 220, 223, 227, 243, 246, 259, 284, 290, 308, 313, 315, 322, 324, 383, 398, 412, 451, 468, 476, 500], "closeabl": 145, "closefd": 123, "closer": [1, 513], "clostridia": [430, 467], "closur": [258, 270, 271, 272], "clover": 110, "clr": [256, 263, 264, 274], "clustal": [30, 34, 506], "clustal_f": 108, "clustalw": 108, "cluster": [1, 298, 300, 412, 416, 428, 441, 480, 484, 508], "cmap": [1, 283, 321], "cnt": 339, "co": 304, "co2": 339, "cock": 112, "cocryst": 113, "code": [108, 111, 112, 113, 122, 156, 184, 187, 188, 189, 191, 192, 193, 194, 215, 221, 224, 225, 226, 245, 247, 304, 388, 479, 496, 508], "codon": [113, 122, 188, 191, 193, 194, 215, 225, 247], "codon_start": 113, "coeff": 298, "coeffici": [44, 297, 298, 304, 320, 333, 336, 412, 415], "coercion": 229, "col": [277, 342, 353, 368, 394], "col1": [29, 120], "col2": [29, 120], "col3": [29, 120], "collabor": 113, "collaps": [120, 406, 436, 450, 453, 454, 459], "collapse_f": 348, "collapsed_id": [348, 358, 392], "collat": 301, "collect": [19, 71, 77, 79, 145, 176, 273, 278, 318, 400], "collinear": [319, 326], "collis": 72, "colon": 116, "color": [1, 61, 62, 283, 321], "colorbar": [283, 321], "colormap": [283, 321], "colormaps_refer": 321, "column": [1, 3, 10, 19, 20, 28, 29, 86, 100, 104, 105, 111, 113, 114, 117, 118, 121, 122, 148, 162, 163, 164, 165, 166, 167, 168, 169, 170, 173, 174, 175, 176, 177, 179, 180, 181, 182, 183, 228, 229, 238, 247, 257, 258, 259, 264, 265, 266, 276, 277, 282, 287, 294, 296, 297, 298, 299, 300, 301, 304, 310, 317, 319, 321, 325, 326, 327, 329, 333, 334, 338, 339, 342, 346, 348, 353, 358, 359, 364, 368, 369, 370, 375, 384, 385, 390, 391, 392, 394, 429, 434, 488, 489], "column_count": 176, "column_missing_schem": [176, 181], "column_typ": [177, 181], "columnproperti": 176, "columnwis": 327, "com": [60, 106, 107, 108, 297, 500], "comb_f": 409, "combin": [19, 20, 21, 24, 43, 113, 264, 297, 320, 326, 370, 409, 412, 482], "combinatori": [415, 485], "come": [121, 304, 456], "comma": [114, 115, 116], "command": [120, 122, 193], "comment": [110, 111, 113, 114, 115, 121, 122, 176], "comment_char": 116, "commit": 336, "common": [22, 38, 53, 70, 106, 111, 112, 113, 120, 121, 122, 171, 172, 174, 175, 257, 277, 310, 346, 347, 400, 409, 412, 416, 424, 439, 458, 466, 467, 468, 472, 480, 506, 508, 511, 512], "commonli": [116, 120, 247, 300, 333, 416, 511], "commun": [43, 44, 49, 53, 58, 67, 70, 74, 80, 84, 85, 264, 276, 296, 297, 299, 300, 319, 321, 326, 333, 340, 468, 505], "compact": 403, "compani": 339, "compar": [1, 65, 84, 90, 106, 107, 158, 213, 239, 240, 241, 242, 244, 259, 276, 277, 298, 304, 331, 338, 339, 340, 411, 412, 413, 414, 415, 416, 422, 482, 485, 488, 489, 508, 511], "compare_bipart": [413, 414], "compare_cophenet": [415, 416, 422, 482, 511], "compare_rfd": [411, 412, 414, 415, 483], "compare_subset": [411, 413, 463, 511], "compare_tip_dist": 412, "compare_wrfd": [412, 413, 485], "comparison": [84, 85, 256, 259, 264, 304, 338, 400, 407, 408, 412, 413, 415, 416, 463, 482, 483, 485, 488], "compat": [53, 70, 84, 85, 120, 122, 191, 496], "compil": [208, 232], "complement": [184, 193, 209, 213, 214, 221, 508], "complement_map": [184, 209, 210, 221], "complementari": 407, "complet": [20, 41, 43, 49, 61, 62, 112, 113, 116, 331, 336, 413, 506], "complex": [116, 513], "compliant": [184, 215, 221], "complic": [247, 506], "compon": [20, 256, 258, 268, 269, 270, 271, 272, 316, 320, 325, 331, 408, 416, 422, 463, 513], "compos": [23, 112, 119, 176, 400], "composit": [49, 53, 70, 145, 326], "compound": 264, "comprehens": 122, "compress": [105, 123, 145, 358, 368, 369, 370, 392], "compresslevel": [123, 145], "comput": [0, 1, 22, 23, 27, 44, 47, 53, 62, 80, 82, 83, 84, 85, 86, 87, 90, 151, 231, 233, 253, 254, 255, 259, 264, 269, 273, 274, 275, 276, 281, 293, 296, 297, 298, 299, 300, 301, 304, 305, 306, 310, 311, 312, 314, 316, 317, 319, 325, 326, 327, 328, 329, 330, 331, 332, 333, 334, 408, 413, 422, 477, 478, 479, 481, 484, 500, 508, 511], "computation": 19, "concat": [28, 29], "concaten": [28, 121, 153, 229, 349, 409], "concentr": [43, 49, 340], "concept": [3, 64, 273], "conceptu": [112, 299], "concern": [19, 115, 408], "conclud": 259, "concret": 162, "condens": [291, 292, 294, 295], "condensed_form": [291, 294, 295], "condit": [1, 61, 62, 339, 388], "confer": [415, 485], "confid": [1, 43, 48, 52, 61, 264, 336, 337, 400, 405], "confirm": [1, 296, 300, 340], "conflict": [419, 460], "conform": 195, "confus": 326, "conjunct": 300, "connect": [53, 55, 70, 116, 400, 407, 412, 416, 422, 435, 441, 442, 450, 453, 454, 456, 457, 458, 462, 468, 472, 480, 482], "consens": 479, "consensu": [184, 195, 215, 221, 412, 479, 482], "consensus_tre": 479, "consequ": 58, "conserv": [53, 60, 61, 70, 108, 229, 259, 276], "consid": [3, 23, 43, 44, 53, 60, 70, 84, 85, 111, 116, 176, 228, 235, 254, 256, 270, 301, 318, 338, 339, 340, 408, 411, 412, 413, 414, 415, 435, 436, 439, 441, 456, 457, 458, 462, 463, 468, 472, 473, 475, 481, 483, 485, 488, 501], "consider": [60, 70, 162, 176, 339], "consist": [3, 6, 74, 107, 111, 112, 114, 117, 118, 120, 121, 122, 177, 228, 245, 247, 339, 407, 408, 412, 435, 443, 465, 478], "constant": [52, 256, 259, 292, 298, 338], "constitut": [1, 247, 251], "constrain": [320, 326], "constraint": [117, 320, 326, 333], "construct": [25, 33, 113, 122, 149, 162, 166, 169, 170, 176, 183, 184, 195, 215, 221, 247, 249, 251, 252, 269, 276, 302, 319, 345, 346, 347, 348, 349, 364, 373, 379, 381, 382, 386, 387, 394, 395, 412, 419, 429, 430, 460, 477, 478, 480, 482, 484, 505, 506], "constructor": [20, 21, 24, 31, 108, 111, 112, 113, 118, 119, 121, 126, 130, 140, 184, 191, 215, 221, 228, 238, 247, 302], "consum": [20, 24, 127, 184, 191, 215, 221, 228], "consumpt": [301, 331, 348, 480], "contain": [1, 3, 19, 20, 22, 24, 29, 35, 36, 37, 38, 39, 40, 41, 44, 82, 83, 86, 87, 90, 96, 100, 104, 106, 108, 109, 110, 111, 112, 114, 115, 117, 118, 120, 121, 122, 123, 148, 160, 164, 166, 169, 170, 171, 173, 174, 176, 177, 178, 182, 183, 184, 191, 196, 198, 201, 202, 203, 204, 205, 206, 215, 217, 219, 221, 228, 233, 235, 236, 237, 244, 245, 253, 254, 259, 273, 274, 276, 277, 280, 281, 283, 286, 293, 295, 296, 297, 298, 299, 300, 301, 303, 305, 319, 321, 323, 326, 348, 358, 359, 388, 392, 403, 407, 412, 455, 462, 477, 478, 479, 480, 481, 482, 495, 501, 504, 508, 511], "content": [20, 22, 110, 111, 112, 113, 114, 116, 120, 123, 125, 126, 127, 174, 182, 184, 187, 197, 199, 210, 214, 221, 224, 229, 508], "context": [1, 19, 74, 146, 147, 254, 321, 407, 416], "contextu": 501, "contigu": [114, 149, 235], "conting": [264, 333, 342, 396], "continu": [35, 36, 37, 319], "contrast": [70, 273, 416, 436, 472, 480], "contribut": [22, 70, 72, 304, 325, 330], "control": [29, 111, 296, 298, 299, 305, 331, 333, 336, 338, 339, 340, 346, 356, 373], "control_cat": [338, 339], "controversi": 67, "contruct": 506, "conveni": [0, 19, 30, 34, 69, 93, 94, 139, 143, 157, 159, 186, 190, 218, 220, 223, 227, 243, 246, 284, 290, 322, 324, 383, 398, 451, 462, 476, 512], "convent": [53, 84, 85, 106, 110, 113], "convers": [3, 112, 145, 292, 373, 400], "convert": [1, 3, 7, 100, 101, 102, 103, 106, 108, 110, 111, 113, 116, 118, 121, 145, 162, 169, 170, 183, 184, 207, 215, 221, 228, 231, 245, 256, 277, 294, 297, 375, 380, 382, 390, 391, 405, 406, 472, 480, 490], "convert_underscor": 116, "convienc": 439, "coo_matrix": 274, "coord": [5, 305, 306, 309, 310, 316, 317], "coord_data": 305, "coordin": [1, 3, 5, 9, 96, 98, 113, 119, 149, 151, 152, 153, 158, 264, 274, 300, 305, 310, 316, 317, 320, 321, 325, 331, 332, 333], "cophenet": [412, 422, 441, 482, 511], "copi": [20, 111, 118, 121, 151, 160, 171, 174, 228, 244, 277, 285, 288, 334, 341, 396, 400, 420, 431, 456, 457, 458, 459, 460, 464, 473, 474, 481], "copy_from": 151, "copyright": [111, 118], "corbet": 54, "cornish": [184, 195, 215, 221, 228], "cornwel": 70, "corr": 1, "corr_coeff": [298, 304], "correct": [47, 48, 49, 51, 55, 59, 75, 76, 111, 259, 264, 456, 457, 458, 506], "correl": [1, 269, 275, 276, 297, 298, 301, 303, 304, 320, 326, 327, 333, 336, 340, 412, 415, 511], "correspond": [1, 6, 28, 43, 53, 70, 84, 85, 91, 96, 98, 102, 109, 111, 112, 114, 119, 121, 138, 142, 167, 176, 191, 193, 212, 225, 226, 238, 247, 259, 273, 277, 320, 325, 326, 329, 340, 348, 353, 358, 360, 362, 363, 374, 375, 392, 394, 395, 400, 407, 424, 428, 429, 434, 444, 467, 479], "cospeci": 304, "cost": [269, 275, 331, 480], "costli": 0, "could": [1, 20, 62, 109, 111, 112, 119, 123, 136, 139, 141, 143, 259, 264, 277, 296, 298, 299, 300, 301, 304, 321, 338, 387, 506], "count": [0, 3, 20, 21, 24, 27, 29, 32, 44, 45, 46, 47, 48, 49, 50, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 71, 72, 73, 74, 75, 76, 77, 78, 79, 80, 81, 82, 84, 85, 86, 87, 90, 105, 108, 111, 112, 118, 121, 211, 212, 233, 237, 239, 241, 255, 256, 259, 264, 304, 326, 332, 339, 340, 341, 348, 362, 378, 382, 388, 409, 411, 413, 414, 444, 479, 483, 506], "counts2": 340, "counts_001": 336, "counts_010": 336, "counts_100": 336, "counts_interv": [336, 339, 340], "coupl": 151, "covari": [70, 327], "cover": [151, 248, 511], "coverag": [44, 52, 56, 62, 106, 107], "cprofil": 513, "cran": [273, 296, 297, 298, 299, 300], "crd": 111, "creat": [1, 3, 4, 5, 6, 7, 11, 14, 15, 16, 19, 20, 21, 24, 25, 26, 28, 30, 31, 32, 33, 93, 110, 111, 114, 116, 118, 120, 128, 130, 140, 145, 146, 149, 151, 152, 153, 157, 169, 170, 171, 174, 183, 184, 186, 195, 215, 218, 221, 223, 228, 243, 244, 249, 251, 252, 259, 268, 276, 281, 283, 284, 287, 293, 295, 302, 304, 310, 319, 321, 322, 342, 348, 355, 356, 362, 363, 365, 366, 368, 373, 374, 379, 380, 381, 383, 384, 386, 387, 389, 394, 395, 397, 399, 406, 410, 431, 451, 456, 457, 458, 459, 460, 480, 487, 496, 498, 506, 508, 511, 513], "create_d": [342, 399], "create_format": [123, 125, 126, 127], "creation": [358, 392, 393, 506], "creation_d": [392, 393], "credibl": 264, "criteria": [156, 165, 180, 338, 426, 453, 454, 471], "critic": [336, 337, 339, 340, 405], "critiqu": [51, 75], "crop": 122, "cross": 113, "cross_refer": 110, "csc": [342, 392], "csc_matrix": 392, "csr": [342, 392], "csr_matrix": 392, "csv": [106, 115, 506], "ctaa": 113, "ctaacccccttttctcaga": 0, "ctagctagta": 110, "ctataaaaaa": 113, "ctattatact": 110, "ctc": 245, "ctcaaaagtc": 245, "ctcaaaattc": 110, "ctcttctagt": 110, "ctgtttgtta": 110, "cttcatgtat": 110, "cttccaattt": 110, "cttgacatag": 110, "cttgatgata": 110, "cuaa": 113, "cual": 120, "cuauaaaaaa": 113, "cucumel": [412, 482], "cug": 193, "cuguuuguua": 110, "cultur": 339, "cumbersom": 120, "cumul": [60, 80, 108, 109, 331], "cup": [413, 415], "cuppini": 55, "curat": 122, "curr": 409, "current": [73, 104, 106, 109, 110, 111, 112, 113, 118, 120, 121, 122, 151, 155, 176, 177, 189, 194, 226, 248, 259, 286, 298, 317, 323, 325, 358, 392, 406, 407, 408, 409, 416, 417, 420, 421, 424, 426, 427, 431, 432, 433, 436, 437, 438, 441, 442, 443, 461, 462, 463, 465, 482, 483, 485, 505], "curti": 1, "curv": [55, 60, 67, 326, 336, 339, 340], "custom": [0, 1, 74, 122, 184, 191, 195, 215, 221, 231, 321, 331, 358, 386, 392, 408, 409, 412, 415, 458, 463, 473, 482, 485, 493, 508], "custom_metr": 231, "customiz": 412, "customsequ": 195, "cutoff": [259, 479], "cuucauguau": 110, "cuugacauag": 110, "cw": 121, "cy": 215, "cyanogen": 110, "cystein": 215, "cytokin": 339, "cytophagia": [430, 467], "cytosin": [184, 221], "czech": 405, "d": [1, 19, 20, 44, 45, 46, 47, 48, 49, 50, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 71, 72, 73, 74, 75, 76, 77, 78, 79, 80, 81, 84, 85, 86, 106, 107, 113, 116, 117, 184, 215, 221, 249, 256, 257, 258, 259, 262, 263, 264, 265, 266, 267, 269, 270, 271, 272, 273, 274, 275, 276, 278, 283, 289, 295, 296, 297, 298, 299, 300, 304, 310, 314, 317, 320, 321, 330, 339, 340, 341, 342, 349, 364, 365, 385, 399, 401, 403, 405, 406, 407, 408, 409, 411, 412, 413, 414, 415, 416, 417, 418, 421, 422, 424, 425, 426, 427, 433, 435, 436, 439, 440, 441, 442, 443, 445, 447, 448, 449, 450, 455, 456, 457, 458, 459, 460, 461, 462, 463, 465, 466, 468, 469, 470, 471, 472, 473, 475, 479, 480, 482, 483, 484, 485, 506, 508, 511, 513], "d1": [122, 508], "d136": 122, "d143": 122, "d2": 508, "d3": 508, "d_": [66, 77], "d_1": 412, "d_2": 412, "d_a": 373, "d_b": 373, "d_d": 116, "d_w": 80, "d_x": 298, "d_y": 298, "da": 256, "daili": 122, "danger": 1, "dash": 120, "data": [1, 3, 20, 29, 53, 55, 67, 70, 82, 84, 85, 86, 87, 90, 100, 103, 105, 106, 109, 110, 112, 114, 115, 117, 119, 120, 121, 122, 145, 148, 162, 173, 176, 177, 184, 195, 215, 221, 228, 247, 256, 257, 258, 259, 260, 263, 264, 266, 268, 269, 273, 275, 277, 285, 291, 297, 304, 305, 308, 313, 315, 318, 319, 321, 323, 325, 326, 330, 331, 333, 336, 338, 339, 340, 342, 343, 345, 348, 353, 355, 356, 357, 358, 359, 360, 362, 363, 364, 365, 366, 368, 369, 374, 377, 379, 380, 381, 382, 384, 386, 387, 389, 390, 391, 392, 394, 395, 396, 397, 400, 416, 429, 480, 482, 483, 484, 485, 486, 495, 501, 505, 506, 507, 508, 513], "data_fh": 357, "data_fram": 297, "data_pump": 359, "data_typ": [358, 392], "databas": [106, 107, 110, 113, 120, 122, 149, 429], "datafram": [1, 20, 86, 100, 106, 107, 122, 162, 169, 174, 175, 176, 183, 184, 215, 221, 228, 259, 264, 278, 287, 289, 296, 297, 299, 300, 301, 305, 310, 317, 319, 320, 321, 325, 326, 332, 333, 338, 339, 346, 375, 391, 429, 430, 488, 508], "datapoint": 67, "dataset": [87, 104, 109, 256, 264, 319, 326, 331, 358, 392], "datatyp": [104, 318], "date": [110, 358, 359, 392, 393], "datetim": [392, 393], "dayhoff": 248, "db": 111, "db_xref": [110, 113], "dbsourc": 110, "dbxref": [113, 114], "ddbj": 113, "ddl": [358, 392], "ddof": [269, 275, 330, 334], "de": [110, 121, 413], "deal": [109, 110, 144, 256, 268, 331, 506], "debug": [44, 501, 502, 513], "debug_post_st": 513, "debug_pre_st": 513, "debug_runtim": 513, "debug_trac": 513, "decemb": 112, "decid": 513, "decim": [116, 120, 489], "decis": 413, "declar": [117, 120], "decod": [112, 145], "decomposit": [70, 87, 103, 256, 300, 331], "decompress": 145, "decor": [123, 125, 126, 127, 151, 195, 479, 487, 492, 493, 497, 498, 499, 501, 503, 504], "decreas": 318, "deem": 326, "deep": [20, 45, 151, 228, 279, 288, 400, 417, 420, 473], "deepcopi": [20, 474], "deeper": [84, 85], "def": [108, 123, 125, 126, 127, 195, 231, 413, 513], "default": [0, 1, 6, 10, 11, 19, 20, 21, 22, 24, 29, 31, 34, 35, 36, 37, 39, 40, 44, 48, 53, 58, 60, 67, 70, 71, 72, 74, 81, 82, 86, 94, 106, 111, 113, 114, 115, 116, 118, 119, 120, 123, 124, 125, 127, 131, 133, 156, 159, 162, 165, 176, 180, 184, 188, 189, 190, 191, 193, 194, 195, 207, 215, 220, 221, 225, 226, 227, 231, 235, 245, 246, 257, 258, 259, 264, 265, 266, 268, 277, 278, 281, 283, 286, 290, 293, 297, 298, 300, 301, 302, 310, 318, 321, 323, 324, 330, 331, 333, 334, 341, 342, 348, 353, 356, 358, 363, 365, 368, 369, 370, 372, 373, 376, 378, 379, 380, 381, 382, 386, 388, 392, 393, 394, 395, 397, 398, 401, 402, 406, 408, 409, 410, 411, 412, 413, 414, 415, 416, 417, 418, 420, 421, 422, 423, 433, 435, 436, 440, 441, 443, 445, 446, 447, 448, 449, 450, 452, 453, 454, 456, 457, 458, 459, 460, 462, 463, 465, 468, 469, 470, 471, 472, 473, 475, 476, 477, 478, 479, 480, 481, 482, 483, 485, 488, 489, 493, 495, 501, 504, 506, 508, 511, 513], "default_column": 106, "default_gap_char": [22, 23, 29, 184, 195, 215, 221], "default_missing_schem": [176, 181], "default_rng": [336, 339, 340, 496], "default_write_format": [20, 96, 97, 127, 151, 176, 228, 277, 320, 342, 400], "defaultdict": 374, "defer": 151, "defin": [1, 5, 9, 20, 29, 31, 37, 40, 44, 45, 46, 47, 49, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 63, 64, 65, 66, 67, 70, 71, 72, 73, 74, 75, 77, 80, 81, 90, 111, 112, 113, 114, 116, 117, 118, 119, 120, 122, 123, 124, 149, 151, 155, 176, 184, 191, 192, 195, 207, 209, 215, 221, 228, 231, 236, 237, 245, 247, 248, 250, 255, 257, 258, 262, 263, 265, 266, 267, 270, 271, 272, 277, 283, 298, 301, 321, 336, 356, 358, 373, 381, 392, 397, 400, 413, 416, 437, 462, 463, 474, 477, 478, 480, 481, 484, 488, 502, 506, 508, 511, 513], "definit": [1, 20, 22, 49, 96, 97, 109, 110, 111, 112, 113, 114, 122, 174, 184, 187, 188, 189, 191, 193, 194, 195, 197, 198, 199, 202, 203, 205, 206, 208, 210, 214, 215, 221, 224, 225, 226, 229, 248, 358, 392, 480, 481, 498, 508, 512, 513], "definite_char": [184, 195, 215, 221], "deflin": 111, "degap": [211, 212, 508], "degener": [20, 22, 23, 96, 97, 109, 110, 111, 112, 113, 114, 174, 184, 187, 188, 189, 191, 193, 194, 195, 196, 197, 199, 202, 203, 205, 206, 207, 208, 210, 211, 212, 214, 215, 221, 224, 225, 226, 229, 248, 508], "degenerate_char": 195, "degenerate_map": [184, 195, 199, 215, 221, 508], "degenerate_mod": 23, "degre": [43, 49, 70, 108, 264, 269, 275, 330, 331, 337, 339], "deiman": 121, "del": [6, 10, 20, 115, 171, 174, 207, 319], "delet": [10, 20, 151, 160, 171, 174, 409, 410, 419, 453, 454], "delgado": [256, 273], "delim": 353, "delimit": [114, 115, 117, 119, 122, 276, 353, 357, 360, 394], "delta": [70, 268, 330], "demograph": 507, "demonstr": [123, 171, 172, 174, 175, 496], "dempqsv": 245, "demultiplex": 318, "den": 273, "dendrogram": [412, 416], "denomin": [257, 273], "denominator_col": 257, "denominator_idx": [257, 258], "denot": [49, 70, 75, 79, 80, 111, 259, 264, 296, 299, 300], "dens": [105, 348, 351, 356, 359, 368, 369, 370, 379, 390, 391, 399], "densiti": 395, "dep": 336, "depend": [11, 48, 51, 52, 53, 58, 70, 82, 84, 85, 86, 111, 112, 121, 125, 126, 127, 145, 212, 277, 298, 302, 314, 331, 358, 479, 501, 502, 506, 511, 513], "deprec": [41, 42, 53, 70, 79, 84, 85, 90, 195, 205, 206, 259, 268, 410, 412, 414, 420, 439, 453, 454, 460, 464, 468, 474, 480, 487], "depth": [70, 319, 336, 339, 340, 409, 433, 440, 447, 448, 449, 469, 511], "deriv": [36, 37, 39, 40, 51, 110, 228, 235, 265, 266, 273, 339, 480], "derives_from": 114, "desc": 228, "descend": [32, 70, 158, 400, 407, 408, 409, 417, 433, 434, 439, 443, 453, 454, 462, 463, 465, 468, 469, 481, 511], "descending_branch_length": 468, "describ": [0, 1, 11, 23, 35, 38, 43, 45, 46, 49, 52, 53, 56, 57, 59, 61, 62, 63, 64, 65, 70, 71, 75, 84, 85, 90, 105, 110, 111, 112, 113, 114, 117, 118, 120, 121, 176, 181, 228, 235, 238, 269, 275, 276, 285, 292, 298, 304, 331, 332, 348, 354, 358, 392, 393, 407, 413, 434, 457, 477, 478, 480, 481, 507, 508, 511], "descript": [19, 44, 53, 60, 66, 77, 82, 84, 85, 86, 104, 106, 111, 112, 113, 114, 116, 118, 120, 122, 148, 162, 171, 173, 277, 392, 479, 508, 511], "description_newline_replac": [111, 112], "descriptor": [113, 332], "deseri": [276, 320], "design": [1, 87, 104, 105, 110, 120, 176, 276, 338, 400], "desir": [55, 61, 106, 115, 375, 387, 459, 513], "desper": [477, 478, 481], "destin": 228, "detach": [3, 452], "detail": [3, 11, 14, 19, 20, 28, 29, 41, 42, 61, 62, 70, 87, 89, 90, 91, 95, 96, 97, 98, 99, 110, 111, 112, 113, 114, 118, 119, 121, 122, 123, 124, 128, 148, 149, 151, 160, 162, 171, 173, 174, 176, 184, 191, 194, 195, 209, 215, 221, 228, 247, 264, 277, 291, 294, 296, 297, 298, 299, 300, 301, 304, 306, 307, 309, 310, 312, 314, 316, 317, 318, 320, 321, 325, 326, 331, 333, 338, 339, 340, 341, 342, 400, 402, 406, 413, 415, 423, 424, 425, 435, 446, 450, 452, 453, 454, 456, 457, 458, 459, 470, 471, 472, 475, 480, 482, 483, 485, 486, 491, 492, 501, 503, 504, 506], "detect": [111, 113, 120, 138, 142, 259, 298, 340, 345], "determin": [1, 20, 53, 58, 70, 72, 82, 84, 85, 86, 115, 123, 134, 135, 145, 161, 162, 164, 168, 172, 175, 176, 177, 178, 191, 202, 203, 204, 205, 213, 217, 228, 259, 277, 300, 304, 318, 331, 336, 338, 339, 342, 348, 407, 413, 415, 469, 479, 513], "determinist": [54, 296, 300], "devdoc": 496, "develop": [1, 11, 87, 90, 110, 120, 125, 126, 127, 259, 505, 513], "deviat": [297, 330, 333, 334, 337, 409], "df": [106, 107, 122, 264, 287, 296, 297, 300, 321, 337, 391, 447, 448, 449, 469], "di": [55, 508], "diag": 370, "diagnos": 513, "diagon": [104, 293, 295, 370], "diagram": 149, "diamet": 441, "dict": [19, 20, 25, 30, 31, 33, 34, 35, 36, 37, 38, 39, 40, 41, 42, 93, 94, 110, 113, 126, 136, 138, 139, 141, 142, 143, 149, 152, 156, 157, 159, 171, 176, 181, 184, 186, 188, 189, 190, 195, 209, 215, 218, 220, 221, 223, 225, 226, 227, 228, 233, 237, 243, 246, 247, 249, 252, 284, 286, 290, 298, 301, 314, 322, 323, 324, 343, 344, 358, 359, 360, 363, 373, 374, 381, 383, 392, 397, 398, 408, 429, 430, 434, 444, 451, 463, 466, 476, 501, 508, 513], "dict_of_metadata": 344, "dictionari": [25, 31, 33, 42, 121, 122, 124, 149, 151, 152, 156, 171, 172, 228, 249, 252, 286, 298, 323, 356, 429], "did": [44, 111, 119, 136, 141, 146, 513], "didn": [111, 513], "diet": 338, "differ": [0, 1, 20, 22, 23, 25, 35, 36, 37, 48, 53, 60, 71, 75, 77, 84, 85, 107, 109, 111, 112, 118, 121, 122, 123, 162, 188, 191, 213, 225, 228, 229, 230, 231, 234, 239, 240, 241, 242, 244, 254, 259, 264, 276, 277, 296, 299, 300, 304, 309, 317, 319, 325, 326, 331, 333, 339, 340, 395, 407, 408, 411, 412, 413, 414, 415, 416, 480, 482, 483, 485, 488, 489, 506, 508, 511], "differenti": [20, 259, 264], "difficult": 1, "digit": 120, "dim": 109, "dimens": [20, 96, 97, 109, 117, 118, 257, 261, 265, 266, 277, 300, 320, 321, 331, 332], "dimension": [1, 102, 109, 258, 270, 271, 272, 277, 285, 292, 319, 325, 332, 333, 339, 340, 384, 509], "direct": [120, 122, 326, 408, 440, 447, 448, 449, 450, 463, 473, 474, 475], "direct_io": [353, 393, 394], "direction": 489, "directli": [20, 21, 24, 120, 184, 191, 215, 221, 228, 253, 259, 304, 393, 394, 442, 472, 496, 501, 513], "dirichilet": 264, "dirichlet": 264, "disabl": [1, 53, 82, 84, 85, 86, 331, 431, 480, 513], "disallow": [116, 121, 298], "disallow_negative_branch_length": 480, "discard": [113, 298, 356], "disconnect": [402, 452], "discov": [1, 73, 419], "discoveri": 1, "discrep": 49, "discret": 79, "discuss": [70, 74, 84, 85, 120, 513], "diseas": [259, 298, 346], "disjoint": [349, 479], "disjointiderror": [345, 349], "disk": [111, 176, 277], "dism": 269, "disperison": 300, "dispers": 300, "displai": [110, 191, 233, 244, 301, 320, 331, 493], "disrupt": [185, 200, 216, 222, 508], "dissimilar": [83, 86, 115, 269, 276, 277, 278, 279, 280, 281, 282, 283, 285, 286, 288, 289, 412, 413, 415, 416], "dissimilaritymatrix": [104, 115, 247, 269, 276, 291, 302], "dist": [433, 441], "dist_f": [409, 412], "distanc": [1, 19, 70, 83, 84, 85, 86, 87, 89, 90, 101, 104, 115, 116, 239, 241, 247, 257, 269, 303, 304, 321, 325, 326, 328, 331, 333, 400, 409, 411, 412, 413, 414, 415, 416, 421, 433, 435, 441, 445, 456, 457, 458, 477, 478, 480, 481, 482, 483, 484, 485, 511], "distance_filt": 19, "distance_matrix": [296, 297, 299, 300, 328, 331], "distancematrix": [86, 87, 90, 101, 104, 115, 253, 269, 276, 277, 286, 287, 296, 297, 298, 299, 300, 301, 302, 304, 321, 331, 412, 416, 477, 478, 480, 481, 482, 483, 484, 485], "distant": [433, 441], "distantli": 458, "distinct": [22, 68, 79, 254, 276, 417], "distinguish": [18, 49, 70, 416], "distort": 256, "distribut": [43, 52, 60, 110, 264, 270, 302, 331, 336, 337, 339, 340, 388, 412], "div": 122, "diverg": [1, 416], "divers": [276, 341, 468, 505], "divid": [108, 273, 328, 330, 334, 348], "divis": [191, 273, 334, 407], "dj": 111, "dm": [104, 276, 277, 278, 283, 286, 287, 289, 295, 296, 297, 300, 301, 321, 477, 478, 480, 481, 482, 483, 484, 485], "dm1": 301, "dm2": 301, "dm_fh": 276, "dm_from_np": 276, "dmp": 429, "dna": [0, 3, 8, 20, 21, 22, 24, 25, 27, 28, 29, 31, 32, 33, 36, 39, 41, 108, 110, 111, 112, 113, 114, 118, 119, 121, 174, 175, 191, 195, 196, 197, 198, 199, 200, 201, 202, 203, 204, 205, 206, 208, 209, 210, 211, 212, 213, 214, 216, 221, 222, 224, 228, 229, 235, 245, 277, 506, 508], "dna_seq": [110, 111, 113], "dnaful": 248, "do": [1, 20, 21, 24, 67, 102, 104, 109, 111, 118, 120, 123, 145, 184, 215, 221, 228, 242, 254, 259, 298, 301, 310, 333, 342, 356, 379, 388, 405, 410, 424, 459, 511, 513], "do_someth": 513, "do_something_awesom": 513, "do_something_els": 513, "doc": [86, 108, 110, 111, 118, 120, 149, 176, 181, 277, 285, 291, 292, 392, 479, 496, 506], "docstr": [148, 162, 173, 493, 497], "doctest": 358, "document": [1, 20, 89, 105, 111, 113, 118, 119, 259, 321, 342, 358, 392, 399, 506, 510], "doe": [20, 21, 22, 24, 29, 32, 41, 53, 70, 106, 108, 109, 111, 112, 114, 116, 118, 121, 145, 164, 178, 191, 193, 229, 248, 254, 276, 285, 286, 294, 296, 298, 300, 310, 323, 331, 339, 340, 352, 374, 375, 392, 406, 426, 427, 446, 460, 462, 467, 472, 479, 481, 482, 485, 488, 497, 498, 506], "doesn": [29, 111, 120, 181, 193, 270, 274, 325, 335, 456, 457, 458, 473, 512], "doi": [19, 41, 110, 112, 269, 275, 477, 478, 480, 481], "domain": [121, 215, 429, 467], "domin": [45, 51, 58, 59, 64, 75, 76, 77, 80], "dominance_": 43, "domrachev": 122, "don": [1, 19, 29, 111, 120, 211, 212, 257, 259, 301, 333, 340, 407, 457], "done": [23, 259, 300, 308, 313, 315, 342], "donor": [402, 423, 435], "doubl": [44, 47, 62, 69, 136, 141, 325, 331], "doubleton": [1, 47, 48, 50, 52, 69], "doubt": 120, "down": 400, "download": [110, 113, 122], "dqyhrykedvgimkdqnmdsyrfsiswprilpkgklsgginhegikyynnli": 110, "dr": 110, "draw": [264, 336, 338, 339, 340, 403], "draw_mod": [336, 340], "drawn": [264, 302, 336, 339, 340], "driver": [1, 51], "drop": [149, 151, 177, 228, 301, 319, 326, 356, 453, 454, 479], "drop_all_miss": 177, "drop_all_uniqu": 177, "drop_missing_valu": [165, 168], "drop_zero_vari": 177, "dt": 110, "dt_rich": 348, "dtype": [0, 1, 8, 20, 21, 22, 23, 24, 27, 28, 29, 31, 32, 108, 109, 111, 112, 118, 119, 121, 174, 176, 183, 196, 197, 198, 201, 206, 210, 214, 219, 228, 229, 240, 242, 245, 259, 277, 295, 296, 300, 319, 342, 372, 376, 390, 399, 466, 508], "due": [43, 116, 155, 268, 297, 300, 326, 339, 481, 484], "dump": [122, 511, 513], "dunn": 110, "duplic": [20, 29, 90, 112, 120, 121, 155, 245, 280, 416, 419, 494], "duplicatenodeerror": [53, 70, 82, 84, 85, 86, 416, 419], "duplicateregistrationerror": [125, 126, 127], "dure": [29, 111, 149, 229, 300, 373, 393, 394, 410, 415, 419, 431, 473, 475, 482, 483, 485, 495], "dx": 55, "e": [0, 1, 19, 20, 23, 27, 32, 49, 54, 55, 56, 57, 58, 59, 60, 65, 66, 70, 71, 72, 73, 74, 75, 77, 79, 84, 85, 86, 87, 90, 106, 107, 108, 110, 111, 112, 113, 115, 116, 117, 118, 119, 120, 121, 122, 123, 149, 154, 162, 172, 176, 181, 182, 193, 215, 217, 219, 224, 228, 229, 232, 233, 247, 254, 259, 264, 273, 274, 276, 277, 278, 283, 289, 291, 295, 296, 297, 298, 299, 300, 321, 328, 329, 338, 339, 341, 349, 353, 358, 375, 388, 392, 401, 403, 405, 406, 407, 408, 409, 412, 413, 415, 416, 417, 418, 421, 422, 424, 425, 426, 427, 431, 433, 435, 436, 439, 440, 441, 442, 443, 445, 447, 448, 449, 450, 455, 456, 457, 458, 459, 461, 462, 463, 465, 466, 467, 468, 469, 470, 471, 472, 473, 475, 479, 480, 482, 483, 485, 489, 494, 501, 506, 508, 511, 513], "e1004075": [269, 275], "e157": 70, "e_": [265, 266], "e_1": [265, 266], "e_d": 77, "e_h": 71, "e_i": 266, "e_matrix": 329, "each": [0, 1, 3, 4, 5, 6, 9, 14, 16, 19, 20, 22, 23, 27, 28, 31, 35, 36, 37, 38, 39, 40, 41, 53, 67, 82, 84, 85, 86, 87, 90, 91, 108, 109, 110, 111, 112, 113, 114, 115, 116, 117, 118, 120, 121, 122, 149, 151, 152, 176, 182, 184, 189, 194, 195, 199, 209, 215, 221, 226, 228, 229, 233, 235, 237, 247, 254, 259, 261, 264, 268, 270, 271, 272, 273, 276, 277, 280, 281, 293, 296, 297, 298, 299, 300, 301, 304, 305, 306, 307, 309, 310, 311, 312, 316, 317, 318, 319, 320, 321, 326, 327, 329, 330, 331, 333, 336, 339, 340, 348, 356, 358, 369, 375, 377, 389, 392, 395, 400, 407, 408, 409, 412, 413, 416, 417, 440, 441, 448, 449, 456, 457, 458, 463, 469, 473, 479, 482, 483, 484, 485, 496, 498, 506, 508, 513], "earlier": 513, "earth": 87, "earthmicrobiom": 87, "easi": [111, 112, 120], "easier": [20, 149, 247], "easili": [115, 508], "ebi": [35, 38, 110, 113, 149], "ec_numb": 110, "ecoli": [107, 345], "ecolog": [1, 51, 319, 326], "ecologi": [1, 51, 53, 54, 58, 63, 64, 75, 80, 259, 296, 297, 298, 299, 319, 325, 326, 331, 332, 333, 468], "ecologist": 325, "ed": [55, 109], "edg": [116, 304, 325, 400, 403, 412, 466, 477, 478, 481, 484], "edgel": 264, "edit": [120, 298, 431], "editor": 111, "edu": [11, 44, 48, 108, 111, 116, 118, 479], "educ": [0, 338], "edward": 113, "eeb": [44, 48], "eeeee": 121, "eeeeeeee": 121, "eeeeeeeeeeh": 121, "eeeeeeeehhh": 121, "ef": 413, "effect": [19, 41, 43, 49, 51, 58, 59, 74, 84, 85, 120, 145, 245, 278, 336, 338, 339, 340, 487, 493], "effici": [0, 3, 115, 294, 331, 407, 408, 409, 462, 463, 473, 480, 482, 483, 485], "effort": 113, "eg": 149, "egozcu": [256, 265, 266, 269, 273, 275], "eh": 53, "eifcyilkinitilqfsitengmnefndatlpveeallntyridyyyrhlyi": 110, "eigendecomposit": [300, 331], "eigenvalu": [300, 320, 325, 331, 333], "eigenvector": [326, 331], "eigh": [300, 331], "eight": 340, "eigval": [117, 320], "either": [1, 20, 29, 31, 35, 36, 37, 70, 106, 120, 121, 125, 126, 127, 176, 195, 212, 235, 255, 298, 300, 318, 321, 323, 325, 330, 338, 340, 346, 347, 373, 381, 389, 408, 412, 413, 415, 456, 479, 481], "elem": [358, 392], "element": [6, 19, 115, 145, 247, 261, 265, 266, 277, 281, 293, 317, 321, 325, 329, 330, 334, 337, 339, 340, 341, 342, 358, 361, 377, 392, 407, 462, 494, 498], "elementwis": 328, "elev": [297, 472], "ellaps": 400, "elong": 470, "els": [12, 13, 116, 123, 126, 136, 141, 208, 228, 327, 356, 380, 395, 409], "elsevi": [298, 319, 325, 326, 332, 333], "elsewher": [53, 82, 84, 85, 86], "emb": [96, 97], "embed": [319, 505], "embedding_ptr": 109, "embeddingvector": [99, 100, 101, 102, 103], "embl": [113, 122, 149, 186, 190, 218, 220, 223, 227, 243, 246], "embl_gen": 110, "embl_str": 110, "emboss": [35, 38], "emboss_needl": 35, "emboss_wat": 38, "embptr": 109, "embryophyta": 110, "emdptr": 109, "emorg": 107, "emperor": 321, "emploi": 48, "empti": [11, 20, 54, 107, 111, 114, 118, 134, 135, 172, 174, 233, 259, 280, 338, 342, 367, 381, 384, 385, 407, 462, 467, 488, 506], "en": [43, 51, 58, 59, 111, 112, 121, 480], "ena": [110, 113], "enabl": [3, 256, 392, 431, 501, 513], "encod": [3, 10, 92, 104, 111, 112, 119, 123, 124, 145, 162, 176, 273, 319], "encode_miss": [169, 170, 183], "encount": [1, 51, 75, 120, 421, 422, 424, 433], "encourag": 339, "end": [0, 11, 19, 20, 35, 36, 37, 38, 39, 40, 41, 96, 106, 107, 110, 111, 112, 113, 114, 121, 122, 149, 151, 152, 158, 193, 230, 234, 402, 423, 457, 473, 493, 499], "endpoint": [340, 416], "enforc": [111, 176, 228], "engel": 65, "engin": 501, "english": [116, 298], "enough": [51, 111, 116, 340], "enrol": 340, "ens_": 51, "ens_pi": 51, "ensur": [1, 19, 23, 53, 84, 85, 123, 184, 215, 221, 261, 264, 268, 277, 291, 336, 388, 406, 439, 488, 496], "entail": [53, 82, 84, 85, 86], "entir": [1, 6, 7, 19, 20, 171, 184, 215, 221, 228, 342, 392, 396, 400, 402, 417, 424, 425, 427, 439, 453, 454, 493, 496, 506], "entiti": [79, 95, 149, 392], "entrez": 122, "entri": [55, 104, 105, 110, 122, 277, 318, 353, 356, 378, 379, 394, 395, 399], "entropi": [23, 58, 72, 74, 81], "enumer": 19, "env": [297, 352], "environ": [44, 84, 85, 270, 326, 390], "environment": [70, 297, 319, 326, 331, 332], "enzym": 67, "eq": [328, 329], "equal": [1, 3, 6, 20, 23, 42, 43, 44, 58, 79, 84, 85, 86, 111, 149, 151, 162, 176, 191, 228, 247, 254, 270, 277, 296, 298, 299, 300, 302, 304, 318, 325, 330, 334, 339, 340, 341, 342, 354, 415, 479, 480, 482, 485, 488, 489], "equat": [47, 48, 54, 67, 298, 415], "equit": [43, 71, 77], "equival": [20, 51, 53, 58, 59, 70, 72, 74, 112, 120, 189, 194, 211, 214, 226, 228, 233, 244, 254, 259, 277, 278, 289, 298, 319, 331, 411, 413, 414, 420, 468, 469, 482, 483, 485, 508], "erb": [269, 275], "eredi": 55, "erik": [19, 41], "error": [1, 23, 53, 67, 70, 82, 84, 85, 86, 111, 112, 118, 120, 123, 145, 155, 176, 182, 245, 296, 298, 300, 336, 340, 397, 419, 421, 422, 433, 459, 490, 506], "escap": 116, "especi": [104, 111, 120, 304, 333], "essenti": [113, 416], "esti": 52, "estim": [19, 43, 44, 47, 48, 52, 54, 56, 60, 61, 62, 67, 73, 264, 330, 338, 339, 340, 457, 477, 478, 481, 484], "estrang": 116, "esty_ci": 56, "et": [259, 304, 342, 399], "etc": [30, 34, 55, 93, 94, 111, 112, 120, 136, 138, 139, 141, 142, 143, 149, 157, 159, 186, 190, 218, 220, 223, 227, 243, 246, 247, 284, 290, 322, 324, 331, 333, 375, 383, 398, 451, 476, 507, 508], "euclidean": [101, 256, 276, 297, 325, 331, 333, 412, 415, 482], "euclidian": 331, "eudicotyledon": 110, "eukaryota": 110, "euryarchaeota": [430, 467], "evalu": [53, 70, 106, 107, 228, 276, 297, 318, 336, 409, 457, 484, 511, 513], "evaul": 123, "even": [20, 35, 36, 37, 57, 58, 65, 71, 77, 111, 116, 193, 296, 300, 340, 453, 454, 463], "evenli": [270, 321], "everi": [44, 120, 122, 177, 247, 258, 270, 271, 272, 273, 274, 286, 301, 323, 406, 409, 427, 434, 436, 472], "evid": [110, 116], "evmltdiprlhindpimk": 121, "evoltuion": [477, 478], "evolut": [111, 116, 118, 303, 304, 405, 415, 416, 477, 478, 479, 480, 481], "evolutionari": [53, 247, 248, 400, 412, 415, 416, 422, 468], "ex": 513, "exact": [53, 70, 82, 84, 85, 86, 120, 149, 229, 331, 506], "exactli": [20, 21, 24, 28, 38, 39, 40, 111, 112, 118, 123, 169, 176, 191, 228, 274, 321, 400, 403, 407, 436, 437, 472], "examin": [501, 513], "exampl": [0, 1, 3, 4, 5, 6, 8, 9, 10, 16, 18, 20, 21, 22, 23, 24, 25, 27, 28, 29, 31, 32, 33, 53, 84, 85, 86, 96, 97, 115, 120, 123, 125, 126, 127, 146, 149, 151, 153, 158, 171, 172, 174, 175, 176, 184, 185, 187, 188, 189, 191, 192, 193, 194, 195, 196, 197, 198, 199, 200, 201, 202, 203, 204, 205, 206, 208, 210, 211, 212, 213, 214, 215, 216, 217, 219, 221, 222, 224, 225, 226, 228, 229, 230, 231, 232, 233, 234, 235, 236, 237, 238, 239, 240, 241, 242, 244, 245, 247, 248, 249, 251, 254, 255, 257, 258, 259, 260, 261, 262, 263, 264, 265, 266, 267, 268, 269, 270, 271, 272, 273, 274, 275, 277, 278, 283, 286, 287, 289, 295, 296, 297, 298, 299, 300, 301, 302, 303, 304, 318, 321, 331, 338, 339, 340, 341, 345, 346, 347, 348, 349, 351, 352, 353, 355, 356, 357, 358, 359, 360, 362, 363, 364, 365, 366, 368, 369, 370, 371, 372, 373, 374, 375, 376, 379, 380, 381, 382, 384, 386, 387, 388, 389, 390, 391, 392, 394, 395, 397, 401, 402, 403, 405, 406, 407, 408, 409, 411, 412, 413, 414, 415, 416, 417, 418, 421, 422, 423, 424, 425, 426, 427, 429, 430, 432, 433, 435, 436, 437, 438, 439, 440, 441, 442, 443, 445, 446, 447, 448, 449, 450, 452, 453, 454, 455, 456, 457, 458, 459, 460, 461, 462, 463, 465, 466, 467, 468, 469, 470, 471, 472, 473, 475, 477, 478, 479, 480, 481, 482, 483, 484, 485, 488, 490, 496, 500, 506, 507, 508, 509, 511, 513], "example_protein_embed": 109, "example_t": [105, 351, 370, 371, 372, 375, 376, 390, 391], "exce": [111, 118, 331, 435], "exceed": 120, "excel": [112, 120], "except": [1, 111, 116, 117, 118, 120, 126, 193, 280, 299, 326, 417, 461, 473, 479, 502, 512], "exchang": 481, "excit": 513, "exclud": [119, 273, 293, 295, 412, 413, 415, 473], "exclude_absent_taxa": 414, "exclude_attr": 473, "exclus": [123, 149, 151, 152, 230, 234, 259], "execut": [123, 307, 314, 501, 504, 513], "exercis": 338, "exhibit": 325, "exist": [0, 31, 44, 49, 105, 116, 123, 125, 126, 127, 134, 135, 193, 247, 248, 276, 281, 293, 298, 301, 321, 352, 358, 364, 410, 423, 435, 446, 452, 459, 462, 473, 495, 504, 508], "exon": [114, 149, 174, 221, 228, 238], "exp": [58, 74, 258, 263, 269, 275], "expand": [304, 375, 467], "expect": [1, 87, 106, 123, 133, 184, 215, 221, 264, 265, 266, 276, 304, 325, 326, 333, 348, 357, 358, 373, 392, 466, 513], "expens": 342, "experi": [0, 73, 110, 113, 120, 259, 264, 339], "experienc": 340, "experiment": [110, 507], "explain": [113, 114, 117, 305, 310, 317, 319, 320, 325, 331, 333], "explan": [325, 326], "explanatori": [304, 319, 320, 326, 333], "explic": 413, "explicit": [112, 400], "explicitli": [20, 70, 118, 120, 245, 319, 409, 413, 415, 431, 453, 454, 463], "explor": [1, 83, 319], "exploratori": 1, "expon": [72, 81, 116, 272], "exponenti": [58, 74], "export": 120, "expos": [358, 496], "express": [80, 208, 232, 264, 269, 275, 339, 508], "extend": [0, 19, 21, 29, 35, 36, 37, 38, 39, 40, 53, 339, 402, 479, 482, 483, 485, 506], "extens": [110, 120], "extern": 116, "extinct": 53, "extra": [122, 123, 296, 297, 299, 300, 314], "extract": [264, 276, 277, 296, 300, 326, 405, 508], "extrapol": [61, 62, 336], "extrem": 298, "f": [1, 19, 29, 45, 61, 70, 87, 105, 106, 107, 109, 112, 116, 119, 121, 122, 146, 215, 298, 299, 300, 326, 329, 336, 339, 347, 348, 358, 381, 384, 392, 394, 395, 401, 403, 405, 406, 407, 408, 409, 412, 413, 415, 416, 417, 418, 421, 422, 424, 425, 426, 427, 433, 439, 440, 441, 442, 443, 445, 447, 448, 449, 455, 456, 457, 458, 459, 461, 462, 463, 465, 468, 469, 470, 471, 472, 473, 475, 479, 482, 483, 485, 511], "f_1": [44, 47, 52, 56, 73], "f_2": [47, 52], "f_i": 44, "f_onewai": 259, "fabacea": 110, "fabal": 110, "fabid": 110, "facili": 409, "facilit": [53, 84, 85, 87, 104, 291, 319, 336, 409, 419], "fact": 193, "factor": [70, 84, 85, 296, 299, 304, 326, 340, 412], "factori": [123, 125, 126, 127, 130, 140], "fail": [53, 54, 70, 82, 84, 85, 86, 155, 300, 336, 501, 513], "fail_callback": [501, 513], "fail_f": 513, "failur": [44, 501, 513], "fairli": 304, "faith": [1, 53, 70, 276, 468], "faith_pd": [1, 70, 468], "fall": [55, 60, 70, 85, 318], "fals": [1, 12, 13, 19, 20, 21, 22, 24, 27, 28, 32, 35, 36, 37, 47, 48, 49, 51, 59, 70, 74, 75, 76, 82, 84, 85, 86, 96, 97, 106, 109, 110, 111, 112, 113, 114, 116, 119, 125, 126, 127, 145, 146, 149, 151, 153, 154, 165, 168, 169, 170, 171, 172, 174, 175, 177, 183, 184, 187, 188, 189, 191, 193, 194, 195, 196, 197, 198, 199, 201, 202, 203, 204, 205, 206, 207, 208, 210, 212, 213, 214, 215, 217, 219, 221, 224, 225, 226, 228, 229, 233, 235, 236, 237, 238, 239, 240, 241, 242, 244, 245, 259, 264, 269, 275, 277, 278, 286, 293, 294, 298, 301, 304, 305, 306, 309, 310, 316, 323, 331, 333, 336, 338, 339, 341, 348, 355, 356, 359, 367, 368, 369, 370, 378, 379, 381, 385, 388, 390, 391, 392, 395, 397, 401, 403, 407, 408, 411, 412, 413, 414, 415, 416, 417, 418, 421, 422, 426, 431, 432, 433, 436, 437, 438, 441, 443, 445, 452, 453, 454, 456, 457, 458, 459, 462, 463, 465, 467, 468, 469, 471, 473, 477, 478, 480, 481, 482, 483, 484, 485, 487, 489, 493, 501, 504, 508, 511, 513], "famili": 1, "far": 325, "farri": 457, "farthest": 457, "fasffbf": 112, "fast": [53, 84, 85, 300, 305, 331, 373, 477, 478, 481], "fasta": [20, 30, 34, 112, 114, 119, 186, 190, 218, 220, 223, 227, 228, 243, 246, 506], "fasta_fl": 111, "fasta_format": 111, "faster": [1, 53, 84, 85, 87, 189, 194, 226, 233], "fastnni": 481, "fastq": [30, 34, 119, 186, 190, 218, 220, 223, 227, 243, 246, 506], "fastq_format": 112, "favor": 41, "fc": 264, "fd": [53, 500], "fdr_bh": [259, 264], "featur": [1, 55, 68, 103, 105, 111, 114, 120, 121, 149, 151, 153, 155, 156, 158, 160, 176, 184, 215, 221, 228, 256, 259, 264, 273, 320, 323, 325, 326, 332, 333, 388, 431, 489, 507, 508, 509], "feature_t": 113, "fecal": 340, "federhen": 122, "fee": [111, 118], "felsenstein": [111, 118, 415, 511], "fernand": 264, "fernandez": [256, 268], "ferr": 113, "fetch": [151, 388, 511], "fetureid": 120, "few": [20, 43, 53, 84, 85, 87, 358, 392, 506, 511, 513], "fewer": [44, 118, 339, 340], "fff": 112, "ffffx": 112, "ffllssssyi": 191, "fglfmeqlttgdysksmrrivknrlpkfskfesslvngsfdfiginyysssi": 110, "fh": [106, 107, 108, 111, 112, 113, 114, 118, 119, 121, 122, 123, 125, 126, 127], "field": [1, 107, 112, 119, 191, 319, 358, 392], "fifth": 111, "fig": [1, 283, 321], "figur": [283, 321, 486], "file": [30, 34, 93, 94, 104, 105, 106, 107, 108, 109, 112, 114, 115, 116, 117, 118, 119, 120, 121, 122, 123, 126, 130, 136, 138, 139, 140, 141, 142, 143, 144, 145, 146, 147, 157, 159, 176, 181, 186, 190, 218, 220, 223, 227, 243, 246, 259, 276, 283, 284, 290, 308, 313, 315, 321, 322, 324, 338, 342, 345, 346, 347, 348, 349, 353, 357, 358, 360, 364, 373, 379, 381, 382, 383, 386, 387, 392, 393, 394, 395, 398, 399, 405, 451, 476, 495, 500, 511], "fileformaterror": 123, "filehandl": [30, 34, 93, 94, 123, 125, 126, 127, 136, 138, 139, 141, 142, 143, 145, 146, 157, 159, 186, 190, 218, 220, 223, 227, 243, 246, 284, 290, 322, 324, 383, 398, 451, 476], "filenam": 495, "filepath": [30, 34, 93, 94, 136, 138, 139, 141, 142, 143, 145, 157, 159, 181, 186, 190, 218, 220, 223, 227, 243, 246, 284, 290, 301, 322, 324, 383, 398, 451, 476], "filesentinel": [123, 125, 127], "filter": [19, 23, 41, 119, 163, 164, 176, 177, 178, 197, 301, 346, 347, 388, 467, 513], "filter_column": 178, "filter_f": 467, "filter_fn": 356, "filter_id": [165, 177, 180], "final": [121, 304, 348, 393, 394, 445, 513], "find": [0, 54, 185, 196, 198, 200, 201, 206, 216, 219, 222, 234, 235, 240, 242, 297, 300, 304, 326, 340, 369, 401, 407, 410, 419, 421, 422, 425, 426, 427, 431, 432, 433, 435, 437, 438, 439, 442, 445, 455, 461, 462, 470, 473, 475, 481, 494], "find_al": [419, 424, 426], "find_by_func": [424, 425], "find_by_id": [404, 424, 425, 426], "find_motif": [235, 508], "find_with_regex": [235, 508], "fine": 395, "finit": [49, 51, 59, 75, 76], "firmicut": [375, 429, 430, 467], "first": [1, 3, 18, 19, 20, 35, 36, 37, 38, 39, 40, 41, 44, 53, 84, 85, 91, 96, 109, 111, 112, 113, 114, 115, 116, 117, 118, 120, 121, 122, 123, 127, 153, 158, 188, 189, 193, 225, 228, 234, 235, 257, 258, 259, 264, 270, 277, 296, 298, 309, 317, 319, 327, 331, 336, 339, 353, 364, 394, 405, 407, 419, 424, 425, 431, 434, 440, 447, 448, 449, 467, 469, 472, 493, 497, 502, 506, 511, 513], "fish": 319, "fisher": 54, "fit": [67, 264, 318, 320, 333, 512], "five": [111, 122, 259, 283, 477, 478, 480, 481], "fix": [61, 115, 118], "fl": 111, "flag": [122, 511], "flat": [113, 235], "flatfil": 110, "flatten": 330, "flexibl": 400, "flip": 473, "float": [23, 27, 35, 36, 37, 38, 39, 40, 41, 42, 45, 46, 49, 51, 53, 54, 55, 56, 57, 58, 59, 60, 61, 63, 64, 65, 66, 67, 70, 71, 72, 73, 74, 75, 77, 80, 81, 82, 84, 85, 86, 87, 90, 104, 106, 113, 115, 116, 120, 176, 183, 211, 212, 231, 239, 241, 251, 254, 255, 259, 264, 268, 272, 275, 276, 277, 281, 293, 298, 300, 302, 304, 307, 314, 321, 331, 337, 339, 340, 341, 342, 358, 359, 361, 362, 373, 389, 392, 400, 408, 411, 412, 413, 414, 415, 421, 422, 433, 435, 441, 456, 458, 463, 466, 468, 479, 488], "float32": [104, 109, 300, 390], "float64": [1, 29, 104, 109, 229, 259, 295, 300, 319, 358, 392], "flush": 145, "fmet": 193, "fn": 495, "focu": 123, "focus": [176, 333], "fold": [264, 506], "folder": 495, "follow": [1, 20, 29, 41, 48, 53, 54, 70, 84, 85, 106, 107, 108, 109, 110, 111, 112, 113, 114, 115, 116, 117, 118, 119, 120, 121, 122, 123, 149, 171, 172, 174, 175, 176, 184, 215, 221, 228, 248, 257, 258, 259, 262, 263, 265, 266, 267, 270, 272, 273, 276, 277, 296, 297, 298, 300, 301, 305, 321, 340, 404, 449, 450, 496, 501, 506, 511, 513], "foo": [114, 120, 151, 228, 342, 348, 349, 358, 359, 374, 384, 392, 394, 395, 500, 513], "foobar": [349, 513], "foral": [262, 263], "foraminifera": 45, "ford": 70, "form": [1, 20, 35, 147, 277, 291, 295, 343, 344, 353, 357, 394, 458, 463, 466], "formal": [112, 122, 256], "format": [3, 11, 16, 30, 34, 93, 94, 128, 129, 130, 131, 132, 133, 134, 135, 136, 137, 138, 139, 140, 141, 142, 143, 148, 149, 157, 159, 173, 176, 181, 186, 190, 191, 208, 218, 220, 223, 227, 243, 246, 277, 284, 285, 290, 291, 292, 294, 308, 313, 315, 322, 324, 336, 339, 340, 342, 353, 357, 358, 359, 360, 383, 390, 392, 393, 394, 398, 399, 400, 403, 405, 429, 451, 476, 480, 486, 510, 511], "format_f": 392, "format_nam": [131, 132, 133], "format_object": 129, "format_url": 359, "format_vers": [105, 342, 358, 392, 399], "formatidentificationwarn": [136, 141], "former": [247, 425], "formula": [55, 300], "forum": 120, "forward": [1, 189, 191, 193, 194, 226], "fould": [411, 413, 414, 415, 483, 485], "found": [19, 79, 105, 107, 110, 111, 112, 113, 116, 118, 121, 136, 139, 141, 143, 245, 280, 297, 298, 300, 340, 358, 392, 416, 424, 425, 426, 427, 439, 459, 460, 468, 479], "foundat": 112, "four": [20, 112, 121, 184, 215, 221, 259, 321, 409, 498], "fourment": [416, 422], "fourth": [3, 72], "fr": 479, "frac": [44, 45, 46, 47, 49, 51, 52, 54, 55, 56, 57, 58, 59, 60, 63, 64, 65, 66, 67, 71, 72, 73, 77, 80, 81, 257, 258, 262, 267, 268, 270, 271, 272, 273, 298, 333], "fraction": [45, 255, 331, 340, 361, 511], "fraction_diff": 231, "fraction_sam": 231, "frame": [100, 106, 107, 189, 191, 193, 194, 226, 264, 297, 429], "framework": [70, 256, 478, 481], "free": [122, 501, 513], "freedom": [264, 269, 275, 330, 337], "freq": [233, 237], "frequenc": [1, 23, 27, 43, 44, 56, 211, 212, 237, 239, 241, 336, 338, 340, 400, 405], "frequent": [342, 409], "friedman": 259, "friedmanchisquar": 259, "from": [0, 1, 2, 3, 4, 5, 6, 7, 8, 9, 10, 14, 15, 16, 18, 19, 20, 21, 22, 23, 24, 25, 26, 27, 28, 29, 30, 31, 32, 33, 35, 36, 37, 38, 39, 40, 49, 51, 53, 60, 70, 74, 79, 80, 84, 85, 93, 96, 97, 105, 106, 107, 108, 109, 110, 111, 112, 113, 114, 115, 116, 117, 118, 119, 120, 121, 122, 123, 125, 126, 127, 136, 137, 141, 149, 150, 151, 153, 154, 157, 162, 163, 169, 170, 171, 172, 174, 175, 176, 181, 182, 183, 184, 185, 186, 187, 188, 189, 191, 193, 194, 195, 196, 197, 198, 199, 200, 201, 202, 203, 204, 205, 206, 208, 210, 211, 212, 213, 214, 215, 216, 217, 218, 219, 221, 222, 223, 224, 225, 226, 228, 229, 230, 231, 232, 233, 234, 235, 236, 237, 238, 239, 240, 241, 242, 243, 244, 245, 247, 248, 249, 251, 252, 254, 255, 257, 258, 259, 260, 261, 262, 263, 264, 265, 266, 267, 268, 269, 270, 271, 272, 273, 274, 275, 276, 277, 278, 281, 283, 284, 286, 287, 289, 293, 295, 296, 297, 298, 300, 301, 302, 304, 305, 306, 318, 319, 321, 322, 325, 326, 328, 329, 331, 336, 338, 339, 340, 341, 345, 346, 347, 348, 349, 351, 352, 355, 356, 357, 358, 359, 360, 362, 363, 364, 365, 366, 368, 369, 370, 371, 372, 373, 374, 375, 376, 379, 380, 381, 382, 383, 384, 385, 386, 387, 388, 389, 390, 391, 392, 394, 395, 397, 400, 401, 402, 403, 404, 405, 406, 407, 408, 409, 410, 411, 412, 413, 414, 415, 416, 417, 418, 419, 421, 422, 423, 424, 425, 426, 427, 428, 429, 430, 432, 433, 435, 436, 437, 438, 439, 440, 441, 442, 443, 444, 445, 446, 447, 448, 449, 450, 451, 452, 453, 454, 455, 456, 457, 458, 459, 460, 461, 462, 463, 465, 466, 467, 468, 469, 470, 471, 472, 473, 474, 475, 477, 478, 479, 480, 481, 482, 483, 484, 485, 490, 496, 497, 500, 501, 508, 511, 513], "from_": 278, "from_dict": [33, 296, 300, 305, 321, 338, 339], "from_hdf5": 392, "from_iter": 253, "from_ncbi": [191, 193, 194, 225, 226], "from_path_seq": 7, "from_tabular": [3, 8], "from_taxdump": 430, "from_taxonomi": [429, 467], "front": [158, 273], "frontier": 70, "frozenset": [407, 408, 409, 462, 463], "fsvd": [300, 331], "ft_current": 149, "ftp": [110, 122, 149], "full": [61, 62, 108, 109, 259, 342, 348, 370, 408, 427, 495], "full_genome_avail": [356, 381], "fulli": [3, 70, 113, 506], "fun": 513, "func": [360, 384, 409, 426, 453, 454, 471, 492, 503, 504], "function": [1, 35, 36, 37, 43, 53, 54, 61, 62, 67, 69, 84, 85, 86, 87, 90, 111, 112, 119, 124, 125, 126, 127, 131, 132, 133, 149, 151, 153, 184, 191, 215, 221, 231, 247, 254, 256, 257, 258, 259, 262, 263, 264, 265, 266, 273, 281, 286, 293, 297, 298, 299, 300, 301, 302, 305, 318, 323, 326, 331, 335, 338, 339, 340, 342, 348, 353, 356, 358, 360, 373, 381, 384, 386, 392, 393, 394, 395, 399, 403, 409, 412, 415, 426, 453, 454, 460, 467, 468, 471, 480, 482, 483, 484, 485, 487, 488, 489, 490, 491, 492, 493, 495, 496, 497, 498, 499, 501, 503, 504, 506, 507, 508, 511, 512], "functionfor": 302, "funtion": 209, "further": [20, 123, 176, 339, 409, 453, 454, 511], "furthest": 441, "futher": 123, "futur": [53, 70, 84, 85, 111, 480], "fuzzi": [114, 149, 150, 151, 152, 153, 228], "g": [0, 1, 19, 20, 23, 24, 29, 37, 40, 55, 60, 67, 70, 87, 90, 106, 108, 110, 111, 112, 113, 115, 116, 117, 118, 120, 122, 123, 149, 162, 176, 181, 184, 201, 211, 212, 215, 221, 228, 229, 230, 232, 233, 235, 247, 248, 251, 254, 259, 264, 273, 276, 277, 291, 295, 296, 297, 299, 300, 321, 331, 339, 340, 358, 375, 388, 392, 401, 406, 407, 409, 412, 416, 418, 425, 431, 440, 447, 448, 449, 450, 456, 457, 458, 459, 461, 462, 463, 467, 468, 469, 471, 472, 473, 475, 479, 482, 501, 506, 508, 511, 513], "g1": 300, "g2": 300, "g_m": 262, "ga": [228, 508], "gaa": 508, "gaagcaatgc": 110, "gaagttgagt": 110, "gaatcaagcc": 110, "gabor": [19, 41], "gac": 236, "gacccgcuuu": 508, "gacg": 236, "gacgtt": [203, 204], "gag": 245, "gagatagagt": 110, "gagcccgggc": [111, 118], "gagccgtggc": [111, 118], "gagcggaggc": 110, "gaggacttcg": 110, "gaggtattgg": 110, "gagrctc": 245, "gain": [176, 276, 331], "gair": 111, "gairaagccttggc": 118, "gamma": 44, "gap": [0, 3, 4, 6, 8, 10, 14, 15, 19, 20, 22, 23, 27, 29, 35, 36, 37, 38, 39, 40, 96, 97, 106, 107, 108, 109, 110, 111, 112, 113, 114, 118, 174, 184, 185, 187, 188, 189, 191, 193, 194, 195, 197, 199, 200, 204, 207, 210, 211, 212, 214, 215, 216, 221, 222, 224, 225, 226, 228, 229, 235, 245, 254, 467, 508, 513], "gap_char": [184, 195, 197, 215, 221], "gap_charact": 245, "gap_extend_penalti": [19, 35, 36, 37, 38, 39, 40], "gap_mod": 23, "gap_open_penalti": [19, 35, 36, 37, 38, 39, 40], "gapopen": [106, 107], "garbag": 145, "gardnerella": 340, "garrison": [19, 41], "gascuel": [477, 478, 480, 481], "gaston": 53, "gataccttca": 110, "gatcacttga": 110, "gatcttcccc": 110, "gatgcaacac": 110, "gather": [289, 511], "gattattcta": 110, "gattttcgag": 110, "gauu": [240, 242], "gb": [107, 113], "gb_str": 113, "gbk": 113, "gc": [20, 22, 110, 111, 112, 113, 114, 122, 174, 184, 187, 191, 194, 197, 199, 210, 212, 214, 221, 224, 229, 508], "gc_content": 212, "gc_frequenc": 211, "gcaattttca": 110, "gcacatccct": 113, "gcacaucccu": 113, "gcagaagctg": 110, "gcagatgtg": 255, "gcatgcatgc": 114, "gcatggtcat": 110, "gcaugcaucugcauacguacguacgcaugca": 108, "gcaugcaucugcauacguacguacgcaugcagucgauacauacguacgucgguacgu": 108, "gcaugcaucugcauacguacguacgcaugcauca": 108, "gccaaaccca": 110, "gcccagtagcttcccaatatgagagcatcaattgtagatcgggcc": 0, "gccccccuuu": 508, "gcgtatagtt": 110, "gcgtgcctaaggtatgcaag": 0, "gctaactaggctcccttctacccctctcagaga": 0, "gctgccgaga": 110, "gctgttattt": 110, "gcttcatctt": 110, "gen": [114, 513], "gen1": 114, "gen2": 114, "gena": 149, "genbank": [110, 114, 122, 186, 190, 218, 220, 223, 227, 243, 246], "gender": [276, 338, 339], "gene": [1, 114, 149, 151, 153, 156, 184, 228, 264, 269, 275, 342, 399, 507], "gene_nam": 149, "genea": 345, "geneb": 345, "gener": [1, 5, 9, 10, 18, 21, 24, 35, 41, 42, 43, 58, 61, 62, 63, 70, 72, 81, 87, 109, 112, 113, 114, 116, 121, 122, 125, 127, 131, 133, 136, 141, 144, 184, 209, 221, 228, 232, 235, 236, 247, 256, 264, 276, 294, 296, 297, 298, 299, 300, 301, 302, 304, 318, 320, 321, 325, 331, 336, 338, 339, 340, 341, 358, 368, 369, 377, 381, 392, 412, 428, 460, 469, 474, 482, 496, 506, 508, 512], "generated_bi": [342, 359, 392, 393, 399], "generatortyp": [368, 370, 381], "genet": [111, 116, 118, 122, 188, 189, 191, 192, 193, 194, 225, 226, 303, 416, 422, 479, 508], "genetic_cod": [225, 226], "geneticcod": [189, 225, 226, 508], "genom": [1, 11, 151], "genpept": 113, "gentil": 273, "genu": [1, 122], "geologi": 256, "geometr": [260, 262, 264, 273, 300], "geometri": [256, 258, 262, 263, 266], "geq": 333, "gerald": 273, "get": [20, 42, 105, 109, 120, 145, 146, 150, 151, 191, 192, 276, 298, 318, 326, 356, 363, 364, 365, 366, 372, 374, 376, 378, 379, 397, 418, 486, 496, 506], "get_alpha_diversity_metr": [1, 82, 89], "get_beta_diversity_metr": [1, 86, 88, 90], "get_column": 180, "get_id": [163, 164, 168, 178, 179], "get_max_dist": 441, "get_nam": 248, "get_trajectori": 305, "get_value_by_id": 351, "getaaafhwqaaf": 119, "getvalu": [108, 111, 112, 113, 114, 118, 121, 276], "gff": 114, "gff3": [113, 151, 157, 159, 186, 190, 243, 246], "gff_str": 114, "gfgmvinn": 121, "gfp": 508, "gfv": 121, "gg": [185, 200, 216, 222, 230], "gg_otu_1": [358, 359], "gg_otu_2": 359, "gg_otu_3": 359, "gg_otu_4": 359, "gg_otu_5": 359, "gga": 508, "ggaa": 229, "ggacugaa": 508, "ggag": [185, 200, 216, 222], "ggattgttta": 110, "ggca": 0, "ggctaacggt": 110, "ggg": 508, "ggggagg": [185, 200, 216, 222], "gggtttttac": 110, "ggt": [121, 244], "ggta": 0, "ggtaccaacg": 244, "ggtacgcaag": 0, "ggtc": 197, "ggtccattc": 197, "ggtggtttct": 110, "ggtgtttagc": 110, "ggtt": 352, "ggu": 228, "gguc": [228, 231, 239, 240, 241, 242], "ggucg": [228, 230], "ggucguaaagga": 228, "ggucgugaag": 228, "ggucgugaagga": 228, "gi": [106, 107, 113], "giaro": 413, "gibb": [81, 416, 422], "gigasci": [321, 342, 399], "gilk": 304, "gini": [55, 75], "gish": [106, 107], "github": [11, 321], "give": [1, 116, 325, 326, 333, 342, 399, 456], "given": [1, 4, 5, 6, 16, 20, 30, 34, 44, 55, 58, 60, 67, 73, 77, 81, 82, 86, 87, 90, 93, 94, 101, 111, 112, 116, 117, 120, 125, 127, 134, 135, 136, 138, 141, 142, 154, 157, 159, 186, 190, 218, 220, 223, 227, 243, 245, 246, 273, 281, 284, 290, 293, 297, 298, 301, 322, 324, 326, 330, 331, 335, 337, 339, 363, 365, 373, 381, 383, 397, 398, 407, 413, 415, 421, 422, 425, 451, 456, 458, 473, 474, 475, 476, 478, 500, 501, 503, 513], "gkp1137": 112, "glahn": [256, 269, 275], "gln": 215, "global": [0, 35, 36, 37], "global_pairwise_align": [36, 37, 38, 39, 40], "global_pairwise_align_nucelotid": [35, 37, 38, 39, 40], "global_pairwise_align_nucleotid": 0, "global_pairwise_align_protein": [35, 36, 38, 39, 40], "gloor": 264, "glossari": 23, "glu": 215, "glucosidas": 110, "glutam": 215, "glutamin": 215, "glx": 215, "gly": 215, "glycin": [23, 215], "glycosyl": [216, 235, 508], "gme": 477, "go": [340, 388, 511, 513], "goa": 110, "goal": [120, 464, 506], "goldman": 70, "gonzalez": 321, "good": [43, 52, 56, 331], "goods_coverag": [52, 73], "googl": 120, "gorilla": [111, 118], "gorlick": 121, "goto": 112, "gotten": 20, "gouet": [61, 62], "gov": [23, 36, 37, 39, 40, 106, 107, 111, 113, 119, 122, 191, 192], "gower": 331, "gracilibacteria": 191, "gradient": [55, 319, 325, 326, 331, 333], "gradientanova": [306, 309, 316, 317], "gradientanovaresult": 311, "graft": 470, "gram": [265, 266], "grammar": [195, 228], "grammaredsequ": [20, 21, 24, 25, 35, 38, 108, 111, 118, 121, 184, 215, 221, 508], "grant": [111, 118], "graph": 400, "graphic": [416, 422], "great": 43, "greater": [111, 151, 228, 264, 296, 298, 299, 300, 301, 304, 339, 340, 341, 364], "greedi": [477, 478], "grei": 321, "group": [1, 79, 120, 208, 256, 259, 264, 273, 278, 296, 299, 300, 305, 306, 307, 311, 314, 315, 316, 319, 338, 339, 340, 343, 358, 363, 381, 392, 462, 463, 484, 501, 507, 511], "group1": 296, "group2": 296, "group3": 296, "group_md": 343, "group_observation_md": 363, "groupbi": 339, "groupresult": 307, "growth": [264, 339], "gsi": 273, "gt": [8, 20, 28, 56], "gt10": 110, "gtaacctgag": 110, "gtaag": 3, "gtacct": [108, 118], "gtagaggacc": 110, "gtagct": [108, 118], "gtatct": 118, "gtcgaa": [108, 118], "gtt": 236, "gttaatgcca": 110, "gttactcaac": 110, "gttcggcctc": 110, "gttgaccaat": 110, "gttgggatta": 110, "gtttatccaa": 110, "guaaccugag": 110, "guanin": [184, 221], "guarante": [29, 62, 120, 184, 199, 215, 221, 277, 302], "guc": 228, "gucgauacauacguacgucgguacgu": 108, "gucgauacauacguacgucguacguacgu": 108, "guess": [67, 111, 136, 141], "guidanc": 506, "gunnerida": 110, "gut": [1, 120, 321], "gytai": 121, "gzip": [145, 392], "h": [19, 44, 45, 49, 51, 57, 58, 59, 70, 71, 73, 74, 75, 77, 81, 111, 118, 121, 146, 184, 215, 221, 406, 418, 450, 456, 457, 459, 462, 463, 468, 472, 473, 475, 479, 511], "h5grp": [358, 392], "h5py": [358, 392], "h_": 259, "h_0": 55, "h_b": 46, "h_i": 55, "h_n": 55, "ha": [1, 3, 19, 20, 22, 35, 36, 37, 42, 90, 96, 97, 104, 105, 106, 107, 108, 109, 110, 111, 112, 113, 114, 115, 116, 117, 118, 119, 120, 121, 122, 123, 138, 142, 145, 161, 168, 172, 174, 175, 176, 181, 184, 187, 188, 189, 191, 193, 194, 195, 197, 199, 205, 206, 210, 214, 215, 221, 224, 225, 226, 228, 229, 261, 276, 318, 325, 327, 338, 339, 340, 348, 356, 373, 400, 406, 407, 408, 413, 431, 432, 435, 436, 437, 453, 454, 456, 459, 472, 475, 479, 480, 484, 493, 496, 497, 498, 501, 508, 511], "habitat": 326, "had": [20, 53, 84, 85, 296, 300, 340], "half": [60, 270, 407], "halko": 331, "halobacteria": [430, 467], "ham": [231, 276, 508], "hamadi": [53, 84, 85], "hand": [1, 331], "handbook": 111, "handi": [501, 513], "handl": [20, 23, 29, 111, 112, 119, 121, 122, 123, 124, 125, 127, 145, 176, 181, 193, 194, 259, 298, 300, 301, 336, 342, 348, 373, 382, 400, 412, 468, 500, 506, 513], "handler": [124, 136, 139, 141, 143, 145], "happen": [20, 116, 235, 433, 441, 479, 513], "hard": [53, 82, 84, 85, 86], "hardcod": 52, "harm": 270, "has_cach": [409, 410, 419], "has_children": [437, 438], "has_definit": [196, 198, 203, 205, 206], "has_degener": [198, 202, 205], "has_gap": 201, "has_metadata": 171, "has_missing_valu": [163, 165], "has_nuc_pattern": 513, "has_positional_metadata": 174, "has_stop": 219, "hashabl": [20, 318, 407, 408, 462, 463, 504], "hashlib": 500, "hasn": [228, 395], "have": [0, 1, 10, 19, 20, 22, 25, 27, 28, 29, 41, 43, 53, 60, 71, 77, 84, 85, 100, 101, 102, 103, 106, 107, 108, 110, 111, 112, 113, 114, 115, 116, 117, 118, 119, 120, 121, 123, 145, 149, 151, 176, 177, 182, 193, 199, 228, 229, 235, 251, 259, 274, 276, 277, 298, 304, 305, 308, 310, 313, 315, 318, 321, 326, 327, 330, 331, 333, 334, 336, 338, 339, 340, 341, 356, 358, 373, 374, 375, 388, 392, 397, 400, 404, 405, 406, 407, 416, 423, 424, 436, 456, 457, 458, 462, 466, 467, 472, 473, 477, 478, 481, 482, 485, 488, 497, 511, 513], "hcdt": 81, "hdf5": [104, 105, 109, 342, 358, 392, 399], "hdfgroup": 104, "hdist": 304, "he": 0, "header": [106, 107, 108, 112, 113, 115, 117, 120, 162, 176, 180, 353, 357], "header_kei": [353, 394], "header_valu": [353, 394], "heagawghe": 0, "health": [259, 338, 339], "healthi": [338, 339, 340], "heatmap": 283, "height": [416, 421, 480], "heip": [57, 65], "heip_": 71, "held": 388, "hello": 228, "help": [120, 122, 458], "helper": [488, 489, 511], "henc": 298, "henikoff": [37, 40, 248], "here": [0, 1, 20, 23, 44, 48, 53, 60, 67, 77, 82, 83, 84, 85, 86, 87, 88, 89, 105, 109, 110, 113, 118, 123, 125, 127, 146, 235, 259, 264, 304, 333, 358, 392, 477, 480, 481, 506, 511], "hernand": 273, "heterogen": 332, "heuer": 112, "heurist": [19, 331], "hexdigest": 500, "hgc": 122, "hi": 215, "hidden": 122, "hierarch": [122, 256, 273, 400, 412, 416, 484], "hierarchi": [348, 416, 428, 429, 441, 511], "high": [53, 84, 85, 111, 112, 264, 319, 321, 325, 331, 430, 509], "higher": [23, 43, 247, 259, 264, 325, 503], "highest": [19, 116], "highest_prior": 503, "highli": [3, 23], "highlight": 112, "hill": [59, 70, 72, 74], "histidin": 215, "histor": [1, 191], "histori": [53, 340, 416], "hit": 107, "hoc": 336, "hochberg": [259, 264], "hoffmann": 70, "hold": [291, 311, 318, 338, 389, 419, 504], "hollow": [86, 104, 277, 293, 294, 302], "holm": [259, 264], "hommola": 304, "homogen": [300, 325, 333], "homolog": 247, "horizont": 29, "host": [122, 304], "host_dist": 304, "hot": 319, "hotton": 122, "hous": 338, "how": [20, 28, 29, 67, 111, 113, 120, 145, 162, 176, 193, 194, 207, 229, 235, 269, 275, 298, 331, 336, 338, 339, 340, 342, 354, 373, 399, 506, 513], "howev": [1, 20, 53, 54, 70, 82, 84, 85, 86, 111, 115, 116, 120, 122, 184, 215, 221, 228, 256, 264, 300, 304, 319, 331, 342, 395, 400, 407, 408, 413, 415, 416, 422, 463, 468, 480, 482, 483, 485, 492], "hsp": [106, 107], "hstack": [338, 339], "ht": 11, "htm": 297, "html": [23, 60, 105, 106, 108, 111, 113, 116, 118, 121, 149, 277, 285, 291, 292, 296, 297, 298, 299, 300, 321, 342, 358, 392, 399, 479, 496], "http": [11, 19, 23, 35, 36, 37, 38, 39, 40, 41, 43, 44, 48, 60, 87, 104, 105, 106, 107, 108, 110, 111, 112, 113, 116, 118, 119, 120, 121, 122, 176, 181, 191, 192, 269, 273, 275, 277, 285, 291, 292, 296, 297, 298, 299, 300, 321, 342, 358, 359, 392, 399, 479, 480, 496, 500], "huerta": 405, "hugh": 110, "human": [104, 111, 112, 115, 116, 117, 477, 478, 481, 490], "hundr": [1, 87], "hurlbert": [51, 75], "hwang": 44, "hydrogenosom": 122, "hypothesi": [256, 259, 264, 298, 301, 304, 336], "hypothet": 149, "h\u00e9bert": 273, "i": [0, 1, 3, 6, 10, 11, 18, 19, 20, 21, 22, 23, 24, 25, 27, 28, 29, 30, 32, 34, 35, 36, 37, 38, 39, 40, 41, 42, 43, 44, 45, 46, 47, 48, 49, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 71, 72, 73, 74, 75, 76, 77, 79, 80, 81, 82, 84, 85, 86, 87, 90, 91, 93, 94, 103, 104, 105, 106, 107, 108, 109, 110, 111, 112, 113, 114, 115, 116, 117, 118, 119, 120, 121, 122, 124, 125, 126, 127, 130, 131, 133, 136, 138, 139, 140, 141, 142, 143, 145, 149, 150, 151, 152, 153, 154, 155, 157, 159, 160, 162, 171, 172, 174, 176, 181, 182, 184, 185, 186, 187, 188, 189, 190, 191, 193, 194, 195, 196, 197, 198, 199, 200, 201, 205, 206, 207, 208, 209, 210, 211, 213, 214, 215, 216, 218, 219, 220, 221, 222, 223, 224, 226, 227, 228, 229, 230, 231, 233, 234, 235, 236, 237, 238, 239, 240, 241, 242, 243, 244, 245, 246, 247, 254, 255, 256, 257, 258, 259, 261, 262, 263, 264, 265, 266, 267, 268, 269, 270, 271, 272, 273, 274, 275, 276, 277, 278, 280, 282, 283, 284, 285, 288, 289, 290, 291, 292, 293, 294, 295, 296, 297, 298, 299, 300, 302, 304, 308, 310, 313, 315, 316, 317, 318, 319, 320, 321, 322, 323, 324, 325, 326, 327, 329, 330, 331, 332, 333, 334, 336, 337, 338, 339, 340, 341, 342, 345, 348, 349, 352, 353, 355, 356, 357, 358, 364, 367, 368, 369, 370, 373, 374, 375, 381, 382, 383, 384, 385, 388, 389, 392, 393, 394, 395, 396, 397, 398, 399, 400, 402, 403, 404, 405, 407, 408, 409, 410, 411, 412, 413, 414, 415, 416, 417, 418, 419, 420, 421, 422, 424, 425, 426, 427, 429, 431, 433, 434, 435, 436, 437, 438, 439, 440, 441, 443, 444, 445, 447, 448, 449, 450, 451, 452, 453, 454, 456, 457, 458, 459, 460, 462, 463, 465, 466, 467, 468, 469, 470, 471, 472, 473, 474, 475, 476, 477, 478, 479, 480, 481, 482, 483, 484, 485, 487, 488, 489, 490, 491, 492, 493, 494, 495, 496, 497, 498, 500, 501, 502, 503, 504, 505, 506, 508, 511, 512, 513], "id": [0, 1, 20, 31, 32, 53, 70, 82, 84, 85, 86, 87, 90, 91, 100, 104, 106, 107, 108, 109, 110, 111, 112, 113, 114, 115, 117, 118, 119, 120, 121, 122, 149, 162, 164, 165, 167, 169, 170, 171, 172, 176, 177, 178, 180, 182, 183, 188, 189, 191, 192, 193, 194, 225, 226, 228, 247, 269, 276, 277, 278, 280, 281, 282, 286, 287, 289, 291, 293, 294, 295, 296, 297, 298, 299, 300, 301, 302, 310, 317, 320, 321, 323, 338, 339, 340, 342, 344, 345, 346, 347, 348, 349, 351, 352, 353, 355, 356, 357, 358, 359, 362, 364, 366, 368, 373, 374, 375, 379, 381, 382, 386, 387, 388, 391, 392, 394, 395, 396, 397, 404, 416, 417, 427, 428, 429, 430, 434, 466, 480, 482, 483, 484, 485, 508], "id1": 120, "id2": 120, "id3": 120, "id_": [348, 356, 381, 395], "id_count": 176, "id_head": [169, 170, 180, 182, 183], "id_i": 370, "id_index": 466, "id_j": 370, "id_list": 428, "id_map": 397, "id_pair": 90, "id_whitespace_replac": [111, 112], "idea": 339, "ideal": 123, "ident": [1, 106, 107, 116, 120, 277, 291, 304, 412, 413, 452, 473, 482, 511], "identif": 38, "identifi": [20, 32, 82, 86, 87, 90, 104, 108, 111, 112, 113, 114, 115, 118, 121, 122, 156, 176, 185, 216, 222, 276, 301, 336, 340, 366, 374, 397, 412, 441, 482, 483, 485, 506], "idptr": 109, "ids_to_keep": [164, 178, 356], "idx": 245, "ie": 212, "igkeeiqqrl": 109, "ignor": [19, 23, 44, 53, 84, 85, 107, 108, 110, 111, 112, 115, 116, 120, 123, 177, 185, 193, 194, 200, 216, 222, 232, 280, 296, 297, 298, 299, 300, 331, 338, 339, 381, 392, 412, 442, 477, 481, 489, 501, 508, 511, 513], "ignore_axis_label": 489, "ignore_direction": 489, "ignore_metadata": 28, "ignore_method_nam": 489, "ignore_non": 381, "ignore_self": 412, "ii": 336, "iii": 61, "ij": 298, "il": 215, "illumina": [112, 119], "illumina1": [112, 119], "illumina_1": 119, "illustr": [228, 296, 300], "iloc": 20, "ilr": [256, 266, 274], "ilr_inv": 274, "im": [114, 151, 153], "im1": 153, "im2": 153, "imagin": 116, "immedi": [111, 118, 434], "immut": [228, 508], "implement": [0, 1, 35, 38, 43, 44, 48, 53, 60, 77, 83, 84, 85, 88, 89, 112, 116, 120, 123, 125, 126, 127, 128, 145, 176, 273, 319, 325, 326, 332, 393, 394, 464, 477, 479, 481], "impli": [23, 145, 304, 408], "implicit": 373, "implicitli": [105, 109, 400], "import": [0, 1, 3, 4, 5, 6, 8, 9, 10, 16, 18, 20, 21, 22, 24, 25, 27, 28, 29, 31, 32, 33, 49, 53, 70, 84, 85, 96, 97, 105, 106, 107, 108, 109, 110, 111, 112, 113, 114, 115, 116, 117, 118, 119, 120, 121, 122, 123, 125, 126, 127, 149, 151, 153, 171, 172, 174, 175, 184, 185, 187, 188, 189, 191, 193, 194, 195, 196, 197, 198, 199, 200, 201, 202, 203, 204, 205, 206, 208, 210, 211, 212, 213, 214, 215, 216, 217, 219, 221, 222, 224, 225, 226, 228, 229, 230, 231, 232, 233, 234, 235, 236, 237, 238, 239, 240, 241, 242, 244, 245, 247, 248, 249, 251, 254, 255, 257, 258, 259, 260, 261, 262, 263, 264, 265, 266, 267, 268, 269, 270, 271, 272, 273, 274, 275, 276, 278, 283, 286, 287, 289, 295, 296, 297, 298, 300, 301, 304, 305, 318, 319, 321, 336, 338, 339, 340, 341, 345, 346, 347, 348, 349, 351, 352, 355, 356, 357, 358, 359, 360, 362, 363, 364, 365, 366, 368, 369, 370, 371, 372, 373, 374, 375, 376, 379, 380, 381, 382, 384, 386, 387, 388, 389, 390, 391, 392, 394, 395, 401, 402, 403, 405, 406, 407, 408, 409, 411, 412, 413, 414, 415, 416, 417, 418, 421, 422, 423, 424, 425, 426, 427, 429, 430, 432, 433, 435, 436, 437, 438, 439, 440, 441, 442, 443, 445, 446, 447, 448, 449, 450, 452, 453, 454, 455, 456, 457, 458, 459, 460, 461, 462, 463, 465, 466, 467, 468, 469, 470, 471, 472, 473, 475, 477, 478, 479, 480, 481, 482, 483, 484, 485, 490, 500, 506, 508, 511, 513], "import_modul": 123, "impos": [53, 84, 85], "improv": [28, 116, 118, 184, 215, 221, 293, 412, 431], "impur": 75, "imput": [256, 268], "inaccuraci": 331, "incid": 304, "includ": [1, 20, 23, 28, 30, 34, 42, 43, 53, 70, 72, 81, 84, 85, 89, 90, 108, 109, 110, 111, 112, 115, 116, 117, 118, 120, 121, 148, 157, 159, 162, 173, 176, 180, 182, 186, 187, 188, 189, 190, 193, 194, 195, 197, 211, 212, 215, 218, 220, 221, 223, 224, 225, 226, 227, 228, 235, 243, 245, 246, 247, 248, 259, 276, 277, 284, 286, 290, 293, 295, 296, 297, 299, 300, 301, 305, 320, 321, 322, 323, 324, 326, 331, 332, 340, 348, 353, 383, 390, 391, 396, 398, 400, 401, 403, 408, 415, 416, 421, 425, 433, 435, 436, 440, 442, 443, 445, 447, 448, 449, 451, 456, 457, 458, 459, 462, 463, 465, 467, 468, 469, 476, 485, 506, 507, 508, 509, 511, 512], "include_collapsed_metadata": 348, "include_end": 445, "include_ful": 463, "include_root": 421, "include_self": [401, 409, 433, 440, 443, 447, 448, 449, 462, 465, 468, 469, 511], "include_stem": 468, "include_tip": [408, 415, 463, 485], "inclus": [145, 149, 151, 152, 230, 234, 297], "incom": [402, 405, 435], "incomplet": [43, 184, 195, 215, 221, 228], "inconsist": 249, "incorpor": [1, 70, 255], "incorrect": 1, "incorrectli": 357, "increas": [264, 276, 277, 301, 302, 304, 318, 336, 339, 348, 395], "increment": [404, 482, 483, 485], "incub": 339, "ind": [336, 340], "inde": 304, "independ": [74, 189, 194, 226, 304, 307, 311, 373, 407, 412, 415, 469], "index": [0, 1, 5, 6, 9, 11, 20, 21, 24, 25, 29, 31, 32, 33, 35, 36, 37, 38, 39, 40, 41, 45, 46, 49, 51, 55, 57, 58, 59, 60, 63, 64, 66, 71, 72, 74, 75, 76, 77, 80, 81, 82, 91, 100, 108, 109, 111, 118, 119, 121, 166, 169, 170, 174, 175, 176, 183, 228, 257, 258, 259, 264, 276, 277, 287, 295, 296, 297, 298, 299, 300, 305, 310, 317, 320, 321, 338, 342, 346, 348, 358, 374, 375, 378, 391, 392, 434, 435, 446, 466, 479, 488], "indexerror": [342, 364, 446], "indic": [1, 3, 6, 10, 13, 20, 44, 47, 48, 65, 70, 90, 104, 111, 112, 120, 123, 149, 151, 161, 162, 172, 175, 176, 185, 191, 196, 198, 200, 201, 202, 203, 204, 205, 206, 216, 217, 219, 222, 228, 232, 235, 240, 242, 244, 245, 247, 259, 264, 274, 296, 298, 299, 300, 304, 318, 320, 321, 325, 331, 338, 358, 392, 426, 428, 453, 454, 471, 487, 493, 497, 503, 504, 511, 513], "indicatd": 513, "indirectli": 457, "indiscern": 291, "individu": [1, 3, 43, 44, 45, 46, 49, 52, 53, 54, 56, 60, 63, 64, 65, 66, 67, 71, 73, 75, 77, 80, 84, 85, 104, 109, 111, 176, 247, 259, 331, 338, 342, 413, 431, 513], "indptr": [358, 392], "ineffici": 342, "inekmtlva": 109, "inequ": [20, 149, 151, 162, 176, 191, 228, 291, 331, 482, 485], "inf": [10, 54, 120, 460], "infeas": 111, "infect": 340, "infer": [30, 93, 113, 120, 136, 141, 157, 181, 186, 218, 223, 243, 284, 322, 383, 451, 483, 485, 495, 506], "infern": 121, "infin": [58, 72, 81, 120], "infinit": [49, 460], "infinitum": 116, "influenc": 58, "info": [19, 41, 151, 160, 305, 314], "inform": [19, 23, 30, 34, 46, 63, 70, 72, 74, 93, 94, 106, 107, 108, 110, 111, 112, 113, 119, 120, 122, 149, 157, 159, 186, 190, 218, 220, 223, 227, 243, 246, 284, 290, 307, 314, 319, 322, 324, 333, 339, 340, 342, 348, 383, 398, 399, 408, 451, 463, 476, 501, 506, 507, 508, 513], "infti": [58, 72, 81], "ingroup": 458, "inher": [256, 304], "inherit": [3, 11, 14, 19, 20, 91, 95, 96, 97, 98, 99, 122, 124, 128, 148, 149, 151, 160, 162, 171, 173, 174, 176, 184, 191, 195, 209, 215, 221, 228, 247, 277, 291, 306, 307, 309, 310, 312, 314, 316, 317, 320, 342, 349, 400, 486, 491, 492, 501, 503, 504], "inidic": [12, 19], "initi": [67, 111, 339, 401, 440, 443, 445, 447, 448, 449, 465, 469, 480, 481, 502], "initialize_st": 513, "inlin": 120, "inner": [29, 116, 182, 229, 249], "inosin": 184, "inplac": [331, 356, 379, 380, 382, 385, 395, 397, 456, 457, 458, 459, 480, 481], "input": [35, 36, 37, 38, 39, 40, 41, 53, 70, 82, 84, 85, 86, 111, 122, 125, 127, 145, 146, 151, 153, 193, 194, 231, 244, 253, 259, 264, 274, 277, 297, 298, 318, 321, 325, 326, 328, 331, 332, 341, 357, 423, 470, 477, 478, 479, 480, 481, 482, 483, 484, 485, 505, 508], "input_is_dens": 359, "insdc": [110, 113, 149, 162, 176, 181], "insensit": [120, 248, 259, 264], "insert": [116, 152, 406, 456, 458], "insert_length": 406, "insid": [113, 116], "insight": [84, 85], "insignific": 1, "inspir": 506, "instanc": [30, 34, 61, 62, 93, 94, 109, 123, 127, 131, 133, 134, 135, 136, 141, 151, 156, 157, 159, 186, 190, 218, 220, 223, 227, 229, 243, 246, 248, 254, 255, 264, 277, 284, 290, 291, 294, 296, 298, 299, 300, 301, 302, 304, 311, 318, 321, 322, 324, 331, 338, 339, 340, 341, 345, 349, 375, 383, 398, 400, 412, 439, 451, 460, 468, 476, 479, 491, 492, 496, 506, 511, 513], "instanti": [19, 110, 123, 195, 209, 513], "instead": [1, 20, 27, 72, 110, 111, 113, 120, 123, 124, 125, 126, 127, 154, 162, 166, 233, 235, 237, 239, 241, 245, 277, 296, 298, 300, 302, 330, 339, 340, 390, 391, 400, 408, 410, 412, 413, 415, 416, 417, 420, 421, 422, 431, 441, 456, 457, 460, 463, 468, 473, 474, 482, 483, 484, 485, 506], "institut": 112, "instruct": 510, "instrument": 111, "int": [3, 4, 5, 6, 9, 10, 11, 14, 16, 19, 20, 27, 32, 35, 36, 37, 38, 39, 40, 42, 44, 45, 46, 47, 48, 49, 50, 51, 52, 53, 54, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 71, 72, 73, 74, 75, 76, 77, 78, 79, 80, 81, 82, 86, 87, 90, 106, 113, 114, 119, 126, 145, 149, 151, 152, 156, 176, 185, 191, 192, 200, 212, 216, 222, 225, 226, 228, 230, 232, 234, 235, 236, 237, 239, 241, 244, 251, 255, 257, 258, 264, 269, 275, 282, 294, 296, 298, 299, 300, 301, 302, 304, 310, 317, 318, 321, 326, 330, 331, 333, 334, 337, 338, 339, 340, 341, 348, 358, 364, 366, 388, 392, 400, 406, 412, 418, 427, 434, 435, 444, 446, 456, 458, 460, 472, 479, 482, 489, 490, 496, 500, 503], "int32": [358, 392], "int64": [20, 22, 29, 174, 197, 210, 214, 228, 358, 392, 508], "integ": [1, 19, 82, 86, 104, 106, 109, 111, 112, 115, 116, 117, 118, 119, 176, 228, 259, 264, 276, 277, 296, 299, 300, 301, 302, 317, 331, 336, 341, 404, 412, 460, 482, 483, 485, 496], "intend": [1, 61, 62, 120, 184, 195, 215, 318, 321, 488, 489], "intens": 339, "interablemetadata": 153, "interact": [304, 510], "interchang": [477, 478, 480, 481], "interconnect": 400, "interest": [1, 120, 228, 259, 276, 304, 333, 339, 439, 458, 513], "interfac": [20, 83, 120, 171, 172, 174, 175, 247, 296, 297, 298, 299, 409, 479, 506], "interface_class": 497, "interleav": [118, 121], "intermedi": 406, "intern": [32, 105, 113, 116, 274, 400, 403, 405, 413, 419, 424, 425, 434, 436, 439, 444, 448, 450, 453, 454, 459, 462, 463, 467, 468, 469, 470, 471, 472, 506, 511], "internet": [111, 122], "interpret": [1, 23, 49, 53, 73, 75, 82, 84, 85, 86, 104, 116, 120, 162, 176, 256, 325, 326, 333, 359, 480], "interpro": 110, "interquantil": 60, "interrog": 501, "intersect": [229, 373, 417], "interspecif": [51, 75], "interv": [43, 48, 52, 61, 110, 113, 114, 151, 152, 153, 154, 155, 156, 158, 160, 161, 184, 187, 210, 215, 221, 228, 264, 337], "interval_metadata": [113, 114, 149, 151, 153, 156, 160, 161, 184, 195, 215, 221, 228], "intervalmetadata": [114, 149, 150, 160, 184, 215, 221, 228], "intracellular": 121, "introduc": [44, 55, 108, 111, 256, 496], "introduct": 496, "intron": [221, 238], "intvl": 151, "inv_simpson": [51, 58, 72], "invalid": [1, 27, 29, 53, 70, 82, 84, 85, 86, 111, 181, 184, 215, 221, 297, 298, 321, 342, 399, 409], "invalidate_cach": 410, "invent": 112, "invers": [23, 49, 51, 58, 59, 72, 258, 263, 266, 271], "inverse_shannon_uncertainti": 23, "invert": [235, 356], "investig": 1, "invok": 409, "involv": [43, 70, 257], "inward": 60, "io": [1, 11, 30, 34, 84, 85, 93, 94, 157, 159, 186, 190, 218, 220, 223, 227, 243, 246, 276, 284, 290, 321, 322, 324, 357, 360, 383, 398, 400, 429, 451, 476, 500, 505, 511], "io_registri": [123, 125, 127], "ionom": 273, "ioregistri": [123, 506], "ipr001360": 110, "ipr013781": 110, "ipr017853": 110, "ipr033132": 110, "ipyparallel": 87, "ipython": 320, "irrelev": [35, 36, 37, 415], "irsairagsnvkgfyawsfldcnewfagftvrfglnfvd": 110, "is_ascii": 247, "is_bifurc": 406, "is_binary_format": 124, "is_circular": 114, "is_reverse_compl": 214, "is_root": [432, 438, 511], "is_tip": [409, 432, 437, 511], "is_zero_bas": 13, "ism": [53, 84, 85], "isn": [20, 21, 24, 29, 55, 120, 121, 146, 149, 265, 266, 375], "isnapshgnakpsystnpmtnisfekhgiplgpraasiwiyvypymfiqedf": 110, "iso": [358, 392], "isoleucin": 215, "isometr": [256, 257, 258, 265, 266], "isometri": [262, 263, 265, 266], "isomorph": [116, 262, 263, 265, 266], "issu": [110, 111, 112, 120, 126, 480, 506], "isubsampl": 341, "item": [35, 36, 37, 38, 39, 40, 41, 121, 228, 233, 244, 278, 289, 318, 341, 352, 388, 466, 467, 501, 502, 513], "iter": [20, 24, 28, 35, 36, 37, 38, 39, 40, 41, 42, 82, 86, 87, 90, 100, 101, 102, 103, 109, 119, 149, 152, 153, 154, 156, 164, 178, 228, 229, 232, 235, 244, 245, 247, 251, 259, 278, 280, 281, 289, 293, 297, 300, 301, 318, 321, 339, 340, 342, 348, 349, 356, 357, 358, 369, 370, 373, 381, 387, 395, 400, 408, 409, 417, 420, 423, 430, 435, 439, 443, 456, 457, 458, 459, 460, 463, 465, 468, 494, 500, 501, 504, 511, 513], "iter_": [370, 501], "iter_km": 233, "its": [1, 6, 20, 21, 22, 24, 25, 28, 29, 35, 36, 37, 58, 110, 111, 112, 113, 116, 117, 121, 123, 127, 145, 149, 151, 161, 172, 175, 176, 182, 184, 209, 221, 228, 233, 237, 248, 260, 277, 297, 320, 325, 327, 330, 331, 335, 356, 400, 402, 407, 408, 409, 417, 433, 435, 449, 452, 453, 454, 456, 457, 458, 462, 463, 464, 467, 469, 472, 479, 480, 482, 483, 484, 485, 487, 495, 498, 499, 506, 511], "itself": [95, 96, 97, 98, 99, 111, 118, 122, 137, 146, 149, 184, 191, 215, 221, 228, 247, 304, 320, 356, 380, 395, 400, 408, 409, 412, 461, 463, 482, 485, 508], "itypeerror": 86, "iupac": [111, 112, 118, 119, 184, 191, 193, 212, 215, 221, 228, 508], "iv": [60, 70], "j": [35, 37, 38, 40, 43, 51, 53, 56, 57, 67, 70, 71, 84, 85, 104, 106, 107, 111, 112, 113, 121, 122, 215, 248, 256, 264, 265, 266, 267, 268, 269, 273, 275, 278, 289, 298, 299, 300, 326, 331, 370, 412, 415, 416, 422, 450, 457, 459, 468, 472, 477, 478, 479, 481, 482], "j00123": 113, "j04373": 121, "jag": 375, "jaim": 405, "januari": 72, "je": 304, "jet": 1, "jim": 112, "jj": [269, 275], "joe": 118, "join": [28, 106, 107, 112, 119, 121, 122, 182, 229, 349, 416, 445, 467, 477, 478, 479, 480], "joint": 113, "joseph": [111, 118, 511], "jost": [58, 70, 74], "journal": [19, 41, 44, 47, 54, 70, 71, 74, 77, 81, 113, 269, 275, 296, 331, 413], "json": [342, 359, 393, 399], "json_obj": 359, "json_tabl": 359, "juli": [19, 41], "june": 116, "jupyt": 321, "just": [60, 61, 62, 67, 123, 342, 353, 370, 373, 394, 459, 472, 491, 506, 511, 513], "justif": 60, "jyzox": 112, "k": [19, 43, 44, 49, 56, 59, 70, 71, 72, 74, 75, 76, 77, 81, 87, 184, 215, 221, 233, 236, 237, 247, 248, 255, 273, 297, 304, 413, 415, 436, 450, 460, 466, 468, 472, 479, 483], "k_": 336, "k__a": 348, "ka": 112, "kan": 122, "kannan": 122, "kansa": 484, "karsch": 122, "keemei": 120, "keep": [109, 113, 120, 154, 228, 318, 346, 347, 356, 368, 373, 459, 473], "keep_spac": 111, "kegg_pathwai": [358, 375, 392], "kei": [11, 20, 21, 24, 25, 31, 42, 110, 111, 113, 121, 152, 156, 172, 184, 199, 215, 221, 228, 238, 244, 281, 293, 348, 352, 375, 397, 408, 444, 463, 466, 479, 513], "kellei": [84, 85], "kempton": 60, "kendalltau": 298, "kept": [79, 113, 259, 268, 410, 412, 414, 416, 421, 439, 441, 453, 454, 460, 468, 480], "kestrel": 121, "keto": 184, "keyerror": [300, 375], "keyword": [41, 110, 113, 115, 126, 136, 138, 139, 141, 142, 143, 156, 188, 189, 225, 226, 238], "kf": 415, "khovanskaya": 122, "kill": 270, "kind": 325, "kinet": 67, "kingdom": [106, 107, 122], "kit": 505, "kj": 53, "klein": 113, "kmer": [236, 237, 255], "kmer_frequ": 233, "knight": [51, 53, 84, 85, 321], "know": [1, 19, 53, 84, 85, 108, 111, 118, 121, 123, 259, 336, 506], "knowledg": [456, 506], "known": [44, 75, 116, 136, 141, 273, 274, 326, 331, 422, 447, 449, 484, 508], "kortlev": 121, "kqlaaargqr": 109, "kr": 296, "kruskal": [259, 339, 340], "kuhner": 415, "kuo": 44, "kva": [189, 194, 226], "kw": 110, "kwarg": [30, 34, 41, 82, 86, 87, 90, 91, 93, 94, 95, 96, 97, 98, 99, 125, 127, 130, 136, 138, 139, 140, 141, 142, 143, 146, 147, 157, 159, 186, 188, 189, 190, 218, 220, 223, 225, 226, 227, 243, 246, 247, 284, 290, 317, 322, 324, 342, 360, 383, 398, 451, 476, 501, 506], "kwarg1": 123, "kz": 112, "l": [19, 45, 46, 53, 58, 60, 61, 70, 74, 80, 110, 112, 122, 193, 215, 273, 298, 319, 325, 326, 332, 333, 413, 415, 467, 468, 483, 485], "l1": 20, "l2": 20, "l3": 20, "l_1": 415, "l_2": 415, "lab": [321, 339], "label": [20, 21, 24, 25, 29, 31, 32, 33, 108, 111, 113, 118, 120, 121, 273, 276, 283, 296, 297, 299, 300, 301, 320, 321, 381, 405, 415, 485, 489], "labor": 339, "lafond": 273, "lahaeavhvyktkyqayqkgkigitlvsnwlmplddnsipdikaaersldfq": 110, "lambda": [110, 318, 336, 339, 340, 348, 356, 360, 381, 384, 386, 395, 409, 426, 453, 454, 471, 479, 513], "lane": 119, "lane_numb": 119, "langl": [265, 267], "languag": [2, 96, 109], "lapoint": [273, 412, 482], "larg": [19, 54, 60, 84, 85, 104, 111, 118, 268, 297, 300, 331, 333, 339, 358, 403, 412, 459, 482, 506], "larger": [23, 58, 339, 413, 506], "largest": [19, 80, 331, 369, 382], "last": [22, 96, 110, 118, 193, 228, 235, 298, 319, 513], "latent": [96, 98, 102, 103, 331], "later": [112, 338], "latter": [1, 43, 247, 420, 425, 482, 483, 485], "law": 52, "layout": 113, "lb": 112, "lca": [53, 70, 405, 416, 458, 468], "ldot": [257, 258, 262, 263, 265, 266, 270, 271, 272], "lead": [53, 82, 84, 85, 86, 111, 112, 115], "leaf": [400, 477, 478, 481], "learn": [342, 399], "least": [67, 116, 120, 161, 172, 175, 176, 185, 200, 216, 222, 259, 298, 321, 339, 340, 432, 478, 513], "leav": [60, 110, 207, 356, 379, 453, 454], "lee": [19, 41, 44], "leesleyqqf": 109, "left": [20, 29, 44, 74, 116, 182, 257, 258, 262, 267, 270, 271, 272, 273, 405, 434, 447, 449, 488, 489, 511], "left_child_id": 466, "leftmost": 122, "legaci": [106, 107, 111, 496], "legal": 145, "legend": 321, "legendr": [298, 319, 325, 326, 328, 329, 332, 333], "len": [19, 20, 228, 248, 302, 340, 417, 445, 479, 513], "length": [0, 1, 3, 4, 5, 6, 9, 10, 14, 18, 19, 20, 21, 22, 24, 28, 35, 36, 37, 53, 70, 84, 85, 96, 97, 100, 101, 102, 103, 104, 106, 107, 109, 110, 111, 112, 113, 114, 115, 118, 119, 121, 151, 153, 174, 184, 187, 188, 189, 191, 193, 194, 195, 197, 199, 207, 210, 211, 212, 214, 215, 221, 224, 225, 226, 228, 229, 230, 233, 235, 236, 237, 239, 240, 241, 242, 245, 254, 255, 259, 264, 281, 293, 296, 299, 300, 304, 330, 331, 339, 340, 358, 392, 400, 406, 408, 409, 412, 415, 416, 421, 422, 433, 435, 441, 450, 456, 457, 458, 463, 466, 468, 470, 471, 472, 473, 475, 477, 478, 480, 481, 482, 485, 508, 511, 513], "lengtherror": 457, "leq": 256, "less": [19, 44, 53, 62, 84, 85, 87, 118, 120, 236, 237, 255, 298, 301, 318, 325, 333, 341, 348, 388, 407, 444, 482, 483, 485, 490], "lesser": 70, "let": [1, 20, 111, 112, 114, 118, 119, 121, 149, 151, 228, 244, 259, 298, 318, 335, 336, 339, 340, 369, 506, 508, 511, 513], "letter": [51, 53, 111, 113, 215], "leu": 215, "leucin": 215, "level": [32, 61, 116, 145, 176, 259, 338, 339, 429, 440, 492, 497, 508], "levelord": [447, 448, 449, 469], "leven": 300, "lewi": 70, "lexicograph": 407, "lexicon": [111, 112, 118], "lfc_result": 264, "li": 70, "librari": [19, 41, 84, 85, 111, 505, 506], "libreria": 55, "licens": 505, "life": 53, "like": [1, 20, 35, 36, 37, 87, 111, 113, 114, 115, 117, 120, 123, 238, 247, 276, 302, 304, 308, 310, 313, 314, 315, 317, 333, 339, 340, 353, 357, 360, 364, 393, 394, 409, 491, 500, 506, 513], "likelihood": 247, "likelyhood": [330, 334], "likewis": [29, 70, 121], "limit": [1, 20, 52, 106, 116, 117, 118, 338, 339, 480], "limits_": [262, 263, 266, 267, 273], "linalg": 335, "linamaras": 110, "line": [55, 108, 110, 111, 112, 113, 114, 115, 117, 118, 119, 120, 121, 122, 145, 339, 357, 360, 403, 493, 506], "lineag": [122, 339, 430, 462, 467, 468], "lineage_map": 430, "linear": [55, 110, 113, 320, 326], "link": [86, 150, 176, 297, 304, 400], "linkag": [340, 428, 484], "linkage_matrix": 428, "linnean": 70, "linux": 364, "lipman": [106, 107, 111], "list": [1, 18, 41, 53, 70, 84, 85, 88, 89, 100, 106, 110, 111, 112, 113, 114, 117, 120, 121, 122, 123, 134, 135, 145, 149, 151, 191, 228, 244, 250, 274, 276, 277, 280, 298, 300, 301, 307, 310, 312, 316, 320, 336, 338, 339, 340, 348, 352, 356, 357, 358, 360, 369, 375, 381, 386, 387, 392, 400, 401, 409, 416, 423, 425, 428, 439, 442, 445, 460, 461, 466, 467, 479, 480, 482, 483, 484, 485, 498, 506, 513], "liter": 116, "literatur": [1, 49, 74, 340], "live": [1, 155], "lkwh": [189, 194, 226], "ll": [1, 53, 84, 85, 111, 297, 298, 301, 319, 336, 339, 340, 511, 513], "lladser": [61, 62, 84, 85], "lladser_ci": 62, "lladser_p": 61, "ln": [46, 54, 60, 63, 257, 259, 262, 267, 273], "load": [0, 109, 111, 112, 117, 119, 120, 176, 248, 259, 276, 277, 296, 297, 300, 301, 358, 495, 500, 506], "loc": [20, 228, 259, 339], "local": [0, 38, 39, 40, 106, 107, 113], "local_pairwise_align": [35, 36, 37, 39, 40], "local_pairwise_align_nucleotid": [35, 36, 37, 38, 40], "local_pairwise_align_protein": [0, 35, 36, 37, 38, 39], "local_pairwise_align_ssw": [0, 35, 36, 37, 38, 39, 40], "locat": [19, 30, 34, 93, 94, 110, 116, 121, 131, 132, 133, 149, 157, 159, 185, 186, 190, 200, 216, 218, 220, 222, 223, 227, 232, 243, 246, 284, 290, 322, 324, 377, 383, 398, 424, 425, 451, 456, 458, 476, 488, 512], "loci": 19, "locu": [110, 113, 122], "log": [63, 71, 72, 257, 258, 259, 262, 263, 264, 265, 266, 269, 275], "log2": 264, "log_b": [72, 74], "logarithm": [71, 72, 74, 256, 259], "logic": [3, 123, 501], "logratio": 256, "long": [108, 111, 118, 120, 185, 200, 216, 222, 257, 297, 317, 325], "long_method_nam": [320, 489], "longer": [20, 111, 118, 256, 340, 453, 454], "look": [20, 42, 115, 117, 118, 123, 156, 225, 226, 244, 259, 277, 321, 338, 339, 340, 353, 409, 504, 511, 513], "lookup": [35, 36, 37, 38, 39, 40, 131, 132, 133, 277, 298, 301, 407, 408, 409, 410, 419, 424, 425, 431, 434, 462, 463, 466, 501], "lookup_id": [277, 282], "loop": 111, "loos": [1, 304], "lorenz": 55, "lose": [331, 480], "loss": [53, 304], "lost": [20, 331], "lot": 325, "love": [342, 399], "lovel": [269, 275], "low": [62, 319, 331, 339, 388, 430], "lower": [43, 60, 61, 111, 118, 149, 151, 176, 259, 264, 293, 295, 298, 318, 319, 340], "lower_bound": [48, 52, 61, 151], "lower_quantil": 60, "lowercas": [19, 110, 111, 112, 113, 119, 184, 195, 215, 221, 228, 229], "lowest": [53, 70, 416, 439, 458, 468, 478], "lowest_common_ancestor": 439, "lozupon": [53, 84, 85], "lq": 60, "lrn": 447, "lsmat": [277, 284, 290], "luca": 405, "ly": 215, "lysin": 215, "m": [18, 19, 38, 44, 51, 53, 58, 70, 84, 85, 106, 107, 110, 112, 118, 122, 184, 191, 193, 215, 221, 248, 264, 297, 300, 304, 321, 325, 326, 331, 332, 333, 335, 338, 358, 364, 392, 412, 415, 416, 422, 480], "m24803": 121, "m24804": 121, "m_shape": 335, "ma": [6, 10, 44, 245], "machin": 119, "machine_nam": 119, "macklaim": 264, "macrophag": 339, "madden": 111, "made": [20, 67, 160, 171, 174, 228, 259, 277, 291, 318, 348, 424, 425, 450], "magnitud": [67, 264, 298, 300, 331], "magnoliophyta": 110, "magnuson": 70, "magurran": [60, 66], "mai": [1, 11, 19, 20, 23, 31, 49, 53, 62, 74, 107, 110, 111, 112, 113, 115, 116, 118, 120, 121, 122, 123, 126, 134, 135, 145, 149, 155, 176, 180, 181, 184, 195, 215, 221, 228, 233, 247, 254, 259, 276, 277, 280, 296, 298, 300, 304, 318, 325, 331, 336, 338, 339, 340, 341, 348, 400, 407, 408, 409, 410, 415, 416, 419, 429, 431, 439, 442, 472, 480, 495, 496, 499, 501, 506, 508], "main": 162, "mainli": [305, 319], "maintain": [111, 116, 123, 294, 325, 326, 336, 339], "major": [22, 43, 74, 184, 195, 215, 221, 256, 295, 358, 392, 479], "make": [20, 23, 29, 58, 111, 116, 120, 123, 176, 191, 254, 277, 296, 300, 340, 407, 408, 463, 464, 466, 467, 487, 492, 496, 501, 513], "mam": 122, "manag": [145, 146, 147, 506], "mandal": 259, "manhattan": [412, 415], "mani": [1, 20, 44, 69, 89, 116, 120, 247, 256, 259, 304, 325, 331, 339, 340, 348, 400, 506, 513], "manipul": [0, 120, 171, 172, 174, 175, 176, 228, 256, 276, 358, 400, 409, 431, 472, 475, 480, 481], "mann": 259, "manner": [22, 111, 118, 197, 228, 298], "mannwhitneyu": 259, "mantel": [1, 276, 301, 304], "manual": [44, 48, 60, 120, 479], "map": [1, 25, 31, 87, 124, 128, 176, 181, 184, 195, 209, 215, 221, 286, 298, 301, 304, 305, 310, 317, 321, 323, 338, 340, 348, 381, 397, 408, 430, 434, 463, 508], "map_async": 87, "map_f": 87, "map_to_length": [408, 463], "mapper": [286, 323], "mappingproxytyp": 176, "mar": [35, 38, 57], "marchand": 273, "margalef": 66, "marguerat": [269, 275], "margush": 479, "marin": 297, "mark": [110, 113, 121, 493, 513], "marrow": 339, "marth": [19, 41], "marti": [299, 300], "martin": [256, 268], "martinsson": 331, "mask": [6, 10, 19, 245, 269, 275], "mask_auto": 19, "mask_gap": 245, "mask_length": 19, "maskedarrai": [6, 10], "mat": [247, 248, 249, 251, 257, 258, 260, 261, 262, 263, 265, 266, 268, 269, 416], "match": [0, 18, 19, 20, 21, 24, 29, 36, 39, 42, 106, 111, 112, 120, 145, 146, 165, 169, 170, 176, 180, 182, 183, 185, 193, 200, 208, 216, 222, 228, 232, 239, 241, 242, 251, 277, 296, 298, 300, 301, 336, 338, 339, 340, 412, 413, 415, 416, 425, 427, 485, 508, 513], "match_frequ": [241, 508], "match_scor": [19, 36, 39, 42], "matevz": 273, "math": 73, "mathbb": [257, 258, 259, 262, 263, 265, 266], "mathemat": [49, 72, 74, 84, 256, 319, 405, 413, 415, 479, 483, 485], "mathemt": 85, "matplotlib": [283, 320, 321], "matric": [1, 37, 40, 104, 115, 215, 247, 248, 250, 276, 277, 297, 298, 301, 303, 304, 327, 331, 333, 412, 457], "matrix": [1, 19, 42, 82, 86, 87, 90, 91, 101, 245, 247, 248, 249, 251, 252, 257, 258, 259, 260, 261, 262, 263, 265, 266, 267, 268, 269, 270, 271, 272, 273, 274, 277, 278, 279, 280, 281, 282, 283, 286, 288, 289, 291, 293, 294, 295, 296, 297, 298, 299, 300, 301, 302, 304, 319, 321, 323, 325, 327, 328, 329, 331, 332, 333, 335, 337, 342, 348, 358, 359, 362, 377, 384, 388, 390, 391, 392, 399, 412, 416, 428, 477, 478, 480, 481, 482, 483, 484, 485, 510], "matrix_data": [342, 399], "matrix_element_typ": 359, "matrix_rank": 335, "matsen": 70, "matter": [120, 149, 153, 277], "matthew": 479, "matto": 273, "max": [19, 44, 45, 58, 67, 72, 339, 340, 369], "max_count": [336, 339, 340], "max_i": 80, "max_sample_count": 369, "max_width": 111, "maxdist": 422, "maxim": [19, 70, 297, 326], "maxima": 372, "maximum": [71, 80, 111, 112, 259, 264, 297, 310, 318, 326, 330, 334, 339, 340, 372, 412, 415, 433, 441], "mccoi": 70, "mcdonald": [342, 399], "mcentyr": 111, "mci": 508, "mcintosh": [64, 65], "mcintosh_": 64, "mcintosh_d": 65, "mcmorri": 479, "mcmurrough": 264, "md": [111, 344, 352, 356, 381, 395], "md5": [110, 500], "md_i": 370, "md_j": 370, "mdfivaifalfvissftitstnaveastlldignlsr": 110, "me": 481, "mean": [20, 114, 116, 123, 145, 149, 151, 156, 184, 211, 212, 256, 259, 262, 264, 273, 278, 289, 314, 317, 329, 330, 331, 334, 336, 337, 339, 340, 358, 392, 409, 484, 506, 511], "meaning": [19, 21, 24, 29, 331, 508], "meaningless": 20, "meanwhil": 496, "measur": [1, 49, 51, 57, 58, 59, 60, 61, 62, 65, 66, 69, 70, 71, 72, 74, 75, 77, 84, 85, 247, 256, 259, 269, 275, 276, 325, 338, 339, 400, 405, 412, 413, 416, 441, 507], "mechan": [496, 501, 513], "media": 339, "median": [259, 300], "medic": 110, "medlin": 121, "meepqsdpsv": 245, "meet": [41, 120, 156, 180, 181, 426, 453, 454, 471], "member": [136, 141, 497, 499, 501, 504, 513], "membership": 123, "meme_v4": 108, "memo": [20, 151, 160, 171, 174, 228, 400, 473], "memori": [3, 55, 108, 109, 111, 112, 113, 118, 119, 121, 176, 276, 301, 318, 331, 342, 399, 480, 500, 506], "mengyao": [19, 41], "menhinick": 63, "menopaus": 340, "menten": 67, "mention": 116, "merg": 176, "merged_t": 373, "messag": [1, 53, 82, 84, 85, 86, 307, 314, 331, 490, 493, 506], "met": [1, 215, 504], "met_neg": 340, "met_po": 340, "meta": [120, 338, 339], "metabolit": [1, 340, 342, 399, 507], "metadata": [0, 1, 20, 21, 22, 24, 28, 29, 31, 32, 105, 108, 110, 111, 112, 113, 114, 118, 119, 184, 187, 188, 189, 191, 193, 194, 195, 197, 199, 210, 214, 215, 221, 224, 225, 226, 228, 229, 238, 244, 281, 293, 297, 305, 307, 310, 312, 314, 317, 321, 333, 336, 338, 339, 340, 342, 343, 344, 346, 347, 348, 352, 353, 356, 358, 359, 360, 363, 368, 373, 375, 381, 390, 391, 392, 394, 395, 396, 505, 508, 509], "metadata_f": 348, "metadata_field": [358, 392], "metadata_formatt": [353, 394], "metadata_i": 370, "metadata_j": 370, "metadata_map": [305, 306, 309, 310, 316, 317], "metadatacolumn": [148, 173, 176, 179], "metadatafileerror": 181, "metag": 345, "metagenom": 345, "metatdata": 110, "metdata": [228, 373], "methionin": [193, 215], "method": [0, 1, 3, 10, 11, 14, 19, 20, 23, 29, 30, 34, 35, 55, 82, 84, 86, 87, 90, 91, 93, 94, 95, 96, 97, 98, 99, 105, 109, 117, 120, 124, 128, 148, 149, 151, 152, 157, 159, 160, 162, 171, 173, 174, 176, 184, 186, 189, 190, 191, 192, 194, 195, 209, 214, 215, 218, 220, 221, 223, 226, 227, 228, 229, 233, 243, 246, 247, 256, 259, 264, 268, 273, 276, 277, 284, 290, 291, 294, 296, 297, 298, 299, 300, 301, 302, 306, 307, 308, 309, 310, 312, 313, 314, 315, 316, 317, 318, 320, 321, 322, 324, 325, 326, 331, 342, 382, 383, 392, 398, 400, 402, 403, 404, 405, 406, 407, 408, 409, 410, 412, 413, 415, 416, 417, 419, 422, 423, 424, 425, 426, 427, 431, 435, 436, 439, 441, 450, 451, 452, 453, 454, 457, 458, 459, 460, 462, 463, 464, 468, 469, 470, 472, 473, 474, 475, 476, 478, 479, 480, 484, 486, 487, 491, 492, 493, 498, 499, 500, 501, 502, 504, 508, 511, 513], "metodologica": 55, "metric": [23, 44, 49, 53, 54, 58, 70, 82, 83, 84, 85, 86, 87, 88, 89, 90, 101, 112, 231, 255, 281, 291, 293, 331, 411, 412, 414, 415, 416, 468, 482, 483, 485, 508], "metricspac": 291, "mgc": 122, "mi": 18, "micha": 67, "michael": 112, "michen": 484, "microbi": [53, 61, 62, 70, 84, 85, 259, 296, 297, 299, 300, 321], "microbiol": [84, 85], "microbiom": [1, 70, 87, 259, 264], "microsoft": 120, "mid": 457, "middl": [60, 155], "midpoint": [435, 456, 457, 458, 480], "mieadkvahvqvgnnleh": 121, "might": [1, 55, 115, 117, 297, 338, 339, 340, 506], "miller": [106, 107], "million": 87, "mimick": 506, "min": [70, 72, 77, 340], "min_count": [336, 339, 340], "min_group_s": 348, "min_length": [185, 200, 216, 222, 235, 508], "minim": [116, 481], "minima": 376, "minimize_scalar": 54, "minimum": [53, 70, 77, 122, 212, 235, 259, 300, 318, 339, 340, 348, 376, 477, 478, 480, 481], "mininum": 264, "minor": [107, 358, 392], "minter": [0, 20, 21, 24, 31, 32, 108, 118], "minu": [23, 81, 113, 121, 316], "mirror": 264, "misc_bind": 113, "mislead": [23, 90], "mismatch": [0, 18, 19, 36, 39, 42, 106, 107, 239, 240, 241, 251, 298], "mismatch_frequ": [239, 508], "mismatch_scor": [19, 36, 39, 42], "miss": [106, 111, 120, 121, 162, 163, 165, 166, 168, 169, 170, 176, 177, 181, 183, 229, 256, 268, 297, 321, 338, 339, 408, 416, 441, 463, 468, 513], "missing_as_zero": [421, 422, 433], "missing_schem": [148, 162, 173], "missingiderror": [277, 278, 280, 282, 289], "missingnodeerror": [53, 70, 82, 84, 85, 86, 416, 424, 425, 427, 439, 444, 460, 468], "mit": 108, "mitochondri": [122, 188, 192, 225], "mix": 120, "mixin": 209, "mizrachi": 122, "ml": 67, "mmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmmm": 191, "mn": 66, "moac": 106, "mock": 111, "mock_fl": 111, "mode": [23, 123, 145, 193, 286, 323, 340, 348, 436, 456, 457, 458, 469, 501], "model": [2, 60, 61, 62, 67, 96, 109, 248, 256, 264, 276, 340, 400], "moder": 298, "modif": [151, 304], "modifi": [32, 111, 113, 121, 184, 215, 221, 228, 294, 317, 332, 356, 395, 406, 459, 460, 472], "modul": [0, 1, 2, 109, 121, 123, 144, 253, 256, 276, 305, 319, 336, 487, 495, 498, 499, 500, 506, 507, 508, 509, 510, 511, 513], "mol": [35, 38, 106, 107, 110, 113], "mol_typ": [110, 113], "molbev": 480, "molecul": [110, 111, 113, 228, 247, 508], "molecular": [38, 304, 405, 415, 480, 508], "moment": [110, 298, 513], "monkei": [477, 478, 481], "monophylet": 458, "monoton": [276, 277, 301, 302], "mont": 336, "month": 122, "mooer": 70, "more": [0, 1, 20, 22, 23, 24, 30, 34, 35, 41, 44, 49, 55, 58, 82, 89, 93, 94, 107, 110, 111, 112, 116, 117, 118, 119, 120, 121, 138, 142, 149, 157, 159, 168, 176, 182, 186, 190, 202, 203, 204, 205, 215, 217, 218, 220, 223, 227, 243, 246, 256, 259, 261, 264, 276, 277, 284, 290, 294, 296, 297, 298, 299, 300, 301, 304, 311, 318, 321, 322, 324, 325, 326, 333, 339, 340, 342, 348, 364, 383, 398, 399, 406, 407, 409, 429, 436, 441, 451, 459, 472, 476, 479, 506, 511, 512], "mosaic": 121, "most": [22, 43, 45, 54, 70, 104, 108, 111, 112, 115, 116, 118, 120, 122, 193, 228, 298, 318, 333, 336, 433, 434, 436, 441, 472, 479, 480, 511], "mostli": [120, 121], "motif": [185, 200, 216, 222, 508], "motif_slic": [185, 200, 216, 222], "motif_typ": [185, 200, 216, 222], "motiv": 87, "move": 402, "mpl": [188, 189, 191, 193, 194, 225, 226], "mpr": 457, "mpt": [188, 225], "mqhvsapvfvfectrlai": 121, "mrna": 110, "msa": [0, 3, 7, 8, 20, 21, 22, 24, 25, 26, 27, 28, 29, 31, 32, 33, 108, 111, 112, 118, 121], "msa1": 29, "msa2": 29, "msa_copi": 20, "msg": 493, "msl072": 480, "mtcraqliavprassla": 121, "mu": 336, "mu_": 336, "much": [0, 1, 53, 84, 85, 116, 506], "mullikin": 112, "multi": [20, 259, 506], "multi_replac": 259, "multifurc": [116, 436, 511], "multiindex": [20, 32, 295], "multimod": 325, "multinomi": [264, 388], "multipl": [0, 20, 28, 53, 58, 72, 84, 85, 108, 110, 111, 112, 113, 114, 116, 122, 149, 153, 228, 247, 256, 259, 264, 268, 304, 319, 333, 339, 348, 409, 433, 467, 468, 479, 496, 506, 511], "multiple_comparisons_correct": 259, "multipletest": [259, 264], "multipli": [70, 412], "multiplicative_replac": 268, "multivari": [257, 296, 297, 299, 300, 325, 326, 331, 505], "must": [6, 19, 20, 21, 24, 29, 30, 34, 53, 55, 70, 84, 85, 86, 87, 90, 93, 94, 101, 106, 108, 111, 112, 115, 116, 117, 118, 120, 121, 126, 156, 157, 159, 176, 180, 182, 184, 186, 188, 190, 215, 218, 220, 221, 223, 225, 227, 228, 229, 231, 238, 243, 246, 259, 264, 274, 277, 280, 284, 286, 290, 296, 297, 298, 299, 300, 302, 304, 308, 313, 315, 318, 321, 322, 323, 324, 325, 330, 339, 340, 341, 348, 356, 357, 364, 373, 381, 383, 393, 394, 395, 398, 412, 435, 451, 458, 460, 467, 472, 476, 479, 480, 482, 485, 487, 488, 490, 500, 501, 504, 513], "mutabl": [55, 228, 492, 508], "mutant": 113, "mutat": [247, 248, 400], "my": 508, "my_obj": 506, "myclass": 499, "myeloid": 339, "myer": [106, 107], "myformat": [123, 125, 126, 127], "myformat2": [125, 126, 127], "myformat_read": [125, 127], "myformat_sniff": 126, "myobject": [125, 127], "n": [1, 19, 45, 46, 49, 52, 54, 55, 56, 60, 63, 64, 65, 66, 67, 70, 73, 80, 104, 106, 107, 108, 111, 112, 113, 117, 118, 119, 121, 122, 123, 125, 126, 127, 145, 146, 184, 215, 216, 221, 235, 245, 264, 268, 276, 298, 301, 304, 318, 325, 326, 327, 330, 331, 332, 333, 334, 336, 340, 341, 358, 364, 388, 392, 409, 417, 426, 434, 441, 442, 460, 461, 467, 479, 480, 490, 508], "n1": 360, "n4": 360, "n_": [44, 45, 60], "n_column": 302, "n_compon": [257, 258, 260, 261, 262, 263, 265, 266, 267, 268, 269, 270, 271, 272, 275], "n_composit": [257, 258, 260, 261, 262, 263, 265, 266, 267, 268, 269, 270, 271, 272], "n_featur": [102, 273], "n_i": [46, 49, 64, 65], "n_ob": 390, "n_object": 102, "n_pack": 3, "n_partit": 273, "n_posit": [4, 6, 8, 10, 15], "n_row": 302, "n_segment": [3, 5, 9, 14], "n_seq": [4, 5, 6, 8, 9, 10, 15], "n_sequenc": [3, 4], "n_var": 390, "na": [120, 357], "naess": 273, "name": [1, 20, 30, 34, 53, 70, 79, 84, 85, 93, 94, 106, 107, 112, 113, 114, 116, 117, 119, 120, 121, 123, 124, 131, 132, 133, 137, 138, 142, 149, 157, 159, 162, 169, 170, 176, 179, 181, 182, 183, 186, 190, 191, 192, 218, 220, 223, 227, 238, 243, 246, 247, 248, 250, 259, 264, 268, 269, 274, 284, 290, 296, 297, 299, 300, 305, 307, 314, 320, 321, 322, 324, 348, 353, 383, 391, 394, 398, 400, 401, 402, 403, 405, 407, 408, 409, 410, 412, 414, 415, 416, 419, 421, 423, 424, 425, 426, 427, 429, 431, 433, 439, 440, 441, 442, 443, 444, 445, 447, 448, 449, 450, 451, 453, 454, 456, 457, 458, 459, 460, 461, 462, 465, 466, 467, 468, 469, 472, 473, 476, 479, 480, 482, 485, 487, 495, 497, 506, 511], "name_txt": 122, "named_gc": 191, "namedtemporaryfil": 145, "nan": [10, 23, 27, 29, 62, 106, 120, 162, 165, 166, 168, 169, 170, 176, 177, 183, 229, 233, 254, 255, 296, 297, 298, 299, 300, 301, 304, 321, 338, 339, 466, 488], "nan_length_valu": 466, "nanmean": 340, "naohisa": 112, "nar": 112, "nasanfta": 235, "nat": 113, "natal": 273, "nation": [111, 122, 248], "nativ": [1, 285, 331], "natl": [37, 40], "natsort": 386, "natur": [49, 59, 60, 75, 77, 176, 184, 209, 221, 386, 478, 506], "naturalist": 457, "navig": 400, "nb": 146, "nbk21097": 111, "nbk279675": 106, "nbk279682": 107, "nc": 146, "ncbi": [36, 37, 39, 40, 106, 107, 111, 113, 122, 188, 189, 191, 192, 193, 194, 225, 226, 429, 508], "ncbiinsight": 122, "ncifcrf": 23, "ncrna": 228, "nd": 357, "ndarrai": [8, 9, 10, 27, 86, 95, 96, 97, 98, 99, 102, 184, 196, 198, 201, 206, 213, 215, 219, 221, 228, 230, 231, 234, 239, 240, 241, 242, 245, 247, 257, 258, 260, 261, 262, 263, 265, 266, 267, 268, 270, 271, 272, 273, 277, 285, 292, 294, 304, 334, 341, 351, 390, 428, 434], "ndmin": 409, "ne2": 110, "nearbi": 19, "nearest": [477, 478, 480, 481], "nearli": [35, 36, 37], "necessari": [29, 106, 118, 151, 184, 195, 215, 221, 228, 256, 277, 296, 297, 298, 300, 308, 313, 315, 436, 495, 506], "necessarili": [21, 24, 29, 117, 228, 233, 341], "nee": 53, "need": [1, 20, 21, 24, 28, 53, 84, 85, 87, 104, 109, 114, 116, 123, 145, 151, 156, 195, 259, 264, 265, 266, 274, 296, 297, 299, 300, 301, 318, 319, 326, 333, 336, 339, 340, 358, 409, 473, 477, 478, 482, 483, 485, 488, 489, 501, 513], "needl": 35, "needleman": [0, 35, 36, 37], "neg": [1, 19, 36, 39, 42, 55, 120, 193, 261, 268, 291, 300, 325, 326, 331, 336, 340, 480, 482, 485, 496], "negat": 154, "neglig": 1, "nei": 480, "neighbor": [113, 461, 477, 478, 480, 481], "neighbour_join": 480, "neither": [20, 31, 146, 323, 384, 460, 469], "nellangiqpfvtlfhwdlpqvledeyggflnsgvindfrdytdlcfkefgd": 110, "nep": 496, "neq": 336, "nest": [116, 276, 298, 375, 390, 408, 463, 511], "never": [111, 121, 464], "new": [0, 21, 24, 30, 31, 32, 46, 57, 61, 62, 73, 84, 93, 122, 125, 126, 127, 130, 140, 151, 157, 160, 171, 174, 182, 184, 186, 195, 197, 215, 218, 221, 223, 228, 229, 243, 244, 277, 284, 286, 294, 298, 299, 301, 302, 322, 323, 326, 334, 356, 379, 380, 382, 383, 385, 387, 395, 396, 397, 412, 417, 420, 451, 456, 457, 458, 460, 473, 474, 475, 477, 478, 480, 481, 496, 508, 511, 513], "new_fasta_fh": 111, "new_fh": 112, "new_qual_fh": 111, "new_root": 475, "new_tabl": [356, 379, 386], "new_taxdump": 122, "new_tre": 473, "newcastl": 110, "newick": [53, 84, 85, 358, 363, 392, 400, 405, 451, 476, 480, 506, 511], "newick_doc": 116, "newicktre": 116, "newlin": [111, 116, 118, 123, 124, 136, 138, 141, 142, 145], "next": [1, 53, 61, 62, 84, 85, 110, 116, 123, 228, 259, 317, 440, 460, 479, 511, 513], "nh": 121, "nhx": 121, "nich": 326, "nident": [106, 107], "nih": [36, 37, 39, 40, 106, 107, 111, 113, 119, 122, 191, 192], "nj": [416, 477, 484], "nlm": [36, 37, 39, 40, 106, 107, 111, 113, 122, 191, 192], "nlr": 449, "nni": 480, "nnz": [342, 358, 392, 399], "no_gap": 235, "node": [1, 53, 84, 85, 274, 400, 401, 402, 404, 405, 406, 407, 408, 409, 410, 413, 415, 416, 417, 418, 419, 421, 422, 423, 424, 425, 426, 427, 429, 431, 432, 433, 434, 435, 436, 437, 438, 439, 440, 441, 442, 443, 444, 445, 446, 447, 448, 449, 450, 452, 453, 454, 456, 457, 458, 459, 461, 462, 463, 465, 466, 467, 468, 469, 470, 471, 472, 473, 474, 475, 477, 478, 479, 480, 481, 506, 511], "node_1": 445, "node_2": 445, "node_c": 442, "node_count": 409, "node_id": [427, 434, 466], "node_info": 116, "nodes_new": 122, "nodes_slim": 122, "nolengtherror": [421, 422, 433], "nomenclatur": [184, 195, 215, 221, 228], "non": [20, 47, 55, 106, 108, 110, 114, 120, 149, 184, 195, 205, 206, 207, 215, 247, 256, 257, 258, 259, 261, 264, 268, 270, 271, 272, 291, 296, 299, 300, 304, 325, 331, 336, 342, 358, 373, 392, 395, 407, 413, 416, 443, 482, 485, 496, 508], "non_tip": [465, 469, 479, 511], "noncanon": 207, "noncanonical_char": [195, 215], "nonconcept": [51, 75], "nondegenerate_char": 195, "nondestruct": 497, "none": [4, 11, 16, 18, 19, 20, 21, 23, 24, 30, 31, 32, 34, 36, 37, 39, 40, 41, 53, 61, 62, 67, 70, 71, 72, 74, 82, 84, 85, 86, 87, 93, 94, 106, 111, 115, 123, 124, 125, 127, 131, 132, 133, 136, 138, 141, 142, 145, 149, 151, 152, 154, 156, 157, 159, 160, 162, 171, 174, 176, 177, 180, 181, 184, 185, 186, 190, 195, 200, 208, 215, 216, 218, 220, 221, 222, 223, 227, 228, 230, 231, 232, 233, 234, 243, 245, 246, 259, 264, 265, 266, 268, 269, 277, 281, 283, 284, 290, 291, 293, 294, 296, 297, 298, 299, 300, 301, 302, 304, 306, 309, 310, 316, 318, 320, 321, 322, 324, 327, 330, 331, 334, 335, 337, 338, 339, 340, 341, 342, 348, 352, 353, 358, 359, 360, 363, 368, 373, 374, 381, 383, 384, 388, 392, 393, 394, 395, 398, 399, 400, 405, 406, 408, 409, 412, 413, 415, 416, 419, 421, 429, 431, 435, 439, 442, 446, 451, 452, 456, 457, 458, 460, 463, 464, 466, 467, 468, 472, 473, 474, 475, 476, 479, 480, 482, 483, 485, 487, 491, 493, 496, 501, 504, 508, 511, 513], "nonlinear": 67, "nonmatch": [298, 301], "nonneg": 111, "nonparametr": [52, 256, 268], "nonscalar": 20, "nonzero": [105, 356, 361, 372, 376, 378, 379, 395, 399], "noparenterror": [421, 435], "noqa": 358, "nor": [20, 21, 24, 31, 115, 118, 277, 323, 384, 460], "norm": [306, 309, 316, 317, 348], "normal": [52, 85, 112, 113, 162, 176, 296, 331, 332, 333, 336, 337, 339, 340, 348, 379, 409], "not_non": [504, 513], "notabl": [112, 412, 415], "notat": [58, 116, 120, 215], "note": [3, 6, 7, 11, 18, 19, 20, 21, 22, 23, 24, 25, 27, 28, 29, 31, 32, 35, 36, 37, 38, 39, 40, 41, 43, 44, 45, 46, 47, 48, 49, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 71, 72, 73, 74, 75, 76, 77, 79, 80, 81, 84, 85, 87, 89, 105, 109, 110, 111, 112, 113, 114, 116, 118, 119, 120, 149, 151, 155, 160, 171, 174, 176, 180, 182, 184, 187, 188, 189, 191, 192, 193, 194, 195, 197, 199, 209, 211, 214, 215, 221, 224, 225, 226, 228, 229, 233, 235, 245, 247, 248, 254, 255, 259, 264, 265, 266, 268, 269, 273, 274, 275, 277, 278, 285, 288, 289, 291, 292, 294, 296, 297, 298, 299, 300, 301, 304, 318, 321, 325, 326, 331, 332, 333, 334, 339, 340, 341, 342, 348, 349, 357, 358, 364, 373, 375, 388, 390, 391, 392, 399, 400, 402, 403, 404, 405, 406, 407, 408, 409, 410, 411, 412, 413, 414, 415, 416, 417, 419, 420, 422, 423, 424, 425, 426, 427, 429, 431, 433, 435, 436, 437, 439, 440, 441, 443, 446, 447, 448, 449, 450, 452, 453, 454, 456, 457, 458, 459, 460, 462, 463, 465, 466, 467, 468, 469, 470, 472, 473, 474, 475, 477, 478, 479, 480, 481, 482, 483, 484, 485, 487, 488, 490, 493, 495, 496, 498, 499, 500, 508, 511, 513], "notebook": [320, 506], "noth": [32, 145, 182, 208, 501], "notic": [1, 20, 111, 116, 118, 340, 477, 478, 513], "notifi": 298, "notimplementederror": [325, 326], "notion": [72, 298], "notredam": [269, 275], "notstart": 120, "nov": [37, 40, 110, 321], "novel": 259, "novemb": 480, "now": [1, 60, 110, 111, 113, 118, 228, 256, 259, 297, 318, 319, 336, 339, 340, 395, 412, 511, 513], "np": [4, 5, 6, 10, 23, 27, 53, 62, 70, 84, 85, 96, 97, 106, 165, 168, 176, 177, 184, 196, 198, 201, 206, 213, 215, 219, 221, 228, 230, 231, 233, 234, 239, 240, 241, 242, 245, 247, 254, 255, 257, 258, 260, 261, 262, 263, 265, 266, 267, 268, 269, 270, 271, 272, 273, 275, 276, 296, 298, 299, 300, 301, 302, 304, 305, 319, 321, 331, 335, 336, 338, 339, 340, 341, 345, 346, 347, 348, 349, 351, 352, 355, 356, 362, 363, 364, 365, 366, 368, 369, 372, 373, 374, 376, 379, 380, 381, 382, 384, 386, 387, 388, 389, 390, 394, 395, 397, 409, 412, 460, 479, 482, 488, 496], "np_286546": 106, "npd": 70, "nrte": 235, "ns_": 67, "nt": 149, "nuc": [245, 247, 248], "nuc_pattern": 513, "nuccor": 113, "nucl": 112, "nucleic": [118, 122, 184, 195, 215, 221, 228], "nucleobas": [184, 221], "nucleotid": [0, 19, 36, 39, 107, 110, 111, 112, 113, 184, 209, 210, 213, 214, 221, 245, 247, 248, 513], "null": [116, 259, 264, 304, 336, 395], "num_interval_featur": 151, "num_it": [336, 339, 340], "num_object": 302, "num_repeat": 67, "num_run": [339, 340], "number": [1, 3, 20, 21, 24, 43, 44, 45, 46, 47, 49, 50, 51, 52, 53, 54, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 71, 72, 73, 74, 75, 77, 78, 79, 80, 81, 84, 85, 86, 104, 106, 108, 110, 111, 113, 116, 118, 119, 121, 122, 145, 149, 151, 152, 176, 228, 230, 233, 239, 241, 247, 249, 258, 259, 264, 268, 270, 271, 272, 273, 277, 296, 297, 298, 299, 300, 301, 302, 304, 310, 317, 318, 326, 330, 331, 333, 334, 336, 337, 339, 340, 341, 342, 348, 358, 362, 364, 378, 388, 392, 400, 405, 407, 409, 412, 413, 415, 416, 418, 421, 422, 433, 441, 456, 458, 460, 482, 483, 485, 488, 489, 496], "number_of_dimens": [300, 331], "numer": [1, 10, 54, 60, 106, 115, 120, 122, 173, 176, 177, 181, 183, 273, 297, 298, 310, 319, 321, 325, 326, 332, 333, 340, 480, 489], "numeric_onli": 1, "numericmetadatacolumn": [162, 176, 179], "numpi": [1, 4, 5, 6, 86, 96, 97, 102, 257, 258, 260, 261, 262, 263, 265, 266, 267, 268, 269, 270, 271, 272, 273, 275, 276, 277, 285, 292, 302, 304, 305, 310, 314, 317, 319, 336, 338, 339, 340, 341, 345, 346, 347, 348, 349, 352, 355, 356, 362, 363, 364, 365, 366, 368, 369, 373, 374, 378, 379, 380, 381, 382, 384, 386, 387, 388, 389, 392, 394, 395, 409, 412, 460, 496, 508], "nutrient": 273, "nwnnnnnn": [202, 205], "o": [29, 30, 34, 58, 70, 93, 94, 110, 111, 112, 119, 121, 157, 159, 186, 190, 215, 218, 220, 223, 227, 243, 246, 284, 290, 322, 324, 364, 383, 398, 451, 476, 477, 478, 480, 481, 506, 512], "o1": [346, 347, 349, 352, 355, 356, 362, 363, 364, 365, 366, 368, 369, 373, 374, 375, 379, 380, 381, 382, 384, 386, 387, 388, 389, 391, 394, 395, 397], "o2": [346, 347, 349, 352, 355, 356, 362, 363, 364, 365, 366, 368, 369, 373, 374, 375, 379, 380, 381, 382, 384, 386, 387, 388, 389, 391, 394, 395, 397], "o3": [346, 347, 349, 355, 364, 369, 373, 382], "o31698": 121, "o31699": 121, "o4": [346, 347, 349, 364, 382], "o5": [349, 364], "o83071": 121, "ob": [1, 47, 58, 79, 81, 390], "obesrvation_metadata_f": 373, "obf": 112, "obj": [95, 123, 127, 139, 143, 491, 492, 513], "object": [0, 1, 2, 3, 7, 11, 19, 20, 21, 24, 25, 28, 29, 31, 32, 34, 35, 36, 37, 38, 39, 40, 41, 87, 90, 91, 94, 100, 101, 102, 103, 104, 105, 106, 107, 108, 109, 110, 111, 112, 113, 114, 115, 116, 117, 118, 119, 120, 121, 122, 123, 136, 137, 139, 141, 143, 148, 149, 150, 151, 152, 153, 154, 155, 156, 159, 160, 161, 162, 164, 167, 171, 172, 173, 174, 175, 176, 178, 181, 182, 183, 184, 190, 208, 213, 215, 220, 221, 227, 228, 229, 230, 231, 232, 233, 234, 239, 240, 241, 242, 246, 253, 254, 259, 276, 277, 280, 281, 283, 290, 291, 293, 296, 297, 299, 300, 301, 302, 308, 313, 315, 324, 325, 326, 331, 332, 333, 342, 347, 357, 358, 359, 360, 385, 390, 392, 393, 394, 397, 398, 400, 412, 416, 417, 424, 425, 445, 456, 466, 473, 475, 476, 477, 478, 480, 481, 484, 486, 488, 489, 500, 501, 504, 506, 508, 511, 513], "obs_id": [362, 364, 369], "obs_map": 360, "obs_phi": 348, "observ": [1, 43, 53, 56, 58, 67, 69, 79, 81, 84, 85, 90, 105, 228, 233, 245, 259, 304, 319, 336, 339, 340, 342, 343, 344, 345, 346, 347, 348, 349, 351, 352, 353, 355, 356, 357, 358, 359, 360, 362, 363, 364, 365, 366, 368, 369, 370, 371, 372, 373, 374, 375, 376, 378, 379, 380, 381, 382, 384, 385, 386, 387, 388, 389, 390, 391, 392, 394, 395, 396, 397, 399, 407, 433, 441, 444, 479, 510, 513], "observation_column_nam": [353, 394], "observation_group_metadata": [342, 363], "observation_id": [342, 369, 377, 382], "observation_index": 342, "observation_metadata": 342, "observation_metadata_f": 373, "observed_char": [228, 233], "observed_featur": 79, "observed_otu": 79, "obsolet": [118, 431], "obtain": [54, 176, 228, 248, 259, 276, 278, 289, 295, 296, 298, 300, 331], "obviou": 116, "oc": 110, "occur": [19, 107, 111, 112, 115, 116, 138, 142, 145, 228, 234, 331, 340], "occurr": [50, 78, 202, 203, 204, 205, 217, 230, 424], "oct": [111, 113], "odot": [266, 272], "off": [60, 184, 215, 221, 270, 339, 479, 488, 513], "offer": [501, 506], "offici": 105, "offset": [112, 113], "often": [1, 53, 82, 86, 110, 111, 113, 276, 304, 325, 326, 331, 336, 433, 441, 495], "oh": 505, "oiko": [58, 74], "ol": [53, 477, 478, 481], "old": [79, 259, 268, 397, 410, 412, 414, 416, 421, 439, 441, 453, 454, 460, 468, 480], "older": 118, "om": [342, 399], "omic": 256, "ominu": 271, "omit": [4, 16, 116, 176, 181, 276, 388, 429, 467, 470, 479, 482, 483, 485, 506], "ommit": 119, "onc": [56, 111, 123, 506], "one": [0, 1, 20, 21, 22, 23, 24, 29, 35, 36, 37, 43, 53, 54, 55, 57, 60, 70, 71, 82, 84, 85, 95, 97, 99, 110, 111, 112, 113, 114, 116, 117, 118, 120, 121, 122, 123, 126, 138, 142, 153, 156, 158, 161, 168, 169, 172, 175, 176, 193, 202, 203, 204, 205, 215, 217, 228, 229, 247, 259, 277, 281, 293, 295, 297, 298, 300, 301, 302, 304, 305, 306, 319, 327, 330, 331, 338, 339, 340, 345, 348, 373, 384, 400, 403, 407, 408, 409, 412, 413, 415, 429, 432, 433, 437, 441, 442, 444, 450, 456, 457, 458, 459, 460, 462, 463, 472, 473, 480, 497, 506, 511, 513], "one_to_mani": 348, "one_to_many_md_kei": 348, "one_to_many_mod": 348, "ones": [4, 8, 15, 326, 339, 373], "onli": [0, 1, 19, 20, 29, 56, 57, 61, 70, 71, 90, 95, 97, 99, 108, 110, 111, 112, 113, 115, 116, 117, 118, 120, 121, 122, 123, 145, 151, 156, 162, 165, 166, 176, 177, 182, 184, 185, 191, 200, 215, 216, 221, 222, 228, 229, 247, 256, 259, 270, 280, 286, 291, 293, 294, 295, 296, 300, 301, 318, 319, 323, 326, 331, 333, 338, 339, 340, 346, 347, 348, 356, 358, 370, 395, 406, 408, 410, 411, 412, 413, 414, 415, 417, 418, 424, 433, 441, 450, 459, 460, 463, 469, 492, 496, 504, 506, 511, 513], "onlin": [60, 112], "ons": 120, "onto": [123, 332, 479], "ontologi": [114, 400], "ontology_term": 114, "open": [0, 30, 34, 35, 36, 37, 38, 39, 40, 87, 93, 94, 106, 107, 111, 112, 123, 125, 127, 136, 138, 139, 141, 142, 143, 146, 147, 149, 157, 159, 186, 190, 218, 220, 223, 227, 243, 246, 284, 290, 322, 324, 358, 383, 394, 398, 451, 476, 500, 505, 506], "open_fil": 500, "open_filehandl": 506, "oper": [1, 3, 20, 21, 24, 29, 84, 106, 111, 116, 154, 184, 211, 212, 215, 221, 228, 258, 270, 271, 272, 276, 277, 292, 298, 299, 331, 343, 344, 346, 347, 348, 352, 358, 371, 375, 384, 385, 386, 387, 388, 389, 392, 395, 408, 413, 415, 416, 429, 431, 436, 441, 450, 456, 457, 458, 463, 473, 475, 479, 480, 482, 483, 485, 501, 506, 508], "operon": 149, "opinion": 55, "oplu": 270, "oppos": [301, 513], "optim": [1, 11, 19, 54, 82, 84, 85, 86, 300, 422, 468, 480, 482, 483, 485], "optimal_alignment_scor": 11, "option": [4, 6, 10, 14, 16, 19, 20, 21, 23, 24, 27, 28, 29, 30, 31, 32, 34, 35, 36, 37, 39, 40, 41, 42, 44, 47, 48, 49, 51, 53, 58, 59, 60, 61, 62, 67, 70, 71, 72, 74, 75, 76, 81, 82, 84, 85, 86, 87, 90, 93, 94, 96, 100, 101, 102, 103, 108, 109, 111, 112, 117, 118, 120, 121, 122, 124, 125, 126, 127, 136, 138, 139, 141, 142, 143, 145, 149, 151, 152, 156, 157, 158, 159, 165, 169, 170, 176, 177, 180, 181, 183, 184, 185, 186, 190, 191, 192, 193, 194, 200, 207, 210, 212, 215, 216, 218, 220, 221, 222, 223, 225, 226, 227, 228, 229, 230, 231, 232, 233, 234, 235, 236, 237, 239, 241, 243, 245, 246, 255, 259, 264, 265, 266, 268, 277, 278, 280, 281, 283, 284, 286, 290, 293, 294, 296, 297, 298, 299, 300, 301, 302, 304, 310, 318, 321, 322, 323, 324, 326, 327, 330, 331, 333, 334, 337, 338, 339, 340, 341, 343, 344, 345, 348, 349, 351, 352, 355, 356, 358, 363, 364, 365, 368, 369, 370, 371, 372, 373, 376, 378, 379, 380, 381, 382, 383, 385, 386, 387, 388, 389, 390, 391, 392, 393, 394, 395, 397, 398, 400, 401, 402, 406, 408, 409, 410, 411, 412, 413, 414, 415, 416, 417, 418, 421, 422, 423, 429, 431, 433, 435, 436, 440, 441, 442, 443, 445, 446, 447, 448, 449, 450, 451, 452, 453, 454, 456, 457, 458, 459, 460, 462, 463, 465, 466, 467, 468, 469, 470, 471, 472, 473, 475, 476, 477, 478, 479, 480, 481, 482, 483, 484, 485, 487, 488, 489, 493, 496, 500, 501, 504, 508, 513], "or_f": 117, "oral": 1, "orcutt": 248, "ord_r": 117, "order": [1, 19, 20, 25, 28, 29, 32, 58, 59, 72, 74, 81, 82, 86, 104, 106, 111, 115, 116, 117, 118, 121, 153, 164, 176, 178, 182, 184, 189, 191, 194, 199, 215, 221, 226, 228, 233, 245, 259, 264, 274, 277, 278, 280, 289, 294, 295, 296, 297, 298, 299, 300, 301, 304, 325, 334, 338, 339, 358, 378, 386, 387, 392, 400, 404, 416, 436, 440, 443, 447, 448, 449, 465, 466, 479, 480, 488, 511, 513], "ordin": [1, 103, 300, 489, 490], "ordinari": 478, "ordination_result": 319, "ordinationresult": [103, 117, 300, 325, 326, 331, 332, 333, 489], "org": [19, 41, 43, 87, 104, 105, 111, 112, 113, 118, 120, 121, 176, 181, 269, 273, 275, 277, 285, 291, 292, 296, 297, 298, 299, 300, 321, 342, 358, 359, 392, 399, 480, 496], "organ": [1, 110, 113, 122], "organis": 113, "orient": [305, 321, 338, 358, 392, 456, 506], "origin": [1, 3, 6, 9, 10, 20, 35, 37, 38, 40, 45, 46, 49, 52, 53, 56, 57, 58, 59, 63, 64, 65, 70, 71, 72, 74, 75, 81, 84, 85, 87, 108, 109, 111, 116, 118, 119, 166, 169, 170, 183, 228, 229, 296, 297, 298, 299, 300, 304, 325, 331, 333, 341, 348, 356, 379, 395, 402, 412, 413, 415, 417, 456, 457, 458, 460, 479, 480, 511, 513], "orthogon": [265, 266], "ortholog": [342, 399], "orthonorm": [265, 266, 273, 274], "orthornorm": 265, "ostel": 111, "other": [0, 1, 6, 19, 20, 29, 53, 69, 74, 87, 110, 111, 112, 113, 115, 116, 118, 120, 121, 122, 145, 149, 151, 155, 160, 162, 171, 172, 174, 175, 176, 182, 184, 191, 211, 212, 213, 215, 221, 228, 231, 239, 240, 241, 242, 244, 247, 253, 259, 264, 276, 277, 291, 300, 319, 321, 325, 326, 331, 338, 340, 342, 345, 349, 354, 369, 373, 400, 407, 411, 412, 413, 414, 415, 422, 424, 445, 472, 473, 475, 488, 501, 502, 506, 507, 508, 511, 513], "other_vertebr": 107, "otherwis": [18, 19, 20, 21, 24, 32, 47, 48, 111, 113, 116, 119, 120, 145, 162, 168, 245, 277, 280, 294, 301, 342, 351, 355, 367, 373, 379, 382, 413, 468, 508], "otu": [1, 120, 342, 345, 346, 347, 348, 349, 353, 357, 358, 359, 364, 369, 373, 379, 381, 382, 386, 387, 392, 394, 395, 399], "otu1": 353, "otu2": 353, "otu_id": [53, 70, 84, 85], "otuid": 120, "our": [1, 20, 55, 112, 120, 123, 126, 146, 235, 319, 336, 339, 340, 341, 508, 513], "out": [20, 23, 109, 119, 120, 123, 163, 321, 356, 388, 513], "out_f": [308, 313, 315], "out_fh": 276, "outcom": [73, 339, 472], "outer": [28, 29, 229, 249], "outfmt": [106, 107], "outgroup": 458, "output": [2, 29, 106, 107, 109, 116, 118, 119, 121, 238, 264, 296, 300, 301, 310, 326, 342, 348, 353, 393, 394, 407, 467, 480, 496, 505, 513], "outsid": [112, 149, 155, 233], "over": [20, 28, 87, 111, 112, 119, 120, 121, 228, 247, 264, 302, 311, 336, 337, 342, 345, 348, 349, 368, 369, 370, 372, 375, 376, 381, 384, 388, 395, 400, 440, 443, 447, 448, 449, 465, 469, 511], "overal": [342, 399, 440, 447, 448, 449, 480], "overhead": [318, 358], "overlap": [60, 156, 182, 236, 237, 255, 264, 278, 373, 412, 482], "overrid": [19, 36, 39, 70, 124, 125, 126, 127, 136, 141, 181, 413, 415, 450, 513], "overridden": [19, 20, 113, 497], "override_skip_babp": 19, "overrideerror": 497, "overriden": [125, 126, 127], "overview": 480, "own": [21, 24, 29, 104, 111, 117, 121, 123], "owner": [491, 492], "oxfordjourn": 112, "oxtobi": 110, "p": [1, 19, 41, 53, 58, 64, 65, 70, 72, 215, 259, 264, 273, 276, 296, 298, 299, 300, 301, 304, 319, 325, 326, 327, 331, 332, 333, 336, 339, 340, 388], "p26204": 110, "p__b": 348, "p__c": 348, "p_adjust": [259, 264], "p_i": [49, 51, 58, 59, 72, 74, 75, 81], "p_valu": [1, 298, 304], "pack": 3, "packag": [19, 41, 43, 83, 108, 111, 116, 118, 264, 273, 276, 296, 297, 298, 299, 300, 303, 325, 326, 333, 484, 496, 511, 512], "pad": [29, 118, 229], "page": [55, 259, 480, 506, 511], "pair": [0, 1, 18, 35, 36, 37, 39, 42, 84, 85, 86, 90, 110, 112, 113, 114, 116, 121, 149, 152, 156, 172, 247, 255, 259, 277, 278, 289, 293, 295, 301, 336, 412, 413, 416, 441, 482, 483, 484, 485, 508], "pairwis": [14, 15, 16, 18, 86, 87, 90, 101, 256, 259, 269, 281, 293, 301, 304, 348, 370, 422, 480, 511], "pairwise_dist": 86, "pairwise_func": 86, "pam": [215, 247, 248], "pam250": 248, "pam30": 248, "pam70": 248, "pancoro": 110, "panda": [1, 20, 32, 86, 100, 106, 107, 122, 162, 169, 170, 175, 176, 183, 184, 215, 221, 259, 264, 287, 295, 296, 297, 299, 300, 301, 305, 310, 317, 319, 321, 338, 339, 346, 375, 391, 429, 488, 508], "paper": 120, "papilionoidea": 110, "par_dist": 304, "parallel": [55, 87], "param": 498, "paramet": [1, 3, 4, 5, 6, 7, 10, 11, 14, 15, 16, 18, 19, 20, 21, 23, 24, 25, 27, 28, 29, 30, 31, 32, 34, 35, 36, 37, 38, 39, 40, 41, 42, 43, 44, 45, 46, 47, 48, 49, 50, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 71, 72, 73, 74, 75, 76, 77, 78, 79, 80, 81, 82, 84, 85, 86, 87, 90, 91, 93, 94, 95, 96, 97, 98, 99, 100, 101, 102, 103, 123, 124, 125, 126, 127, 129, 131, 132, 133, 134, 135, 136, 137, 138, 139, 141, 142, 143, 145, 149, 151, 152, 153, 154, 155, 156, 157, 158, 159, 162, 164, 165, 167, 169, 170, 176, 177, 178, 179, 180, 181, 182, 183, 184, 185, 186, 188, 189, 190, 191, 192, 193, 194, 200, 207, 208, 210, 212, 213, 215, 216, 218, 220, 221, 222, 223, 225, 226, 227, 228, 229, 230, 231, 232, 233, 234, 235, 236, 237, 238, 239, 240, 241, 242, 243, 244, 245, 246, 247, 248, 249, 251, 254, 255, 257, 258, 259, 260, 261, 262, 263, 264, 265, 266, 267, 268, 269, 270, 271, 272, 273, 274, 275, 277, 278, 280, 281, 282, 283, 284, 286, 289, 290, 293, 294, 296, 297, 298, 299, 300, 301, 302, 304, 308, 310, 313, 315, 317, 318, 321, 322, 323, 324, 325, 326, 327, 330, 331, 332, 333, 334, 336, 337, 338, 339, 340, 341, 342, 343, 344, 345, 346, 347, 348, 349, 351, 352, 355, 356, 357, 358, 359, 360, 362, 363, 364, 365, 366, 368, 369, 370, 371, 372, 373, 374, 375, 376, 378, 379, 380, 381, 382, 383, 384, 385, 386, 387, 388, 389, 390, 391, 392, 393, 394, 395, 397, 398, 400, 401, 402, 403, 406, 408, 409, 410, 411, 412, 413, 414, 415, 416, 417, 418, 421, 422, 423, 424, 425, 426, 427, 428, 429, 430, 433, 435, 436, 439, 440, 441, 442, 443, 444, 445, 446, 447, 448, 449, 450, 451, 452, 453, 454, 456, 457, 458, 459, 460, 462, 463, 465, 466, 467, 468, 469, 470, 471, 472, 473, 474, 475, 476, 477, 478, 479, 480, 481, 482, 483, 484, 485, 487, 488, 489, 490, 492, 493, 494, 495, 496, 497, 498, 500, 501, 502, 503, 504, 513], "parametr": [47, 256, 259, 296, 299], "params_alias": 487, "params_guess": 67, "paramt": 331, "parasit": 304, "pardi": 70, "parent": [110, 114, 116, 122, 228, 273, 400, 402, 405, 407, 413, 423, 426, 435, 437, 442, 446, 447, 450, 452, 456, 457, 458, 461, 462, 466, 470, 473, 474, 475, 487, 497, 511], "parent_tax_id": [122, 429], "parenthes": 511, "parenthesi": 116, "parker": [45, 58], "pars": [111, 112, 113, 115, 123, 357, 358, 359, 360, 506], "parse_biom_t": 358, "parse_f": 358, "parser": [114, 116, 506], "part": [106, 111, 113, 116, 119, 253, 257, 273, 318, 381, 501, 511], "partial": [19, 70, 155, 342], "partial_beta_divers": 87, "partialdistancematrix": 87, "particip": 340, "particuarli": 111, "particular": [1, 400, 424, 513], "particularli": [409, 506], "partit": [256, 273, 274, 348, 407], "pass": [1, 20, 24, 30, 31, 34, 41, 82, 86, 87, 88, 89, 93, 94, 106, 108, 111, 113, 118, 119, 121, 125, 126, 127, 130, 136, 138, 139, 140, 141, 142, 143, 145, 157, 159, 184, 185, 186, 190, 191, 193, 200, 215, 216, 218, 220, 221, 222, 223, 227, 228, 231, 233, 243, 244, 246, 277, 284, 290, 293, 294, 298, 301, 310, 322, 324, 339, 369, 382, 383, 398, 451, 476, 504, 506, 511, 513], "passthrough": 32, "password": 123, "path": [3, 4, 5, 6, 7, 8, 9, 10, 14, 15, 16, 18, 26, 105, 109, 111, 112, 119, 145, 181, 348, 400, 401, 412, 422, 468, 482, 495, 506], "path_2": 445, "path_dist": 412, "pathwai": [342, 348, 399], "patrist": [416, 422, 441], "pattern": [20, 122, 208, 232, 319, 408, 415, 463, 508, 513], "paw": [215, 217, 219], "pawhea": 0, "pawlowski": [256, 269, 275], "pc": [1, 305, 321], "pca": [325, 331, 333], "pcbi": [269, 275], "pcoa": [1, 117, 300, 320, 321, 332], "pcoa_result": 321, "pcr": 340, "pd": [1, 20, 24, 32, 53, 70, 82, 100, 106, 107, 122, 162, 174, 175, 228, 259, 264, 276, 278, 287, 289, 295, 296, 297, 300, 305, 319, 320, 321, 325, 333, 338, 339, 346, 375, 391, 429, 430, 468, 488], "pd_": 70, "pdf": [11, 119], "pdist": [1, 83, 86, 89, 101, 304], "pearson": [111, 298, 301, 304, 412, 415], "pearsonr": [298, 304, 336], "peerj": 70, "penal": [35, 36, 37], "penalize_terminal_gap": [35, 36, 37], "penalti": [0, 19, 35, 36, 37, 38, 39, 40], "penni": 412, "pentapetala": 110, "per": [3, 14, 29, 106, 107, 119, 121, 184, 215, 221, 228, 264, 301, 304, 318, 333, 339, 340, 389, 403, 409, 500], "percent": [106, 508], "percentag": [106, 256], "percentil": 259, "percentile_df": 259, "perfect": [319, 326], "perform": [0, 1, 3, 19, 20, 28, 29, 41, 53, 67, 82, 84, 85, 86, 87, 103, 111, 112, 120, 149, 182, 184, 189, 194, 215, 221, 226, 228, 256, 257, 258, 259, 261, 262, 263, 264, 265, 266, 269, 270, 271, 272, 274, 275, 277, 291, 292, 293, 301, 304, 305, 306, 309, 316, 317, 319, 331, 333, 334, 340, 341, 342, 348, 379, 382, 388, 412, 417, 427, 431, 440, 447, 448, 449, 456, 457, 458, 460, 473, 474, 477, 478, 480, 481, 484, 488, 506], "period": 120, "periton": 339, "perm_stat": 304, "permanova": [296, 300], "permdisp2": 300, "permiss": [111, 116, 118], "permit": [3, 116, 126], "permut": [1, 149, 296, 298, 299, 300, 301, 304], "perplex": [58, 74], "perspect": [70, 472], "pertain": 303, "perturb": [256, 271], "petchei": 53, "peter": 112, "pfam": 121, "pgc": 122, "ph": 297, "phagocyt": 339, "phase": [113, 114], "phe": 215, "phenylalanin": 215, "php": 111, "phred": [111, 112], "phred_offset": [112, 119], "phydiv": 53, "phylip": [30, 34, 111, 116, 479, 506, 511], "phylip_multiple_alignment_format": 118, "phylipformaterror": 118, "phylo": 118, "phylochip": [53, 84, 85], "phylogenet": [1, 53, 70, 84, 85, 116, 118, 276, 304, 400, 413, 416, 424, 436, 457, 468, 472, 477, 478, 480, 481, 483, 484, 505, 508], "phylogeni": [118, 303, 304, 415, 477, 478, 481], "phylum": 429, "physic": [81, 332, 340], "pick": [19, 339], "pident": [106, 107], "pie": [51, 75], "piec": 513, "pielou": [71, 77], "pielou_": 57, "piet": 326, "pig": [477, 478, 481], "pii": 108, "ping": [19, 41], "pipe": 122, "pirrung": 321, "pisc": 60, "pitfal": 23, "pizetti": 55, "place": [32, 116, 121, 182, 193, 318, 331, 334, 356, 379, 382, 392, 395, 409, 425, 431, 434, 456, 457, 458, 459, 460, 470, 472, 475, 480, 481, 489], "placebo": [259, 264], "placement": [407, 480], "plain": [108, 111, 112, 113, 116, 118, 119], "plan": 120, "planetmath": 291, "plankton": 45, "plant": [80, 110, 273], "plastid": 122, "pleas": [20, 30, 34, 93, 94, 111, 119, 157, 159, 186, 190, 218, 220, 223, 227, 243, 246, 284, 290, 322, 324, 383, 398, 451, 476, 506, 510], "pleij": 121, "plm": [2, 109], "pln": [110, 122], "plo": [19, 41, 61, 62, 269, 275], "ploson": [19, 41], "plot": [1, 320], "plottabl": 486, "plu": [122, 184, 215, 221], "plug": 496, "plugin": 120, "plural": [1, 147], "pm": 52, "pmid": [121, 298, 477, 478, 480, 481], "png": [320, 486], "point": [23, 55, 60, 62, 104, 108, 120, 123, 126, 149, 176, 238, 244, 245, 247, 248, 300, 306, 309, 317, 319, 321, 339, 340, 435, 457, 488, 495], "poisson": [61, 62], "polici": 496, "polymeras": 121, "polytomi": 436, "pone": [19, 41], "pool": 44, "poorli": [304, 331], "pop": [450, 452, 453, 454], "popul": [43, 47, 54, 56, 79, 119, 121, 238, 270, 302, 336, 340], "port": 120, "portal": 122, "portion": 298, "pos_idx": 20, "pos_rat": 340, "posit": [0, 3, 4, 5, 6, 7, 9, 14, 16, 19, 20, 21, 22, 23, 24, 25, 27, 28, 29, 32, 35, 36, 37, 38, 39, 40, 41, 42, 106, 107, 108, 111, 112, 113, 116, 118, 119, 120, 121, 174, 175, 184, 185, 187, 188, 189, 193, 194, 196, 197, 198, 199, 200, 201, 206, 210, 214, 215, 216, 219, 221, 222, 224, 225, 226, 228, 229, 230, 232, 234, 235, 238, 239, 240, 241, 242, 244, 256, 257, 258, 259, 268, 298, 304, 317, 320, 331, 336, 337, 339, 340, 342, 362, 375, 407, 408, 435, 446, 456, 460, 472, 473, 475, 508], "positional_metadata": [20, 22, 28, 29, 111, 121, 174, 175, 184, 195, 197, 210, 214, 215, 221, 228, 229, 238, 244, 508], "possess": 497, "possibl": [1, 19, 20, 71, 77, 81, 111, 112, 120, 121, 155, 189, 191, 194, 199, 226, 297, 301, 339, 479], "post": [118, 336, 340, 448], "posterior": [264, 400], "postmenopaus": 340, "postord": [404, 409, 424, 440, 443, 448, 449, 465, 469, 511], "potenti": [111, 235, 318, 331, 453, 454, 513], "pound": [120, 176], "power": [256, 264, 342, 399, 506], "pp": [54, 66, 72, 326, 415, 485], "ppo": [106, 107], "practic": [1, 29, 70, 111, 112, 119, 318, 419, 424], "pre": [208, 232, 247, 248, 250, 340, 408, 448], "pre_and_postord": [440, 447, 449, 469], "pre_rat": 340, "prealloc": 501, "preced": [19, 108, 116, 118], "precis": 480, "precomput": 335, "predefin": [114, 231], "predict": [61, 62, 121, 339], "preemptiv": 20, "prefer": [23, 82, 86, 112, 325, 326, 506], "prefer_self": 373, "prefix": 122, "preliminari": 339, "premenopaus": 340, "preorder": [440, 447, 448, 469, 511], "prepar": 120, "preq1": 113, "presenc": [48, 70, 191, 193, 340, 380, 431], "present": [20, 22, 23, 53, 84, 85, 106, 109, 111, 117, 120, 121, 151, 176, 184, 193, 196, 197, 198, 201, 206, 210, 214, 215, 219, 221, 233, 234, 259, 280, 296, 297, 299, 300, 310, 320, 331, 340, 348, 357, 358, 397, 402, 406, 423, 431, 435, 442, 446, 450, 452, 453, 454, 459, 463, 470, 471, 472, 475, 479, 480, 511], "preserv": [111, 116, 176, 319, 325, 326, 331, 402, 412], "preset": [412, 415, 482, 485], "press": [46, 72], "presum": 111, "prev": 409, "prevent": 19, "previou": [1, 35, 36, 37, 38, 39, 40, 228, 296, 298, 300, 409, 412, 480], "previous": [0, 238, 244, 513], "pri": 122, "primari": [123, 508], "primer": 297, "princip": [1, 300, 321, 325, 331, 332], "principl": [336, 477, 478, 481], "print": [0, 1, 28, 53, 84, 85, 108, 111, 112, 113, 114, 116, 118, 119, 121, 171, 189, 194, 199, 226, 228, 235, 245, 276, 286, 298, 304, 305, 318, 336, 339, 340, 345, 346, 347, 348, 349, 352, 356, 362, 364, 365, 369, 370, 371, 372, 373, 376, 379, 380, 381, 382, 386, 387, 388, 394, 395, 397, 401, 402, 403, 406, 407, 408, 409, 412, 413, 415, 416, 417, 418, 423, 425, 427, 429, 430, 432, 435, 437, 438, 439, 440, 443, 445, 446, 447, 448, 449, 450, 453, 454, 456, 457, 458, 459, 460, 462, 463, 465, 466, 467, 468, 469, 470, 471, 472, 473, 475, 477, 478, 479, 480, 481, 482, 483, 484, 485, 508, 511, 513], "printabl": [112, 119], "prior": [193, 256, 298, 301, 388, 406, 429, 435, 456, 457, 458, 460, 501, 502, 513], "prioriti": [70, 503, 513], "privat": [113, 403], "prng": 318, "pro": 215, "prob": [20, 22, 28], "probabl": [49, 51, 61, 62, 72, 73, 75, 264, 305, 307, 318, 336, 340, 400], "problem": [120, 259, 477, 481], "problemat": [120, 466], "proc": [37, 40], "procedur": [300, 412, 482, 506], "proceed": [72, 248, 415, 485], "process": [87, 111, 121, 155, 264, 333, 393, 394, 501, 513], "process_func": 360, "processor": 513, "prod": [262, 273], "prod_": 74, "produc": [43, 106, 107, 118, 119, 125, 235, 325, 333, 407, 480, 484], "product": [0, 149, 267, 298], "program": [115, 116, 120, 122, 416, 422], "progress": 297, "prohibit": [473, 474, 475], "project": [87, 112, 257, 273, 296, 297, 298, 299, 300, 332], "prolin": 215, "promis": 259, "pronounc": [342, 399, 505], "prop_expl": [305, 306, 309, 310, 316, 317], "propag": 228, "proper": 458, "properli": [116, 145], "properti": [3, 20, 108, 118, 122, 149, 160, 162, 171, 174, 176, 182, 191, 195, 228, 247, 277, 281, 291, 293, 331, 336, 405, 409, 436, 450, 492, 507], "proport": [43, 49, 51, 55, 56, 58, 59, 67, 70, 72, 74, 75, 81, 117, 212, 254, 256, 257, 259, 260, 261, 262, 265, 266, 267, 268, 269, 270, 271, 272, 275, 296, 298, 299, 305, 310, 317, 320, 325, 331, 333, 411, 413, 414, 483], "proportion": [269, 275], "proportion_explain": [319, 320], "propos": [43, 74], "prot": 110, "protein": [0, 2, 19, 20, 23, 35, 37, 40, 41, 96, 97, 106, 108, 109, 110, 111, 112, 113, 118, 119, 121, 188, 189, 191, 193, 194, 195, 225, 226, 228, 235, 245, 248, 339, 508], "protein_from_dna": 508, "protein_from_rna": 508, "protein_id": 110, "proteinembed": 109, "proteinvector": 109, "provid": [0, 1, 2, 15, 18, 19, 20, 21, 23, 24, 31, 36, 39, 41, 43, 53, 60, 61, 62, 70, 82, 83, 84, 85, 86, 106, 109, 111, 112, 116, 118, 120, 121, 122, 123, 125, 127, 136, 138, 141, 142, 144, 146, 167, 176, 181, 182, 221, 228, 233, 235, 238, 245, 247, 256, 264, 276, 277, 281, 289, 293, 294, 296, 297, 298, 299, 300, 301, 302, 304, 305, 310, 318, 319, 320, 321, 327, 331, 336, 338, 339, 340, 341, 342, 343, 351, 353, 356, 358, 363, 365, 366, 371, 372, 374, 376, 381, 382, 388, 392, 393, 395, 397, 399, 408, 409, 410, 412, 421, 424, 425, 429, 439, 444, 456, 460, 463, 466, 468, 472, 479, 480, 481, 482, 496, 501, 506, 507, 508, 509, 510, 511, 512, 513], "proxim": 319, "prune": [406, 436, 453, 454, 459, 470, 471, 472], "psa": [35, 38], "pseudo": 299, "pseudocount": [256, 259, 264], "pseudoknot": 121, "pub": [110, 122, 149], "public": [70, 112, 321], "publish": [112, 121, 412], "pubm": [110, 113, 171, 228], "pull": [111, 497], "pure": 0, "purin": [184, 185, 200, 216, 222, 508], "purpos": [0, 1, 41, 44, 120, 122, 191, 336, 408, 422, 513], "put": [58, 228], "pvalu": [264, 336, 339, 340], "pwmantel": 298, "pwr": 339, "pwr_001": 336, "pwr_010": 336, "pwr_100": 336, "pwr_est": 340, "pwr_est2": 340, "py": [112, 123], "pycog": [53, 84, 85, 479], "pyl": 215, "pyrimidin": [184, 185, 222], "pyrosequenc": [53, 84, 85], "pyrrolysin": 215, "python": [0, 1, 11, 228, 276, 291, 298, 492, 505, 506, 508], "q": [19, 58, 60, 72, 81, 107, 215, 326, 327], "q2": 120, "q2cli": 120, "qacc": [106, 107], "qaccver": [106, 107], "qcov": [106, 107], "qcovhsp": [106, 107], "qd": 58, "qend": [106, 107], "qframe": [106, 107], "qgi": [106, 107], "qh": [72, 81], "qiim": [53, 84, 85, 120, 176], "qiime2": [120, 176, 181], "qiita": 120, "qiu": 304, "qlen": [106, 107], "qseq": [106, 107, 186, 218, 223, 243], "qseqid": [106, 107], "qstart": [106, 107], "quadrat": 72, "qual": 112, "qual_fl": 111, "qualifi": [110, 113], "qualit": [84, 85, 321], "qualiti": [111, 119, 174, 175, 184, 197, 210, 214, 215, 221, 228, 321, 508], "quantifi": [1, 416], "quantil": [60, 264], "quantit": [70, 84, 85, 325, 340], "quantiti": 85, "quartil": 60, "queri": [0, 11, 18, 19, 41, 106, 107, 151, 180, 228], "query1": 107, "query_begin": 11, "query_end": 11, "query_sequ": [0, 11, 19], "quick": [277, 292, 321], "quit": 513, "quot": 116, "qvalu": 264, "r": [1, 19, 53, 54, 60, 61, 62, 63, 64, 70, 84, 85, 112, 113, 122, 145, 184, 215, 221, 248, 256, 257, 258, 262, 263, 264, 265, 266, 273, 296, 297, 298, 299, 300, 304, 321, 325, 326, 333, 347, 412, 413, 415, 416, 477, 478, 481, 483, 484, 485], "r1": 508, "r2": 508, "r2d0c0545a225": 481, "r3": 508, "r4": 508, "r5": 508, "r_i": 273, "r_m": 298, "ra": [110, 121], "raaijmak": 67, "raimon": 273, "rais": [20, 21, 23, 24, 27, 29, 31, 33, 44, 53, 54, 55, 70, 82, 84, 85, 86, 90, 102, 111, 112, 118, 123, 125, 126, 127, 136, 138, 139, 141, 142, 143, 155, 164, 178, 181, 182, 185, 193, 195, 200, 213, 216, 222, 228, 229, 230, 231, 233, 234, 236, 237, 239, 240, 241, 242, 245, 248, 249, 254, 255, 261, 268, 274, 277, 278, 280, 281, 282, 286, 289, 293, 296, 297, 298, 300, 301, 310, 317, 318, 321, 323, 325, 326, 331, 333, 339, 340, 341, 342, 343, 345, 349, 351, 352, 356, 357, 358, 363, 364, 365, 366, 369, 370, 371, 372, 374, 375, 376, 382, 384, 385, 388, 395, 397, 399, 409, 412, 416, 419, 421, 422, 424, 425, 427, 429, 433, 435, 439, 444, 446, 457, 458, 459, 460, 468, 470, 487, 488, 489, 490, 492, 497], "rand": [96, 97], "random": [52, 54, 61, 62, 67, 96, 97, 104, 264, 294, 296, 298, 299, 300, 301, 302, 304, 318, 326, 331, 336, 338, 339, 340, 341, 388, 412, 460, 482, 496], "random_fn": 302, "randomli": [49, 75, 294, 296, 298, 299, 302, 318, 341, 388, 412, 460, 482], "randomst": [61, 62, 264, 294, 296, 298, 299, 300, 301, 318, 338, 339, 340, 341, 496], "rang": [49, 58, 60, 71, 72, 81, 85, 112, 113, 120, 175, 197, 210, 214, 233, 235, 247, 296, 297, 321, 340, 364, 369, 388, 412, 413, 415, 434, 436, 456, 513], "rangeindex": [20, 21, 24, 31, 118, 174], "rangle_a": [265, 267], "rank": [1, 60, 80, 122, 259, 296, 297, 298, 335, 382, 429, 430], "rapid": [104, 111, 434], "rapidli": 513, "rare": [44, 58, 340], "rare_threshold": 44, "rarefact": [67, 388], "rat": [477, 478, 481], "rate": [44, 247, 336, 415], "rather": [1, 60, 116, 247, 256, 304, 412, 417, 439, 462], "ratio": [61, 71, 77, 257, 258, 259, 262, 263, 265, 266, 269, 275, 340], "rational": 335, "raw": [106, 308, 313], "raw_f": [308, 313, 315], "raxml": 118, "rbwpd_": 70, "rc": [121, 210, 283, 321], "rda": [117, 320, 325, 326], "re": [0, 1, 21, 24, 29, 53, 82, 84, 85, 86, 105, 108, 111, 112, 118, 121, 184, 195, 208, 215, 221, 228, 232, 301, 333, 335, 336, 340, 345, 388, 407, 408, 466, 472, 473, 475, 477, 478, 480, 482, 483, 485, 511, 513], "reach": 118, "read": [1, 19, 20, 34, 53, 84, 85, 94, 105, 106, 107, 108, 109, 112, 114, 115, 116, 117, 118, 119, 121, 122, 125, 126, 127, 134, 138, 142, 145, 146, 159, 162, 176, 181, 184, 189, 190, 191, 193, 194, 215, 220, 221, 226, 227, 228, 246, 274, 276, 290, 301, 324, 347, 398, 401, 403, 405, 406, 407, 408, 409, 411, 412, 413, 414, 415, 416, 417, 418, 421, 422, 424, 425, 426, 427, 429, 432, 433, 435, 436, 437, 438, 439, 440, 441, 442, 443, 445, 446, 447, 448, 449, 450, 452, 453, 454, 455, 456, 457, 458, 459, 460, 461, 462, 463, 465, 466, 468, 469, 470, 471, 472, 473, 475, 476, 479, 481, 482, 483, 485, 492, 511], "read_numb": 119, "read_sequ": 11, "readabl": [104, 111, 112, 115, 116, 117, 118, 145, 490], "reader": [30, 93, 104, 105, 106, 107, 108, 109, 110, 112, 115, 116, 117, 118, 119, 120, 121, 122, 123, 124, 126, 131, 136, 138, 141, 142, 157, 186, 218, 223, 243, 284, 322, 383, 451, 506], "readi": [0, 123], "reading_fram": [189, 191, 193, 194, 226], "readlin": [125, 145], "real": [20, 28, 111, 112, 119, 256, 257, 258, 262, 263, 265, 266, 270, 271, 272, 480], "realiti": 20, "realli": 1, "rearrang": [475, 481], "rearranged": 481, "reason": [1, 20, 54, 67, 110, 116, 339, 358], "reassign": [31, 118, 298], "reassign_index": [20, 21, 24, 32, 33, 118], "reca": 156, "recal": 116, "recapitul": 304, "recaptur": 44, "receiv": [123, 124, 126, 233, 479], "recent": [118, 193, 228, 298], "receptor": 339, "reciev": 20, "recipi": [402, 423, 435], "reciproc": [59, 340], "recod": 23, "recogn": [120, 375, 385], "recommend": [1, 60, 70, 118, 121, 184, 195, 215, 221, 228, 259, 276, 321, 333, 339, 413, 496], "recomput": [21, 24, 29], "reconstruct": [477, 478, 480, 481, 484, 508], "record": [107, 110, 111, 112, 113, 114, 119], "rectangl": 55, "recurs": [116, 403, 473, 474, 475], "red": 283, "redefin": [298, 492], "reduc": [87, 300, 318, 331, 348, 459, 480], "reduce_f": 87, "reduct": 319, "redund": [277, 285, 291, 333, 474], "redundant_form": 269, "reeder": [61, 62], "ref": 106, "refer": [1, 11, 18, 19, 20, 23, 35, 36, 37, 38, 39, 40, 41, 44, 45, 46, 47, 48, 49, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 70, 71, 72, 73, 74, 75, 77, 80, 81, 84, 85, 87, 149, 184, 191, 192, 195, 215, 221, 228, 247, 248, 257, 258, 259, 264, 268, 269, 273, 275, 277, 285, 291, 292, 296, 297, 298, 299, 300, 304, 321, 325, 326, 331, 332, 333, 342, 358, 392, 399, 405, 412, 413, 415, 416, 417, 422, 431, 441, 457, 468, 475, 477, 478, 479, 480, 481, 482, 483, 484, 485, 496, 498, 510], "reference_sequ": 11, "refin": [408, 459, 463, 468, 477], "reflect": [145, 304, 456], "regard": 264, "regardless": [19, 22, 28, 29, 121, 176, 182, 193, 251, 302, 331, 407, 408, 412, 424, 425, 463], "regex": [208, 232], "region": [114, 149, 151, 235], "regist": [34, 94, 123, 124, 125, 126, 127, 130, 138, 140, 142, 159, 190, 220, 227, 246, 290, 324, 398, 409, 431, 476, 499, 506], "register_alias": [487, 498], "registri": [30, 34, 93, 94, 105, 109, 111, 112, 119, 157, 159, 186, 190, 218, 220, 223, 227, 243, 246, 284, 290, 322, 324, 383, 398, 451, 476, 506], "regress": [256, 298, 333, 340], "regsistri": [130, 140], "regular": [105, 109, 116, 208, 232, 508], "reid": 264, "reject": [259, 264, 336], "rel": [27, 43, 70, 105, 110, 113, 164, 178, 182, 211, 212, 233, 237, 239, 241, 269, 275, 292, 412, 461, 488, 497, 503, 508], "relat": [1, 53, 54, 64, 70, 84, 85, 87, 110, 111, 115, 121, 276, 295, 325, 326, 333, 358, 392, 412, 416, 458, 468], "relationship": [1, 70, 116, 256, 325, 326, 333, 336, 340, 348, 477, 478, 480, 481, 484, 506, 509], "relax": 118, "releas": [53, 70, 84, 85, 110, 122, 480], "relev": [1, 19, 113, 264, 339, 348, 358, 392, 431, 459, 480, 508], "reli": [69, 120, 184, 215, 221], "reliabl": 264, "reload": 112, "remain": [31, 111, 407, 408, 412, 458, 475, 480], "remaind": [111, 348], "rememb": [20, 120, 149], "remot": 113, "remov": [23, 41, 53, 70, 84, 85, 96, 111, 115, 118, 137, 154, 163, 197, 207, 352, 381, 385, 423, 435, 446, 450, 453, 454, 456, 457, 458, 459, 464, 470, 472, 473, 480, 508], "remove_by_func": [446, 450, 452, 454, 459], "remove_delet": 453, "remove_empti": 381, "remove_format": [125, 127], "renam": [79, 113, 195, 205, 206, 259, 268, 410, 412, 414, 416, 421, 439, 441, 453, 454, 460, 468, 473, 480], "renyi": [58, 81], "reorder": [298, 301], "repeat": [1, 112, 336, 494], "repeatedli": 336, "repect": 111, "repen": 110, "replac": [1, 10, 42, 49, 67, 111, 184, 187, 207, 215, 221, 224, 247, 256, 268, 318, 334, 341, 388, 395, 408, 415, 416, 441, 463, 466, 468, 493, 497], "report": [70, 120, 126, 264, 304, 333], "repres": [1, 3, 4, 6, 8, 14, 15, 18, 20, 22, 43, 49, 51, 53, 56, 58, 59, 67, 72, 74, 75, 81, 84, 85, 87, 95, 96, 97, 98, 99, 101, 104, 105, 106, 107, 110, 111, 115, 116, 118, 120, 121, 122, 149, 152, 162, 176, 184, 195, 215, 221, 228, 245, 247, 265, 266, 273, 274, 277, 278, 281, 289, 293, 304, 319, 321, 325, 331, 336, 342, 348, 359, 384, 389, 393, 400, 408, 409, 463, 467, 477, 478, 479, 480, 508, 511], "represent": [0, 1, 3, 14, 92, 95, 97, 98, 99, 104, 105, 111, 116, 120, 151, 191, 238, 274, 277, 303, 320, 342, 348, 358, 394, 399, 466, 467, 506, 511], "reprint": 55, "reproduc": [29, 53, 84, 85, 336, 496], "reproduct": 340, "request": [111, 179, 278, 289, 345, 352, 364, 375, 495, 506], "requir": [19, 53, 61, 62, 70, 84, 85, 104, 107, 108, 111, 114, 118, 121, 122, 156, 176, 181, 188, 193, 194, 225, 274, 276, 291, 298, 304, 318, 330, 338, 342, 348, 357, 409, 419, 457, 458, 480, 481, 498, 501, 506, 508, 513], "reroot": [400, 407, 456, 457, 458], "rerrang": 475, "rerun": 298, "res_metadata": 346, "res_tabl": [346, 347], "res_tre": 347, "resampl": 388, "research": [1, 122, 298], "resembl": [111, 409], "reserv": [118, 120], "reset": [20, 21, 24, 31, 456, 457, 458], "reset_index": [21, 24], "reshap": [364, 369], "resid": 318, "residu": [23, 96, 109, 333], "resolv": [87, 90, 120, 304], "resourc": [70, 120, 122, 145], "respect": [1, 20, 47, 111, 114, 117, 120, 122, 125, 126, 127, 136, 139, 141, 143, 145, 176, 228, 233, 251, 259, 273, 278, 281, 289, 293, 295, 304, 319, 320, 346, 347, 368, 369, 370, 389, 412, 413, 415, 496], "respons": [30, 34, 93, 94, 157, 159, 186, 190, 218, 220, 223, 227, 243, 246, 284, 290, 308, 313, 315, 319, 322, 324, 326, 333, 383, 398, 439, 451, 476], "restrict": [20, 53, 84, 85, 118, 162, 176, 482, 485, 508], "result": [1, 11, 19, 20, 23, 25, 29, 35, 36, 37, 53, 54, 60, 73, 82, 84, 85, 86, 90, 103, 106, 107, 111, 120, 123, 145, 153, 180, 182, 184, 197, 210, 214, 215, 221, 229, 245, 259, 264, 267, 268, 270, 293, 296, 298, 299, 300, 301, 302, 305, 307, 308, 309, 311, 312, 313, 314, 315, 316, 318, 320, 321, 325, 326, 331, 333, 336, 341, 348, 349, 370, 373, 381, 388, 392, 394, 408, 409, 412, 415, 416, 424, 426, 442, 459, 463, 466, 467, 468, 472, 479, 480, 489, 496, 506, 508, 513], "result_constructor": 480, "retain": [29, 164, 177, 178, 229, 244, 280, 318, 331, 348, 388, 397, 456, 457, 458], "retriev": [20, 165, 167, 171, 174, 176, 179, 180, 228, 291, 358, 362, 364], "return": [0, 1, 4, 5, 6, 7, 8, 9, 10, 11, 12, 14, 15, 16, 18, 19, 20, 22, 23, 25, 27, 29, 30, 32, 33, 35, 36, 37, 38, 39, 40, 41, 42, 44, 45, 46, 47, 48, 49, 50, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 71, 72, 73, 74, 75, 76, 77, 78, 79, 80, 81, 82, 84, 85, 86, 87, 88, 89, 90, 91, 93, 95, 100, 101, 102, 103, 106, 114, 123, 124, 125, 126, 130, 131, 132, 133, 134, 135, 136, 138, 139, 140, 141, 142, 143, 145, 149, 151, 152, 153, 157, 160, 161, 162, 163, 164, 165, 166, 167, 168, 169, 170, 171, 172, 174, 175, 176, 177, 178, 179, 180, 181, 182, 183, 184, 185, 186, 187, 188, 191, 192, 193, 195, 196, 197, 198, 200, 201, 202, 203, 204, 205, 206, 207, 208, 209, 210, 211, 212, 213, 214, 215, 216, 217, 218, 219, 221, 222, 223, 224, 225, 228, 229, 230, 231, 233, 234, 237, 238, 239, 240, 241, 242, 243, 244, 245, 247, 248, 249, 250, 251, 252, 254, 255, 257, 258, 259, 260, 261, 262, 263, 264, 265, 266, 267, 268, 269, 270, 271, 272, 273, 274, 275, 277, 278, 279, 280, 281, 282, 283, 284, 285, 287, 288, 289, 292, 293, 294, 295, 296, 297, 298, 299, 300, 301, 302, 304, 311, 318, 320, 321, 322, 325, 326, 327, 330, 331, 332, 333, 334, 336, 337, 338, 339, 340, 341, 342, 346, 347, 348, 350, 351, 353, 355, 356, 357, 358, 359, 360, 361, 362, 363, 364, 365, 366, 367, 368, 369, 370, 371, 372, 373, 374, 375, 376, 377, 378, 379, 380, 381, 382, 383, 384, 385, 386, 387, 388, 389, 390, 391, 392, 393, 394, 395, 396, 397, 400, 401, 403, 407, 408, 409, 411, 412, 413, 414, 415, 416, 417, 418, 420, 421, 422, 424, 425, 426, 427, 428, 429, 430, 431, 432, 433, 434, 437, 438, 439, 441, 442, 444, 445, 446, 451, 452, 453, 454, 455, 456, 457, 458, 459, 461, 462, 463, 466, 467, 468, 469, 471, 472, 473, 474, 475, 477, 478, 479, 480, 481, 482, 483, 484, 485, 486, 490, 491, 492, 494, 495, 496, 497, 500, 504, 506, 508, 513], "return_cod": 245, "reus": [19, 335, 431], "reveal": [319, 480], "revers": [20, 28, 32, 123, 189, 191, 193, 194, 210, 213, 214, 224, 226, 228, 296, 300, 386, 508, 513], "reverse_compl": [210, 213, 508], "reverse_transcrib": 188, "review": 405, "revisit": 273, "rf": [189, 194, 226, 413, 415, 483], "rf_dist": 413, "rfam": 121, "rho": 297, "riboswitch": [113, 149], "rice": 112, "rich": [1, 47, 53, 58, 63, 66, 67, 70, 79, 81], "rich_sparse_otu_table_hdf5": 358, "right": [20, 29, 44, 74, 116, 182, 256, 257, 258, 262, 267, 270, 271, 272, 273, 434, 447, 449, 488, 489, 513], "right_child_id": 466, "rightarrow": [257, 258, 262, 263, 265, 266], "risk": 340, "rl": [110, 121], "rm": [121, 306, 316], "rn": [110, 121], "rna": [0, 20, 36, 39, 41, 108, 110, 111, 112, 113, 118, 119, 121, 184, 187, 188, 189, 191, 193, 194, 195, 209, 228, 229, 264, 508], "rna_seq": [110, 113], "rng": [336, 339, 340, 496], "robbin": 56, "robinson": [411, 413, 414, 415, 483, 485], "robust": [70, 120, 269, 275, 300, 304], "rohlf": [412, 416], "role": [121, 247, 339], "rome": 55, "root": [1, 3, 53, 66, 70, 84, 85, 116, 122, 274, 331, 400, 401, 402, 403, 405, 406, 407, 408, 410, 412, 413, 414, 415, 416, 417, 419, 421, 422, 423, 424, 425, 426, 427, 429, 431, 433, 436, 437, 439, 440, 441, 442, 445, 447, 448, 449, 450, 456, 457, 458, 459, 461, 462, 463, 466, 467, 469, 470, 472, 473, 474, 475, 477, 478, 479, 480, 481, 482, 483, 485, 511], "root_at": [457, 472, 474, 475], "root_at_midpoint": 480, "root_nam": [456, 457, 458, 473], "rosid": 110, "roughli": 67, "round": [53, 60, 67, 84, 85, 298, 336, 339, 412, 415, 460, 468], "roundtrip": [105, 109], "roundtripp": 176, "routin": 291, "row": [1, 3, 20, 82, 86, 87, 90, 91, 95, 96, 97, 98, 99, 100, 104, 105, 109, 118, 149, 176, 247, 258, 259, 261, 264, 265, 266, 268, 270, 271, 272, 273, 276, 277, 282, 294, 295, 296, 297, 298, 299, 300, 301, 304, 320, 325, 326, 329, 333, 339, 340, 342, 353, 358, 359, 364, 368, 369, 370, 384, 385, 392, 394, 488], "rozan": 273, "rp": 110, "rpd": 70, "rpd_": 70, "rrna": [1, 264], "rt": [110, 121], "rtol": 488, "rubbbbrbcefgh": 119, "rule": [44, 111, 118, 120, 121, 479], "run": [1, 3, 53, 82, 84, 85, 86, 112, 119, 120, 185, 200, 216, 222, 259, 296, 297, 298, 300, 301, 304, 311, 321, 508, 513], "run_numb": 119, "runtim": [111, 184, 215, 221, 501, 513], "runtimeerror": 54, "rvrywstlnepwvfsnsgyalgtnapgrcsasnvakpgdsgtgpyivthnqi": 110, "rvsrv": 121, "rx": 110, "rykmbdhvn": [211, 212], "r\u00e9nyi": 72, "s1": [0, 1, 184, 213, 215, 221, 228, 229, 230, 231, 234, 239, 240, 241, 242, 259, 264, 296, 300, 345, 346, 347, 349, 351, 352, 355, 356, 362, 363, 364, 365, 366, 368, 370, 373, 374, 379, 380, 381, 382, 384, 386, 387, 388, 389, 391, 394, 395, 397], "s12064": [269, 275], "s2": [0, 1, 229, 231, 259, 264, 296, 300, 345, 346, 347, 349, 352, 355, 356, 362, 363, 364, 365, 366, 368, 370, 373, 374, 379, 380, 381, 382, 384, 386, 387, 388, 389, 391, 394, 395, 397], "s3": [259, 264, 296, 300, 345, 346, 347, 349, 355, 356, 363, 364, 365, 366, 370, 373, 374, 380, 381, 382, 384, 386, 387, 388, 389, 391, 394, 395, 397], "s4": [259, 264, 296, 300, 346, 347, 349, 355, 364], "s46826": 110, "s5": [259, 264, 296, 300, 349, 364], "s6": [259, 264, 300, 349], "s7": [300, 349], "s8": 349, "s9": 349, "s_": [1, 44, 47, 58, 60, 67, 79, 81], "s_1": [413, 415], "s_2": [413, 415], "s_i": 273, "sa": 121, "sacc": [106, 107], "saccver": [106, 107], "safe": [1, 53, 82, 84, 85, 86, 120, 331, 403], "safe_char": 116, "saga": [151, 153, 228], "sagb": [151, 153], "sagc": 151, "sai": [149, 151, 340], "saitou": 480, "sallacc": [106, 107], "sallgi": [106, 107], "sallseqid": [106, 107], "salltitl": [106, 107], "salmo": [111, 118], "salvemini": 55, "sam": 11, "sam_id": 369, "same": [1, 20, 22, 23, 24, 27, 29, 31, 43, 49, 53, 58, 60, 70, 71, 77, 84, 85, 100, 101, 102, 103, 109, 111, 112, 113, 114, 116, 119, 121, 123, 151, 158, 162, 164, 177, 178, 182, 188, 191, 193, 197, 199, 207, 210, 214, 225, 228, 229, 231, 235, 239, 240, 241, 242, 248, 254, 255, 259, 264, 277, 279, 280, 281, 286, 288, 293, 294, 296, 297, 298, 299, 300, 301, 304, 318, 323, 325, 326, 330, 331, 333, 339, 340, 341, 342, 348, 356, 379, 395, 407, 408, 412, 413, 425, 460, 475, 477, 479, 480, 488, 497, 508, 511], "samp_id": [362, 364], "sampl": [1, 43, 44, 45, 46, 49, 51, 52, 53, 54, 55, 56, 57, 58, 59, 61, 62, 63, 64, 65, 66, 67, 70, 71, 72, 73, 74, 75, 76, 77, 79, 80, 81, 82, 83, 84, 85, 86, 87, 90, 103, 104, 105, 120, 176, 256, 259, 264, 277, 296, 297, 299, 300, 306, 310, 316, 317, 318, 320, 321, 323, 325, 326, 331, 332, 333, 336, 338, 339, 340, 343, 344, 345, 346, 347, 348, 349, 351, 352, 355, 356, 357, 358, 360, 362, 363, 364, 365, 366, 368, 369, 370, 371, 372, 373, 374, 375, 376, 378, 379, 381, 382, 384, 385, 386, 387, 388, 389, 390, 391, 392, 394, 395, 396, 397, 412, 482, 489, 509], "sample1": [353, 359], "sample2": [353, 359], "sample3": 359, "sample4": 359, "sample5": 359, "sample6": 359, "sample_constraint": 320, "sample_count": [339, 340], "sample_gen": 369, "sample_group_metadata": 342, "sample_id": [342, 369, 377, 382], "sample_index": 342, "sample_map": 360, "sample_md": 1, "sample_metadata": [120, 176, 342, 352], "sample_metadata_f": 373, "sample_nam": 120, "sample_typ": [356, 381], "samplea": 318, "sampleb": 318, "samplec": 318, "sampleid": [120, 357], "samplemetadata": 120, "samplerecord": 113, "samtool": 11, "samv1": 11, "sanger": 112, "sapien": 111, "sapiensaccggttggc": 118, "satisfi": [123, 156, 331, 338, 504], "save": [19, 151, 176, 181, 277, 308, 313, 315, 408], "sb": 35, "sbc": 121, "sbjct": 107, "sbjctframe": 107, "sblastnam": [106, 107], "sbp": 273, "scalar": [20, 48, 245, 247, 267, 272, 276, 277, 321, 372, 376], "scale": [51, 297, 325, 326, 327, 333, 412, 415], "scale_i": 333, "scandinavian": 47, "scatter": 321, "scatterplot": [320, 321], "scenario": [109, 259, 472], "scheme": [122, 145, 166, 169, 170, 176, 181, 183, 283], "schmidt": [265, 266], "schneider": 23, "schoch": 122, "school": 110, "schwartz": 248, "sci": [37, 40, 107, 273], "scienc": [45, 46, 53, 108, 111, 248, 326, 413, 484], "sciencedirect": 108, "scientif": [106, 120, 291, 319, 331], "sciki": 111, "scikit": [0, 1, 30, 34, 35, 38, 41, 42, 53, 84, 85, 86, 87, 88, 89, 90, 93, 94, 105, 106, 107, 108, 110, 111, 112, 116, 117, 118, 119, 121, 122, 157, 159, 171, 172, 174, 175, 186, 188, 189, 190, 191, 193, 194, 218, 220, 223, 225, 226, 227, 243, 246, 253, 284, 290, 319, 322, 324, 383, 398, 400, 451, 472, 476, 496, 508, 512], "scipi": [1, 54, 83, 86, 89, 101, 254, 259, 264, 274, 277, 285, 291, 292, 295, 297, 298, 304, 336, 339, 340, 351, 382, 392, 412, 415, 416, 428, 441, 482, 484, 485], "scomnam": [106, 107], "scope": [53, 513], "score": [0, 11, 19, 23, 35, 36, 37, 38, 39, 40, 41, 42, 48, 106, 107, 111, 113, 114, 119, 228, 247, 249, 251, 320, 333, 415, 508], "score_filt": 19, "score_onli": 19, "score_s": 19, "sdr": 60, "sdrhelp": 60, "se": 121, "sea": 45, "search": [20, 35, 106, 107, 111, 156, 165, 180, 185, 200, 216, 222, 234, 277, 326, 351, 363, 366, 374, 397, 400, 410, 419, 424, 425, 426, 427, 431, 440, 447, 448, 449, 469, 494, 508], "sec": 215, "second": [1, 18, 19, 20, 35, 36, 37, 38, 39, 40, 41, 109, 112, 118, 123, 127, 149, 153, 191, 259, 277, 340, 407, 408, 434, 467, 506, 513], "secondari": [340, 359], "section": [29, 111, 112, 117, 120, 121, 176, 191, 228, 297, 298, 325, 326, 506], "sediment": 45, "see": [1, 28, 29, 30, 34, 41, 53, 61, 62, 70, 82, 84, 85, 86, 87, 89, 90, 93, 94, 107, 110, 111, 112, 116, 118, 119, 120, 122, 123, 148, 157, 159, 162, 173, 176, 186, 190, 191, 194, 218, 220, 223, 227, 228, 231, 243, 246, 264, 265, 266, 277, 284, 290, 294, 296, 297, 298, 299, 300, 301, 304, 318, 319, 321, 322, 324, 331, 333, 335, 336, 338, 339, 340, 341, 342, 373, 383, 398, 399, 402, 406, 413, 415, 416, 423, 424, 425, 435, 446, 450, 451, 452, 453, 454, 456, 457, 458, 459, 468, 470, 471, 472, 475, 476, 482, 485, 496, 506, 507, 513], "seed": [61, 62, 264, 294, 296, 298, 299, 300, 301, 302, 304, 318, 331, 336, 338, 339, 340, 341, 388, 412, 460, 482, 496], "seem": 339, "seen": [110, 113, 340], "segment": [3, 5, 9, 14, 55], "select": [20, 49, 70, 75, 120, 264, 300, 338, 339, 388, 460, 462, 478, 496], "selenocystein": 215, "self": [11, 91, 95, 125, 127, 140, 141, 142, 143, 151, 155, 160, 171, 174, 214, 228, 277, 278, 279, 288, 289, 323, 342, 345, 349, 353, 364, 370, 372, 373, 376, 385, 388, 394, 397, 400, 401, 402, 405, 407, 408, 409, 413, 415, 417, 420, 421, 422, 423, 424, 425, 433, 435, 439, 442, 444, 445, 446, 452, 455, 456, 461, 462, 463, 465, 466, 467, 468, 470, 473, 474, 475, 501, 502, 511, 513], "self_aft": 469, "self_befor": 469, "semi": 116, "semicolon": [111, 114], "send": [106, 107], "sens": [326, 340, 467], "sensit": [111, 120, 238], "sep": 110, "separ": [1, 106, 107, 109, 111, 112, 114, 115, 116, 117, 118, 120, 300, 302, 326, 357, 360, 407, 412], "seq": [0, 3, 8, 18, 20, 25, 26, 31, 32, 33, 35, 36, 37, 38, 39, 40, 106, 107, 108, 111, 112, 114, 118, 119, 171, 172, 174, 175, 189, 194, 195, 199, 208, 210, 214, 226, 228, 233, 244, 245, 264, 318, 513], "seq1": [0, 20, 21, 24, 31, 35, 36, 37, 38, 39, 40, 108, 111, 112, 118, 121, 254, 255], "seq2": [0, 20, 21, 24, 31, 35, 36, 37, 38, 39, 40, 111, 112, 121, 254, 255], "seq3": [20, 24, 111, 118], "seq4": 111, "seq5": 111, "seq_1": 114, "seq_2": 114, "seq_gen": 506, "seq_gener": 199, "seq_id": 114, "seq_idx": 20, "seq_num": [111, 112, 113, 114, 119], "seqid": 114, "seqr": 113, "sequenc": [1, 3, 4, 5, 6, 9, 10, 11, 14, 16, 18, 19, 20, 21, 22, 24, 25, 26, 27, 28, 29, 31, 32, 33, 35, 36, 37, 38, 39, 40, 41, 95, 96, 97, 98, 99, 106, 107, 108, 109, 110, 112, 113, 114, 119, 122, 149, 151, 153, 171, 172, 174, 264, 277, 302, 318, 340, 505, 506, 513], "sequence1": 41, "sequence2": 41, "sequenceprocessor": 513, "sequencevector": [97, 100], "sequenti": [80, 109, 111, 112, 118, 273, 274, 321, 470], "ser": 215, "seri": [1, 32, 82, 114, 148, 162, 166, 170, 173, 259, 264, 295, 296, 297, 299, 300, 305, 320, 336], "serial": [115, 176, 276, 320, 506], "serin": 215, "serv": [0, 122, 319, 321, 456, 458, 499], "server": [35, 36, 37, 38, 39, 40, 122], "set": [4, 13, 16, 19, 20, 22, 25, 28, 29, 53, 70, 84, 85, 90, 111, 113, 115, 118, 124, 145, 151, 154, 160, 165, 171, 174, 180, 182, 184, 195, 215, 221, 228, 229, 233, 235, 238, 245, 248, 256, 268, 283, 289, 304, 318, 331, 333, 336, 338, 339, 340, 348, 349, 356, 388, 390, 404, 407, 408, 409, 412, 413, 415, 417, 423, 431, 435, 446, 452, 456, 457, 458, 462, 463, 468, 473, 475, 479, 480, 482, 483, 485, 492, 494, 508, 513], "set1": 321, "set_index": 429, "setminu": 413, "setter": 150, "setup": 513, "seven": 259, "sever": [53, 116, 118, 336], "sex": [338, 339], "sffaaa": 112, "sfprgfifgagssayqfegavneggrgpsiwdtfthkypekirdgsnaditv": 110, "sframe": [106, 107], "sg": [189, 194, 226], "sgc": [193, 194], "sgi": [106, 107], "shallow": [20, 151, 160, 171, 174, 228, 400, 417, 473], "shannon": [23, 57, 58, 71, 72, 81], "shannon_entropi": 23, "shape": [3, 4, 5, 6, 8, 9, 10, 14, 15, 16, 20, 25, 102, 104, 117, 257, 258, 260, 261, 262, 263, 265, 266, 267, 268, 269, 270, 271, 272, 273, 275, 277, 298, 327, 330, 341, 342, 358, 359, 392, 399], "share": [19, 29, 44, 171, 172, 174, 175, 182, 228, 229, 319, 411, 412, 413, 414, 415, 416, 482, 483, 485, 511], "shared_by_al": [482, 483, 485], "shared_onli": 414, "shear": 450, "sheet": 120, "shift": 153, "shkolniski": 331, "short": 513, "short_cicruit": 501, "short_circuit": 501, "short_method_nam": [320, 489], "shorter": 118, "should": [1, 19, 23, 42, 43, 49, 53, 54, 67, 70, 79, 82, 83, 84, 85, 86, 106, 113, 117, 120, 122, 123, 125, 126, 127, 149, 151, 164, 176, 178, 184, 191, 207, 215, 221, 231, 235, 236, 237, 255, 257, 258, 259, 269, 275, 292, 298, 300, 304, 318, 325, 326, 332, 333, 336, 339, 340, 343, 344, 353, 388, 394, 397, 407, 408, 416, 429, 435, 456, 457, 458, 463, 469, 473, 475, 480, 496, 497], "shouldn": 326, "show": [1, 151, 336, 511], "show_intern": 403, "shown": [149, 259, 325], "shrink": 264, "shtml": 111, "shuffl": [412, 482], "shuffle_f": [412, 460], "shuffler": [412, 460, 482], "siam": 331, "sibl": [116, 229, 400], "side": [70, 298, 301, 304, 407, 408, 472], "sidewai": 400, "sigh": 505, "sign": [120, 259, 489], "signatur": [87, 146, 348, 358, 392], "signific": [1, 120, 259, 264, 296, 298, 299, 300, 301, 304, 339, 340], "significance_test": 259, "significantli": [1, 28, 259, 296, 299, 300, 431], "silent": [53, 84, 85, 364, 410], "silpl": 193, "simd": [19, 41], "similar": [35, 36, 37, 38, 39, 40, 83, 107, 110, 111, 112, 115, 118, 120, 123, 228, 247, 296, 297, 298, 299, 300, 319, 326, 331, 333, 339, 340, 412, 415, 508, 511], "similarli": [0, 1, 20, 111, 508], "simpl": [106, 107, 111, 112, 116, 120, 121, 123, 130, 140, 270, 297, 304, 480, 506, 511], "simpler": 0, "simplex": [257, 265, 266, 273], "simpli": [20, 23, 29, 79, 123, 191, 285, 331, 336, 513], "simplifi": 55, "simpson": [49, 51, 58, 59, 72, 76, 77, 81], "simpson_": 76, "simul": [256, 336, 339, 340, 415], "simultan": [331, 468], "sinc": [1, 20, 21, 24, 32, 41, 42, 55, 90, 110, 111, 113, 118, 120, 122, 149, 193, 228, 233, 259, 298, 336, 340, 420, 464, 474, 480, 483, 492, 513], "singl": [1, 20, 21, 24, 31, 53, 61, 62, 69, 84, 85, 87, 109, 110, 111, 112, 113, 116, 118, 119, 120, 121, 148, 149, 151, 153, 162, 173, 176, 208, 228, 233, 235, 247, 259, 273, 304, 337, 348, 349, 358, 373, 400, 406, 407, 415, 436, 450, 453, 454, 458, 459, 462, 468, 485, 504, 506, 511, 513], "singleton": [1, 44, 47, 48, 52, 54, 56, 69, 73, 78, 123], "singular": [1, 103, 300, 331, 335, 504], "sinica": 44, "site": [1, 113, 117, 235, 319, 320, 321, 331], "site0": 117, "site1": [117, 319], "site10": 319, "site2": [117, 319], "site3": [117, 319], "site4": [117, 319], "site5": [117, 319], "site6": [117, 319], "site7": [117, 319], "site8": [117, 319], "site9": [117, 319], "sitemap": 113, "situat": [1, 321, 338, 407], "six": [117, 189, 191, 194, 226, 259], "sixth": [415, 485], "size": [20, 51, 264, 277, 296, 297, 298, 300, 317, 318, 321, 330, 336, 338, 339, 340, 348, 358, 392, 477, 481, 484, 500], "sk": 120, "sk_read": 506, "skbio": [120, 505], "skbio_func1": 496, "skbio_func2": 496, "skin": [1, 321], "skip": [235, 296, 298, 299, 300, 304, 358, 410], "skip_subregion": 114, "sklearn": 86, "slen": [106, 107], "slice": [20, 185, 200, 216, 222, 228, 232, 235, 244, 276, 277, 342, 400, 508], "slightli": [35, 60, 300, 480], "slope": 60, "slow": [1, 53, 82, 84, 85, 86], "slower": 0, "sm": 245, "small": [1, 49, 115, 121, 256, 268, 331, 333], "smaller": [58, 79, 235, 301, 407, 408], "smallest": [80, 118, 339, 340, 382], "smith": [0, 19, 38, 39, 40, 41, 304], "snif": 506, "sniff": 506, "sniffer": [104, 105, 106, 107, 108, 109, 110, 111, 112, 113, 114, 115, 116, 117, 118, 119, 120, 121, 122, 123, 124, 132, 136, 138, 141, 142, 506], "sniffer_funct": 124, "so": [1, 3, 11, 23, 35, 36, 37, 38, 39, 40, 42, 53, 82, 84, 85, 86, 111, 116, 120, 123, 145, 146, 151, 211, 212, 298, 316, 319, 325, 326, 327, 333, 336, 338, 339, 340, 390, 479, 480, 482, 506, 511, 513], "sob": [1, 43, 58, 68, 69, 81], "societi": 70, "softwar": [1, 111, 112, 120, 393, 505], "sokal": [412, 416, 484], "sole": [120, 177], "solexa": 112, "solut": 54, "solv": [54, 336], "some": [1, 19, 43, 53, 55, 67, 70, 96, 111, 113, 116, 119, 120, 125, 126, 127, 149, 155, 184, 215, 221, 258, 270, 271, 272, 326, 331, 336, 339, 409, 412, 415, 439, 450, 459, 468, 501, 511, 513], "someformat": 506, "someskbioclass": [123, 506], "someth": [30, 34, 93, 94, 123, 126, 136, 138, 139, 141, 142, 143, 157, 159, 186, 190, 218, 220, 223, 227, 243, 246, 284, 290, 322, 324, 353, 383, 398, 451, 476, 513], "sometim": [49, 111, 113, 120, 326, 506], "somewhat": 304, "sonnhamm": 121, "soppos": 110, "sort": [25, 29, 88, 89, 149, 151, 199, 233, 245, 310, 316, 318, 348, 387, 388, 407, 408, 462, 463, 466, 467, 479, 508, 513], "sort_categori": [305, 306, 309, 310, 316], "sort_f": 386, "sort_index": 32, "sorted_t": 387, "sourc": [3, 4, 5, 6, 7, 8, 9, 10, 14, 15, 16, 17, 18, 20, 21, 22, 23, 24, 25, 26, 27, 28, 29, 30, 31, 32, 33, 34, 35, 36, 37, 38, 39, 40, 41, 42, 44, 45, 46, 47, 48, 49, 50, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 71, 72, 73, 74, 75, 76, 77, 78, 79, 80, 81, 82, 84, 85, 86, 87, 88, 89, 90, 91, 92, 93, 94, 95, 96, 97, 98, 99, 100, 101, 102, 103, 110, 111, 113, 114, 124, 125, 126, 127, 128, 129, 130, 131, 132, 133, 134, 135, 136, 137, 138, 139, 140, 141, 142, 143, 145, 146, 147, 148, 149, 150, 151, 152, 153, 154, 155, 156, 157, 158, 159, 160, 161, 162, 163, 164, 165, 166, 167, 168, 169, 170, 171, 172, 173, 174, 175, 176, 177, 178, 179, 180, 181, 182, 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, 193, 194, 195, 196, 197, 198, 199, 200, 201, 202, 203, 204, 205, 206, 207, 208, 209, 210, 211, 212, 213, 214, 215, 216, 217, 218, 219, 220, 221, 222, 223, 224, 225, 226, 227, 228, 229, 230, 231, 232, 233, 234, 235, 236, 237, 238, 239, 240, 241, 242, 243, 244, 245, 246, 247, 248, 249, 250, 251, 252, 254, 255, 257, 258, 259, 260, 261, 262, 263, 264, 265, 266, 267, 268, 269, 270, 271, 272, 273, 274, 275, 277, 278, 279, 280, 281, 282, 283, 284, 285, 286, 287, 288, 289, 290, 291, 292, 293, 294, 295, 296, 297, 298, 299, 300, 301, 302, 304, 306, 307, 308, 309, 310, 311, 312, 313, 314, 315, 316, 317, 318, 320, 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, 331, 332, 333, 334, 335, 337, 338, 339, 340, 341, 342, 343, 344, 345, 346, 347, 348, 349, 350, 351, 352, 353, 354, 355, 356, 357, 358, 359, 360, 361, 362, 363, 364, 365, 366, 367, 368, 369, 370, 371, 372, 373, 374, 375, 376, 377, 378, 379, 380, 381, 382, 383, 384, 385, 386, 387, 388, 389, 390, 391, 392, 393, 394, 395, 396, 397, 398, 399, 400, 401, 402, 403, 404, 405, 406, 407, 408, 409, 410, 411, 412, 413, 414, 415, 416, 417, 418, 419, 420, 421, 422, 423, 424, 425, 426, 427, 428, 429, 430, 431, 432, 433, 434, 435, 436, 437, 438, 439, 440, 441, 442, 443, 444, 445, 446, 447, 448, 449, 450, 451, 452, 453, 454, 455, 456, 457, 458, 459, 460, 461, 462, 463, 464, 465, 466, 467, 468, 469, 470, 471, 472, 473, 474, 475, 476, 477, 478, 479, 480, 481, 482, 483, 484, 485, 486, 487, 488, 489, 490, 491, 492, 493, 494, 495, 496, 497, 498, 499, 500, 501, 502, 503, 504, 505], "space": [1, 102, 111, 116, 118, 120, 121, 151, 153, 256, 257, 258, 262, 263, 265, 266, 310, 319, 320, 321, 325, 332, 348], "spaitial": 300, "span": [7, 53, 70, 87, 111, 113, 116, 149, 156, 348, 458], "spars": [105, 265, 266, 274, 325, 333, 342, 351, 358, 368, 369, 370, 390, 392], "sparse_vector": 348, "sparsedatafram": 391, "spatial": [1, 83, 86, 89, 101, 254, 277, 285, 291, 292, 295, 300, 412, 415, 482, 485], "spearman": [1, 297, 298, 301], "spearmanr": [297, 298], "spec": [11, 176], "specfi": 513, "speci": [1, 43, 44, 51, 53, 56, 58, 59, 60, 65, 70, 74, 75, 79, 80, 81, 117, 122, 264, 270, 319, 326, 331, 333], "special": [3, 11, 14, 19, 20, 72, 81, 91, 95, 96, 97, 98, 99, 115, 123, 124, 128, 148, 149, 151, 160, 162, 171, 173, 174, 176, 184, 191, 195, 209, 215, 221, 228, 247, 277, 291, 306, 307, 309, 310, 312, 314, 316, 317, 320, 342, 358, 392, 400, 486, 491, 492, 501, 503, 504], "speciat": 304, "specie1": 319, "specie2": 319, "specie3": 319, "specie4": 319, "specie5": 319, "specie6": 319, "specie7": 319, "specie8": 319, "specie9": 319, "species0": 117, "species1": 117, "species2": 117, "species3": 117, "species4": 117, "species5": 117, "species6": 117, "species7": 117, "species8": 117, "species_a": 405, "species_divers": 43, "species_even": 43, "species_rich": 43, "speciesa": 405, "specif": [48, 53, 60, 82, 84, 85, 86, 87, 90, 123, 156, 162, 228, 304, 310, 311, 339, 340, 342, 348, 358, 392, 400, 410, 413, 460, 472, 497, 506, 512, 513], "specifi": [20, 27, 29, 70, 90, 96, 106, 108, 109, 111, 112, 113, 114, 115, 118, 121, 122, 123, 145, 149, 151, 154, 156, 180, 181, 184, 185, 188, 192, 193, 195, 200, 215, 216, 221, 222, 225, 228, 233, 238, 257, 258, 259, 264, 265, 266, 268, 274, 277, 278, 280, 282, 283, 286, 289, 296, 297, 298, 299, 300, 304, 317, 321, 323, 330, 331, 337, 342, 345, 348, 358, 362, 364, 385, 392, 410, 412, 413, 416, 435, 456, 457, 460, 467, 468, 473, 474, 475, 479, 482, 496, 501, 503, 504, 513], "speed": [151, 331], "spermatophyta": 110, "sph": 11, "sphingobacteria": [430, 467], "split": [20, 111, 112, 118, 121, 407], "spmatrix": [342, 351], "spreadsheet": [115, 120], "sqcup": [53, 70], "sqlite": 180, "sqrt": [52, 64, 65, 66, 273, 333, 412, 415], "squar": [66, 67, 86, 116, 247, 277, 291, 328, 412, 415, 478, 482], "squareform": [277, 295], "sr1": 191, "srava": 121, "ss": [121, 388], "ss_con": 121, "sscinam": [106, 107], "sseq": [106, 107], "sseqid": [106, 107], "sskingdom": [106, 107], "sstart": [106, 107], "sstrand": [106, 107], "ssw": [11, 19, 41], "stabl": [278, 289, 404, 433, 441, 496], "stackoverflow": 500, "stai": 120, "stale": 151, "stamataki": 405, "stand": [212, 298], "standalon": 111, "standard": [111, 112, 114, 116, 120, 188, 189, 191, 193, 194, 225, 226, 245, 256, 259, 277, 297, 298, 327, 330, 333, 334, 409, 506, 508], "standard_norm": [336, 339, 340], "standardis": 51, "staphylococcu": 345, "start": [0, 3, 4, 5, 6, 7, 9, 10, 12, 13, 14, 16, 18, 19, 20, 21, 24, 31, 35, 36, 37, 38, 39, 40, 41, 96, 106, 107, 110, 113, 114, 115, 116, 118, 121, 122, 149, 152, 158, 174, 191, 193, 194, 230, 234, 277, 301, 302, 336, 339, 340, 368, 400, 404, 475, 513], "start_end_posit": 0, "stat": [0, 1, 3, 20, 21, 22, 24, 28, 29, 32, 67, 96, 97, 101, 103, 104, 108, 109, 110, 111, 112, 113, 114, 115, 117, 118, 119, 121, 174, 184, 187, 188, 189, 191, 193, 194, 195, 197, 199, 210, 214, 215, 221, 224, 225, 226, 228, 229, 247, 253, 382, 505, 508], "state": [3, 4, 5, 6, 8, 9, 10, 14, 17, 18, 70, 108, 118, 120, 145, 501, 502, 504, 513], "static": [195, 357, 360], "statis": [296, 299], "statist": [1, 44, 47, 52, 60, 67, 72, 73, 81, 257, 259, 264, 296, 298, 299, 300, 301, 304, 319, 325, 326, 330, 336, 339, 340, 478, 484, 505], "statistica": [44, 55], "statsmodel": [259, 264, 336], "statu": [3, 14, 338, 339, 487, 493], "staxid": [106, 107], "std": [110, 330, 334, 339], "steel": [412, 480], "steep": 325, "step": [1, 20, 21, 24, 31, 53, 82, 84, 85, 86, 118, 123, 174, 329], "still": [20, 116, 117, 145, 150, 259, 264, 268, 298, 452, 472], "stimat": 334, "stitl": [106, 107], "stochast": 496, "stockholm": [30, 34], "stockholm_format": 121, "stombaugh": [84, 85], "stool": 340, "stop": [20, 21, 24, 31, 44, 96, 97, 109, 118, 174, 188, 189, 191, 193, 194, 215, 217, 225, 226, 230, 234, 342, 399, 405, 501, 508], "stop_char": 215, "storag": [151, 390], "store": [2, 20, 28, 104, 105, 106, 107, 108, 109, 110, 111, 112, 113, 115, 116, 117, 118, 119, 120, 121, 122, 149, 151, 171, 172, 174, 175, 176, 183, 184, 195, 215, 221, 228, 276, 277, 285, 291, 301, 307, 312, 314, 320, 325, 326, 331, 333, 348, 358, 392, 400, 507, 508], "str": [11, 16, 18, 19, 20, 30, 34, 42, 82, 86, 87, 88, 89, 90, 91, 93, 94, 95, 96, 97, 98, 99, 101, 106, 113, 114, 121, 124, 131, 132, 133, 136, 137, 138, 139, 141, 142, 143, 145, 157, 159, 162, 164, 167, 176, 177, 178, 179, 180, 181, 184, 185, 186, 190, 191, 195, 199, 200, 207, 213, 215, 216, 218, 220, 221, 222, 223, 227, 228, 230, 231, 232, 233, 234, 236, 238, 239, 240, 241, 242, 243, 244, 245, 246, 248, 250, 259, 264, 269, 274, 277, 278, 280, 282, 283, 284, 289, 290, 296, 297, 299, 300, 301, 302, 307, 310, 312, 314, 320, 321, 322, 323, 324, 331, 338, 339, 342, 345, 348, 351, 352, 353, 355, 357, 358, 362, 366, 374, 382, 383, 390, 392, 393, 394, 398, 400, 403, 407, 408, 409, 410, 412, 415, 416, 424, 425, 435, 439, 451, 456, 457, 458, 459, 462, 463, 468, 473, 475, 476, 479, 482, 483, 485, 486, 487, 490, 493, 495], "straight": 1, "straightforward": [120, 508], "strand": [106, 107, 113, 114, 121, 149, 187, 188, 189, 224], "stranded": 113, "strategi": [256, 268, 480], "stream": [111, 114], "strength": 1, "streptophyta": 110, "strict": [29, 118, 229, 280, 286, 298, 301, 304, 323, 348, 397, 436, 459], "strict_match": [338, 339], "stricter": [116, 488], "strictli": [111, 259, 264, 274, 406], "string": [1, 3, 11, 14, 16, 18, 19, 20, 82, 86, 87, 90, 92, 98, 99, 104, 108, 109, 111, 112, 116, 118, 120, 121, 169, 170, 176, 183, 191, 208, 228, 232, 233, 238, 244, 245, 247, 259, 264, 276, 277, 281, 293, 296, 299, 300, 302, 320, 321, 353, 356, 382, 393, 394, 397, 400, 403, 467, 480, 490, 511], "stringifi": 342, "stringio": [1, 84, 85, 106, 107, 108, 110, 111, 112, 113, 114, 116, 117, 118, 119, 121, 122, 145, 276, 357, 360, 506, 511], "strip": 405, "stripe": [19, 41], "stripedsmithwaterman": [0, 41], "strong": [1, 184, 296, 298, 304], "struct": [11, 113], "structur": [3, 84, 85, 107, 109, 113, 116, 122, 248, 277, 296, 297, 304, 319, 342, 348, 358, 392, 399, 400, 463, 501], "studi": [1, 53, 120, 176, 256, 259, 319, 333, 340, 458], "style": [256, 473, 474, 475], "su": 121, "sub": [113, 114, 149, 341], "subclass": [29, 100, 101, 102, 103, 108, 111, 118, 121, 123, 162, 228, 229, 247, 276, 277, 302, 479, 501], "subfold": 495, "subject": [1, 106, 107, 120, 456, 457, 473, 507, 513], "subject1": 107, "subject2": 107, "sublist": 340, "submit": [110, 111, 340], "submodul": 123, "suboptim": [11, 19], "suboptimal_alignment_scor": 11, "subsampl": [67, 318, 336, 339, 340, 341, 412, 482], "subsample_count": [67, 318], "subsample_paired_pow": 340, "subsample_pow": 336, "subseq": [228, 235], "subsequ": [38, 108, 111, 120, 228, 230, 234, 235, 256, 419, 431, 480, 501, 508], "subset": [53, 70, 84, 85, 90, 104, 110, 297, 358, 364, 388, 407, 408, 409, 413, 414, 415, 458, 459, 468, 511], "subset_with_metadata": 358, "subsitut": 245, "substitut": [19, 35, 36, 37, 38, 39, 40, 42, 115, 215, 245, 247, 248, 249, 250, 251, 252, 256, 508], "substitution_matrix": [19, 35, 36, 37, 38, 39, 40], "substitutionmatrix": [42, 245, 508], "substract": [35, 36, 37, 38, 39, 40, 329], "substrat": 319, "substrate_cor": 319, "substrate_oth": 319, "substrate_sand": 319, "subtili": 121, "subtract": [19, 317], "subtre": [116, 122, 406, 408, 413, 415, 416, 417, 426, 427, 436, 439, 441, 463, 477, 481, 484, 511], "success": [501, 513], "success_callback": [501, 513], "success_f": 513, "successfulli": 405, "suffic": [482, 485], "suffix": 43, "sugar": 20, "suggest": [19, 126, 136, 138, 141, 142, 331, 339], "suit": 326, "sum": [44, 53, 64, 65, 67, 70, 109, 153, 233, 258, 262, 263, 267, 340, 341, 368, 369, 373, 378, 388, 409, 412, 415, 416, 421, 422, 433, 441, 466, 478, 480, 482, 485, 500], "sum_": [46, 49, 51, 53, 55, 58, 59, 70, 72, 74, 75, 81, 256, 258, 270, 271, 272, 298, 415], "summar": 259, "summari": [20, 259, 277, 378], "super": [106, 107], "superkingdom": 122, "superset": [53, 70, 84, 85, 296, 300], "supplementari": [112, 259], "suppli": [19, 106, 111, 119, 136, 141, 177, 231, 253, 340, 348], "support": [1, 2, 23, 30, 34, 55, 145, 148, 157, 159, 173, 176, 177, 184, 186, 190, 215, 218, 220, 221, 223, 227, 243, 246, 247, 248, 259, 264, 284, 290, 298, 320, 322, 324, 331, 336, 342, 348, 375, 383, 398, 400, 405, 435, 451, 456, 457, 458, 471, 473, 475, 476, 479, 492, 496, 501, 504, 509, 510, 511, 512, 513], "support_attr": 479, "support_valu": 479, "suppos": [106, 107, 110, 111, 112, 113, 116, 119, 121, 270, 336, 340], "suppress": [122, 296, 300, 301, 431], "suppress_sequ": [11, 19, 41], "sure": [293, 340, 513], "surfac": 416, "surpass": 118, "surround": [116, 264], "survei": 1, "sv": 110, "svd": [103, 335], "svg": [320, 486], "sw": [19, 338], "swab": 1, "swiss": 110, "switch": [302, 342, 412, 460], "sy": [146, 499], "symbiont": 304, "symbol": [23, 111], "symmetr": [1, 247, 276, 277, 291, 293, 298, 302, 304, 325, 413, 482, 483, 485], "symmetri": [276, 277, 291, 293, 294], "symposium": 72, "symptom": 340, "syn": 113, "synonym": [1, 122], "syntact": 20, "syntax": 20, "synthesi": 121, "synthet": 113, "system": [30, 34, 63, 74, 93, 94, 120, 122, 123, 151, 157, 159, 186, 190, 218, 220, 223, 227, 243, 246, 284, 290, 322, 324, 339, 364, 383, 398, 400, 451, 476], "systemat": [70, 412, 482, 484], "t": [1, 8, 19, 20, 21, 23, 24, 25, 28, 29, 33, 41, 51, 53, 55, 70, 82, 84, 85, 86, 110, 111, 112, 113, 114, 115, 117, 119, 120, 121, 122, 146, 149, 181, 184, 187, 193, 202, 203, 204, 205, 211, 212, 215, 221, 224, 228, 230, 231, 233, 239, 240, 241, 242, 247, 251, 257, 259, 264, 265, 266, 269, 270, 274, 277, 301, 325, 326, 331, 333, 335, 338, 340, 345, 353, 358, 359, 375, 382, 392, 395, 407, 456, 457, 458, 465, 466, 473, 479, 491, 506, 508, 512, 513], "t0": [106, 107, 114, 117, 119, 276], "t1": [106, 107, 117, 119, 122, 276, 357, 456], "t10": [114, 117], "t100": [106, 107], "t10596": 107, "t1217": 107, "t1233": 107, "t131567": 122, "t1566": 107, "t161": 106, "t2": [117, 119, 357, 360, 456], "t2130": 107, "t2214": 107, "t3": [119, 357, 360], "t30": [114, 119], "t329": 106, "t330": 106, "t335928": 122, "t34": 119, "t35": 119, "t3e": [106, 107], "t4": 117, "t42": 107, "t44": 107, "t5": 360, "t50": 114, "t5565": 107, "t5587": 107, "t5671": 107, "t6": 360, "t6821": 107, "t6928": 107, "t6e": 107, "t80": 114, "t811": 107, "t8468": 107, "t8552": 107, "t8e": 107, "t9": 117, "t90": 114, "t94": 107, "t96": 114, "t99": 106, "t9e": 106, "t_1": [412, 413, 415], "t_2": [412, 413, 415], "t_a": 373, "t_b": 373, "ta": [276, 508], "taaactatta": 110, "taaactccgg": 110, "taacaatcct": 110, "taacatatac": 112, "taacgtta": [187, 224], "taagactaaa": 110, "taatgaatgg": 110, "tab": [106, 107, 114, 115, 116, 117, 119, 120, 122, 352, 357, 360, 394], "tabl": [1, 82, 86, 105, 112, 113, 120, 122, 180, 188, 189, 191, 192, 193, 194, 225, 226, 259, 264, 319, 325, 326, 332, 333, 419, 424, 425, 431, 501, 505, 507, 508], "table2": 395, "table3": 395, "table_id": [192, 342, 399], "tableexcept": [342, 384, 397, 399], "tabular": [3, 7, 20, 26, 106, 107, 120, 122, 176], "tabularmsa": [0, 3, 7, 8, 14, 35, 36, 37, 38, 39, 40, 41, 108, 112, 118, 121, 151, 506], "tac": 119, "tacatcgttt": 110, "tacatgtgta": 110, "taccaggcat": 110, "tacccggt": 508, "tacctaagtt": 110, "tacg": 119, "tacgta": 119, "tae000111": 107, "tae000171": 107, "tae000174": 107, "tae000425": 107, "tag": [114, 121, 199, 208, 273], "tagagattaattgccactgccaaaattctg": 0, "tagattacag": 110, "taggttgatc": 110, "tagtgaatgg": 110, "take": [1, 86, 118, 123, 125, 126, 127, 162, 231, 244, 259, 281, 291, 293, 297, 298, 302, 316, 325, 333, 336, 337, 343, 344, 353, 373, 386, 394, 395, 409, 412, 415, 480, 482, 485, 501, 511, 513], "taken": [1, 106, 107, 111, 118, 121, 122, 259, 304, 500], "target": [0, 1, 11, 19, 41, 52, 114, 278, 289, 456], "target_begin": 11, "target_end_optim": 11, "target_end_suboptim": 11, "target_sequ": [0, 11, 19], "task": 506, "tata": 232, "tataa": 232, "tatattagca": 110, "tatctaactg": 110, "tatgtatata": 112, "tatgtatatataacatatacatatatacatacata": 112, "tau": 259, "tax": 107, "tax_id": [122, 429], "taxa": [1, 43, 44, 45, 46, 49, 50, 51, 52, 53, 54, 56, 57, 58, 59, 60, 63, 65, 66, 67, 69, 70, 71, 72, 73, 74, 75, 77, 78, 79, 80, 81, 82, 84, 85, 86, 87, 90, 120, 122, 259, 326, 340, 400, 407, 408, 411, 412, 413, 414, 415, 416, 458, 459, 462, 463, 468, 477, 478, 480, 481, 482, 483, 484, 485], "taxdump": 429, "taxdump_readm": 122, "taxid": 122, "taxon": [1, 44, 45, 46, 49, 51, 53, 57, 58, 59, 64, 65, 70, 71, 72, 73, 74, 75, 80, 81, 84, 85, 110, 113, 342, 399, 408, 409, 412, 415, 416, 429, 430, 458, 462, 463, 468, 485, 511], "taxonom": [1, 84, 430], "taxonomi": [106, 116, 120, 122, 191, 192, 348, 349, 358, 375, 392, 400, 429, 430, 467], "taxonomy_0": [375, 390], "taxonomy_1": [375, 390], "taylor": 60, "tb": [276, 357, 360], "tc": [276, 357, 360], "tcaaaagaaa": 110, "tcatttagga": 119, "tcc": 0, "tccacaaatg": 110, "tccagaaaaa": 110, "tcg": 208, "tcga": 245, "tcggagcagt": 110, "tcgggcasdgca": 119, "tcgggcattgca": 119, "tcgtatagat": 110, "tctacccctctcagaga": 0, "tctataagattccgcatgcgttacttataagatgtctcaacgg": 0, "tctcaatctc": 110, "tctcaga": 0, "tcttaacata": 110, "tcttcagcat": 110, "tcttgctcat": 110, "tctttgcttc": 110, "technic": [74, 116], "techniqu": [1, 54, 256, 325, 326, 509], "teh": [342, 399], "tell": 259, "temorg": 107, "temperatur": 339, "tempfil": 145, "temporari": 348, "temporaryfil": 145, "ten": 1, "tend": 120, "tensor": [91, 95], "ter": [215, 326], "term": [1, 23, 43, 49, 70, 105, 113, 162, 166, 176, 304, 319, 400, 480, 482], "termin": [110, 188, 193, 225, 415, 485], "test": [1, 20, 70, 123, 149, 151, 162, 176, 191, 228, 256, 259, 264, 276, 296, 298, 299, 300, 301, 303, 304, 311, 336, 339, 340, 354, 488, 489, 495], "test2": 340, "test_tabl": [357, 360], "texon": 114, "text": [46, 49, 64, 65, 80, 106, 108, 110, 111, 112, 113, 114, 115, 116, 117, 118, 119, 120, 122, 123, 125, 126, 127, 145, 176, 276, 308, 313, 315, 413, 415], "textiobas": [124, 125, 126, 127, 145], "textiowrapp": 145, "tf": 38, "tgaaggatca": 110, "tgaattcaac": 110, "tgca": 119, "tgene": 114, "tgenu": 122, "tgetaaafhwqaaf": 119, "tgg": [199, 208], "tggaacaatt": 110, "tggattaaaa": 110, "tggattctgc": 149, "tggtgcacct": 110, "tggtgctgga": 110, "tgi": 106, "tgtaataaat": 110, "tgtacacta": 3, "th": [46, 49, 64, 65, 73, 80, 273], "than": [0, 1, 19, 22, 23, 43, 44, 53, 60, 62, 79, 84, 85, 111, 116, 118, 121, 138, 142, 151, 176, 184, 189, 194, 213, 215, 221, 226, 228, 230, 231, 233, 234, 235, 236, 237, 239, 240, 241, 242, 247, 255, 256, 259, 261, 264, 276, 294, 296, 298, 299, 300, 304, 318, 325, 326, 333, 339, 340, 341, 364, 369, 388, 406, 407, 409, 412, 417, 429, 439, 441, 444, 462, 472, 473, 490, 506, 511], "thank": [184, 209, 221], "thei": [0, 1, 20, 23, 28, 44, 82, 86, 106, 110, 111, 112, 113, 114, 115, 116, 118, 120, 121, 122, 123, 149, 158, 184, 191, 210, 221, 228, 235, 256, 277, 280, 296, 297, 298, 299, 300, 301, 305, 320, 321, 325, 331, 336, 349, 358, 392, 405, 416, 423, 435, 439, 442, 453, 454, 456, 457, 458, 469, 488, 513], "them": [1, 18, 55, 113, 118, 120, 149, 151, 153, 154, 207, 228, 298, 310, 330, 331, 333, 407, 416, 422, 433, 441, 480, 482, 483, 485, 501, 506], "themselv": [462, 507, 508], "theorem": [61, 62], "theoret": [71, 77], "theori": [23, 46, 63, 72, 74, 269, 275], "therebi": 319, "therefor": [1, 21, 24, 29, 49, 51, 53, 60, 70, 75, 84, 85, 90, 120, 176, 247, 259, 331, 402, 413, 415, 416, 439, 448, 452, 462], "thermoplasmata": [430, 467], "theta": [70, 259], "thi": [0, 1, 2, 3, 10, 11, 14, 19, 20, 21, 22, 23, 24, 28, 29, 30, 31, 32, 33, 34, 35, 36, 37, 38, 39, 40, 41, 42, 43, 49, 53, 54, 55, 60, 61, 62, 67, 69, 70, 82, 83, 84, 85, 86, 87, 89, 90, 93, 94, 96, 104, 105, 106, 107, 108, 109, 110, 111, 112, 113, 114, 115, 116, 117, 118, 119, 120, 121, 122, 123, 124, 125, 126, 127, 130, 138, 140, 142, 144, 145, 146, 149, 150, 151, 152, 153, 154, 155, 156, 157, 159, 160, 162, 164, 169, 170, 171, 174, 176, 177, 178, 181, 182, 183, 184, 186, 189, 190, 191, 192, 193, 194, 195, 208, 209, 211, 212, 213, 214, 215, 218, 220, 221, 223, 226, 227, 228, 229, 230, 231, 233, 234, 235, 236, 237, 239, 240, 241, 242, 243, 244, 245, 246, 247, 253, 254, 255, 256, 257, 258, 259, 262, 263, 264, 265, 266, 267, 268, 270, 271, 272, 274, 276, 277, 284, 285, 287, 290, 291, 294, 295, 296, 297, 298, 300, 302, 303, 304, 305, 318, 319, 321, 322, 324, 326, 331, 332, 333, 336, 338, 339, 340, 345, 348, 349, 356, 358, 364, 373, 379, 382, 383, 388, 392, 393, 397, 398, 400, 402, 403, 404, 405, 406, 407, 408, 409, 410, 411, 412, 413, 414, 415, 416, 417, 419, 421, 422, 423, 424, 425, 426, 427, 429, 431, 433, 434, 435, 436, 439, 441, 450, 451, 452, 453, 454, 456, 457, 458, 459, 460, 462, 463, 464, 466, 467, 468, 469, 470, 472, 473, 474, 475, 476, 477, 478, 479, 480, 481, 482, 483, 485, 487, 488, 489, 490, 493, 495, 496, 497, 498, 499, 500, 501, 502, 504, 506, 507, 508, 509, 510, 511, 512, 513], "thing": [20, 513], "third": [270, 276, 434, 513], "those": [1, 83, 120, 176, 182, 304, 318, 325, 340, 368, 450, 460, 477, 478, 480, 501, 508], "though": [20, 55, 111, 112, 118, 119, 120, 259, 292, 296, 300, 370, 482, 485, 513], "thought": 300, "thr": 215, "thraustochytrium": 192, "three": [1, 3, 20, 69, 118, 122, 270, 276, 291, 301, 319, 321, 339, 340, 348, 349, 395, 413, 436, 456, 468, 472, 513], "threonin": 215, "threshold": [44, 331, 488], "through": [1, 20, 35, 36, 37, 109, 120, 130, 140, 277, 409, 424, 513], "throughout": [1, 115, 191, 192, 339, 512], "throughput": [53, 84, 85, 111, 112, 264, 321, 339], "thrown": 126, "thu": [1, 111, 112, 116, 120, 164, 178, 228, 233, 277, 291, 296, 298, 300, 304], "thymin": [110, 113, 184, 187, 224], "ti": [22, 45, 382, 479], "tid": 114, "tie": [407, 433, 441], "tile": 119, "tile_numb": 119, "till": 122, "time": [1, 19, 21, 24, 53, 67, 77, 84, 85, 87, 111, 112, 120, 247, 265, 266, 273, 292, 296, 297, 298, 299, 301, 305, 309, 317, 333, 336, 339, 340, 342, 348, 379, 388, 400, 409, 460, 493, 506, 513], "timestamp": 392, "tip": [1, 53, 70, 84, 85, 400, 401, 403, 405, 407, 408, 409, 412, 416, 418, 419, 422, 424, 425, 433, 438, 439, 440, 441, 443, 444, 447, 448, 449, 457, 459, 460, 462, 463, 467, 468, 469, 470, 472, 479, 480, 482, 506, 511], "tip_": 461, "tip_a": [422, 455], "tip_count": 444, "tip_d": 422, "tip_list": 464, "tip_nam": 409, "tip_subset": 468, "tip_tip_dist": 416, "tipnam": 439, "tissue_typ": 110, "titl": [1, 106, 107, 113, 121, 283, 321, 493], "tjflkafnkkghvm": 119, "tmgc": 192, "tn": 121, "tno": 122, "to_": 278, "to_data_fram": 295, "to_datafram": [170, 176], "to_dict": 25, "to_hdf5": 358, "to_seri": 169, "toarrai": 274, "tobacco": 340, "togeth": [29, 110, 111, 113, 121, 259, 348, 373, 501], "token": 96, "tol": 335, "toler": [335, 488], "tolosana": [256, 273], "ton": 1, "tongu": 1, "too": [62, 331, 345], "tool": [35, 38, 106, 107, 111, 118, 120, 122, 321, 326], "toolkit": 405, "top": [259, 429], "topolog": [404, 407, 408, 413, 463], "topologi": [407, 408, 413, 472, 473, 475, 478, 480, 481, 511], "total": [45, 46, 49, 52, 53, 54, 56, 58, 63, 64, 65, 66, 67, 73, 80, 104, 106, 120, 151, 233, 277, 297, 348, 468], "total_length": 409, "toward": [401, 484], "tparent": 114, "traceback": [106, 118, 193, 228, 298], "tracheophyta": 110, "track": [109, 110], "tracker": [111, 126], "tract": 340, "trail": [111, 112, 115], "trajectori": [305, 306, 307, 308, 309, 310, 311, 312, 313, 314, 315, 316, 317], "trajectory_categori": [305, 306, 309, 310, 316], "trajectory_result": 305, "tranform": 395, "tranpos": 390, "transcrib": [110, 113, 188, 189, 224, 508], "transcript": 149, "transect": 319, "transfer": [435, 472, 473], "transform": [125, 127, 235, 257, 258, 262, 263, 265, 266, 269, 274, 325, 331, 333, 342, 360, 382], "translat": [110, 113, 116, 122, 145, 187, 189, 191, 194, 215, 224, 226, 508], "translate_six_fram": [187, 188, 193, 224, 225], "transloc": 339, "transpar": [120, 145, 506], "transpos": [277, 390], "trapezoid": 55, "trascrib": 110, "traver": 511, "travers": [400, 404, 408, 409, 417, 424, 427, 440, 443, 447, 448, 449, 465, 511], "traves": 409, "tre361": 110, "treat": [20, 21, 22, 23, 24, 111, 115, 120, 176, 184, 207, 215, 221, 228, 238, 254, 339, 412], "treatment": [162, 259, 264, 305, 339, 346], "treatment_stat": 339, "tree": [1, 53, 70, 84, 85, 116, 121, 122, 151, 274, 347, 363, 505, 506], "tree1": [411, 412, 413, 414, 415, 511], "tree2": [407, 408, 411, 412, 413, 414, 415, 511], "tree3": 511, "tree_copi": 417, "tree_copy_nod": 417, "tree_nod": 417, "tree_node_class": 479, "treeerror": [457, 458], "treenod": [1, 53, 70, 84, 85, 116, 274, 347, 477, 478, 479, 480, 481, 482, 483, 484, 485, 506, 511], "trg": [199, 208], "tri": 370, "triangl": [291, 293, 295, 298, 331, 370, 413, 482, 485], "triangular": 298, "trifoliea": 110, "trifolium": 110, "trifuc": 472, "trifurc": [53, 84, 85, 116], "trim": 193, "tripleton": 1, "trivial": 413, "trp": 215, "trubbbbrbcefgh": 119, "true": [1, 11, 12, 13, 19, 20, 21, 22, 24, 25, 27, 28, 32, 33, 35, 36, 37, 43, 47, 48, 49, 51, 53, 54, 58, 59, 67, 70, 74, 75, 76, 79, 82, 84, 85, 86, 87, 90, 96, 97, 100, 101, 102, 103, 106, 109, 110, 111, 112, 113, 114, 116, 119, 124, 125, 126, 127, 136, 141, 145, 146, 149, 151, 153, 158, 165, 168, 171, 172, 174, 175, 177, 184, 187, 188, 189, 191, 193, 194, 195, 196, 197, 198, 199, 201, 202, 203, 204, 205, 206, 207, 208, 210, 211, 212, 213, 214, 215, 217, 219, 221, 224, 225, 226, 228, 229, 233, 236, 237, 238, 239, 240, 241, 242, 244, 245, 247, 255, 259, 264, 265, 266, 269, 276, 277, 278, 280, 286, 291, 293, 294, 296, 298, 300, 301, 304, 310, 312, 323, 330, 331, 333, 334, 338, 339, 341, 342, 348, 351, 355, 356, 358, 359, 367, 368, 369, 370, 374, 378, 379, 380, 381, 382, 385, 386, 388, 390, 391, 392, 395, 397, 401, 402, 403, 405, 406, 407, 408, 409, 410, 411, 412, 413, 414, 415, 416, 417, 418, 420, 421, 422, 423, 426, 431, 432, 433, 435, 437, 438, 440, 441, 445, 446, 447, 448, 449, 450, 452, 453, 454, 455, 456, 457, 458, 459, 462, 463, 465, 467, 468, 469, 470, 471, 472, 473, 475, 477, 478, 479, 480, 481, 482, 483, 484, 485, 487, 493, 501, 502, 504, 508, 511, 513], "truncat": [112, 277, 320, 513], "trust": 112, "truth": 228, "truthi": 228, "try": [340, 341], "tryptophan": [23, 215], "tsalli": 72, "tsuperkingdom": 122, "tsv": [115, 120, 176, 181, 360, 394], "tsv_fh": 360, "tt": [22, 235], "tta": 237, "ttacatatta": 110, "ttacgcttaaac": 111, "ttactattac": 110, "ttactgttcg": 110, "ttagctcatt": 110, "ttattaaaag": 110, "ttattgtagc": 110, "ttattttttt": 110, "ttcaatttgg": 110, "ttcatt": [210, 213, 214], "ttcatttgat": 110, "ttccagtaga": 110, "ttctactctt": 110, "ttctgcaatc": 110, "ttest_ind": [259, 264], "ttest_rel": 259, "ttgaatactt": 110, "ttgagaatac": 110, "ttgg": 348, "ttggccaaga": 110, "ttgtaactct": 110, "ttgttgtacc": 110, "ttjflkafnkkghvm": 119, "tttattggta": 110, "tttcctcgtg": 110, "tttgaattaa": 110, "tttgcaggct": 110, "ttttcattgg": 110, "ttttggactg": 110, "ttttggatta": 110, "tttttaggcc": 110, "tttttttaaaaaaa": 513, "tupl": [20, 35, 36, 37, 38, 39, 40, 41, 48, 52, 61, 67, 69, 90, 114, 126, 149, 152, 156, 182, 188, 189, 225, 226, 247, 277, 302, 342, 343, 348, 358, 359, 375, 388, 392, 409, 430, 441, 466, 467, 498], "ture": 56, "turkei": [111, 118], "turn": [3, 184, 215, 221, 333, 488, 513], "turnip": 121, "tutori": [120, 123, 176, 181], "twice": [20, 340, 448, 469], "two": [0, 1, 3, 35, 36, 37, 38, 39, 40, 41, 44, 49, 70, 75, 84, 85, 106, 107, 111, 112, 113, 114, 116, 118, 119, 122, 149, 151, 153, 158, 184, 215, 221, 228, 229, 231, 235, 239, 241, 247, 254, 255, 256, 259, 261, 264, 270, 273, 274, 276, 277, 278, 281, 285, 293, 296, 297, 298, 299, 300, 301, 302, 304, 326, 331, 336, 339, 340, 345, 348, 358, 373, 392, 400, 406, 407, 408, 409, 411, 412, 413, 414, 415, 416, 422, 431, 436, 441, 456, 457, 472, 479, 480, 481, 482, 483, 485, 489, 493, 506, 508, 511], "txt": [110, 120, 122], "tygert": 331, "tyne": 110, "type": [1, 19, 20, 21, 22, 24, 61, 71, 77, 86, 90, 100, 101, 102, 103, 104, 108, 109, 111, 112, 113, 114, 115, 118, 121, 122, 125, 127, 131, 133, 134, 135, 136, 141, 145, 148, 162, 173, 176, 177, 181, 185, 191, 197, 199, 200, 210, 213, 214, 216, 222, 228, 229, 230, 231, 234, 239, 240, 241, 242, 244, 254, 255, 276, 277, 279, 288, 297, 300, 302, 319, 325, 326, 333, 336, 338, 342, 343, 349, 358, 359, 373, 392, 399, 409, 423, 431, 466, 479, 488, 491, 492], "typeerror": [20, 21, 24, 29, 82, 136, 138, 141, 142, 213, 228, 229, 230, 231, 233, 234, 239, 240, 241, 242, 254, 255, 297, 298, 300, 339, 340, 375, 409], "typic": [35, 36, 37, 38, 39, 40, 42, 95, 97, 99, 111, 112, 119, 120, 121, 149, 151, 331, 431, 456, 507], "tyr": 215, "tyrosin": 215, "u": [1, 37, 40, 53, 61, 64, 84, 85, 110, 111, 113, 122, 187, 215, 221, 224, 228, 259, 262, 263, 274, 298, 335, 340, 347, 508, 513], "u1": [1, 53, 84, 85], "u2": [1, 53, 84, 85], "u3": [1, 53, 84, 85], "u4": [1, 53, 84, 85], "u5": [1, 53, 84, 85], "u6": [1, 53, 84, 85], "u7": [1, 53, 84, 85], "u8": [53, 84, 85], "u_count": [53, 84, 85], "u_i": 259, "uaacguua": [187, 224], "uaaguucucgaucucuaaaaucg": 121, "uaaguucucgaucuuuaaaaucg": 121, "uagguugauc": 110, "uc": 508, "ucagucagucagucagucagucagucagucagucagucagucagucagucagucagucagucag": 191, "uccacaaaug": 110, "uconn": [44, 48], "ugaguucucgaucucuaaaaucg": 121, "ugaguucucuaucucuaaaaucg": 121, "uint8": [3, 8, 14, 111, 112, 119, 184, 213, 215, 221, 228, 230, 231, 234, 239, 240, 241, 242, 245], "uk": [35, 38, 57, 110, 113, 149, 256], "ulcl": 61, "ulcu": 61, "ultrametr": 416, "umich": 11, "un": 116, "unabl": 124, "unalign": [35, 36, 37, 38, 39, 40, 41, 508], "unbias": 484, "unbound": [151, 155], "uncach": [402, 406, 423, 431, 435, 446, 450, 452, 453, 454, 459, 470, 471, 472, 475], "uncertainti": [23, 264, 304], "unclear": 60, "unconstrain": 326, "uncorrect": [47, 48], "uncov": [61, 62, 509], "undefin": [120, 338, 339], "under": [55, 86, 111, 184, 215, 221, 228, 259, 310, 339, 348, 406, 408, 409, 412, 415, 427, 482, 485, 505], "underli": [0, 3, 96, 98, 99, 145, 193, 228, 254, 319, 336, 342, 400, 463, 508], "underlii": 3, "underpow": 336, "underscor": [116, 118], "understand": [120, 259], "understood": [30, 34, 93, 94, 116, 136, 138, 139, 141, 142, 143, 157, 159, 186, 190, 218, 220, 223, 227, 243, 246, 284, 290, 322, 324, 383, 398, 451, 476], "unequ": [44, 191, 247, 415], "unescap": 116, "uneven": [43, 80], "unfortun": [20, 112, 339], "ungap": 235, "ungapped_subsequ": 235, "unicod": [104, 120, 145], "unifi": [58, 264], "uniform": [1, 302], "uniformli": [7, 18], "unifrac": [1, 53, 70, 84, 85, 87, 90], "unimod": [326, 331], "union": [349, 373], "uniprotkb": 110, "uniq": 245, "uniqu": [1, 29, 33, 106, 111, 115, 116, 120, 121, 122, 177, 182, 245, 255, 276, 300, 321, 348, 375, 404, 412, 413, 415, 419, 424, 439, 481, 482, 483, 485], "unit": [1, 3, 84, 113, 123, 247, 331, 333, 334, 412, 413, 415, 430, 488, 489, 512], "unitcorr": [412, 415], "univers": [72, 110, 111, 118, 120, 124, 484], "unix": 122, "unknown": [23, 61, 62, 113, 149, 185, 200, 216, 222, 318, 382], "unknownaxiserror": [343, 345, 351, 352, 356, 363, 365, 366, 369, 370, 371, 372, 374, 375, 376, 384, 385, 395, 397], "unknowniderror": [366, 374], "unless": [19, 20, 28, 47, 119, 409, 465, 473, 501], "unlik": [121, 318, 477, 478, 480, 498], "unmask": 19, "unnam": 506, "unnecessari": 29, "unobserv": [43, 73], "unord": [400, 407, 408, 462, 463], "unpack": [8, 17, 471], "unpack_by_func": 470, "unpair": 116, "unpermut": [296, 298, 299], "unread": 145, "unrecogn": [343, 345, 351, 356, 363, 365, 366, 371, 372, 374, 376, 395, 397], "unrecognizedformaterror": [136, 138, 139, 141, 142, 143], "unresolv": 90, "unroot": [53, 70, 84, 85, 116, 400, 407, 408, 411, 413, 415, 428, 456, 463, 473, 474, 475, 480, 483, 485], "unrooted_copi": [417, 456, 457, 474, 475], "unrooted_mov": [456, 473], "unset": 20, "unshar": [29, 413], "unsign": [318, 444], "unsolv": 259, "unstabl": 90, "unsupport": [120, 215], "until": [151, 273, 419], "untouch": [356, 379], "untreat": 339, "unweight": [1, 70, 84, 85, 334, 484], "unweighted_unifrac": [1, 85], "unwrit": 145, "unzip": 381, "up": [20, 23, 42, 108, 118, 120, 121, 145, 151, 153, 225, 226, 261, 268, 270, 271, 272, 277, 298, 318, 340, 348, 400, 409, 450, 457, 504, 511], "upd": 70, "upd_": 70, "updat": [110, 111, 122, 151, 155, 171, 174, 228, 397], "updated_t": 397, "upgma": [416, 480], "upon": 110, "upper": [19, 60, 61, 111, 118, 149, 151, 153, 155, 293, 295, 298, 370], "upper_bound": [48, 52, 61, 151, 153], "upper_quantil": 60, "uppercas": [184, 215, 221, 228], "upsk": 121, "uq": 60, "uracil": [110, 113, 187, 221, 224], "urinari": 340, "url": [30, 93, 136, 138, 139, 141, 142, 143, 145, 157, 186, 218, 223, 243, 284, 322, 358, 383, 392, 451], "urn": [61, 62], "us": [1, 6, 11, 16, 19, 20, 21, 22, 23, 24, 25, 28, 29, 31, 35, 36, 37, 47, 48, 49, 53, 54, 60, 67, 69, 70, 71, 72, 74, 82, 84, 85, 86, 87, 90, 96, 101, 104, 105, 106, 108, 109, 111, 112, 113, 114, 115, 116, 118, 119, 120, 122, 123, 124, 125, 126, 127, 134, 135, 138, 142, 145, 151, 153, 162, 169, 170, 171, 172, 174, 175, 176, 180, 181, 183, 184, 188, 189, 191, 192, 193, 194, 195, 215, 221, 225, 226, 228, 229, 231, 235, 238, 244, 245, 247, 253, 254, 256, 257, 258, 259, 264, 265, 266, 268, 274, 276, 277, 281, 291, 293, 295, 296, 297, 298, 299, 300, 301, 302, 304, 305, 306, 309, 310, 312, 316, 317, 319, 321, 325, 331, 335, 336, 337, 338, 339, 340, 348, 353, 354, 356, 379, 382, 384, 386, 387, 390, 392, 393, 403, 405, 406, 408, 409, 412, 413, 415, 416, 417, 420, 421, 422, 429, 431, 433, 450, 452, 456, 459, 460, 462, 463, 466, 474, 477, 478, 479, 480, 481, 482, 483, 484, 485, 488, 489, 490, 496, 497, 501, 504, 508, 511, 512, 513], "usag": [299, 496], "use_length": [412, 416, 421, 422, 433, 441, 482], "usefulli": 479, "user": [1, 23, 61, 62, 83, 106, 120, 122, 123, 124, 125, 126, 127, 136, 139, 141, 143, 207, 259, 264, 294, 296, 298, 299, 300, 301, 304, 318, 326, 331, 338, 339, 340, 341, 439, 473, 496, 508], "usrman": 110, "usual": [1, 43, 79, 110, 113, 120, 122, 247, 331, 405, 416, 442, 456, 457, 458, 473], "ut": 508, "uti": 340, "util": [1, 30, 34, 93, 94, 122, 125, 127, 157, 159, 186, 190, 191, 192, 195, 218, 220, 223, 227, 243, 246, 284, 290, 322, 324, 358, 373, 381, 383, 386, 392, 398, 419, 451, 476, 478, 505, 506], "uu": 84, "uuagcucauu": 110, "uuauuguagc": 110, "uuauuuuuuu": 110, "uucuacucuu": 110, "uugagaauac": 110, "uuugaauuaa": 110, "uuuuccccaaaagggguuuuccccaaaagggguuuuccccaaaagggguuuuccccaaaagggg": 191, "uuuuuuuuuuuuuuuuccccccccccccccccaaaaaaaaaaaaaaaagggggggggggggggg": 191, "v": [19, 84, 85, 162, 176, 184, 215, 221, 228, 256, 269, 273, 275, 338, 339, 466], "v2": 105, "v_count": [84, 85], "vagin": 340, "vaginali": 340, "val": [215, 356], "val_i": 370, "val_j": 370, "valdar": 23, "valid": [35, 38, 53, 70, 82, 84, 85, 86, 87, 90, 100, 101, 102, 103, 109, 111, 112, 116, 118, 176, 181, 184, 195, 215, 221, 245, 269, 275, 277, 291, 293, 342, 358, 382, 392, 508, 513], "valin": 215, "valu": [1, 3, 5, 6, 9, 10, 20, 23, 35, 36, 37, 38, 39, 40, 42, 44, 55, 57, 67, 71, 74, 80, 82, 85, 103, 104, 106, 107, 109, 110, 111, 112, 113, 114, 115, 120, 121, 145, 149, 150, 152, 156, 160, 162, 163, 165, 166, 167, 168, 169, 170, 171, 172, 174, 176, 177, 181, 182, 183, 184, 210, 214, 215, 221, 228, 229, 238, 244, 247, 256, 259, 261, 264, 268, 269, 270, 271, 272, 275, 278, 289, 296, 297, 298, 299, 300, 301, 302, 304, 308, 310, 313, 315, 318, 321, 325, 326, 330, 331, 333, 335, 336, 337, 338, 339, 340, 342, 343, 348, 356, 357, 358, 362, 368, 369, 372, 376, 378, 379, 382, 386, 388, 389, 395, 397, 400, 405, 407, 408, 412, 416, 417, 456, 457, 462, 463, 466, 472, 475, 477, 478, 481, 484, 488, 489, 492, 501, 503, 504, 513], "valueerror": [20, 21, 23, 24, 27, 29, 31, 33, 44, 53, 55, 70, 82, 84, 85, 86, 90, 102, 136, 141, 164, 178, 182, 185, 193, 195, 200, 216, 222, 228, 229, 230, 233, 234, 236, 237, 239, 240, 241, 242, 245, 248, 249, 254, 255, 261, 268, 274, 281, 286, 293, 297, 298, 300, 301, 310, 317, 318, 321, 323, 325, 326, 333, 339, 340, 341, 357, 358, 382, 388, 412, 416, 429, 435, 444, 459, 460, 470, 490], "van": 273, "vanveeeeaw": 109, "var": [297, 390], "vari": [1, 300, 336, 338, 339, 480], "variabl": [55, 103, 104, 228, 244, 259, 297, 300, 319, 320, 321, 326, 331, 332, 333, 336, 338, 339, 501, 504, 513], "varianc": [48, 177, 269, 275, 297, 299, 300, 319, 327, 330, 331, 334, 339], "variant": [1, 53, 70, 119, 122, 247, 415, 482, 484, 485], "variat": [44, 298, 326], "varieti": 115, "variou": [1, 3, 43, 117, 176, 276, 320, 336, 400, 409, 496, 509, 512], "vazquez": 321, "ve": [1, 111, 112, 340, 511], "vec": 337, "vector": [3, 20, 27, 44, 45, 46, 47, 48, 49, 50, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 71, 72, 73, 74, 75, 76, 77, 78, 79, 80, 81, 82, 84, 85, 95, 96, 97, 98, 99, 100, 101, 102, 103, 109, 115, 185, 191, 196, 198, 200, 201, 206, 216, 219, 222, 235, 238, 240, 242, 244, 245, 256, 257, 258, 259, 264, 265, 266, 270, 271, 272, 275, 276, 277, 291, 296, 299, 300, 312, 326, 331, 340, 341, 342, 348, 381, 385, 388, 395, 412, 415, 466, 482, 485], "vegan": [296, 297, 298, 299, 300, 325, 326, 333], "vellend": 70, "ver": [107, 487, 493, 498], "verdonschot": 326, "veri": [1, 35, 36, 37, 60, 111, 116, 123, 270, 358, 412, 482, 506], "verifi": [110, 123, 136, 141], "versa": [116, 304, 379], "versatil": [319, 400], "version": [1, 41, 42, 47, 48, 53, 61, 62, 70, 74, 79, 82, 84, 85, 86, 90, 104, 106, 108, 109, 110, 113, 114, 118, 126, 199, 207, 208, 259, 268, 273, 294, 296, 298, 299, 300, 301, 302, 304, 318, 331, 338, 339, 340, 342, 353, 356, 358, 379, 388, 392, 394, 399, 402, 403, 406, 407, 408, 409, 410, 411, 412, 413, 414, 415, 416, 417, 420, 421, 422, 423, 431, 433, 435, 436, 439, 441, 445, 446, 450, 452, 453, 454, 456, 457, 458, 459, 460, 462, 463, 464, 468, 470, 471, 472, 473, 474, 475, 480, 481, 482, 483, 485, 487, 490, 493, 496, 508], "versu": [71, 77, 84, 85], "vertic": 400, "veschi": 55, "vi": [415, 485], "via": [21, 24, 31, 44, 61, 62, 111, 118, 191, 231, 256, 296, 298, 299, 348, 388, 404], "vice": [116, 304, 379], "viceroi": [44, 48], "view": [110, 381], "viewer": 405, "violat": [264, 408, 436, 480], "viral": 121, "virgilio": 55, "viridiplanta": 110, "virol": 121, "viru": 121, "visit": [440, 443, 447, 448, 449, 465, 469, 473], "visual": [1, 319, 321, 400], "vlen": [358, 392], "vocabulari": [113, 114, 162, 169, 170, 176, 183], "vol": 72, "volatil": 305, "volum": [72, 480], "vqhklrah": 121, "vrt": 122, "w": [19, 23, 44, 45, 52, 67, 70, 80, 106, 107, 108, 145, 184, 215, 221, 259, 273, 392, 394], "wa": [1, 11, 20, 35, 38, 44, 45, 46, 49, 52, 53, 55, 56, 57, 58, 59, 63, 64, 65, 70, 71, 72, 74, 75, 81, 82, 84, 85, 86, 87, 108, 111, 112, 116, 118, 145, 166, 169, 170, 183, 193, 228, 235, 259, 269, 273, 275, 298, 312, 330, 331, 338, 340, 412, 413, 452, 457, 464, 479, 480, 487, 496, 506, 511, 513], "wai": [0, 1, 111, 112, 116, 118, 121, 123, 149, 181, 207, 247, 259, 298, 336, 348, 358, 392, 506, 511], "wakefield": 479, "walk": [473, 474, 475, 511, 513], "walli": [259, 339, 340], "wan": [19, 41], "want": [35, 36, 37, 110, 111, 113, 151, 336, 338, 339, 340, 506], "warn": [112, 120, 300, 331, 487, 493, 498, 512], "warn_neg_eigv": [300, 331], "washington": [111, 116, 118, 479], "wasn": [20, 112], "water": 38, "waterman": [0, 19, 38, 39, 40, 41], "we": [0, 1, 19, 20, 21, 23, 24, 53, 60, 67, 70, 84, 85, 87, 105, 106, 107, 108, 109, 110, 111, 112, 113, 114, 115, 117, 118, 119, 120, 121, 123, 146, 149, 151, 193, 228, 233, 235, 244, 259, 264, 269, 275, 276, 296, 297, 298, 300, 301, 304, 305, 319, 321, 333, 335, 336, 338, 339, 340, 345, 358, 388, 479, 506, 511, 513], "weak": 184, "weaker": 304, "web": [19, 35, 38, 41, 108, 122, 296, 297, 298, 299, 300], "webfeat": 113, "webpag": 113, "websit": 23, "week": 340, "weight": [1, 53, 58, 70, 84, 85, 116, 305, 306, 309, 310, 312, 316, 330, 334, 412, 415, 479, 482, 484, 485], "weighted_unifrac": [1, 84], "welcom": 111, "well": [0, 20, 112, 120, 123, 176, 228, 264, 276, 277, 297, 299, 300, 304, 320, 326, 358, 400, 479, 506, 511, 512], "wellcom": 112, "were": [1, 20, 37, 40, 53, 60, 82, 84, 85, 86, 116, 118, 119, 228, 235, 296, 298, 300, 321, 331, 339, 340, 409, 410, 450, 513], "wf": [112, 513], "what": [1, 53, 70, 82, 84, 85, 86, 116, 120, 123, 124, 134, 135, 139, 143, 156, 235, 304, 318, 339, 345, 348, 358, 381, 392, 511, 513], "whatev": 123, "when": [1, 11, 19, 20, 21, 23, 24, 29, 32, 35, 36, 37, 44, 49, 54, 57, 59, 70, 71, 75, 77, 87, 90, 104, 106, 108, 111, 112, 113, 114, 115, 116, 118, 119, 120, 121, 123, 125, 126, 127, 136, 138, 139, 141, 142, 143, 145, 151, 153, 160, 171, 174, 176, 177, 181, 184, 185, 195, 200, 211, 212, 215, 216, 221, 222, 228, 229, 232, 238, 254, 259, 276, 296, 298, 299, 300, 302, 304, 308, 313, 315, 325, 331, 333, 337, 338, 339, 340, 341, 342, 348, 358, 388, 399, 409, 412, 413, 415, 421, 422, 431, 433, 441, 459, 463, 468, 480, 482, 487, 489, 490, 493, 497, 501, 506, 511, 513], "whenev": 112, "where": [1, 3, 5, 9, 11, 42, 44, 45, 46, 47, 49, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 63, 64, 65, 66, 67, 70, 71, 72, 73, 74, 75, 77, 80, 81, 86, 87, 90, 91, 102, 104, 109, 111, 115, 116, 117, 120, 121, 123, 180, 196, 198, 201, 206, 219, 232, 234, 235, 240, 242, 244, 247, 257, 258, 259, 261, 262, 263, 264, 265, 266, 268, 270, 271, 272, 273, 277, 298, 304, 318, 321, 330, 332, 333, 334, 336, 340, 341, 356, 358, 375, 387, 392, 397, 400, 412, 413, 415, 424, 425, 426, 453, 454, 456, 458, 467, 471, 472, 475, 477, 484, 495, 511, 513], "where_values_miss": 165, "wherea": [105, 286, 318, 323, 407, 413, 435, 468, 473, 475], "wherev": 334, "whether": [12, 20, 47, 48, 53, 70, 114, 123, 145, 161, 162, 169, 170, 172, 175, 176, 183, 191, 202, 203, 204, 205, 217, 228, 235, 236, 237, 247, 255, 259, 269, 275, 277, 296, 298, 299, 300, 320, 333, 334, 355, 356, 358, 367, 392, 395, 401, 402, 406, 407, 408, 409, 410, 411, 412, 413, 414, 415, 416, 417, 421, 422, 423, 432, 433, 435, 436, 437, 438, 441, 443, 445, 446, 450, 452, 453, 454, 456, 457, 458, 459, 462, 463, 465, 468, 469, 470, 471, 472, 473, 475, 477, 478, 481, 482, 483, 485], "which": [1, 3, 4, 6, 8, 11, 15, 20, 35, 36, 37, 44, 49, 53, 58, 70, 75, 79, 84, 85, 87, 106, 108, 109, 111, 113, 114, 115, 116, 117, 118, 120, 121, 122, 123, 124, 125, 126, 127, 128, 131, 133, 134, 135, 136, 141, 171, 176, 184, 193, 212, 215, 221, 228, 229, 230, 234, 235, 238, 245, 256, 257, 258, 259, 264, 277, 278, 296, 299, 300, 304, 323, 326, 330, 331, 336, 337, 338, 339, 340, 346, 347, 348, 349, 353, 356, 372, 375, 376, 378, 384, 385, 389, 392, 394, 400, 408, 409, 410, 412, 413, 415, 416, 420, 431, 453, 454, 455, 458, 460, 463, 466, 467, 472, 474, 479, 480, 482, 483, 484, 485, 491, 492, 496, 497, 501, 504, 506, 508, 511, 513], "while": [0, 1, 104, 110, 111, 112, 113, 118, 149, 191, 228, 259, 300, 310, 317, 319, 321, 338, 342, 399, 400, 412, 415, 419, 481, 501, 507, 508, 513], "white": 110, "whitespac": [111, 112, 115, 117, 121], "whitnei": 259, "who": [116, 340], "whole": [121, 329, 337, 352, 372, 376, 378, 385, 389], "whose": [113, 119, 120, 282, 297, 298, 334, 351, 366, 374, 386, 419], "why": 51, "wide": [1, 29, 70, 229, 436], "width": [111, 115, 118], "wiener": 74, "wiki": [11, 43, 111, 112, 118, 121, 480], "wikipedia": [43, 111, 112, 121, 480, 511], "wilcoxon": 259, "wild": 207, "wildcard": [184, 195, 207, 215, 221, 245], "wildcard_char": [184, 195, 215, 221, 245], "wilei": 256, "william": 54, "window": 317, "window_s": 317, "wish": [120, 511], "with_mean": [330, 334], "with_replac": 388, "with_std": [330, 334], "within": [1, 23, 43, 70, 80, 87, 104, 107, 111, 112, 116, 118, 120, 121, 176, 184, 215, 221, 228, 247, 256, 264, 278, 300, 301, 314, 319, 320, 321, 338, 339, 348, 377, 400, 402, 408, 409, 410, 413, 419, 424, 425, 427, 431, 434, 458, 462, 463, 488, 492, 504, 511, 513], "within_captur": 208, "without": [20, 21, 24, 29, 31, 49, 67, 85, 107, 116, 118, 120, 121, 228, 256, 318, 321, 340, 341, 353, 370, 388, 394, 400, 415, 421, 422, 433, 467, 477, 478, 481, 500, 501, 506], "wllllpppphhqqrrrriiimttttnnkkssrrvvvvaaaaddeegggg": 191, "woman": 340, "women": 340, "won": [1, 82, 84, 85, 86, 112, 149, 326, 465, 506], "word": [0, 20, 110, 111, 113, 116, 121, 156, 237], "work": [1, 19, 20, 87, 111, 118, 120, 123, 176, 184, 209, 215, 221, 276, 298, 326, 340, 364, 373, 505, 506, 507, 508, 510, 511], "workflow": 505, "world": [20, 480], "worri": [116, 342, 399], "would": [3, 20, 23, 53, 55, 58, 60, 84, 85, 108, 111, 114, 116, 118, 120, 121, 123, 176, 229, 235, 270, 273, 278, 304, 338, 339, 409, 467, 479], "wpgma": 484, "wprintgc": [191, 192], "wr": [111, 304], "wrap": [11, 118, 121, 504], "wrapper": [19, 41, 61, 62, 488], "wrf": [415, 485], "wrf_dist": 415, "writabl": [145, 149], "write": [30, 93, 105, 108, 109, 110, 112, 114, 115, 116, 118, 121, 123, 125, 127, 135, 145, 157, 186, 218, 223, 243, 276, 284, 308, 313, 315, 322, 383, 392, 393, 394, 451, 490], "write_fil": 506, "writeabl": [3, 20, 228, 277, 506], "writer": [34, 94, 104, 105, 106, 107, 108, 109, 110, 112, 113, 115, 116, 117, 118, 119, 120, 121, 122, 123, 124, 133, 139, 143, 145, 159, 190, 220, 227, 246, 290, 324, 398, 476, 506], "written": [108, 111, 112, 116, 118, 176, 353, 393, 394, 479, 506, 511], "wu": [70, 85], "wu_dm": 1, "wu_pc": 1, "wunsch": [0, 35, 36, 37], "www": [19, 35, 38, 41, 60, 87, 104, 106, 107, 108, 110, 111, 112, 113, 118, 122, 191, 192, 297], "x": [18, 19, 55, 105, 112, 119, 195, 215, 245, 256, 257, 258, 260, 261, 262, 263, 265, 266, 267, 268, 270, 271, 272, 273, 275, 286, 298, 301, 304, 319, 320, 321, 325, 326, 327, 333, 336, 339, 340, 348, 356, 360, 369, 374, 379, 384, 386, 390, 392, 394, 395, 399, 407, 426, 435, 445, 453, 454, 466, 471, 482, 483, 485, 500, 513], "x00": 146, "x01": 146, "x03": 146, "x0c": 146, "x108": 146, "x1c": 146, "x2": 407, "x56734": 110, "x86": 146, "x89": 146, "x8b": 146, "x9ah3m": 146, "x9c": 146, "x_": [256, 257, 273, 336, 340], "x_1": [257, 258, 262, 263, 270, 271, 272], "x_d": [257, 258, 262, 263, 270, 271, 272], "x_i": [258, 262, 267, 270, 271, 272, 273], "x_j": 267, "xa6": 146, "xaa": 215, "xb7": 146, "xb9": 146, "xc1": 146, "xc4": 146, "xle": 215, "xx": 110, "xxxxxx": 195, "xyz": 108, "y": [19, 44, 55, 112, 119, 184, 215, 221, 267, 270, 271, 275, 286, 298, 301, 304, 319, 321, 326, 327, 331, 332, 333, 338, 374, 384, 392, 394, 395, 407, 466, 482, 485], "y2": 407, "y_": [258, 340], "y_1": [258, 270, 271], "y_2": 258, "y_d": [270, 271], "y_i": 267, "y_j": 267, "yang": 44, "ye": [104, 105, 106, 107, 108, 109, 110, 111, 112, 113, 114, 115, 116, 117, 118, 119, 120, 121, 122], "yeast": [188, 225], "yeild": 300, "yellow": 121, "yet": [116, 122, 123], "yiel": 465, "yield": [20, 28, 111, 156, 185, 189, 194, 199, 200, 216, 222, 226, 228, 232, 235, 236, 300, 368, 369, 370, 377, 381, 426, 440, 443, 447, 448, 449, 460, 465, 467, 469, 501, 506, 513], "york": 46, "you": [1, 19, 35, 36, 37, 53, 82, 84, 85, 86, 87, 106, 108, 111, 112, 114, 118, 120, 121, 123, 150, 151, 153, 155, 156, 184, 215, 221, 228, 247, 293, 296, 300, 333, 338, 339, 340, 387, 431, 496, 506, 508, 511, 513], "your": [19, 29, 53, 82, 84, 85, 86, 112, 120, 123, 151, 300, 339, 506, 511, 513], "yy": 112, "z": [19, 29, 52, 120, 215, 301, 321, 368, 407, 466], "z3": [362, 368], "zero": [3, 4, 7, 8, 15, 16, 44, 54, 90, 104, 149, 152, 176, 182, 233, 259, 261, 264, 268, 269, 270, 271, 272, 275, 277, 296, 297, 298, 299, 300, 301, 304, 325, 331, 334, 339, 341, 342, 358, 385, 388, 392, 395, 480, 482, 485, 513], "zero_index": [19, 41], "zhao": [19, 41], "zip": 352, "zp_02903423": 106, "zscore": 48, "zxx": 112, "\u00e9": 273, "\u00f8": 70}, "titles": ["Sequence Alignments (skbio.alignment)", "Community Diversity (skbio.diversity)", "Biological Embeddings (skbio.embedding)", "skbio.alignment.AlignPath", "skbio.alignment.AlignPath.from_bits", "skbio.alignment.AlignPath.from_coordinates", "skbio.alignment.AlignPath.from_indices", "skbio.alignment.AlignPath.from_tabular", "skbio.alignment.AlignPath.to_bits", "skbio.alignment.AlignPath.to_coordinates", "skbio.alignment.AlignPath.to_indices", "skbio.alignment.AlignmentStructure", "skbio.alignment.AlignmentStructure.is_zero_based", "skbio.alignment.AlignmentStructure.set_zero_based", "skbio.alignment.PairAlignPath", "skbio.alignment.PairAlignPath.from_bits", "skbio.alignment.PairAlignPath.from_cigar", "skbio.alignment.PairAlignPath.to_bits", "skbio.alignment.PairAlignPath.to_cigar", "skbio.alignment.StripedSmithWaterman", "skbio.alignment.TabularMSA", "skbio.alignment.TabularMSA.append", "skbio.alignment.TabularMSA.consensus", "skbio.alignment.TabularMSA.conservation", "skbio.alignment.TabularMSA.extend", "skbio.alignment.TabularMSA.from_dict", "skbio.alignment.TabularMSA.from_path_seqs", "skbio.alignment.TabularMSA.gap_frequencies", "skbio.alignment.TabularMSA.iter_positions", "skbio.alignment.TabularMSA.join", "skbio.alignment.TabularMSA.read", "skbio.alignment.TabularMSA.reassign_index", "skbio.alignment.TabularMSA.sort", "skbio.alignment.TabularMSA.to_dict", "skbio.alignment.TabularMSA.write", "skbio.alignment.global_pairwise_align", "skbio.alignment.global_pairwise_align_nucleotide", "skbio.alignment.global_pairwise_align_protein", "skbio.alignment.local_pairwise_align", "skbio.alignment.local_pairwise_align_nucleotide", "skbio.alignment.local_pairwise_align_protein", "skbio.alignment.local_pairwise_align_ssw", "skbio.alignment.make_identity_substitution_matrix", "Alpha diversity measures (skbio.diversity.alpha)", "skbio.diversity.alpha.ace", "skbio.diversity.alpha.berger_parker_d", "skbio.diversity.alpha.brillouin_d", "skbio.diversity.alpha.chao1", "skbio.diversity.alpha.chao1_ci", "skbio.diversity.alpha.dominance", "skbio.diversity.alpha.doubles", "skbio.diversity.alpha.enspie", "skbio.diversity.alpha.esty_ci", "skbio.diversity.alpha.faith_pd", "skbio.diversity.alpha.fisher_alpha", "skbio.diversity.alpha.gini_index", "skbio.diversity.alpha.goods_coverage", "skbio.diversity.alpha.heip_e", "skbio.diversity.alpha.hill", "skbio.diversity.alpha.inv_simpson", "skbio.diversity.alpha.kempton_taylor_q", "skbio.diversity.alpha.lladser_ci", "skbio.diversity.alpha.lladser_pe", "skbio.diversity.alpha.margalef", "skbio.diversity.alpha.mcintosh_d", "skbio.diversity.alpha.mcintosh_e", "skbio.diversity.alpha.menhinick", "skbio.diversity.alpha.michaelis_menten_fit", "skbio.diversity.alpha.observed_features", "skbio.diversity.alpha.osd", "skbio.diversity.alpha.phydiv", "skbio.diversity.alpha.pielou_e", "skbio.diversity.alpha.renyi", "skbio.diversity.alpha.robbins", "skbio.diversity.alpha.shannon", "skbio.diversity.alpha.simpson", "skbio.diversity.alpha.simpson_d", "skbio.diversity.alpha.simpson_e", "skbio.diversity.alpha.singles", "skbio.diversity.alpha.sobs", "skbio.diversity.alpha.strong", "skbio.diversity.alpha.tsallis", "skbio.diversity.alpha_diversity", "Beta diversity measures (skbio.diversity.beta)", "skbio.diversity.beta.unweighted_unifrac", "skbio.diversity.beta.weighted_unifrac", "skbio.diversity.beta_diversity", "skbio.diversity.block_beta_diversity", "skbio.diversity.get_alpha_diversity_metrics", "skbio.diversity.get_beta_diversity_metrics", "skbio.diversity.partial_beta_diversity", "skbio.embedding.Embedding", "skbio.embedding.Embedding.bytes", "skbio.embedding.Embedding.read", "skbio.embedding.Embedding.write", "skbio.embedding.EmbeddingVector", "skbio.embedding.ProteinEmbedding", "skbio.embedding.ProteinVector", "skbio.embedding.SequenceEmbedding", "skbio.embedding.SequenceVector", "skbio.embedding.embed_vec_to_dataframe", "skbio.embedding.embed_vec_to_distances", "skbio.embedding.embed_vec_to_numpy", "skbio.embedding.embed_vec_to_ordination", "Simple binary dissimilarity matrix format (skbio.io.format.binary_dm)", "BIOM-Format (skbio.io.format.biom)", "BLAST+6 format (skbio.io.format.blast6)", "BLAST+7 format (skbio.io.format.blast7)", "Clustal format (skbio.io.format.clustal)", "Embedding format (skbio.io.format.embed).", "EMBL format (skbio.io.format.embl)", "FASTA/QUAL format (skbio.io.format.fasta)", "FASTQ format (skbio.io.format.fastq)", "GenBank format (skbio.io.format.genbank)", "GFF3 format (skbio.io.format.gff3)", "Labeled square matrix format (skbio.io.format.lsmat)", "Newick format (skbio.io.format.newick)", "Ordination results format (skbio.io.format.ordination)", "PHYLIP multiple sequence alignment format (skbio.io.format.phylip)", "QSeq format (skbio.io.format.qseq)", "Format Support", "Stockholm format (skbio.io.format.stockholm)", "Taxdump format (skbio.io.format.taxdump)", "I/O Registry (skbio.io.registry)", "skbio.io.registry.Format", "skbio.io.registry.Format.reader", "skbio.io.registry.Format.sniffer", "skbio.io.registry.Format.writer", "skbio.io.registry.IORegistry", "skbio.io.registry.IORegistry.add_format", "skbio.io.registry.IORegistry.create_format", "skbio.io.registry.IORegistry.get_reader", "skbio.io.registry.IORegistry.get_sniffer", "skbio.io.registry.IORegistry.get_writer", "skbio.io.registry.IORegistry.list_read_formats", "skbio.io.registry.IORegistry.list_write_formats", "skbio.io.registry.IORegistry.read", "skbio.io.registry.IORegistry.remove_format", "skbio.io.registry.IORegistry.sniff", "skbio.io.registry.IORegistry.write", "skbio.io.registry.create_format", "skbio.io.registry.read", "skbio.io.registry.sniff", "skbio.io.registry.write", "I/O utilities (skbio.io.util)", "skbio.io.util.open", "skbio.io.util.open_file", "skbio.io.util.open_files", "skbio.metadata.CategoricalMetadataColumn", "skbio.metadata.Interval", "skbio.metadata.Interval.drop", "skbio.metadata.IntervalMetadata", "skbio.metadata.IntervalMetadata.add", "skbio.metadata.IntervalMetadata.concat", "skbio.metadata.IntervalMetadata.drop", "skbio.metadata.IntervalMetadata.merge", "skbio.metadata.IntervalMetadata.query", "skbio.metadata.IntervalMetadata.read", "skbio.metadata.IntervalMetadata.sort", "skbio.metadata.IntervalMetadata.write", "skbio.metadata.IntervalMetadataMixin", "skbio.metadata.IntervalMetadataMixin.has_interval_metadata", "skbio.metadata.MetadataColumn", "skbio.metadata.MetadataColumn.drop_missing_values", "skbio.metadata.MetadataColumn.filter_ids", "skbio.metadata.MetadataColumn.get_ids", "skbio.metadata.MetadataColumn.get_missing", "skbio.metadata.MetadataColumn.get_value", "skbio.metadata.MetadataColumn.has_missing_values", "skbio.metadata.MetadataColumn.to_dataframe", "skbio.metadata.MetadataColumn.to_series", "skbio.metadata.MetadataMixin", "skbio.metadata.MetadataMixin.has_metadata", "skbio.metadata.NumericMetadataColumn", "skbio.metadata.PositionalMetadataMixin", "skbio.metadata.PositionalMetadataMixin.has_positional_metadata", "skbio.metadata.SampleMetadata", "skbio.metadata.SampleMetadata.filter_columns", "skbio.metadata.SampleMetadata.filter_ids", "skbio.metadata.SampleMetadata.get_column", "skbio.metadata.SampleMetadata.get_ids", "skbio.metadata.SampleMetadata.load", "skbio.metadata.SampleMetadata.merge", "skbio.metadata.SampleMetadata.to_dataframe", "skbio.sequence.DNA", "skbio.sequence.DNA.find_motifs", "skbio.sequence.DNA.read", "skbio.sequence.DNA.transcribe", "skbio.sequence.DNA.translate", "skbio.sequence.DNA.translate_six_frames", "skbio.sequence.DNA.write", "skbio.sequence.GeneticCode", "skbio.sequence.GeneticCode.from_ncbi", "skbio.sequence.GeneticCode.translate", "skbio.sequence.GeneticCode.translate_six_frames", "skbio.sequence.GrammaredSequence", "skbio.sequence.GrammaredSequence.definites", "skbio.sequence.GrammaredSequence.degap", "skbio.sequence.GrammaredSequence.degenerates", "skbio.sequence.GrammaredSequence.expand_degenerates", "skbio.sequence.GrammaredSequence.find_motifs", "skbio.sequence.GrammaredSequence.gaps", "skbio.sequence.GrammaredSequence.has_definites", "skbio.sequence.GrammaredSequence.has_degenerates", "skbio.sequence.GrammaredSequence.has_gaps", "skbio.sequence.GrammaredSequence.has_nondegenerates", "skbio.sequence.GrammaredSequence.nondegenerates", "skbio.sequence.GrammaredSequence.to_definites", "skbio.sequence.GrammaredSequence.to_regex", "skbio.sequence.NucleotideMixin", "skbio.sequence.NucleotideMixin.complement", "skbio.sequence.NucleotideMixin.gc_content", "skbio.sequence.NucleotideMixin.gc_frequency", "skbio.sequence.NucleotideMixin.is_reverse_complement", "skbio.sequence.NucleotideMixin.reverse_complement", "skbio.sequence.Protein", "skbio.sequence.Protein.find_motifs", "skbio.sequence.Protein.has_stops", "skbio.sequence.Protein.read", "skbio.sequence.Protein.stops", "skbio.sequence.Protein.write", "skbio.sequence.RNA", "skbio.sequence.RNA.find_motifs", "skbio.sequence.RNA.read", "skbio.sequence.RNA.reverse_transcribe", "skbio.sequence.RNA.translate", "skbio.sequence.RNA.translate_six_frames", "skbio.sequence.RNA.write", "skbio.sequence.Sequence", "skbio.sequence.Sequence.concat", "skbio.sequence.Sequence.count", "skbio.sequence.Sequence.distance", "skbio.sequence.Sequence.find_with_regex", "skbio.sequence.Sequence.frequencies", "skbio.sequence.Sequence.index", "skbio.sequence.Sequence.iter_contiguous", "skbio.sequence.Sequence.iter_kmers", "skbio.sequence.Sequence.kmer_frequencies", "skbio.sequence.Sequence.lowercase", "skbio.sequence.Sequence.match_frequency", "skbio.sequence.Sequence.matches", "skbio.sequence.Sequence.mismatch_frequency", "skbio.sequence.Sequence.mismatches", "skbio.sequence.Sequence.read", "skbio.sequence.Sequence.replace", "skbio.sequence.Sequence.to_indices", "skbio.sequence.Sequence.write", "skbio.sequence.SubstitutionMatrix", "skbio.sequence.SubstitutionMatrix.by_name", "skbio.sequence.SubstitutionMatrix.from_dict", "skbio.sequence.SubstitutionMatrix.get_names", "skbio.sequence.SubstitutionMatrix.identity", "skbio.sequence.SubstitutionMatrix.to_dict", "Sequence distance metrics (skbio.sequence.distance)", "skbio.sequence.distance.hamming", "skbio.sequence.distance.kmer_distance", "Composition Statistics (skbio.stats.composition)", "skbio.stats.composition.alr", "skbio.stats.composition.alr_inv", "skbio.stats.composition.ancom", "skbio.stats.composition.centralize", "skbio.stats.composition.closure", "skbio.stats.composition.clr", "skbio.stats.composition.clr_inv", "skbio.stats.composition.dirmult_ttest", "skbio.stats.composition.ilr", "skbio.stats.composition.ilr_inv", "skbio.stats.composition.inner", "skbio.stats.composition.multi_replace", "skbio.stats.composition.pairwise_vlr", "skbio.stats.composition.perturb", "skbio.stats.composition.perturb_inv", "skbio.stats.composition.power", "skbio.stats.composition.sbp_basis", "skbio.stats.composition.tree_basis", "skbio.stats.composition.vlr", "Distance matrix-based statistics (skbio.stats.distance)", "skbio.stats.distance.DissimilarityMatrix", "skbio.stats.distance.DissimilarityMatrix.between", "skbio.stats.distance.DissimilarityMatrix.copy", "skbio.stats.distance.DissimilarityMatrix.filter", "skbio.stats.distance.DissimilarityMatrix.from_iterable", "skbio.stats.distance.DissimilarityMatrix.index", "skbio.stats.distance.DissimilarityMatrix.plot", "skbio.stats.distance.DissimilarityMatrix.read", "skbio.stats.distance.DissimilarityMatrix.redundant_form", "skbio.stats.distance.DissimilarityMatrix.rename", "skbio.stats.distance.DissimilarityMatrix.to_data_frame", "skbio.stats.distance.DissimilarityMatrix.transpose", "skbio.stats.distance.DissimilarityMatrix.within", "skbio.stats.distance.DissimilarityMatrix.write", "skbio.stats.distance.DistanceMatrix", "skbio.stats.distance.DistanceMatrix.condensed_form", "skbio.stats.distance.DistanceMatrix.from_iterable", "skbio.stats.distance.DistanceMatrix.permute", "skbio.stats.distance.DistanceMatrix.to_series", "skbio.stats.distance.anosim", "skbio.stats.distance.bioenv", "skbio.stats.distance.mantel", "skbio.stats.distance.permanova", "skbio.stats.distance.permdisp", "skbio.stats.distance.pwmantel", "skbio.stats.distance.randdm", "Evolutionary statistics (skbio.stats.evolve)", "skbio.stats.evolve.hommola_cospeciation", "Gradient analyses (skbio.stats.gradient)", "skbio.stats.gradient.AverageGradientANOVA", "skbio.stats.gradient.CategoryResults", "skbio.stats.gradient.CategoryResults.to_files", "skbio.stats.gradient.FirstDifferenceGradientANOVA", "skbio.stats.gradient.GradientANOVA", "skbio.stats.gradient.GradientANOVA.get_trajectories", "skbio.stats.gradient.GradientANOVAResults", "skbio.stats.gradient.GradientANOVAResults.to_files", "skbio.stats.gradient.GroupResults", "skbio.stats.gradient.GroupResults.to_files", "skbio.stats.gradient.TrajectoryGradientANOVA", "skbio.stats.gradient.WindowDifferenceGradientANOVA", "skbio.stats.isubsample", "Ordination methods (skbio.stats.ordination)", "skbio.stats.ordination.OrdinationResults", "skbio.stats.ordination.OrdinationResults.plot", "skbio.stats.ordination.OrdinationResults.read", "skbio.stats.ordination.OrdinationResults.rename", "skbio.stats.ordination.OrdinationResults.write", "skbio.stats.ordination.ca", "skbio.stats.ordination.cca", "skbio.stats.ordination.corr", "skbio.stats.ordination.e_matrix", "skbio.stats.ordination.f_matrix", "skbio.stats.ordination.mean_and_std", "skbio.stats.ordination.pcoa", "skbio.stats.ordination.pcoa_biplot", "skbio.stats.ordination.rda", "skbio.stats.ordination.scale", "skbio.stats.ordination.svd_rank", "Empirical Power Estimation (skbio.stats.power)", "skbio.stats.power.confidence_bound", "skbio.stats.power.paired_subsamples", "skbio.stats.power.subsample_paired_power", "skbio.stats.power.subsample_power", "skbio.stats.subsample_counts", "skbio.table.Table", "skbio.table.Table.add_group_metadata", "skbio.table.Table.add_metadata", "skbio.table.Table.align_to", "skbio.table.Table.align_to_dataframe", "skbio.table.Table.align_tree", "skbio.table.Table.collapse", "skbio.table.Table.concat", "skbio.table.Table.copy", "skbio.table.Table.data", "skbio.table.Table.del_metadata", "skbio.table.Table.delimited_self", "skbio.table.Table.descriptive_equality", "skbio.table.Table.exists", "skbio.table.Table.filter", "skbio.table.Table.from_adjacency", "skbio.table.Table.from_hdf5", "skbio.table.Table.from_json", "skbio.table.Table.from_tsv", "skbio.table.Table.get_table_density", "skbio.table.Table.get_value_by_ids", "skbio.table.Table.group_metadata", "skbio.table.Table.head", "skbio.table.Table.ids", "skbio.table.Table.index", "skbio.table.Table.is_empty", "skbio.table.Table.iter", "skbio.table.Table.iter_data", "skbio.table.Table.iter_pairwise", "skbio.table.Table.length", "skbio.table.Table.max", "skbio.table.Table.merge", "skbio.table.Table.metadata", "skbio.table.Table.metadata_to_dataframe", "skbio.table.Table.min", "skbio.table.Table.nonzero", "skbio.table.Table.nonzero_counts", "skbio.table.Table.norm", "skbio.table.Table.pa", "skbio.table.Table.partition", "skbio.table.Table.rankdata", "skbio.table.Table.read", "skbio.table.Table.reduce", "skbio.table.Table.remove_empty", "skbio.table.Table.sort", "skbio.table.Table.sort_order", "skbio.table.Table.subsample", "skbio.table.Table.sum", "skbio.table.Table.to_anndata", "skbio.table.Table.to_dataframe", "skbio.table.Table.to_hdf5", "skbio.table.Table.to_json", "skbio.table.Table.to_tsv", "skbio.table.Table.transform", "skbio.table.Table.transpose", "skbio.table.Table.update_ids", "skbio.table.Table.write", "skbio.table.example_table", "skbio.tree.TreeNode", "skbio.tree.TreeNode.ancestors", "skbio.tree.TreeNode.append", "skbio.tree.TreeNode.ascii_art", "skbio.tree.TreeNode.assign_ids", "skbio.tree.TreeNode.assign_supports", "skbio.tree.TreeNode.bifurcate", "skbio.tree.TreeNode.bipart", "skbio.tree.TreeNode.biparts", "skbio.tree.TreeNode.cache_attr", "skbio.tree.TreeNode.clear_caches", "skbio.tree.TreeNode.compare_biparts", "skbio.tree.TreeNode.compare_cophenet", "skbio.tree.TreeNode.compare_rfd", "skbio.tree.TreeNode.compare_subsets", "skbio.tree.TreeNode.compare_wrfd", "skbio.tree.TreeNode.cophenet", "skbio.tree.TreeNode.copy", "skbio.tree.TreeNode.count", "skbio.tree.TreeNode.create_caches", "skbio.tree.TreeNode.deepcopy", "skbio.tree.TreeNode.depth", "skbio.tree.TreeNode.distance", "skbio.tree.TreeNode.extend", "skbio.tree.TreeNode.find", "skbio.tree.TreeNode.find_all", "skbio.tree.TreeNode.find_by_func", "skbio.tree.TreeNode.find_by_id", "skbio.tree.TreeNode.from_linkage_matrix", "skbio.tree.TreeNode.from_taxdump", "skbio.tree.TreeNode.from_taxonomy", "skbio.tree.TreeNode.has_caches", "skbio.tree.TreeNode.has_children", "skbio.tree.TreeNode.height", "skbio.tree.TreeNode.index_tree", "skbio.tree.TreeNode.insert", "skbio.tree.TreeNode.is_bifurcating", "skbio.tree.TreeNode.is_root", "skbio.tree.TreeNode.is_tip", "skbio.tree.TreeNode.lca", "skbio.tree.TreeNode.levelorder", "skbio.tree.TreeNode.maxdist", "skbio.tree.TreeNode.neighbors", "skbio.tree.TreeNode.non_tips", "skbio.tree.TreeNode.observed_node_counts", "skbio.tree.TreeNode.path", "skbio.tree.TreeNode.pop", "skbio.tree.TreeNode.postorder", "skbio.tree.TreeNode.pre_and_postorder", "skbio.tree.TreeNode.preorder", "skbio.tree.TreeNode.prune", "skbio.tree.TreeNode.read", "skbio.tree.TreeNode.remove", "skbio.tree.TreeNode.remove_by_func", "skbio.tree.TreeNode.remove_deleted", "skbio.tree.TreeNode.root", "skbio.tree.TreeNode.root_at", "skbio.tree.TreeNode.root_at_midpoint", "skbio.tree.TreeNode.root_by_outgroup", "skbio.tree.TreeNode.shear", "skbio.tree.TreeNode.shuffle", "skbio.tree.TreeNode.siblings", "skbio.tree.TreeNode.subset", "skbio.tree.TreeNode.subsets", "skbio.tree.TreeNode.subtree", "skbio.tree.TreeNode.tips", "skbio.tree.TreeNode.to_array", "skbio.tree.TreeNode.to_taxonomy", "skbio.tree.TreeNode.total_length", "skbio.tree.TreeNode.traverse", "skbio.tree.TreeNode.unpack", "skbio.tree.TreeNode.unpack_by_func", "skbio.tree.TreeNode.unroot", "skbio.tree.TreeNode.unrooted_copy", "skbio.tree.TreeNode.unrooted_deepcopy", "skbio.tree.TreeNode.unrooted_move", "skbio.tree.TreeNode.write", "skbio.tree.bme", "skbio.tree.gme", "skbio.tree.majority_rule", "skbio.tree.nj", "skbio.tree.nni", "skbio.tree.path_dists", "skbio.tree.rf_dists", "skbio.tree.upgma", "skbio.tree.wrf_dists", "skbio.util.PlottableMixin", "skbio.util.aliased", "skbio.util.assert_data_frame_almost_equal", "skbio.util.assert_ordination_results_equal", "skbio.util.cardinal_to_ordinal", "skbio.util.classonlymethod", "skbio.util.classproperty", "skbio.util.deprecated", "skbio.util.find_duplicates", "skbio.util.get_data_path", "skbio.util.get_rng", "skbio.util.overrides", "skbio.util.params_aliased", "skbio.util.register_aliases", "skbio.util.safe_md5", "skbio.workflow.Workflow", "skbio.workflow.Workflow.initialize_state", "skbio.workflow.method", "skbio.workflow.requires", "Home", "Input and Output (skbio.io)", "Metadata (skbio.metadata)", "Biological Sequences (skbio.sequence)", "Multivariate Statistics (skbio.stats)", "Data Table (skbio.table)", "Trees and Phylogenetics (skbio.tree)", "Utilities for Developers (skbio.util)", "Workflow construction (skbio.workflow)"], "titleterms": {"0": 505, "3": 505, "6": [106, 505], "7": 107, "abstract": [507, 508], "abund": 256, "ac": 44, "ad": 116, "add": 152, "add_format": 129, "add_group_metadata": 343, "add_metadata": 344, "advanc": 116, "algorithm": 0, "alias": 487, "align": [0, 3, 4, 5, 6, 7, 8, 9, 10, 11, 12, 13, 14, 15, 16, 17, 18, 19, 20, 21, 22, 23, 24, 25, 26, 27, 28, 29, 30, 31, 32, 33, 34, 35, 36, 37, 38, 39, 40, 41, 42, 108, 118, 121], "align_to": 345, "align_to_datafram": 346, "align_tre": 347, "alignmentstructur": [11, 12, 13], "alignpath": [3, 4, 5, 6, 7, 8, 9, 10], "alpha": [1, 43, 44, 45, 46, 47, 48, 49, 50, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 71, 72, 73, 74, 75, 76, 77, 78, 79, 80, 81], "alpha_divers": 82, "alr": 257, "alr_inv": 258, "analys": 305, "analysi": [256, 319], "ancestor": 401, "ancom": 259, "anosim": 296, "append": [21, 402], "applic": 116, "argument": 123, "arithmet": 256, "ascii_art": 403, "assert_data_frame_almost_equ": 488, "assert_ordination_results_equ": 489, "assign_id": 404, "assign_support": 405, "averagegradientanova": 306, "base": 276, "basi": 256, "basic": 116, "befor": [110, 113], "berger_parker_d": 45, "beta": [1, 83, 84, 85], "beta_divers": 86, "between": 278, "bifurc": 406, "binari": 104, "binary_dm": 104, "bio": [123, 505, 506], "bioenv": 297, "biolog": [2, 508], "biom": [105, 510], "bipart": [407, 408], "blast": [106, 107], "blast6": 106, "blast7": 107, "block_beta_divers": 87, "bme": 477, "brillouin_d": 46, "by_nam": 248, "byte": 92, "ca": 325, "cache_attr": 409, "calcul": 508, "can": 506, "canon": 319, "cardinal_to_ordin": 490, "categor": 276, "categoricalmetadatacolumn": 148, "categoryresult": [307, 308], "caveat": 116, "cca": 326, "central": 260, "chao1": 47, "chao1_ci": 48, "charact": 120, "class": [123, 276, 305, 507, 508, 513], "classonlymethod": 491, "classproperti": 492, "clear_cach": 410, "closur": 261, "clr": 262, "clr_inv": 263, "clustal": 108, "collaps": 348, "column": [106, 107, 120, 507], "comment": [116, 120], "commun": 1, "compare_bipart": 411, "compare_cophenet": 412, "compare_rfd": 413, "compare_subset": 414, "compare_wrfd": 415, "comparison": [276, 511], "complement": 210, "composit": [256, 257, 258, 259, 260, 261, 262, 263, 264, 265, 266, 267, 268, 269, 270, 271, 272, 273, 274, 275, 509], "concat": [153, 229, 349], "condensed_form": 292, "confidence_bound": 337, "consensu": 22, "conserv": 23, "construct": [256, 511, 513], "continu": 276, "cophenet": 416, "cophylogenet": 303, "copi": [279, 350, 417], "corr": 327, "correl": 256, "correspond": 319, "count": [1, 230, 418], "coverag": 43, "creat": 123, "create_cach": 419, "create_format": [130, 140], "custom": 506, "data": [0, 111, 276, 351, 509, 510], "decor": [512, 513], "deepcopi": 420, "definit": 196, "degap": 197, "degener": 198, "del_metadata": 352, "delimited_self": 353, "deprec": [0, 493], "depth": 421, "descriptive_equ": 354, "dev": 505, "develop": [506, 512], "differenti": 256, "dirmult_ttest": 264, "dissimilar": 104, "dissimilaritymatrix": [277, 278, 279, 280, 281, 282, 283, 284, 285, 286, 287, 288, 289, 290], "distanc": [231, 253, 254, 255, 276, 277, 278, 279, 280, 281, 282, 283, 284, 285, 286, 287, 288, 289, 290, 291, 292, 293, 294, 295, 296, 297, 298, 299, 300, 301, 302, 422, 508, 509], "distancematrix": [291, 292, 293, 294, 295], "divers": [1, 43, 44, 45, 46, 47, 48, 49, 50, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 71, 72, 73, 74, 75, 76, 77, 78, 79, 80, 81, 82, 83, 84, 85, 86, 87, 88, 89, 90], "divis": 122, "dmp": 122, "dna": [184, 185, 186, 187, 188, 189, 190], "document": 505, "domin": [43, 49], "doubl": 50, "drop": [150, 154], "drop_missing_valu": 163, "e_matrix": 328, "emb": 109, "embed": [2, 91, 92, 93, 94, 95, 96, 97, 98, 99, 100, 101, 102, 103, 109], "embed_vec_to_datafram": 100, "embed_vec_to_dist": 101, "embed_vec_to_numpi": 102, "embed_vec_to_ordin": 103, "embeddingvector": 95, "embl": 110, "empir": 336, "empti": 120, "enspi": 51, "estim": 336, "esty_ci": 52, "even": 43, "evolutionari": 303, "evolv": [303, 304], "exampl": [105, 106, 107, 108, 109, 110, 111, 112, 113, 114, 116, 117, 118, 119, 121, 122, 276, 305, 319, 336, 510], "example_t": 399, "except": [123, 276, 506, 511], "exist": 355, "expand_degener": 199, "explan": 116, "extend": [24, 423], "f_matrix": 329, "faith_pd": 53, "fasta": 111, "fastq": 112, "featur": [110, 113], "fh": 110, "file": [110, 111, 113, 506], "filter": [280, 356], "filter_column": 177, "filter_id": [164, 178], "find": 424, "find_al": 425, "find_by_func": 426, "find_by_id": 427, "find_dupl": 494, "find_motif": [185, 200, 216, 222], "find_with_regex": 232, "firstdifferencegradientanova": 309, "fisher_alpha": 54, "footer": 121, "formal": 116, "format": [104, 105, 106, 107, 108, 109, 110, 111, 112, 113, 114, 115, 116, 117, 118, 119, 120, 121, 122, 123, 124, 125, 126, 127, 506], "frequenc": 233, "from": 506, "from_adjac": 357, "from_bit": [4, 15], "from_cigar": 16, "from_coordin": 5, "from_dict": [25, 249], "from_hdf5": 358, "from_indic": 6, "from_iter": [281, 293], "from_json": 359, "from_linkage_matrix": 428, "from_ncbi": 192, "from_path_seq": 26, "from_tabular": 7, "from_taxdump": 429, "from_taxonomi": 430, "from_tsv": 360, "ft": 110, "function": [0, 83, 123, 144, 253, 276, 303, 319, 336], "g": 121, "gap": 201, "gap_frequ": 27, "gc": 121, "gc_content": 211, "gc_frequenc": 212, "genbank": 113, "gencod": 122, "gener": [110, 111, 119], "geneticcod": [191, 192, 193, 194], "get_alpha_diversity_metr": 88, "get_beta_diversity_metr": 89, "get_column": 179, "get_data_path": 495, "get_id": [165, 180], "get_miss": 166, "get_nam": 250, "get_read": 131, "get_rng": 496, "get_sniff": 132, "get_table_dens": 361, "get_trajectori": 311, "get_valu": 167, "get_value_by_id": 362, "get_writ": 133, "gf": 121, "gff3": 114, "gini_index": 55, "global_pairwise_align": 35, "global_pairwise_align_nucleotid": 36, "global_pairwise_align_protein": 37, "gme": 478, "goods_coverag": 56, "gr": 121, "gradient": [305, 306, 307, 308, 309, 310, 311, 312, 313, 314, 315, 316, 317], "gradientanova": [310, 311], "gradientanovaresult": [312, 313], "grammar": 116, "grammaredsequ": [195, 196, 197, 198, 199, 200, 201, 202, 203, 204, 205, 206, 207, 208], "group_metadata": 363, "groupresult": [314, 315], "ham": 254, "handl": 256, "has_cach": 431, "has_children": 432, "has_definit": 202, "has_degener": 203, "has_gap": 204, "has_interval_metadata": 161, "has_metadata": 172, "has_missing_valu": 168, "has_nondegener": 205, "has_positional_metadata": 175, "has_stop": 217, "head": 364, "header": [110, 111, 118, 121], "height": 433, "heip_": 57, "hill": 58, "hommola_cospeci": 304, "i": [123, 144], "id": 365, "ident": 251, "identifi": 120, "ilr": 265, "ilr_inv": 266, "index": [234, 282, 366], "index_tre": 434, "inform": 116, "initialize_st": 502, "inlin": 116, "inner": 267, "input": [1, 506], "insert": 435, "interv": [149, 150, 507], "intervalmetadata": [151, 152, 153, 154, 155, 156, 157, 158, 159], "intervalmetadatamixin": [160, 161], "introduct": 1, "inv_simpson": 59, "io": [104, 105, 106, 107, 108, 109, 110, 111, 112, 113, 114, 115, 116, 117, 118, 119, 121, 122, 123, 124, 125, 126, 127, 128, 129, 130, 131, 132, 133, 134, 135, 136, 137, 138, 139, 140, 141, 142, 143, 144, 145, 146, 147, 506], "ioregistri": [128, 129, 130, 131, 132, 133, 134, 135, 136, 137, 138, 139], "is_bifurc": 436, "is_empti": 367, "is_reverse_compl": 213, "is_root": 437, "is_tip": 438, "is_zero_bas": 12, "isubsampl": 318, "iter": 368, "iter_contigu": 235, "iter_data": 369, "iter_km": 236, "iter_pairwis": 370, "iter_posit": 28, "join": 29, "kempton_taylor_q": 60, "keyword": 123, "kind": 506, "kmer_dist": 255, "kmer_frequ": 237, "label": [115, 116], "lca": 439, "lead": 120, "length": [116, 371], "level": 110, "levelord": 440, "list_read_format": 134, "list_write_format": 135, "lladser_ci": 61, "lladser_p": 62, "load": 181, "local_pairwise_align": 38, "local_pairwise_align_nucleotid": 39, "local_pairwise_align_protein": 40, "local_pairwise_align_ssw": 41, "locat": 113, "log": 256, "lowercas": 238, "lsmat": 115, "majority_rul": 479, "make_identity_substitution_matrix": 42, "mantel": 298, "margalef": 63, "match": 240, "match_frequ": 239, "matrix": [104, 115, 276, 509], "max": 372, "maxdist": 441, "mcintosh_": 65, "mcintosh_d": 64, "mean_and_std": 330, "measur": [43, 83], "menhinick": 66, "merg": [155, 182, 373], "metadata": [120, 121, 148, 149, 150, 151, 152, 153, 154, 155, 156, 157, 158, 159, 160, 161, 162, 163, 164, 165, 166, 167, 168, 169, 170, 171, 172, 173, 174, 175, 176, 177, 178, 179, 180, 181, 182, 183, 374, 507], "metadata_to_datafram": 375, "metadatacolumn": [162, 163, 164, 165, 166, 167, 168, 169, 170], "metadatamixin": [171, 172], "method": [303, 319, 503, 509], "metric": [1, 43, 253], "michaelis_menten_fit": 67, "min": 376, "miscellan": 512, "mismatch": 242, "mismatch_frequ": 241, "multi": 111, "multi_replac": 268, "multidimension": 319, "multipl": [118, 121], "multivari": 509, "name": 122, "neighbor": 442, "new": 123, "newick": 116, "nj": 480, "nni": 481, "node": [116, 122], "non_tip": 443, "nondegener": 206, "nonzero": 377, "nonzero_count": 378, "norm": 379, "nucleotidemixin": [209, 210, 211, 212, 213, 214], "number": 120, "numericmetadatacolumn": 173, "o": [123, 144], "observed_featur": 68, "observed_node_count": 444, "onli": 119, "open": 145, "open_fil": [146, 147], "oper": [256, 511], "optim": 0, "ordin": [117, 319, 320, 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, 331, 332, 333, 334, 335, 509], "ordinationresult": [320, 321, 322, 323, 324], "origin": 113, "osd": 69, "other": 509, "output": 506, "overrid": 497, "pa": 380, "pairalignpath": [14, 15, 16, 17, 18], "paired_subsampl": 338, "pairwise_vlr": 269, "paramet": [106, 108, 111, 112, 113, 114, 115, 116, 118, 119, 121, 122], "params_alias": 498, "partial_beta_divers": 90, "partit": 381, "path": 445, "path_dist": 482, "pcoa": 331, "pcoa_biplot": 332, "permanova": 299, "permdisp": 300, "permut": 294, "perturb": 270, "perturb_inv": 271, "phydiv": 70, "phylip": 118, "phylogenet": 511, "pielou_": 71, "plot": [283, 321, 512], "plottablemixin": 486, "pop": 446, "positionalmetadatamixin": [174, 175], "postord": 447, "power": [272, 336, 337, 338, 339, 340], "pre_and_postord": 448, "preorder": 449, "product": 110, "protein": [215, 216, 217, 218, 219, 220], "proteinembed": 96, "proteinvector": 97, "prune": 450, "pwmantel": 301, "qseq": 119, "qual": 111, "qualiti": 112, "queri": 156, "randdm": 302, "rankdata": 382, "ratio": 256, "rda": 333, "read": [30, 93, 110, 111, 113, 136, 141, 157, 186, 218, 223, 243, 284, 322, 383, 451, 506], "reader": [111, 113, 114, 125], "rearrang": 511, "reassign_index": 31, "recommend": 120, "reduc": 384, "redundant_form": 285, "refer": [43, 104, 105, 106, 107, 108, 110, 111, 112, 113, 114, 116, 118, 119, 121, 122, 256, 276, 319], "register_alias": 499, "registri": [123, 124, 125, 126, 127, 128, 129, 130, 131, 132, 133, 134, 135, 136, 137, 138, 139, 140, 141, 142, 143], "remov": 452, "remove_by_func": 453, "remove_delet": 454, "remove_empti": 385, "remove_format": 137, "renam": [286, 323], "renyi": 72, "replac": 244, "requir": [120, 504], "reserv": 123, "result": [117, 319], "reverse_compl": 214, "reverse_transcrib": 224, "rf_dist": 483, "rich": 43, "rna": [221, 222, 223, 224, 225, 226, 227], "robbin": 73, "root": 455, "root_at": 456, "root_at_midpoint": 457, "root_by_outgroup": 458, "row": 120, "rule": 116, "safe_md5": 500, "sampl": 507, "samplemetadata": [176, 177, 178, 179, 180, 181, 182, 183], "sbp_basi": 273, "scale": [319, 334], "scikit": [123, 505, 506], "score": 112, "section": [108, 110, 113, 118], "sequenc": [0, 111, 118, 121, 184, 185, 186, 187, 188, 189, 190, 191, 192, 193, 194, 195, 196, 197, 198, 199, 200, 201, 202, 203, 204, 205, 206, 207, 208, 209, 210, 211, 212, 213, 214, 215, 216, 217, 218, 219, 220, 221, 222, 223, 224, 225, 226, 227, 228, 229, 230, 231, 232, 233, 234, 235, 236, 237, 238, 239, 240, 241, 242, 243, 244, 245, 246, 247, 248, 249, 250, 251, 252, 253, 254, 255, 508], "sequenceembed": 98, "sequencevector": 99, "set_zero_bas": 13, "shannon": 74, "shear": 459, "shuffl": 460, "sibl": 461, "simpl": 104, "simpson": 75, "simpson_": 77, "simpson_d": 76, "singl": 78, "skbio": [0, 1, 2, 3, 4, 5, 6, 7, 8, 9, 10, 11, 12, 13, 14, 15, 16, 17, 18, 19, 20, 21, 22, 23, 24, 25, 26, 27, 28, 29, 30, 31, 32, 33, 34, 35, 36, 37, 38, 39, 40, 41, 42, 43, 44, 45, 46, 47, 48, 49, 50, 51, 52, 53, 54, 55, 56, 57, 58, 59, 60, 61, 62, 63, 64, 65, 66, 67, 68, 69, 70, 71, 72, 73, 74, 75, 76, 77, 78, 79, 80, 81, 82, 83, 84, 85, 86, 87, 88, 89, 90, 91, 92, 93, 94, 95, 96, 97, 98, 99, 100, 101, 102, 103, 104, 105, 106, 107, 108, 109, 110, 111, 112, 113, 114, 115, 116, 117, 118, 119, 121, 122, 123, 124, 125, 126, 127, 128, 129, 130, 131, 132, 133, 134, 135, 136, 137, 138, 139, 140, 141, 142, 143, 144, 145, 146, 147, 148, 149, 150, 151, 152, 153, 154, 155, 156, 157, 158, 159, 160, 161, 162, 163, 164, 165, 166, 167, 168, 169, 170, 171, 172, 173, 174, 175, 176, 177, 178, 179, 180, 181, 182, 183, 184, 185, 186, 187, 188, 189, 190, 191, 192, 193, 194, 195, 196, 197, 198, 199, 200, 201, 202, 203, 204, 205, 206, 207, 208, 209, 210, 211, 212, 213, 214, 215, 216, 217, 218, 219, 220, 221, 222, 223, 224, 225, 226, 227, 228, 229, 230, 231, 232, 233, 234, 235, 236, 237, 238, 239, 240, 241, 242, 243, 244, 245, 246, 247, 248, 249, 250, 251, 252, 253, 254, 255, 256, 257, 258, 259, 260, 261, 262, 263, 264, 265, 266, 267, 268, 269, 270, 271, 272, 273, 274, 275, 276, 277, 278, 279, 280, 281, 282, 283, 284, 285, 286, 287, 288, 289, 290, 291, 292, 293, 294, 295, 296, 297, 298, 299, 300, 301, 302, 303, 304, 305, 306, 307, 308, 309, 310, 311, 312, 313, 314, 315, 316, 317, 318, 319, 320, 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, 331, 332, 333, 334, 335, 336, 337, 338, 339, 340, 341, 342, 343, 344, 345, 346, 347, 348, 349, 350, 351, 352, 353, 354, 355, 356, 357, 358, 359, 360, 361, 362, 363, 364, 365, 366, 367, 368, 369, 370, 371, 372, 373, 374, 375, 376, 377, 378, 379, 380, 381, 382, 383, 384, 385, 386, 387, 388, 389, 390, 391, 392, 393, 394, 395, 396, 397, 398, 399, 400, 401, 402, 403, 404, 405, 406, 407, 408, 409, 410, 411, 412, 413, 414, 415, 416, 417, 418, 419, 420, 421, 422, 423, 424, 425, 426, 427, 428, 429, 430, 431, 432, 433, 434, 435, 436, 437, 438, 439, 440, 441, 442, 443, 444, 445, 446, 447, 448, 449, 450, 451, 452, 453, 454, 455, 456, 457, 458, 459, 460, 461, 462, 463, 464, 465, 466, 467, 468, 469, 470, 471, 472, 473, 474, 475, 476, 477, 478, 479, 480, 481, 482, 483, 484, 485, 486, 487, 488, 489, 490, 491, 492, 493, 494, 495, 496, 497, 498, 499, 500, 501, 502, 503, 504, 506, 507, 508, 509, 510, 511, 512, 513], "slow": 0, "sniff": [138, 142], "sniffer": 126, "sob": 79, "sort": [32, 158, 386], "sort_ord": 387, "specif": [104, 105, 106, 107, 108, 109, 110, 111, 112, 113, 114, 115, 116, 117, 118, 119, 120, 121, 122], "specifi": 1, "sq": 110, "squar": 115, "stat": [256, 257, 258, 259, 260, 261, 262, 263, 264, 265, 266, 267, 268, 269, 270, 271, 272, 273, 274, 275, 276, 277, 278, 279, 280, 281, 282, 283, 284, 285, 286, 287, 288, 289, 290, 291, 292, 293, 294, 295, 296, 297, 298, 299, 300, 301, 302, 303, 304, 305, 306, 307, 308, 309, 310, 311, 312, 313, 314, 315, 316, 317, 318, 319, 320, 321, 322, 323, 324, 325, 326, 327, 328, 329, 330, 331, 332, 333, 334, 335, 336, 337, 338, 339, 340, 341, 509], "statist": [256, 276, 303, 509], "stockholm": 121, "stop": 219, "stream": 506, "string": 113, "stripedsmithwaterman": 19, "strong": 80, "structur": [0, 276, 511], "subsampl": [388, 509], "subsample_count": 341, "subsample_paired_pow": 339, "subsample_pow": 340, "subset": [462, 463], "substitutionmatrix": [247, 248, 249, 250, 251, 252], "subtre": 464, "sum": 389, "support": [104, 105, 106, 107, 108, 109, 110, 111, 112, 113, 114, 115, 116, 117, 118, 119, 120, 121, 122, 506], "svd_rank": 335, "symbol": 116, "tabl": [342, 343, 344, 345, 346, 347, 348, 349, 350, 351, 352, 353, 354, 355, 356, 357, 358, 359, 360, 361, 362, 363, 364, 365, 366, 367, 368, 369, 370, 371, 372, 373, 374, 375, 376, 377, 378, 379, 380, 381, 382, 383, 384, 385, 386, 387, 388, 389, 390, 391, 392, 393, 394, 395, 396, 397, 398, 399, 510], "tabularmsa": [20, 21, 22, 23, 24, 25, 26, 27, 28, 29, 30, 31, 32, 33, 34, 111], "taxdump": 122, "test": 512, "tip": 465, "to_anndata": 390, "to_arrai": 466, "to_bit": [8, 17], "to_cigar": 18, "to_coordin": 9, "to_data_fram": 287, "to_datafram": [169, 183, 391], "to_definit": 207, "to_dict": [33, 252], "to_fil": [308, 313, 315], "to_hdf5": 392, "to_indic": [10, 245], "to_json": 393, "to_regex": 208, "to_seri": [170, 295], "to_taxonomi": 467, "to_tsv": 394, "total_length": 468, "trail": 120, "trajectorygradientanova": 316, "transcrib": 187, "transform": [256, 395], "translat": [188, 193, 225], "translate_six_fram": [189, 194, 226], "transpos": [288, 396], "travers": 469, "tree": [400, 401, 402, 403, 404, 405, 406, 407, 408, 409, 410, 411, 412, 413, 414, 415, 416, 417, 418, 419, 420, 421, 422, 423, 424, 425, 426, 427, 428, 429, 430, 431, 432, 433, 434, 435, 436, 437, 438, 439, 440, 441, 442, 443, 444, 445, 446, 447, 448, 449, 450, 451, 452, 453, 454, 455, 456, 457, 458, 459, 460, 461, 462, 463, 464, 465, 466, 467, 468, 469, 470, 471, 472, 473, 474, 475, 476, 477, 478, 479, 480, 481, 482, 483, 484, 485, 511], "tree_basi": 274, "treenod": [400, 401, 402, 403, 404, 405, 406, 407, 408, 409, 410, 411, 412, 413, 414, 415, 416, 417, 418, 419, 420, 421, 422, 423, 424, 425, 426, 427, 428, 429, 430, 431, 432, 433, 434, 435, 436, 437, 438, 439, 440, 441, 442, 443, 444, 445, 446, 447, 448, 449, 450, 451, 452, 453, 454, 455, 456, 457, 458, 459, 460, 461, 462, 463, 464, 465, 466, 467, 468, 469, 470, 471, 472, 473, 474, 475, 476], "tsalli": 81, "tutori": [0, 1, 506, 508, 511, 513], "type": [2, 106, 107, 120, 508], "unpack": 470, "unpack_by_func": 471, "unroot": 472, "unrooted_copi": 473, "unrooted_deepcopi": 474, "unrooted_mov": 475, "unweighted_unifrac": 84, "update_id": 397, "upgma": 484, "us": [0, 110, 506], "util": [2, 144, 145, 146, 147, 319, 486, 487, 488, 489, 490, 491, 492, 493, 494, 495, 496, 497, 498, 499, 500, 508, 511, 512], "valid": [1, 120], "variabl": 276, "variant": 112, "vector": [1, 2], "vlr": 275, "warn": 506, "weighted_unifrac": 85, "what": 506, "whitespac": [116, 120], "windowdifferencegradientanova": 317, "within": 289, "workflow": [501, 502, 503, 504, 513], "wrf_dist": 485, "write": [34, 94, 111, 113, 139, 143, 159, 190, 220, 227, 246, 290, 324, 398, 476, 506], "writer": [111, 114, 127], "zero": 256}}) \ No newline at end of file diff --git a/docs/dev/sequence.html b/docs/dev/sequence.html index 4879921f8..4026b15e9 100644 --- a/docs/dev/sequence.html +++ b/docs/dev/sequence.html @@ -31,7 +31,7 @@ - + @@ -751,7 +751,7 @@

Tutorial

New sequences are created with optional metadata and positional metadata. Metadata is stored as a Python dict, while positional metadata is stored as a pandas DataFrame.

-
>>> from skbio import DNA, RNA
+
>>> from skbio import DNA, RNA
 >>> d = DNA('ACCGGGTA', metadata={'id':"my-sequence", 'description':"GFP"},
 ...          positional_metadata={'quality':[22, 25, 22, 18, 23, 25, 25, 25]})
 >>> d
@@ -1079,7 +1079,7 @@ 

Tutorial diff --git a/docs/dev/stats.html b/docs/dev/stats.html index 4ac36370d..50dececae 100644 --- a/docs/dev/stats.html +++ b/docs/dev/stats.html @@ -31,7 +31,7 @@ - + @@ -823,7 +823,7 @@

Other statistical methods - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/table.html b/docs/dev/table.html index 94760f76d..820c0527b 100644 --- a/docs/dev/table.html +++ b/docs/dev/table.html @@ -31,7 +31,7 @@ - + @@ -767,7 +767,7 @@

Example data - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/tree.html b/docs/dev/tree.html index d1d4d0b1f..33cfced9a 100644 --- a/docs/dev/tree.html +++ b/docs/dev/tree.html @@ -31,7 +31,7 @@ - + @@ -775,8 +775,8 @@

Exceptions

Tutorial#

-
>>> from skbio import TreeNode
->>> from io import StringIO
+
>>> from skbio import TreeNode
+>>> from io import StringIO
 

A new tree can be constructed from a Newick string. Newick is a common format @@ -982,7 +982,7 @@

Tutorial diff --git a/docs/dev/util.html b/docs/dev/util.html index d0acbc15e..b9f899bbd 100644 --- a/docs/dev/util.html +++ b/docs/dev/util.html @@ -31,7 +31,7 @@ - + @@ -840,7 +840,7 @@

Miscellaneous utilities - © Copyright 2014-2024, scikit-bio development team. + © Copyright 2014-2025, scikit-bio development team.

diff --git a/docs/dev/workflow.html b/docs/dev/workflow.html index 749b90f26..03869b49a 100644 --- a/docs/dev/workflow.html +++ b/docs/dev/workflow.html @@ -31,7 +31,7 @@ - + @@ -692,7 +692,7 @@

Decorators

Tutorial#

-
>>> from skbio.workflow import Workflow
+
>>> from skbio.workflow import Workflow
 

As an example of the Workflow object, let’s construct a sequence processor @@ -705,23 +705,23 @@

Tutorial directly to workflow checks.

>>> nuc_pattern = 'AATTG'
 >>> has_nuc_pattern = lambda s: s[:len(nuc_pattern)] == nuc_pattern
->>> class SequenceProcessor(Workflow):
-...    def initialize_state(self, item):
+>>> class SequenceProcessor(Workflow):
+...    def initialize_state(self, item):
 ...        # Setup the state for a new item (e.g., a new sequence)
 ...        self.state = item
 ...    @method(priority=100)
-...    def check_length(self):
+...    def check_length(self):
 ...        # Always make sure the sequence is at least 10 nucleotides
 ...        if len(self.state) < 10:
 ...            self.failed = True
 ...    @method(priority=90)
 ...    @requires(state=has_nuc_pattern)
-...    def truncate(self):
+...    def truncate(self):
 ...        # Truncate if a specific starting nucleotide pattern is observed
 ...        self.state = self.state[len(nuc_pattern):]
 ...    @method(priority=80)
 ...    @requires(option='reverse', values=True)
-...    def reverse(self):
+...    def reverse(self):
 ...        # Reverse the sequence if indicatd at runtime
 ...        self.state = self.state[::-1]
 
@@ -745,9 +745,9 @@

Tutorial member variable while failures are ignored – but, depending on your workflow, it can be useful to handle failures or potentially do something fun and exciting on success.

-