# HG changeset patch # User florianbegusch # Date 1565809968 14400 # Node ID f190567fe3f60112d63accd61dc467a941a6f966 # Parent d66c7509e8f97473a8bde1a925697f45c3cbc8be Uploaded diff -r d66c7509e8f9 -r f190567fe3f6 qiime2/merge_feature_table_and_taxonomy.xml --- a/qiime2/merge_feature_table_and_taxonomy.xml Tue Aug 13 07:57:53 2019 -0400 +++ b/qiime2/merge_feature_table_and_taxonomy.xml Wed Aug 14 15:12:48 2019 -0400 @@ -1,8 +1,8 @@ - + - Merge features and taxonomy into a single biom file. - qiime2 + qiime2 mkdir out; diff -r d66c7509e8f9 -r f190567fe3f6 qiime2/qiime_alignment_mafft.xml --- a/qiime2/qiime_alignment_mafft.xml Tue Aug 13 07:57:53 2019 -0400 +++ b/qiime2/qiime_alignment_mafft.xml Wed Aug 14 15:12:48 2019 -0400 @@ -1,8 +1,8 @@ - + - De novo multiple sequence alignment with MAFFT - qiime2 + qiime2 - + - Positional conservation and gap filtering. - qiime2 + qiime2 - + - Add pseudocount to table - qiime2 + qiime2 - + - Apply ANCOM to identify features that differ in abundance. - qiime2 + qiime2 - + - Demultiplex paired-end sequence data with barcodes in- sequence. - qiime2 + qiime2 + + + + + + @@ -101,7 +119,7 @@ - + - Demultiplex single-end sequence data with barcodes in- sequence. - qiime2 + qiime2 + + + + + @@ -78,6 +91,15 @@ The level of error tolerance, specified as the maximum allowable error rate. The default value specified by cutadapt is 0.1 (=10%), which is greater than `demux emp-*`, which is 0.0 (=0%). +batch_size : Int % Range(0, None), optional + The number of samples cutadapt demultiplexes concurrently. + Demultiplexing in smaller batches will yield the same result with + marginal speed loss, and may solve "too many files" errors related to + sample quantity. Set to "0" to process all samples at once. +minimum_length : Int % Range(1, None), optional + Discard reads shorter than specified value. Note, the cutadapt default + of 0 has been overridden, because that value produces empty sequence + records. Returns ------- diff -r d66c7509e8f9 -r f190567fe3f6 qiime2/qiime_cutadapt_trim-paired.xml --- a/qiime2/qiime_cutadapt_trim-paired.xml Tue Aug 13 07:57:53 2019 -0400 +++ b/qiime2/qiime_cutadapt_trim-paired.xml Wed Aug 14 15:12:48 2019 -0400 @@ -1,8 +1,8 @@ - + - Find and remove adapters in demultiplexed paired-end sequences. - qiime2 + qiime2 - + - Find and remove adapters in demultiplexed single-end sequences. - qiime2 + qiime2 - + - Denoise and dereplicate paired-end sequences - qiime2 + qiime2 - + + + + + + + + @@ -149,7 +166,7 @@ - + - Denoise and dereplicate single-end pyrosequences - qiime2 + qiime2 - + - Denoise and dereplicate single-end sequences - qiime2 + qiime2 - + - Deblur sequences using a 16S positive filter. - qiime2 + qiime2 - + - Deblur sequences using a user-specified positive filter. - qiime2 + qiime2 - + - Visualize Deblur stats per sample. - qiime2 + qiime2 - + - Demultiplex paired-end sequence data generated with the EMP protocol. - qiime2 + qiime2 - + - Demultiplex sequence data generated with the EMP protocol. - qiime2 + qiime2 + + - Filter samples out of demultiplexed data. + + qiime2 + + + + + + + + + + + + + + + + + + qiime_citation.xml + + + diff -r d66c7509e8f9 -r f190567fe3f6 qiime2/qiime_demux_subsample-paired.xml --- a/qiime2/qiime_demux_subsample-paired.xml Tue Aug 13 07:57:53 2019 -0400 +++ b/qiime2/qiime_demux_subsample-paired.xml Wed Aug 14 15:12:48 2019 -0400 @@ -1,8 +1,8 @@ - + - Subsample paired-end sequences without replacement. - qiime2 + qiime2 - + - Subsample single-end sequences without replacement. - qiime2 + qiime2 - + - Summarize counts per sample. - qiime2 + qiime2 - + - adonis PERMANOVA test for beta group significance - qiime2 + qiime2 - + - Alpha diversity correlation - qiime2 + qiime2 - + - Alpha diversity comparisons - qiime2 + qiime2 + + - Alpha diversity (phylogenetic) - alternative implementation + + qiime2 + + + + + + + + + + + + + + + qiime_citation.xml + + + diff -r d66c7509e8f9 -r f190567fe3f6 qiime2/qiime_diversity_alpha-phylogenetic.xml --- a/qiime2/qiime_diversity_alpha-phylogenetic.xml Tue Aug 13 07:57:53 2019 -0400 +++ b/qiime2/qiime_diversity_alpha-phylogenetic.xml Wed Aug 14 15:12:48 2019 -0400 @@ -1,8 +1,8 @@ - + - Alpha diversity (phylogenetic) - qiime2 + qiime2 - + - Alpha rarefaction curves - qiime2 + qiime2 - + - Alpha diversity - qiime2 + qiime2 - + - Beta diversity correlation - qiime2 + qiime2 - + - Beta diversity group significance - qiime2 + qiime2 - + - Beta diversity (phylogenetic) - qiime2 + qiime2 - + - Beta diversity rarefaction - qiime2 + qiime2 - + - Beta diversity - qiime2 + qiime2 - + - bioenv - qiime2 + qiime2 - + - Core diversity metrics (phylogenetic and non- phylogenetic) - qiime2 + qiime2 - + - Core diversity metrics (non-phylogenetic) - qiime2 + qiime2 - + - Filter samples from a distance matrix. - qiime2 + qiime2 - + - Apply the Mantel test to two distance matrices - qiime2 + qiime2 - + - Principal Coordinate Analysis Biplot - qiime2 + qiime2 - + - Principal Coordinate Analysis - qiime2 + qiime2 - + - Procrustes Analysis - qiime2 + qiime2 - + - Visualize and Interact with Principal Coordinates Analysis Biplot - qiime2 + qiime2 - + - Visualize and Interact with Principal Coordinates Analysis Plots - qiime2 + qiime2 - + - Visualize and Interact with a procrustes plot - qiime2 + qiime2 - + - BLAST+ consensus taxonomy classifier - qiime2 + qiime2 - + - VSEARCH consensus taxonomy classifier - qiime2 + qiime2 @@ -95,13 +106,17 @@ + + + + + perc_identity similarity. Must be in range [0, infinity]. +maxaccepts : Int % Range(1, None) | Str % Choices('all'), optional + Maximum number of hits to keep for each query. Set to "all" to keep all + hits > perc_identity similarity. perc_identity : Float % Range(0.0, 1.0, inclusive_end=True), optional - Reject match if percent identity to query is lower. Must be in range - [0.0, 1.0]. + Reject match if percent identity to query is lower. query_cov : Float % Range(0.0, 1.0, inclusive_end=True), optional Reject match if query alignment coverage per high-scoring pair is - lower. Must be in range [0.0, 1.0]. + lower. strand : Str % Choices('both', 'plus'), optional Align against reference sequences in forward ("plus") or both directions ("both"). min_consensus : Float % Range(0.5, 1.0, inclusive_start=False, inclusive_end=True), optional Minimum fraction of assignments must match top hit to be accepted as - consensus assignment. Must be in range (0.5, 1.0]. + consensus assignment. unassignable_label : Str, optional - \ +search_exact : Bool, optional + Search for exact full-length matches to the query sequences. Only 100% + exact matches are reported and this command is much faster than the + default. If True, the perc_identity and query_cov settings are ignored. + Note: query and reference reads must be trimmed to the exact same DNA + locus (e.g., primer site) because only exact matches will be reported. +top_hits_only : Bool, optional + Only the top hits between the query and reference sequence sets are + reported. For each query, the top hit is the one presenting the highest + percentage of identity. Multiple equally scored top hits will be used + for consensus taxonomic assignment if maxaccepts is greater than 1. +threads : Int % Range(1, None), optional + Number of threads to use for job parallelization. Returns ------- diff -r d66c7509e8f9 -r f190567fe3f6 qiime2/qiime_feature-classifier_classify-hybrid-vsearch-sklearn.xml --- /dev/null Thu Jan 01 00:00:00 1970 +0000 +++ b/qiime2/qiime_feature-classifier_classify-hybrid-vsearch-sklearn.xml Wed Aug 14 15:12:48 2019 -0400 @@ -0,0 +1,241 @@ + + + - ALPHA Hybrid classifier: VSEARCH exact match + sklearn classifier + + qiime2 + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + perc_identity similarity. +perc_identity : Float % Range(0.0, 1.0, inclusive_end=True), optional + Percent sequence similarity to use for PREFILTER. Reject match if + percent identity to query is lower. Set to a lower value to perform a + rough pre-filter. This parameter is ignored if `prefilter` is disabled. +query_cov : Float % Range(0.0, 1.0, inclusive_end=True), optional + Query coverage threshold to use for PREFILTER. Reject match if query + alignment coverage per high-scoring pair is lower. Set to a lower value + to perform a rough pre-filter. This parameter is ignored if `prefilter` + is disabled. +strand : Str % Choices('both', 'plus'), optional + Align against reference sequences in forward ("plus") or both + directions ("both"). +min_consensus : Float % Range(0.5, 1.0, inclusive_start=False, inclusive_end=True), optional + Minimum fraction of assignments must match top hit to be accepted as + consensus assignment. +reads_per_batch : Int % Range(0, None), optional + Number of reads to process in each batch for sklearn classification. If + "auto", this parameter is autoscaled to min(number of query sequences / + threads, 20000). +confidence : Float % Range(0, 1, inclusive_end=True) | Str % Choices('disable'), optional + Confidence threshold for limiting taxonomic depth. Set to "disable" to + disable confidence calculation, or 0 to calculate confidence but not + apply it to limit the taxonomic depth of the assignments. +read_orientation : Str % Choices('same', 'reverse-complement', 'auto'), optional + Direction of reads with respect to reference sequences in pre-trained + sklearn classifier. same will cause reads to be classified unchanged; + reverse-complement will cause reads to be reversed and complemented + prior to classification. "auto" will autodetect orientation based on + the confidence estimates for the first 100 reads. +prefilter : Bool, optional + Toggle positive filter of query sequences on or off. +sample_size : Int % Range(1, None), optional + Randomly extract the given number of sequences from the reference + database to use for prefiltering. This parameter is ignored if + `prefilter` is disabled. +randseed : Int % Range(0, None), optional + Use integer as a seed for the pseudo-random generator used during + prefiltering. A given seed always produces the same output, which is + useful for replicability. Set to 0 to use a pseudo-random seed. This + parameter is ignored if `prefilter` is disabled. + +Returns +------- +classification : FeatureData[Taxonomy] + The resulting taxonomy classifications. + ]]> + + qiime_citation.xml + + + diff -r d66c7509e8f9 -r f190567fe3f6 qiime2/qiime_feature-classifier_classify-sklearn.xml --- a/qiime2/qiime_feature-classifier_classify-sklearn.xml Tue Aug 13 07:57:53 2019 -0400 +++ b/qiime2/qiime_feature-classifier_classify-sklearn.xml Wed Aug 14 15:12:48 2019 -0400 @@ -1,8 +1,8 @@ - + - Pre-fitted sklearn-based taxonomy classifier - qiime2 + qiime2 - + - Extract reads from reference - qiime2 + qiime2 - + - Train the naive_bayes classifier - qiime2 + qiime2 - + - Train an almost arbitrary scikit-learn classifier - qiime2 + qiime2 - + - Identify core features in table - qiime2 + qiime2 - + - Filter features from table - qiime2 + qiime2 - + - Filter samples from table - qiime2 + qiime2 - + - Filter features from sequences - qiime2 + qiime2 - + - Group samples or features by a metadata column - qiime2 + qiime2 - + - Generate a heatmap representation of a feature table - qiime2 + qiime2 - + - Combine collections of feature sequences - qiime2 + qiime2 - + - Combine collections of feature taxonomies - qiime2 + qiime2 - + - Combine multiple tables - qiime2 + qiime2 - + - Convert to presence/absence - qiime2 + qiime2 - + - Rarefy table - qiime2 + qiime2 - + - Convert to relative frequencies - qiime2 + qiime2 - + - Subsample table - qiime2 + qiime2 - + - Summarize table - qiime2 + qiime2 - + - View sequence associated with each feature - qiime2 + qiime2 - + - Transpose a feature table. - qiime2 + qiime2 - + - Experimental: Obtain taxonomic lineages, by finding closest OTU in reference phylogeny. - qiime2 + qiime2 - + - Filter fragments in tree from table. - qiime2 + qiime2 - + - Insert fragment sequences using SEPP into reference phylogenies like Greengenes 13_8 - qiime2 + qiime2 - + - Assigns ids on internal nodes in the tree, and makes sure that they are consistent with the table columns. - qiime2 + qiime2 - + - Balance Summary - qiime2 + qiime2 - + - Hierarchical clustering using feature correlation. - qiime2 + qiime2 - + - Dendrogram heatmap. - qiime2 + qiime2 - + - Hierarchical clustering using gradient information. - qiime2 + qiime2 - - - + diff -r d66c7509e8f9 -r f190567fe3f6 qiime2/qiime_gneiss_ilr-hierarchical.xml --- a/qiime2/qiime_gneiss_ilr-hierarchical.xml Tue Aug 13 07:57:53 2019 -0400 +++ b/qiime2/qiime_gneiss_ilr-hierarchical.xml Wed Aug 14 15:12:48 2019 -0400 @@ -1,8 +1,8 @@ - + - Isometric Log-ratio Transform applied to a hierarchical clustering - qiime2 + qiime2 - + - Isometric Log-ratio Transform applied to a phylogenetic tree - qiime2 + qiime2 - + - Simplicial Linear mixed effects regression - qiime2 + qiime2 - + - Simplicial Ordinary Least Squares Regression - qiime2 + qiime2 - + - ANOVA test - qiime2 + qiime2 - + - Feature volatility analysis - qiime2 + qiime2 - + - Compute first differences or difference from baseline between sequential states - qiime2 + qiime2 - + - Compute first distances or distance from baseline between sequential states - qiime2 + qiime2 - + - Linear mixed effects modeling - qiime2 + qiime2 - + - Microbial maturity index prediction. - qiime2 + qiime2 - + - Nonparametric microbial interdependence test - qiime2 + qiime2 - + - Paired difference testing and boxplots - qiime2 + qiime2 - + - Paired pairwise distance testing and boxplots - qiime2 + qiime2 - + - Plot longitudinal feature volatility and importances - qiime2 + qiime2 - + - Generate interactive volatility plot - qiime2 + qiime2 - + - Create a distance matrix from a numeric Metadata column - qiime2 + qiime2 - + - Interactively explore Metadata in an HTML table - qiime2 + qiime2 - + - Build a phylogenetic tree using fasttree and mafft alignment - qiime2 + qiime2 - + - Construct a phylogenetic tree with FastTree. - qiime2 + qiime2 - + - Remove features from table if they're not present in tree. - qiime2 + qiime2 - + - Construct a phylogenetic tree with IQ-TREE with bootstrap supports. - qiime2 + qiime2 - + - Construct a phylogenetic tree with IQ-TREE. - qiime2 + qiime2 - + - Midpoint root an unrooted phylogenetic tree. - qiime2 + qiime2 - + - Construct a phylogenetic tree with bootstrap supports using RAxML. - qiime2 + qiime2 - + - Construct a phylogenetic tree with RAxML. - qiime2 + qiime2 - + - Evaluate expected vs. observed taxonomic composition of samples - qiime2 + qiime2 - + - Compare query (observed) vs. reference (expected) sequences. - qiime2 + qiime2 - + - Evaluate expected vs. observed taxonomic assignments - qiime2 + qiime2 - + - Exclude sequences by alignment - qiime2 + qiime2 - + - Quality filter based on joined sequence quality scores. - qiime2 + qiime2 - + - Quality filter based on sequence quality scores. - qiime2 + qiime2 - + - Run k-nearest-neighbors on a labeled distance matrix. - qiime2 + qiime2 - + - Nested cross-validated supervised learning classifier. - qiime2 + qiime2 @@ -81,6 +83,7 @@ + @@ -127,6 +130,8 @@ Predicted target values for each input sample. feature_importance : FeatureData[Importance] Importance of each input feature to model accuracy. +probabilities : SampleData[Probabilities] + Predicted class probabilities for each input sample. ]]> qiime_citation.xml diff -r d66c7509e8f9 -r f190567fe3f6 qiime2/qiime_sample-classifier_classify-samples.xml --- a/qiime2/qiime_sample-classifier_classify-samples.xml Tue Aug 13 07:57:53 2019 -0400 +++ b/qiime2/qiime_sample-classifier_classify-samples.xml Wed Aug 14 15:12:48 2019 -0400 @@ -1,8 +1,8 @@ - + - Train and test a cross-validated supervised learning classifier. - qiime2 + qiime2 + @@ -213,6 +216,8 @@ the trained estimator. accuracy_results : Visualization Accuracy results visualization. +probabilities : SampleData[Probabilities] + Predicted class probabilities for each input sample. ]]> qiime_citation.xml diff -r d66c7509e8f9 -r f190567fe3f6 qiime2/qiime_sample-classifier_confusion-matrix.xml --- a/qiime2/qiime_sample-classifier_confusion-matrix.xml Tue Aug 13 07:57:53 2019 -0400 +++ b/qiime2/qiime_sample-classifier_confusion-matrix.xml Wed Aug 14 15:12:48 2019 -0400 @@ -1,8 +1,8 @@ - + - Make a confusion matrix from sample classifier predictions. - qiime2 + qiime2 - + - Fit a supervised learning classifier. - qiime2 + qiime2 - + - Fit a supervised learning regressor. - qiime2 + qiime2 - + - Generate heatmap of important features. - qiime2 + qiime2 - + - Convert (and merge) positive numeric metadata (in)to feature table. - qiime2 + qiime2 - + - Use trained classifier to predict target values for new samples. - qiime2 + qiime2 - + - Use trained regressor to predict target values for new samples. - qiime2 + qiime2 - + - Nested cross-validated supervised learning regressor. - qiime2 + qiime2 - + - Train and test a cross-validated supervised learning regressor. - qiime2 + qiime2 - + - Make 2D scatterplot and linear regression of regressor predictions. - qiime2 + qiime2 - + - Split a feature table into training and testing sets. - qiime2 + qiime2 - + - Summarize parameter and feature extraction information for a trained estimator. - qiime2 + qiime2 - + - Visualize taxonomy with an interactive bar plot - qiime2 + qiime2 - + - Collapse features by their taxonomy at the specified level - qiime2 + qiime2 - + - Taxonomy-based feature sequence filter. - qiime2 + qiime2 - + - Taxonomy-based feature table filter. - qiime2 + qiime2 - + - Export data from a QIIME 2 Artifact or Visualization. - qiime2 + qiime2 diff -r d66c7509e8f9 -r f190567fe3f6 qiime2/qiime_tools_export_collection.xml --- a/qiime2/qiime_tools_export_collection.xml Tue Aug 13 07:57:53 2019 -0400 +++ b/qiime2/qiime_tools_export_collection.xml Wed Aug 14 15:12:48 2019 -0400 @@ -1,8 +1,8 @@ - + - Export data from a QIIME 2 Artifact or Visualization. - qiime2 + qiime2 diff -r d66c7509e8f9 -r f190567fe3f6 qiime2/qiime_tools_export_paired_collection.xml --- a/qiime2/qiime_tools_export_paired_collection.xml Tue Aug 13 07:57:53 2019 -0400 +++ b/qiime2/qiime_tools_export_paired_collection.xml Wed Aug 14 15:12:48 2019 -0400 @@ -1,8 +1,8 @@ - + - Export data from a QIIME 2 Artifact or Visualization. - qiime2 + qiime2 diff -r d66c7509e8f9 -r f190567fe3f6 qiime2/qiime_tools_import.xml --- a/qiime2/qiime_tools_import.xml Tue Aug 13 07:57:53 2019 -0400 +++ b/qiime2/qiime_tools_import.xml Wed Aug 14 15:12:48 2019 -0400 @@ -1,8 +1,8 @@ - + - Import data into a new QIIME 2 Artifact. - qiime2 + qiime2 - + - Closed-reference clustering of features. - qiime2 + qiime2 - + - De novo clustering of features. - qiime2 + qiime2 - + - Open-reference clustering of features. - qiime2 + qiime2 - + - Dereplicate sequences. - qiime2 + qiime2 - + - Join paired-end reads. - qiime2 + qiime2 - + - De novo chimera filtering with vsearch. - qiime2 + qiime2 - + - Reference-based chimera filtering with vsearch. - qiime2 + qiime2 -# -#For each reference database, you need to download the qza file in qiime path -# - diff -r d66c7509e8f9 -r f190567fe3f6 tool_data/ref_taxnonomy.loc --- a/tool_data/ref_taxnonomy.loc Tue Aug 13 07:57:53 2019 -0400 +++ /dev/null Thu Jan 01 00:00:00 1970 +0000 @@ -1,5 +0,0 @@ -# -# -#For each reference database, you need to download the qza file in qiime path -# - diff -r d66c7509e8f9 -r f190567fe3f6 tool_data_table_conf.xml.sample --- a/tool_data_table_conf.xml.sample Tue Aug 13 07:57:53 2019 -0400 +++ b/tool_data_table_conf.xml.sample Wed Aug 14 15:12:48 2019 -0400 @@ -1,11 +1,12 @@ value, name, dbkey, path - +
value, name, dbkey, path - +
+