From f4328a531a0be876c275494f17d8894cdb492b23 Mon Sep 17 00:00:00 2001 From: github-actions Date: Tue, 4 Jun 2024 10:53:27 +0000 Subject: [PATCH] fetch all tools bot - step fetch --- results/repositories03.list_tools.json | 19586 +++++++++++++++++++++++ results/repositories03.list_tools.tsv | 200 +- 2 files changed, 19674 insertions(+), 112 deletions(-) create mode 100644 results/repositories03.list_tools.json diff --git a/results/repositories03.list_tools.json b/results/repositories03.list_tools.json new file mode 100644 index 00000000..a50f283b --- /dev/null +++ b/results/repositories03.list_tools.json @@ -0,0 +1,19586 @@ +[ + { + "Galaxy wrapper id": "TrimNs", + "Galaxy tool ids": [ + "trimns" + ], + "Description": "TrimNs is used to trim and remove fake cut sites from bionano hybrid scaffold data in the VGP pipeline", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/VGP/vgp-assembly/tree/master/pipeline/bionano/trimNs", + "ToolShed categories": [ + "Assembly" + ], + "ToolShed id": "trimns", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/trimN", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/TrimNs", + "Galaxy wrapper version": "0.1.0", + "Conda id": "trimns_vgp", + "Conda version": "1.0" + }, + { + "Galaxy wrapper id": "abricate", + "Galaxy tool ids": [ + "abricate", + "abricate_list", + "abricate_summary" + ], + "Description": "Mass screening of contigs for antiobiotic resistance genes", + "bio.tool id": "ABRicate", + "bio.tool ids": [ + "ABRicate" + ], + "biii": null, + "bio.tool name": "ABRicate", + "bio.tool description": "Mass screening of contigs for antimicrobial resistance or virulence genes.", + "EDAM operation": [ + "Antimicrobial resistance prediction" + ], + "EDAM topic": [ + "Genomics", + "Microbiology" + ], + "Status": "Up-to-date", + "Source": "https://github.com/tseemann/abricate", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "abricate", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/abricate/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/abricate", + "Galaxy wrapper version": "1.0.1", + "Conda id": "abricate", + "Conda version": "1.0.1" + }, + { + "Galaxy wrapper id": "abritamr", + "Galaxy tool ids": [ + "abritamr" + ], + "Description": "A pipeline for running AMRfinderPlus and collating results into functional classes", + "bio.tool id": "abritamr", + "bio.tool ids": [ + "abritamr" + ], + "biii": null, + "bio.tool name": "abriTAMR", + "bio.tool description": "an AMR gene detection pipeline that runs AMRFinderPlus on a single (or list ) of given isolates and collates the results into a table, separating genes identified into functionally relevant groups.", + "EDAM operation": [ + "Antimicrobial resistance prediction" + ], + "EDAM topic": [ + "Microbiology", + "Public health and epidemiology", + "Infectious disease" + ], + "Status": "To update", + "Source": "https://zenodo.org/record/7370628", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "abritamr", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/abritamr", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/abritamr", + "Galaxy wrapper version": "1.0.14", + "Conda id": "abritamr", + "Conda version": "1.0.17" + }, + { + "Galaxy wrapper id": "abyss", + "Galaxy tool ids": [ + "abyss-pe" + ], + "Description": "Assembly By Short Sequences - a de novo, parallel, paired-end sequence assembler", + "bio.tool id": "abyss", + "bio.tool ids": [ + "abyss" + ], + "biii": null, + "bio.tool name": "ABySS", + "bio.tool description": "De novo genome sequence assembler using short reads.", + "EDAM operation": [ + "Genome assembly", + "De-novo assembly", + "Scaffolding" + ], + "EDAM topic": [ + "Sequence assembly" + ], + "Status": "Up-to-date", + "Source": "http://www.bcgsc.ca/platform/bioinfo/software/abyss", + "ToolShed categories": [ + "Assembly" + ], + "ToolShed id": "abyss", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/abyss", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/abyss", + "Galaxy wrapper version": "2.3.7", + "Conda id": "abyss", + "Conda version": "2.3.7" + }, + { + "Galaxy wrapper id": "adapter_removal", + "Galaxy tool ids": [ + "adapter_removal" + ], + "Description": "Removes residual adapter sequences from single-end (SE) or paired-end (PE) FASTQ reads.", + "bio.tool id": "adapterremoval", + "bio.tool ids": [ + "adapterremoval" + ], + "biii": null, + "bio.tool name": "AdapterRemoval", + "bio.tool description": "AdapterRemoval searches for and removes adapter sequences from High-Throughput Sequencing (HTS) data and (optionally) trims low quality bases from the 3' end of reads following adapter removal. AdapterRemoval can analyze both single end and paired end data, and can be used to merge overlapping paired-ended reads into (longer) consensus sequences. Additionally, AdapterRemoval can construct a consensus adapter sequence for paired-ended reads, if which this information is not available.", + "EDAM operation": [ + "Sequence trimming", + "Sequence merging", + "Primer removal" + ], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/MikkelSchubert/adapterremoval", + "ToolShed categories": [ + "Fasta Manipulation", + "Sequence Analysis" + ], + "ToolShed id": "adapter_removal", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/adapter_removal/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/adapter_removal", + "Galaxy wrapper version": "2.3.3", + "Conda id": "adapterremoval", + "Conda version": "2.3.3" + }, + { + "Galaxy wrapper id": "add_input_name_as_column", + "Galaxy tool ids": [ + "addName" + ], + "Description": "Add input name as column on an existing tabular file", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/add_input_name_as_column", + "ToolShed categories": [ + "Text Manipulation" + ], + "ToolShed id": "add_input_name_as_column", + "Galaxy wrapper owner": "mvdbeek", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/add_input_name_as_column", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/add_input_name_as_column", + "Galaxy wrapper version": "0.2.0", + "Conda id": "python", + "Conda version": null + }, + { + "Galaxy wrapper id": "aegean", + "Galaxy tool ids": [ + "aegean_canongff3", + "aegean_gaeval", + "aegean_locuspocus", + "aegean_parseval" + ], + "Description": "AEGeAn toolkit wrappers", + "bio.tool id": "gaeval", + "bio.tool ids": [ + "gaeval" + ], + "biii": null, + "bio.tool name": "GAEVAL", + "bio.tool description": "Gene Annotation EVAluation.", + "EDAM operation": [ + "Sequence annotation" + ], + "EDAM topic": [ + "Sequence analysis", + "Gene structure" + ], + "Status": "Up-to-date", + "Source": "https://github.com/BrendelGroup/AEGeAn", + "ToolShed categories": [ + "Transcriptomics", + "Sequence Analysis" + ], + "ToolShed id": "aegean", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/aegean", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/aegean", + "Galaxy wrapper version": "0.16.0", + "Conda id": "aegean", + "Conda version": "0.16.0" + }, + { + "Galaxy wrapper id": "aldex2", + "Galaxy tool ids": [ + "aldex2" + ], + "Description": "Performs analysis Of differential abundance taking sample variation into account", + "bio.tool id": "aldex2", + "bio.tool ids": [ + "aldex2" + ], + "biii": null, + "bio.tool name": "ALDEx2", + "bio.tool description": "A differential abundance analysis for the comparison of two or more conditions. It uses a Dirichlet-multinomial model to infer abundance from counts, that has been optimized for three or more experimental replicates. Infers sampling variation and calculates the expected FDR given the biological and sampling variation using the Wilcox rank test and Welches t-test, or the glm and Kruskal Wallis tests. Reports both P and fdr values calculated by the Benjamini Hochberg correction.", + "EDAM operation": [ + "Statistical inference" + ], + "EDAM topic": [ + "Gene expression", + "Statistics and probability" + ], + "Status": "To update", + "Source": "https://github.com/ggloor/ALDEx_bioc", + "ToolShed categories": [ + "Metagenomics" + ], + "ToolShed id": "aldex2", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/aldex2", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/aldex2", + "Galaxy wrapper version": "1.26.0", + "Conda id": "bioconductor-aldex2", + "Conda version": "1.34.0" + }, + { + "Galaxy wrapper id": "allegro", + "Galaxy tool ids": [ + "allegro" + ], + "Description": "Linkage and haplotype analysis from deCODE", + "bio.tool id": "allegro", + "bio.tool ids": [ + "allegro" + ], + "biii": null, + "bio.tool name": "Allegro", + "bio.tool description": "It does simultaneous discovery of cis-regulatory motifs and their associated expression profiles. Its input are DNA sequences (typically, promoters or 3\u2032 UTRs) and genome-wide expression profiles. Its output is the set of motifs found, and for each motif the set of genes it regulates (its transcriptional module). It is highly efficient and can analyze expression profiles of thousands of genes, measured across dozens of experimental conditions, along with all regulatory sequences in the genome.", + "EDAM operation": [ + "Sequence motif discovery" + ], + "EDAM topic": [ + "Sequence analysis", + "Transcription factors and regulatory sites", + "DNA" + ], + "Status": "To update", + "Source": "http://www.decode.com/software/", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "allegro", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/allegro/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/allegro", + "Galaxy wrapper version": "@VER@.0", + "Conda id": "allegro", + "Conda version": "3" + }, + { + "Galaxy wrapper id": "amplican", + "Galaxy tool ids": [ + "amplican" + ], + "Description": "AmpliCan is an analysis tool for genome editing.", + "bio.tool id": "amplican", + "bio.tool ids": [ + "amplican" + ], + "biii": null, + "bio.tool name": "amplican", + "bio.tool description": "It performs alignment of the amplicon reads, normalizes gathered data, calculates multiple statistics (e.g. cut rates, frameshifts) and presents results in form of aggregated reports. Data and statistics can be broken down by experiments, barcodes, user defined groups, guides and amplicons allowing for quick identification of potential problems.", + "EDAM operation": [ + "Alignment", + "Standardisation and normalisation" + ], + "EDAM topic": [ + "PCR experiment", + "Statistics and probability" + ], + "Status": "To update", + "Source": "https://github.com/valenlab/amplican", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "amplican", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/amplican", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/amplican", + "Galaxy wrapper version": "1.14.0", + "Conda id": "bioconductor-amplican", + "Conda version": "1.24.0" + }, + { + "Galaxy wrapper id": "ampvis2", + "Galaxy tool ids": [ + "ampvis2_alpha_diversity", + "ampvis2_boxplot", + "ampvis2_core", + "ampvis2_export_fasta", + "ampvis2_frequency", + "ampvis2_heatmap", + "ampvis2_load", + "ampvis2_merge_ampvis2", + "ampvis2_mergereplicates", + "ampvis2_octave", + "ampvis2_ordinate", + "ampvis2_otu_network", + "ampvis2_rankabundance", + "ampvis2_rarecurve", + "ampvis2_setmetadata", + "ampvis2_subset_samples", + "ampvis2_subset_taxa", + "ampvis2_timeseries", + "ampvis2_venn" + ], + "Description": "ampvis2", + "bio.tool id": "ampvis", + "bio.tool ids": [ + "ampvis" + ], + "biii": null, + "bio.tool name": "ampvis", + "bio.tool description": "ampvis2 is an R-package to conveniently visualise and analyse 16S rRNA amplicon data in different ways.", + "EDAM operation": [ + "Analysis", + "Visualisation" + ], + "EDAM topic": [ + "Biodiversity" + ], + "Status": "To update", + "Source": "https://github.com/MadsAlbertsen/ampvis2/", + "ToolShed categories": [ + "Metagenomics" + ], + "ToolShed id": "ampvis2", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/ampvis2", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/ampvis2", + "Galaxy wrapper version": "2.8.6", + "Conda id": null, + "Conda version": null + }, + { + "Galaxy wrapper id": "amrfinderplus", + "Galaxy tool ids": [ + "amrfinderplus" + ], + "Description": "\"AMRFinderPlus is designed to find acquired antimicrobial resistance genes and point mutations in protein and/or assembled nucleotide sequences.It can also search \"plus\", stress, heat, and biocide resistance and virulence factors for some organisms.", + "bio.tool id": "amrfinderplus", + "bio.tool ids": [ + "amrfinderplus" + ], + "biii": null, + "bio.tool name": "AMRFinderPlus", + "bio.tool description": "AMRFinderPlus is designed to find acquired antimicrobial resistance genes and point mutations in protein and/or assembled nucleotide sequences.It can also search \"plus\", stress, heat, and biocide resistance and virulence factors for some organisms", + "EDAM operation": [ + "Antimicrobial resistance prediction" + ], + "EDAM topic": [ + "Microbiology", + "Public health and epidemiology", + "Infectious disease" + ], + "Status": "Up-to-date", + "Source": "https://github.com/ncbi/amr", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "AMRFinderPlus", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/blob/master/tools/amrfinderplus", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/amrfinderplus", + "Galaxy wrapper version": "3.12.8", + "Conda id": "ncbi-amrfinderplus", + "Conda version": "3.12.8" + }, + { + "Galaxy wrapper id": "ancombc", + "Galaxy tool ids": [ + "ancombc" + ], + "Description": "Performs analysis of compositions of microbiomes with bias correction.", + "bio.tool id": "ancombc", + "bio.tool ids": [ + "ancombc" + ], + "biii": null, + "bio.tool name": "ANCOMBC", + "bio.tool description": "Determine taxa whose absolute abundances, per unit volume, of the ecosystem (e.g. gut) are significantly different with changes in the covariate of interest (e.g. group). The current version of ancombc function implements Analysis of Compositions of Microbiomes with Bias Correction (ANCOM-BC) in cross-sectional data while allowing for covariate adjustment.", + "EDAM operation": [ + "DNA barcoding" + ], + "EDAM topic": [ + "Microbial ecology", + "Metagenomics", + "Taxonomy" + ], + "Status": "To update", + "Source": "https://github.com/FrederickHuangLin/ANCOMBC", + "ToolShed categories": [ + "Metagenomics" + ], + "ToolShed id": "ancombc", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/ancombc", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/ancombc", + "Galaxy wrapper version": "1.4.0", + "Conda id": "bioconductor-ancombc", + "Conda version": "2.4.0" + }, + { + "Galaxy wrapper id": "anndata", + "Galaxy tool ids": [ + "anndata_export", + "anndata_import", + "anndata_inspect", + "anndata_manipulate", + "modify_loom" + ], + "Description": "Import, Export, Inspect and Manipulate Anndata and Loom objects", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://anndata.readthedocs.io", + "ToolShed categories": [ + "Transcriptomics", + "Sequence Analysis" + ], + "ToolShed id": "anndata", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/anndata/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/anndata", + "Galaxy wrapper version": "0.10.3", + "Conda id": "anndata", + "Conda version": "0.6.22.post1" + }, + { + "Galaxy wrapper id": "annotatemyids", + "Galaxy tool ids": [ + "annotatemyids" + ], + "Description": "annotateMyIDs: get annotation for a set of IDs using the Bioconductor annotation packages", + "bio.tool id": "annotatemyids", + "bio.tool ids": [ + "annotatemyids" + ], + "biii": null, + "bio.tool name": "annotatemyids", + "bio.tool description": "This tool can get annotation for a generic set of IDs, using the Bioconductor annotation data packages. Supported organisms are human, mouse, rat, fruit fly and zebrafish. The org.db packages that are used here are primarily based on mapping using Entrez Gene identifiers. More information on the annotation packages can be found at the Bioconductor website, for example, information on the human annotation package (org.Hs.eg.db) can be found here.", + "EDAM operation": [ + "Annotation" + ], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/annotatemyids", + "ToolShed categories": [ + "Genome annotation" + ], + "ToolShed id": "annotatemyids", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/annotatemyids", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/annotatemyids", + "Galaxy wrapper version": "3.18.0", + "Conda id": "bioconductor-org.hs.eg.db", + "Conda version": "3.18.0" + }, + { + "Galaxy wrapper id": "arriba", + "Galaxy tool ids": [ + "arriba", + "arriba_draw_fusions", + "arriba_get_filters" + ], + "Description": "Arriba detects fusion genes in RNA-Seq data after running RNA-STAR", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/suhrig/arriba", + "ToolShed categories": [ + "Sequence Analysis", + "Transcriptomics" + ], + "ToolShed id": "arriba", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/arriba", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/arriba", + "Galaxy wrapper version": "2.4.0", + "Conda id": "arriba", + "Conda version": "2.4.0" + }, + { + "Galaxy wrapper id": "art", + "Galaxy tool ids": [ + "art_454", + "art_illumina", + "art_solid" + ], + "Description": "Simulator for Illumina, 454, and SOLiD sequencing data", + "bio.tool id": "art", + "bio.tool ids": [ + "art" + ], + "biii": null, + "bio.tool name": "ART", + "bio.tool description": "ART is a set of simulation tools to generate synthetic next-generation sequencing reads. ART simulates sequencing reads by mimicking real sequencing process with empirical error models or quality profiles summarized from large recalibrated sequencing data. ART can also simulate reads using user own read error model or quality profiles. ART supports simulation of single-end, paired-end/mate-pair reads of three major commercial next-generation sequencing platforms. Illuminas Solexa, Roches 454 and Applied Biosystems SOLiD", + "EDAM operation": [ + "Conversion" + ], + "EDAM topic": [ + "Bioinformatics" + ], + "Status": "To update", + "Source": null, + "ToolShed categories": [ + "Sequence Analysis", + "Data Source" + ], + "ToolShed id": "art", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/art", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/art", + "Galaxy wrapper version": "2014.11.03.0", + "Conda id": "art", + "Conda version": "2016.06.05" + }, + { + "Galaxy wrapper id": "artic", + "Galaxy tool ids": [ + "artic_guppyplex", + "artic_minion" + ], + "Description": "The artic pipeline is designed to help run the artic bioinformatics protocols;for example the nCoV-2019 novel coronavirus protocol.Features include: read filtering, primer trimming, amplicon coverage normalisation,variant calling and consensus building", + "bio.tool id": "artic", + "bio.tool ids": [ + "artic" + ], + "biii": null, + "bio.tool name": "ARTIC", + "bio.tool description": "A bioinformatics pipeline for working with virus sequencing data sequenced with nanopore", + "EDAM operation": [ + "Sequence alignment" + ], + "EDAM topic": [ + "Genomics" + ], + "Status": "To update", + "Source": "https://github.com/artic-network/fieldbioinformatics", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": null, + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/artic", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/artic", + "Galaxy wrapper version": null, + "Conda id": "artic", + "Conda version": "1.2.4" + }, + { + "Galaxy wrapper id": "assembly-stats", + "Galaxy tool ids": [ + "assembly_stats" + ], + "Description": "Assembly metric visualisations to facilitate rapid assessment and comparison of assembly quality.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/rjchallis/assembly-stats", + "ToolShed categories": [ + "Assembly" + ], + "ToolShed id": "assembly_stats", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/assembly-stats", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/assembly-stats", + "Galaxy wrapper version": "17.02", + "Conda id": "rjchallis-assembly-stats", + "Conda version": "17.02" + }, + { + "Galaxy wrapper id": "augustus", + "Galaxy tool ids": [ + "augustus", + "augustus_training" + ], + "Description": "AUGUSTUS is a program that predicts genes in eukaryotic genomic sequences.", + "bio.tool id": "augustus", + "bio.tool ids": [ + "augustus" + ], + "biii": null, + "bio.tool name": "AUGUSTUS", + "bio.tool description": "AUGUSTUS is a eukaryotic gene prediction tool. It can integrate evidence, e.g. from RNA-Seq, ESTs, proteomics, but can also predict genes ab initio. The PPX extension to AUGUSTUS can take a protein sequence multiple sequence alignment as input to find new members of the family in a genome. It can be run through a web interface (see https://bio.tools/webaugustus), or downloaded and run locally.", + "EDAM operation": [ + "Gene prediction", + "Ab-initio gene prediction", + "Homology-based gene prediction", + "Homology-based gene prediction", + "Operation" + ], + "EDAM topic": [ + "Gene transcripts", + "Gene and protein families" + ], + "Status": "To update", + "Source": "http://bioinf.uni-greifswald.de/augustus/", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "augustus", + "Galaxy wrapper owner": "bgruening", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/augustus", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/augustus", + "Galaxy wrapper version": "3.4.0", + "Conda id": "augustus", + "Conda version": "3.5.0" + }, + { + "Galaxy wrapper id": "b2btools", + "Galaxy tool ids": [ + "b2btools_single_sequence" + ], + "Description": "This software suite provides structural predictions for protein sequences made by Bio2Byte group.About Bio2Byte: We investigate how the dynamics, conformational states, and available experimental data of proteins relate to their amino acid sequence.Underlying physical and chemical principles are computationally unraveled through data integration, analysis, and machine learning, so connecting themto biological events and improving our understanding of the way proteins work.", + "bio.tool id": "b2btools", + "bio.tool ids": [ + "b2btools" + ], + "biii": null, + "bio.tool name": "b2bTools", + "bio.tool description": "The bio2byte tools server (b2btools) offers the following single protein sequence based predictions:- Backbone and sidechain dynamics (DynaMine)- Helix, sheet, coil and polyproline-II propensity- Early folding propensity (EFoldMine)- Disorder (DisoMine)- Beta-sheet aggregation (Agmata)In addition, multiple sequence alignments (MSAs) can be uploaded to scan the 'biophysical limits' of a protein family as defined in the MSA", + "EDAM operation": [ + "Protein disorder prediction", + "Protein secondary structure prediction", + "Protein feature detection" + ], + "EDAM topic": [], + "Status": "To update", + "Source": "https://bio2byte.be", + "ToolShed categories": [ + "Computational chemistry", + "Molecular Dynamics", + "Proteomics", + "Sequence Analysis", + "Synthetic Biology" + ], + "ToolShed id": null, + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": null, + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/b2btools", + "Galaxy wrapper version": "3.0.5+galaxy0", + "Conda id": "b2btools", + "Conda version": "3.0.6" + }, + { + "Galaxy wrapper id": "bakta", + "Galaxy tool ids": [ + "bakta" + ], + "Description": "\"Bakta is a tool for the rapid & standardized annotation of bacterial genomes and plasmids from both isolates and MAGs.It provides dbxref-rich and sORF-including annotations in machine-readable JSON & bioinformatics standard file formats for automatic downstream analysis.\"", + "bio.tool id": "bakta", + "bio.tool ids": [ + "bakta" + ], + "biii": null, + "bio.tool name": "Bakta", + "bio.tool description": "Rapid & standardized annotation of bacterial genomes, MAGs & plasmids", + "EDAM operation": [ + "Genome annotation" + ], + "EDAM topic": [ + "Genomics", + "Data submission, annotation and curation", + "Sequence analysis" + ], + "Status": "Up-to-date", + "Source": "https://github.com/oschwengers/bakta", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "bakta", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/blob/master/tools/bakta", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/bakta", + "Galaxy wrapper version": "1.9.3", + "Conda id": "bakta", + "Conda version": "1.9.3" + }, + { + "Galaxy wrapper id": "bam_to_scidx", + "Galaxy tool ids": [ + "bam_to_scidx" + ], + "Description": "Contains a tool that converts a BAM file to an ScIdx file.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/seqcode/cegr-tools/tree/master/src/org/seqcode/cegrtools/bamtoscidx", + "ToolShed categories": [ + "Convert Formats" + ], + "ToolShed id": "bam_to_scidx", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/bam_to_scidx", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/bam_to_scidx", + "Galaxy wrapper version": "1.0.1", + "Conda id": "openjdk", + "Conda version": null + }, + { + "Galaxy wrapper id": "bamutil", + "Galaxy tool ids": [ + "bamutil_clip_overlap", + "bamutil_diff" + ], + "Description": "bamUtil is a repository that contains several programs that perform operations on SAM/BAM files.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/statgen/bamUtil", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "bamutil", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/bamutil", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/bamutil", + "Galaxy wrapper version": null, + "Conda id": "bamutil", + "Conda version": "1.0.15" + }, + { + "Galaxy wrapper id": "bandage", + "Galaxy tool ids": [ + "bandage_image", + "bandage_info" + ], + "Description": "Bandage - A Bioinformatics Application for Navigating De novo Assembly Graphs Easily", + "bio.tool id": "bandage", + "bio.tool ids": [ + "bandage" + ], + "biii": null, + "bio.tool name": "Bandage", + "bio.tool description": "GUI program that allows users to interact with the assembly graphs made by de novo assemblers such as Velvet, SPAdes, MEGAHIT and others. It visualises assembly graphs, with connections, using graph layout algorithms.", + "EDAM operation": [ + "Sequence assembly visualisation" + ], + "EDAM topic": [ + "Genomics", + "Sequence assembly" + ], + "Status": "Up-to-date", + "Source": "https://github.com/rrwick/Bandage", + "ToolShed categories": [ + "Visualization" + ], + "ToolShed id": "bandage", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/bandage", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/bandage", + "Galaxy wrapper version": "2022.09", + "Conda id": "bandage_ng", + "Conda version": "2022.09" + }, + { + "Galaxy wrapper id": "barcode_splitter", + "Galaxy tool ids": [ + "barcode_splitter" + ], + "Description": "A utility to split sequence files using multiple sets of barcodes", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://bitbucket.org/princeton_genomics/barcode_splitter/", + "ToolShed categories": [ + "Fastq Manipulation" + ], + "ToolShed id": "barcode_splitter", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/barcode_splitter", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/barcode_splitter", + "Galaxy wrapper version": "0.18.4.0", + "Conda id": "barcode_splitter", + "Conda version": "0.18.6" + }, + { + "Galaxy wrapper id": "baredsc", + "Galaxy tool ids": [ + "baredsc_1d", + "baredsc_2d", + "baredsc_combine_1d", + "baredsc_combine_2d" + ], + "Description": "baredSC is a tool that uses a Monte-Carlo Markov Chain to estimate a confidence interval on the probability density function (PDF) of expression of one or two genes from single-cell RNA-seq data.", + "bio.tool id": "baredsc", + "bio.tool ids": [ + "baredsc" + ], + "biii": null, + "bio.tool name": "baredSC", + "bio.tool description": "The baredSC (Bayesian Approach to Retreive Expression Distribution of Single Cell) is a tool that uses a Monte-Carlo Markov Chain to estimate a confidence interval on the probability density function (PDF) of expression of one or two genes from single-cell RNA-seq data.", + "EDAM operation": [ + "Data retrieval", + "Expression correlation analysis", + "Differential gene expression profiling" + ], + "EDAM topic": [ + "RNA-Seq", + "Cytometry", + "Transcriptomics", + "Gene transcripts", + "Statistics and probability" + ], + "Status": "Up-to-date", + "Source": "https://github.com/lldelisle/baredSC", + "ToolShed categories": [ + "Transcriptomics", + "Visualization" + ], + "ToolShed id": "baredsc", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/baredsc", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/baredsc", + "Galaxy wrapper version": "1.1.3", + "Conda id": "baredsc", + "Conda version": "1.1.3" + }, + { + "Galaxy wrapper id": "barrnap", + "Galaxy tool ids": [ + "barrnap" + ], + "Description": "Contains the Barrnap tool for finding ribosomal RNAs in FASTA sequences.", + "bio.tool id": "barrnap", + "bio.tool ids": [ + "barrnap" + ], + "biii": null, + "bio.tool name": "Barrnap", + "bio.tool description": "Predict the location of ribosomal RNA genes in genomes. It supports bacteria (5S,23S,16S), archaea (5S,5.8S,23S,16S), mitochondria (12S,16S) and eukaryotes (5S,5.8S,28S,18S).", + "EDAM operation": [ + "Gene prediction" + ], + "EDAM topic": [ + "Genomics", + "Model organisms", + "Model organisms" + ], + "Status": "To update", + "Source": null, + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "barrnap", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": null, + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/barrnap", + "Galaxy wrapper version": "1.2.2", + "Conda id": "barrnap", + "Conda version": "0.9" + }, + { + "Galaxy wrapper id": "basil", + "Galaxy tool ids": [ + "basil" + ], + "Description": "Breakpoint detection, including large insertions", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/seqan/anise_basil", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "basil", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": null, + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/basil", + "Galaxy wrapper version": "1.2.0", + "Conda id": "anise_basil", + "Conda version": "1.2.0" + }, + { + "Galaxy wrapper id": "bax2bam", + "Galaxy tool ids": [ + "bax2bam" + ], + "Description": "BAX to BAM converter", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/pacificbiosciences/bax2bam/", + "ToolShed categories": [ + "Convert Formats", + "Sequence Analysis" + ], + "ToolShed id": "bax2bam", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/pax2bam", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/bax2bam", + "Galaxy wrapper version": "0.0.11", + "Conda id": "bax2bam", + "Conda version": "0.0.11" + }, + { + "Galaxy wrapper id": "bayescan", + "Galaxy tool ids": [ + "BayeScan" + ], + "Description": "Detecting natural selection from population-based genetic data", + "bio.tool id": "bayescan", + "bio.tool ids": [ + "bayescan" + ], + "biii": null, + "bio.tool name": "BayeScan", + "bio.tool description": "BAYEsian genome SCAN for outliers, aims at identifying candidate loci under natural selection from genetic data, using differences in allele frequencies between populations. It is based on the multinomial-Dirichlet model.", + "EDAM operation": [ + "Statistical inference" + ], + "EDAM topic": [ + "Genetics", + "Evolutionary biology", + "Statistics and probability", + "DNA polymorphism" + ], + "Status": "To update", + "Source": "http://cmpg.unibe.ch/software/BayeScan/index.html", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "bayescan", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/bayescan/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/bayescan", + "Galaxy wrapper version": "2.1", + "Conda id": "bayescan", + "Conda version": "2.0.1" + }, + { + "Galaxy wrapper id": "bbtools", + "Galaxy tool ids": [ + "bbtools_bbduk", + "bbtools_bbmap", + "bbtools_bbmerge", + "bbtools_bbnorm", + "bbtools_callvariants", + "bbtools_tadpole" + ], + "Description": "BBTools is a suite of fast, multithreaded bioinformatics tools designed for analysis of DNA and RNA sequence data.BBTools can handle common sequencing file formats such as fastq, fasta, sam, scarf, fasta+qual, compressed or raw,with autodetection of quality encoding and interleaving. It is written in Java and works on any platform supportingJava, including Linux, MacOS, and Microsoft Windows and Linux; there are no dependencies other than Java (version7 or higher). Program descriptions and options are shown when running the shell scripts with no parameters.", + "bio.tool id": "bbmap", + "bio.tool ids": [ + "bbmap", + "bbtools" + ], + "biii": null, + "bio.tool name": "BBMap", + "bio.tool description": "BBMap is a fast splice-aware aligner for RNA and DNA. It is faster than almost all short-read aligners, yet retains unrivaled sensitivity and specificity, particularly for reads with many errors and indels.", + "EDAM operation": [ + "RNA-Seq analysis", + "Sequence trimming", + "Read mapping", + "Sequence contamination filtering", + "Read binning", + "Sequence alignment" + ], + "EDAM topic": [ + "Sequencing", + "RNA splicing", + "Whole genome sequencing", + "Phylogenetics", + "Metagenomics", + "RNA-Seq" + ], + "Status": "Up-to-date", + "Source": "https://jgi.doe.gov/data-and-tools/bbtools/", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "bbtools", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/bbtools", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/bbtools", + "Galaxy wrapper version": "39.06", + "Conda id": "bbmap", + "Conda version": "39.06" + }, + { + "Galaxy wrapper id": "bcftools", + "Galaxy tool ids": [ + "bcftools_@EXECUTABLE@", + "bcftools_@EXECUTABLE@", + "bcftools_@EXECUTABLE@", + "bcftools_@EXECUTABLE@", + "bcftools_@EXECUTABLE@", + "bcftools_@EXECUTABLE@_from_vcf", + "bcftools_@EXECUTABLE@_to_vcf", + "bcftools_@EXECUTABLE@", + "bcftools_@EXECUTABLE@", + "bcftools_@EXECUTABLE@", + "bcftools_@EXECUTABLE@", + "bcftools_@EXECUTABLE@", + "bcftools_@EXECUTABLE@", + "bcftools_@EXECUTABLE@", + "bcftools_plugin_@PLUGIN_ID@", + "bcftools_plugin_@PLUGIN_ID@", + "bcftools_plugin_@PLUGIN_ID@", + "bcftools_plugin_@PLUGIN_ID@", + "bcftools_plugin_@PLUGIN_ID@", + "bcftools_plugin_@PLUGIN_ID@", + "bcftools_plugin_@PLUGIN_ID@", + "bcftools_plugin_@PLUGIN_ID@", + "bcftools_plugin_@PLUGIN_ID@", + "bcftools_plugin_@PLUGIN_ID@", + "bcftools_plugin_@PLUGIN_ID@", + "bcftools_plugin_@PLUGIN_ID@", + "bcftools_plugin_@PLUGIN_ID@", + "bcftools_@EXECUTABLE@", + "bcftools_@EXECUTABLE@_list_samples", + "bcftools_@EXECUTABLE@", + "bcftools_@EXECUTABLE@", + "bcftools_@EXECUTABLE@", + "bcftools_@EXECUTABLE@" + ], + "Description": "BCFtools toolkit wrappers", + "bio.tool id": "bcftools", + "bio.tool ids": [ + "bcftools" + ], + "biii": null, + "bio.tool name": "BCFtools", + "bio.tool description": "BCFtools is a set of utilities that manipulate variant calls in the Variant Call Format (VCF) and its binary counterpart BCF. All commands work transparently with both VCFs and BCFs, both uncompressed and BGZF-compressed.", + "EDAM operation": [ + "Data handling", + "Variant calling" + ], + "EDAM topic": [ + "Genetic variation", + "DNA polymorphism", + "GWAS study", + "Genotyping experiment" + ], + "Status": "To update", + "Source": "https://samtools.github.io/bcftools/", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": null, + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/bcftools", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/bcftools", + "Galaxy wrapper version": "1.15.1", + "Conda id": "bcftools", + "Conda version": "1.20" + }, + { + "Galaxy wrapper id": "bctools", + "Galaxy tool ids": [ + "bctools_convert_to_binary_barcode", + "bctools_extract_crosslinked_nucleotides", + "bctools_extract_alignment_ends", + "bctools_extract_barcodes", + "bctools_merge_pcr_duplicates", + "bctools_remove_tail", + "bctools_remove_spurious_events" + ], + "Description": "bctools is a set of tools for handling barcodes and UMIs in NGS data.bctools can be used to merge PCR duplicates according to unique molecular barcodes (UMIs),to extract barcodes from arbitrary positions relative to the read starts,to clean up readthroughs into UMIs with paired-end sequencing andhandles binary barcodes as used with uvCLAP and FLASH.License: Apache License 2.0", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/dmaticzka/bctools", + "ToolShed categories": [ + "Sequence Analysis", + "Transcriptomics" + ], + "ToolShed id": null, + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/bedtools", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/bctools", + "Galaxy wrapper version": "0.2.2", + "Conda id": "bctools", + "Conda version": "0.2.2" + }, + { + "Galaxy wrapper id": "beacon2", + "Galaxy tool ids": [ + "beacon2_csv2xlsx", + "beacon2_pxf2bff", + "beacon2_vcf2bff" + ], + "Description": "beacon2-ri-tools are part of the ELIXIR-CRG Beacon v2 Reference Implementation (B2RI).", + "bio.tool id": "ga4gh_beacon", + "bio.tool ids": [ + "ga4gh_beacon" + ], + "biii": null, + "bio.tool name": "GA4GH Beacon", + "bio.tool description": "A global search engine for genetic mutations.", + "EDAM operation": [ + "Service discovery", + "Database search", + "Genetic variation analysis" + ], + "EDAM topic": [ + "Genetic variation", + "Population genetics", + "Data security", + "Rare diseases" + ], + "Status": "Up-to-date", + "Source": "https://github.com/EGA-archive/beacon2-ri-tools/tree/main", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "beacon2", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/beacon2", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/beacon2", + "Galaxy wrapper version": "2.0.0", + "Conda id": "beacon2-ri-tools", + "Conda version": "2.0.0" + }, + { + "Galaxy wrapper id": "beagle", + "Galaxy tool ids": [ + "beagle" + ], + "Description": "Beagle is a program for phasing and imputing missing genotypes.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://faculty.washington.edu/browning/beagle/beagle.html", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "beagle", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/beagle", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/beagle", + "Galaxy wrapper version": "5.2_21Apr21.304", + "Conda id": "beagle", + "Conda version": "5.4_22Jul22.46e" + }, + { + "Galaxy wrapper id": "bedops", + "Galaxy tool ids": [ + "bedops-sort-bed" + ], + "Description": "BEDOPS: high-performance genomic feature operations", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://bedops.readthedocs.io/en/latest/", + "ToolShed categories": [ + "Genomic Interval Operations" + ], + "ToolShed id": "bedops_sortbed", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://bedops.readthedocs.io/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/bedops", + "Galaxy wrapper version": "2.4.41", + "Conda id": "bedops", + "Conda version": "2.4.41" + }, + { + "Galaxy wrapper id": "bedtools", + "Galaxy tool ids": [ + "bedtools_annotatebed", + "bedtools_bamtobed", + "bedtools_bed12tobed6", + "bedtools_bedtobam", + "bedtools_bedtoigv", + "bedtools_bedpetobam", + "bedtools_closestbed", + "bedtools_clusterbed", + "bedtools_complementbed", + "bedtools_coveragebed", + "bedtools_expandbed", + "bedtools_fisher", + "bedtools_flankbed", + "bedtools_genomecoveragebed", + "bedtools_getfastabed", + "bedtools_groupbybed", + "bedtools_intersectbed", + "bedtools_jaccard", + "bedtools_links", + "bedtools_makewindowsbed", + "bedtools_map", + "bedtools_maskfastabed", + "bedtools_mergebed", + "bedtools_multicovtbed", + "bedtools_multiintersectbed", + "bedtools_nucbed", + "bedtools_overlapbed", + "bedtools_randombed", + "bedtools_reldistbed", + "bedtools_shufflebed", + "bedtools_slopbed", + "bedtools_sortbed", + "bedtools_spacingbed", + "bedtools_subtractbed", + "bedtools_tagbed", + "bedtools_unionbedgraph", + "bedtools_windowbed" + ], + "Description": "bedtools is a powerful toolset for genome arithmetic", + "bio.tool id": "bedtools", + "bio.tool ids": [ + "bedtools" + ], + "biii": null, + "bio.tool name": "BEDTools", + "bio.tool description": "BEDTools is an extensive suite of utilities for comparing genomic features in BED format.", + "EDAM operation": [ + "Mapping" + ], + "EDAM topic": [ + "Genomics" + ], + "Status": "Up-to-date", + "Source": "https://github.com/arq5x/bedtools2", + "ToolShed categories": [ + "Genomic Interval Operations", + "Text Manipulation" + ], + "ToolShed id": "bedtools", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/bedtools", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/bedtools", + "Galaxy wrapper version": "2.31.1", + "Conda id": "bedtools", + "Conda version": "2.31.1" + }, + { + "Galaxy wrapper id": "bellerophon", + "Galaxy tool ids": [ + "bellerophon" + ], + "Description": "Filter mapped reads where the mapping spans a junction, retaining the 5-prime read.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/davebx/bellerophon", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "bellerophon", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/davebx/bellerophon", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/bellerophon", + "Galaxy wrapper version": "1.0", + "Conda id": "bellerophon", + "Conda version": "1.0" + }, + { + "Galaxy wrapper id": "berokka", + "Galaxy tool ids": [ + "berokka" + ], + "Description": "Berokka is used to trim, circularise, orient & filter long read bacterial genome assemblies.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/tseemann/berokka", + "ToolShed categories": [ + "Fasta Manipulation" + ], + "ToolShed id": "berokka", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/blob/master/tools/berokka", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/berokka", + "Galaxy wrapper version": "0.2.3", + "Conda id": "berokka", + "Conda version": null + }, + { + "Galaxy wrapper id": "bigscape", + "Galaxy tool ids": [ + "bigscape" + ], + "Description": "Construct sequence similarity networks of BGCs and groups them into GCF", + "bio.tool id": "BiG-SCAPE", + "bio.tool ids": [ + "BiG-SCAPE" + ], + "biii": null, + "bio.tool name": "BiG-SCAPE", + "bio.tool description": "A computational framework to explore large-scale biosynthetic diversity.BiG-SCAPE (Biosynthetic Gene Similarity Clustering and Prospecting Engine) is a software package, written in Python, that constructs sequence similarity networks of Biosynthetic Gene Clusters (BGCs) and groups them into Gene Cluster Families (GCFs). BiG-SCAPE does this by rapidly calculating a distance matrix between gene clusters based on a comparison of their protein domain content, order, copy number and sequence identity.It defines a distance metric between Gene Clusters using a combination of three indices (Jaccard Index of domain types, Domain Sequence Similarity the Adjacency...BiG-SCAPE and CORASON provide a set of tools to explore the diversity of biosynthetic gene clusters (BGCs) across large numbers of genomes, by constructing BGC sequence similarity networks, grouping BGCs into gene cluster families, and exploring gene cluster diversity linked to enzyme phylogenies.", + "EDAM operation": [ + "Clustering", + "Global alignment", + "Fold recognition" + ], + "EDAM topic": [ + "Phylogeny", + "Microbial ecology", + "Mapping", + "Metabolomics", + "Bioinformatics", + "Gene and protein families" + ], + "Status": "Up-to-date", + "Source": "https://github.com/medema-group/BiG-SCAPE", + "ToolShed categories": [ + "Metagenomics" + ], + "ToolShed id": "bigscape", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/bigscape/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/bigscape", + "Galaxy wrapper version": "1.1.9", + "Conda id": "bigscape", + "Conda version": "1.1.9" + }, + { + "Galaxy wrapper id": "binning_refiner", + "Galaxy tool ids": [ + "bin_refiner" + ], + "Description": "Reconciles the outputs of different binning programs with the aim to improve the quality of genome bins,especially with respect to contamination levels.", + "bio.tool id": "binning_refiner", + "bio.tool ids": [ + "binning_refiner" + ], + "biii": null, + "bio.tool name": "Binning_refiner", + "bio.tool description": "Improving genome bins through the combination of different binning programs", + "EDAM operation": [ + "Read binning", + "Sequence clustering" + ], + "EDAM topic": [ + "Metagenomics", + "Sequence assembly", + "Microbial ecology" + ], + "Status": "Up-to-date", + "Source": "https://github.com/songweizhi/Binning_refiner", + "ToolShed categories": [ + "Metagenomics" + ], + "ToolShed id": "binning_refiner", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/binning_refiner/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/binning_refiner", + "Galaxy wrapper version": "1.4.3", + "Conda id": "binning_refiner", + "Conda version": "1.4.3" + }, + { + "Galaxy wrapper id": "bioext", + "Galaxy tool ids": [ + "bioext_bam2msa", + "bioext_bealign" + ], + "Description": "A suite of Galaxy tools designed around the BioExt extension to BioPython. Align sequences, merge duplicate sequences into one, and more!", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://pypi.python.org/pypi/biopython-extensions/", + "ToolShed categories": [ + "Next Gen Mappers" + ], + "ToolShed id": null, + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/davebx/bioext-gx/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/bioext", + "Galaxy wrapper version": "0.21.2", + "Conda id": "python-bioext", + "Conda version": null + }, + { + "Galaxy wrapper id": "bioinformatics_cafe", + "Galaxy tool ids": [ + "fasta_regex_finder" + ], + "Description": "Miscellanea of scripts for bioinformatics", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/dariober/bioinformatics-cafe/", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "bioinformatics_cafe", + "Galaxy wrapper owner": "mbernt", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/bioinformatics-cafe", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/bioinformatics_cafe", + "Galaxy wrapper version": "0.1.0", + "Conda id": "python", + "Conda version": null + }, + { + "Galaxy wrapper id": "biom_format", + "Galaxy tool ids": [ + "biom_add_metadata", + "biom_convert", + "biom_from_uc", + "biom_normalize_table", + "biom_subset_table", + "biom_summarize_table" + ], + "Description": "The biom-format package provides a command line interface and Python API for working with BIOM files.", + "bio.tool id": "biomformat", + "bio.tool ids": [ + "biomformat" + ], + "biii": null, + "bio.tool name": "biomformat", + "bio.tool description": "This package includes basic tools for reading biom-format files, accessing and subsetting data tables from a biom object, as well as limited support for writing a biom-object back to a biom-format file. The design of this API is intended to match the python API and other tools included with the biom-format project, but with a decidedly \"R flavor\" that should be familiar to R users. This includes S4 classes and methods, as well as extensions of common core functions/methods.", + "EDAM operation": [ + "Formatting" + ], + "EDAM topic": [ + "Laboratory information management", + "Sequence analysis" + ], + "Status": "To update", + "Source": "https://github.com/biocore/biom-format", + "ToolShed categories": [ + "Metagenomics" + ], + "ToolShed id": null, + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/biom_format", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/biom_format", + "Galaxy wrapper version": "2.1.15", + "Conda id": "biom-format", + "Conda version": "2.1.7" + }, + { + "Galaxy wrapper id": "bioperl", + "Galaxy tool ids": [ + "bp_genbank2gff3" + ], + "Description": "Converts GenBank format files to GFF3", + "bio.tool id": "bioperl", + "bio.tool ids": [ + "bioperl" + ], + "biii": null, + "bio.tool name": "BioPerl", + "bio.tool description": "A collection of Perl modules that facilitate the development of Perl scripts for bioinformatics applications. It provides software modules for many of the typical tasks of bioinformatics programming.", + "EDAM operation": [ + "Data handling", + "Service invocation" + ], + "EDAM topic": [ + "Genomics", + "Software engineering", + "Data management" + ], + "Status": "To update", + "Source": "https://bioperl.org/", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "bp_genbank2gff3", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/bioperl", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/bioperl", + "Galaxy wrapper version": "1.1", + "Conda id": "perl-bioperl", + "Conda version": "1.7.8" + }, + { + "Galaxy wrapper id": "biscot", + "Galaxy tool ids": [ + "biscot" + ], + "Description": "Bionano scaffolding correction tool", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/institut-de-genomique/biscot", + "ToolShed categories": [ + "Assembly" + ], + "ToolShed id": "biscot", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/bgruening/iuc/tree/master/tools/biscot", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/biscot", + "Galaxy wrapper version": "2.3.3", + "Conda id": "biscot", + "Conda version": "2.3.3" + }, + { + "Galaxy wrapper id": "blast", + "Galaxy tool ids": [ + "magicblast" + ], + "Description": "Maps large next-generation RNA or DNA sequencing runs against a whole genome or transcriptome", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://ncbi.github.io/magicblast/", + "ToolShed categories": [ + "Next Gen Mappers" + ], + "ToolShed id": "magicblast", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/blast", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/blast", + "Galaxy wrapper version": "1.7.0", + "Conda id": "magicblast", + "Conda version": "1.7.0" + }, + { + "Galaxy wrapper id": "blastxml_to_gapped_gff3", + "Galaxy tool ids": [ + "blastxml_to_gapped_gff3" + ], + "Description": "BlastXML to gapped GFF3", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": null, + "ToolShed categories": [ + "Convert Formats", + "Sequence Analysis" + ], + "ToolShed id": "blastxml_to_gapped_gff3", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/blastxml_to_gapped_gff3", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/blastxml_to_gapped_gff3", + "Galaxy wrapper version": "1.1", + "Conda id": "bcbiogff", + "Conda version": "0.6.6" + }, + { + "Galaxy wrapper id": "bowtie2", + "Galaxy tool ids": [ + "bowtie2" + ], + "Description": "Bowtie2: Fast and sensitive read alignment", + "bio.tool id": "bowtie2", + "bio.tool ids": [ + "bowtie2" + ], + "biii": null, + "bio.tool name": "Bowtie 2", + "bio.tool description": "Bowtie 2 is an ultrafast and memory-efficient tool for aligning sequencing reads to long reference sequences. It is particularly good at aligning reads of about 50 up to 100s or 1,000s of characters, and particularly good at aligning to relatively long (e.g. mammalian) genomes. Bowtie 2 indexes the genome with an FM Index to keep its memory footprint small: for the human genome, its memory footprint is typically around 3.2 GB. Bowtie 2 supports gapped, local, and paired-end alignment modes.", + "EDAM operation": [ + "Read mapping" + ], + "EDAM topic": [ + "Mapping", + "Genomics", + "Mapping" + ], + "Status": "To update", + "Source": "http://bowtie-bio.sourceforge.net/bowtie2", + "ToolShed categories": [ + "Next Gen Mappers" + ], + "ToolShed id": "bowtie2", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/bowtie2", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/bowtie2", + "Galaxy wrapper version": "2.5.3", + "Conda id": "bowtie2", + "Conda version": "2.5.4" + }, + { + "Galaxy wrapper id": "bracken", + "Galaxy tool ids": [ + "est_abundance" + ], + "Description": "Bayesian Reestimation of Abundance with KrakEN", + "bio.tool id": "bracken", + "bio.tool ids": [ + "bracken" + ], + "biii": null, + "bio.tool name": "Bracken", + "bio.tool description": "Statistical method that computes the abundance of species in DNA sequences from a metagenomics sample.", + "EDAM operation": [ + "Statistical calculation" + ], + "EDAM topic": [ + "Metagenomics", + "Microbial ecology" + ], + "Status": "Up-to-date", + "Source": "https://ccb.jhu.edu/software/bracken/", + "ToolShed categories": [ + "Sequence Analysis", + "Metagenomics" + ], + "ToolShed id": "bracken", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/bracken", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/bracken", + "Galaxy wrapper version": "2.9", + "Conda id": "bracken", + "Conda version": "2.9" + }, + { + "Galaxy wrapper id": "breseq", + "Galaxy tool ids": [ + "breseq" + ], + "Description": "Predicts mutations in microbial genomes", + "bio.tool id": "breseq", + "bio.tool ids": [ + "breseq" + ], + "biii": null, + "bio.tool name": "breseq", + "bio.tool description": "Runs Breseq software on a set of fastq files.", + "EDAM operation": [ + "Polymorphism detection" + ], + "EDAM topic": [ + "Sequencing", + "Sequence analysis", + "DNA mutation" + ], + "Status": "To update", + "Source": "https://github.com/barricklab/breseq", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "breseq", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": null, + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/breseq", + "Galaxy wrapper version": "0.35.5", + "Conda id": "breseq", + "Conda version": "0.38.3" + }, + { + "Galaxy wrapper id": "busco", + "Galaxy tool ids": [ + "busco" + ], + "Description": "BUSCO assess genome and annotation completeness", + "bio.tool id": "busco", + "bio.tool ids": [ + "busco" + ], + "biii": null, + "bio.tool name": "BUSCO", + "bio.tool description": "Provides measures for quantitative assessment of genome assembly, gene set, and transcriptome completeness based on evolutionarily informed expectations of gene content from near-universal single-copy orthologs.", + "EDAM operation": [ + "Sequence assembly validation", + "Scaffolding", + "Genome assembly", + "Transcriptome assembly" + ], + "EDAM topic": [ + "Sequence assembly", + "Genomics", + "Transcriptomics", + "Sequence analysis" + ], + "Status": "To update", + "Source": "https://gitlab.com/ezlab/busco/-/releases", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "busco", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/busco/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/busco", + "Galaxy wrapper version": "5.5.0", + "Conda id": "busco", + "Conda version": "5.7.1" + }, + { + "Galaxy wrapper id": "bwa", + "Galaxy tool ids": [ + "bwa_mem", + "bwa" + ], + "Description": "Wrapper for bwa mem, aln, sampe, and samse", + "bio.tool id": "bwa", + "bio.tool ids": [ + "bwa" + ], + "biii": null, + "bio.tool name": "BWA", + "bio.tool description": "Fast, accurate, memory-efficient aligner for short and long sequencing reads", + "EDAM operation": [ + "Genome indexing", + "Sequence alignment", + "Read mapping", + "Sequence alignment", + "Generation", + "Sequence alignment", + "Generation", + "Sequence alignment", + "Sequence alignment" + ], + "EDAM topic": [ + "Mapping" + ], + "Status": "Up-to-date", + "Source": "http://bio-bwa.sourceforge.net/", + "ToolShed categories": [ + "Next Gen Mappers" + ], + "ToolShed id": "bwa", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/bwa", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/bwa", + "Galaxy wrapper version": "0.7.18", + "Conda id": "bwa", + "Conda version": "0.7.18" + }, + { + "Galaxy wrapper id": "bwa_mem2", + "Galaxy tool ids": [ + "bwa_mem2" + ], + "Description": "Bwa-mem2 is the next version of the bwa-mem algorithm in bwa.", + "bio.tool id": "bwa-mem2", + "bio.tool ids": [ + "bwa-mem2" + ], + "biii": null, + "bio.tool name": "Bwa-mem2", + "bio.tool description": "Bwa-mem2 is the next version of the bwa-mem algorithm in bwa. It produces alignment identical to bwa and is ~1.3-3.1x faster depending on the use-case, dataset and the running machine.", + "EDAM operation": [ + "Sequence alignment" + ], + "EDAM topic": [ + "Mapping" + ], + "Status": "Up-to-date", + "Source": "https://github.com/bwa-mem2/bwa-mem2", + "ToolShed categories": [ + "Next Gen Mappers" + ], + "ToolShed id": "bwa_mem2", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/bwa_mem2", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/bwa_mem2", + "Galaxy wrapper version": "2.2.1", + "Conda id": "bwa-mem2", + "Conda version": "2.2.1" + }, + { + "Galaxy wrapper id": "bwameth", + "Galaxy tool ids": [ + "bwameth" + ], + "Description": "Fast and accurate alignment of BS-seq reads", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/brentp/bwa-meth", + "ToolShed categories": [ + "Sequence Analysis", + "Next Gen Mappers" + ], + "ToolShed id": "bwameth", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/bwameth", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/bwameth", + "Galaxy wrapper version": "0.2.7", + "Conda id": "bwameth", + "Conda version": "0.2.7" + }, + { + "Galaxy wrapper id": "cactus", + "Galaxy tool ids": [ + "cactus_cactus", + "cactus_export" + ], + "Description": "Cactus is a reference-free whole-genome multiple alignment program", + "bio.tool id": "cactus", + "bio.tool ids": [ + "cactus" + ], + "biii": null, + "bio.tool name": "Cactus", + "bio.tool description": "Cactus is a reference-free whole-genome multiple alignment program.", + "EDAM operation": [ + "Multiple sequence alignment", + "Genome alignment" + ], + "EDAM topic": [ + "Genomics", + "Sequence analysis", + "Phylogeny", + "Sequence assembly", + "Mapping", + "Phylogenetics" + ], + "Status": "To update", + "Source": "https://github.com/ComparativeGenomicsToolkit/cactus", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "cactus", + "Galaxy wrapper owner": "galaxy-australia", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/cactus", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/cactus", + "Galaxy wrapper version": "2.7.1", + "Conda id": null, + "Conda version": null + }, + { + "Galaxy wrapper id": "calculate_contrast_threshold", + "Galaxy tool ids": [ + "calculate_contrast_threshold" + ], + "Description": "Calculates a contrast threshold from the CDT file generated by ``tag_pileup_frequency``. The calculated values are then used to set a uniform contrast for all the heatmaps generated downstream.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/CEGRcode/ChIP-QC-tools/tree/master/calculate_contrast_threshold", + "ToolShed categories": [ + "Visualization", + "Genomic Interval Operations", + "SAM" + ], + "ToolShed id": "calculate_contrast_threshold", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/calculate_contrast_threshold", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/calculate_contrast_threshold", + "Galaxy wrapper version": "1.0.0", + "Conda id": "numpy", + "Conda version": null + }, + { + "Galaxy wrapper id": "calculate_numeric_param", + "Galaxy tool ids": [ + "calculate_numeric_param" + ], + "Description": "Calculate a numeric parameter value using integer and float values.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": null, + "ToolShed categories": [ + "Text Manipulation" + ], + "ToolShed id": "calculate_numeric_param", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/calculate_numeric_param", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/calculate_numeric_param", + "Galaxy wrapper version": "0.1.0", + "Conda id": null, + "Conda version": null + }, + { + "Galaxy wrapper id": "cami_amber", + "Galaxy tool ids": [ + "cami_amber", + "cami_amber_add", + "cami_amber_convert" + ], + "Description": "Evaluation package for the comparative assessment of genome reconstructions and taxonomic assignments", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/CAMI-challenge/AMBER", + "ToolShed categories": [ + "Metagenomics" + ], + "ToolShed id": "cami_amber", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/amber/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/cami_amber", + "Galaxy wrapper version": "2.0.4", + "Conda id": "cami-amber", + "Conda version": "2.0.4" + }, + { + "Galaxy wrapper id": "cat", + "Galaxy tool ids": [ + "cat_add_names", + "cat_bins", + "cat_contigs", + "cat_prepare", + "cat_summarise" + ], + "Description": "Contig Annotation Tool (CAT)", + "bio.tool id": "cat_bins", + "bio.tool ids": [ + "cat_bins" + ], + "biii": null, + "bio.tool name": "CAT and BAT", + "bio.tool description": "Contig Annotation Tool (CAT) and Bin Annotation Tool (BAT) are pipelines for the taxonomic classification of long DNA sequences and metagenome assembled genomes (MAGs/bins) of both known and (highly) unknown microorganisms, as generated by contemporary metagenomics studies. The core algorithm of both programs involves gene calling, mapping of predicted ORFs against the nr protein database, and voting-based classification of the entire contig / MAG based on classification of the individual ORFs.", + "EDAM operation": [ + "Taxonomic classification", + "Sequence assembly", + "Coding region prediction" + ], + "EDAM topic": [ + "Metagenomics", + "Metagenomic sequencing", + "Taxonomy", + "Sequence assembly" + ], + "Status": "To update", + "Source": "https://github.com/dutilh/CAT", + "ToolShed categories": [ + "Metagenomics" + ], + "ToolShed id": "contig_annotation_tool", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproteomics/tools-galaxyp/tree/master/tools/cat", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/cat", + "Galaxy wrapper version": "5.2.3", + "Conda id": "cat", + "Conda version": "5.3" + }, + { + "Galaxy wrapper id": "cdhit", + "Galaxy tool ids": [ + "cd_hit" + ], + "Description": "Cluster or compare biological sequence datasets", + "bio.tool id": "cd-hit", + "bio.tool ids": [ + "cd-hit" + ], + "biii": null, + "bio.tool name": "cd-hit", + "bio.tool description": "Cluster a nucleotide dataset into representative sequences.", + "EDAM operation": [ + "Sequence clustering" + ], + "EDAM topic": [ + "Sequencing" + ], + "Status": "Up-to-date", + "Source": "http://weizhongli-lab.org/cd-hit/", + "ToolShed categories": [ + "Sequence Analysis", + "Fasta Manipulation" + ], + "ToolShed id": "cd_hit", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/cdhit", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/cdhit", + "Galaxy wrapper version": "4.8.1", + "Conda id": "cd-hit", + "Conda version": "4.8.1" + }, + { + "Galaxy wrapper id": "cemitool", + "Galaxy tool ids": [ + "cemitool" + ], + "Description": "Gene co-expression network analysis tool", + "bio.tool id": "cemitool", + "bio.tool ids": [ + "cemitool" + ], + "biii": null, + "bio.tool name": "CEMiTool", + "bio.tool description": "It unifies the discovery and the analysis of coexpression gene modules in a fully automatic manner, while providing a user-friendly html report with high quality graphs. Our tool evaluates if modules contain genes that are over-represented by specific pathways or that are altered in a specific sample group. Additionally, CEMiTool is able to integrate transcriptomic data with interactome information, identifying the potential hubs on each network.", + "EDAM operation": [ + "Enrichment analysis", + "Pathway or network analysis" + ], + "EDAM topic": [ + "Gene expression", + "Transcriptomics", + "Microarray experiment" + ], + "Status": "To update", + "Source": "https://www.bioconductor.org/packages/release/bioc/html/CEMiTool.html", + "ToolShed categories": [ + "Transcriptomics", + "RNA", + "Statistics" + ], + "ToolShed id": "cemitool", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/cemitool", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/cemitool", + "Galaxy wrapper version": "1.18.1", + "Conda id": "bioconductor-cemitool", + "Conda version": "1.26.0" + }, + { + "Galaxy wrapper id": "charts", + "Galaxy tool ids": [ + "charts" + ], + "Description": "Enables advanced visualization options in Galaxy Charts", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": null, + "ToolShed categories": [ + "Visualization" + ], + "ToolShed id": "charts", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/charts/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/charts", + "Galaxy wrapper version": "1.0.1", + "Conda id": "r-getopt", + "Conda version": null + }, + { + "Galaxy wrapper id": "checkm", + "Galaxy tool ids": [ + "checkm_analyze", + "checkm_lineage_set", + "checkm_lineage_wf", + "checkm_plot", + "checkm_qa", + "checkm_taxon_set", + "checkm_taxonomy_wf", + "checkm_tetra", + "checkm_tree", + "checkm_tree_qa" + ], + "Description": "Assess the quality of microbial genomes recovered from isolates, single cells, and metagenomes", + "bio.tool id": "checkm", + "bio.tool ids": [ + "checkm" + ], + "biii": null, + "bio.tool name": "CheckM", + "bio.tool description": "CheckM provides a set of tools for assessing the quality of genomes recovered from isolates, single cells, or metagenomes.", + "EDAM operation": [ + "Sequence assembly validation", + "Validation", + "Sequence composition calculation", + "Sequencing quality control", + "Statistical calculation" + ], + "EDAM topic": [ + "Genomics", + "Phylogenomics", + "Phylogenetics", + "Taxonomy", + "Metagenomics", + "Data quality management" + ], + "Status": "To update", + "Source": "https://github.com/Ecogenomics/CheckM", + "ToolShed categories": [ + "Metagenomics" + ], + "ToolShed id": "checkm", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/checkm", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/checkm", + "Galaxy wrapper version": "1.2.0", + "Conda id": "checkm-genome", + "Conda version": "1.2.2" + }, + { + "Galaxy wrapper id": "cherri", + "Galaxy tool ids": [ + "cherri_eval", + "cherri_train" + ], + "Description": "Computational Help Evaluating RNA-RNA interactions", + "bio.tool id": "cherri", + "bio.tool ids": [ + "cherri" + ], + "biii": null, + "bio.tool name": "cherri", + "bio.tool description": "CheRRI detects functional RNA-RNA interaction (RRI) sites, by evaluating if an interaction site most likely occurs in nature. It helps to filter interaction sites generated either experimentally or by an RRI prediction algorithm by removing false positive interactions.", + "EDAM operation": [], + "EDAM topic": [ + "Molecular interactions, pathways and networks", + "Structure analysis", + "Machine learning" + ], + "Status": "To update", + "Source": "https://github.com/BackofenLab/Cherri", + "ToolShed categories": [ + "Transcriptomics", + "RNA" + ], + "ToolShed id": null, + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/cherri", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/cherri", + "Galaxy wrapper version": "0.7", + "Conda id": "cherri", + "Conda version": "0.8" + }, + { + "Galaxy wrapper id": "chewbbaca", + "Galaxy tool ids": [ + "chewbbaca_allelecall", + "chewbbaca_allelecallevaluator", + "chewbbaca_createschema", + "chewbbaca_downloadschema", + "chewbbaca_extractcgmlst", + "chewbbaca_joinprofiles", + "chewbbaca_nsstats", + "chewbbaca_prepexternalschema" + ], + "Description": "BSR-Based Allele Calling Algorithm", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/B-UMMI/chewBBACA/tree/master", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "chewbbaca", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/chewbbaca", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/chewbbaca", + "Galaxy wrapper version": null, + "Conda id": "chewbbaca", + "Conda version": "3.3.5" + }, + { + "Galaxy wrapper id": "chira", + "Galaxy tool ids": [ + "chira_collapse", + "chira_extract", + "chira_map", + "chira_merge", + "chira_quantify" + ], + "Description": "Chimeric Read Annotator for RNA-RNA interactome data", + "bio.tool id": "chira", + "bio.tool ids": [ + "chira" + ], + "biii": null, + "bio.tool name": "ChiRA", + "bio.tool description": "ChiRA is a tool suite to analyze RNA-RNA interactome experimental data such as CLASH, CLEAR-CLIP, PARIS, SPLASH, etc.", + "EDAM operation": [], + "EDAM topic": [ + "RNA", + "Molecular interactions, pathways and networks", + "Functional, regulatory and non-coding RNA" + ], + "Status": "Up-to-date", + "Source": "https://github.com/pavanvidem/chira", + "ToolShed categories": [ + "RNA", + "Transcriptomics", + "Sequence Analysis" + ], + "ToolShed id": "chira", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/chira", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/chira", + "Galaxy wrapper version": "1.4.3", + "Conda id": "chira", + "Conda version": "1.4.3" + }, + { + "Galaxy wrapper id": "chopin2", + "Galaxy tool ids": [ + "chopin2" + ], + "Description": "Domain-Agnostic Supervised Learning with Hyperdimensional Computing", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/cumbof/chopin2", + "ToolShed categories": [ + "Machine Learning" + ], + "ToolShed id": "chopin2", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/chopin2", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/chopin2", + "Galaxy wrapper version": "1.0.8.post1", + "Conda id": "chopin2", + "Conda version": null + }, + { + "Galaxy wrapper id": "chromeister", + "Galaxy tool ids": [ + "chromeister" + ], + "Description": "ultra-fast pairwise genome comparisons", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/estebanpw/chromeister", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "chromeister", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/chromeister", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/chromeister", + "Galaxy wrapper version": "1.5.a", + "Conda id": "chromeister", + "Conda version": "1.5.a" + }, + { + "Galaxy wrapper id": "circexplorer2", + "Galaxy tool ids": [ + "circexplorer2" + ], + "Description": "Comprehensive and integrative circular RNA analysis toolset.", + "bio.tool id": "circexplorer2", + "bio.tool ids": [ + "circexplorer2" + ], + "biii": null, + "bio.tool name": "CIRCexplorer2", + "bio.tool description": "Genome-wide annotation of circRNAs and their alternative back-splicing/splicing.", + "EDAM operation": [], + "EDAM topic": [ + "RNA splicing", + "Gene transcripts", + "Literature and language" + ], + "Status": "Up-to-date", + "Source": "https://github.com/YangLab/CIRCexplorer2", + "ToolShed categories": [ + "RNA", + "Assembly" + ], + "ToolShed id": "circexplorer2", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/circexplorer2", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/circexplorer2", + "Galaxy wrapper version": "2.3.8", + "Conda id": "circexplorer2", + "Conda version": "2.3.8" + }, + { + "Galaxy wrapper id": "circos", + "Galaxy tool ids": [ + "circos_aln_to_links", + "circos_binlinks", + "circos_bundlelinks", + "circos", + "circos_gc_skew", + "circos_resample", + "circos_wiggle_to_scatter", + "circos_wiggle_to_stacked", + "circos_tableviewer", + "circos_interval_to_text", + "circos_interval_to_tile" + ], + "Description": "Build Circos Plots in Galaxy", + "bio.tool id": "galactic_circos", + "bio.tool ids": [ + "galactic_circos" + ], + "biii": null, + "bio.tool name": "Galactic Circos", + "bio.tool description": "Galactic Circos is a Galaxy wrapper providing a GUI for the Circos tool. Circos allows visualizing data in a circular format.", + "EDAM operation": [ + "Sequence visualisation" + ], + "EDAM topic": [], + "Status": "To update", + "Source": "http://circos.ca/", + "ToolShed categories": [ + "Graphics" + ], + "ToolShed id": "circos", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/circos", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/circos", + "Galaxy wrapper version": "0.69.8", + "Conda id": "circos", + "Conda version": "0.69.9" + }, + { + "Galaxy wrapper id": "cite_seq_count", + "Galaxy tool ids": [ + "cite_seq_count" + ], + "Description": "Count CMO/HTO", + "bio.tool id": "CITE-seq-Count", + "bio.tool ids": [ + "CITE-seq-Count" + ], + "biii": null, + "bio.tool name": "CITE-seq-Count", + "bio.tool description": "Tool for counting antibody TAGS from a CITE-seq and/or cell hashing experiment.", + "EDAM operation": [ + "RNA-Seq quantification" + ], + "EDAM topic": [ + "Transcriptomics", + "Immunoproteins and antigens" + ], + "Status": "Up-to-date", + "Source": "https://github.com/Hoohm/CITE-seq-Count", + "ToolShed categories": [ + "Transcriptomics" + ], + "ToolShed id": "cite_seq_count", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/cite_seq_count", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/cite_seq_count", + "Galaxy wrapper version": "1.4.4", + "Conda id": "cite-seq-count", + "Conda version": "1.4.4" + }, + { + "Galaxy wrapper id": "clair3", + "Galaxy tool ids": [ + "clair3" + ], + "Description": "Symphonizing pileup and full-alignment for high-performance long-read variant calling", + "bio.tool id": "clair3", + "bio.tool ids": [ + "clair3" + ], + "biii": null, + "bio.tool name": "Clair3", + "bio.tool description": "Clair3 is a germline small variant caller for long-reads. Clair3 makes the best of two major method categories: pileup calling handles most variant candidates with speed, and full-alignment tackles complicated candidates to maximize precision and recall. Clair3 runs fast and has superior performance, especially at lower coverage. Clair3 is simple and modular for easy deployment and integration.", + "EDAM operation": [ + "Variant calling" + ], + "EDAM topic": [ + "Molecular genetics" + ], + "Status": "To update", + "Source": "https://github.com/HKU-BAL/Clair3", + "ToolShed categories": [ + "Sequence Analysis", + "Variant Analysis" + ], + "ToolShed id": "clair3", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/clair3", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/clair3", + "Galaxy wrapper version": "0.1.12", + "Conda id": "clair3", + "Conda version": "1.0.8" + }, + { + "Galaxy wrapper id": "clustalw", + "Galaxy tool ids": [ + "clustalw" + ], + "Description": "ClustalW multiple sequence alignment program for DNA or proteins", + "bio.tool id": "clustal2", + "bio.tool ids": [ + "clustal2" + ], + "biii": null, + "bio.tool name": "Clustal 2 (Clustal W, Clustal X)", + "bio.tool description": "Multiple sequence alignment program with a command-line interface (Clustal W) and a graphical user interface (Clustal X). The display colours allow conserved features to be highlighted for easy viewing in the alignment. It is available for several platforms, including Windows, Macintosh PowerMac, Linux and Solaris.Names occassionally spelled also as Clustal W2, ClustalW2, ClustalW, ClustalX, Clustal2.", + "EDAM operation": [ + "Multiple sequence alignment" + ], + "EDAM topic": [ + "Phylogeny", + "Sequence analysis" + ], + "Status": "Up-to-date", + "Source": "http://www.clustal.org/clustal2/", + "ToolShed categories": [ + "Phylogenetics", + "Sequence Analysis" + ], + "ToolShed id": "clustalw", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/clustalw", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/clustalw", + "Galaxy wrapper version": "2.1", + "Conda id": "clustalw", + "Conda version": "2.1" + }, + { + "Galaxy wrapper id": "cnv-phenopacket", + "Galaxy tool ids": [ + "cnv_phenopacket" + ], + "Description": "cnv-phenopacket Converts TSV metadata file to JSON.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://pypi.org/project/cnv-phenopacket/", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "cnv_phenopacket", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/cnv-phenopacket", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/cnv-phenopacket", + "Galaxy wrapper version": "1.0.2", + "Conda id": "cnv-phenopacket", + "Conda version": null + }, + { + "Galaxy wrapper id": "cnv-vcf2json", + "Galaxy tool ids": [ + "cnv_vcf2json" + ], + "Description": "cnv-vcf2json Converts structural variants VCF file to JSON.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://pypi.org/project/cnv-phenopacket/", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "cnv-vcf2json", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/cnv-vcf2json", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/cnv-vcf2json", + "Galaxy wrapper version": "1.0.4", + "Conda id": "cnv-vcf2json", + "Conda version": null + }, + { + "Galaxy wrapper id": "cnvkit", + "Galaxy tool ids": [ + "cnvkit_access", + "cnvkit_antitarget", + "cnvkit_autobin", + "cnvkit_batch", + "cnvkit_breaks", + "cnvkit_call", + "cnvkit_coverage", + "cnvkit_diagram", + "cnvkit_fix", + "cnvkit_genemetrics", + "cnvkit_heatmap", + "cnvkit_reference", + "cnvkit_scatter", + "cnvkit_segment", + "cnvkit_segmetrics", + "cnvkit_sex", + "cnvkit_target" + ], + "Description": "detecting copy number variants and alterations genome-wide from high-throughput sequencing", + "bio.tool id": "cnvkit", + "bio.tool ids": [ + "cnvkit" + ], + "biii": null, + "bio.tool name": "CNVkit", + "bio.tool description": "CNVkit is a software toolkit to infer and visualize copy number from targeted DNA sequencing data.", + "EDAM operation": [ + "Variant calling" + ], + "EDAM topic": [ + "DNA structural variation" + ], + "Status": "Up-to-date", + "Source": "https://github.com/etal/cnvkit", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "cnvkit", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/cnvkit", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/cnvkit", + "Galaxy wrapper version": "0.9.11", + "Conda id": "cnvkit", + "Conda version": "0.9.11" + }, + { + "Galaxy wrapper id": "codeml", + "Galaxy tool ids": [ + "codeml" + ], + "Description": "Detects positive selection", + "bio.tool id": "paml", + "bio.tool ids": [ + "paml" + ], + "biii": null, + "bio.tool name": "PAML", + "bio.tool description": "Package of programs for phylogenetic analyses of DNA or protein sequences using maximum likelihood.", + "EDAM operation": [ + "Probabilistic sequence generation", + "Phylogenetic tree generation (maximum likelihood and Bayesian methods)", + "Phylogenetic tree analysis" + ], + "EDAM topic": [ + "Phylogenetics", + "Sequence analysis" + ], + "Status": "To update", + "Source": "http://abacus.gene.ucl.ac.uk/software/paml.html", + "ToolShed categories": [ + "Phylogenetics" + ], + "ToolShed id": "codeml", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/codeml", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/codeml", + "Galaxy wrapper version": "4.9", + "Conda id": "paml", + "Conda version": "4.10.7" + }, + { + "Galaxy wrapper id": "cojac", + "Galaxy tool ids": [ + "cooc_mutbamscan", + "cooc_pubmut", + "cooc_tabmut" + ], + "Description": "co-occurrence of mutations on amplicons", + "bio.tool id": "cojac", + "bio.tool ids": [ + "cojac" + ], + "biii": null, + "bio.tool name": "COJAC", + "bio.tool description": "CoOccurrence adJusted Analysis and Calling - The cojac package comprises a set of command-line tools to analyse co-occurrence of mutations on amplicons. It is useful, for example, for early detection of viral variants of concern (e.g. Alpha, Delta, Omicron) in environmental samples, and has been designed to scan for multiple SARS-CoV-2 variants in wastewater samples, as analyzed jointly by ETH Zurich, EPFL and Eawag.", + "EDAM operation": [], + "EDAM topic": [ + "Genetic variation" + ], + "Status": "To update", + "Source": "https://github.com/cbg-ethz/cojac", + "ToolShed categories": [ + "Metagenomics", + "Sequence Analysis" + ], + "ToolShed id": "cojac", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/cojac", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/cojac", + "Galaxy wrapper version": "0.9.1", + "Conda id": "cojac", + "Conda version": "0.9.2" + }, + { + "Galaxy wrapper id": "colabfold", + "Galaxy tool ids": [ + "colabfold_alphafold", + "colabfold_msa" + ], + "Description": "Protein prediction based on AlphaFold2", + "bio.tool id": "Colabfold", + "bio.tool ids": [ + "Colabfold" + ], + "biii": null, + "bio.tool name": "ColabFold", + "bio.tool description": "ColabFold databases are MMseqs2 expandable profile databases to generate diverse multiple sequence alignments to predict protein structures.", + "EDAM operation": [ + "Database search", + "Protein structure prediction", + "Fold recognition" + ], + "EDAM topic": [ + "Protein folds and structural domains", + "Protein folding, stability and design", + "Structure prediction", + "Sequence sites, features and motifs", + "Metagenomics" + ], + "Status": "To update", + "Source": "https://github.com/sokrypton/ColabFold", + "ToolShed categories": [ + "Proteomics", + "Graphics" + ], + "ToolShed id": "colabfold", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/sokrypton/ColabFold", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/colabfold", + "Galaxy wrapper version": "1.5.5", + "Conda id": null, + "Conda version": null + }, + { + "Galaxy wrapper id": "colibread", + "Galaxy tool ids": [ + "commet", + "discosnp_rad", + "discosnp_pp", + "kissplice", + "lordec", + "mapsembler2", + "takeabreak" + ], + "Description": "Colib'read tools are all dedicated to the analysis of NGS datasets without the need of any reference genome", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://colibread.inria.fr/", + "ToolShed categories": [ + "Sequence Analysis", + "Variant Analysis" + ], + "ToolShed id": "colibread", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/colibread", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/colibread", + "Galaxy wrapper version": "24.7.14+galaxy0", + "Conda id": "commet", + "Conda version": "24.7.14" + }, + { + "Galaxy wrapper id": "collection_column_join", + "Galaxy tool ids": [ + "collection_column_join" + ], + "Description": "Column Join on Collections", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": null, + "ToolShed categories": [ + "Text Manipulation" + ], + "ToolShed id": "collection_column_join", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/collection_column_join", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/collection_column_join", + "Galaxy wrapper version": "0.0.3", + "Conda id": "coreutils", + "Conda version": "8.25" + }, + { + "Galaxy wrapper id": "collection_element_identifiers", + "Galaxy tool ids": [ + "collection_element_identifiers" + ], + "Description": "Extract element identifiers of a collection", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": null, + "ToolShed categories": [ + "Text Manipulation" + ], + "ToolShed id": "collection_element_identifiers", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/collection_element_identifiers", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/collection_element_identifiers", + "Galaxy wrapper version": "0.0.2", + "Conda id": null, + "Conda version": null + }, + { + "Galaxy wrapper id": "column_maker", + "Galaxy tool ids": [ + "Add_a_column1" + ], + "Description": "Compute an expression on every row", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": null, + "ToolShed categories": [ + "Text Manipulation" + ], + "ToolShed id": "column_maker", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/column_maker", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/column_maker", + "Galaxy wrapper version": "2.0", + "Conda id": "python", + "Conda version": null + }, + { + "Galaxy wrapper id": "column_order_header_sort", + "Galaxy tool ids": [ + "column_order_header_sort" + ], + "Description": "Sort Column Order by heading", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": null, + "ToolShed categories": [ + "Text Manipulation" + ], + "ToolShed id": "column_order_header_sort", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/column_order_header_sort", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/column_order_header_sort", + "Galaxy wrapper version": "0.0.1", + "Conda id": "python", + "Conda version": null + }, + { + "Galaxy wrapper id": "column_remove_by_header", + "Galaxy tool ids": [ + "column_remove_by_header" + ], + "Description": "Remove columns by header", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": null, + "ToolShed categories": [ + "Text Manipulation" + ], + "ToolShed id": "column_remove_by_header", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/column_remove_by_header", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/column_remove_by_header", + "Galaxy wrapper version": "1.0", + "Conda id": "python", + "Conda version": null + }, + { + "Galaxy wrapper id": "compleasm", + "Galaxy tool ids": [ + "compleasm" + ], + "Description": "Compleasm: a faster and more accurate reimplementation of BUSCO", + "bio.tool id": "compleasm", + "bio.tool ids": [ + "compleasm" + ], + "biii": null, + "bio.tool name": "compleasm", + "bio.tool description": "\"Compleasm: a faster and more accurate reimplementation of BUSCO\"", + "EDAM operation": [ + "Sequence assembly validation", + "Sequence analysis", + "Scaffolding", + "Transcriptome assembly" + ], + "EDAM topic": [ + "Sequence assembly", + "Genomics", + "Transcriptomics", + "Sequence analysis" + ], + "Status": "Up-to-date", + "Source": "https://github.com/huangnengCSU/compleasm", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "compleasm", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/compleasm/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/compleasm", + "Galaxy wrapper version": "0.2.6", + "Conda id": "compleasm", + "Conda version": "0.2.6" + }, + { + "Galaxy wrapper id": "compose_text_param", + "Galaxy tool ids": [ + "compose_text_param" + ], + "Description": "Compose a text parameter value using text, integer and float values", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": null, + "ToolShed categories": [ + "Text Manipulation" + ], + "ToolShed id": "compose_text_param", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/compose_text_param", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/compose_text_param", + "Galaxy wrapper version": "0.1.1", + "Conda id": null, + "Conda version": null + }, + { + "Galaxy wrapper id": "compress_file", + "Galaxy tool ids": [ + "compress_file" + ], + "Description": "Compress files.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": null, + "ToolShed categories": [ + "Text Manipulation" + ], + "ToolShed id": "compress_file", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/compress_file", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/compress_file", + "Galaxy wrapper version": "0.1.0", + "Conda id": "gzip", + "Conda version": null + }, + { + "Galaxy wrapper id": "concoct", + "Galaxy tool ids": [ + "concoct", + "concoct_coverage_table", + "concoct_cut_up_fasta", + "concoct_extract_fasta_bins", + "concoct_merge_cut_up_clustering" + ], + "Description": "CONCOCT (Clustering cONtigs with COverage and ComposiTion) does unsupervised binning of metagenomic contigs byusing nucleotide composition - kmer frequencies - and coverage data for multiple samples. CONCOCT can accurately(up to species level) bin metagenomic contigs.", + "bio.tool id": "concoct", + "bio.tool ids": [ + "concoct" + ], + "biii": null, + "bio.tool name": "CONCOCT", + "bio.tool description": "A program for unsupervised binning of metagenomic contigs by using nucleotide composition, coverage data in multiple samples and linkage data from paired end reads.", + "EDAM operation": [ + "Sequence clustering", + "Read binning" + ], + "EDAM topic": [ + "Metagenomics" + ], + "Status": "Up-to-date", + "Source": "https://github.com/BinPro/CONCOCT", + "ToolShed categories": [ + "Metagenomics" + ], + "ToolShed id": "concoct", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/concoct", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/concoct", + "Galaxy wrapper version": "1.1.0", + "Conda id": "concoct", + "Conda version": "1.1.0" + }, + { + "Galaxy wrapper id": "cosg", + "Galaxy tool ids": [ + "cosg" + ], + "Description": "Marker gene identification for single-cell sequencing data using COSG.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/genecell/COSG", + "ToolShed categories": [ + "Transcriptomics", + "Sequence Analysis" + ], + "ToolShed id": "cosg", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/cosg/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/cosg", + "Galaxy wrapper version": "1.0.1", + "Conda id": "cosg", + "Conda version": "1.0.1" + }, + { + "Galaxy wrapper id": "coverage_report", + "Galaxy tool ids": [ + "CoverageReport2" + ], + "Description": "Generate Detailed Coverage Report from BAM file", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/galaxyproject/tools-iuc", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "coverage_report", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/coverage_report", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/coverage_report", + "Galaxy wrapper version": "0.0.4", + "Conda id": "perl-number-format", + "Conda version": "1.76" + }, + { + "Galaxy wrapper id": "coverm", + "Galaxy tool ids": [ + "coverm_contig", + "coverm_genome" + ], + "Description": "CoverM genome and contig wrappers", + "bio.tool id": "coverm", + "bio.tool ids": [ + "coverm" + ], + "biii": null, + "bio.tool name": "CoverM", + "bio.tool description": "Read coverage calculator for metagenomics", + "EDAM operation": [ + "Local alignment" + ], + "EDAM topic": [ + "Bioinformatics" + ], + "Status": "Up-to-date", + "Source": "https://github.com/wwood/CoverM", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "coverm", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tools/coverm", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/coverm", + "Galaxy wrapper version": "0.7.0", + "Conda id": "coverm", + "Conda version": "0.7.0" + }, + { + "Galaxy wrapper id": "crispr_studio", + "Galaxy tool ids": [ + "crispr_studio" + ], + "Description": "CRISPR Studio is a program developed to facilitate and accelerate CRISPR array visualization.", + "bio.tool id": "crisprstudio", + "bio.tool ids": [ + "crisprstudio" + ], + "biii": null, + "bio.tool name": "CRISPRStudio", + "bio.tool description": "CRISPRStudio is a program developed to facilitate and accelerate CRISPR array visualization. It works by first comparing spacers sequence homology in a dataset, then assigning a two-color-code to each cluster of spacers and finally writing an svg file, which can be opened in graphics vector editor.", + "EDAM operation": [ + "Visualisation" + ], + "EDAM topic": [ + "Sequence analysis", + "Genomics", + "Data visualisation" + ], + "Status": "To update", + "Source": "https://github.com/moineaulab/CRISPRStudio", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "crispr_studio", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/crispr_studio/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/crispr_studio", + "Galaxy wrapper version": "1+galaxy0", + "Conda id": "crispr_studio", + "Conda version": "1" + }, + { + "Galaxy wrapper id": "crosscontamination_barcode_filter", + "Galaxy tool ids": [ + "crosscontamination_barcode_filter" + ], + "Description": "Barcode contamination discovery tool", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": null, + "ToolShed categories": [ + "Transcriptomics", + "Visualization" + ], + "ToolShed id": "crosscontamination_barcode_filter", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/crosscontamination_barcode_filter", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/crosscontamination_barcode_filter", + "Galaxy wrapper version": "0.3", + "Conda id": "r-ggplot2", + "Conda version": "2.2.1" + }, + { + "Galaxy wrapper id": "crossmap", + "Galaxy tool ids": [ + "crossmap_bam", + "crossmap_bed", + "crossmap_bw", + "crossmap_gff", + "crossmap_region", + "crossmap_vcf", + "crossmap_wig" + ], + "Description": "CrossMap converts genome coordinates or annotation files between genome assemblies", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "http://crossmap.sourceforge.net/", + "ToolShed categories": [ + "Convert Formats", + "Genomic Interval Operations" + ], + "ToolShed id": "crossmap", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/crossmap", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/crossmap", + "Galaxy wrapper version": "0.6.1", + "Conda id": "crossmap", + "Conda version": "0.7.0" + }, + { + "Galaxy wrapper id": "cutadapt", + "Galaxy tool ids": [ + "cutadapt" + ], + "Description": "Flexible tool to remove adapter sequences (and quality trim) high throughput sequencing reads (fasta/fastq).", + "bio.tool id": "cutadapt", + "bio.tool ids": [ + "cutadapt" + ], + "biii": null, + "bio.tool name": "Cutadapt", + "bio.tool description": "Find and remove adapter sequences, primers, poly-A tails and other types of unwanted sequence from your high-throughput sequencing reads.", + "EDAM operation": [ + "Sequence trimming", + "Primer removal", + "Read pre-processing" + ], + "EDAM topic": [ + "Genomics", + "Probes and primers", + "Sequencing" + ], + "Status": "Up-to-date", + "Source": "https://cutadapt.readthedocs.org/en/stable/", + "ToolShed categories": [ + "Fasta Manipulation", + "Fastq Manipulation", + "Sequence Analysis" + ], + "ToolShed id": "cutadapt", + "Galaxy wrapper owner": "lparsons", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/cutadapt", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/cutadapt", + "Galaxy wrapper version": "4.8", + "Conda id": "cutadapt", + "Conda version": "4.8" + }, + { + "Galaxy wrapper id": "cutesv", + "Galaxy tool ids": [ + "cutesv" + ], + "Description": "Long-read sequencing enables the comprehensive discovery of structural variations (SVs). However, it is still non-trivial to achieve high sensitivity and performance simultaneously due to the complex SV characteristics implied by noisy long reads. Therefore, we propose cuteSV, a sensitive, fast and scalable long-read-based SV detection approach. cuteSV uses tailored methods to collect the signatures of various types of SVs and employs a clustering-and-refinement method to analyze the signatures to implement sensitive SV detection. Benchmarks on real Pacific Biosciences (PacBio) and Oxford Nanopore Technology (ONT) datasets demonstrate that cuteSV has better yields and scalability than state-of-the-art tools.", + "bio.tool id": "cuteSV", + "bio.tool ids": [ + "cuteSV" + ], + "biii": null, + "bio.tool name": "cuteSV", + "bio.tool description": "Long Read based Human Genomic Structural Variation Detection with cuteSV | Long-read sequencing technologies enable to comprehensively discover structural variations (SVs). However, it is still non-trivial for state-of-the-art approaches to detect SVs with high sensitivity or high performance or both. Herein, we propose cuteSV, a sensitive, fast and lightweight SV detection approach. cuteSV uses tailored methods to comprehensively collect various types of SV signatures, and a clustering-and-refinement method to implement a stepwise SV detection, which enables to achieve high sensitivity without loss of accuracy. Benchmark results demonstrate that cuteSV has better yields on real datasets. Further, its speed and scalability are outstanding and promising to large-scale data analysis", + "EDAM operation": [ + "Split read mapping", + "Genotyping", + "Structural variation detection" + ], + "EDAM topic": [ + "DNA structural variation", + "Sequencing", + "Computer science" + ], + "Status": "To update", + "Source": "https://github.com/tjiangHIT/cuteSV", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "cutesv", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/cutesv", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/cutesv", + "Galaxy wrapper version": "1.0.8", + "Conda id": "cutesv", + "Conda version": null + }, + { + "Galaxy wrapper id": "cwpair2", + "Galaxy tool ids": [ + "cwpair2" + ], + "Description": "Contains a tool that takes a list of called peaks on both strands and produces a list of matched pairsand a list of unmatched orphans.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": null, + "ToolShed categories": [ + "ChIP-seq" + ], + "ToolShed id": "cwpair2", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/cwpair2", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/cwpair2", + "Galaxy wrapper version": "1.1.1", + "Conda id": "matplotlib", + "Conda version": null + }, + { + "Galaxy wrapper id": "dada2", + "Galaxy tool ids": [ + "dada2_assignTaxonomyAddspecies", + "dada2_dada", + "dada2_filterAndTrim", + "dada2_learnErrors", + "dada2_makeSequenceTable", + "dada2_mergePairs", + "dada2_plotComplexity", + "dada2_plotQualityProfile", + "dada2_removeBimeraDenovo", + "dada2_seqCounts" + ], + "Description": "DADA2 wrappers", + "bio.tool id": "dada2", + "bio.tool ids": [ + "dada2" + ], + "biii": null, + "bio.tool name": "dada2", + "bio.tool description": "This package infers exact sequence variants (SVs) from amplicon data, replacing the commonly used and coarser OTU clustering approach. This pipeline inputs demultiplexed fastq files, and outputs the sequence variants and their sample-wise abundances after removing substitution and chimera errors. Taxonomic classification is available via a native implementation of the RDP naive Bayesian classifier.", + "EDAM operation": [ + "Variant calling", + "DNA barcoding" + ], + "EDAM topic": [ + "Sequencing", + "Genetic variation", + "Microbial ecology", + "Metagenomics" + ], + "Status": "To update", + "Source": "https://benjjneb.github.io/dada2/index.html", + "ToolShed categories": [ + "Metagenomics" + ], + "ToolShed id": "dada2", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/dada2", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/dada2", + "Galaxy wrapper version": null, + "Conda id": "bioconductor-dada2", + "Conda version": "1.30.0" + }, + { + "Galaxy wrapper id": "das_tool", + "Galaxy tool ids": [ + "Fasta_to_Contig2Bin", + "das_tool" + ], + "Description": "DAS Tool for genome resolved metagenomics", + "bio.tool id": "dastool", + "bio.tool ids": [ + "dastool" + ], + "biii": null, + "bio.tool name": "dastool", + "bio.tool description": "DAS Tool is an automated method that integrates the results of a flexible number of binning algorithms to calculate an optimized, non-redundant set of bins from a single assembly.", + "EDAM operation": [ + "Read binning" + ], + "EDAM topic": [ + "Metagenomics" + ], + "Status": "Up-to-date", + "Source": "https://github.com/cmks/DAS_Tool", + "ToolShed categories": [ + "Metagenomics" + ], + "ToolShed id": "das_tool", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/das_tool", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/das_tool", + "Galaxy wrapper version": "1.1.7", + "Conda id": "das_tool", + "Conda version": "1.1.7" + }, + { + "Galaxy wrapper id": "data_source_iris_tcga", + "Galaxy tool ids": [ + "data_source_iris_tcga" + ], + "Description": "IRIS-TCGA Data source tool", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": null, + "ToolShed categories": [ + "Data Source" + ], + "ToolShed id": "data_source_iris_tcga", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/data_source_iris_tcga", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/data_source_iris_tcga", + "Galaxy wrapper version": "1.0.0", + "Conda id": "python", + "Conda version": null + }, + { + "Galaxy wrapper id": "datamash", + "Galaxy tool ids": [ + "datamash_ops", + "datamash_reverse", + "datamash_transpose" + ], + "Description": "GNU Datamash is a command-line program which performs basicnumeric,textual and statistical operations on input textual data files.It is designed to be portable and reliable, and aid researchersto easily automate analysis pipelines, without writing code or even short scripts.License: GPL Version 3 (or later).These tool wrappers were originally writen by Assaf Gordon.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://www.gnu.org/software/datamash/", + "ToolShed categories": [ + "Text Manipulation" + ], + "ToolShed id": null, + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/datamash", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/datamash", + "Galaxy wrapper version": "1.8", + "Conda id": "datamash", + "Conda version": "1.1.0" + }, + { + "Galaxy wrapper id": "decontaminator", + "Galaxy tool ids": [ + "decontaminator" + ], + "Description": "Deep Learning method for novel virus detection in sequencing data", + "bio.tool id": "decontaminator", + "bio.tool ids": [ + "decontaminator" + ], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/cbib/decontaminator", + "ToolShed categories": [ + "Machine Learning" + ], + "ToolShed id": "decontaminator", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/decontaminator", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/decontaminator", + "Galaxy wrapper version": "1.0.0", + "Conda id": "numpy", + "Conda version": null + }, + { + "Galaxy wrapper id": "deepmicro", + "Galaxy tool ids": [ + "deepmicro" + ], + "Description": "Representation learning and classification framework", + "bio.tool id": "DeepMicro", + "bio.tool ids": [ + "DeepMicro" + ], + "biii": null, + "bio.tool name": "DeepMicro", + "bio.tool description": "Deep representation learning for disease prediction based on microbiome data.DeepMicro is a deep representation learning framework exploiting various autoencoders to learn robust low-dimensional representations from high-dimensional data and training classification models based on the learned representation.", + "EDAM operation": [ + "Essential dynamics", + "Splitting", + "Community profiling" + ], + "EDAM topic": [ + "Microbial ecology", + "Machine learning", + "Pathology", + "Public health and epidemiology", + "Allergy, clinical immunology and immunotherapeutics" + ], + "Status": "Up-to-date", + "Source": "https://github.com/paulzierep/DeepMicro", + "ToolShed categories": [ + "Machine Learning" + ], + "ToolShed id": "deepmicro", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/paulzierep/DeepMicro", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/deepmicro", + "Galaxy wrapper version": "1.4", + "Conda id": "deepmicro", + "Conda version": "1.4" + }, + { + "Galaxy wrapper id": "deepsig", + "Galaxy tool ids": [ + "deepsig" + ], + "Description": "Predictor of signal peptides in proteins based on deep learning", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/BolognaBiocomp/deepsig", + "ToolShed categories": [ + "Genome annotation" + ], + "ToolShed id": "deepsig", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/deepsig", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/deepsig", + "Galaxy wrapper version": "1.2.5", + "Conda id": "deepsig", + "Conda version": "1.2.5" + }, + { + "Galaxy wrapper id": "deepvariant", + "Galaxy tool ids": [ + "deepvariant" + ], + "Description": "DeepVariant is a deep learning-based variant caller", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/google/deepvariant", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "deepvariant", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/deepvariant", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/deepvariant", + "Galaxy wrapper version": "1.5.0", + "Conda id": null, + "Conda version": null + }, + { + "Galaxy wrapper id": "deg_annotate", + "Galaxy tool ids": [ + "deg_annotate" + ], + "Description": "Annotate DESeq2/DEXSeq output tables", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": null, + "ToolShed categories": [ + "Transcriptomics" + ], + "ToolShed id": "deg_annotate", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/deg_annotate", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/deg_annotate", + "Galaxy wrapper version": "1.1.0", + "Conda id": "bedtools", + "Conda version": "2.31.1" + }, + { + "Galaxy wrapper id": "delly", + "Galaxy tool ids": [ + "delly_call", + "delly_classify", + "delly_cnv", + "delly_filter", + "delly_lr", + "delly_merge" + ], + "Description": "Delly is an integrated structural variant (SV) prediction method that can discover, genotype and visualize deletions, tandem duplications, inversions and translocations at single-nucleotide resolution in short-read massively parallel sequencing data. It uses paired-ends, split-reads and read-depth to sensitively and accurately delineate genomic rearrangements throughout the genome.", + "bio.tool id": "delly2", + "bio.tool ids": [ + "delly2" + ], + "biii": null, + "bio.tool name": "Delly2", + "bio.tool description": "Integrated structural variant prediction method that can discover, genotype and visualize deletions, tandem duplications, inversions and translocations at single-nucleotide resolution in short-read massively parallel sequencing data. It uses paired-ends and split-reads to sensitively and accurately delineate genomic rearrangements throughout the genome. Structural variants can be visualized using Delly-maze and Delly-suave.", + "EDAM operation": [ + "Indel detection", + "Structural variation detection", + "Variant calling", + "Genotyping", + "Genetic variation analysis" + ], + "EDAM topic": [ + "DNA structural variation", + "Sequencing", + "Pathology", + "Genomics", + "Genetic variation", + "Bioinformatics", + "Population genomics", + "Rare diseases" + ], + "Status": "To update", + "Source": "https://github.com/dellytools/delly", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "delly", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/delly", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/delly", + "Galaxy wrapper version": "0.9.1", + "Conda id": "delly", + "Conda version": "1.2.6" + }, + { + "Galaxy wrapper id": "deseq2", + "Galaxy tool ids": [ + "deseq2" + ], + "Description": "Differential gene expression analysis based on the negative binomial distribution", + "bio.tool id": "DESeq2", + "bio.tool ids": [ + "DESeq2" + ], + "biii": null, + "bio.tool name": "DESeq2", + "bio.tool description": "R/Bioconductor package for differential gene expression analysis based on the negative binomial distribution. Estimate variance-mean dependence in count data from high-throughput sequencing assays and test for differential expression based on a model using the negative binomial distribution.", + "EDAM operation": [ + "Differential gene expression analysis", + "RNA-Seq analysis" + ], + "EDAM topic": [ + "RNA-Seq" + ], + "Status": "To update", + "Source": "https://www.bioconductor.org/packages/release/bioc/html/DESeq2.html", + "ToolShed categories": [ + "Transcriptomics", + "RNA", + "Statistics" + ], + "ToolShed id": "deseq2", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/deseq2", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/deseq2", + "Galaxy wrapper version": "2.11.40.8", + "Conda id": "bioconductor-deseq2", + "Conda version": "1.42.0" + }, + { + "Galaxy wrapper id": "dexseq", + "Galaxy tool ids": [ + "dexseq", + "dexseq_count", + "plotdexseq" + ], + "Description": "Inference of differential exon usage in RNA-Seq", + "bio.tool id": "dexseq", + "bio.tool ids": [ + "dexseq" + ], + "biii": null, + "bio.tool name": "DEXSeq", + "bio.tool description": "The package is focused on finding differential exon usage using RNA-seq exon counts between samples with different experimental designs. It provides functions that allows the user to make the necessary statistical tests based on a model that uses the negative binomial distribution to estimate the variance between biological replicates and generalized linear models for testing. The package also provides functions for the visualization and exploration of the results.", + "EDAM operation": [ + "Enrichment analysis", + "Exonic splicing enhancer prediction" + ], + "EDAM topic": [ + "RNA-Seq" + ], + "Status": "Up-to-date", + "Source": "https://www.bioconductor.org/packages/release/bioc/html/DEXSeq.html", + "ToolShed categories": [ + "Transcriptomics", + "RNA", + "Statistics" + ], + "ToolShed id": "dexseq", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/dexseq", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/dexseq", + "Galaxy wrapper version": "1.48.0", + "Conda id": "bioconductor-dexseq", + "Conda version": "1.48.0" + }, + { + "Galaxy wrapper id": "diamond", + "Galaxy tool ids": [ + "bg_diamond", + "bg_diamond_makedb", + "bg_diamond_view" + ], + "Description": "DIAMOND is a new alignment tool for aligning short DNA sequencing reads to a protein reference database such as NCBI-NR.", + "bio.tool id": "diamond", + "bio.tool ids": [ + "diamond" + ], + "biii": null, + "bio.tool name": "Diamond", + "bio.tool description": "Sequence aligner for protein and translated DNA searches and functions as a drop-in replacement for the NCBI BLAST software tools. It is suitable for protein-protein search as well as DNA-protein search on short reads and longer sequences including contigs and assemblies, providing a speedup of BLAST ranging up to x20,000.", + "EDAM operation": [ + "Sequence alignment analysis" + ], + "EDAM topic": [ + "Sequence analysis", + "Proteins" + ], + "Status": "To update", + "Source": "https://github.com/bbuchfink/diamond", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "diamond", + "Galaxy wrapper owner": "bgruening", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/diamond", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/diamond", + "Galaxy wrapper version": "2.0.15", + "Conda id": "diamond", + "Conda version": "2.1.9" + }, + { + "Galaxy wrapper id": "diffbind", + "Galaxy tool ids": [ + "diffbind" + ], + "Description": "Diffbind provides functions for processing ChIP-Seq data.", + "bio.tool id": "diffbind", + "bio.tool ids": [ + "diffbind" + ], + "biii": null, + "bio.tool name": "DiffBind", + "bio.tool description": "Compute differentially bound sites from multiple ChIP-seq experiments using affinity (quantitative) data. Also enables occupancy (overlap) analysis and plotting functions.", + "EDAM operation": [ + "Differential binding analysis" + ], + "EDAM topic": [ + "ChIP-seq" + ], + "Status": "To update", + "Source": "http://bioconductor.org/packages/release/bioc/html/DiffBind.html", + "ToolShed categories": [ + "ChIP-seq" + ], + "ToolShed id": "diffbind", + "Galaxy wrapper owner": "bgruening", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/diffbind", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/diffbind", + "Galaxy wrapper version": "2.10.0", + "Conda id": "bioconductor-diffbind", + "Conda version": "3.12.0" + }, + { + "Galaxy wrapper id": "dimet", + "Galaxy tool ids": [ + "dimet_@EXECUTABLE@", + "dimet_@EXECUTABLE@", + "dimet_@EXECUTABLE@", + "dimet_@EXECUTABLE@", + "dimet_@EXECUTABLE@", + "dimet_@EXECUTABLE@", + "dimet_@EXECUTABLE@", + "dimet_@EXECUTABLE@", + "dimet_@EXECUTABLE@", + "dimet_@EXECUTABLE@" + ], + "Description": "DIMet is a bioinformatics pipeline for differential analysis of isotopic targeted labeling data.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/cbib/DIMet", + "ToolShed categories": [ + "Metabolomics" + ], + "ToolShed id": null, + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/DIMet", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/dimet", + "Galaxy wrapper version": "0.2.4", + "Conda id": "dimet", + "Conda version": "0.2.4" + }, + { + "Galaxy wrapper id": "disco", + "Galaxy tool ids": [ + "disco" + ], + "Description": "DISCO is a overlap-layout-consensus (OLC) metagenome assembler", + "bio.tool id": "disco", + "bio.tool ids": [ + "disco" + ], + "biii": null, + "bio.tool name": "DISCO", + "bio.tool description": "DISCO is software to perform structure determination of protein homo-oligomers with cyclic symmetry.DISCO computes oligomeric protein structures using geometric constraints derived from RDCs and intermolecular distance restraints such as NOEs or disulfide bonds. When a reliable subunit structure can be calculated from intramolecular restraints, DISCO guarantees that all satisfying oligomer structures will be discovered, yet can run in minutes to hours on only a single desktop-class computer.", + "EDAM operation": [ + "Protein sequence analysis" + ], + "EDAM topic": [ + "Structure determination" + ], + "Status": "To update", + "Source": "http://disco.omicsbio.org/", + "ToolShed categories": [ + "Metagenomics", + "Assembly" + ], + "ToolShed id": "disco", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/disco/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/disco", + "Galaxy wrapper version": null, + "Conda id": "disco", + "Conda version": "1.2" + }, + { + "Galaxy wrapper id": "dnabot", + "Galaxy tool ids": [ + "dnabot" + ], + "Description": "DNA assembly using BASIC on OpenTrons", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/BASIC-DNA-ASSEMBLY/DNA-BOT", + "ToolShed categories": [ + "Synthetic Biology" + ], + "ToolShed id": "dnabot", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/dnabot", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/dnabot", + "Galaxy wrapper version": "3.1.0", + "Conda id": "dnabot", + "Conda version": null + }, + { + "Galaxy wrapper id": "dnaweaver", + "Galaxy tool ids": [ + "dnaweaver" + ], + "Description": "Given a SBOL input, calculate assembly parts for Gibson or Golden Gate.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/Edinburgh-Genome-Foundry/DnaWeaver", + "ToolShed categories": [ + "Synthetic Biology" + ], + "ToolShed id": "dnaweaver", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/dnaweaver", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/dnaweaver", + "Galaxy wrapper version": "1.0.2", + "Conda id": "dnaweaver_synbiocad", + "Conda version": "1.0.2" + }, + { + "Galaxy wrapper id": "dram", + "Galaxy tool ids": [ + "dram_annotate", + "dram_distill", + "dram_merge_annotations", + "dram_neighborhoods", + "dram_strainer" + ], + "Description": "DRAM for distilling microbial metabolism to automate the curation of microbiome function", + "bio.tool id": "dram", + "bio.tool ids": [ + "dram" + ], + "biii": null, + "bio.tool name": "DRAM", + "bio.tool description": "Distilled and Refined Annotation of Metabolism: A tool for the annotation and curation of function for microbial and viral genomes", + "EDAM operation": [ + "Gene functional annotation" + ], + "EDAM topic": [ + "Metagenomics", + "Biological databases", + "Molecular genetics" + ], + "Status": "To update", + "Source": "https://github.com/WrightonLabCSU/DRAM", + "ToolShed categories": [ + "Metagenomics" + ], + "ToolShed id": "dram", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/dram", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/dram", + "Galaxy wrapper version": "1.3.5", + "Conda id": "dram", + "Conda version": "1.5.0" + }, + { + "Galaxy wrapper id": "drep", + "Galaxy tool ids": [ + "drep_compare", + "drep_dereplicate" + ], + "Description": "dRep compares and dereplicates genome sets", + "bio.tool id": "drep", + "bio.tool ids": [ + "drep" + ], + "biii": null, + "bio.tool name": "dRep", + "bio.tool description": "Fast and accurate genomic comparisons that enables improved genome recovery from metagenomes through de-replication.", + "EDAM operation": [ + "Genome comparison" + ], + "EDAM topic": [ + "Metagenomics", + "Genomics", + "Sequence analysis" + ], + "Status": "Up-to-date", + "Source": "https://github.com/MrOlm/drep", + "ToolShed categories": [ + "Metagenomics" + ], + "ToolShed id": "drep", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/drep", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/drep", + "Galaxy wrapper version": "3.5.0", + "Conda id": "drep", + "Conda version": "3.5.0" + }, + { + "Galaxy wrapper id": "dropletutils", + "Galaxy tool ids": [ + "dropletutils" + ], + "Description": "DropletUtils - Utilities for handling droplet-based single-cell RNA-seq data", + "bio.tool id": "dropletutils", + "bio.tool ids": [ + "dropletutils" + ], + "biii": null, + "bio.tool name": "DropletUtils", + "bio.tool description": "Provides a number of utility functions for handling single-cell (RNA-seq) data from droplet technologies such as 10X Genomics. This includes data loading, identification of cells from empty droplets, removal of barcode-swapped pseudo-cells, and downsampling of the count matrix.", + "EDAM operation": [ + "Loading", + "Community profiling" + ], + "EDAM topic": [ + "Gene expression", + "RNA-seq", + "Sequencing", + "Transcriptomics" + ], + "Status": "To update", + "Source": "https://bioconductor.org/packages/devel/bioc/html/DropletUtils.html", + "ToolShed categories": [ + "Transcriptomics", + "Sequence Analysis" + ], + "ToolShed id": "dropletutils", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/dropletutils/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/dropletutils", + "Galaxy wrapper version": "1.10.0", + "Conda id": "bioconductor-dropletutils", + "Conda version": "1.22.0" + }, + { + "Galaxy wrapper id": "ebi_tools", + "Galaxy tool ids": [ + "ebi_metagenomics_run_downloader", + "ebi_search_rest_results" + ], + "Description": "Tools to query and download data from several EMBL-EBI databases", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "http://www.ebi.ac.uk/services/all", + "ToolShed categories": [ + "Web Services", + "Data Source" + ], + "ToolShed id": "ebi_tools", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/ebi_tools", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/ebi_tools", + "Galaxy wrapper version": "0.1.0", + "Conda id": "six", + "Conda version": null + }, + { + "Galaxy wrapper id": "edger", + "Galaxy tool ids": [ + "edger" + ], + "Description": "Perform RNA-Seq differential expression analysis using edgeR pipeline", + "bio.tool id": "edger", + "bio.tool ids": [ + "edger" + ], + "biii": null, + "bio.tool name": "edgeR", + "bio.tool description": "Differential expression analysis of RNA-seq expression profiles with biological replication. Implements a range of statistical methodology based on the negative binomial distributions, including empirical Bayes estimation, exact tests, generalized linear models and quasi-likelihood tests. As well as RNA-seq, it be applied to differential signal analysis of other types of genomic data that produce counts, including ChIP-seq, SAGE and CAGE.", + "EDAM operation": [ + "Differential gene expression analysis" + ], + "EDAM topic": [ + "Genetics", + "RNA-Seq", + "ChIP-seq" + ], + "Status": "To update", + "Source": "http://bioconductor.org/packages/release/bioc/html/edgeR.html", + "ToolShed categories": [ + "Transcriptomics", + "RNA", + "Statistics" + ], + "ToolShed id": "edger", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/edger", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/edger", + "Galaxy wrapper version": "3.36.0", + "Conda id": "bioconductor-edger", + "Conda version": "4.0.16" + }, + { + "Galaxy wrapper id": "egsea", + "Galaxy tool ids": [ + "egsea" + ], + "Description": "This tool implements the Ensemble of Gene Set Enrichment Analyses (EGSEA) method for gene set testing", + "bio.tool id": "egsea", + "bio.tool ids": [ + "egsea" + ], + "biii": null, + "bio.tool name": "EGSEA", + "bio.tool description": "This package implements the Ensemble of Gene Set Enrichment Analyses method for gene set testing.", + "EDAM operation": [ + "Gene set testing" + ], + "EDAM topic": [ + "Systems biology" + ], + "Status": "To update", + "Source": "https://bioconductor.org/packages/release/bioc/html/EGSEA.html", + "ToolShed categories": [ + "Transcriptomics", + "RNA", + "Statistics" + ], + "ToolShed id": "egsea", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/egsea", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/egsea", + "Galaxy wrapper version": "1.20.0", + "Conda id": "bioconductor-egsea", + "Conda version": "1.28.0" + }, + { + "Galaxy wrapper id": "emboss_5", + "Galaxy tool ids": [ + "EMBOSS: antigenic1", + "EMBOSS: backtranseq2", + "EMBOSS: banana3", + "EMBOSS: biosed4", + "EMBOSS: btwisted5", + "EMBOSS: cai6", + "EMBOSS: cai_custom6", + "EMBOSS: chaos7", + "EMBOSS: charge8", + "EMBOSS: checktrans9", + "EMBOSS: chips10", + "EMBOSS: cirdna11", + "EMBOSS: codcmp12", + "EMBOSS: coderet13", + "EMBOSS: compseq14", + "EMBOSS: cpgplot15", + "EMBOSS: cpgreport16", + "EMBOSS: cusp17", + "EMBOSS: cutseq18", + "EMBOSS: dan19", + "EMBOSS: degapseq20", + "EMBOSS: descseq21", + "EMBOSS: diffseq22", + "EMBOSS: digest23", + "EMBOSS: dotmatcher24", + "EMBOSS: dotpath25", + "EMBOSS: dottup26", + "EMBOSS: dreg27", + "EMBOSS: einverted28", + "EMBOSS: epestfind29", + "EMBOSS: equicktandem31", + "EMBOSS: est2genome32", + "EMBOSS: etandem33", + "EMBOSS: extractfeat34", + "EMBOSS: extractseq35", + "EMBOSS: freak36", + "EMBOSS: fuzznuc37", + "EMBOSS: fuzzpro38", + "EMBOSS: fuzztran39", + "EMBOSS: garnier40", + "EMBOSS: geecee41", + "EMBOSS: getorf42", + "EMBOSS: helixturnhelix43", + "EMBOSS: hmoment44", + "EMBOSS: iep45", + "EMBOSS: infoseq46", + "EMBOSS: isochore47", + "EMBOSS: lindna48", + "EMBOSS: marscan49", + "EMBOSS: maskfeat50", + "EMBOSS: maskseq51", + "EMBOSS: matcher52", + "EMBOSS: megamerger53", + "EMBOSS: merger54", + "EMBOSS: msbar55", + "EMBOSS: needle56", + "EMBOSS: newcpgreport57", + "EMBOSS: newcpgseek58", + "EMBOSS: newseq59", + "EMBOSS: noreturn60", + "EMBOSS: notseq61", + "EMBOSS: nthseq62", + "EMBOSS: octanol63", + "EMBOSS: oddcomp64", + "EMBOSS: palindrome65", + "EMBOSS: pasteseq66", + "EMBOSS: patmatdb67", + "EMBOSS: pepcoil68", + "EMBOSS: pepinfo69", + "EMBOSS: pepnet70", + "EMBOSS: pepstats71", + "EMBOSS: pepwheel72", + "EMBOSS: pepwindow73", + "EMBOSS: pepwindowall74", + "EMBOSS: plotcon75", + "EMBOSS: plotorf76", + "EMBOSS: polydot77", + "EMBOSS: preg78", + "EMBOSS: prettyplot79", + "EMBOSS: prettyseq80", + "EMBOSS: primersearch81", + "EMBOSS: revseq82", + "EMBOSS: seqmatchall83", + "EMBOSS: seqret84", + "EMBOSS: showfeat85", + "EMBOSS: shuffleseq87", + "EMBOSS: sigcleave88", + "EMBOSS: sirna89", + "EMBOSS: sixpack90", + "EMBOSS: skipseq91", + "EMBOSS: splitter92", + "EMBOSS: supermatcher95", + "EMBOSS: syco96", + "EMBOSS: tcode97", + "EMBOSS: textsearch98", + "EMBOSS: tmap99", + "EMBOSS: tranalign100", + "EMBOSS: transeq101", + "EMBOSS: trimest102", + "EMBOSS: trimseq103", + "EMBOSS: twofeat104", + "EMBOSS: union105", + "EMBOSS: vectorstrip106", + "EMBOSS: water107", + "EMBOSS: wobble108", + "EMBOSS: wordcount109", + "EMBOSS: wordmatch110" + ], + "Description": "Galaxy wrappers for EMBOSS version 5.0.0 tools", + "bio.tool id": "emboss", + "bio.tool ids": [ + "emboss" + ], + "biii": null, + "bio.tool name": "EMBOSS", + "bio.tool description": "Diverse suite of tools for sequence analysis; many programs analagous to GCG; context-sensitive help for each tool.", + "EDAM operation": [ + "Sequence analysis", + "Local alignment", + "Sequence alignment analysis", + "Global alignment", + "Sequence alignment" + ], + "EDAM topic": [ + "Molecular biology", + "Sequence analysis", + "Biology" + ], + "Status": "To update", + "Source": "http://emboss.open-bio.org/", + "ToolShed categories": [ + "Sequence Analysis", + "Fasta Manipulation" + ], + "ToolShed id": "emboss_5", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/emboss_5", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/emboss_5", + "Galaxy wrapper version": "5.0.0", + "Conda id": "emboss", + "Conda version": "6.6.0" + }, + { + "Galaxy wrapper id": "ena_upload", + "Galaxy tool ids": [ + "ena_upload" + ], + "Description": "Submits experimental data and respective metadata to the European Nucleotide Archive (ENA). ", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/usegalaxy-eu/ena-upload-cli", + "ToolShed categories": [ + "Data Export" + ], + "ToolShed id": "ena_upload", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/ena_upload", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/ena_upload", + "Galaxy wrapper version": "0.7.1", + "Conda id": "ena-upload-cli", + "Conda version": "0.7.1" + }, + { + "Galaxy wrapper id": "enasearch", + "Galaxy tool ids": [ + "enasearch_retrieve_analysis_report", + "enasearch_retrieve_data", + "enasearch_retrieve_run_report", + "enasearch_retrieve_taxons", + "enasearch_search_data" + ], + "Description": "A Python library for interacting with ENA's API", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/bebatut/enasearch", + "ToolShed categories": [ + "Data Source" + ], + "ToolShed id": "enasearch", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/enasearch", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/enasearch", + "Galaxy wrapper version": null, + "Conda id": "enasearch", + "Conda version": "0.2.2" + }, + { + "Galaxy wrapper id": "ensembl_vep", + "Galaxy tool ids": [ + "ensembl_vep" + ], + "Description": "Ensembl VEP: Annotate VCFs with variant effect predictions", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/Ensembl/ensembl-vep", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "ensembl_vep", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/ensembl_vep", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/ensembl_vep", + "Galaxy wrapper version": "110.1", + "Conda id": "ensembl-vep", + "Conda version": "112.0" + }, + { + "Galaxy wrapper id": "episcanpy", + "Galaxy tool ids": [ + "episcanpy_build_matrix", + "episcanpy_cluster_embed", + "episcanpy_preprocess" + ], + "Description": "EpiScanpy \u2013 Epigenomics single cell analysis in python", + "bio.tool id": "episcanpy", + "bio.tool ids": [ + "episcanpy" + ], + "biii": null, + "bio.tool name": "epiScanpy", + "bio.tool description": "Epigenomics Single Cell Analysis in Python.", + "EDAM operation": [ + "Enrichment analysis", + "Imputation" + ], + "EDAM topic": [ + "Epigenomics", + "Cell biology", + "DNA" + ], + "Status": "To update", + "Source": "https://github.com/colomemaria/epiScanpy", + "ToolShed categories": [ + "Epigenetics" + ], + "ToolShed id": "episcanpy", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/episcanpy/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/episcanpy", + "Galaxy wrapper version": "0.3.2", + "Conda id": "episcanpy", + "Conda version": "0.4.0" + }, + { + "Galaxy wrapper id": "exomedepth", + "Galaxy tool ids": [ + "exomedepth" + ], + "Description": "ExomeDepth: Calls copy number variants (CNVs) from targeted sequence data", + "bio.tool id": "exomedepth", + "bio.tool ids": [ + "exomedepth" + ], + "biii": null, + "bio.tool name": "ExomeDepth", + "bio.tool description": "Copy number variant (CNV) calling algorithm designed to control technical variability between samples. It calls CNVs from targeted sequence data, typically exome sequencing experiments designed to identify the genetic basis of Mendelian disorders.", + "EDAM operation": [ + "Sequence analysis", + "Variant calling", + "Genotyping", + "Copy number estimation" + ], + "EDAM topic": [ + "Exome sequencing", + "Gene transcripts", + "Mapping", + "Sequencing", + "Genetic variation", + "Rare diseases" + ], + "Status": "To update", + "Source": "https://cran.r-project.org/package=ExomeDepth", + "ToolShed categories": [ + "Sequence Analysis", + "Variant Analysis" + ], + "ToolShed id": "exomedepth", + "Galaxy wrapper owner": "crs4", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/exomedepth", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/exomedepth", + "Galaxy wrapper version": "1.1.0", + "Conda id": "r-exomedepth", + "Conda version": "1.1.16" + }, + { + "Galaxy wrapper id": "exonerate", + "Galaxy tool ids": [ + "exonerate" + ], + "Description": "Exonerate is a generic tool for pairwise sequence comparison.", + "bio.tool id": "exonerate", + "bio.tool ids": [ + "exonerate" + ], + "biii": null, + "bio.tool name": "Exonerate", + "bio.tool description": "A tool for pairwise sequence alignment. It enables alignment for DNA-DNA and DNA-protein pairs and also gapped and ungapped alignment.", + "EDAM operation": [ + "Pairwise sequence alignment", + "Protein threading", + "Genome alignment" + ], + "EDAM topic": [ + "Sequence analysis", + "Sequence sites, features and motifs", + "Molecular interactions, pathways and networks" + ], + "Status": "Up-to-date", + "Source": "https://www.ebi.ac.uk/about/vertebrate-genomics/software/exonerate", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "exonerate", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/exonerate", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/exonerate", + "Galaxy wrapper version": "2.4.0", + "Conda id": "exonerate", + "Conda version": "2.4.0" + }, + { + "Galaxy wrapper id": "export2graphlan", + "Galaxy tool ids": [ + "export2graphlan" + ], + "Description": "export2graphlan is a conversion software tool for producing both annotation and tree file for GraPhlAn", + "bio.tool id": "export2graphlan", + "bio.tool ids": [ + "export2graphlan" + ], + "biii": null, + "bio.tool name": "export2graphlan", + "bio.tool description": "export2graphlan is a conversion software tool for producing both annotation and tree file for GraPhlAn. In particular, the annotation file tries to highlight specific sub-trees deriving automatically from input file what nodes are important.", + "EDAM operation": [ + "Conversion" + ], + "EDAM topic": [ + "Taxonomy", + "Metabolomics", + "Biomarkers" + ], + "Status": "To update", + "Source": "https://bitbucket.org/CibioCM/export2graphlan/overview", + "ToolShed categories": [ + "Metagenomics" + ], + "ToolShed id": "export2graphlan", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/export2graphlan/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/export2graphlan", + "Galaxy wrapper version": "0.20", + "Conda id": "export2graphlan", + "Conda version": "0.22" + }, + { + "Galaxy wrapper id": "extract_genomic_dna", + "Galaxy tool ids": [ + "Extract genomic DNA 1" + ], + "Description": "Contains a tool that extracts genomic DNA using coordinates from ASSEMBLED genomes and UNassembled genomes.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": null, + "ToolShed categories": [ + "Genomic Interval Operations" + ], + "ToolShed id": "extract_genomic_dna", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/extract_genomic_dna", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/extract_genomic_dna", + "Galaxy wrapper version": "3.0.3+galaxy2", + "Conda id": "bx-python", + "Conda version": "0.11.0" + }, + { + "Galaxy wrapper id": "fargene", + "Galaxy tool ids": [ + "fargene" + ], + "Description": "fARGene (Fragmented Antibiotic Resistance Gene iENntifiEr )", + "bio.tool id": "fargene", + "bio.tool ids": [ + "fargene" + ], + "biii": null, + "bio.tool name": "fARGene", + "bio.tool description": "fARGene (Fragmented Antibiotic Resistance Gene iENntifiEr ) is a tool that takes either fragmented metagenomic data or longer sequences as input and predicts and delivers full-length antiobiotic resistance genes as output.", + "EDAM operation": [ + "Antimicrobial resistance prediction" + ], + "EDAM topic": [ + "Metagenomics", + "Microbiology", + "Public health and epidemiology" + ], + "Status": "Up-to-date", + "Source": "https://github.com/fannyhb/fargene", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "fargene", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/fargene", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/fargene", + "Galaxy wrapper version": "0.1", + "Conda id": "fargene", + "Conda version": "0.1" + }, + { + "Galaxy wrapper id": "fasta_nucleotide_color_plot", + "Galaxy tool ids": [ + "fasta_nucleotide_color_plot" + ], + "Description": "Contains a tool that produces a graphical representation of FASTA data with each nucleotide represented by a selected color.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/seqcode/cegr-tools/tree/master/src/org/seqcode/cegrtools/fourcolorplot", + "ToolShed categories": [ + "Visualization" + ], + "ToolShed id": "fasta_nucleotide_color_plot", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/fasta_nucleotide_color_plot", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/fasta_nucleotide_color_plot", + "Galaxy wrapper version": "1.0.1", + "Conda id": "openjdk", + "Conda version": null + }, + { + "Galaxy wrapper id": "fasta_stats", + "Galaxy tool ids": [ + "fasta-stats" + ], + "Description": "Display summary statistics for a fasta file.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/fasta_stats/", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "fasta_stats", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/fasta_stats/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/fasta_stats", + "Galaxy wrapper version": "2.0", + "Conda id": "numpy", + "Conda version": null + }, + { + "Galaxy wrapper id": "fastani", + "Galaxy tool ids": [ + "fastani" + ], + "Description": "Fast alignment-free computation of whole-genome Average Nucleotide Identity", + "bio.tool id": "fastani", + "bio.tool ids": [ + "fastani" + ], + "biii": null, + "bio.tool name": "FastANI", + "bio.tool description": "FastANI is developed for fast alignment-free computation of whole-genome Average Nucleotide Identity (ANI). ANI is defined as mean nucleotide identity of orthologous gene pairs shared between two microbial genomes. FastANI supports pairwise comparison of both complete and draft genome assemblies.", + "EDAM operation": [ + "Genome alignment", + "Sequence similarity search" + ], + "EDAM topic": [ + "Microbiology", + "Genetic variation" + ], + "Status": "To update", + "Source": "https://github.com/ParBLiSS/FastANI", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "fastani", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/fastani", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/fastani", + "Galaxy wrapper version": "1.3", + "Conda id": "fastani", + "Conda version": "1.34" + }, + { + "Galaxy wrapper id": "fastk", + "Galaxy tool ids": [ + "fastk_fastk" + ], + "Description": "FastK: A K-mer counter (for HQ assembly data sets)", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/thegenemyers/FASTK", + "ToolShed categories": [ + "Assembly" + ], + "ToolShed id": "fastk", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/fastk", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/fastk", + "Galaxy wrapper version": "1.0.0", + "Conda id": "fastk", + "Conda version": "1.0" + }, + { + "Galaxy wrapper id": "fastp", + "Galaxy tool ids": [ + "fastp" + ], + "Description": "Fast all-in-one preprocessing for FASTQ files", + "bio.tool id": "fastp", + "bio.tool ids": [ + "fastp" + ], + "biii": null, + "bio.tool name": "fastp", + "bio.tool description": "A tool designed to provide fast all-in-one preprocessing for FastQ files. This tool is developed in C++ with multithreading supported to afford high performance.", + "EDAM operation": [ + "Sequencing quality control", + "Sequence contamination filtering" + ], + "EDAM topic": [ + "Sequence analysis", + "Probes and primers" + ], + "Status": "Up-to-date", + "Source": "https://github.com/OpenGene/fastp", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "fastp", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/fastp", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/fastp", + "Galaxy wrapper version": "0.23.4", + "Conda id": "fastp", + "Conda version": "0.23.4" + }, + { + "Galaxy wrapper id": "fastqc", + "Galaxy tool ids": [ + "fastqc" + ], + "Description": "Read QC reports using FastQC", + "bio.tool id": "fastqc", + "bio.tool ids": [ + "fastqc" + ], + "biii": null, + "bio.tool name": "FastQC", + "bio.tool description": "This tool aims to provide a QC report which can spot problems or biases which originate either in the sequencer or in the starting library material. It can be run in one of two modes. It can either run as a stand alone interactive application for the immediate analysis of small numbers of FastQ files, or it can be run in a non-interactive mode where it would be suitable for integrating into a larger analysis pipeline for the systematic processing of large numbers of files.", + "EDAM operation": [ + "Sequence composition calculation", + "Sequencing quality control", + "Statistical calculation" + ], + "EDAM topic": [ + "Sequencing", + "Data quality management", + "Sequence analysis" + ], + "Status": "To update", + "Source": "http://www.bioinformatics.babraham.ac.uk/projects/fastqc/", + "ToolShed categories": [ + "Fastq Manipulation" + ], + "ToolShed id": "fastqc", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/fastqc", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/fastqc", + "Galaxy wrapper version": "0.74+galaxy0", + "Conda id": "fastqc", + "Conda version": "0.12.1" + }, + { + "Galaxy wrapper id": "fastqe", + "Galaxy tool ids": [ + "fastqe" + ], + "Description": "FASTQE", + "bio.tool id": "fastqe", + "bio.tool ids": [ + "fastqe" + ], + "biii": null, + "bio.tool name": "FASTQE", + "bio.tool description": "Compute quality stats for FASTQ files and print those stats as emoji... for some reason.", + "EDAM operation": [ + "Sequencing quality control" + ], + "EDAM topic": [ + "Sequence analysis", + "Sequencing" + ], + "Status": "To update", + "Source": "https://fastqe.com/", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "fastqe", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/fastqe", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/fastqe", + "Galaxy wrapper version": "0.3.1+galaxy0", + "Conda id": "fastqe", + "Conda version": "0.3.1" + }, + { + "Galaxy wrapper id": "fasttree", + "Galaxy tool ids": [ + "fasttree" + ], + "Description": "FastTree infers approximately-maximum-likelihood phylogenetic trees from alignments of nucleotide or protein sequences - GVL", + "bio.tool id": "fasttree", + "bio.tool ids": [ + "fasttree" + ], + "biii": null, + "bio.tool name": "FastTree", + "bio.tool description": "Infers approximately-maximum-likelihood phylogenetic trees from alignments of nucleotide or protein sequences.", + "EDAM operation": [ + "Phylogenetic tree generation (from molecular sequences)", + "Phylogenetic tree generation (maximum likelihood and Bayesian methods)" + ], + "EDAM topic": [ + "Phylogenetics", + "Sequence analysis" + ], + "Status": "To update", + "Source": "http://www.microbesonline.org/fasttree/", + "ToolShed categories": [ + "Phylogenetics" + ], + "ToolShed id": "fasttree", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/fasttree", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/fasttree", + "Galaxy wrapper version": "2.1.10", + "Conda id": "fasttree", + "Conda version": "2.1.11" + }, + { + "Galaxy wrapper id": "featurecounts", + "Galaxy tool ids": [ + "featurecounts" + ], + "Description": "featureCounts counts the number of reads aligned to defined masked regions in a reference genome", + "bio.tool id": "featurecounts", + "bio.tool ids": [ + "featurecounts" + ], + "biii": null, + "bio.tool name": "FeatureCounts", + "bio.tool description": "featureCounts is a very efficient read quantifier. It can be used to summarize RNA-seq reads and gDNA-seq reads to a variety of genomic features such as genes, exons, promoters, gene bodies and genomic bins. It is included in the Bioconductor Rsubread package and also in the SourceForge Subread package.", + "EDAM operation": [ + "Read summarisation", + "RNA-Seq quantification" + ], + "EDAM topic": [ + "RNA-Seq" + ], + "Status": "To update", + "Source": "http://bioinf.wehi.edu.au/featureCounts", + "ToolShed categories": [ + "RNA", + "Transcriptomics", + "Sequence Analysis" + ], + "ToolShed id": "featurecounts", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/featurecounts", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/featurecounts", + "Galaxy wrapper version": "2.0.3", + "Conda id": "subread", + "Conda version": "2.0.6" + }, + { + "Galaxy wrapper id": "feelnc", + "Galaxy tool ids": [ + "feelnc" + ], + "Description": "Galaxy wrapper for FEELnc", + "bio.tool id": "feelnc", + "bio.tool ids": [ + "feelnc" + ], + "biii": null, + "bio.tool name": "FEELnc", + "bio.tool description": "A tool to annotate long non-coding RNAs from RNA-seq assembled transcripts.", + "EDAM operation": [ + "Annotation", + "Classification" + ], + "EDAM topic": [ + "RNA-seq", + "Functional, regulatory and non-coding RNA" + ], + "Status": "To update", + "Source": "https://github.com/tderrien/FEELnc", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "feelnc", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/feelnc", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/feelnc", + "Galaxy wrapper version": "0.2.1", + "Conda id": "feelnc", + "Conda version": "0.2" + }, + { + "Galaxy wrapper id": "fermikit", + "Galaxy tool ids": [ + "fermi2", + "fermikit_variants" + ], + "Description": "FermiKit is a de novo assembly based variant calling pipeline for deep Illumina resequencing data.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/lh3/fermikit", + "ToolShed categories": [ + "Assembly", + "Variant Analysis" + ], + "ToolShed id": "fermikit", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/fermikit", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/fermikit", + "Galaxy wrapper version": "r193", + "Conda id": "fermi2", + "Conda version": "r193" + }, + { + "Galaxy wrapper id": "fgsea", + "Galaxy tool ids": [ + "fgsea" + ], + "Description": "Perform gene set testing using fgsea", + "bio.tool id": "fgsea", + "bio.tool ids": [ + "fgsea" + ], + "biii": null, + "bio.tool name": "fgsea", + "bio.tool description": "The package implements an algorithm for fast gene set enrichment analysis. Using the fast algorithm allows to make more permutations and get more fine grained p-values, which allows to use accurate stantard approaches to multiple hypothesis correction.", + "EDAM operation": [ + "Gene-set enrichment analysis" + ], + "EDAM topic": [ + "Genetics" + ], + "Status": "To update", + "Source": "https://bioconductor.org/packages/release/bioc/html/fgsea.html", + "ToolShed categories": [ + "Visualization", + "Transcriptomics", + "Statistics" + ], + "ToolShed id": "fgsea", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/fgsea", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/fgsea", + "Galaxy wrapper version": "1.8.0+galaxy1", + "Conda id": "bioconductor-fgsea", + "Conda version": "1.28.0" + }, + { + "Galaxy wrapper id": "filtlong", + "Galaxy tool ids": [ + "filtlong" + ], + "Description": "Filtlong - Filtering long reads by quality", + "bio.tool id": "filtlong", + "bio.tool ids": [ + "filtlong" + ], + "biii": null, + "bio.tool name": "Filtlong", + "bio.tool description": "Filtlong is a tool for filtering long reads by quality. It can take a set of long reads and produce a smaller, better subset. It uses both read length (longer is better) and read identity (higher is better) when choosing which reads pass the filter.", + "EDAM operation": [ + "Filtering", + "Sequencing quality control" + ], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/rrwick/Filtlong", + "ToolShed categories": [ + "Fastq Manipulation", + "Sequence Analysis" + ], + "ToolShed id": "filtlong", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/filtlong", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/filtlong", + "Galaxy wrapper version": "0.2.1", + "Conda id": "filtlong", + "Conda version": "0.2.1" + }, + { + "Galaxy wrapper id": "flair", + "Galaxy tool ids": [ + "flair_collapse", + "flair_correct" + ], + "Description": "FLAIR (Full-Length Alternative Isoform analysis of RNA) for the correction, isoform definition, and alternative splicing analysis of noisy reads.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/BrooksLabUCSC/flair", + "ToolShed categories": [ + "Nanopore" + ], + "ToolShed id": "flair", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/flair", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/flair", + "Galaxy wrapper version": "1.5", + "Conda id": "flair", + "Conda version": "2.0.0" + }, + { + "Galaxy wrapper id": "flash", + "Galaxy tool ids": [ + "flash" + ], + "Description": "Fast Length Adjustment of SHort reads", + "bio.tool id": "flash", + "bio.tool ids": [ + "flash" + ], + "biii": null, + "bio.tool name": "FLASH", + "bio.tool description": "Identifies paired-end reads which overlap in the middle, converting them to single long reads", + "EDAM operation": [ + "Read pre-processing", + "Sequence merging", + "Sequence assembly" + ], + "EDAM topic": [ + "Sequencing", + "Sequence assembly" + ], + "Status": "Up-to-date", + "Source": "https://ccb.jhu.edu/software/FLASH/", + "ToolShed categories": [ + "Assembly", + "Fastq Manipulation" + ], + "ToolShed id": "flash", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/flash", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/flash", + "Galaxy wrapper version": "1.2.11", + "Conda id": "flash", + "Conda version": "1.2.11" + }, + { + "Galaxy wrapper id": "fraggenescan", + "Galaxy tool ids": [ + "fraggenescan" + ], + "Description": "Tool for finding (fragmented) genes in short read", + "bio.tool id": "fraggenescan", + "bio.tool ids": [ + "fraggenescan" + ], + "biii": null, + "bio.tool name": "FragGeneScan", + "bio.tool description": "Application for finding (fragmented) genes in short reads", + "EDAM operation": [ + "Gene prediction" + ], + "EDAM topic": [ + "Genetics", + "Sequence analysis" + ], + "Status": "To update", + "Source": "https://sourceforge.net/projects/fraggenescan/", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "fraggenescan", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/fraggenescan/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/fraggenescan", + "Galaxy wrapper version": null, + "Conda id": "fraggenescan", + "Conda version": "1.31" + }, + { + "Galaxy wrapper id": "freebayes", + "Galaxy tool ids": [ + "freebayes", + "bamleftalign" + ], + "Description": "Galaxy Freebayes Bayesian genetic variant detector tool", + "bio.tool id": "freebayes", + "bio.tool ids": [ + "freebayes" + ], + "biii": null, + "bio.tool name": "FreeBayes", + "bio.tool description": "Bayesian genetic variant detector designed to find small polymorphisms, specifically SNPs, indels, multi-nucleotide polymorphisms, and complex events (composite insertion and substitution events) smaller than the length of a short-read sequencing alignment.", + "EDAM operation": [ + "Variant calling", + "Statistical calculation" + ], + "EDAM topic": [ + "Genomics", + "Genetic variation", + "Rare diseases" + ], + "Status": "To update", + "Source": "https://github.com/ekg/freebayes", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "freebayes", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/freebayes", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/freebayes", + "Galaxy wrapper version": "1.3.6", + "Conda id": "freebayes", + "Conda version": "1.3.7" + }, + { + "Galaxy wrapper id": "freec", + "Galaxy tool ids": [ + "control_freec" + ], + "Description": "Control-FREEC is a tool for detection of copy-number changes and allelic imbalances (including LOH) using deep-sequencing data originally developed by the Bioinformatics Laboratory of Institut Curie (Paris). It automatically computes, normalizes, segments copy number and beta allele frequency (BAF) profiles, then calls copy number alterations and LOH.", + "bio.tool id": "freec", + "bio.tool ids": [ + "freec" + ], + "biii": null, + "bio.tool name": "FREEC", + "bio.tool description": "A tool for control-free copy number alteration (CNA) and allelic imbalances (LOH) detection using deep-sequencing data, particularly useful for cancer studies.", + "EDAM operation": [ + "Copy number estimation", + "Variant calling", + "Genome alignment" + ], + "EDAM topic": [ + "DNA structural variation", + "Oncology", + "Human genetics", + "Data mining" + ], + "Status": "To update", + "Source": "http://boevalab.inf.ethz.ch/FREEC/", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "control_freec", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/freec", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/freec", + "Galaxy wrapper version": "11.6", + "Conda id": "gawk", + "Conda version": null + }, + { + "Galaxy wrapper id": "freyja", + "Galaxy tool ids": [ + "freyja_aggregate_plot", + "freyja_boot", + "freyja_demix", + "freyja_variants" + ], + "Description": "lineage abundances estimation", + "bio.tool id": "freyja", + "bio.tool ids": [ + "freyja" + ], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/andersen-lab/Freyja", + "ToolShed categories": [ + "Metagenomics", + "Sequence Analysis" + ], + "ToolShed id": "freyja", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/freyja", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/freyja", + "Galaxy wrapper version": "1.4.4", + "Conda id": "freyja", + "Conda version": "1.5.0" + }, + { + "Galaxy wrapper id": "fsd", + "Galaxy tool ids": [ + "fsd", + "fsd_beforevsafter", + "fsd_regions", + "td" + ], + "Description": "Tool that plots a histogram of sizes of read families", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": null, + "ToolShed categories": [ + "Graphics" + ], + "ToolShed id": "duplex_family_size_distribution", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/fsd", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/fsd", + "Galaxy wrapper version": "1.0.2", + "Conda id": "matplotlib", + "Conda version": null + }, + { + "Galaxy wrapper id": "funannotate", + "Galaxy tool ids": [ + "funannotate_annotate", + "funannotate_clean", + "funannotate_compare", + "funannotate_predict", + "funannotate_sort" + ], + "Description": "Funannotate is a genome prediction, annotation, and comparison software package.", + "bio.tool id": "funannotate", + "bio.tool ids": [ + "funannotate" + ], + "biii": null, + "bio.tool name": "funannotate", + "bio.tool description": "funannotate is a pipeline for genome annotation (built specifically for fungi, but will also work with higher eukaryotes).", + "EDAM operation": [ + "Genome annotation" + ], + "EDAM topic": [ + "Genomics" + ], + "Status": "To update", + "Source": "https://funannotate.readthedocs.io", + "ToolShed categories": [ + "Genome annotation" + ], + "ToolShed id": null, + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/funannotate", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/funannotate", + "Galaxy wrapper version": "1.8.15", + "Conda id": null, + "Conda version": null + }, + { + "Galaxy wrapper id": "gatk4", + "Galaxy tool ids": [ + "gatk4_mutect2" + ], + "Description": "A Galaxy wrapper for Mutect2 from GATK", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://software.broadinstitute.org/gatk/gatk4", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "gatk4_mutect2", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/gatk4", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/gatk4", + "Galaxy wrapper version": "4.1.7.0", + "Conda id": "gatk4", + "Conda version": "4.5.0.0" + }, + { + "Galaxy wrapper id": "gdcwebapp", + "Galaxy tool ids": [ + "data_source_gdcwebapp" + ], + "Description": "GDCWebApp automatically filter, extract, and convert genomic data from the Genomic Data Commons portal to BED format", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "http://bioinf.iasi.cnr.it/gdcwebapp/", + "ToolShed categories": [ + "Data Source", + "Convert Formats" + ], + "ToolShed id": "gdcwebapp", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/fabio-cumbo/GDCWebApp4Galaxy", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/gdcwebapp", + "Galaxy wrapper version": "1.0.0", + "Conda id": "python", + "Conda version": null + }, + { + "Galaxy wrapper id": "gecko", + "Galaxy tool ids": [ + "gecko" + ], + "Description": "Ungapped genome comparison", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/otorreno/gecko", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "gecko", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/gecko", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/gecko", + "Galaxy wrapper version": "1.2", + "Conda id": "gecko", + "Conda version": "1.2" + }, + { + "Galaxy wrapper id": "gemini", + "Galaxy tool ids": [ + "gemini_@BINARY@", + "gemini_@BINARY@", + "gemini_@BINARY@", + "gemini_@BINARY@", + "gemini_db_info", + "gemini_@BINARY@", + "gemini_@BINARY@", + "gemini_inheritance", + "gemini_@BINARY@", + "gemini_@BINARY@", + "gemini_@BINARY@", + "gemini_@BINARY@", + "gemini_@BINARY@", + "gemini_@BINARY@", + "gemini_@BINARY@", + "gemini_@BINARY@", + "gemini_@BINARY@", + "gemini_@BINARY@" + ], + "Description": "GEMINI: a flexible framework for exploring genome variation", + "bio.tool id": "gemini", + "bio.tool ids": [ + "gemini" + ], + "biii": null, + "bio.tool name": "GEMINI", + "bio.tool description": "GEMINI (GEnome MINIng) is a flexible framework for exploring genetic variation in the context of the wealth of genome annotations available for the human genome. By placing genetic variants, sample phenotypes and genotypes, as well as genome annotations into an integrated database framework, GEMINI provides a simple, flexible, and powerful system for exploring genetic variation for disease and population genetics.", + "EDAM operation": [ + "Sequence analysis", + "Genetic variation analysis" + ], + "EDAM topic": [ + "Sequence analysis" + ], + "Status": "To update", + "Source": "https://github.com/arq5x/gemini", + "ToolShed categories": [ + "Sequence Analysis", + "Next Gen Mappers" + ], + "ToolShed id": "gemini", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/gemini", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/gemini", + "Galaxy wrapper version": "0.20.1", + "Conda id": "gemini", + "Conda version": "0.30.2" + }, + { + "Galaxy wrapper id": "genebed_maf_to_fasta", + "Galaxy tool ids": [ + "GeneBed_Maf_Fasta2" + ], + "Description": "Stitch gene blocks given a set of coding exon intervals", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/genebed_maf_to_fasta/", + "ToolShed categories": [ + "Genomic Interval Operations" + ], + "ToolShed id": "genebed_maf_to_fasta", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/genebed_maf_to_fasta/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/genebed_maf_to_fasta", + "Galaxy wrapper version": "1.0.1+galaxy0", + "Conda id": null, + "Conda version": null + }, + { + "Galaxy wrapper id": "genehunter_modscore", + "Galaxy tool ids": [ + "genehunter_modscore" + ], + "Description": "Maximised LOD score pedigree analysis utility", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://www.helmholtz-muenchen.de/en/ige/service/software-download/genehunter-modscore/index.html", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "genehunter_modscore", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/genehunter_modscore/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/genehunter_modscore", + "Galaxy wrapper version": "3.0.0", + "Conda id": "ghm", + "Conda version": "3.1" + }, + { + "Galaxy wrapper id": "geneiobio", + "Galaxy tool ids": [ + "gene_iobio_display_generation_iframe" + ], + "Description": "Gene.iobio is an interactive tool for variant and trio analysis.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/iobio/gene.iobio", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "geneiobio", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/geneiobio", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/geneiobio", + "Galaxy wrapper version": "4.7.1+galaxy1", + "Conda id": null, + "Conda version": null + }, + { + "Galaxy wrapper id": "genetrack", + "Galaxy tool ids": [ + "genetrack" + ], + "Description": "Contains a tool that separately identifies peaks on the forward \"+\u201d (W) and reverse \u201c-\u201d (C) strand.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": null, + "ToolShed categories": [ + "ChIP-seq" + ], + "ToolShed id": "genetrack", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/genetrack", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/genetrack", + "Galaxy wrapper version": null, + "Conda id": "numpy", + "Conda version": null + }, + { + "Galaxy wrapper id": "genomescope", + "Galaxy tool ids": [ + "genomescope" + ], + "Description": "Analyze unassembled short reads", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/tbenavi1/genomescope2.0", + "ToolShed categories": [ + "Statistics" + ], + "ToolShed id": "genomescope", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/genomescope", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/genomescope", + "Galaxy wrapper version": "2.0", + "Conda id": "genomescope2", + "Conda version": "2.0" + }, + { + "Galaxy wrapper id": "genomic_super_signature", + "Galaxy tool ids": [ + "genomic_super_signature" + ], + "Description": "Interpretation of RNAseq experiments through robust, efficient comparison to public databases", + "bio.tool id": "genomicsupersignature", + "bio.tool ids": [ + "genomicsupersignature" + ], + "biii": null, + "bio.tool name": "GenomicSuperSignature", + "bio.tool description": "GenomicSuperSignature is a package for the interpretation of RNA-seq experiments through robust, efficient comparison to public databases.", + "EDAM operation": [ + "Gene-set enrichment analysis", + "Essential dynamics", + "Deposition", + "Principal component visualisation", + "Dimensionality reduction" + ], + "EDAM topic": [ + "RNA-Seq", + "Transcriptomics", + "Microbial ecology", + "Genotype and phenotype", + "Microarray experiment" + ], + "Status": "To update", + "Source": "https://github.com/shbrief/GenomicSuperSignature", + "ToolShed categories": [ + "Sequence Analysis", + "RNA", + "Transcriptomics" + ], + "ToolShed id": "genomic_super_signature", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/genomic_super_signature", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/genomic_super_signature", + "Galaxy wrapper version": "1.2.0", + "Conda id": "bioconductor-genomicsupersignature", + "Conda version": "1.10.0" + }, + { + "Galaxy wrapper id": "genrich", + "Galaxy tool ids": [ + "genrich" + ], + "Description": "Genrich is a peak-caller for genomic enrichment assays (e.g. ChIP-seq, ATAC-seq).", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/jsh58/Genrich", + "ToolShed categories": [ + "ChIP-seq" + ], + "ToolShed id": "genrich", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/jsh58/Genrich", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/genrich", + "Galaxy wrapper version": "0.5+galaxy2", + "Conda id": "genrich", + "Conda version": "0.6.1" + }, + { + "Galaxy wrapper id": "get_hrun", + "Galaxy tool ids": [ + "get_hrun" + ], + "Description": "Annotate indel variants with homopolymer context", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/get_hrun", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "get_hrun", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/get_hrun", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/get_hrun", + "Galaxy wrapper version": "0.5.9.2", + "Conda id": "pyfaidx", + "Conda version": "0.8.1.1" + }, + { + "Galaxy wrapper id": "getorganelle", + "Galaxy tool ids": [ + "get_annotated_regions_from_gb", + "get_organelle_from_reads" + ], + "Description": "GetOrganelle - This toolkit assembles organelle genomes from genomic skimming data.", + "bio.tool id": "getorganelle", + "bio.tool ids": [ + "getorganelle" + ], + "biii": null, + "bio.tool name": "GetOrganelle", + "bio.tool description": "A fast and versatile toolkit for accurate de novo assembly of organelle genomes.This toolkit assemblies organelle genome from genomic skimming data.", + "EDAM operation": [ + "De-novo assembly", + "Genome assembly", + "Mapping assembly", + "Mapping", + "Sequence trimming" + ], + "EDAM topic": [ + "Cell biology", + "Sequence assembly", + "Whole genome sequencing", + "Plant biology", + "Model organisms" + ], + "Status": "Up-to-date", + "Source": "https://github.com/Kinggerm/GetOrganelle", + "ToolShed categories": [ + "Assembly" + ], + "ToolShed id": "getorganelle", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/getorganelle", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/getorganelle", + "Galaxy wrapper version": "1.7.7.1", + "Conda id": "getorganelle", + "Conda version": "1.7.7.1" + }, + { + "Galaxy wrapper id": "gfa_to_fa", + "Galaxy tool ids": [ + "gfa_to_fa" + ], + "Description": "gfa_to_fa - Converting GFA format to Fasta format", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "http://gfa-spec.github.io/GFA-spec/", + "ToolShed categories": [ + "Convert Formats" + ], + "ToolShed id": "gfa_to_fa", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/gfa_to_fa", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/gfa_to_fa", + "Galaxy wrapper version": "0.1.2", + "Conda id": null, + "Conda version": null + }, + { + "Galaxy wrapper id": "gff3_rebase", + "Galaxy tool ids": [ + "gff3.rebase" + ], + "Description": "Rebase a GFF against a parent GFF (e.g. an original genome)", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/gff3_rebase", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "gff3_rebase", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/gff3_rebase", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/gff3_rebase", + "Galaxy wrapper version": "1.2", + "Conda id": "bcbiogff", + "Conda version": "0.6.6" + }, + { + "Galaxy wrapper id": "gffcompare", + "Galaxy tool ids": [ + "gffcompare" + ], + "Description": "Galaxy wrappers for Geo Pertea's GffCompare package.", + "bio.tool id": "gffcompare", + "bio.tool ids": [ + "gffcompare" + ], + "biii": null, + "bio.tool name": "gffcompare", + "bio.tool description": "Program for comparing, annotating, merging and tracking transcripts in GFF files.", + "EDAM operation": [ + "Sequence annotation" + ], + "EDAM topic": [ + "Nucleic acids", + "Sequence analysis" + ], + "Status": "Up-to-date", + "Source": "https://github.com/gpertea/gffcompare/", + "ToolShed categories": [ + "Transcriptomics" + ], + "ToolShed id": "gffcompare", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/gffcompare", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/gffcompare", + "Galaxy wrapper version": "0.12.6", + "Conda id": "gffcompare", + "Conda version": "0.12.6" + }, + { + "Galaxy wrapper id": "gffread", + "Galaxy tool ids": [ + "gffread" + ], + "Description": "gffread filters and/or converts GFF3/GTF2 records", + "bio.tool id": "gffread", + "bio.tool ids": [ + "gffread" + ], + "biii": null, + "bio.tool name": "gffread", + "bio.tool description": "program for filtering, converting and manipulating GFF files", + "EDAM operation": [ + "Sequence annotation" + ], + "EDAM topic": [ + "Nucleic acids", + "Sequence analysis" + ], + "Status": "Up-to-date", + "Source": "http://ccb.jhu.edu/software/stringtie/gff.shtml#gffread/", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "gffread", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/gffread", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/gffread", + "Galaxy wrapper version": "0.12.7", + "Conda id": "gffread", + "Conda version": "0.12.7" + }, + { + "Galaxy wrapper id": "ggplot2", + "Galaxy tool ids": [ + "ggplot2_heatmap", + "ggplot2_pca", + "ggplot2_histogram", + "ggplot2_point", + "ggplot2_violin" + ], + "Description": "ggplot2 is a system for declaratively creating graphics, based on The Grammar of Graphics.You provide the data, tell ggplot2 how to map variables to aesthetics, what graphical primitives to use,and it takes care of the details.", + "bio.tool id": "ggplot2", + "bio.tool ids": [ + "ggplot2" + ], + "biii": null, + "bio.tool name": "ggplot2", + "bio.tool description": "Plotting system for R, based on the grammar of graphics.", + "EDAM operation": [ + "Visualisation" + ], + "EDAM topic": [ + "Data visualisation" + ], + "Status": "To update", + "Source": "https://github.com/tidyverse/ggplot2", + "ToolShed categories": [ + "Visualization" + ], + "ToolShed id": null, + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/ggplot2", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/ggplot2", + "Galaxy wrapper version": "3.4.0", + "Conda id": "r-base", + "Conda version": null + }, + { + "Galaxy wrapper id": "ggupset", + "Galaxy tool ids": [ + "emc-ggupset" + ], + "Description": "Create Upset Plots with ggupset", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/const-ae/ggupset", + "ToolShed categories": [ + "Graphics" + ], + "ToolShed id": "ggupset", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/ggupset", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/ggupset", + "Galaxy wrapper version": "1.0", + "Conda id": "r-ggupset", + "Conda version": null + }, + { + "Galaxy wrapper id": "glimmer", + "Galaxy tool ids": [ + "glimmer_acgt_content", + "glimmer_build_icm", + "glimmer_extract", + "glimmer_gbk_to_orf", + "glimmer_glimmer_to_gff", + "glimmer_long_orfs", + "glimmer_knowledge_based", + "glimmer_not_knowledge_based" + ], + "Description": "Glimmer makes gene predictions.", + "bio.tool id": "gemini", + "bio.tool ids": [ + "gemini" + ], + "biii": null, + "bio.tool name": "GEMINI", + "bio.tool description": "GEMINI (GEnome MINIng) is a flexible framework for exploring genetic variation in the context of the wealth of genome annotations available for the human genome. By placing genetic variants, sample phenotypes and genotypes, as well as genome annotations into an integrated database framework, GEMINI provides a simple, flexible, and powerful system for exploring genetic variation for disease and population genetics.", + "EDAM operation": [ + "Sequence analysis", + "Genetic variation analysis" + ], + "EDAM topic": [ + "Sequence analysis" + ], + "Status": "To update", + "Source": "https://ccb.jhu.edu/software/glimmer/", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": null, + "Galaxy wrapper owner": "bgruening", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/glimmer", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/glimmer", + "Galaxy wrapper version": null, + "Conda id": "glimmer", + "Conda version": "3.02" + }, + { + "Galaxy wrapper id": "goenrichment", + "Galaxy tool ids": [ + "goenrichment", + "goslimmer" + ], + "Description": "Performs GO Enrichment analysis.", + "bio.tool id": "goenrichment", + "bio.tool ids": [ + "goenrichment" + ], + "biii": null, + "bio.tool name": "GOEnrichment", + "bio.tool description": "GOEnrichment is a tool for performing GO enrichment analysis of gene sets, such as those obtained from RNA-seq or Microarray experiments, to help characterize them at the functional level. It is available in Galaxy Europe and as a stand-alone tool.GOEnrichment is flexible in that it allows the user to use any version of the Gene Ontology and any GO annotation file they desire. To enable the use of GO slims, it is accompanied by a sister tool GOSlimmer, which can convert annotation files from full GO to any specified GO slim.The tool features an optional graph clustering algorithm to reduce the redundancy in the set of enriched GO terms and simplify its output.It was developed by the BioData.pt / ELIXIR-PT team at the Instituto Gulbenkian de Ci\u00eancia.", + "EDAM operation": [ + "Gene-set enrichment analysis" + ], + "EDAM topic": [ + "Transcriptomics" + ], + "Status": "Up-to-date", + "Source": "https://github.com/DanFaria/GOEnrichment", + "ToolShed categories": [ + "Genome annotation" + ], + "ToolShed id": null, + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/goenrichment", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/goenrichment", + "Galaxy wrapper version": "2.0.1", + "Conda id": "goenrichment", + "Conda version": "2.0.1" + }, + { + "Galaxy wrapper id": "goseq", + "Galaxy tool ids": [ + "goseq" + ], + "Description": "goseq does selection-unbiased testing for category enrichment amongst differentially expressed (DE) genes for RNA-seq data", + "bio.tool id": "goseq", + "bio.tool ids": [ + "goseq" + ], + "biii": null, + "bio.tool name": "GOseq", + "bio.tool description": "Detect Gene Ontology and/or other user defined categories which are over/under represented in RNA-seq data.", + "EDAM operation": [ + "Gene functional annotation" + ], + "EDAM topic": [ + "RNA-Seq" + ], + "Status": "To update", + "Source": "https://bioconductor.org/packages/release/bioc/html/goseq.html", + "ToolShed categories": [ + "Statistics", + "RNA", + "Micro-array Analysis" + ], + "ToolShed id": "goseq", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/goseq", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/goseq", + "Galaxy wrapper version": "1.50.0", + "Conda id": "bioconductor-goseq", + "Conda version": "1.54.0" + }, + { + "Galaxy wrapper id": "gprofiler", + "Galaxy tool ids": [ + "gprofiler_convert", + "gprofiler_gost", + "gprofiler_orth", + "gprofiler_random", + "gprofiler_snpense" + ], + "Description": "functional enrichment analysis of gene lists, convertion between various types of namespaces, translation gene identifiers between organisms and more", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://biit.cs.ut.ee/gprofiler", + "ToolShed categories": [ + "Statistics", + "Web Services" + ], + "ToolShed id": "gprofiler", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/gprofiler/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/gprofiler", + "Galaxy wrapper version": "@TOOL_VERSION@+galaxy11", + "Conda id": "r-gprofiler2", + "Conda version": null + }, + { + "Galaxy wrapper id": "graphembed", + "Galaxy tool ids": [ + "graphembed" + ], + "Description": "Compute a 2D embedding of a data matrix given supervised class information", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/fabriziocosta/GraphEmbed", + "ToolShed categories": [ + "Statistics", + "Graphics" + ], + "ToolShed id": "graphembed", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/graphembed/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/graphembed", + "Galaxy wrapper version": "2.4", + "Conda id": "graph_embed", + "Conda version": "2.4" + }, + { + "Galaxy wrapper id": "graphlan", + "Galaxy tool ids": [ + "graphlan", + "graphlan_annotate" + ], + "Description": "GraPhlAn is a software tool for producing high-quality circular representations of taxonomic and phylogenetic trees", + "bio.tool id": "graphlan", + "bio.tool ids": [ + "graphlan" + ], + "biii": null, + "bio.tool name": "GraPhlAn", + "bio.tool description": "GraPhlAn is a software tool for producing high-quality circular representations of taxonomic and phylogenetic trees. GraPhlAn focuses on concise, integrative, informative, and publication-ready representations of phylogenetically- and taxonomically-driven investigation.", + "EDAM operation": [ + "Phylogenetic inference", + "Phylogenetic tree visualisation", + "Phylogenetic tree editing", + "Taxonomic classification" + ], + "EDAM topic": [ + "Metagenomics", + "Phylogenetics", + "Phylogenomics", + "Cladistics" + ], + "Status": "To update", + "Source": "https://github.com/biobakery/graphlan", + "ToolShed categories": [ + "Metagenomics", + "Graphics", + "Phylogenetics" + ], + "ToolShed id": "graphlan", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/humann2/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/graphlan", + "Galaxy wrapper version": null, + "Conda id": "graphlan", + "Conda version": "1.1.3" + }, + { + "Galaxy wrapper id": "gtdbtk", + "Galaxy tool ids": [ + "gtdbtk_classify_wf" + ], + "Description": "GTDB-Tk is a software tool kit for assigning objective taxonomic classifications to bacterial and archaeal genomesbased on the Genome Database Taxonomy GTDB. It is designed to work with recent advances that allow hundreds orthousands of metagenome-assembled genomes (MAGs) to be obtained directly from environmental samples. It can alsobe applied to isolate and single-cell genomes. ", + "bio.tool id": "GTDB-Tk", + "bio.tool ids": [ + "GTDB-Tk" + ], + "biii": null, + "bio.tool name": "GTDB-Tk", + "bio.tool description": "a toolkit to classify genomes with the Genome Taxonomy Database.GTDB-Tk: a toolkit for assigning objective taxonomic classifications to bacterial and archaeal genomes.GTDB-Tk is a software toolkit for assigning objective taxonomic classifications to bacterial and archaeal genomes based on the Genome Database Taxonomy GTDB. It is designed to work with recent advances that allow hundreds or thousands of metagenome-assembled genomes (MAGs) to be obtained directly from environmental samples. It can also be applied to isolate and single-cell genomes. The GTDB-Tk is open source and released under the GNU General Public License (Version 3).", + "EDAM operation": [ + "Genome alignment", + "Taxonomic classification", + "Sequence assembly", + "Query and retrieval" + ], + "EDAM topic": [ + "Metagenomics", + "Taxonomy", + "Phylogenetics", + "Database management", + "Proteins" + ], + "Status": "To update", + "Source": "https://github.com/Ecogenomics/GTDBTk", + "ToolShed categories": [ + "Metagenomics" + ], + "ToolShed id": "gtdbtk", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/gtdbtk", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/gtdbtk", + "Galaxy wrapper version": "2.3.2", + "Conda id": "gtdbtk", + "Conda version": "2.4.0" + }, + { + "Galaxy wrapper id": "gtfToBed12", + "Galaxy tool ids": [ + "gtftobed12" + ], + "Description": "Convert GTF files to BED12 format", + "bio.tool id": "UCSC_Genome_Browser_Utilities", + "bio.tool ids": [ + "UCSC_Genome_Browser_Utilities" + ], + "biii": null, + "bio.tool name": "UCSC Genome Browser Utilities", + "bio.tool description": "Utilities for handling sequences and assemblies from the UCSC Genome Browser project.", + "EDAM operation": [], + "EDAM topic": [ + "Sequence analysis" + ], + "Status": "To update", + "Source": "http://genome-source.cse.ucsc.edu/gitweb/?p=kent.git;a=blob;f=src/userApps/README", + "ToolShed categories": [ + "Convert Formats" + ], + "ToolShed id": "gtftobed12", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/gtfToBed12", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/gtfToBed12", + "Galaxy wrapper version": "357", + "Conda id": "ucsc-gtftogenepred", + "Conda version": "447" + }, + { + "Galaxy wrapper id": "gubbins", + "Galaxy tool ids": [ + "gubbins" + ], + "Description": "Gubbins - bacterial recombination detection", + "bio.tool id": "gubbins", + "bio.tool ids": [ + "gubbins" + ], + "biii": null, + "bio.tool name": "Gubbins", + "bio.tool description": "Gubbins is a tool for rapid phylogenetic analysis of large samples of recombinant bacterial whole genome sequences.", + "EDAM operation": [ + "Genotyping", + "Phylogenetic inference", + "Ancestral reconstruction" + ], + "EDAM topic": [ + "Phylogeny", + "Genotype and phenotype", + "Whole genome sequencing" + ], + "Status": "To update", + "Source": null, + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "gubbins", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/gubbins", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/gubbins", + "Galaxy wrapper version": "3.2.1", + "Conda id": "gubbins", + "Conda version": "3.3.5" + }, + { + "Galaxy wrapper id": "gvcftools", + "Galaxy tool ids": [ + "gvcftools_extract_variants" + ], + "Description": null, + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/sequencing/gvcftools", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": null, + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/gvcftools", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/gvcftools", + "Galaxy wrapper version": "0.1", + "Conda id": "gvcftools", + "Conda version": "0.17.0" + }, + { + "Galaxy wrapper id": "gwastools", + "Galaxy tool ids": [ + "gwastools_manhattan_plot" + ], + "Description": null, + "bio.tool id": "gwastools", + "bio.tool ids": [ + "gwastools" + ], + "biii": null, + "bio.tool name": "GWASTools", + "bio.tool description": "Classes for storing very large GWAS data sets and annotation, and functions for GWAS data cleaning and analysis.", + "EDAM operation": [ + "Deposition", + "Analysis", + "Annotation" + ], + "EDAM topic": [ + "GWAS study" + ], + "Status": "To update", + "Source": "https://bioconductor.org/packages/release/bioc/html/GWASTools.html", + "ToolShed categories": [ + "Visualization", + "Variant Analysis" + ], + "ToolShed id": null, + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": null, + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/gwastools", + "Galaxy wrapper version": "0.1.0", + "Conda id": "bioconductor-gwastools", + "Conda version": "1.48.0" + }, + { + "Galaxy wrapper id": "hamronization", + "Galaxy tool ids": [ + "hamronize_summarize", + "hamronize_tool" + ], + "Description": "Convert AMR gene detection tool output to hAMRonization specification format.", + "bio.tool id": "hamronization", + "bio.tool ids": [ + "hamronization" + ], + "biii": null, + "bio.tool name": "hAMRonization", + "bio.tool description": "Parse multiple Antimicrobial Resistance Analysis Reports into a common data structure", + "EDAM operation": [ + "Data handling", + "Antimicrobial resistance prediction", + "Parsing" + ], + "EDAM topic": [ + "Public health and epidemiology", + "Microbiology", + "Bioinformatics" + ], + "Status": "Up-to-date", + "Source": "https://github.com/pha4ge/hAMRonization", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "hamronization", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/hamronization", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/hamronization", + "Galaxy wrapper version": "1.1.4", + "Conda id": "hamronization", + "Conda version": "1.1.4" + }, + { + "Galaxy wrapper id": "hansel", + "Galaxy tool ids": [ + "bio_hansel" + ], + "Description": "Heidelberg and Enteritidis SNP Elucidation", + "bio.tool id": "Biohansel", + "bio.tool ids": [ + "Biohansel" + ], + "biii": null, + "bio.tool name": "BioHansel", + "bio.tool description": "BioHansel is a tool for performing high-resolution genotyping of bacterial isolates by identifying phylogenetically informative single nucleotide polymorphisms (SNPs), also known as canonical SNPs, in whole genome sequencing (WGS) data. The application uses a fast k-mer matching algorithm to map pathogen WGS data to canonical SNPs contained in hierarchically structured schemas and assigns genotypes based on the detected SNP profile.", + "EDAM operation": [ + "Genotyping", + "SNP detection", + "Genome assembly" + ], + "EDAM topic": [ + "Whole genome sequencing", + "DNA polymorphism", + "Genotype and phenotype", + "Infectious disease", + "Agricultural science" + ], + "Status": "Up-to-date", + "Source": "https://github.com/phac-nml/bio_hansel", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "bio_hansel", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/hansel", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/hansel", + "Galaxy wrapper version": "2.6.1", + "Conda id": "bio_hansel", + "Conda version": "2.6.1" + }, + { + "Galaxy wrapper id": "hapcut2", + "Galaxy tool ids": [ + "hapcut2" + ], + "Description": "Robust and accurate haplotype assembly for diverse sequencing technologies", + "bio.tool id": "hapcut2", + "bio.tool ids": [ + "hapcut2" + ], + "biii": null, + "bio.tool name": "HapCUT2", + "bio.tool description": "HapCUT2 is a maximum-likelihood-based tool for assembling haplotypes from DNA sequence reads, designed to \"just work\" with excellent speed and accuracy across a range of long- and short-read sequencing technologies.The output is in Haplotype block format described here: https://github.com/vibansal/HapCUT2/blob/master/outputformat.md", + "EDAM operation": [ + "Haplotype mapping", + "Variant classification" + ], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/vibansal/HapCUT2", + "ToolShed categories": [ + "Assembly" + ], + "ToolShed id": "hapcut2", + "Galaxy wrapper owner": "galaxy-australia", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/hapcut2", + "Galaxy wrapper version": "1.3.4", + "Conda id": "hapcut2", + "Conda version": "1.3.4" + }, + { + "Galaxy wrapper id": "hapog", + "Galaxy tool ids": [ + "hapog" + ], + "Description": "Hapo-G - Haplotype-Aware Polishing of Genomes", + "bio.tool id": "hapog", + "bio.tool ids": [ + "hapog" + ], + "biii": null, + "bio.tool name": "Hapo-G", + "bio.tool description": "Hapo-G is a tool that aims to improve the quality of genome assemblies by polishing the consensus with accurate reads. It capable of incorporating phasing information from high-quality reads (short or long-reads) to polish genome assemblies and in particular assemblies of diploid and heterozygous genomes.", + "EDAM operation": [ + "Genome assembly", + "Optimisation and refinement" + ], + "EDAM topic": [ + "Sequence assembly", + "Genomics" + ], + "Status": "Up-to-date", + "Source": "https://github.com/institut-de-genomique/HAPO-G", + "ToolShed categories": [ + "Assembly" + ], + "ToolShed id": "hapog", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/hapog", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/hapog", + "Galaxy wrapper version": "1.3.8", + "Conda id": "hapog", + "Conda version": "1.3.8" + }, + { + "Galaxy wrapper id": "happy", + "Galaxy tool ids": [ + "som.py" + ], + "Description": "A tool to perform comparisons only based on chromosome, position, and allele identity for comparison of somatic callsets.", + "bio.tool id": "hap.py", + "bio.tool ids": [ + "hap.py" + ], + "biii": null, + "bio.tool name": "hap.py", + "bio.tool description": "This is a set of programs based on htslib to benchmark variant calls against gold standard truth datasets.To compare a VCF against a gold standard dataset, use the following commmand line to perform genotype-level haplotype comparison.", + "EDAM operation": [ + "Variant calling", + "Sequence analysis", + "Genotyping" + ], + "EDAM topic": [ + "Genomics", + "DNA polymorphism" + ], + "Status": "To update", + "Source": "https://github.com/Illumina/hap.py", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "happy", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/happy", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/happy", + "Galaxy wrapper version": "0.3.14", + "Conda id": "hap.py", + "Conda version": "0.3.15" + }, + { + "Galaxy wrapper id": "heatmap2", + "Galaxy tool ids": [ + "ggplot2_heatmap2" + ], + "Description": "heatmap.2 function from the R gplots package", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/cran/gplots", + "ToolShed categories": [ + "Visualization" + ], + "ToolShed id": "ggplot2_heatmap2", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/heatmap2", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/heatmap2", + "Galaxy wrapper version": "3.1.3.1", + "Conda id": "r-gplots", + "Conda version": "2.17.0" + }, + { + "Galaxy wrapper id": "heinz", + "Galaxy tool ids": [ + "heinz_bum", + "heinz", + "heinz_scoring", + "heinz_visualization" + ], + "Description": "An algorithm for identification of the optimal scoring subnetwork.", + "bio.tool id": "heinz", + "bio.tool ids": [ + "bionet", + "heinz" + ], + "biii": null, + "bio.tool name": "Heinz", + "bio.tool description": "Tool for single-species active module discovery.", + "EDAM operation": [ + "Pathway or network analysis" + ], + "EDAM topic": [ + "Genetics", + "Gene expression", + "Molecular interactions, pathways and networks" + ], + "Status": "To update", + "Source": "https://github.com/ls-cwi/heinz", + "ToolShed categories": [ + "Transcriptomics", + "Visualization", + "Statistics" + ], + "ToolShed id": "heinz", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/heinz", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/heinz", + "Galaxy wrapper version": "1.0", + "Conda id": "bioconductor-bionet", + "Conda version": "1.62.0" + }, + { + "Galaxy wrapper id": "hicexplorer", + "Galaxy tool ids": [ + "hicexplorer_chicaggregatestatistic", + "hicexplorer_chicdifferentialtest", + "hicexplorer_chicexportdata", + "hicexplorer_chicplotviewpoint", + "hicexplorer_chicqualitycontrol", + "hicexplorer_chicsignificantinteractions", + "hicexplorer_chicviewpoint", + "hicexplorer_chicviewpointbackgroundmodel", + "hicexplorer_hicadjustmatrix", + "hicexplorer_hicaggregatecontacts", + "hicexplorer_hicaverageregions", + "hicexplorer_hicbuildmatrix", + "hicexplorer_hiccomparematrices", + "hicexplorer_hiccompartmentspolarization", + "hicexplorer_hicconvertformat", + "hicexplorer_hiccorrectmatrix", + "hicexplorer_hiccorrelate", + "hicexplorer_hicdetectloops", + "hicexplorer_hicdifferentialtad", + "hicexplorer_hicfindrestrictionsites", + "hicexplorer_hicfindtads", + "hicexplorer_hichyperoptDetectLoops", + "hicexplorer_hicinfo", + "hicexplorer_hicinterintratad", + "hicexplorer_hicmergedomains", + "hicexplorer_hicmergeloops", + "hicexplorer_hicmergematrixbins", + "hicexplorer_hicnormalize", + "hicexplorer_hicpca", + "hicexplorer_hicplotaverageregions", + "hicexplorer_hicplotdistvscounts", + "hicexplorer_hicplotmatrix", + "hicexplorer_hicplotsvl", + "hicexplorer_hicplotviewpoint", + "hicexplorer_hicquickqc", + "hicexplorer_hicsummatrices", + "hicexplorer_hictadclassifier", + "hicexplorer_hictraintadclassifier", + "hicexplorer_hictransform", + "hicexplorer_hicvalidatelocations" + ], + "Description": "HiCExplorer: Set of programs to process, analyze and visualize Hi-C data.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/deeptools/HiCExplorer", + "ToolShed categories": [ + "Sequence Analysis", + "Visualization" + ], + "ToolShed id": "hicexplorer", + "Galaxy wrapper owner": "bgruening", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/hicexplorer", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/hicexplorer", + "Galaxy wrapper version": "3.7.2", + "Conda id": "hicexplorer", + "Conda version": "3.7.4" + }, + { + "Galaxy wrapper id": "hicstuff", + "Galaxy tool ids": [ + "hicstuff_pipeline" + ], + "Description": null, + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/koszullab/hicstuff", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": null, + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/hicstuff", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/hicstuff", + "Galaxy wrapper version": "3.1.5", + "Conda id": "hicstuff", + "Conda version": "3.2.2" + }, + { + "Galaxy wrapper id": "hifiasm_meta", + "Galaxy tool ids": [ + "hifiasm_meta" + ], + "Description": "A hifiasm fork for metagenome assembly using Hifi reads.", + "bio.tool id": "hifiasm-meta", + "bio.tool ids": [ + "hifiasm-meta" + ], + "biii": null, + "bio.tool name": "Hifiasm-meta", + "bio.tool description": "Hifiasm_meta - de novo metagenome assembler, based on hifiasm, a haplotype-resolved de novo assembler for PacBio Hifi reads.", + "EDAM operation": [ + "Sequence assembly" + ], + "EDAM topic": [ + "Sequence assembly", + "Metagenomics" + ], + "Status": "To update", + "Source": "https://github.com/xfengnefx/hifiasm-meta", + "ToolShed categories": [ + "Metagenomics" + ], + "ToolShed id": "hifiasm_meta", + "Galaxy wrapper owner": "galaxy-australia", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/hifiasm_meta", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/hifiasm_meta", + "Galaxy wrapper version": "0.3.1", + "Conda id": "hifiasm_meta", + "Conda version": "hamtv0.3.1" + }, + { + "Galaxy wrapper id": "hisat2", + "Galaxy tool ids": [ + "hisat2" + ], + "Description": "HISAT2 is a fast and sensitive spliced alignment program.", + "bio.tool id": "hisat2", + "bio.tool ids": [ + "hisat2" + ], + "biii": null, + "bio.tool name": "HISAT2", + "bio.tool description": "Alignment program for mapping next-generation sequencing reads (both DNA and RNA) to a population of human genomes (as well as to a single reference genome).", + "EDAM operation": [ + "Sequence alignment" + ], + "EDAM topic": [ + "RNA-seq" + ], + "Status": "Up-to-date", + "Source": "http://ccb.jhu.edu/software/hisat2/", + "ToolShed categories": [ + "Assembly" + ], + "ToolShed id": "hisat2", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/hisat2", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/hisat2", + "Galaxy wrapper version": "2.2.1", + "Conda id": "hisat2", + "Conda version": "2.2.1" + }, + { + "Galaxy wrapper id": "hivclustering", + "Galaxy tool ids": [ + "hivclustering" + ], + "Description": "Infers transmission networks from pairwise distances inferred by tn93", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://pypi.org/project/hivclustering/", + "ToolShed categories": [ + "Next Gen Mappers" + ], + "ToolShed id": "hivclustering", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/hivclustering/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/hivclustering", + "Galaxy wrapper version": "1.3.1", + "Conda id": "python-hivclustering", + "Conda version": "1.6.8" + }, + { + "Galaxy wrapper id": "hmmer3", + "Galaxy tool ids": [ + "hmmer_alimask", + "hmmer_hmmalign", + "hmmer_hmmbuild", + "hmmer_hmmconvert", + "hmmer_hmmemit", + "hmmer_hmmfetch", + "hmmer_hmmscan", + "hmmer_hmmsearch", + "hmmer_jackhmmer", + "hmmer_nhmmer", + "hmmer_nhmmscan", + "hmmer_phmmer" + ], + "Description": "HMMER is used for searching sequence databases for homologs of proteinsequences, and for making protein sequence alignments. It implementsmethods using probabilistic models called profile hidden Markov models(profile HMMs).", + "bio.tool id": "hmmer3", + "bio.tool ids": [ + "hmmer3" + ], + "biii": null, + "bio.tool name": "HMMER3", + "bio.tool description": "This tool is used for searching sequence databases for homologs of protein sequences, and for making protein sequence alignments. It implements methods using probabilistic models called profile hidden Markov models. The new HMMER3 project, HMMER is now as fast as BLAST for protein search.", + "EDAM operation": [ + "Formatting", + "Multiple sequence alignment", + "Sequence profile generation", + "Format validation", + "Conversion", + "Sequence generation", + "Data retrieval", + "Statistical calculation", + "Database search", + "Formatting", + "Database search", + "Database search", + "Probabilistic sequence generation", + "Statistical calculation", + "Statistical calculation", + "Sequence database search", + "Formatting", + "Sequence database search", + "Database search", + "Sequence database search" + ], + "EDAM topic": [ + "Sequence analysis", + "Sequence sites, features and motifs", + "Gene and protein families" + ], + "Status": "Up-to-date", + "Source": "http://hmmer.org/", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": null, + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/hmmer3", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/hmmer3", + "Galaxy wrapper version": "3.4", + "Conda id": "hmmer", + "Conda version": "3.4" + }, + { + "Galaxy wrapper id": "homer", + "Galaxy tool ids": [ + "homer_annotatePeaks", + "homer_findMotifs", + "homer_findMotifsGenome", + "homer_gtf_to_annotations", + "homer_scanMotifGenomeWide" + ], + "Description": "HOMER (Hypergeometric Optimization of Motif EnRichment) is a suite of tools for Motif Discovery and next-gen sequencing analysis.", + "bio.tool id": "homer", + "bio.tool ids": [ + "homer" + ], + "biii": null, + "bio.tool name": "homer", + "bio.tool description": "HOMER contains a novel motif discovery algorithm that was designed for regulatory element analysis in genomics applications (DNA only, no protein). It is a differential motif discovery algorithm, which means that it takes two sets of sequences and tries to identify the regulatory elements that are specifically enriched in on set relative to the other. It uses ZOOPS scoring (zero or one occurrence per sequence) coupled with the hypergeometric enrichment calculations (or binomial) to determine motif enrichment. HOMER also tries its best to account for sequenced bias in the dataset. It was designed with ChIP-Seq and promoter analysis in mind, but can be applied to pretty much any nucleic acids motif finding problem.", + "EDAM operation": [ + "Sequence motif discovery" + ], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "http://homer.ucsd.edu/homer/index.html", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "data_manager_homer_preparse", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/homer", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/homer", + "Galaxy wrapper version": "4.11", + "Conda id": "homer", + "Conda version": "4.11" + }, + { + "Galaxy wrapper id": "htseq_count", + "Galaxy tool ids": [ + "htseq_count" + ], + "Description": "Count aligned reads (SAM/BAM) that overlap genomic features (GFF)", + "bio.tool id": "htseq", + "bio.tool ids": [ + "htseq" + ], + "biii": null, + "bio.tool name": "HTSeq", + "bio.tool description": "Python framework to process and analyse high-throughput sequencing (HTS) data", + "EDAM operation": [ + "Nucleic acid sequence analysis" + ], + "EDAM topic": [ + "Sequence analysis" + ], + "Status": "Up-to-date", + "Source": "https://readthedocs.org/projects/htseq/", + "ToolShed categories": [ + "Genomic Interval Operations", + "SAM", + "Sequence Analysis", + "RNA" + ], + "ToolShed id": "htseq_count", + "Galaxy wrapper owner": "lparsons", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/htseq_count", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/htseq_count", + "Galaxy wrapper version": "2.0.5", + "Conda id": "htseq", + "Conda version": "2.0.5" + }, + { + "Galaxy wrapper id": "humann", + "Galaxy tool ids": [ + "humann", + "humann_associate", + "humann_barplot", + "humann_join_tables", + "humann_reduce_table", + "humann_regroup_table", + "humann_rename_table", + "humann_renorm_table", + "humann_rna_dna_norm", + "humann_split_stratified_table", + "humann_split_table", + "humann_strain_profiler", + "humann_unpack_pathways" + ], + "Description": "HUMAnN for functionally profiling metagenomes and metatranscriptomes at species-level resolution", + "bio.tool id": "humann", + "bio.tool ids": [ + "humann" + ], + "biii": null, + "bio.tool name": "humann", + "bio.tool description": "HUMAnN is a pipeline for efficiently and accurately profiling the presence/absence and abundance of microbial pathways in a community from metagenomic or metatranscriptomic sequencing data (typically millions of short DNA/RNA reads). This process, referred to as functional profiling, aims to describe the metabolic potential of a microbial community and its members. More generally, functional profiling answers the question \u201cWhat are the microbes in my community-of-interest doing (or are capable of doing)?\u201d", + "EDAM operation": [ + "Species frequency estimation", + "Taxonomic classification", + "Phylogenetic analysis" + ], + "EDAM topic": [ + "Metagenomics", + "Phylogenomics" + ], + "Status": "Up-to-date", + "Source": "http://huttenhower.sph.harvard.edu/humann", + "ToolShed categories": [ + "Metagenomics" + ], + "ToolShed id": "humann", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/humann", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/humann", + "Galaxy wrapper version": "3.8", + "Conda id": "humann", + "Conda version": "3.8" + }, + { + "Galaxy wrapper id": "hybpiper", + "Galaxy tool ids": [ + "hybpiper" + ], + "Description": "Analyse targeted sequence capture data", + "bio.tool id": "HybPiper", + "bio.tool ids": [ + "HybPiper" + ], + "biii": null, + "bio.tool name": "HybPiper", + "bio.tool description": "Paralogs and off-target sequences improve phylogenetic resolution in a densely-sampled study of the breadfruit genus (Artocarpus, Moraceae).Recovering genes from targeted sequence capture data.Current version: 1.3.1 (August 2018).-- Read our article in Applications in Plant Sciences (Open Access).HybPiper was designed for targeted sequence capture, in which DNA sequencing libraries are enriched for gene regions of interest, especially for phylogenetics. HybPiper is a suite of Python scripts that wrap and connect bioinformatics tools in order to extract target sequences from high-throughput DNA sequencing reads.", + "EDAM operation": [ + "Sequence trimming", + "Sequence assembly", + "Read mapping" + ], + "EDAM topic": [ + "Phylogenetics", + "Plant biology", + "Gene transcripts", + "Sequence assembly", + "Phylogenomics" + ], + "Status": "To update", + "Source": "https://github.com/mossmatters/HybPiper", + "ToolShed categories": [ + "Sequence Analysis", + "Phylogenetics" + ], + "ToolShed id": "hybpiper", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/hybpiper", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/hybpiper", + "Galaxy wrapper version": "2.1.6", + "Conda id": "hybpiper", + "Conda version": "2.1.7" + }, + { + "Galaxy wrapper id": "hyphy", + "Galaxy tool ids": [ + "hyphy_absrel", + "hyphy_annotate", + "hyphy_bgm", + "hyphy_busted", + "hyphy_cfel", + "hyphy_conv", + "hyphy_fade", + "hyphy_fel", + "hyphy_fubar", + "hyphy_gard", + "hyphy_meme", + "hyphy_prime", + "hyphy_relax", + "hyphy_slac", + "hyphy_sm19", + "hyphy_strike_ambigs", + "hyphy_summary" + ], + "Description": "Hypothesis Testing using Phylogenies", + "bio.tool id": "HyPhy", + "bio.tool ids": [ + "HyPhy" + ], + "biii": null, + "bio.tool name": "HyPhy", + "bio.tool description": "Software package for the analysis of genetic sequences using techniques in phylogenetics, molecular evolution, and machine learning.", + "EDAM operation": [ + "Statistical calculation" + ], + "EDAM topic": [ + "Phylogeny", + "Small molecules", + "Molecular interactions, pathways and networks" + ], + "Status": "To update", + "Source": "http://www.hyphy.org", + "ToolShed categories": [ + "Phylogenetics" + ], + "ToolShed id": null, + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/hyphy/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/hyphy", + "Galaxy wrapper version": "2.5.47", + "Conda id": "hyphy", + "Conda version": "2.5.62" + }, + { + "Galaxy wrapper id": "hypo", + "Galaxy tool ids": [ + "hypo" + ], + "Description": "Super Fast & Accurate Polisher for Long Read Genome Assemblies", + "bio.tool id": "HyPo", + "bio.tool ids": [ + "HyPo" + ], + "biii": null, + "bio.tool name": "HyPo", + "bio.tool description": "HyPo, a Hybrid Polisher, utilizes short as well as long reads within a single run to polish a long reads assembly of small and large genomes.", + "EDAM operation": [ + "Optimisation and refinement", + "Genome assembly" + ], + "EDAM topic": [ + "Sequence assembly", + "Genomics" + ], + "Status": "Up-to-date", + "Source": "https://github.com/kensung-lab/hypo", + "ToolShed categories": [ + "Assembly" + ], + "ToolShed id": "hypo", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/hypo", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/hypo", + "Galaxy wrapper version": "1.0.3", + "Conda id": "hypo", + "Conda version": "1.0.3" + }, + { + "Galaxy wrapper id": "icescreen", + "Galaxy tool ids": [ + "icescreen" + ], + "Description": "ICEscreen identifies Integrative Conjugative Elements (ICEs) and Integrative Mobilizable Elements (IMEs) in Bacillota genomes.", + "bio.tool id": "icescreen", + "bio.tool ids": [ + "icescreen" + ], + "biii": null, + "bio.tool name": "ICEscreen", + "bio.tool description": "A tool to detect Firmicute ICEs and IMEs, isolated or enclosed in composite structures.", + "EDAM operation": [ + "Database search", + "Protein feature detection" + ], + "EDAM topic": [ + "Mobile genetic elements", + "Sequence sites, features and motifs", + "Genomics", + "Molecular interactions, pathways and networks", + "Structural variation" + ], + "Status": "To update", + "Source": "https://icescreen.migale.inrae.fr/", + "ToolShed categories": [ + "Genome annotation" + ], + "ToolShed id": "icescreen", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://forgemia.inra.fr/ices_imes_analysis/icescreen", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/icescreen", + "Galaxy wrapper version": "1.3.1", + "Conda id": "icescreen", + "Conda version": "1.3.2" + }, + { + "Galaxy wrapper id": "idba_ud", + "Galaxy tool ids": [ + "idba_hybrid", + "idba_tran", + "idba_ud" + ], + "Description": "Wrappers for the idba assembler variants.", + "bio.tool id": "idba", + "bio.tool ids": [ + "idba" + ], + "biii": null, + "bio.tool name": "IDBA", + "bio.tool description": "A short read assembler based on iterative De Bruijn graph. It is developed under 64-bit Linux, but should be suitable for all unix-like system.", + "EDAM operation": [ + "Sequence assembly" + ], + "EDAM topic": [ + "Sequence assembly" + ], + "Status": "To update", + "Source": "https://i.cs.hku.hk/~alse/hkubrg/projects/index.html", + "ToolShed categories": [ + "Assembly" + ], + "ToolShed id": "idba", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/idba_ud", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/idba_ud", + "Galaxy wrapper version": null, + "Conda id": "idba", + "Conda version": "1.1.3" + }, + { + "Galaxy wrapper id": "idr", + "Galaxy tool ids": [ + "idr" + ], + "Description": "Galaxy wrappers for the IDR package from Nathan Boleu", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/nboley/idr", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "idr", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/idr/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/idr", + "Galaxy wrapper version": "2.0.3", + "Conda id": "idr", + "Conda version": "2.0.4.2" + }, + { + "Galaxy wrapper id": "idr_download", + "Galaxy tool ids": [ + "idr_download_by_ids" + ], + "Description": "Image Data Resource downloading tool", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://idr.openmicroscopy.org", + "ToolShed categories": [ + "Data Source" + ], + "ToolShed id": "idr_download_by_ids", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/idr_download", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/idr_download", + "Galaxy wrapper version": "0.44.1", + "Conda id": "omero-py", + "Conda version": "5.11.1" + }, + { + "Galaxy wrapper id": "iedb_api", + "Galaxy tool ids": [ + "iedb_api" + ], + "Description": "Get epitope binding predictions from IEDB-API", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "http://tools.immuneepitope.org/main/tools-api/", + "ToolShed categories": [ + "Data Source", + "Sequence Analysis" + ], + "ToolShed id": "iedb_api", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/iedb_api", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/iedb_api", + "Galaxy wrapper version": "2.15.2", + "Conda id": "python", + "Conda version": null + }, + { + "Galaxy wrapper id": "instrain", + "Galaxy tool ids": [ + "instrain_compare", + "instrain_profile" + ], + "Description": "InStrain is a tool for analysis of co-occurring genome populations from metagenomes", + "bio.tool id": "instrain", + "bio.tool ids": [ + "instrain" + ], + "biii": null, + "bio.tool name": "InStrain", + "bio.tool description": "InStrain is a tool for analysis of co-occurring genome populations from metagenomes that allows highly accurate genome comparisons, analysis of coverage, microdiversity, and linkage, and sensitive SNP detection with gene localization and synonymous non-synonymous identification", + "EDAM operation": [ + "SNP detection", + "Genome comparison" + ], + "EDAM topic": [ + "Mapping", + "Metagenomics" + ], + "Status": "To update", + "Source": "https://instrain.readthedocs.io/en/latest/#", + "ToolShed categories": [ + "Metagenomics" + ], + "ToolShed id": "instrain", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/instrain", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/instrain", + "Galaxy wrapper version": "1.5.3", + "Conda id": "instrain", + "Conda version": "1.9.0" + }, + { + "Galaxy wrapper id": "integron_finder", + "Galaxy tool ids": [ + "integron_finder" + ], + "Description": "\"IntegronFinder identify integrons with high accuracy and sensitivity.It searches for attC sites using covariance models, for integron-integrases using HMM profiles, and for other features (promoters, attI site) using pattern matching\"", + "bio.tool id": "integron_finder", + "bio.tool ids": [ + "integron_finder" + ], + "biii": null, + "bio.tool name": "Integron Finder", + "bio.tool description": "A tool to detect Integron in DNA sequences.", + "EDAM operation": [ + "Nucleic acid feature detection", + "Sequence motif recognition", + "Protein feature detection", + "Genome annotation" + ], + "EDAM topic": [ + "Functional genomics", + "Mobile genetic elements", + "Molecular biology", + "Sequence analysis" + ], + "Status": "Up-to-date", + "Source": "https://github.com/gem-pasteur/Integron_Finder", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "integronfinder", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/blob/master/tools/integron_finder", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/integron_finder", + "Galaxy wrapper version": "2.0.3", + "Conda id": "integron_finder", + "Conda version": "2.0.3" + }, + { + "Galaxy wrapper id": "intermine_galaxy_exchange", + "Galaxy tool ids": [ + "galaxy_intermine_exchange" + ], + "Description": "InterMine Exporter", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": null, + "ToolShed categories": [ + "Convert Formats" + ], + "ToolShed id": "intermine_galaxy_exchange", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/intermine_galaxy_exchange", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/intermine_galaxy_exchange", + "Galaxy wrapper version": "0.0.1", + "Conda id": "coreutils", + "Conda version": "8.25" + }, + { + "Galaxy wrapper id": "interproscan", + "Galaxy tool ids": [ + "interproscan" + ], + "Description": "Interproscan queries the interpro database and provides annotations.", + "bio.tool id": "interproscan_ebi", + "bio.tool ids": [ + "interproscan_ebi" + ], + "biii": null, + "bio.tool name": "InterProScan (EBI)", + "bio.tool description": "Scan sequences against the InterPro protein signature databases.", + "EDAM operation": [ + "Sequence motif recognition", + "Protein feature detection" + ], + "EDAM topic": [ + "Gene and protein families", + "Sequence analysis" + ], + "Status": "To update", + "Source": "http://www.ebi.ac.uk/Tools/pfa/iprscan5/", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "interproscan", + "Galaxy wrapper owner": "bgruening", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/interproscan", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/interproscan", + "Galaxy wrapper version": "5.59-91.0", + "Conda id": "interproscan", + "Conda version": "5.59_91.0" + }, + { + "Galaxy wrapper id": "interval2maf", + "Galaxy tool ids": [ + "Interval2Maf1" + ], + "Description": "Extract MAF blocks given a set of intervals", + "bio.tool id": "bx-python", + "bio.tool ids": [ + "bx-python" + ], + "biii": null, + "bio.tool name": "bx-python", + "bio.tool description": "Tools for manipulating biological data, particularly multiple sequence alignments.", + "EDAM operation": [], + "EDAM topic": [ + "Sequence analysis" + ], + "Status": "To update", + "Source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/interval2maf/", + "ToolShed categories": [ + "Genomic Interval Operations" + ], + "ToolShed id": "interval2maf", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/interval2maf/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/interval2maf", + "Galaxy wrapper version": "1.0.1+galaxy1", + "Conda id": "bx-python", + "Conda version": "0.11.0" + }, + { + "Galaxy wrapper id": "intervene", + "Galaxy tool ids": [ + "intervene_pairwise", + "intervene_upset" + ], + "Description": "Create pairwise and upset plots", + "bio.tool id": "intervene", + "bio.tool ids": [ + "intervene" + ], + "biii": null, + "bio.tool name": "Intervene", + "bio.tool description": "Tool for intersection and visualization of multiple gene or genomic region sets. Intervene contains three modules: venn to generate Venn diagrams of up to six sets, upset to generate UpSet plots of multiple sets, and pairwise to compute and visualize intersections of multiple sets as clustered heat maps.", + "EDAM operation": [ + "Sequence comparison", + "Sequence visualisation" + ], + "EDAM topic": [ + "Computational biology" + ], + "Status": "Up-to-date", + "Source": "https://intervene.readthedocs.io", + "ToolShed categories": [ + "Statistics" + ], + "ToolShed id": "intervene", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/intervene", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/intervene", + "Galaxy wrapper version": "0.6.5", + "Conda id": "intervene", + "Conda version": "0.6.5" + }, + { + "Galaxy wrapper id": "iqtree", + "Galaxy tool ids": [ + "iqtree" + ], + "Description": "Efficient phylogenomic software by maximum likelihood", + "bio.tool id": "iqtree", + "bio.tool ids": [ + "iqtree" + ], + "biii": null, + "bio.tool name": "iqtree", + "bio.tool description": "A fast and effective stochastic algorithm to infer phylogenetic trees by maximum likelihood. IQ-TREE compares favorably to RAxML and PhyML in terms of likelihoods with similar computing time", + "EDAM operation": [ + "Phylogenetic analysis", + "Sequence analysis" + ], + "EDAM topic": [ + "Phylogenetics" + ], + "Status": "Up-to-date", + "Source": "http://www.iqtree.org/", + "ToolShed categories": [ + "Phylogenetics" + ], + "ToolShed id": "iqtree", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/iqtree/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/iqtree", + "Galaxy wrapper version": "2.3.4", + "Conda id": "iqtree", + "Conda version": "2.3.4" + }, + { + "Galaxy wrapper id": "irissv", + "Galaxy tool ids": [ + "irissv" + ], + "Description": "Refine insertion sequences", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/mkirsche/Iris", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "irissv", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tools/irissv/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/irissv", + "Galaxy wrapper version": "1.0.5", + "Conda id": "samtools", + "Conda version": "1.20" + }, + { + "Galaxy wrapper id": "isescan", + "Galaxy tool ids": [ + "isescan" + ], + "Description": "\"ISEScan is a pipeline to identify IS (Insertion Sequence) elements in genome and metagenomebased on profile hidden Markov models constructed from manually curated IS elements.\"", + "bio.tool id": "ISEScan", + "bio.tool ids": [ + "ISEScan" + ], + "biii": null, + "bio.tool name": "ISEScan", + "bio.tool description": "Automated identification of insertion sequence elements in prokaryotic genomes.", + "EDAM operation": [ + "Structural variation detection" + ], + "EDAM topic": [ + "Genomics", + "DNA structural variation", + "Sequence analysis", + "Genetic variation" + ], + "Status": "To update", + "Source": "https://github.com/xiezhq/ISEScan", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "ISEScan", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/blob/master/tools/isescan", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/isescan", + "Galaxy wrapper version": "1.7.2.3", + "Conda id": "isescan", + "Conda version": "1.7.2.1" + }, + { + "Galaxy wrapper id": "isoformswitchanalyzer", + "Galaxy tool ids": [ + "isoformswitchanalyzer" + ], + "Description": "Statistical identification of isoform switching from RNA-seq derived quantification of novel and/or annotated full-length isoforms.", + "bio.tool id": "IsoformSwitchAnalyzeR", + "bio.tool ids": [ + "IsoformSwitchAnalyzeR" + ], + "biii": null, + "bio.tool name": "IsoformSwitchAnalyzeR", + "bio.tool description": "Enables identification of isoform switches with predicted functional consequences from RNA-seq data. Consequences can be chosen from a long list but includes protein domains gain/loss changes in NMD sensitivity etc. It directly supports import of data from Cufflinks/Cuffdiff, Kallisto, Salmon and RSEM but other transcript qunatification tools are easy to import as well.", + "EDAM operation": [ + "Sequence comparison", + "Sequence analysis" + ], + "EDAM topic": [ + "Computational biology", + "Gene transcripts" + ], + "Status": "To update", + "Source": "https://bioconductor.org/packages/devel/bioc/html/IsoformSwitchAnalyzeR.html", + "ToolShed categories": [ + "Transcriptomics", + "RNA", + "Statistics" + ], + "ToolShed id": "isoformswitchanalyzer", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/isoformswitchanalyzer", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/isoformswitchanalyzer", + "Galaxy wrapper version": "1.20.0", + "Conda id": "bioconductor-isoformswitchanalyzer", + "Conda version": "2.2.0" + }, + { + "Galaxy wrapper id": "ivar", + "Galaxy tool ids": [ + "ivar_consensus", + "ivar_filtervariants", + "ivar_removereads", + "ivar_trim", + "ivar_variants" + ], + "Description": "iVar is a computational package that contains functions broadly useful for viral amplicon-based sequencing", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/andersen-lab/ivar", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "ivar", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/ivar/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/ivar", + "Galaxy wrapper version": "1.4.2", + "Conda id": "ivar", + "Conda version": "1.4.2" + }, + { + "Galaxy wrapper id": "iwtomics", + "Galaxy tool ids": [ + "iwtomics_loadandplot", + "iwtomics_plotwithscale", + "iwtomics_testandplot" + ], + "Description": "Interval-Wise Testing for Omics Data", + "bio.tool id": "iwtomics", + "bio.tool ids": [ + "iwtomics" + ], + "biii": null, + "bio.tool name": "IWTomics", + "bio.tool description": "Implementation of the Interval-Wise Testing (IWT) for omics data. This inferential procedure tests for differences in \"Omics\" data between two groups of genomic regions (or between a group of genomic regions and a reference center of symmetry), and does not require fixing location and scale at the outset.", + "EDAM operation": [ + "Differential gene expression analysis", + "Differentially-methylated region identification", + "Peak calling", + "Genome annotation", + "Comparison" + ], + "EDAM topic": [ + "Statistics and probability" + ], + "Status": "To update", + "Source": "https://bioconductor.org/packages/release/bioc/html/IWTomics.html", + "ToolShed categories": [ + "Statistics" + ], + "ToolShed id": "iwtomics", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/iwtomics", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/iwtomics", + "Galaxy wrapper version": "1.0.0", + "Conda id": "bioconductor-iwtomics", + "Conda version": "1.26.0" + }, + { + "Galaxy wrapper id": "jasminesv", + "Galaxy tool ids": [ + "jasminesv" + ], + "Description": "Merge structural variants across samples", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/mkirsche/Jasmine/", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "jasminesv", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/jasminesv/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/jasminesv", + "Galaxy wrapper version": "1.0.11", + "Conda id": "jasminesv", + "Conda version": "1.1.5" + }, + { + "Galaxy wrapper id": "jbrowse", + "Galaxy tool ids": [ + "jbrowse_to_standalone", + "jbrowse" + ], + "Description": "JBrowse Genome Browser integrated as a Galaxy Tool", + "bio.tool id": "jbrowse", + "bio.tool ids": [ + "jbrowse" + ], + "biii": null, + "bio.tool name": "JBrowse", + "bio.tool description": "Slick, speedy genome browser with a responsive and dynamic AJAX interface for visualization of genome data. Being developed by the GMOD project as a successor to GBrowse.", + "EDAM operation": [ + "Genome visualisation" + ], + "EDAM topic": [ + "Genomics" + ], + "Status": "Up-to-date", + "Source": "https://jbrowse.org", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "jbrowse", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/jbrowse", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/jbrowse", + "Galaxy wrapper version": "1.16.11", + "Conda id": "jbrowse", + "Conda version": "1.16.11" + }, + { + "Galaxy wrapper id": "jcvi_gff_stats", + "Galaxy tool ids": [ + "jcvi_gff_stats" + ], + "Description": "Compute statistics from a genome annotation in GFF3 format (using JCVI Python utilities)", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/tanghaibao/jcvi", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "jcvi_gff_stats", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/jcvi_gff_stats", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/jcvi_gff_stats", + "Galaxy wrapper version": "0.8.4", + "Conda id": "jcvi", + "Conda version": "1.4.15" + }, + { + "Galaxy wrapper id": "jellyfish", + "Galaxy tool ids": [ + "jellyfish" + ], + "Description": "Jellyfish is a tool for fast, memory-efficient counting of k-mers in DNA", + "bio.tool id": "Jellyfish", + "bio.tool ids": [ + "Jellyfish" + ], + "biii": null, + "bio.tool name": "Jellyfish", + "bio.tool description": "A command-line algorithm for counting k-mers in DNA sequence.", + "EDAM operation": [ + "k-mer counting" + ], + "EDAM topic": [ + "Sequence analysis", + "Genomics" + ], + "Status": "To update", + "Source": "https://github.com/gmarcais/Jellyfish", + "ToolShed categories": [ + "Assembly" + ], + "ToolShed id": "jellyfish", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/jellyfish", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/jellyfish", + "Galaxy wrapper version": null, + "Conda id": "kmer-jellyfish", + "Conda version": "2.3.1" + }, + { + "Galaxy wrapper id": "join_files_by_id", + "Galaxy tool ids": [ + "join_files_by_id" + ], + "Description": "This tool will join datasets according to a column with identifier", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": null, + "ToolShed categories": [ + "Text Manipulation" + ], + "ToolShed id": "join_files_by_id", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/join_files_by_id", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/join_files_by_id", + "Galaxy wrapper version": "1.0", + "Conda id": "r-data.table", + "Conda version": "1.11.6" + }, + { + "Galaxy wrapper id": "jq", + "Galaxy tool ids": [ + "jq" + ], + "Description": "JQ is a lightweight and flexible command-line JSON processor", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://stedolan.github.io/jq/", + "ToolShed categories": [ + "Text Manipulation" + ], + "ToolShed id": "jq", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/jq", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/jq", + "Galaxy wrapper version": "1.0", + "Conda id": "jq", + "Conda version": "1.5" + }, + { + "Galaxy wrapper id": "jvarkit", + "Galaxy tool ids": [ + "jvarkit_wgscoverageplotter" + ], + "Description": "Jvarkit : Java utilities for Bioinformatics", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://lindenb.github.io/jvarkit/", + "ToolShed categories": [ + "SAM" + ], + "ToolShed id": "jvarkit", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/iuc/tree/master/tools/jvarkit", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/jvarkit", + "Galaxy wrapper version": "20201223", + "Conda id": "jvarkit-wgscoverageplotter", + "Conda version": "20201223" + }, + { + "Galaxy wrapper id": "kallisto", + "Galaxy tool ids": [ + "kallisto_pseudo", + "kallisto_quant" + ], + "Description": "kallisto is a program for quantifying abundances of transcripts from RNA-Seqdata, or more generally of target sequences using high-throughput sequencingreads. It is based on the novel idea of pseudoalignment for rapidlydetermining the compatibility of reads with targets, without the need foralignment.", + "bio.tool id": "kallisto", + "bio.tool ids": [ + "kallisto" + ], + "biii": null, + "bio.tool name": "kallisto", + "bio.tool description": "A program for quantifying abundances of transcripts from RNA-Seq data, or more generally of target sequences using high-throughput sequencing reads. It is based on the novel idea of pseudoalignment for rapidly determining the compatibility of reads with targets, without the need for alignment.", + "EDAM operation": [ + "Gene expression profiling" + ], + "EDAM topic": [ + "Transcriptomics", + "RNA-seq", + "Gene expression" + ], + "Status": "To update", + "Source": "https://pachterlab.github.io/kallisto/", + "ToolShed categories": [ + "Transcriptomics" + ], + "ToolShed id": null, + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/kallisto/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/kallisto", + "Galaxy wrapper version": "0.48.0", + "Conda id": "kallisto", + "Conda version": "0.50.1" + }, + { + "Galaxy wrapper id": "kc-align", + "Galaxy tool ids": [ + "kc-align" + ], + "Description": "Kc-Align custom tool", + "bio.tool id": "kc-align", + "bio.tool ids": [ + "kc-align" + ], + "biii": null, + "bio.tool name": "kc-align", + "bio.tool description": "A fast and accurate tool for performing codon-aware multiple sequence alignments", + "EDAM operation": [ + "Multiple sequence alignment" + ], + "EDAM topic": [ + "Mapping" + ], + "Status": "Up-to-date", + "Source": "https://github.com/davebx/kc-align", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "kc_align", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/kc-align", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/kc-align", + "Galaxy wrapper version": "1.0.2", + "Conda id": "kcalign", + "Conda version": "1.0.2" + }, + { + "Galaxy wrapper id": "khmer", + "Galaxy tool ids": [ + "khmer_abundance_distribution_single", + "khmer_abundance_distribution", + "khmer_count_median", + "khmer_partition", + "khmer_extract_partitions", + "khmer_filter_abundance", + "khmer_filter_below_abundance_cutoff", + "khmer_normalize_by_median" + ], + "Description": "In-memory nucleotide sequence k-mer counting, filtering, graph traversal and more", + "bio.tool id": "khmer", + "bio.tool ids": [ + "khmer" + ], + "biii": null, + "bio.tool name": "khmer", + "bio.tool description": "khmer is a set of command-line tools for working with DNA shotgun sequencing data from genomes, transcriptomes, metagenomes, and single cells. khmer can make de novo assemblies faster, and sometimes better. khmer can also identify (and fix) problems with shotgun data.", + "EDAM operation": [ + "Standardisation and normalisation", + "De-novo assembly" + ], + "EDAM topic": [ + "Sequence assembly" + ], + "Status": "Up-to-date", + "Source": "https://khmer.readthedocs.org/", + "ToolShed categories": [ + "Assembly", + "Next Gen Mappers" + ], + "ToolShed id": "khmer", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/khmer", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/khmer", + "Galaxy wrapper version": "3.0.0a3", + "Conda id": "khmer", + "Conda version": "3.0.0a3" + }, + { + "Galaxy wrapper id": "king", + "Galaxy tool ids": [ + "king" + ], + "Description": "Kinship-based INference for Gwas", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "http://people.virginia.edu/~wc9c/KING/", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "king", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/king/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/king", + "Galaxy wrapper version": "2.2.7", + "Conda id": "king", + "Conda version": "2.2.7" + }, + { + "Galaxy wrapper id": "kleborate", + "Galaxy tool ids": [ + "kleborate" + ], + "Description": "Screen genome assemblies of Klebsiella pneumoniae and the Klebsiella pneumoniae species complex (KpSC)", + "bio.tool id": "kleborate", + "bio.tool ids": [ + "kleborate" + ], + "biii": null, + "bio.tool name": "Kleborate", + "bio.tool description": "Genomic surveillance framework and global population structure for Klebsiella pneumoniae.Kleborate is a tool to screen genome assemblies of Klebsiella pneumoniae and the Klebsiella pneumoniae species complex (KpSC) for:.A manuscript describing the Kleborate software in full is currently in preparation. In the meantime, if you use Kleborate, please cite the preprint: Lam, MMC. et al. Genomic surveillance framework and global population structure for Klebsiella pneumoniae. bioRxiv (2020).", + "EDAM operation": [ + "Multilocus sequence typing", + "Genome assembly", + "Virulence prediction" + ], + "EDAM topic": [ + "Public health and epidemiology", + "Metagenomics", + "Population genomics", + "Sequence assembly", + "Whole genome sequencing" + ], + "Status": "Up-to-date", + "Source": "https://github.com/katholt/Kleborate/wiki", + "ToolShed categories": [ + "Metagenomics" + ], + "ToolShed id": "kleborate", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/katholt/Kleborate", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/kleborate", + "Galaxy wrapper version": "2.3.2", + "Conda id": "kleborate", + "Conda version": "2.3.2" + }, + { + "Galaxy wrapper id": "kma", + "Galaxy tool ids": [ + "kma_map" + ], + "Description": "Map with KMA", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://bitbucket.org/genomicepidemiology/kma", + "ToolShed categories": [ + "Next Gen Mappers" + ], + "ToolShed id": "kma", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/kma", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/kma", + "Galaxy wrapper version": "1.2.21", + "Conda id": "kma", + "Conda version": "1.4.14" + }, + { + "Galaxy wrapper id": "kofamscan", + "Galaxy tool ids": [ + "kofamscan" + ], + "Description": "Gene function annotation tool based on KEGG Orthology and hidden Markov model", + "bio.tool id": "kofamscan", + "bio.tool ids": [ + "kofamscan" + ], + "biii": null, + "bio.tool name": "kofamscan", + "bio.tool description": "KofamScan is a gene function annotation tool based on KEGG Orthology and hidden Markov model. You need KOfam database to use this tool.", + "EDAM operation": [ + "Sequence analysis", + "Gene functional annotation" + ], + "EDAM topic": [ + "Genomics" + ], + "Status": "Up-to-date", + "Source": "https://github.com/takaram/kofam_scan", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "kofamscan", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/kofamscan", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/kofamscan", + "Galaxy wrapper version": "1.3.0", + "Conda id": "kofamscan", + "Conda version": "1.3.0" + }, + { + "Galaxy wrapper id": "kraken_biom", + "Galaxy tool ids": [ + "kraken_biom" + ], + "Description": "Create BIOM-format tables (http://biom-format.org) from Kraken output (http://ccb.jhu.edu/software/kraken/)", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/smdabdoub/kraken-biom", + "ToolShed categories": [ + "Metagenomics" + ], + "ToolShed id": "kraken_biom", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/smdabdoub/kraken-biom", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/kraken_biom", + "Galaxy wrapper version": "1.2.0", + "Conda id": "kraken-biom", + "Conda version": "1.2.0" + }, + { + "Galaxy wrapper id": "kraken_taxonomy_report", + "Galaxy tool ids": [ + "kraken_taxonomy_report" + ], + "Description": "Kraken taxonomy report", + "bio.tool id": "Kraken-Taxonomy-Report", + "bio.tool ids": [ + "Kraken-Taxonomy-Report" + ], + "biii": null, + "bio.tool name": "Kraken-Taxonomy-Report", + "bio.tool description": "view report of classification for multiple samples", + "EDAM operation": [ + "Visualisation", + "Classification" + ], + "EDAM topic": [ + "Metagenomics", + "Taxonomy" + ], + "Status": "To update", + "Source": "https://github.com/blankenberg/Kraken-Taxonomy-Report", + "ToolShed categories": [ + "Metagenomics" + ], + "ToolShed id": "kraken_taxonomy_report", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/kraken_taxonomy_report", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/kraken_taxonomy_report", + "Galaxy wrapper version": "0.0.3", + "Conda id": "biopython", + "Conda version": "1.70" + }, + { + "Galaxy wrapper id": "krakentools", + "Galaxy tool ids": [ + "krakentools_alpha_diversity", + "krakentools_beta_diversity", + "krakentools_combine_kreports", + "krakentools_extract_kraken_reads", + "krakentools_kreport2krona", + "krakentools_kreport2mpa" + ], + "Description": "KrakenTools is a suite of scripts to be used alongside the Kraken", + "bio.tool id": "krakentools", + "bio.tool ids": [ + "krakentools" + ], + "biii": null, + "bio.tool name": "KrakenTools", + "bio.tool description": "KrakenTools provides individual scripts to analyze Kraken/Kraken2/Bracken/KrakenUniq output files", + "EDAM operation": [ + "Visualisation", + "Aggregation" + ], + "EDAM topic": [ + "Taxonomy", + "Metagenomics" + ], + "Status": "Up-to-date", + "Source": "https://github.com/jenniferlu717/KrakenTools", + "ToolShed categories": [ + "Metagenomics" + ], + "ToolShed id": "krakentools", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/krakentools", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/krakentools", + "Galaxy wrapper version": "1.2", + "Conda id": "krakentools", + "Conda version": "1.2" + }, + { + "Galaxy wrapper id": "krocus", + "Galaxy tool ids": [ + "krocus" + ], + "Description": "Predict MLST directly from uncorrected long reads", + "bio.tool id": "krocus", + "bio.tool ids": [ + "krocus" + ], + "biii": null, + "bio.tool name": "krocus", + "bio.tool description": "Predict MLST directly from uncorrected long reads", + "EDAM operation": [ + "Multilocus sequence typing", + "k-mer counting" + ], + "EDAM topic": [ + "Public health and epidemiology" + ], + "Status": "To update", + "Source": "https://github.com/quadram-institute-bioscience/krocus", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "krocus", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/krocus", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/krocus", + "Galaxy wrapper version": "1.0.1", + "Conda id": "krocus", + "Conda version": "1.0.3" + }, + { + "Galaxy wrapper id": "last", + "Galaxy tool ids": [ + "last_al", + "last_db", + "last_split", + "last_train", + "last_maf_convert" + ], + "Description": "LAST finds similar regions between sequences.", + "bio.tool id": "last", + "bio.tool ids": [ + "last" + ], + "biii": null, + "bio.tool name": "LAST", + "bio.tool description": "Short read alignment program incorporating quality scores", + "EDAM operation": [ + "Sequence alignment" + ], + "EDAM topic": [ + "Genomics", + "Comparative genomics" + ], + "Status": "To update", + "Source": "http://last.cbrc.jp/", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "last", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/last", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/last", + "Galaxy wrapper version": "1205", + "Conda id": "last", + "Conda version": "1542" + }, + { + "Galaxy wrapper id": "lastz", + "Galaxy tool ids": [ + "lastz_wrapper_2", + "lastz_d_wrapper" + ], + "Description": "Galaxy wrappers for the Lastz and Lastz_d", + "bio.tool id": "lastz", + "bio.tool ids": [ + "lastz" + ], + "biii": null, + "bio.tool name": "LASTZ", + "bio.tool description": "A tool for (1) aligning two DNA sequences, and (2) inferring appropriate scoring parameters automatically.", + "EDAM operation": [ + "Sequence alignment", + "Read mapping" + ], + "EDAM topic": [ + "Genomics" + ], + "Status": "Up-to-date", + "Source": "https://github.com/lastz/lastz", + "ToolShed categories": [ + "Next Gen Mappers" + ], + "ToolShed id": "lastz", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/lastz", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/lastz", + "Galaxy wrapper version": "1.04.22", + "Conda id": "lastz", + "Conda version": "1.04.22" + }, + { + "Galaxy wrapper id": "lcrgenie", + "Galaxy tool ids": [ + "lcrgenie" + ], + "Description": "Ligase Chain Reaction Genie", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/neilswainston/LCRGenie", + "ToolShed categories": [ + "Synthetic Biology" + ], + "ToolShed id": "lcrgenie", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/lcrgenie", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/lcrgenie", + "Galaxy wrapper version": "1.0.2", + "Conda id": "lcr_genie", + "Conda version": null + }, + { + "Galaxy wrapper id": "legsta", + "Galaxy tool ids": [ + "legsta" + ], + "Description": "Performs in silico Legionella pneumophila sequence based typing.", + "bio.tool id": "legsta", + "bio.tool ids": [ + "legsta" + ], + "biii": null, + "bio.tool name": "legsta", + "bio.tool description": "Performs in silico Legionella pneumophila sequence based typing", + "EDAM operation": [ + "Sequence analysis" + ], + "EDAM topic": [ + "Public health and epidemiology" + ], + "Status": "Up-to-date", + "Source": "https://github.com/tseemann/legsta", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "legsta", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/tseemann/legsta", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/legsta", + "Galaxy wrapper version": "0.5.1", + "Conda id": "legsta", + "Conda version": "0.5.1" + }, + { + "Galaxy wrapper id": "length_and_gc_content", + "Galaxy tool ids": [ + "length_and_gc_content" + ], + "Description": "Gets gene length and gc content from a fasta and a GTF file", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/length_and_gc_content", + "ToolShed categories": [ + "Fasta Manipulation", + "Statistics", + "RNA", + "Micro-array Analysis" + ], + "ToolShed id": "length_and_gc_content", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/length_and_gc_content", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/length_and_gc_content", + "Galaxy wrapper version": "0.1.2", + "Conda id": "r-optparse", + "Conda version": "1.3.2" + }, + { + "Galaxy wrapper id": "limma_voom", + "Galaxy tool ids": [ + "limma_voom" + ], + "Description": "Perform RNA-Seq differential expression analysis using limma voom pipeline", + "bio.tool id": "limma", + "bio.tool ids": [ + "limma" + ], + "biii": null, + "bio.tool name": "limma", + "bio.tool description": "Data analysis, linear models and differential expression for microarray data.", + "EDAM operation": [ + "RNA-Seq analysis" + ], + "EDAM topic": [ + "Molecular biology", + "Genetics" + ], + "Status": "Up-to-date", + "Source": "http://bioconductor.org/packages/release/bioc/html/limma.html", + "ToolShed categories": [ + "Transcriptomics", + "RNA", + "Statistics" + ], + "ToolShed id": "limma_voom", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/limma_voom", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/limma_voom", + "Galaxy wrapper version": "3.58.1", + "Conda id": "bioconductor-limma", + "Conda version": "3.58.1" + }, + { + "Galaxy wrapper id": "lineagespot", + "Galaxy tool ids": [ + "lineagespot" + ], + "Description": "Identification of SARS-CoV-2 related metagenomic mutations based on a single (or a list of) variant(s) file(s)", + "bio.tool id": "lineagespot", + "bio.tool ids": [ + "lineagespot" + ], + "biii": null, + "bio.tool name": "lineagespot", + "bio.tool description": "Lineagespot is a framework written in R, and aims to identify and assign different SARS-CoV-2 lineages based on a single variant file (i.e., variant calling format).", + "EDAM operation": [ + "Variant calling" + ], + "EDAM topic": [ + "Metagenomics", + "Gene transcripts", + "Evolutionary biology", + "Sequencing", + "Genetic variation" + ], + "Status": "To update", + "Source": "https://www.bioconductor.org/packages/release/bioc/html/lineagespot.html", + "ToolShed categories": [ + "Metagenomics", + "Sequence Analysis" + ], + "ToolShed id": "lineagespot", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/lineagespot", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/lineagespot", + "Galaxy wrapper version": "1.6.0", + "Conda id": "r-base", + "Conda version": null + }, + { + "Galaxy wrapper id": "links", + "Galaxy tool ids": [ + "links" + ], + "Description": "Scaffold genome assemblies with long reads.", + "bio.tool id": "links", + "bio.tool ids": [ + "links" + ], + "biii": null, + "bio.tool name": "LINKS", + "bio.tool description": "LINKS (Long Interval Nucleotide K-mer Scaffolder) is a genomics application for scaffolding genome assemblies with long reads, such as those produced by Oxford Nanopore Technologies Ltd. It can be used to scaffold high-quality draft genome assemblies with any long sequences (eg. ONT reads, PacBio reads, other draft genomes, etc). It is also used to scaffold contig pairs linked by ARCS/ARKS.", + "EDAM operation": [ + "Scaffolding", + "Genome assembly", + "Read mapping", + "Read pre-processing", + "Sequence trimming" + ], + "EDAM topic": [ + "Sequence assembly", + "Mapping", + "Sequencing" + ], + "Status": "Up-to-date", + "Source": "https://github.com/bcgsc/LINKS", + "ToolShed categories": [ + "Assembly" + ], + "ToolShed id": "links", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/links", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/links", + "Galaxy wrapper version": "2.0.1", + "Conda id": "links", + "Conda version": "2.0.1" + }, + { + "Galaxy wrapper id": "lofreq", + "Galaxy tool ids": [ + "lofreq_alnqual", + "lofreq_call", + "lofreq_filter", + "lofreq_indelqual", + "lofreq_viterbi" + ], + "Description": "LoFreq is a fast and sensitive variant-caller for inferring SNVs and indelsfrom next-generation sequencing data. It makes full use of base-call qualitiesand other sources of errors inherent in sequencing (e.g. mapping or base/indelalignment uncertainty), which are usually ignored by other methods or onlyused for filtering.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://csb5.github.io/lofreq/", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": null, + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/lofreq", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/lofreq", + "Galaxy wrapper version": "2.1.5", + "Conda id": "lofreq", + "Conda version": "2.1.5" + }, + { + "Galaxy wrapper id": "lorikeet", + "Galaxy tool ids": [ + "lorikeet_spoligotype" + ], + "Description": "Tools for M. tuberculosis DNA fingerprinting (spoligotyping)", + "bio.tool id": "lorikeet", + "bio.tool ids": [ + "lorikeet" + ], + "biii": null, + "bio.tool name": "lorikeet", + "bio.tool description": "Tools for M. tuberculosis DNA fingerprinting (spoligotyping)", + "EDAM operation": [ + "Sequence analysis", + "Genotyping" + ], + "EDAM topic": [ + "Genotype and phenotype" + ], + "Status": "Up-to-date", + "Source": "https://github.com/AbeelLab/lorikeet", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "lorikeet_spoligotype", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/AbeelLab/lorikeet", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/lorikeet", + "Galaxy wrapper version": "20", + "Conda id": "lorikeet", + "Conda version": "20" + }, + { + "Galaxy wrapper id": "lumpy_sv", + "Galaxy tool ids": [ + "lumpy_prep", + "lumpy_sv" + ], + "Description": "LUMPY - a general probabilistic framework for structural variant discovery", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "http://layerlab.org/software/", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "lumpy_sv", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/arq5x/lumpy-sv", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/lumpy_sv", + "Galaxy wrapper version": "0.3.1", + "Conda id": "lumpy-sv", + "Conda version": "0.3.1" + }, + { + "Galaxy wrapper id": "m6anet", + "Galaxy tool ids": [ + "m6anet" + ], + "Description": "m6anet to detect m6A RNA modifications from nanopore data", + "bio.tool id": "m6Anet", + "bio.tool ids": [ + "m6Anet" + ], + "biii": null, + "bio.tool name": "m6Anet", + "bio.tool description": "Detection of m6A from direct RNA sequencing using a Multiple Instance Learning framework.", + "EDAM operation": [ + "Quantification", + "Imputation", + "Gene expression profiling" + ], + "EDAM topic": [ + "RNA-Seq", + "Transcriptomics", + "RNA", + "Machine learning" + ], + "Status": "Up-to-date", + "Source": "https://m6anet.readthedocs.io/en/latest", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "m6anet", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/m6anet", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/m6anet", + "Galaxy wrapper version": "2.1.0", + "Conda id": "m6anet", + "Conda version": "2.1.0" + }, + { + "Galaxy wrapper id": "maaslin2", + "Galaxy tool ids": [ + "maaslin2" + ], + "Description": "MaAsLin2 is comprehensive R package for efficiently determining multivariable association between microbial meta'omic features and clinical metadata.", + "bio.tool id": "maaslin2", + "bio.tool ids": [ + "maaslin2" + ], + "biii": null, + "bio.tool name": "MaAsLin2", + "bio.tool description": "MaAsLin2 is comprehensive R package for efficiently determining multivariable association between phenotypes, environments, exposures, covariates and microbial meta\u2019omic features. MaAsLin2 relies on general linear models to accommodate most modern epidemiological study designs, including cross-sectional and longitudinal, and offers a variety of data exploration, normalization, and transformation methods.", + "EDAM operation": [ + "Filtering", + "Statistical calculation", + "Standardisation and normalisation", + "Visualisation" + ], + "EDAM topic": [ + "Metagenomics", + "Statistics and probability" + ], + "Status": "To update", + "Source": "http://huttenhower.sph.harvard.edu/maaslin", + "ToolShed categories": [ + "Metagenomics" + ], + "ToolShed id": "maaslin2", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/biobakery/Maaslin2", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/maaslin2", + "Galaxy wrapper version": "0.99.12", + "Conda id": "maaslin2", + "Conda version": "1.16.0" + }, + { + "Galaxy wrapper id": "macs2", + "Galaxy tool ids": [ + "macs2_bdgbroadcall", + "macs2_bdgcmp", + "macs2_bdgdiff", + "macs2_bdgpeakcall", + "macs2_callpeak", + "macs2_filterdup", + "macs2_predictd", + "macs2_randsample", + "macs2_refinepeak" + ], + "Description": "MACS - Model-based Analysis of ChIP-Seq", + "bio.tool id": "macs", + "bio.tool ids": [ + "macs" + ], + "biii": null, + "bio.tool name": "MACS", + "bio.tool description": "Model-based Analysis of ChIP-seq data.", + "EDAM operation": [ + "Peak calling", + "Enrichment analysis", + "Gene regulatory network analysis" + ], + "EDAM topic": [ + "ChIP-seq", + "Molecular interactions, pathways and networks", + "Transcription factors and regulatory sites" + ], + "Status": "Up-to-date", + "Source": "https://github.com/taoliu/MACS", + "ToolShed categories": [ + "Sequence Analysis", + "Statistics" + ], + "ToolShed id": "macs2", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/macs2", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/macs2", + "Galaxy wrapper version": "2.2.9.1", + "Conda id": "macs2", + "Conda version": "2.2.9.1" + }, + { + "Galaxy wrapper id": "maf_stats", + "Galaxy tool ids": [ + "maf_stats1" + ], + "Description": "MAF Coverage statistics", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/interval2maf/", + "ToolShed categories": [ + "Genomic Interval Operations" + ], + "ToolShed id": "maf_stats", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/interval2maf/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/maf_stats", + "Galaxy wrapper version": "1.0.2+galaxy0", + "Conda id": null, + "Conda version": null + }, + { + "Galaxy wrapper id": "mageck", + "Galaxy tool ids": [ + "mageck_count", + "mageck_gsea", + "mageck_mle", + "mageck_pathway", + "mageck_test" + ], + "Description": "Model-based Analysis of Genome-wide CRISPR-Cas9 Knockout (MAGeCK) is a computational tool to identifyimportant genes from the recent genome-scale CRISPR-Cas9 knockout screens technology.", + "bio.tool id": "mageck", + "bio.tool ids": [ + "mageck" + ], + "biii": null, + "bio.tool name": "MAGeCK", + "bio.tool description": "Computational tool to identify important genes from the recent genome-scale CRISPR-Cas9 knockout screens technology.", + "EDAM operation": [ + "Genetic variation analysis" + ], + "EDAM topic": [ + "Genetics", + "Genetic variation", + "Genomics" + ], + "Status": "To update", + "Source": "https://sourceforge.net/projects/mageck/", + "ToolShed categories": [ + "Genome editing" + ], + "ToolShed id": null, + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/mageck", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/mageck", + "Galaxy wrapper version": "0.5.9.2", + "Conda id": "mageck", + "Conda version": "0.5.9.5" + }, + { + "Galaxy wrapper id": "maker", + "Galaxy tool ids": [ + "maker", + "maker_map_ids" + ], + "Description": "MAKER is a portable and easily configurable genome annotation pipeline.Its purpose is to allow smaller eukaryotic and prokaryotic genome projects to independently annotate their genomes and to create genome databases.", + "bio.tool id": "maker", + "bio.tool ids": [ + "maker" + ], + "biii": null, + "bio.tool name": "MAKER", + "bio.tool description": "Portable and easily configurable genome annotation pipeline. It\u2019s purpose is to allow smaller eukaryotic and prokaryotic genome projects to independently annotate their genomes and to create genome databases.", + "EDAM operation": [ + "Genome annotation" + ], + "EDAM topic": [ + "Genomics", + "DNA", + "Sequence analysis" + ], + "Status": "To update", + "Source": "http://www.yandell-lab.org/software/maker.html", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": null, + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/maker", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/maker", + "Galaxy wrapper version": "2.31.11", + "Conda id": "maker", + "Conda version": "3.01.03" + }, + { + "Galaxy wrapper id": "malt", + "Galaxy tool ids": [ + "malt_run" + ], + "Description": "Aligns an input sequence (DNA or proteins) against an index representing a collection of reference DNA or protein sequences.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/husonlab/malt", + "ToolShed categories": [ + "Next Gen Mappers" + ], + "ToolShed id": "malt_run", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/malt", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/malt", + "Galaxy wrapper version": "0.5.3", + "Conda id": "malt", + "Conda version": "0.62" + }, + { + "Galaxy wrapper id": "map_param_value", + "Galaxy tool ids": [ + "map_param_value" + ], + "Description": "Map a parameter value to another value", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": null, + "ToolShed categories": [ + "Text Manipulation" + ], + "ToolShed id": "map_param_value", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/map_param_value", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/map_param_value", + "Galaxy wrapper version": "0.2.0", + "Conda id": null, + "Conda version": null + }, + { + "Galaxy wrapper id": "mapseq", + "Galaxy tool ids": [ + "mapseq" + ], + "Description": "fast and accurate sequence read classification tool designed to assign taxonomy and OTU classifications to ribosomal RNA sequences.", + "bio.tool id": "mapseq", + "bio.tool ids": [ + "mapseq" + ], + "biii": null, + "bio.tool name": "MAPseq", + "bio.tool description": "Highly efficient k-mer search with confidence estimates, for rRNA sequence analysis .", + "EDAM operation": [ + "k-mer counting" + ], + "EDAM topic": [ + "Functional, regulatory and non-coding RNA", + "Sequence analysis", + "Sequence sites, features and motifs" + ], + "Status": "To update", + "Source": "https://github.com/jfmrod/MAPseq", + "ToolShed categories": [ + "Metagenomics" + ], + "ToolShed id": "mapseq", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/mapseq", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/mapseq", + "Galaxy wrapper version": "2.1.1", + "Conda id": "perl", + "Conda version": null + }, + { + "Galaxy wrapper id": "mash", + "Galaxy tool ids": [ + "mash_screen", + "mash_sketch" + ], + "Description": "Fast genome and metagenome distance estimation using MinHash", + "bio.tool id": "mash", + "bio.tool ids": [ + "mash" + ], + "biii": null, + "bio.tool name": "Mash", + "bio.tool description": "Fast genome and metagenome distance estimation using MinHash.", + "EDAM operation": [ + "Sequence distance matrix generation" + ], + "EDAM topic": [ + "Genomics", + "Metagenomics", + "Statistics and probability", + "Sequence analysis", + "DNA mutation" + ], + "Status": "Up-to-date", + "Source": "https://github.com/marbl/Mash", + "ToolShed categories": [ + "Metagenomics" + ], + "ToolShed id": null, + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/mash", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/mash", + "Galaxy wrapper version": "2.3", + "Conda id": "mash", + "Conda version": "2.3" + }, + { + "Galaxy wrapper id": "mashmap", + "Galaxy tool ids": [ + "mashmap" + ], + "Description": "Fast local alignment boundaries", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/mashmap", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "mashmap", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/mashmap", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/mashmap", + "Galaxy wrapper version": "3.1.3", + "Conda id": "mashmap", + "Conda version": "3.1.3" + }, + { + "Galaxy wrapper id": "masigpro", + "Galaxy tool ids": [ + "masigpro" + ], + "Description": "Identify significantly differential expression profiles in time-course microarray experiments", + "bio.tool id": "masigpro", + "bio.tool ids": [ + "masigpro" + ], + "biii": null, + "bio.tool name": "maSigPro", + "bio.tool description": "Regression based approach to find genes for which there are significant gene expression profile differences between experimental groups in time course microarray and RNA-Seq experiments.", + "EDAM operation": [ + "Regression analysis" + ], + "EDAM topic": [ + "Gene expression", + "Molecular genetics", + "Microarray experiment", + "RNA-Seq" + ], + "Status": "To update", + "Source": "https://www.bioconductor.org/packages/release/bioc/html/maSigPro.html", + "ToolShed categories": [ + "Transcriptomics", + "RNA", + "Statistics" + ], + "ToolShed id": "masigpro", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/masigpro", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/masigpro", + "Galaxy wrapper version": "1.49.3", + "Conda id": "coreutils", + "Conda version": "8.25" + }, + { + "Galaxy wrapper id": "maxbin2", + "Galaxy tool ids": [ + "maxbin2" + ], + "Description": "clusters metagenomic contigs into bins", + "bio.tool id": "maxbin", + "bio.tool ids": [ + "maxbin" + ], + "biii": null, + "bio.tool name": "MaxBin", + "bio.tool description": "Software for binning assembled metagenomic sequences based on an Expectation-Maximization algorithm.", + "EDAM operation": [ + "Sequence assembly" + ], + "EDAM topic": [ + "Metagenomics", + "Sequence assembly", + "Microbiology" + ], + "Status": "To update", + "Source": "https://downloads.jbei.org/data/microbial_communities/MaxBin/MaxBin.html", + "ToolShed categories": [ + "Metagenomics" + ], + "ToolShed id": "maxbin2", + "Galaxy wrapper owner": "mbernt", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/maxbin2/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/maxbin2", + "Galaxy wrapper version": null, + "Conda id": "maxbin2", + "Conda version": "2.2.7" + }, + { + "Galaxy wrapper id": "mcl", + "Galaxy tool ids": [ + "mcl" + ], + "Description": "The Markov Cluster Algorithm, a cluster algorithm for graphs", + "bio.tool id": "mcl", + "bio.tool ids": [ + "mcl" + ], + "biii": null, + "bio.tool name": "MCL", + "bio.tool description": "MCL is a clustering algorithm widely used in bioinformatics and gaining traction in other fields.", + "EDAM operation": [ + "Clustering", + "Network analysis", + "Gene regulatory network analysis" + ], + "EDAM topic": [ + "Molecular interactions, pathways and networks" + ], + "Status": "Up-to-date", + "Source": "https://micans.org/mcl/man/mcl.html", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "mcl", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/mcl", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/mcl", + "Galaxy wrapper version": "22.282", + "Conda id": "mcl", + "Conda version": "22.282" + }, + { + "Galaxy wrapper id": "medaka", + "Galaxy tool ids": [ + "medaka_consensus", + "medaka_consensus_pipeline", + "medaka_snp", + "medaka_variant" + ], + "Description": "Sequence correction provided by ONT Research", + "bio.tool id": "medaka", + "bio.tool ids": [ + "medaka" + ], + "biii": null, + "bio.tool name": "Medaka", + "bio.tool description": "medaka is a tool to create consensus sequences and variant calls from nanopore sequencing data. This task is performed using neural networks applied a pileup of individual sequencing reads against a draft assembly.", + "EDAM operation": [ + "Base-calling", + "Variant calling", + "Sequence assembly" + ], + "EDAM topic": [ + "Sequence assembly", + "Machine learning" + ], + "Status": "To update", + "Source": "https://github.com/nanoporetech/medaka", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": null, + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/medaka", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/medaka", + "Galaxy wrapper version": "1.7.2", + "Conda id": "medaka", + "Conda version": "1.11.3" + }, + { + "Galaxy wrapper id": "megahit", + "Galaxy tool ids": [ + "megahit" + ], + "Description": "An ultra-fast single-node solution for large and complex metagenomics assembly via succinct de Bruijn graph.", + "bio.tool id": "megahit", + "bio.tool ids": [ + "megahit" + ], + "biii": null, + "bio.tool name": "MEGAHIT", + "bio.tool description": "Single node assembler for large and complex metagenomics NGS reads, such as soil. It makes use of succinct de Bruijn graph to achieve low memory usage, whereas its goal is not to make memory usage as low as possible.", + "EDAM operation": [ + "Genome assembly" + ], + "EDAM topic": [ + "Metagenomics", + "Sequencing", + "Ecology", + "Sequence assembly" + ], + "Status": "Up-to-date", + "Source": "https://github.com/voutcn/megahit", + "ToolShed categories": [ + "Sequence Analysis", + "Assembly", + "Metagenomics" + ], + "ToolShed id": "megahit", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/megahit", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/megahit", + "Galaxy wrapper version": "1.2.9", + "Conda id": "megahit", + "Conda version": "1.2.9" + }, + { + "Galaxy wrapper id": "megahit_contig2fastg", + "Galaxy tool ids": [ + "megahit_contig2fastg" + ], + "Description": "A subprogram within the Megahit toolkit for converting contigs to assembly graphs (fastg)", + "bio.tool id": "megahit", + "bio.tool ids": [ + "megahit" + ], + "biii": null, + "bio.tool name": "MEGAHIT", + "bio.tool description": "Single node assembler for large and complex metagenomics NGS reads, such as soil. It makes use of succinct de Bruijn graph to achieve low memory usage, whereas its goal is not to make memory usage as low as possible.", + "EDAM operation": [ + "Genome assembly" + ], + "EDAM topic": [ + "Metagenomics", + "Sequencing", + "Ecology", + "Sequence assembly" + ], + "Status": "To update", + "Source": "https://github.com/voutcn/megahit/blob/master/tools/toolkit.cpp", + "ToolShed categories": [ + "Sequence Analysis", + "Assembly", + "Metagenomics" + ], + "ToolShed id": "megahit_contig2fastg", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/megahit_contig2fastg", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/megahit_contig2fastg", + "Galaxy wrapper version": "1.1.3", + "Conda id": "megahit", + "Conda version": "1.2.9" + }, + { + "Galaxy wrapper id": "megan", + "Galaxy tool ids": [ + "megan_blast2lca", + "megan_blast2rma", + "megan_daa2info", + "megan_daa2rma", + "megan_daa_meganizer", + "megan_read_extractor", + "megan_sam2rma" + ], + "Description": "MEGAN Community Edition - Interactive exploration and analysis of large-scale microbiome sequencing data. MEGAN is a tool for studying the taxonomic content of a set of DNA reads, typically collected in a metagenomics project.In a preprocessing step, a sequence alignment of all reads against a suitable database of reference DNA or proteinsequences must be performed to produce an input file for the program. MEGAN is suitable for DNA reads (metagenomedata), RNA reads (metatranscriptome data), peptide sequences (metaproteomics data) and, using a suitable synonymsfile that maps SILVA ids to taxon ids, for 16S rRNA data (amplicon sequencing).", + "bio.tool id": "megan", + "bio.tool ids": [ + "megan" + ], + "biii": null, + "bio.tool name": "MEGAN", + "bio.tool description": "Metagenome Analysis Software - MEGAN (MEtaGenome ANalyzer\u009d) is a new computer program that allows laptop analysis of large metagenomic datasets. In a preprocessing step, the set of DNA reads (or contigs) is compared against databases of known sequences using BLAST or another comparison tool. MEGAN can then be used to compute and interactively explore the taxonomical content of the dataset, employing the NCBI taxonomy to summarize and order the results.", + "EDAM operation": [ + "Sequence analysis", + "Taxonomic classification" + ], + "EDAM topic": [ + "Sequence analysis" + ], + "Status": "To update", + "Source": "https://github.com/husonlab/megan-ce", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "megan", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/megan", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/megan", + "Galaxy wrapper version": "6.21.7", + "Conda id": "megan", + "Conda version": "6.25.9" + }, + { + "Galaxy wrapper id": "meme", + "Galaxy tool ids": [ + "meme_dreme", + "meme_fimo", + "meme_meme", + "meme_psp_gen" + ], + "Description": "The MEME Suite allows the biologist to discover novel motifs in collections of unaligned nucleotideor protein sequences, and to perform a wide variety of other motif-based analyses.", + "bio.tool id": "meme_meme", + "bio.tool ids": [ + "meme_meme", + "meme_fimo" + ], + "biii": null, + "bio.tool name": "meme_meme", + "bio.tool description": "An algorithm that discovers one or more motifs in a collection of DNA or protein sequences by using the technique of expectation maximization to fit a two-component finite mixture model to the set of sequences.", + "EDAM operation": [ + "Nucleic acid feature detection", + "Protein feature detection", + "Statistical calculation" + ], + "EDAM topic": [ + "Data mining", + "Sequence analysis", + "Genetic variation", + "Statistics and probability" + ], + "Status": "To update", + "Source": "http://meme-suite.org/", + "ToolShed categories": [ + "ChIP-seq" + ], + "ToolShed id": "meme", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/meme", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/meme", + "Galaxy wrapper version": "5.4.1", + "Conda id": "meme", + "Conda version": "5.5.5" + }, + { + "Galaxy wrapper id": "meme_chip", + "Galaxy tool ids": [ + "meme_chip" + ], + "Description": "Performs motif discovery, motif enrichment analysis and clustering on large nucleotide datasets.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "http://meme-suite.org/", + "ToolShed categories": [ + "ChIP-seq" + ], + "ToolShed id": "meme_chip", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/meme_chip", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/meme_chip", + "Galaxy wrapper version": "4.11.2", + "Conda id": "graphicsmagick", + "Conda version": "1.3.26" + }, + { + "Galaxy wrapper id": "meningotype", + "Galaxy tool ids": [ + "meningotype" + ], + "Description": "Assign sequence type to N. meningitidis genome assemblies", + "bio.tool id": "meningotype", + "bio.tool ids": [ + "meningotype" + ], + "biii": null, + "bio.tool name": "meningotype", + "bio.tool description": "In silico typing of Neisseria meningitidis contigs.", + "EDAM operation": [ + "Genotyping", + "Multilocus sequence typing" + ], + "EDAM topic": [ + "Microbiology", + "Genotype and phenotype" + ], + "Status": "Up-to-date", + "Source": "https://github.com/MDU-PHL/meningotype", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "meningotype", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/meningotype", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/meningotype", + "Galaxy wrapper version": "0.8.5", + "Conda id": "meningotype", + "Conda version": "0.8.5" + }, + { + "Galaxy wrapper id": "merlin", + "Galaxy tool ids": [ + "merlin" + ], + "Description": "Pedigree Analysis package", + "bio.tool id": "merlin", + "bio.tool ids": [ + "merlin" + ], + "biii": null, + "bio.tool name": "Merlin", + "bio.tool description": "Can be used for parametric and non-parametric linkage analysis, regression-based linkage analysis or association analysis for quantitative traits, ibd and kinship estimation, haplotyping, error detection and simulation", + "EDAM operation": [ + "Haplotype mapping", + "Genetic mapping" + ], + "EDAM topic": [ + "GWAS study", + "Mapping" + ], + "Status": "Up-to-date", + "Source": "http://csg.sph.umich.edu/abecasis/Merlin/", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "merlin", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/merlin/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/merlin", + "Galaxy wrapper version": "1.1.2", + "Conda id": "merlin", + "Conda version": "1.1.2" + }, + { + "Galaxy wrapper id": "merqury", + "Galaxy tool ids": [ + "merqury", + "merquryplot" + ], + "Description": "Merqury is a tool for evaluating genomes assemblies based of k-mer operations.", + "bio.tool id": "merqury", + "bio.tool ids": [ + "merqury" + ], + "biii": null, + "bio.tool name": "Merqury", + "bio.tool description": "Reference-free quality, completeness, and phasing assessment for genome assemblies.Evaluate genome assemblies with k-mers and more.Often, genome assembly projects have illumina whole genome sequencing reads available for the assembled individual.Merqury provides a set of tools for this purpose.", + "EDAM operation": [ + "Genome assembly", + "k-mer counting", + "Scaffolding", + "Phasing", + "De-novo assembly" + ], + "EDAM topic": [ + "Sequence assembly", + "Whole genome sequencing", + "Plant biology" + ], + "Status": "Up-to-date", + "Source": "https://github.com/marbl/merqury", + "ToolShed categories": [ + "Assembly" + ], + "ToolShed id": "merqury", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/merqury", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/merqury", + "Galaxy wrapper version": "1.3", + "Conda id": "merqury", + "Conda version": "1.3" + }, + { + "Galaxy wrapper id": "meryl", + "Galaxy tool ids": [ + "meryl_arithmetic_kmers", + "meryl_count_kmers", + "meryl_filter_kmers", + "meryl_groups_kmers", + "meryl_histogram_kmers", + "meryl_print", + "meryl_trio_mode" + ], + "Description": "Meryl a k-mer counter.", + "bio.tool id": "meryl", + "bio.tool ids": [ + "meryl" + ], + "biii": null, + "bio.tool name": "Meryl", + "bio.tool description": "Meryl is a tool for counting and working with sets of k-mers that was originally developed for use in the Celera Assembler and has since been migrated and maintained as part of Canu.", + "EDAM operation": [ + "k-mer counting" + ], + "EDAM topic": [ + "Whole genome sequencing", + "Genomics", + "Sequence analysis", + "Sequencing" + ], + "Status": "Up-to-date", + "Source": "https://github.com/marbl/meryl", + "ToolShed categories": [ + "Assembly" + ], + "ToolShed id": "meryl", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/meryl", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/meryl", + "Galaxy wrapper version": "1.3", + "Conda id": "merqury", + "Conda version": "1.3" + }, + { + "Galaxy wrapper id": "metabat2", + "Galaxy tool ids": [ + "metabat2_jgi_summarize_bam_contig_depths", + "metabat2" + ], + "Description": "MetaBAT2 (Metagenome Binning based on Abundance and Tetranucleotide frequency) is an automated metagenome binningsoftware that integrates empirical probabilistic distances of genome abundance and tetranucleotide frequency.", + "bio.tool id": "MetaBAT_2", + "bio.tool ids": [ + "MetaBAT_2" + ], + "biii": null, + "bio.tool name": "MetaBAT 2", + "bio.tool description": "an adaptive binning algorithm for robust and efficient genome reconstruction from metagenome assemblies | MetaBAT2 clusters metagenomic contigs into different \"bins\", each of which should correspond to a putative genome | MetaBAT2 uses nucleotide composition information and source strain abundance (measured by depth-of-coverage by aligning the reads to the contigs) to perform binning", + "EDAM operation": [ + "Read binning", + "Sequence assembly", + "Genome annotation" + ], + "EDAM topic": [ + "Metagenomics", + "Sequence assembly", + "Metagenomic sequencing" + ], + "Status": "Up-to-date", + "Source": "https://bitbucket.org/berkeleylab/metabat/src/master/", + "ToolShed categories": [ + "Metagenomics" + ], + "ToolShed id": "metabat2", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/metabat2/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/metabat2", + "Galaxy wrapper version": "2.15", + "Conda id": "metabat2", + "Conda version": "2.15" + }, + { + "Galaxy wrapper id": "metaeuk", + "Galaxy tool ids": [ + "metaeuk_easy_predict" + ], + "Description": "MetaEuk is a modular toolkit designed for large-scale gene discovery andannotation in eukaryotic metagenomic contigs. Metaeuk combines the fast andsensitive homology search capabilities of MMseqs2 with a dynamic programmingprocedure to recover optimal exons sets. It reduces redundancies in multiplediscoveries of the same gene and resolves conflicting gene predictions onthe same strand. ", + "bio.tool id": "MetaEuk", + "bio.tool ids": [ + "MetaEuk" + ], + "biii": null, + "bio.tool name": "MetaEuk", + "bio.tool description": "MetaEuk - sensitive, high-throughput gene discovery and annotation for large-scale eukaryotic metagenomics", + "EDAM operation": [ + "Homology-based gene prediction" + ], + "EDAM topic": [ + "Metagenomics", + "Gene and protein families" + ], + "Status": "To update", + "Source": "https://github.com/soedinglab/metaeuk", + "ToolShed categories": [ + "Sequence Analysis", + "Genome annotation" + ], + "ToolShed id": null, + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/metaeuk", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/metaeuk", + "Galaxy wrapper version": "5.34c21f2", + "Conda id": "metaeuk", + "Conda version": "6.a5d39d9" + }, + { + "Galaxy wrapper id": "metagenomeseq", + "Galaxy tool ids": [ + "metagenomeseq_normalizaton" + ], + "Description": "metagenomeSeq Normalization", + "bio.tool id": "metagenomeseq", + "bio.tool ids": [ + "metagenomeseq" + ], + "biii": null, + "bio.tool name": "metagenomeSeq", + "bio.tool description": "Designed to determine features (be it Operational Taxanomic Unit (OTU), species, etc.) that are differentially abundant between two or more groups of multiple samples. It is designed to address the effects of both normalization and under-sampling of microbial communities on disease association detection and the testing of feature correlations.", + "EDAM operation": [ + "Sequence visualisation", + "Statistical calculation" + ], + "EDAM topic": [ + "Metagenomics", + "Sequencing" + ], + "Status": "To update", + "Source": null, + "ToolShed categories": [ + "Metagenomics" + ], + "ToolShed id": "metagenomeseq_normalization", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/metagenomeseq", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/metagenomeseq", + "Galaxy wrapper version": "1.16.0-0.0.1", + "Conda id": "bioconductor-metagenomeseq", + "Conda version": "1.43.0" + }, + { + "Galaxy wrapper id": "metaphlan", + "Galaxy tool ids": [ + "customize_metaphlan_database", + "extract_metaphlan_database", + "merge_metaphlan_tables", + "metaphlan" + ], + "Description": "MetaPhlAn for Metagenomic Phylogenetic Analysis", + "bio.tool id": "metaphlan", + "bio.tool ids": [ + "metaphlan" + ], + "biii": null, + "bio.tool name": "MetaPhlAn", + "bio.tool description": "Computational tool for profiling the composition of microbial communities from metagenomic shotgun sequencing data.", + "EDAM operation": [ + "Nucleic acid sequence analysis", + "Phylogenetic tree analysis" + ], + "EDAM topic": [ + "Metagenomics", + "Phylogenomics" + ], + "Status": "To update", + "Source": "https://github.com/biobakery/MetaPhlAn", + "ToolShed categories": [ + "Metagenomics" + ], + "ToolShed id": "metaphlan", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/metaphlan/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/metaphlan", + "Galaxy wrapper version": "4.0.6", + "Conda id": "metaphlan", + "Conda version": "4.1.1" + }, + { + "Galaxy wrapper id": "metawrapmg", + "Galaxy tool ids": [ + "metawrapmg_binning" + ], + "Description": "A flexible pipeline for genome-resolved metagenomic data analysis", + "bio.tool id": "metawrap", + "bio.tool ids": [ + "metawrap" + ], + "biii": null, + "bio.tool name": "MetaWRAP", + "bio.tool description": "MetaWRAP aims to be an easy-to-use metagenomic wrapper suite that accomplishes the core tasks of metagenomic analysis from start to finish: read quality control, assembly, visualization, taxonomic profiling, extracting draft genomes (binning), and functional annotation.", + "EDAM operation": [ + "Read binning", + "Sequence assembly", + "Genome annotation", + "Sequence trimming", + "Demultiplexing" + ], + "EDAM topic": [ + "Whole genome sequencing", + "Metagenomic sequencing", + "Metagenomics" + ], + "Status": "Up-to-date", + "Source": "https://github.com/bxlab/metaWRAP", + "ToolShed categories": [ + "Metagenomics" + ], + "ToolShed id": "metawrapmg_binning", + "Galaxy wrapper owner": "galaxy-australia", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/metawrapmg", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/metawrapmg", + "Galaxy wrapper version": "1.3.0", + "Conda id": "metawrap-mg", + "Conda version": "1.3.0" + }, + { + "Galaxy wrapper id": "migmap", + "Galaxy tool ids": [ + "migmap" + ], + "Description": "mapper for full-length T- and B-cell repertoire sequencing", + "bio.tool id": "MiGMAP", + "bio.tool ids": [ + "MiGMAP" + ], + "biii": null, + "bio.tool name": "MiGMAP", + "bio.tool description": "Mapper for full-length T- and B-cell repertoire sequencing.", + "EDAM operation": [ + "Sequence analysis", + "Read mapping" + ], + "EDAM topic": [ + "Immunoproteins, genes and antigens", + "Sequence analysis" + ], + "Status": "Up-to-date", + "Source": "https://github.com/mikessh/migmap", + "ToolShed categories": [ + "RNA", + "Sequence Analysis" + ], + "ToolShed id": "migmap", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/migmap", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/migmap", + "Galaxy wrapper version": "1.0.3", + "Conda id": "migmap", + "Conda version": "1.0.3" + }, + { + "Galaxy wrapper id": "minia", + "Galaxy tool ids": [ + "minia" + ], + "Description": "Short-read assembler based on a de Bruijn graph", + "bio.tool id": "minia", + "bio.tool ids": [ + "minia" + ], + "biii": null, + "bio.tool name": "Minia", + "bio.tool description": "Short-read assembler based on a de Bruijn graph, capable of assembling a human genome on a desktop computer in a day.", + "EDAM operation": [ + "Genome assembly" + ], + "EDAM topic": [ + "Sequence assembly" + ], + "Status": "Up-to-date", + "Source": "https://gatb.inria.fr/software/minia/", + "ToolShed categories": [ + "Assembly" + ], + "ToolShed id": "minia", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/minia", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/minia", + "Galaxy wrapper version": "3.2.6", + "Conda id": "minia", + "Conda version": "3.2.6" + }, + { + "Galaxy wrapper id": "miniasm", + "Galaxy tool ids": [ + "miniasm" + ], + "Description": "Miniasm - Ultrafast de novo assembly for long noisy reads (though having no consensus step)", + "bio.tool id": "miniasm", + "bio.tool ids": [ + "miniasm" + ], + "biii": null, + "bio.tool name": "miniasm", + "bio.tool description": "Miniasm is a very fast OLC-based de novo assembler for noisy long reads. It takes all-vs-all read self-mappings (typically by minimap) as input and outputs an assembly graph in the GFA format.", + "EDAM operation": [ + "De-novo assembly" + ], + "EDAM topic": [ + "Genomics", + "Sequence assembly" + ], + "Status": "To update", + "Source": "https://github.com/lh3/miniasm", + "ToolShed categories": [ + "Assembly" + ], + "ToolShed id": "miniasm", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/miniasm", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/miniasm", + "Galaxy wrapper version": "0.3_r179", + "Conda id": "miniasm", + "Conda version": "0.3" + }, + { + "Galaxy wrapper id": "minimap2", + "Galaxy tool ids": [ + "minimap2" + ], + "Description": "A fast pairwise aligner for genomic and spliced nucleotide sequences", + "bio.tool id": "minimap2", + "bio.tool ids": [ + "minimap2" + ], + "biii": null, + "bio.tool name": "Minimap2", + "bio.tool description": "Pairwise aligner for genomic and spliced nucleotide sequences", + "EDAM operation": [ + "Pairwise sequence alignment" + ], + "EDAM topic": [ + "Mapping" + ], + "Status": "Up-to-date", + "Source": "https://github.com/lh3/minimap2", + "ToolShed categories": [ + "Next Gen Mappers" + ], + "ToolShed id": "minimap2", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/minimap2", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/minimap2", + "Galaxy wrapper version": "2.28", + "Conda id": "minimap2", + "Conda version": "2.28" + }, + { + "Galaxy wrapper id": "miniprot", + "Galaxy tool ids": [ + "miniprot", + "miniprot_index" + ], + "Description": "Align a protein sequence against a genome with affine gap penalty, splicing and frameshift.", + "bio.tool id": "miniprot", + "bio.tool ids": [ + "miniprot" + ], + "biii": null, + "bio.tool name": "miniprot", + "bio.tool description": "Miniprot aligns a protein sequence against a genome with affine gap penalty, splicing and frameshift. It is primarily intended for annotating protein-coding genes in a new species using known genes from other species.", + "EDAM operation": [ + "Sequence alignment", + "Protein sequence analysis" + ], + "EDAM topic": [ + "Sequence sites, features and motifs", + "Sequence analysis" + ], + "Status": "Up-to-date", + "Source": "https://github.com/lh3/miniprot", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": null, + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/miniprot", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/miniprot", + "Galaxy wrapper version": "0.13", + "Conda id": "miniprot", + "Conda version": "0.13" + }, + { + "Galaxy wrapper id": "mirmachine", + "Galaxy tool ids": [ + "mirmachine" + ], + "Description": "Tool to detect miRNA in genome sequences", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/sinanugur/MirMachine", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "mirmachine", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/mirmachine", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/mirmachine", + "Galaxy wrapper version": "0.2.13", + "Conda id": "mirmachine", + "Conda version": "0.2.13" + }, + { + "Galaxy wrapper id": "mirnature", + "Galaxy tool ids": [ + "mirnature" + ], + "Description": "Computational detection of canonical microRNAs", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/Bierinformatik/miRNAture", + "ToolShed categories": [ + "RNA", + "Sequence Analysis" + ], + "ToolShed id": "mirnature", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/Bierinformatik/miRNAture", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/mirnature", + "Galaxy wrapper version": "1.1", + "Conda id": "mirnature", + "Conda version": "1.1" + }, + { + "Galaxy wrapper id": "mitobim", + "Galaxy tool ids": [ + "mitobim" + ], + "Description": "assemble mitochondrial genomes", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/chrishah/MITObim", + "ToolShed categories": [ + "Assembly" + ], + "ToolShed id": "mitobim", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/mitobim", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/mitobim", + "Galaxy wrapper version": "1.9.1", + "Conda id": "mitobim", + "Conda version": "1.9.1" + }, + { + "Galaxy wrapper id": "mitos", + "Galaxy tool ids": [ + "mitos", + "mitos2" + ], + "Description": "de-novo annotation of metazoan mitochondrial genomes", + "bio.tool id": "mitos", + "bio.tool ids": [ + "mitos" + ], + "biii": null, + "bio.tool name": "MITOS", + "bio.tool description": "De novo metazoan mitochondrial genome annotation.", + "EDAM operation": [ + "Genome annotation" + ], + "EDAM topic": [ + "Zoology", + "Whole genome sequencing" + ], + "Status": "To update", + "Source": "http://mitos.bioinf.uni-leipzig.de/", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "mitos", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/mitos", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/mitos", + "Galaxy wrapper version": "1.1.7", + "Conda id": "mitos", + "Conda version": "2.1.9" + }, + { + "Galaxy wrapper id": "mlst", + "Galaxy tool ids": [ + "mlst", + "mlst_list" + ], + "Description": "Scan contig files against PubMLST typing schemes", + "bio.tool id": "mlst", + "bio.tool ids": [ + "mlst" + ], + "biii": null, + "bio.tool name": "MLST", + "bio.tool description": "Multi Locus Sequence Typing from an assembled genome or from a set of reads.", + "EDAM operation": [ + "Multilocus sequence typing" + ], + "EDAM topic": [ + "Immunoproteins and antigens" + ], + "Status": "To update", + "Source": "https://github.com/tseemann/mlst", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "mlst", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/mlst", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/mlst", + "Galaxy wrapper version": "2.22.0", + "Conda id": "mlst", + "Conda version": "2.23.0" + }, + { + "Galaxy wrapper id": "moabs", + "Galaxy tool ids": [ + "moabs" + ], + "Description": "MOABS for differential methylation analysis on Bisulfite sequencing data.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/sunnyisgalaxy/moabs", + "ToolShed categories": [ + "Epigenetics" + ], + "ToolShed id": "moabs", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/sunnyisgalaxy/moabs", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/moabs", + "Galaxy wrapper version": "1.3.4.6", + "Conda id": "moabs", + "Conda version": "1.3.9.0" + }, + { + "Galaxy wrapper id": "mosdepth", + "Galaxy tool ids": [ + "mosdepth" + ], + "Description": "fast and flexible BAM/CRAM depth calculation", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/brentp/mosdepth", + "ToolShed categories": [ + "SAM" + ], + "ToolShed id": "mosdepth", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/mosdepth", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/mosdepth", + "Galaxy wrapper version": "0.3.8", + "Conda id": "mosdepth", + "Conda version": "0.3.8" + }, + { + "Galaxy wrapper id": "mothur", + "Galaxy tool ids": [ + "mothur_align_check", + "mothur_align_seqs", + "mothur_amova", + "mothur_anosim", + "mothur_bin_seqs", + "mothur_biom_info", + "mothur_chimera_bellerophon", + "mothur_chimera_ccode", + "mothur_chimera_check", + "mothur_chimera_perseus", + "mothur_chimera_pintail", + "mothur_chimera_slayer", + "mothur_chimera_uchime", + "mothur_chimera_vsearch", + "mothur_chop_seqs", + "mothur_classify_otu", + "mothur_classify_seqs", + "mothur_classify_tree", + "mothur_clearcut", + "mothur_cluster_classic", + "mothur_cluster_fragments", + "mothur_cluster_split", + "mothur_cluster", + "mothur_collect_shared", + "mothur_collect_single", + "mothur_consensus_seqs", + "mothur_cooccurrence", + "mothur_corr_axes", + "mothur_count_groups", + "mothur_count_seqs", + "mothur_create_database", + "mothur_degap_seqs", + "mothur_deunique_seqs", + "mothur_deunique_tree", + "mothur_dist_seqs", + "mothur_dist_shared", + "mothur_fastq_info", + "mothur_filter_seqs", + "mothur_filter_shared", + "mothur_get_communitytype", + "mothur_get_coremicrobiome", + "mothur_get_dists", + "mothur_get_group", + "mothur_get_groups", + "mothur_get_label", + "mothur_get_lineage", + "mothur_get_mimarkspackage", + "mothur_get_otulabels", + "mothur_get_otulist", + "mothur_get_oturep", + "mothur_get_otus", + "mothur_get_rabund", + "mothur_get_relabund", + "mothur_get_sabund", + "mothur_get_seqs", + "mothur_get_sharedseqs", + "mothur_heatmap_bin", + "mothur_heatmap_sim", + "mothur_homova", + "mothur_indicator", + "mothur_lefse", + "mothur_libshuff", + "mothur_list_otulabels", + "mothur_list_seqs", + "mothur_make_biom", + "mothur_make_contigs", + "mothur_make_design", + "mothur_make_fastq", + "mothur_make_group", + "mothur_make_lefse", + "mothur_make_lookup", + "mothur_make_shared", + "mothur_make_sra", + "mothur_mantel", + "mothur_merge_count", + "mothur_merge_files", + "mothur_merge_groups", + "mothur_merge_sfffiles", + "mothur_merge_taxsummary", + "mothur_metastats", + "mothur_mimarks_attributes", + "mothur_nmds", + "mothur_normalize_shared", + "mothur_otu_association", + "mothur_otu_hierarchy", + "mothur_pairwise_seqs", + "mothur_parse_list", + "mothur_parsimony", + "mothur_pca", + "mothur_pcoa", + "mothur_pcr_seqs", + "mothur_phylo_diversity", + "mothur_phylotype", + "mothur_pre_cluster", + "mothur_primer_design", + "mothur_rarefaction_shared", + "mothur_rarefaction_single", + "mothur_remove_dists", + "mothur_remove_groups", + "mothur_remove_lineage", + "mothur_remove_otulabels", + "mothur_remove_otus", + "mothur_remove_rare", + "mothur_remove_seqs", + "mothur_rename_seqs", + "mothur_reverse_seqs", + "mothur_screen_seqs", + "mothur_sens_spec", + "mothur_seq_error", + "mothur_sffinfo", + "mothur_shhh_flows", + "mothur_shhh_seqs", + "mothur_sort_seqs", + "mothur_split_abund", + "mothur_split_groups", + "mothur_sub_sample", + "mothur_summary_qual", + "mothur_summary_seqs", + "mothur_summary_shared", + "mothur_summary_single", + "mothur_summary_tax", + "mothur_taxonomy_to_krona", + "mothur_tree_shared", + "mothur_trim_flows", + "mothur_trim_seqs", + "mothur_unifrac_unweighted", + "mothur_unifrac_weighted", + "mothur_unique_seqs", + "mothur_venn" + ], + "Description": "Mothur wrappers", + "bio.tool id": "mothur", + "bio.tool ids": [ + "mothur" + ], + "biii": null, + "bio.tool name": "mothur", + "bio.tool description": "Open-source, platform-independent, community-supported software for describing and comparing microbial communities", + "EDAM operation": [ + "DNA barcoding", + "Sequencing quality control", + "Sequence clustering", + "Taxonomic classification", + "Visualisation", + "Sequence read processing", + "Phylogenetic analysis" + ], + "EDAM topic": [ + "Microbial ecology", + "Taxonomy", + "Sequence analysis", + "Phylogeny" + ], + "Status": "To update", + "Source": "https://www.mothur.org", + "ToolShed categories": [ + "Metagenomics" + ], + "ToolShed id": "mothur", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/mothur", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/mothur", + "Galaxy wrapper version": "1.0", + "Conda id": "mothur", + "Conda version": "1.48.0" + }, + { + "Galaxy wrapper id": "msaboot", + "Galaxy tool ids": [ + "msaboot" + ], + "Description": "A multiple sequences alignment bootstrapping tool.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/phac-nml/msaboot", + "ToolShed categories": [ + "Fasta Manipulation" + ], + "ToolShed id": "msaboot", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/msaboot", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/msaboot", + "Galaxy wrapper version": "0.1.2", + "Conda id": "msaboot", + "Conda version": "0.1.2" + }, + { + "Galaxy wrapper id": "multigps", + "Galaxy tool ids": [ + "multigps" + ], + "Description": "Analyzes collections of multi-condition ChIP-seq data.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "http://mahonylab.org/software/multigps/", + "ToolShed categories": [ + "ChIP-seq" + ], + "ToolShed id": "multigps", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": null, + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/multigps", + "Galaxy wrapper version": "0.74.0", + "Conda id": "fonts-conda-ecosystem", + "Conda version": null + }, + { + "Galaxy wrapper id": "multigsea", + "Galaxy tool ids": [ + "multigsea" + ], + "Description": "GSEA-based pathway enrichment analysis for multi-omics data", + "bio.tool id": "multiGSEA", + "bio.tool ids": [ + "multiGSEA" + ], + "biii": null, + "bio.tool name": "multiGSEA", + "bio.tool description": "A GSEA-based pathway enrichment analysis for multi-omics data.multiGSEA: a GSEA-based pathway enrichment analysis for multi-omics data, BMC Bioinformatics 21, 561 (2020).Combining GSEA-based pathway enrichment with multi omics data integration.", + "EDAM operation": [ + "Gene-set enrichment analysis", + "Aggregation", + "Pathway analysis" + ], + "EDAM topic": [ + "Metabolomics", + "Molecular interactions, pathways and networks", + "Proteomics", + "Transcriptomics", + "Small molecules" + ], + "Status": "Up-to-date", + "Source": "https://bioconductor.org/packages/devel/bioc/html/multiGSEA.html", + "ToolShed categories": [ + "Transcriptomics", + "Proteomics", + "Statistics" + ], + "ToolShed id": "multigsea", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/multigsea", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/multigsea", + "Galaxy wrapper version": "1.12.0", + "Conda id": "bioconductor-multigsea", + "Conda version": "1.12.0" + }, + { + "Galaxy wrapper id": "multiqc", + "Galaxy tool ids": [ + "multiqc" + ], + "Description": "MultiQC aggregates results from bioinformatics analyses across many samples into a single report", + "bio.tool id": "multiqc", + "bio.tool ids": [ + "multiqc" + ], + "biii": null, + "bio.tool name": "MultiQC", + "bio.tool description": "MultiQC aggregates results from multiple bioinformatics analyses across many samples into a single report. It searches a given directory for analysis logs and compiles a HTML report. It's a general use tool, perfect for summarising the output from numerous bioinformatics tools.", + "EDAM operation": [ + "Validation", + "Sequencing quality control" + ], + "EDAM topic": [ + "Sequencing", + "Bioinformatics", + "Sequence analysis", + "Genomics" + ], + "Status": "To update", + "Source": "http://multiqc.info/", + "ToolShed categories": [ + "Fastq Manipulation", + "Statistics", + "Visualization" + ], + "ToolShed id": "multiqc", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/multiqc", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/multiqc", + "Galaxy wrapper version": "1.11", + "Conda id": "multiqc", + "Conda version": "1.22.2" + }, + { + "Galaxy wrapper id": "mummer4", + "Galaxy tool ids": [ + "mummer_delta_filter", + "mummer_dnadiff", + "mummer_mummer", + "mummer_mummerplot", + "mummer_nucmer", + "mummer_show_coords" + ], + "Description": "Mummer4 Tools", + "bio.tool id": "mummer4", + "bio.tool ids": [ + "mummer4" + ], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/mummer4/mummer", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "mummer4", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/mummer4", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/mummer4", + "Galaxy wrapper version": "4.0.0rc1", + "Conda id": "mummer4", + "Conda version": "4.0.0rc1" + }, + { + "Galaxy wrapper id": "mykrobe", + "Galaxy tool ids": [ + "mykrobe_predict" + ], + "Description": "Antibiotic resistance predictions", + "bio.tool id": "Mykrobe", + "bio.tool ids": [ + "Mykrobe" + ], + "biii": null, + "bio.tool name": "Mykrobe", + "bio.tool description": "Antibiotic resistance prediction for Mycobacterium tuberculosis from genome sequence data with Mykrobe.Antibiotic resistance prediction in minutes.Table of Contents generated with DocToc.AMR prediction (Mykrobe predictor).Before attempting to install with bioconda, please ensure you have your channels set up as specified in the documentation. If you don't, you may run into issues with an older version of mykrobe being installed", + "EDAM operation": [ + "Antimicrobial resistance prediction", + "Variant calling", + "Genotyping", + "Sequence trimming" + ], + "EDAM topic": [ + "Whole genome sequencing", + "Genotype and phenotype", + "Probes and primers", + "Genetic variation", + "Metagenomics" + ], + "Status": "To update", + "Source": "https://github.com/Mykrobe-tools/mykrobe", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "mykrobe", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/mykrobe", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/mykrobe", + "Galaxy wrapper version": "0.10.0", + "Conda id": "mykrobe", + "Conda version": "0.13.0" + }, + { + "Galaxy wrapper id": "mzmine", + "Galaxy tool ids": [ + "mzmine_batch" + ], + "Description": "mass-spectrometry data processing, with the main focus on LC-MS data", + "bio.tool id": "mzmine", + "bio.tool ids": [ + "mzmine" + ], + "biii": null, + "bio.tool name": "MZmine", + "bio.tool description": "Toolbox for visualization and analysis of LC-MS data in netCDF or mzXML.", + "EDAM operation": [ + "Natural product identification", + "Standardisation and normalisation", + "Peptide database search", + "Deisotoping", + "Clustering", + "Filtering", + "Chromatographic alignment", + "Peak detection", + "Peptide identification", + "Chromatogram visualisation", + "Mass spectrum visualisation", + "Structure visualisation", + "Plotting", + "Heat map generation" + ], + "EDAM topic": [ + "Proteomics", + "Metabolomics", + "Proteomics experiment", + "Small molecules" + ], + "Status": "Up-to-date", + "Source": "http://mzmine.github.io/", + "ToolShed categories": [ + "Metabolomics" + ], + "ToolShed id": "mzmine_batch", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/workflow4metabolomics/tools-metabolomics/blob/master/tools/mzmine/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/mzmine", + "Galaxy wrapper version": "3.9.0", + "Conda id": "mzmine", + "Conda version": "3.9.0" + }, + { + "Galaxy wrapper id": "naltorfs", + "Galaxy tool ids": [ + "bicodon_counts_from_fasta", + "codon_freq_from_bicodons", + "find_nested_alt_orfs" + ], + "Description": "nAlt-ORFs: Nested Alternate Open Reading Frames (nAltORFs)", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/BlankenbergLab/nAltORFs", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": null, + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/naltorfs/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/naltorfs", + "Galaxy wrapper version": "0.1.2", + "Conda id": "naltorfs", + "Conda version": "0.1.2" + }, + { + "Galaxy wrapper id": "nanocompore", + "Galaxy tool ids": [ + "nanocompore_db", + "nanocompore_sampcomp" + ], + "Description": "Nanocompore compares 2 ONT nanopore direct RNA sequencing datasets from different experimental conditions expected to have a significant impact on RNA modifications. It is recommended to have at least 2 replicates per condition. For example one can use a control condition with a significantly reduced number of modifications such as a cell line for which a modification writing enzyme was knocked-down or knocked-out. Alternatively, on a smaller scale transcripts of interests could be synthesized in-vitro.", + "bio.tool id": "Nanocompore", + "bio.tool ids": [ + "Nanocompore" + ], + "biii": null, + "bio.tool name": "Nanocompore", + "bio.tool description": "RNA modifications detection by comparative Nanopore direct RNA sequencing.RNA modifications detection from Nanopore dRNA-Seq data.Nanocompore identifies differences in ONT nanopore sequencing raw signal corresponding to RNA modifications by comparing 2 samples.Analyses performed for the nanocompore paper.Nanocompore compares 2 ONT nanopore direct RNA sequencing datasets from different experimental conditions expected to have a significant impact on RNA modifications. It is recommended to have at least 2 replicates per condition. For example one can use a control condition with a significantly reduced number of modifications such as a cell line for which a modification writing enzyme was knocked-down or knocked-out. Alternatively, on a smaller scale transcripts of interests could be synthesized in-vitro", + "EDAM operation": [ + "Post-translation modification site prediction", + "PolyA signal detection", + "Genotyping", + "k-mer counting" + ], + "EDAM topic": [ + "Functional, regulatory and non-coding RNA", + "RNA-Seq", + "Gene transcripts", + "Transcriptomics", + "Transcription factors and regulatory sites" + ], + "Status": "To update", + "Source": "https://nanocompore.rna.rocks/", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "nanocompore", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/nanocompore", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/nanocompore", + "Galaxy wrapper version": "1.0.0rc3.post2", + "Conda id": "nanocompore", + "Conda version": "1.0.4" + }, + { + "Galaxy wrapper id": "nanoplot", + "Galaxy tool ids": [ + "nanoplot" + ], + "Description": "Plotting tool for long read sequencing data and alignments", + "bio.tool id": "nanoplot", + "bio.tool ids": [ + "nanoplot" + ], + "biii": null, + "bio.tool name": "NanoPlot", + "bio.tool description": "NanoPlot is a tool with various visualizations of sequencing data in bam, cram, fastq, fasta or platform-specific TSV summaries, mainly intended for long-read sequencing from Oxford Nanopore Technologies and Pacific Biosciences", + "EDAM operation": [ + "Scatter plot plotting", + "Box-Whisker plot plotting" + ], + "EDAM topic": [ + "Genomics" + ], + "Status": "Up-to-date", + "Source": "https://github.com/wdecoster/NanoPlot", + "ToolShed categories": [ + "Visualization" + ], + "ToolShed id": "nanoplot", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/nanoplot/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/nanoplot", + "Galaxy wrapper version": "1.42.0", + "Conda id": "nanoplot", + "Conda version": "1.42.0" + }, + { + "Galaxy wrapper id": "nanopolishcomp", + "Galaxy tool ids": [ + "nanopolishcomp_eventaligncollapse", + "nanopolishcomp_freqmethcalculate" + ], + "Description": "NanopolishComp contains 2 modules. Eventalign_collapse collapses the raw file generated by nanopolish eventalign by kmers rather than by event. Freq_meth_calculate methylation frequency at genomic CpG sites from the output of nanopolish call-methylation.", + "bio.tool id": "nanopolishcomp", + "bio.tool ids": [ + "nanopolishcomp" + ], + "biii": null, + "bio.tool name": "NanopolishComp", + "bio.tool description": "NanopolishComp is a Python3 package for downstream analyses of Nanopolish output files.It is a companion package for Nanopolish.", + "EDAM operation": [ + "Methylation analysis", + "Collapsing methods" + ], + "EDAM topic": [ + "Sequence analysis", + "Sequencing", + "Genetic variation" + ], + "Status": "To update", + "Source": "https://a-slide.github.io/NanopolishComp", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "nanopolishcomp", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/nanopolishcomp", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/nanopolishcomp", + "Galaxy wrapper version": "0.6.11", + "Conda id": "nanopolishcomp", + "Conda version": "0.6.12" + }, + { + "Galaxy wrapper id": "ncbi_acc_download", + "Galaxy tool ids": [ + "ncbi_acc_download" + ], + "Description": "Download sequences from GenBank/RefSeq by accession through the NCBI ENTREZ API", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/kblin/ncbi-acc-download", + "ToolShed categories": [ + "Data Source" + ], + "ToolShed id": "ncbi_acc_download", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/ncbi_acc_download", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/ncbi_acc_download", + "Galaxy wrapper version": "0.2.8", + "Conda id": "ncbi-acc-download", + "Conda version": "0.2.8" + }, + { + "Galaxy wrapper id": "ncbi_datasets", + "Galaxy tool ids": [ + "datasets_download_gene", + "datasets_download_genome" + ], + "Description": "NCBI datasets downloads biological sequence data across all domains of life from NCBI.", + "bio.tool id": "ncbi_datasets", + "bio.tool ids": [ + "ncbi_datasets" + ], + "biii": null, + "bio.tool name": "NCBI Datasets", + "bio.tool description": "NCBI Datasets is a new resource that lets you easily gather data from across NCBI databases. Find and download sequence, annotation, and metadata for genes and genomes using our command-line tools or web interface.", + "EDAM operation": [ + "Data handling", + "Sequence database search", + "Data retrieval" + ], + "EDAM topic": [ + "Biological databases" + ], + "Status": "To update", + "Source": "https://github.com/ncbi/datasets", + "ToolShed categories": [ + "Data Source" + ], + "ToolShed id": "ncbi_datasets", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/ncbi_datasets", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/ncbi_datasets", + "Galaxy wrapper version": "16.6.0", + "Conda id": "ncbi-datasets-cli", + "Conda version": null + }, + { + "Galaxy wrapper id": "ncbi_entrez_direct", + "Galaxy tool ids": [ + "ncbi_entrez_direct_efetch", + "ncbi_entrez_direct_einfo", + "ncbi_entrez_direct_esearch" + ], + "Description": "NCBI Entrez Direct allow fetching data from NCBI Databases", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "http://www.ncbi.nlm.nih.gov/books/NBK179288/", + "ToolShed categories": [ + "Data Source" + ], + "ToolShed id": "ncbi_entrez_direct", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/ncbi_entrez_direct", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/ncbi_entrez_direct", + "Galaxy wrapper version": "21.6", + "Conda id": "entrez-direct", + "Conda version": "21.6" + }, + { + "Galaxy wrapper id": "ncbi_entrez_eutils", + "Galaxy tool ids": [ + "ncbi_eutils_ecitmatch", + "ncbi_eutils_efetch", + "ncbi_eutils_egquery", + "ncbi_eutils_einfo", + "ncbi_eutils_elink", + "ncbi_eutils_epost", + "ncbi_eutils_esearch", + "ncbi_eutils_esummary" + ], + "Description": "NCBI Entrez E-Utilties allow fetching data from NCBI Databases", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://www.ncbi.nlm.nih.gov/books/NBK25501/", + "ToolShed categories": [ + "Data Source" + ], + "ToolShed id": "ncbi_entrez_eutils", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/ncbi_entrez_eutils", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/ncbi_entrez_eutils", + "Galaxy wrapper version": "1.70", + "Conda id": "python", + "Conda version": null + }, + { + "Galaxy wrapper id": "ncbi_fcs_gx", + "Galaxy tool ids": [ + "ncbi_fcs_gx" + ], + "Description": "FCS-GX detects contamination from foreign organisms in genome sequences using the genome cross-species aligner (GX).", + "bio.tool id": "ncbi_fcs", + "bio.tool ids": [ + "ncbi_fcs" + ], + "biii": null, + "bio.tool name": "NCBI fcs", + "bio.tool description": "The NCBI Foreign Contamination Screen (FCS) is a tool suite for identifying and removing contaminant sequences in genome assemblies. Contaminants are defined as sequences in a dataset that do not originate from the biological source organism and can arise from a variety of environmental and laboratory sources. FCS will help you remove contaminants from genomes before submission to GenBank.", + "EDAM operation": [ + "Sequence assembly validation", + "Sequence trimming", + "Sequence contamination filtering" + ], + "EDAM topic": [ + "Sequence analysis", + "Sequence assembly" + ], + "Status": "Up-to-date", + "Source": "https://github.com/ncbi/fcs-gx", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "ncbi_fcs_gx", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/ncbi_fcs_gx", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/ncbi_fcs_gx", + "Galaxy wrapper version": "0.5.0", + "Conda id": "ncbi-fcs-gx", + "Conda version": "0.5.0" + }, + { + "Galaxy wrapper id": "necat", + "Galaxy tool ids": [ + "necat" + ], + "Description": "Error correction and de-novo assembly for ONT Nanopore reads", + "bio.tool id": "necat", + "bio.tool ids": [ + "necat" + ], + "biii": null, + "bio.tool name": "NECAT", + "bio.tool description": "NECAT is an error correction and de-novo assembly tool for Nanopore long noisy reads.", + "EDAM operation": [ + "De-novo assembly" + ], + "EDAM topic": [ + "Sequence assembly" + ], + "Status": "Up-to-date", + "Source": "https://github.com/xiaochuanle/NECAT", + "ToolShed categories": [ + "Assembly" + ], + "ToolShed id": "necat", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/necat", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/necat", + "Galaxy wrapper version": "0.0.1_update20200803", + "Conda id": "necat", + "Conda version": "0.0.1_update20200803" + }, + { + "Galaxy wrapper id": "newick_utils", + "Galaxy tool ids": [ + "newick_display" + ], + "Description": "Perform operations on Newick trees", + "bio.tool id": "newick_utilities", + "bio.tool ids": [ + "newick_utilities" + ], + "biii": null, + "bio.tool name": "Newick Utilities", + "bio.tool description": "The Newick Utilities are a set of command-line tools for processing phylogenetic trees. They can process arbitrarily large amounts of data and do not require user interaction, which makes them suitable for automating phylogeny processing tasks.", + "EDAM operation": [ + "Phylogenetic tree generation", + "Phylogenetic tree analysis", + "Phylogenetic tree reconstruction" + ], + "EDAM topic": [ + "Phylogeny", + "Genomics", + "Computer science" + ], + "Status": "To update", + "Source": "http://cegg.unige.ch/newick_utils", + "ToolShed categories": [ + "Visualization", + "Metagenomics" + ], + "ToolShed id": "newick_utils", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/tjunier/newick_utils", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/newick_utils", + "Galaxy wrapper version": "1.6+galaxy1", + "Conda id": "newick_utils", + "Conda version": "1.6" + }, + { + "Galaxy wrapper id": "nextclade", + "Galaxy tool ids": [ + "nextalign", + "nextclade" + ], + "Description": "Identify differences between your sequences and a reference sequence used by Nextstrain", + "bio.tool id": "nextclade", + "bio.tool ids": [ + "nextclade" + ], + "biii": null, + "bio.tool name": "Nextclade", + "bio.tool description": "Nextclade is an open-source project for viral genome alignment, mutation calling, clade assignment, quality checks and phylogenetic placement.", + "EDAM operation": [ + "Methylation analysis", + "Variant calling" + ], + "EDAM topic": [ + "Genomics", + "Sequence analysis", + "Cladistics" + ], + "Status": "To update", + "Source": "https://github.com/nextstrain/nextclade", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": null, + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/nextclade", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/nextclade", + "Galaxy wrapper version": "2.7.0", + "Conda id": "nextalign", + "Conda version": "2.14.0" + }, + { + "Galaxy wrapper id": "ngmlr", + "Galaxy tool ids": [ + "ngmlr" + ], + "Description": "CoNvex Gap-cost alignMents for Long Reads", + "bio.tool id": "ngmlr", + "bio.tool ids": [ + "ngmlr" + ], + "biii": null, + "bio.tool name": "NGMLR", + "bio.tool description": "An algorithm to map third generation long-read sequencing data (PacBio and Oxford Nanopore) to a reference genome with a focus on reads that span structural variation.", + "EDAM operation": [ + "DNA mapping", + "Sequence alignment", + "Genetic variation analysis" + ], + "EDAM topic": [ + "Sequencing", + "Mapping", + "DNA structural variation" + ], + "Status": "Up-to-date", + "Source": "https://github.com/philres/ngmlr", + "ToolShed categories": [ + "Next Gen Mappers" + ], + "ToolShed id": "ngmlr", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/ngmlr", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/ngmlr", + "Galaxy wrapper version": "0.2.7", + "Conda id": "ngmlr", + "Conda version": "0.2.7" + }, + { + "Galaxy wrapper id": "ngsutils", + "Galaxy tool ids": [ + "ngsutils_bam_filter" + ], + "Description": "NGSUtils is a suite of software tools for working with next-generation sequencing datasets.Starting in 2009, we (Liu Lab @ Indiana University School of Medicine) starting working withnext-generation sequencing data. We initially started doing custom coding for each project in a one-off manner.It quickly became apparent that this was an inefficient manner to work, so we started assembling smallerutilities that could be adapted into larger, more complicated, workflows. We have used them for Illumia,SOLiD, 454, Ion Torrent, and Pac Bio sequencing data. We have used them for DNA and RNA resequcing,ChIP-Seq, CLIP-Seq, and targeted resequencing (Agilent exome capture and PCR targeting).These tools are also used heavily in our in-house DNA and RNA mapping pipelines.NGSUtils is made up of 50+ programs, mainly written in Python.These are separated into modules based on the type of file that is to be analyzed.", + "bio.tool id": "ngsutils", + "bio.tool ids": [ + "ngsutils" + ], + "biii": null, + "bio.tool name": "NGSUtils", + "bio.tool description": "NGSUtils is a suite of software tools for working with next-generation sequencing datasets", + "EDAM operation": [ + "Read pre-processing", + "Sequencing quality control", + "Variant calling", + "Formatting", + "Sequence contamination filtering" + ], + "EDAM topic": [ + "Genomics", + "Transcriptomics" + ], + "Status": "To update", + "Source": "https://github.com/ngsutils/ngsutils", + "ToolShed categories": [ + "SAM" + ], + "ToolShed id": null, + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/ngsutils", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/ngsutils", + "Galaxy wrapper version": null, + "Conda id": "ngsutils", + "Conda version": "0.5.9" + }, + { + "Galaxy wrapper id": "nonpareil", + "Galaxy tool ids": [ + "nonpareil" + ], + "Description": "Estimate average coverage in metagenomic datasets", + "bio.tool id": "nonpareil", + "bio.tool ids": [ + "nonpareil" + ], + "biii": null, + "bio.tool name": "nonpareil", + "bio.tool description": "Estimate metagenomic coverage and sequence diversity", + "EDAM operation": [ + "Operation" + ], + "EDAM topic": [], + "Status": "To update", + "Source": "http://nonpareil.readthedocs.io", + "ToolShed categories": [ + "Metagenomics" + ], + "ToolShed id": "nonpareil", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/nonpareil", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/nonpareil", + "Galaxy wrapper version": "3.1.1", + "Conda id": "nonpareil", + "Conda version": "3.4.1" + }, + { + "Galaxy wrapper id": "novoplasty", + "Galaxy tool ids": [ + "novoplasty" + ], + "Description": "NOVOPlasty is a de novo assembler and heteroplasmy/variance caller for short circular genomes.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/ndierckx/NOVOPlasty", + "ToolShed categories": [ + "Assembly" + ], + "ToolShed id": "novoplasty", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/novoplasty", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/novoplasty", + "Galaxy wrapper version": "4.3.1", + "Conda id": "novoplasty", + "Conda version": "4.3.5" + }, + { + "Galaxy wrapper id": "nugen_nudup", + "Galaxy tool ids": [ + "nugen_nudup" + ], + "Description": "Marks/removes PCR introduced duplicate molecules based on the molecular tagging technology used in NuGEN products.", + "bio.tool id": "nudup", + "bio.tool ids": [ + "nudup" + ], + "biii": null, + "bio.tool name": "NuDup", + "bio.tool description": "Marks/removes duplicate molecules based on the molecular tagging technology used in Tecan products.", + "EDAM operation": [ + "Duplication detection" + ], + "EDAM topic": [ + "Sequencing" + ], + "Status": "Up-to-date", + "Source": "https://github.com/tecangenomics/nudup", + "ToolShed categories": [ + "SAM", + "Metagenomics", + "Sequence Analysis", + "Transcriptomics" + ], + "ToolShed id": "nugen_nudup", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/nugen_nudup", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/nugen_nudup", + "Galaxy wrapper version": "2.3.3", + "Conda id": "nudup", + "Conda version": "2.3.3" + }, + { + "Galaxy wrapper id": "obitools", + "Galaxy tool ids": [ + "obi_illumina_pairend", + "obi_ngsfilter", + "obi_annotate", + "obi_clean", + "obi_convert", + "obi_grep", + "obi_sort", + "obi_stat", + "obi_tab", + "obi_uniq" + ], + "Description": "OBITools is a set of programs developed to simplify the manipulation of sequence files", + "bio.tool id": "obitools", + "bio.tool ids": [ + "obitools" + ], + "biii": null, + "bio.tool name": "OBITools", + "bio.tool description": "Set of python programs developed to simplify the manipulation of sequence files. They were mainly designed to help us for analyzing Next Generation Sequencer outputs (454 or Illumina) in the context of DNA Metabarcoding.", + "EDAM operation": [ + "Sequence analysis", + "Sequence analysis" + ], + "EDAM topic": [ + "Sequence analysis", + "DNA", + "Sequencing" + ], + "Status": "Up-to-date", + "Source": "http://metabarcoding.org/obitools", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "obitools", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/obitools", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/obitools", + "Galaxy wrapper version": "1.2.13", + "Conda id": "obitools", + "Conda version": "1.2.13" + }, + { + "Galaxy wrapper id": "ococo", + "Galaxy tool ids": [ + "ococo" + ], + "Description": "Variant detection of SNVs", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/karel-brinda/ococo", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "ococo", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/ococo", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/ococo", + "Galaxy wrapper version": "0.1.2.6", + "Conda id": "ococo", + "Conda version": "0.1.2.6" + }, + { + "Galaxy wrapper id": "odgi", + "Galaxy tool ids": [ + "odgi_build", + "odgi_viz" + ], + "Description": "Representing large genomic variation graphs with minimal memory overhead requires a careful encoding of the graph entities. odgi follows the dynamic GBWT in developing a byte-packed version of the graph and paths through it.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/vgteam/odgi", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": null, + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/odgi/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/odgi", + "Galaxy wrapper version": "0.3", + "Conda id": "odgi", + "Conda version": "0.8.6" + }, + { + "Galaxy wrapper id": "omark", + "Galaxy tool ids": [ + "omark" + ], + "Description": "Proteome quality assessment software", + "bio.tool id": "omark", + "bio.tool ids": [ + "omark" + ], + "biii": null, + "bio.tool name": "OMArk", + "bio.tool description": "Proteome quality assessment software", + "EDAM operation": [ + "Sequence assembly validation", + "Differential protein expression profiling" + ], + "EDAM topic": [ + "Proteomics", + "Sequence analysis", + "Statistics and probability" + ], + "Status": "To update", + "Source": "https://github.com/DessimozLab/OMArk", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "omark", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/omark/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/omark", + "Galaxy wrapper version": "0.3.0", + "Conda id": null, + "Conda version": null + }, + { + "Galaxy wrapper id": "ont_fast5_api", + "Galaxy tool ids": [ + "ont_fast5_api_compress_fast5", + "ont_fast5_api_fast5_subset", + "ont_fast5_api_multi_to_single_fast5", + "ont_fast5_api_single_to_multi_fast5" + ], + "Description": "ont_fast5_api is a simple interface to HDF5 files of the Oxford Nanopore FAST5 file format.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/nanoporetech/ont_fast5_api/", + "ToolShed categories": [ + "Nanopore" + ], + "ToolShed id": "ont_fast5_api", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/ont_fast5_api", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/ont_fast5_api", + "Galaxy wrapper version": "3.1.3", + "Conda id": "ont-fast5-api", + "Conda version": "4.1.3" + }, + { + "Galaxy wrapper id": "onto_toolkit", + "Galaxy tool ids": [ + "onto_tk_get_ancestor_terms", + "onto_tk_get_child_terms", + "onto_tk_get_descendent_terms", + "onto_tk_get_parent_terms", + "onto_tk_get_parent_terms_by_relationship_type", + "onto_tk_get_relationship_id_vs_relationship_def", + "onto_tk_get_relationship_id_vs_relationship_name", + "onto_tk_get_relationship_id_vs_relationship_namespace", + "onto_tk_get_relationship_types", + "onto_tk_get_root_terms", + "onto_tk_get_subontology_from", + "onto_tk_term_id_vs_term_def", + "onto_tk_term_id_vs_term_name", + "onto_tk_get_term_synonyms", + "onto_tk_get_terms", + "onto_tk_get_terms_by_relationship_type", + "onto_tk_obo2owl", + "onto_tk_obo2rdf", + "onto_tk_term_id_vs_term_def" + ], + "Description": "ONTO-Toolkit is a collection of tools for managing ontologies.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "http://search.cpan.org/~easr/ONTO-PERL-1.45/", + "ToolShed categories": [ + "Ontology Manipulation" + ], + "ToolShed id": "onto_toolkit", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/onto-toolkit", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/onto_toolkit", + "Galaxy wrapper version": "1.45", + "Conda id": "perl-onto-perl", + "Conda version": "1.45" + }, + { + "Galaxy wrapper id": "optdoe", + "Galaxy tool ids": [ + "optdoe" + ], + "Description": "Optimal Design Of Experiment", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/pablocarb/doebase", + "ToolShed categories": [ + "Synthetic Biology" + ], + "ToolShed id": "optdoe", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/optdoe", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/optdoe", + "Galaxy wrapper version": "v2.0.2", + "Conda id": "doebase", + "Conda version": null + }, + { + "Galaxy wrapper id": "optitype", + "Galaxy tool ids": [ + "optitype" + ], + "Description": "Precision HLA typing from NGS data", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/FRED-2/OptiType", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "optitype", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/optitype1", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/optitype", + "Galaxy wrapper version": "1.3.5", + "Conda id": "optitype", + "Conda version": "1.3.5" + }, + { + "Galaxy wrapper id": "orfipy", + "Galaxy tool ids": [ + "orfipy" + ], + "Description": "Galaxy wrapper for ORFIPY", + "bio.tool id": "orfipy", + "bio.tool ids": [ + "orfipy" + ], + "biii": null, + "bio.tool name": "orfipy", + "bio.tool description": "A fast and flexible tool for extracting ORFs.orfipy is a tool written in python/cython to extract ORFs in extremely an fast and flexible manner. Other popular ORF searching tools are OrfM and getorf. Compared to OrfM and getorf, orfipy provides the most options to fine tune ORF searches. orfipy uses multiple CPU cores and is particularly faster for data containing multiple smaller fasta sequences such as de-novo transcriptome assemblies. Please read the preprint here.", + "EDAM operation": [ + "Coding region prediction", + "Database search", + "Transcriptome assembly", + "De-novo assembly" + ], + "EDAM topic": [ + "Computer science", + "RNA-Seq", + "Transcriptomics", + "Small molecules" + ], + "Status": "Up-to-date", + "Source": "https://github.com/urmi-21/orfipy", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "orfipy", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/orfipy", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/orfipy", + "Galaxy wrapper version": "0.0.4", + "Conda id": "orfipy", + "Conda version": "0.0.4" + }, + { + "Galaxy wrapper id": "orthofinder", + "Galaxy tool ids": [ + "orthofinder_onlygroups" + ], + "Description": "Accurate inference of orthologous gene groups made easy", + "bio.tool id": "OrthoFinder", + "bio.tool ids": [ + "OrthoFinder" + ], + "biii": null, + "bio.tool name": "OrthoFinder", + "bio.tool description": "OrthoFinder is a fast, accurate and comprehensive platform for comparative genomics. It finds orthogroups and orthologs, infers rooted gene trees for all orthogroups and identifies all of the gene duplcation events in those gene trees. It also infers a rooted species tree for the species being analysed and maps the gene duplication events from the gene trees to branches in the species tree. OrthoFinder also provides comprehensive statistics for comparative genomic analyses.", + "EDAM operation": [ + "Genome comparison", + "Phylogenetic tree generation (from molecular sequences)", + "Phylogenetic tree analysis", + "Genome alignment" + ], + "EDAM topic": [ + "Phylogenetics", + "Phylogenomics", + "Bioinformatics", + "Comparative genomics", + "Sequence analysis" + ], + "Status": "Up-to-date", + "Source": "https://github.com/davidemms/OrthoFinder", + "ToolShed categories": [ + "Phylogenetics", + "Sequence Analysis" + ], + "ToolShed id": "orthofinder", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/orthofinder", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/orthofinder", + "Galaxy wrapper version": "2.5.5", + "Conda id": "orthofinder", + "Conda version": "2.5.5" + }, + { + "Galaxy wrapper id": "packaged_annotation_loader", + "Galaxy tool ids": [ + "packaged_annotation_loader" + ], + "Description": "Tool to make cached genome annotation data available as a list of datasets collection", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": null, + "ToolShed categories": [ + "Data Source" + ], + "ToolShed id": "packaged_annotation_loader", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/packaged_annotation_loader", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/packaged_annotation_loader", + "Galaxy wrapper version": "0.1", + "Conda id": "python", + "Conda version": null + }, + { + "Galaxy wrapper id": "pairtools", + "Galaxy tool ids": [ + "pairtools_dedup", + "pairtools_parse", + "pairtools_sort", + "pairtools_split", + "pairtools_stats" + ], + "Description": "Flexible tools for Hi-C data processing", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://pairtools.readthedocs.io", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "pairtools", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/open2c/pairtools", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/pairtools", + "Galaxy wrapper version": "1.1.0", + "Conda id": "pairtools", + "Conda version": "1.1.0" + }, + { + "Galaxy wrapper id": "pangolin", + "Galaxy tool ids": [ + "pangolin" + ], + "Description": "Pangolin assigns SARS-CoV-2 genome sequences their most likely lineages under the Pango nomenclature system.", + "bio.tool id": "pangolin_cov-lineages", + "bio.tool ids": [ + "pangolin_cov-lineages" + ], + "biii": null, + "bio.tool name": "pangolin", + "bio.tool description": "Phylogenetic Assignment of Named Global Outbreak LINeages - software package for assigning SARS-CoV-2 genome sequences to global lineages", + "EDAM operation": [ + "Tree-based sequence alignment", + "Variant classification" + ], + "EDAM topic": [ + "Virology" + ], + "Status": "Up-to-date", + "Source": "https://github.com/cov-lineages/pangolin", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "pangolin", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/pangolin", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/pangolin", + "Galaxy wrapper version": "4.3", + "Conda id": "pangolin", + "Conda version": "4.3" + }, + { + "Galaxy wrapper id": "parse_mito_blast", + "Galaxy tool ids": [ + "parse_mito_blast" + ], + "Description": "Filtering blast out from querying assembly against mitochondrial database.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://raw.githubusercontent.com/VGP/vgp-assembly/master/galaxy_tools/parse_mito_blast/parse_mito_blast.py", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "parse_mito_blast", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/parse_mito_blast", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/parse_mito_blast", + "Galaxy wrapper version": "1.0.2", + "Conda id": "parse_mito_blast", + "Conda version": "1.0.2" + }, + { + "Galaxy wrapper id": "pathview", + "Galaxy tool ids": [ + "pathview" + ], + "Description": "Pathview is a tool set for pathway based data integration and visualization.", + "bio.tool id": "pathview", + "bio.tool ids": [ + "pathview" + ], + "biii": null, + "bio.tool name": "pathview", + "bio.tool description": "Tool set for pathway based data integration and visualization that maps and renders a wide variety of biological data on relevant pathway graphs. It downloads the pathway graph data, parses the data file, maps user data to the pathway, and render pathway graph with the mapped data. In addition, it integrates with pathway and gene set (enrichment) analysis tools for large-scale and fully automated analysis.", + "EDAM operation": [ + "Pathway or network analysis", + "Pathway or network visualisation" + ], + "EDAM topic": [ + "Molecular interactions, pathways and networks", + "Systems biology", + "Data visualisation" + ], + "Status": "To update", + "Source": "https://bioconductor.org/packages/release/bioc/html/pathview.html", + "ToolShed categories": [ + "Statistics", + "RNA", + "Micro-array Analysis" + ], + "ToolShed id": "pathview", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/pathview", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/pathview", + "Galaxy wrapper version": "1.34.0", + "Conda id": "bioconductor-pathview", + "Conda version": "1.42.0" + }, + { + "Galaxy wrapper id": "pbgcpp", + "Galaxy tool ids": [ + "pbgcpp" + ], + "Description": "Compute genomic consensus and call variants using PacBio reads mapped to a reference", + "bio.tool id": "genomicconsensus", + "bio.tool ids": [ + "genomicconsensus" + ], + "biii": null, + "bio.tool name": "GenomicConsensus", + "bio.tool description": "The GenomicConsensus package provides the variantCaller tool, which allows you to apply the Quiver or Arrow algorithm to mapped PacBio reads to get consensus and variant calls.", + "EDAM operation": [ + "Variant calling" + ], + "EDAM topic": [ + "Mapping" + ], + "Status": "Up-to-date", + "Source": "https://github.com/PacificBiosciences/gcpp", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "pbgcpp", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/pbgcpp", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/pbgcpp", + "Galaxy wrapper version": "2.0.2", + "Conda id": "pbgcpp", + "Conda version": "2.0.2" + }, + { + "Galaxy wrapper id": "pbmm2", + "Galaxy tool ids": [ + "pbmm2" + ], + "Description": "A minimap2 SMRT wrapper for PacBio data.", + "bio.tool id": "pbmm2", + "bio.tool ids": [ + "pbmm2" + ], + "biii": null, + "bio.tool name": "pbmm2", + "bio.tool description": "pbmm2 is a SMRT C++ wrapper for minimap2's C API. Its purpose is to support native PacBio in- and output, provide sets of recommended parameters, generate sorted output on-the-fly, and postprocess alignments. Sorted output can be used directly for polishing using GenomicConsensus, if BAM has been used as input to pbmm2. Benchmarks show that pbmm2 outperforms BLASR in sequence identity, number of mapped bases, and especially runtime. pbmm2 is the official replacement for BLASR.", + "EDAM operation": [ + "Pairwise sequence alignment", + "Sorting" + ], + "EDAM topic": [ + "Mapping" + ], + "Status": "Up-to-date", + "Source": "https://github.com/PacificBiosciences/pbmm2", + "ToolShed categories": [ + "Next Gen Mappers" + ], + "ToolShed id": "pbmm2", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/pbmm2", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/pbmm2", + "Galaxy wrapper version": "1.13.1", + "Conda id": "pbmm2", + "Conda version": "1.13.1" + }, + { + "Galaxy wrapper id": "pbtk", + "Galaxy tool ids": [ + "bam2fastx" + ], + "Description": "Convert PacBio Bam File to fasta or fastq file", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/PacificBiosciences/pbtk", + "ToolShed categories": [ + "Convert Formats", + "Fasta Manipulation", + "Fastq Manipulation" + ], + "ToolShed id": "bam2fastx", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/pbtk", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/pbtk", + "Galaxy wrapper version": "3.1.1", + "Conda id": "pbtk", + "Conda version": "3.1.1" + }, + { + "Galaxy wrapper id": "pe_histogram", + "Galaxy tool ids": [ + "pe_histogram" + ], + "Description": "Contains a tool that produces an insert size histogram for a paired-end BAM file.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/seqcode/cegr-tools/tree/master/src/org/seqcode/cegrtools/pehistogram", + "ToolShed categories": [ + "Graphics" + ], + "ToolShed id": "pe_histogram", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/pe_histogram", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/pe_histogram", + "Galaxy wrapper version": "1.0.1", + "Conda id": "openjdk", + "Conda version": null + }, + { + "Galaxy wrapper id": "peakzilla", + "Galaxy tool ids": [ + "peakzilla" + ], + "Description": "Peakzilla identifies sites of enrichment and transcription factor binding sites from ChIP-seq and ChIP-exo experiments.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/steinmann/peakzilla", + "ToolShed categories": [ + "ChIP-seq" + ], + "ToolShed id": "peakzilla", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/peakzilla", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/peakzilla", + "Galaxy wrapper version": "1.0", + "Conda id": "python", + "Conda version": null + }, + { + "Galaxy wrapper id": "pear", + "Galaxy tool ids": [ + "iuc_pear" + ], + "Description": "PEAR evaluates all possible paired-end read overlaps", + "bio.tool id": "pear", + "bio.tool ids": [ + "pear" + ], + "biii": null, + "bio.tool name": "PEAR", + "bio.tool description": "Paired-end read merger. PEAR evaluates all possible paired-end read overlaps without requiring the target fragment size as input. In addition, it implements a statistical test for minimizing false-positive results.", + "EDAM operation": [ + "Sequence merging" + ], + "EDAM topic": [ + "Sequence assembly" + ], + "Status": "Up-to-date", + "Source": null, + "ToolShed categories": [], + "ToolShed id": "pear", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/pear", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/pear", + "Galaxy wrapper version": "0.9.6", + "Conda id": "pear", + "Conda version": "0.9.6" + }, + { + "Galaxy wrapper id": "pharokka", + "Galaxy tool ids": [ + "pharokka" + ], + "Description": "rapid standardised annotation tool for bacteriophage genomes and metagenomes", + "bio.tool id": "pharokka", + "bio.tool ids": [ + "pharokka" + ], + "biii": null, + "bio.tool name": "Pharokka", + "bio.tool description": "Pharokka is a rapid standardised annotation tool for bacteriophage genomes and metagenomes.", + "EDAM operation": [ + "Genome annotation", + "Antimicrobial resistance prediction", + "tRNA gene prediction", + "Formatting", + "Sequence assembly" + ], + "EDAM topic": [ + "Metagenomics", + "Sequence sites, features and motifs", + "Workflows", + "Functional, regulatory and non-coding RNA" + ], + "Status": "To update", + "Source": "https://github.com/gbouras13/pharokka", + "ToolShed categories": [ + "Genome annotation" + ], + "ToolShed id": "pharokka", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/pharokka", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/pharokka", + "Galaxy wrapper version": "1.3.2", + "Conda id": "\n pharokka\n ", + "Conda version": null + }, + { + "Galaxy wrapper id": "phyloseq", + "Galaxy tool ids": [ + "phyloseq_from_biom", + "phyloseq_from_dada2", + "phyloseq_plot_ordination", + "phyloseq_plot_richness" + ], + "Description": "Handling and analysis of high-throughput microbiome census data", + "bio.tool id": "phyloseq", + "bio.tool ids": [ + "phyloseq" + ], + "biii": null, + "bio.tool name": "phyloseq", + "bio.tool description": "Provides a set of classes and tools to facilitate the import, storage, analysis, and graphical display of microbiome census data.", + "EDAM operation": [ + "Deposition", + "Analysis", + "Visualisation" + ], + "EDAM topic": [ + "Microbiology", + "Sequence analysis", + "Metagenomics" + ], + "Status": "Up-to-date", + "Source": "https://www.bioconductor.org/packages/release/bioc/html/phyloseq.html", + "ToolShed categories": [ + "Metagenomics" + ], + "ToolShed id": "phyloseq", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/phyloseq", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/phyloseq", + "Galaxy wrapper version": "1.46.0", + "Conda id": "bioconductor-phyloseq", + "Conda version": "1.46.0" + }, + { + "Galaxy wrapper id": "phyml", + "Galaxy tool ids": [ + "phyml" + ], + "Description": "PhyML is a phylogeny software based on the maximum-likelihood principle.", + "bio.tool id": "phyml", + "bio.tool ids": [ + "phyml" + ], + "biii": null, + "bio.tool name": "PhyML", + "bio.tool description": "Phylogenetic estimation software using Maximum Likelihood", + "EDAM operation": [ + "Phylogenetic tree generation (maximum likelihood and Bayesian methods)" + ], + "EDAM topic": [ + "Phylogenetics", + "Bioinformatics", + "Phylogenetics" + ], + "Status": "Up-to-date", + "Source": "http://www.atgc-montpellier.fr/phyml/", + "ToolShed categories": [ + "Phylogenetics" + ], + "ToolShed id": "phyml", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/phyml", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/phyml", + "Galaxy wrapper version": "3.3.20220408", + "Conda id": "phyml", + "Conda version": "3.3.20220408" + }, + { + "Galaxy wrapper id": "picard", + "Galaxy tool ids": [ + "picard_AddCommentsToBam", + "picard_AddOrReplaceReadGroups", + "picard_BedToIntervalList", + "picard_CleanSam", + "picard_CASM", + "picard_CollectBaseDistributionByCycle", + "picard_CollectGcBiasMetrics", + "picard_CollectHsMetrics", + "picard_CollectInsertSizeMetrics", + "picard_CollectRnaSeqMetrics", + "picard_artifact_metrics", + "picard_CollectWgsMetrics", + "picard_DownsampleSam", + "picard_EstimateLibraryComplexity", + "picard_FastqToSam", + "picard_FilterSamReads", + "picard_FixMateInformation", + "picard_MarkDuplicates", + "picard_MarkDuplicatesWithMateCigar", + "picard_MeanQualityByCycle", + "picard_MergeBamAlignment", + "picard_MergeSamFiles", + "picard_NormalizeFasta", + "picard_QualityScoreDistribution", + "picard_ReorderSam", + "picard_ReplaceSamHeader", + "picard_RevertOriginalBaseQualitiesAndAddMateCigar", + "picard_RevertSam", + "picard_SamToFastq", + "picard_SortSam", + "picard_ValidateSamFile" + ], + "Description": "Picard SAM/BAM manipulation tools.", + "bio.tool id": "picard_samtofastq", + "bio.tool ids": [ + "picard_fastqtosam", + "picard_replacesamheader", + "picard_samtofastq", + "picard_reordersam" + ], + "biii": null, + "bio.tool name": "picard_samtofastq", + "bio.tool description": "Create a FASTQ file.", + "EDAM operation": [ + "Formatting" + ], + "EDAM topic": [ + "Sequencing" + ], + "Status": "Up-to-date", + "Source": "http://broadinstitute.github.io/picard/", + "ToolShed categories": [ + "SAM" + ], + "ToolShed id": "picard", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/picard", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/picard", + "Galaxy wrapper version": "3.1.1", + "Conda id": "picard", + "Conda version": "3.1.1" + }, + { + "Galaxy wrapper id": "pick_value", + "Galaxy tool ids": [ + "pick_value" + ], + "Description": "Compose a text parameter value using text, integer and float values", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": null, + "ToolShed categories": [ + "Text Manipulation" + ], + "ToolShed id": "pick_value", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/pick_value", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/pick_value", + "Galaxy wrapper version": "0.2.0", + "Conda id": null, + "Conda version": null + }, + { + "Galaxy wrapper id": "picrust", + "Galaxy tool ids": [ + "picrust_categorize", + "picrust_compare_biom", + "picrust_format_tree_and_trait_table", + "picrust_metagenome_contributions", + "picrust_normalize_by_copy_number", + "picrust_predict_metagenomes" + ], + "Description": "PICRUSt wrappers", + "bio.tool id": "picrust", + "bio.tool ids": [ + "picrust" + ], + "biii": null, + "bio.tool name": "PICRUSt", + "bio.tool description": "PICRUSt (Phylogenetic Investigation of Communities by Reconstruction of Unobserved States) is a bioinformatics software package designed to predict metagenome functional content from marker gene (e.g., 16S rRNA) surveys and full genomes.", + "EDAM operation": [ + "Phylogenetic reconstruction", + "Expression analysis", + "Genome annotation", + "DNA barcoding" + ], + "EDAM topic": [ + "Metagenomics", + "Microbial ecology", + "Functional, regulatory and non-coding RNA", + "Metagenomic sequencing" + ], + "Status": "To update", + "Source": "https://picrust.github.io/picrust/", + "ToolShed categories": [ + "Metagenomics" + ], + "ToolShed id": "picrust", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/picrust", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/picrust", + "Galaxy wrapper version": "1.1.1", + "Conda id": "picrust", + "Conda version": "1.1.4" + }, + { + "Galaxy wrapper id": "picrust2", + "Galaxy tool ids": [ + "picrust2_add_descriptions", + "picrust2_hsp", + "picrust2_metagenome_pipeline", + "picrust2_pathway_pipeline", + "picrust2_pipeline", + "picrust2_place_seqs", + "picrust2_shuffle_predictions" + ], + "Description": "PICRUSt2: Phylogenetic Investigation of Communities by Reconstruction of Unobserved States", + "bio.tool id": "picrust2", + "bio.tool ids": [ + "picrust2" + ], + "biii": null, + "bio.tool name": "PICRUSt2", + "bio.tool description": "PICRUSt2 (Phylogenetic Investigation of Communities by Reconstruction of Unobserved States) is a software for predicting functional abundances based only on marker gene sequences.", + "EDAM operation": [ + "Phylogenetic reconstruction", + "Expression analysis", + "Rarefaction", + "Pathway analysis" + ], + "EDAM topic": [ + "Metagenomics", + "Microbiology", + "Phylogenetics", + "Metagenomic sequencing" + ], + "Status": "To update", + "Source": "https://github.com/picrust/picrust2/wiki", + "ToolShed categories": [ + "Metagenomics" + ], + "ToolShed id": "picrust2", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/picrust/picrust2", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/picrust2", + "Galaxy wrapper version": "2.5.1", + "Conda id": "picrust2", + "Conda version": "2.5.2" + }, + { + "Galaxy wrapper id": "pilon", + "Galaxy tool ids": [ + "pilon" + ], + "Description": "pilon is a tool for assembly improvement and variant analysis in bacteria", + "bio.tool id": "pilon", + "bio.tool ids": [ + "pilon" + ], + "biii": null, + "bio.tool name": "pilon", + "bio.tool description": "Read alignment analysis to diagnose, report, and automatically improve de novo genome assemblies.", + "EDAM operation": [ + "Sequence assembly", + "Analysis", + "Read alignment" + ], + "EDAM topic": [ + "Assembly" + ], + "Status": "To update", + "Source": null, + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "pilon", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/pilon", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/pilon", + "Galaxy wrapper version": "1.20.1", + "Conda id": "pilon", + "Conda version": "1.24" + }, + { + "Galaxy wrapper id": "pipelign", + "Galaxy tool ids": [ + "pipelign" + ], + "Description": "Multipe sequence alignment", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/asmmhossain/pipelign/", + "ToolShed categories": [ + "Next Gen Mappers" + ], + "ToolShed id": "pipelign", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/pipelign", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/pipelign", + "Galaxy wrapper version": "0.2", + "Conda id": "pipelign", + "Conda version": "0.2" + }, + { + "Galaxy wrapper id": "pizzly", + "Galaxy tool ids": [ + "pizzly" + ], + "Description": "Pizzly is a program for detecting gene fusions from RNA-Seq data of cancer samples.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/pmelsted/pizzly/", + "ToolShed categories": [ + "Transcriptomics" + ], + "ToolShed id": null, + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/pizzly/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/pizzly", + "Galaxy wrapper version": "0.37.3.1", + "Conda id": "pizzly", + "Conda version": "0.37.3" + }, + { + "Galaxy wrapper id": "plasflow", + "Galaxy tool ids": [ + "PlasFlow" + ], + "Description": "PlasFlow - Prediction of plasmid sequences in metagenomic contigs.", + "bio.tool id": "plasflow", + "bio.tool ids": [ + "plasflow" + ], + "biii": null, + "bio.tool name": "PlasFlow", + "bio.tool description": "PlasFlow is a set of scripts used for prediction of plasmid sequences in metagenomic contigs.", + "EDAM operation": [ + "Sequence analysis" + ], + "EDAM topic": [ + "Metagenomics" + ], + "Status": "Up-to-date", + "Source": "https://github.com/smaegol/PlasFlow", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "plasflow", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/plasflow", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/plasflow", + "Galaxy wrapper version": "1.1.0", + "Conda id": "plasflow", + "Conda version": "1.1.0" + }, + { + "Galaxy wrapper id": "plasmidfinder", + "Galaxy tool ids": [ + "plasmidfinder" + ], + "Description": "\"PlasmidFinder provides the detection of replicons in the WGSand assigns the plasmids under study to lineages that trace backthe information to the existing knowledge on Inc groups and suggestspossible reference plasmids for each lineage\"", + "bio.tool id": "PlasmidFinder", + "bio.tool ids": [ + "PlasmidFinder" + ], + "biii": null, + "bio.tool name": "PlasmidFinder", + "bio.tool description": "PlasmidFinder is a tool for the identification and typing of Plasmid Replicons in Whole-Genome Sequencing (WGS).", + "EDAM operation": [ + "Genome assembly", + "Scaffolding", + "Multilocus sequence typing" + ], + "EDAM topic": [ + "Whole genome sequencing", + "Sequence assembly", + "Mapping", + "Probes and primers" + ], + "Status": "Up-to-date", + "Source": "https://bitbucket.org/genomicepidemiology/plasmidfinder/src/master/", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "plasmidfinder", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/blob/master/tools/plasmidfinder", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/plasmidfinder", + "Galaxy wrapper version": "2.1.6", + "Conda id": "plasmidfinder", + "Conda version": "2.1.6" + }, + { + "Galaxy wrapper id": "plink", + "Galaxy tool ids": [ + "plink" + ], + "Description": "PLINK is a free, open-source whole genome association analysis toolset, designed to perform a range of basic, large-scale analyses in a computationally efficient manner.", + "bio.tool id": "plink", + "bio.tool ids": [ + "plink" + ], + "biii": null, + "bio.tool name": "PLINK", + "bio.tool description": "Free, open-source whole genome association analysis toolset, designed to perform a range of basic, large-scale analyses in a computationally efficient manner.", + "EDAM operation": [ + "Genetic variation analysis" + ], + "EDAM topic": [ + "GWAS study" + ], + "Status": "Up-to-date", + "Source": "https://www.cog-genomics.org/plink", + "ToolShed categories": [ + "Genome-Wide Association Study" + ], + "ToolShed id": "plink", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/plink", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/plink", + "Galaxy wrapper version": "1.90b6.21", + "Conda id": "plink", + "Conda version": "1.90b6.21" + }, + { + "Galaxy wrapper id": "polypolish", + "Galaxy tool ids": [ + "polypolish" + ], + "Description": "\"Polypolish is a tool for polishing genome assemblies with short reads.Polypolish uses SAM files where each read has been aligned to all possible locations (not just a single best location).This allows it to repair errors in repeat regions that other alignment-based polishers cannot fix.\"", + "bio.tool id": "Polypolish", + "bio.tool ids": [ + "Polypolish" + ], + "biii": null, + "bio.tool name": "Polypolish", + "bio.tool description": "Polypolish is a tool for polishing genome assemblies with short reads. Unlike other tools in this category, Polypolish uses SAM files where each read has been aligned to all possible locations (not just a single best location). This allows it to repair errors in repeat regions that other alignment-based polishers cannot fix.", + "EDAM operation": [ + "Genome assembly", + "Read mapping", + "Mapping assembly", + "Sequencing error detection" + ], + "EDAM topic": [ + "Sequence assembly", + "Sequence composition, complexity and repeats", + "Mapping" + ], + "Status": "To update", + "Source": "https://github.com/rrwick/Polypolish", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "polypolish", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/mesocentre-clermont-auvergne/galaxy-tools/tree/master/tools/polypolish", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/polypolish", + "Galaxy wrapper version": "0.5.0", + "Conda id": "polypolish", + "Conda version": "0.6.0" + }, + { + "Galaxy wrapper id": "porechop", + "Galaxy tool ids": [ + "porechop" + ], + "Description": "Porechop - Finding and removing adapters from Oxford Nanopore reads", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/rrwick/Porechop", + "ToolShed categories": [ + "Fasta Manipulation", + "Fastq Manipulation" + ], + "ToolShed id": "porechop", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/porechop", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/porechop", + "Galaxy wrapper version": null, + "Conda id": "porechop", + "Conda version": "0.2.4" + }, + { + "Galaxy wrapper id": "poretools", + "Galaxy tool ids": [ + "poretools_events", + "poretools_extract", + "poretools_hist", + "poretools_nucdist", + "poretools_occupancy", + "poretools_qualdist", + "poretools_qualpos", + "poretools_squiggle", + "poretools_stats", + "poretools_tabular", + "poretools_times", + "poretools_winner", + "poretools_yield_plot" + ], + "Description": "A flexible toolkit for exploring datasets generated by nanopore sequencing devices from MinION for the purposes of quality control and downstream analysis.", + "bio.tool id": "poretools", + "bio.tool ids": [ + "poretools" + ], + "biii": null, + "bio.tool name": "Poretools", + "bio.tool description": "Flexible toolkit for exploring datasets generated by nanopore sequencing devices from MinION for the purposes of quality control and downstream analysis.", + "EDAM operation": [ + "Nucleic acid sequence analysis" + ], + "EDAM topic": [ + "DNA", + "Sequencing" + ], + "Status": "Up-to-date", + "Source": "https://poretools.readthedocs.io/en/latest/", + "ToolShed categories": [ + "Fasta Manipulation", + "Fastq Manipulation" + ], + "ToolShed id": null, + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/poretools", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/poretools", + "Galaxy wrapper version": "0.6.1a1", + "Conda id": "poretools", + "Conda version": "0.6.1a1" + }, + { + "Galaxy wrapper id": "presto", + "Galaxy tool ids": [ + "presto_alignsets", + "presto_assemblepairs", + "presto_buildconsensus", + "presto_collapseseq", + "presto_filterseq", + "presto_maskprimers", + "presto_pairseq", + "presto_parseheaders", + "presto_parselog", + "presto_partition", + "prestor_abseq3" + ], + "Description": "pRESTO toolkit for immune repertoire analysis.", + "bio.tool id": "presto", + "bio.tool ids": [ + "presto" + ], + "biii": null, + "bio.tool name": "pRESTO", + "bio.tool description": "Integrated collection of platform-independent Python modules for processing raw reads from high-throughput (next-generation) sequencing of lymphocyte repertoires.", + "EDAM operation": [ + "Nucleic acid sequence analysis" + ], + "EDAM topic": [ + "Sequencing", + "DNA", + "Immunology" + ], + "Status": "To update", + "Source": "https://presto.readthedocs.io/", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "presto", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/presto", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/presto", + "Galaxy wrapper version": "0.6.2", + "Conda id": "presto", + "Conda version": "0.7.2" + }, + { + "Galaxy wrapper id": "pretext", + "Galaxy tool ids": [ + "pretext_graph", + "pretext_map", + "pretext_snapshot" + ], + "Description": "Process genome contacts maps processing images.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/wtsi-hpag/PretextSnapshot", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "suite_pretext", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/pretext", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/pretext", + "Galaxy wrapper version": "0.0.6", + "Conda id": "pretextgraph", + "Conda version": "0.0.6" + }, + { + "Galaxy wrapper id": "prinseq", + "Galaxy tool ids": [ + "prinseq" + ], + "Description": "PRINSEQ is a tool for easy and rapid quality control and data processing of metagenomic and metatranscriptomic datasets", + "bio.tool id": "prinseq", + "bio.tool ids": [ + "prinseq" + ], + "biii": null, + "bio.tool name": "PRINSEQ", + "bio.tool description": "PRINSEQ is a sequence processing tool that can be used to filter, reformat and trim genomic and metagenomic sequence data. It generates summary statistics of the input in graphical and tabular formats that can be used for quality control steps. PRINSEQ is available as both standalone and web-based versions.", + "EDAM operation": [ + "Read pre-processing", + "Sequence trimming", + "Sequence contamination filtering" + ], + "EDAM topic": [ + "Transcriptomics", + "Metagenomics", + "Genomics" + ], + "Status": "To update", + "Source": "http://prinseq.sourceforge.net/manual.html", + "ToolShed categories": [ + "Fastq Manipulation", + "Metagenomics" + ], + "ToolShed id": "prinseq", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/prinseq/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/prinseq", + "Galaxy wrapper version": "@TOOL_VERSION+galaxy2", + "Conda id": "prinseq", + "Conda version": "0.20.4" + }, + { + "Galaxy wrapper id": "prodigal", + "Galaxy tool ids": [ + "prodigal" + ], + "Description": "A protein-coding gene prediction software tool for bacterial and archaeal genomes", + "bio.tool id": "prodigal", + "bio.tool ids": [ + "prodigal" + ], + "biii": null, + "bio.tool name": "Prodigal", + "bio.tool description": "Fast, reliable protein-coding gene prediction for prokaryotic genomes.", + "EDAM operation": [ + "Genome annotation" + ], + "EDAM topic": [ + "Genomics", + "Sequence analysis" + ], + "Status": "Up-to-date", + "Source": "https://github.com/hyattpd/Prodigal", + "ToolShed categories": [ + "Genome annotation" + ], + "ToolShed id": "prodigal", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/prodigal", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/prodigal", + "Galaxy wrapper version": "2.6.3", + "Conda id": "prodigal", + "Conda version": "2.6.3" + }, + { + "Galaxy wrapper id": "progressivemauve", + "Galaxy tool ids": [ + "progressivemauve", + "xmfa2gff3" + ], + "Description": "Mauve/ProgressiveMauve Multiple Sequence Aligner", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": null, + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "progressivemauve", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/progressivemauve", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/progressivemauve", + "Galaxy wrapper version": null, + "Conda id": "progressivemauve", + "Conda version": "snapshot_2015_02_13" + }, + { + "Galaxy wrapper id": "prokka", + "Galaxy tool ids": [ + "prokka" + ], + "Description": "Rapid annotation of prokaryotic genomes", + "bio.tool id": "prokka", + "bio.tool ids": [ + "prokka" + ], + "biii": null, + "bio.tool name": "Prokka", + "bio.tool description": "Software tool to annotate bacterial, archaeal and viral genomes quickly and produce standards-compliant output files.", + "EDAM operation": [ + "Gene prediction", + "Coding region prediction", + "Genome annotation" + ], + "EDAM topic": [ + "Genomics", + "Model organisms", + "Virology" + ], + "Status": "Up-to-date", + "Source": "http://github.com/tseemann/prokka", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "prokka", + "Galaxy wrapper owner": "crs4", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/prokka/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/prokka", + "Galaxy wrapper version": "1.14.6", + "Conda id": "prokka", + "Conda version": "1.14.6" + }, + { + "Galaxy wrapper id": "prot-scriber", + "Galaxy tool ids": [ + "prot_scriber" + ], + "Description": "Protein annotation of short human readable descriptions", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/usadellab/prot-scriber", + "ToolShed categories": [ + "Proteomics" + ], + "ToolShed id": "prot_scriber", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/prot-scriber", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/prot-scriber", + "Galaxy wrapper version": "0.1.5", + "Conda id": "prot-scriber", + "Conda version": "0.1.5" + }, + { + "Galaxy wrapper id": "proteinortho", + "Galaxy tool ids": [ + "proteinortho", + "proteinortho_grab_proteins", + "proteinortho_summary" + ], + "Description": "Proteinortho is a tool to detect orthologous proteins/genes within different species.", + "bio.tool id": "proteinortho", + "bio.tool ids": [ + "proteinortho" + ], + "biii": null, + "bio.tool name": "Proteinortho", + "bio.tool description": "Proteinortho is a tool to detect orthologous genes within different species", + "EDAM operation": [ + "Sequence clustering", + "Sequence analysis" + ], + "EDAM topic": [ + "Comparative genomics" + ], + "Status": "Up-to-date", + "Source": "https://gitlab.com/paulklemm_PHD/proteinortho", + "ToolShed categories": [ + "Proteomics" + ], + "ToolShed id": "proteinortho", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://gitlab.com/paulklemm_PHD/proteinortho", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/proteinortho", + "Galaxy wrapper version": "6.3.1", + "Conda id": "proteinortho", + "Conda version": "6.3.1" + }, + { + "Galaxy wrapper id": "psiclass", + "Galaxy tool ids": [ + "psiclass" + ], + "Description": "PsiCLASS is a reference-based transcriptome assembler for single or multiple RNA-seq samples.", + "bio.tool id": "psiclass", + "bio.tool ids": [ + "psiclass" + ], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/splicebox/PsiCLASS", + "ToolShed categories": [ + "Transcriptomics" + ], + "ToolShed id": "psiclass", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/psiclass", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/psiclass", + "Galaxy wrapper version": "1.0.3", + "Conda id": "psiclass", + "Conda version": "1.0.3" + }, + { + "Galaxy wrapper id": "pureclip", + "Galaxy tool ids": [ + "pureclip" + ], + "Description": "PureCLIP is an HMM based peak caller specifically designed for eCLIP/iCLIP data", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/skrakau/PureCLIP", + "ToolShed categories": [ + "Sequence Analysis", + "RNA", + "CLIP-seq" + ], + "ToolShed id": "pureclip", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/pureclip", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/pureclip", + "Galaxy wrapper version": "1.0.4", + "Conda id": "pureclip", + "Conda version": "1.3.1" + }, + { + "Galaxy wrapper id": "purge_dups", + "Galaxy tool ids": [ + "purge_dups" + ], + "Description": "Purge haplotigs and overlaps in an assembly based on read depth", + "bio.tool id": "purge_dups", + "bio.tool ids": [ + "purge_dups" + ], + "biii": null, + "bio.tool name": "purge_dups", + "bio.tool description": "Identifying and removing haplotypic duplication in primary genome assemblies | haplotypic duplication identification tool | scripts/pd_config.py: script to generate a configuration file used by run_purge_dups.py | purge haplotigs and overlaps in an assembly based on read depth | Given a primary assembly pri_asm and an alternative assembly hap_asm (optional, if you have one), follow the steps shown below to build your own purge_dups pipeline, steps with same number can be run simultaneously. Among all the steps, although step 4 is optional, we highly recommend our users to do so, because assemblers may produce overrepresented seqeuences. In such a case, The final step 4 can be applied to remove those seqeuences", + "EDAM operation": [ + "Genome assembly", + "Read binning", + "Scaffolding" + ], + "EDAM topic": [ + "Sequence assembly" + ], + "Status": "Up-to-date", + "Source": "https://github.com/dfguan/purge_dups", + "ToolShed categories": [ + "Assembly" + ], + "ToolShed id": "purge_dups", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/purge_dups", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/purge_dups", + "Galaxy wrapper version": "1.2.6", + "Conda id": "purge_dups", + "Conda version": "1.2.6" + }, + { + "Galaxy wrapper id": "pycoqc", + "Galaxy tool ids": [ + "pycoqc" + ], + "Description": "QC metrics for ONT Basecalling", + "bio.tool id": "pycoqc", + "bio.tool ids": [ + "pycoqc" + ], + "biii": null, + "bio.tool name": "pycoQC", + "bio.tool description": "PycoQC computes metrics and generates interactive QC plots for Oxford Nanopore technologies sequencing data.", + "EDAM operation": [ + "Sequencing quality control", + "Statistical calculation" + ], + "EDAM topic": [ + "Sequence analysis", + "Data quality management", + "Sequencing" + ], + "Status": "Up-to-date", + "Source": "https://github.com/tleonardi/pycoQC", + "ToolShed categories": [ + "Nanopore" + ], + "ToolShed id": "pycoqc", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/pycoqc", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/pycoqc", + "Galaxy wrapper version": "2.5.2", + "Conda id": "pycoqc", + "Conda version": "2.5.2" + }, + { + "Galaxy wrapper id": "pyega3", + "Galaxy tool ids": [ + "pyega3" + ], + "Description": "EGA python client uses the EGA REST API to download authorized datasets and files.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/EGA-archive/ega-download-client", + "ToolShed categories": [ + "Data Source" + ], + "ToolShed id": "ega_download_client", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/pyega3", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/pyega3", + "Galaxy wrapper version": "5.0.2", + "Conda id": "pyega3", + "Conda version": "5.2.0" + }, + { + "Galaxy wrapper id": "pygenometracks", + "Galaxy tool ids": [ + "pygenomeTracks" + ], + "Description": "pyGenomeTracks: Standalone program and library to plot beautiful genome browser tracks.", + "bio.tool id": "pygenometracks", + "bio.tool ids": [ + "pygenometracks" + ], + "biii": null, + "bio.tool name": "pyGenomeTracks", + "bio.tool description": "reproducible plots for multivariate genomic data sets.Standalone program and library to plot beautiful genome browser tracks.pyGenomeTracks aims to produce high-quality genome browser tracks that are highly customizable. Currently, it is possible to plot:.", + "EDAM operation": [ + "Visualisation", + "Formatting" + ], + "EDAM topic": [ + "Model organisms", + "Imaging", + "Workflows" + ], + "Status": "To update", + "Source": "https://github.com/deeptools/pyGenomeTracks", + "ToolShed categories": [ + "Visualization" + ], + "ToolShed id": "pygenometracks", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/pygenometracks", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/pygenometracks", + "Galaxy wrapper version": "3.8", + "Conda id": "pygenometracks", + "Conda version": "3.9" + }, + { + "Galaxy wrapper id": "pysradb", + "Galaxy tool ids": [ + "pysradb_search" + ], + "Description": "pysradb allows to retrieve metadata, such as run accession numbers, from SRA and ENA based on multiple criteria.", + "bio.tool id": "pysradb", + "bio.tool ids": [ + "pysradb" + ], + "biii": null, + "bio.tool name": "pysradb", + "bio.tool description": "Python package to query next-generation sequencing metadata and data from NCBI Sequence Read Archive.", + "EDAM operation": [ + "Deposition", + "Data retrieval" + ], + "EDAM topic": [ + "Sequencing", + "Gene transcripts", + "Bioinformatics" + ], + "Status": "To update", + "Source": "https://github.com/saketkc/pysradb", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "pysradb_search", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/pysradb", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/pysradb", + "Galaxy wrapper version": "1.4.2", + "Conda id": "pysradb", + "Conda version": "2.2.0" + }, + { + "Galaxy wrapper id": "qfilt", + "Galaxy tool ids": [ + "qfilt" + ], + "Description": "Filter sequencing data", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/veg/qfilt", + "ToolShed categories": [ + "Fastq Manipulation" + ], + "ToolShed id": "qfilt", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/qfilt", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/qfilt", + "Galaxy wrapper version": "1.0.0+galaxy1", + "Conda id": "qfilt", + "Conda version": "0.0.1" + }, + { + "Galaxy wrapper id": "qiime_add_on", + "Galaxy tool ids": [ + "qiime_collapse_samples", + "qiime_make_otu_table" + ], + "Description": "QIIME to perform microbial community analysis", + "bio.tool id": "qiime_add_on", + "bio.tool ids": [ + "qiime_add_on", + "qiime_core" + ], + "biii": null, + "bio.tool name": "qiime_add_on", + "bio.tool description": "QIIME 2 is a next-generation microbiome bioinformatics platform that is extensible, free, open source, and community developed.", + "EDAM operation": [ + "Demultiplexing", + "Visualisation", + "Taxonomic classification", + "Phylogenetic analysis", + "Sequencing quality control" + ], + "EDAM topic": [ + "Microbial ecology", + "Phylogeny", + "Metagenomics", + "Metatranscriptomics" + ], + "Status": "To update", + "Source": "http://www.qiime.org", + "ToolShed categories": [ + "Metagenomics" + ], + "ToolShed id": "qiime", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/qiime/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/qiime/qiime_add_on", + "Galaxy wrapper version": null, + "Conda id": "qiime", + "Conda version": "1.9.1" + }, + { + "Galaxy wrapper id": "qiime_core", + "Galaxy tool ids": [ + "qiime_align_seqs", + "qiime_alpha_diversity", + "qiime_alpha_rarefaction", + "qiime_assign_taxonomy", + "qiime_beta_diversity", + "qiime_beta_diversity_through_plots", + "qiime_compare_categories", + "qiime_core_diversity", + "qiime_count_seqs", + "qiime_extract_barcodes", + "qiime_filter_alignment", + "qiime_filter_fasta", + "qiime_filter_otus_from_otu_table", + "qiime_filter_samples_from_otu_table", + "qiime_filter_taxa_from_otu_table", + "qiime_jackknifed_beta_diversity", + "qiime_make_emperor", + "qiime_make_otu_heatmap", + "qiime_make_phylogeny", + "qiime_multiple_join_paired_ends", + "qiime_multiple_split_libraries_fastq", + "qiime_pick_closed_reference_otus", + "qiime_pick_open_reference_otus", + "qiime_pick_otus", + "qiime_pick_rep_set", + "qiime_plot_taxa_summary", + "qiime_split_libraries", + "qiime_split_libraries_fastq", + "qiime_summarize_taxa", + "qiime_summarize_taxa_through_plots", + "qiime_upgma_cluster", + "qiime_validate_mapping_file" + ], + "Description": "QIIME to perform microbial community analysis", + "bio.tool id": "qiime_core", + "bio.tool ids": [ + "qiime_core" + ], + "biii": null, + "bio.tool name": "qiime_core", + "bio.tool description": "QIIME 2\u2122 is a next-generation microbiome bioinformatics platform that is extensible, free, open source, and community developed.", + "EDAM operation": [ + "Demultiplexing", + "Visualisation", + "Taxonomic classification", + "Phylogenetic analysis", + "Sequencing quality control" + ], + "EDAM topic": [ + "Microbial ecology", + "Phylogeny", + "Metagenomics", + "Metatranscriptomics" + ], + "Status": "To update", + "Source": "http://www.qiime.org", + "ToolShed categories": [ + "Metagenomics" + ], + "ToolShed id": "qiime", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/qiime/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/qiime/qiime_core", + "Galaxy wrapper version": null, + "Conda id": "qiime", + "Conda version": "1.9.1" + }, + { + "Galaxy wrapper id": "qiime_extract_viz", + "Galaxy tool ids": [ + "qiime_extract_viz" + ], + "Description": "Extract vizualization from QIIME artifacts", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "http://www.qiime.org", + "ToolShed categories": [ + "Metagenomics" + ], + "ToolShed id": "qiime_extract_viz", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/qiimme_extract_viz", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/qiime_extract_viz", + "Galaxy wrapper version": "0.1.0", + "Conda id": "unzip", + "Conda version": null + }, + { + "Galaxy wrapper id": "qq_tools", + "Galaxy tool ids": [ + "qq_manhattan" + ], + "Description": null, + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://CRAN.R-project.org/package=qqman", + "ToolShed categories": [ + "Visualization", + "Variant Analysis" + ], + "ToolShed id": null, + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": null, + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/qq_tools", + "Galaxy wrapper version": "0.1.0", + "Conda id": "r-qqman", + "Conda version": "0.1.4" + }, + { + "Galaxy wrapper id": "qualimap", + "Galaxy tool ids": [ + "qualimap_bamqc", + "qualimap_counts", + "qualimap_multi_bamqc", + "qualimap_rnaseq" + ], + "Description": null, + "bio.tool id": "qualimap", + "bio.tool ids": [ + "qualimap" + ], + "biii": null, + "bio.tool name": "QualiMap", + "bio.tool description": "Platform-independent application written in Java and R that provides both a Graphical User Inteface (GUI) and a command-line interface to facilitate the quality control of alignment sequencing data.", + "EDAM operation": [ + "Sequencing quality control" + ], + "EDAM topic": [ + "Data quality management" + ], + "Status": "To update", + "Source": "http://qualimap.bioinfo.cipf.es/", + "ToolShed categories": [ + "Sequence Analysis", + "Transcriptomics", + "SAM" + ], + "ToolShed id": "qualimap", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/qualimap", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/qualimap", + "Galaxy wrapper version": "2.2.2d", + "Conda id": "qualimap", + "Conda version": "2.3" + }, + { + "Galaxy wrapper id": "quast", + "Galaxy tool ids": [ + "quast" + ], + "Description": "Quast (Quality ASsessment Tool) evaluates genome assemblies.", + "bio.tool id": "quast", + "bio.tool ids": [ + "quast" + ], + "biii": null, + "bio.tool name": "QUAST", + "bio.tool description": "QUAST stands for QUality ASsessment Tool. It evaluates a quality of genome assemblies by computing various metrics and providing nice reports.", + "EDAM operation": [ + "Visualisation", + "Sequence assembly validation" + ], + "EDAM topic": [ + "Sequence assembly" + ], + "Status": "Up-to-date", + "Source": "http://quast.bioinf.spbau.ru/", + "ToolShed categories": [ + "Assembly" + ], + "ToolShed id": "quast", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/quast", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/quast", + "Galaxy wrapper version": "5.2.0", + "Conda id": "quast", + "Conda version": "5.2.0" + }, + { + "Galaxy wrapper id": "query_impc", + "Galaxy tool ids": [ + "query_impc" + ], + "Description": "Contains a tool to query the IMPC database.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/INFRAFRONTIERDIB/tools-iuc/tree/query_impc/tools/query_impc", + "ToolShed categories": [ + "Convert Formats", + "Web Services" + ], + "ToolShed id": "query_impc", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/INFRAFRONTIERDIB/tools-iuc/tree/query_impc/tools/query_impc", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/query_impc", + "Galaxy wrapper version": "0.9.0", + "Conda id": "requests", + "Conda version": null + }, + { + "Galaxy wrapper id": "query_tabular", + "Galaxy tool ids": [ + "filter_tabular", + "query_tabular", + "sqlite_to_tabular" + ], + "Description": "Loads tabular files into a SQLite DB to perform a SQL query producing a tabular output", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": null, + "ToolShed categories": [ + "Text Manipulation" + ], + "ToolShed id": null, + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/query_tabular", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/query_tabular", + "Galaxy wrapper version": "3.3.0", + "Conda id": "python", + "Conda version": null + }, + { + "Galaxy wrapper id": "quickmerge", + "Galaxy tool ids": [ + "quickmerge" + ], + "Description": "Merge long-read and hybrid assemblies to increase contiguity", + "bio.tool id": "quickmerge", + "bio.tool ids": [ + "quickmerge" + ], + "biii": null, + "bio.tool name": "quickmerge", + "bio.tool description": "Quickmerge is a program that uses complementary information from genomes assembled with long reads in order to improve contiguity, and works with assemblies derived from both Pacific Biosciences or Oxford Nanopore. Quickmerge will even work with hybrid assemblies made by combining long reads and Illumina short reads.", + "EDAM operation": [ + "Genome assembly", + "Scaffolding", + "De-novo assembly", + "Genotyping" + ], + "EDAM topic": [ + "Structural variation", + "Sequence assembly", + "DNA polymorphism", + "Whole genome sequencing", + "Genotype and phenotype" + ], + "Status": "Up-to-date", + "Source": "https://github.com/mahulchak/quickmerge", + "ToolShed categories": [ + "Assembly" + ], + "ToolShed id": "quickmerge", + "Galaxy wrapper owner": "galaxy-australia", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/quickmerge", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/quickmerge", + "Galaxy wrapper version": "0.3", + "Conda id": "quickmerge", + "Conda version": "0.3" + }, + { + "Galaxy wrapper id": "raceid", + "Galaxy tool ids": [ + "raceid_clustering", + "raceid_filtnormconf", + "raceid_inspectclusters", + "raceid_inspecttrajectory", + "raceid_trajectory" + ], + "Description": "RaceID3, StemID2, FateID - scRNA analysis", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/dgrun/RaceID3_StemID2_package/", + "ToolShed categories": [ + "Transcriptomics" + ], + "ToolShed id": null, + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/raceid3", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/raceid", + "Galaxy wrapper version": "0.2.3", + "Conda id": "r-raceid", + "Conda version": "0.1.3" + }, + { + "Galaxy wrapper id": "ragtag", + "Galaxy tool ids": [ + "ragtag" + ], + "Description": "Reference-guided scaffolding of draft genomes tool.", + "bio.tool id": "ragtag", + "bio.tool ids": [ + "ragtag" + ], + "biii": null, + "bio.tool name": "ragtag", + "bio.tool description": "RagTag is a collection of software tools for scaffolding and improving modern genome assemblies.", + "EDAM operation": [ + "Genome assembly" + ], + "EDAM topic": [ + "Sequence assembly" + ], + "Status": "Up-to-date", + "Source": "https://github.com/malonge/RagTag", + "ToolShed categories": [ + "Assembly" + ], + "ToolShed id": "ragtag", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/ragtag", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/ragtag", + "Galaxy wrapper version": "2.1.0", + "Conda id": "ragtag", + "Conda version": "2.1.0" + }, + { + "Galaxy wrapper id": "rapidnj", + "Galaxy tool ids": [ + "rapidnj" + ], + "Description": "Galaxy wrapper for the RapidNJ tool", + "bio.tool id": "rapidnj", + "bio.tool ids": [ + "rapidnj" + ], + "biii": null, + "bio.tool name": "RapidNJ", + "bio.tool description": "A tool for fast canonical neighbor-joining tree construction.", + "EDAM operation": [ + "Phylogenetic tree generation" + ], + "EDAM topic": [ + "Phylogeny" + ], + "Status": "Up-to-date", + "Source": "https://birc.au.dk/software/rapidnj/", + "ToolShed categories": [ + "Phylogenetics" + ], + "ToolShed id": "rapidnj", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/rapidnj", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/rapidnj", + "Galaxy wrapper version": "2.3.2", + "Conda id": "rapidnj", + "Conda version": "2.3.2" + }, + { + "Galaxy wrapper id": "rasusa", + "Galaxy tool ids": [ + "rasusa" + ], + "Description": "Randomly subsample sequencing reads to a specified coverage", + "bio.tool id": "rasusa", + "bio.tool ids": [ + "rasusa" + ], + "biii": null, + "bio.tool name": "rasusa", + "bio.tool description": "Produces an unbiased subsample of your reads", + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/mbhall88/rasusa", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "rasusa", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/rasusa", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/rasusa", + "Galaxy wrapper version": "0.8.0", + "Conda id": "rasusa", + "Conda version": "2.0.0" + }, + { + "Galaxy wrapper id": "raven", + "Galaxy tool ids": [ + "raven" + ], + "Description": "Raven is a de novo genome assembler for long uncorrected reads.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/lbcb-sci/raven", + "ToolShed categories": [ + "Assembly" + ], + "ToolShed id": null, + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/raven", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/raven", + "Galaxy wrapper version": "1.8.3", + "Conda id": "raven-assembler", + "Conda version": "1.8.3" + }, + { + "Galaxy wrapper id": "raxml", + "Galaxy tool ids": [ + "raxml" + ], + "Description": "RAxML - A Maximum Likelihood based phylogenetic inference", + "bio.tool id": "raxml", + "bio.tool ids": [ + "raxml" + ], + "biii": null, + "bio.tool name": "RAxML", + "bio.tool description": "A tool for Phylogenetic Analysis and Post-Analysis of Large Phylogenies.", + "EDAM operation": [ + "Sequence analysis", + "Phylogenetic tree analysis" + ], + "EDAM topic": [ + "Phylogenetics", + "Sequence analysis" + ], + "Status": "To update", + "Source": "http://www.exelixis-lab.org/web/software/raxml/", + "ToolShed categories": [ + "Phylogenetics" + ], + "ToolShed id": "raxml", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/raxml", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/raxml", + "Galaxy wrapper version": "8.2.12", + "Conda id": "raxml", + "Conda version": "8.2.13" + }, + { + "Galaxy wrapper id": "rcorrector", + "Galaxy tool ids": [ + "rcorrector" + ], + "Description": "Rcorrector (RNA-seq error CORRECTOR) is a kmer-based error correction method for RNA-seq data.", + "bio.tool id": "rcorrector", + "bio.tool ids": [ + "rcorrector" + ], + "biii": null, + "bio.tool name": "Rcorrector", + "bio.tool description": "This is a kmer-based error correction method for RNA-seq data. It can also be applied to other types of sequencing data where the read coverage is non-uniform, such as single-cell sequencing.", + "EDAM operation": [ + "Sequencing error detection" + ], + "EDAM topic": [ + "RNA", + "RNA-Seq", + "Sequencing" + ], + "Status": "To update", + "Source": "https://github.com/mourisl/Rcorrector", + "ToolShed categories": [ + "Fastq Manipulation" + ], + "ToolShed id": "rcorrector", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/rcorrector", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/rcorrector", + "Galaxy wrapper version": "1.0.3+galaxy1", + "Conda id": "rcorrector", + "Conda version": "1.0.7" + }, + { + "Galaxy wrapper id": "read_it_and_keep", + "Galaxy tool ids": [ + "read_it_and_keep" + ], + "Description": "Rapid decontamination of SARS-CoV-2 sequencing reads", + "bio.tool id": "read_it_and_keep", + "bio.tool ids": [ + "read_it_and_keep" + ], + "biii": null, + "bio.tool name": "read_it_and_keep", + "bio.tool description": "Read contamination removal", + "EDAM operation": [ + "Filtering", + "Genome alignment" + ], + "EDAM topic": [ + "Pathology", + "Genomics" + ], + "Status": "To update", + "Source": "https://github.com/GenomePathogenAnalysisService/read-it-and-keep", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "read_it_and_keep", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/read-it-and-keep", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/read_it_and_keep", + "Galaxy wrapper version": "0.2.2", + "Conda id": "read-it-and-keep", + "Conda version": "0.3.0" + }, + { + "Galaxy wrapper id": "recentrifuge", + "Galaxy tool ids": [ + "recentrifuge" + ], + "Description": "\"With Recentrifuge, researchers can analyze results from taxonomic classifiers using interactive charts with emphasis on the confidence level of the classifications.In addition to contamination-subtracted samples.Recentrifuge provides shared and exclusive taxa per sample,thus enabling robust contamination removal and comparative analysis in environmental and clinical metagenomics.\"", + "bio.tool id": "Recentrifuge", + "bio.tool ids": [ + "Recentrifuge" + ], + "biii": null, + "bio.tool name": "Recentrifuge", + "bio.tool description": "Robust comparative analysis and contamination removal for metagenomics.", + "EDAM operation": [ + "Taxonomic classification", + "Expression analysis", + "Cross-assembly" + ], + "EDAM topic": [ + "Metagenomics", + "Microbial ecology", + "Metagenomic sequencing" + ], + "Status": "Up-to-date", + "Source": "https://github.com/khyox/recentrifuge", + "ToolShed categories": [ + "Metagenomics" + ], + "ToolShed id": "recentrifuge", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/blob/master/tools/recentrifuge", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/recentrifuge", + "Galaxy wrapper version": "1.14.0", + "Conda id": "recentrifuge", + "Conda version": "1.14.0" + }, + { + "Galaxy wrapper id": "red", + "Galaxy tool ids": [ + "red" + ], + "Description": "Red (REpeat Detector)", + "bio.tool id": "red", + "bio.tool ids": [ + "red" + ], + "biii": null, + "bio.tool name": "RED", + "bio.tool description": "This is a program to detect and visualize RNA editing events at genomic scale using next-generation sequencing data.", + "EDAM operation": [ + "RNA-Seq analysis", + "Editing" + ], + "EDAM topic": [ + "RNA", + "Sequencing", + "Data visualisation" + ], + "Status": "Up-to-date", + "Source": "https://github.com/BioinformaticsToolsmith/Red", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "red", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/red", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/red", + "Galaxy wrapper version": "2018.09.10", + "Conda id": "red", + "Conda version": "2018.09.10" + }, + { + "Galaxy wrapper id": "repeatmasker", + "Galaxy tool ids": [ + "repeatmasker_wrapper" + ], + "Description": "RepeatMasker is a program that screens DNA sequences for interspersed repeats and low complexity DNA sequences.", + "bio.tool id": "repeatmasker", + "bio.tool ids": [ + "repeatmasker" + ], + "biii": null, + "bio.tool name": "RepeatMasker", + "bio.tool description": "A program that screens DNA sequences for interspersed repeats and low complexity DNA sequences. The output of the program is a detailed annotation of the repeats that are present in the query sequence as well as a modified version of the query sequence in which all the annotated repeats have been masked (default: replaced by Ns).", + "EDAM operation": [ + "Genome annotation" + ], + "EDAM topic": [ + "Sequence analysis", + "Sequence composition, complexity and repeats" + ], + "Status": "Up-to-date", + "Source": "http://www.repeatmasker.org/", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "repeat_masker", + "Galaxy wrapper owner": "bgruening", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/repeatmasker", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/repeatmasker", + "Galaxy wrapper version": "4.1.5", + "Conda id": "repeatmasker", + "Conda version": "4.1.5" + }, + { + "Galaxy wrapper id": "repeatmodeler", + "Galaxy tool ids": [ + "repeatmodeler" + ], + "Description": "RepeatModeler - Model repetitive DNA", + "bio.tool id": "repeatmodeler", + "bio.tool ids": [ + "repeatmodeler" + ], + "biii": null, + "bio.tool name": "RepeatModeler", + "bio.tool description": "De-novo repeat family identification and modeling package. At the heart of RepeatModeler are two de-novo repeat finding programs ( RECON and RepeatScout ) which employ complementary computational methods for identifying repeat element boundaries and family relationships from sequence data. RepeatModeler assists in automating the runs of RECON and RepeatScout given a genomic database and uses the output to build, refine and classify consensus models of putative interspersed repeats.", + "EDAM operation": [ + "Repeat sequence detection" + ], + "EDAM topic": [ + "Sequence composition, complexity and repeats", + "Sequence composition, complexity and repeats" + ], + "Status": "To update", + "Source": "https://www.repeatmasker.org/RepeatModeler/", + "ToolShed categories": [ + "Genome annotation" + ], + "ToolShed id": "repeatmodeler", + "Galaxy wrapper owner": "csbl", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/repeatmodeler", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/repeatmodeler", + "Galaxy wrapper version": "2.0.5", + "Conda id": null, + "Conda version": null + }, + { + "Galaxy wrapper id": "repmatch_gff3", + "Galaxy tool ids": [ + "repmatch_gff3" + ], + "Description": "Contains a tool that matches corresponding peak-pair midpoints from separate datasets based onuser-defined criteria.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": null, + "ToolShed categories": [ + "ChIP-seq" + ], + "ToolShed id": "repmatch_gff3", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/repmatch_gff3", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/repmatch_gff3", + "Galaxy wrapper version": null, + "Conda id": "matplotlib", + "Conda version": null + }, + { + "Galaxy wrapper id": "reshape2", + "Galaxy tool ids": [ + "cast", + "melt" + ], + "Description": "Flexibly restructure and aggregate data using just the two functions melt and dcast", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://cran.r-project.org/web/packages/reshape2/index.html", + "ToolShed categories": [ + "Text Manipulation" + ], + "ToolShed id": null, + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/reshape2", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/reshape2", + "Galaxy wrapper version": "1.4.2", + "Conda id": "r-reshape2", + "Conda version": null + }, + { + "Galaxy wrapper id": "resize_coordinate_window", + "Galaxy tool ids": [ + "resize_coordinate_window" + ], + "Description": "Contains a tool that modifies the start and stop coordinates of GFF data, expanding the coordinate windowby a specified size.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": null, + "ToolShed categories": [ + "Genomic Interval Operations" + ], + "ToolShed id": "resize_coordinate_window", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/resize_coordinate_window", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/resize_coordinate_window", + "Galaxy wrapper version": "1.0.2", + "Conda id": "python", + "Conda version": null + }, + { + "Galaxy wrapper id": "revoluzer", + "Galaxy tool ids": [ + "revoluzer_crex", + "revoluzer_distmat" + ], + "Description": "revoluzer wrappers", + "bio.tool id": "revoluzer", + "bio.tool ids": [ + "revoluzer" + ], + "biii": null, + "bio.tool name": "revoluzer", + "bio.tool description": "Various tools for genome rearrangement analysis. CREx, TreeREx, etc", + "EDAM operation": [ + "Structural variation detection" + ], + "EDAM topic": [ + "Molecular evolution", + "Phylogeny" + ], + "Status": "Up-to-date", + "Source": "https://gitlab.com/Bernt/revoluzer/", + "ToolShed categories": [ + "Phylogenetics" + ], + "ToolShed id": "revoluzer", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/revoluzer", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/revoluzer", + "Galaxy wrapper version": "0.1.6", + "Conda id": "revoluzer", + "Conda version": "0.1.6" + }, + { + "Galaxy wrapper id": "rgcca", + "Galaxy tool ids": [ + "rgcca" + ], + "Description": "multi-block analysis", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/rgcca-factory/RGCCA", + "ToolShed categories": [ + "Statistics" + ], + "ToolShed id": "rgcca", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/rgcca", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/rgcca", + "Galaxy wrapper version": "3.0.2", + "Conda id": "rgccacmd", + "Conda version": "3.0.3" + }, + { + "Galaxy wrapper id": "rgrnastar", + "Galaxy tool ids": [ + "rna_star", + "rna_starsolo" + ], + "Description": "RNA STAR is an ultra fast universal RNA and scRNA-seq aligner and mapper", + "bio.tool id": "star", + "bio.tool ids": [ + "star" + ], + "biii": null, + "bio.tool name": "STAR", + "bio.tool description": "Ultrafast universal RNA-seq data aligner", + "EDAM operation": [ + "Sequence alignment" + ], + "EDAM topic": [ + "RNA-Seq", + "Transcriptomics" + ], + "Status": "To update", + "Source": "https://github.com/alexdobin/STAR", + "ToolShed categories": [ + "Next Gen Mappers", + "Transcriptomics" + ], + "ToolShed id": "rgrnastar", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/rgrnastar", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/rgrnastar", + "Galaxy wrapper version": "2.7.11a", + "Conda id": "star", + "Conda version": "2.7.11b" + }, + { + "Galaxy wrapper id": "ribowaltz", + "Galaxy tool ids": [ + "ribowaltz_process", + "ribowaltz_plot" + ], + "Description": "Calculation of optimal P-site offsets, diagnostic analysis and visual inspection of ribosome profiling data", + "bio.tool id": "riboWaltz", + "bio.tool ids": [ + "riboWaltz" + ], + "biii": null, + "bio.tool name": "riboWaltz", + "bio.tool description": "riboWaltz is an R package for calculation of optimal P-site offsets, diagnostic analysis and visual inspection of ribosome profiling data.", + "EDAM operation": [], + "EDAM topic": [ + "Computational biology" + ], + "Status": "To update", + "Source": "https://github.com/LabTranslationalArchitectomics/riboWaltz", + "ToolShed categories": [ + "Transcriptomics", + "RNA" + ], + "ToolShed id": null, + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/ribowaltz", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/ribowaltz", + "Galaxy wrapper version": "1.2.0", + "Conda id": "ribowaltz", + "Conda version": "2.0" + }, + { + "Galaxy wrapper id": "rnaquast", + "Galaxy tool ids": [ + "rna_quast" + ], + "Description": "rnaQuast (RNA Quality Assessment Tool) evaluates genome assemblies.", + "bio.tool id": "rnaQUAST", + "bio.tool ids": [ + "rnaQUAST" + ], + "biii": null, + "bio.tool name": "rnaQUAST", + "bio.tool description": "Quality assessment tool for de novo transcriptome assemblies.", + "EDAM operation": [ + "De-novo assembly", + "Transcriptome assembly", + "Sequence assembly validation" + ], + "EDAM topic": [ + "Sequence assembly", + "Transcriptomics", + "RNA-seq" + ], + "Status": "Up-to-date", + "Source": "https://github.com/ablab/rnaquast", + "ToolShed categories": [ + "Assembly", + "RNA" + ], + "ToolShed id": "rnaquast", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://git.ufz.de/lehmanju/rnaquast", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/rnaquast", + "Galaxy wrapper version": "2.2.3", + "Conda id": "rnaquast", + "Conda version": "2.2.3" + }, + { + "Galaxy wrapper id": "roary", + "Galaxy tool ids": [ + "roary" + ], + "Description": "Roary the pangenome pipeline", + "bio.tool id": "roary", + "bio.tool ids": [ + "roary" + ], + "biii": null, + "bio.tool name": "Roary", + "bio.tool description": "A high speed stand alone pan genome pipeline, which takes annotated assemblies in GFF3 format (produced by Prokka (Seemann, 2014)) and calculates the pan genome.", + "EDAM operation": [ + "Genome assembly" + ], + "EDAM topic": [ + "DNA", + "Genomics", + "Mapping" + ], + "Status": "Up-to-date", + "Source": "https://sanger-pathogens.github.io/Roary/", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "roary", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/roary", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/roary", + "Galaxy wrapper version": "3.13.0", + "Conda id": "roary", + "Conda version": "3.13.0" + }, + { + "Galaxy wrapper id": "rp2biosensor", + "Galaxy tool ids": [ + "rp2biosensor" + ], + "Description": "Build Sensing-Enabling Metabolic Pathways from RetroPath2.0 output", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/brsynth/rp2biosensor", + "ToolShed categories": [ + "Synthetic Biology" + ], + "ToolShed id": "rp2biosensor", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/rp2biosensor", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/rp2biosensor", + "Galaxy wrapper version": "3.2.1", + "Conda id": "rp2biosensor", + "Conda version": null + }, + { + "Galaxy wrapper id": "rp2paths", + "Galaxy tool ids": [ + "rp2paths" + ], + "Description": "Enumerate and seperate the different pathways generated by RetroPath2.0", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/brsynth/rp2paths", + "ToolShed categories": [ + "Synthetic Biology" + ], + "ToolShed id": "rp2paths", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/rp2paths", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/rp2paths", + "Galaxy wrapper version": "1.5.1", + "Conda id": "rp2paths", + "Conda version": null + }, + { + "Galaxy wrapper id": "rpbasicdesign", + "Galaxy tool ids": [ + "rpbasicdesign" + ], + "Description": "Extracting enzyme IDs from rpSBML files", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/brsynth/rpbasicdesign", + "ToolShed categories": [ + "Synthetic Biology" + ], + "ToolShed id": "rpbasicdesign", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/rpbasicdesign", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/rpbasicdesign", + "Galaxy wrapper version": "1.2.2", + "Conda id": "rpbasicdesign", + "Conda version": null + }, + { + "Galaxy wrapper id": "rpfba", + "Galaxy tool ids": [ + "rpfba" + ], + "Description": "Perform FBA for the RetroPath2.0 heterologous pathways", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/brsynth/rptools/releases", + "ToolShed categories": [ + "Synthetic Biology" + ], + "ToolShed id": "rpfba", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/rpfba", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/rpfba", + "Galaxy wrapper version": "5.12.3", + "Conda id": "rptools", + "Conda version": null + }, + { + "Galaxy wrapper id": "rptools", + "Galaxy tool ids": [ + "rptools_rpextractsink", + "rptools_rpfba", + "rptools_rpranker", + "rptools_rpreport", + "rptools_rpviz" + ], + "Description": "Suite of tools that work on rpSBML format", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/brsynth/rptools", + "ToolShed categories": [ + "Synthetic Biology" + ], + "ToolShed id": "rptools", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/rptools", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/rptools", + "Galaxy wrapper version": "5.13.1", + "Conda id": "rptools", + "Conda version": null + }, + { + "Galaxy wrapper id": "rrparser", + "Galaxy tool ids": [ + "rrparser" + ], + "Description": "Reaction Rules Parser", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/brsynth/RRParser", + "ToolShed categories": [ + "Synthetic Biology" + ], + "ToolShed id": "rrparser", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/rrparser", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/rrparser", + "Galaxy wrapper version": "2.5.2", + "Conda id": "rrparser", + "Conda version": null + }, + { + "Galaxy wrapper id": "rseqc", + "Galaxy tool ids": [ + "rseqc_FPKM_count", + "rseqc_RNA_fragment_size", + "rseqc_RPKM_saturation", + "rseqc_bam2wig", + "rseqc_bam_stat", + "rseqc_clipping_profile", + "rseqc_deletion_profile", + "rseqc_geneBody_coverage", + "rseqc_geneBody_coverage2", + "rseqc_infer_experiment", + "rseqc_inner_distance", + "rseqc_insertion_profile", + "rseqc_junction_annotation", + "rseqc_junction_saturation", + "rseqc_mismatch_profile", + "rseqc_read_GC", + "rseqc_read_NVC", + "rseqc_read_distribution", + "rseqc_read_duplication", + "rseqc_read_hexamer", + "rseqc_read_quality", + "rseqc_tin" + ], + "Description": "an RNA-seq quality control package", + "bio.tool id": "rseqc", + "bio.tool ids": [ + "rseqc" + ], + "biii": null, + "bio.tool name": "RSeQC", + "bio.tool description": "Provides a number of useful modules that can comprehensively evaluate high throughput sequence data especially RNA-seq data. Some basic modules quickly inspect sequence quality, nucleotide composition bias, PCR bias and GC bias, while RNA-seq specific modules evaluate sequencing saturation, mapped reads distribution, coverage uniformity, strand specificity, transcript level RNA integrity etc.", + "EDAM operation": [ + "Data handling" + ], + "EDAM topic": [ + "Sequencing" + ], + "Status": "Up-to-date", + "Source": "https://code.google.com/p/rseqc/", + "ToolShed categories": [ + "Convert Formats", + "Sequence Analysis", + "RNA", + "Transcriptomics", + "Visualization" + ], + "ToolShed id": "rseqc", + "Galaxy wrapper owner": "nilesh", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/rseqc", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/rseqc", + "Galaxy wrapper version": "5.0.3", + "Conda id": "rseqc", + "Conda version": "5.0.3" + }, + { + "Galaxy wrapper id": "ruvseq", + "Galaxy tool ids": [ + "ruvseq" + ], + "Description": "Remove Unwanted Variation from RNA-Seq Data", + "bio.tool id": "ruvseq", + "bio.tool ids": [ + "ruvseq" + ], + "biii": null, + "bio.tool name": "RUVSeq", + "bio.tool description": "This package implements the remove unwanted variation (RUV) methods for the normalization of RNA-Seq read counts between samples.", + "EDAM operation": [ + "Differential gene expression analysis" + ], + "EDAM topic": [ + "Gene expression", + "RNA-seq" + ], + "Status": "To update", + "Source": "https://www.bioconductor.org/packages/release/bioc/html/DESeq2.html", + "ToolShed categories": [ + "Transcriptomics", + "RNA", + "Statistics" + ], + "ToolShed id": "ruvseq", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/ruvseq", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/ruvseq", + "Galaxy wrapper version": "1.26.0", + "Conda id": "bioconductor-ruvseq", + "Conda version": "1.36.0" + }, + { + "Galaxy wrapper id": "salsa2", + "Galaxy tool ids": [ + "salsa" + ], + "Description": "A tool to scaffold long read assemblies with Hi-C", + "bio.tool id": "SALSA", + "bio.tool ids": [ + "SALSA" + ], + "biii": null, + "bio.tool name": "SALSA", + "bio.tool description": "> VERY_LOW CONFIDENCE! | > CORRECT NAME OF TOOL COULD ALSO BE 'chromosome-scale', 'reference-quality', 'Hi-C', 'scaffolder' | Integrating Hi-C links with assembly graphs for chromosome-scale assembly | SALSA: A tool to scaffold long read assemblies with Hi-C data | SALSA: A tool to scaffold long read assemblies with Hi-C | This code is used to scaffold your assemblies using Hi-C data. This version implements some improvements in the original SALSA algorithm. If you want to use the old version, it can be found in the old_salsa branch", + "EDAM operation": [ + "Genome assembly", + "De-novo assembly", + "Scaffolding" + ], + "EDAM topic": [ + "Sequence assembly", + "DNA binding sites", + "Mapping" + ], + "Status": "Up-to-date", + "Source": "https://github.com/marbl/SALSA", + "ToolShed categories": [ + "Assembly" + ], + "ToolShed id": "salsa", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/salsa2", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/salsa2", + "Galaxy wrapper version": "2.3", + "Conda id": "salsa2", + "Conda version": "2.3" + }, + { + "Galaxy wrapper id": "samblaster", + "Galaxy tool ids": [ + "samblaster" + ], + "Description": "samblaster marks duplicates and can output split and discordant alignments from SAM/BAM files", + "bio.tool id": "samblaster", + "bio.tool ids": [ + "samblaster" + ], + "biii": null, + "bio.tool name": "SAMBLASTER", + "bio.tool description": "A tool to mark duplicates and extract discordant and split reads from SAM files.", + "EDAM operation": [ + "Split read mapping" + ], + "EDAM topic": [ + "DNA", + "Sequencing", + "Mapping" + ], + "Status": "To update", + "Source": "https://github.com/GregoryFaust/samblaster", + "ToolShed categories": [ + "SAM", + "Fastq Manipulation", + "Variant Analysis" + ], + "ToolShed id": "samblaster", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/samblaster", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/samblaster", + "Galaxy wrapper version": "0.1.24", + "Conda id": "samblaster", + "Conda version": "0.1.26" + }, + { + "Galaxy wrapper id": "sansa", + "Galaxy tool ids": [ + "sansa_annotate" + ], + "Description": "Sansa is a tool for structural variant annotation.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/dellytools/sansa", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "sansa", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/sansa", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/sansa", + "Galaxy wrapper version": "0.2.1", + "Conda id": "sansa", + "Conda version": "0.2.1" + }, + { + "Galaxy wrapper id": "sarscov2formatter", + "Galaxy tool ids": [ + "sarscov2formatter" + ], + "Description": "sarscov2formatter custom script", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/nickeener/sarscov2formatter", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "sarscov2formatter", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/sarscov2formatter", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/sarscov2formatter", + "Galaxy wrapper version": "1.0", + "Conda id": "sarscov2formatter", + "Conda version": "1.0" + }, + { + "Galaxy wrapper id": "sarscov2summary", + "Galaxy tool ids": [ + "sarscov2summary" + ], + "Description": "sarscov2summary custom script", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/nickeener/sarscov2summary", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "sarscov2summary", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/sarscov2summary", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/sarscov2summary", + "Galaxy wrapper version": "0.1", + "Conda id": "sarscov2summary", + "Conda version": "0.5" + }, + { + "Galaxy wrapper id": "sbml2sbol", + "Galaxy tool ids": [ + "sbml2sbol" + ], + "Description": "Convert SBML to SBOL format", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/neilswainston/SbmlToSbol", + "ToolShed categories": [ + "Synthetic Biology" + ], + "ToolShed id": "sbml2sbol", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": null, + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/sbml2sbol", + "Galaxy wrapper version": "0.1.13", + "Conda id": "sbml2sbol", + "Conda version": null + }, + { + "Galaxy wrapper id": "scanpy", + "Galaxy tool ids": [ + "scanpy_cluster_reduce_dimension", + "scanpy_filter", + "scanpy_inspect", + "scanpy_normalize", + "scanpy_plot", + "scanpy_remove_confounders" + ], + "Description": "Scanpy \u2013 Single-Cell Analysis in Python", + "bio.tool id": "scanpy", + "bio.tool ids": [ + "scanpy" + ], + "biii": null, + "bio.tool name": "SCANPY", + "bio.tool description": "Scalable toolkit for analyzing single-cell gene expression data. It includes preprocessing, visualization, clustering, pseudotime and trajectory inference and differential expression testing. The Python-based implementation efficiently deals with datasets of more than one million cells.", + "EDAM operation": [ + "Differential gene expression analysis" + ], + "EDAM topic": [ + "Gene expression", + "Cell biology", + "Genetics" + ], + "Status": "To update", + "Source": "https://scanpy.readthedocs.io", + "ToolShed categories": [ + "Transcriptomics", + "Sequence Analysis" + ], + "ToolShed id": "scanpy", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/scanpy/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/scanpy", + "Galaxy wrapper version": "1.9.6", + "Conda id": "scanpy", + "Conda version": "1.7.2" + }, + { + "Galaxy wrapper id": "scater", + "Galaxy tool ids": [ + "scater_create_qcmetric_ready_sce", + "scater_filter", + "scater_plot_dist_scatter", + "scater_plot_pca", + "scater_plot_tsne" + ], + "Description": "Scater (Single-Cell Analysis Toolkit for gene Expression data in R) is acollection of tools for doing various analyses of single-cell RNA-seq geneexpression data, with a focus on quality control and visualization.", + "bio.tool id": "scater", + "bio.tool ids": [ + "scater" + ], + "biii": null, + "bio.tool name": "scater", + "bio.tool description": "Pre-processing, quality control, normalization and visualization of single-cell RNA-seq data.", + "EDAM operation": [ + "Read pre-processing", + "Sequencing quality control", + "Sequence visualisation" + ], + "EDAM topic": [ + "RNA-seq", + "Quality affairs", + "Molecular genetics" + ], + "Status": "To update", + "Source": "http://bioconductor.org/packages/scater/", + "ToolShed categories": [ + "Transcriptomics", + "RNA", + "Visualization" + ], + "ToolShed id": null, + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/scater", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/scater", + "Galaxy wrapper version": "1.22.0", + "Conda id": "bioconductor-scater", + "Conda version": "1.30.1" + }, + { + "Galaxy wrapper id": "sceasy", + "Galaxy tool ids": [ + "sceasy_convert" + ], + "Description": "Converter between difference single-cell formats", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/cellgeni/sceasy/", + "ToolShed categories": [ + "Transcriptomics" + ], + "ToolShed id": "sceasy_convert", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/sceasy/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/sceasy", + "Galaxy wrapper version": "0.0.7", + "Conda id": "r-sceasy", + "Conda version": "0.0.7" + }, + { + "Galaxy wrapper id": "schicexplorer", + "Galaxy tool ids": [ + "schicexplorer_schicadjustmatrix", + "schicexplorer_schiccluster", + "schicexplorer_schicclustercompartments", + "schicexplorer_schicclusterminhash", + "schicexplorer_schicclustersvl", + "schicexplorer_schicconsensusmatrices", + "schicexplorer_schiccorrectmatrices", + "schicexplorer_schiccreatebulkmatrix", + "schicexplorer_schicdemultiplex", + "schicexplorer_schicinfo", + "schicexplorer_schicmergematrixbins", + "schicexplorer_schicmergetoscool", + "schicexplorer_schicnormalize", + "schicexplorer_schicplotclusterprofiles", + "schicexplorer_schicplotconsensusmatrices", + "schicexplorer_schicqualitycontrol" + ], + "Description": "scHiCExplorer: Set of programs to process, analyze and visualize scHi-C data.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/joachimwolff/schicexplorer", + "ToolShed categories": [ + "Sequence Analysis", + "Transcriptomics", + "Visualization" + ], + "ToolShed id": "schicexplorer", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/schicexplorer", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/schicexplorer", + "Galaxy wrapper version": "4", + "Conda id": "schicexplorer", + "Conda version": "7" + }, + { + "Galaxy wrapper id": "scikit-bio", + "Galaxy tool ids": [ + "scikit_bio_diversity_beta_diversity" + ], + "Description": "scikit-bio: an open-source, BSD-licensed, python package providing data structures, algorithms, and educational resources for bioinformatics", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "http://scikit-bio.org/", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "scikit_bio", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/scikit_bio", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/scikit-bio", + "Galaxy wrapper version": "0.4.2", + "Conda id": "scikit-bio", + "Conda version": "0.4.2" + }, + { + "Galaxy wrapper id": "scoary", + "Galaxy tool ids": [ + "scoary" + ], + "Description": "Scoary calculates the assocations between all genes in the accessory genome and the traits.", + "bio.tool id": "scoary", + "bio.tool ids": [ + "scoary" + ], + "biii": null, + "bio.tool name": "Scoary", + "bio.tool description": "Pan-genome wide association studies and is designed to take the gene_presence_absence.csv file from Roary as well as a traits file created by the user and calculate the assocations between all genes in the accessory genome (all genes that are present in i genomes where 1 < i < N) and the traits. It reports a list of genes sorted by strength of association per trait.", + "EDAM operation": [ + "Analysis" + ], + "EDAM topic": [ + "Genotype and phenotype", + "Model organisms", + "GWAS study", + "Functional genomics" + ], + "Status": "Up-to-date", + "Source": "https://github.com/AdmiralenOla/Scoary", + "ToolShed categories": [ + "Metagenomics" + ], + "ToolShed id": "scoary", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/scoary", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/scoary", + "Galaxy wrapper version": "1.6.16", + "Conda id": "scoary", + "Conda version": "1.6.16" + }, + { + "Galaxy wrapper id": "scpipe", + "Galaxy tool ids": [ + "scpipe" + ], + "Description": "A flexible preprocessing pipeline for single-cell RNA-sequencing data", + "bio.tool id": "scpipe", + "bio.tool ids": [ + "scpipe" + ], + "biii": null, + "bio.tool name": "scPipe", + "bio.tool description": "A preprocessing pipeline for single cell RNA-seq data that starts from the fastq files and produces a gene count matrix with associated quality control information. It can process fastq data generated by CEL-seq, MARS-seq, Drop-seq, Chromium 10x and SMART-seq protocols.", + "EDAM operation": [ + "Genome annotation", + "Validation", + "Alignment", + "Visualisation" + ], + "EDAM topic": [ + "Gene expression", + "RNA-Seq", + "Sequencing" + ], + "Status": "To update", + "Source": "http://bioconductor.org/packages/release/bioc/html/scPipe.html", + "ToolShed categories": [ + "Transcriptomics", + "RNA", + "Statistics" + ], + "ToolShed id": "scpipe", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/scpipe", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/scpipe", + "Galaxy wrapper version": "1.0.0+galaxy2", + "Conda id": "bioconductor-scpipe", + "Conda version": "2.2.0" + }, + { + "Galaxy wrapper id": "seacr", + "Galaxy tool ids": [ + "seacr" + ], + "Description": "SEACR is intended to call peaks and enriched regions from sparse CUT&RUN or chromatin profiling data in which background is dominated by zeroes.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/FredHutch/SEACR", + "ToolShed categories": [ + "Epigenetics", + "ChIP-seq" + ], + "ToolShed id": "seacr", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/seacr", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/seacr", + "Galaxy wrapper version": "1.3", + "Conda id": "seacr", + "Conda version": "1.3" + }, + { + "Galaxy wrapper id": "selenzy_wrapper", + "Galaxy tool ids": [ + "selenzy_wrapper" + ], + "Description": "Performs enzyme selection from a reaction query.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/brsynth/selenzy-wrapper", + "ToolShed categories": [ + "Synthetic Biology" + ], + "ToolShed id": "selenzy_wrapper", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/selenzy_wrapper", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/selenzy_wrapper", + "Galaxy wrapper version": "0.3.0", + "Conda id": "selenzy_wrapper", + "Conda version": "0.3.0" + }, + { + "Galaxy wrapper id": "semibin", + "Galaxy tool ids": [ + "semibin_bin", + "semibin_concatenate_fasta", + "semibin_generate_cannot_links", + "semibin_generate_sequence_features", + "semibin", + "semibin_train" + ], + "Description": "SemiBin: Semi-supervised Metagenomic Binning Using Siamese Neural Networks", + "bio.tool id": "semibin", + "bio.tool ids": [ + "semibin" + ], + "biii": null, + "bio.tool name": "SemiBin", + "bio.tool description": "Command tool for metagenomic binning with semi-supervised deep learning using information from reference genomes.", + "EDAM operation": [ + "Sequence assembly", + "Read binning" + ], + "EDAM topic": [ + "Metagenomics", + "Machine learning", + "Microbial ecology", + "Sequence assembly" + ], + "Status": "To update", + "Source": "https://semibin.readthedocs.io/en/latest/", + "ToolShed categories": [ + "Metagenomics" + ], + "ToolShed id": "semibin", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/semibin", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/semibin", + "Galaxy wrapper version": "2.0.2", + "Conda id": "semibin", + "Conda version": "2.1.0" + }, + { + "Galaxy wrapper id": "seq2hla", + "Galaxy tool ids": [ + "seq2hla" + ], + "Description": "Precision HLA typing and expression from RNAseq data", + "bio.tool id": "seq2hla", + "bio.tool ids": [ + "seq2hla" + ], + "biii": null, + "bio.tool name": "Seq2HLA", + "bio.tool description": "seq2HLA is a computational tool to determine Human Leukocyte Antigen (HLA) directly from existing and future short RNA-Seq reads. It takes standard RNA-Seq sequence reads in fastq format as input, uses a bowtie index comprising known HLA alleles and outputs the most likely HLA class I and class II types, a p-value for each call, and the expression of each class.", + "EDAM operation": [ + "Read mapping", + "Genetic variation analysis" + ], + "EDAM topic": [ + "Transcriptomics", + "Mapping" + ], + "Status": "Up-to-date", + "Source": "https://github.com/TRON-Bioinformatics/seq2HLA", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "seq2hla", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/seq2hla", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/seq2hla", + "Galaxy wrapper version": "2.3", + "Conda id": "seq2hla", + "Conda version": "2.3" + }, + { + "Galaxy wrapper id": "seqcomplexity", + "Galaxy tool ids": [ + "seqcomplexity" + ], + "Description": "Sequence complexity for raw reads", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/stevenweaver/seqcomplexity", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": null, + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/stephenshank/tools-iuc/tree/seqcomplexity/tools/seqcomplexity/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/seqcomplexity", + "Galaxy wrapper version": "0.1.2", + "Conda id": "seqcomplexity", + "Conda version": "0.1.2" + }, + { + "Galaxy wrapper id": "seqkit", + "Galaxy tool ids": [ + "seqkit_fx2tab", + "seqkit_locate", + "seqkit_sort", + "seqkit_stats", + "seqkit_translate" + ], + "Description": "A cross-platform and ultrafast toolkit for FASTA/Q file manipulation", + "bio.tool id": "seqkit", + "bio.tool ids": [ + "seqkit" + ], + "biii": null, + "bio.tool name": "seqkit", + "bio.tool description": "FASTA and FASTQ are basic and ubiquitous formats for storing nucleotide and protein sequences. Common manipulations of FASTA/Q file include converting, searching, filtering, deduplication, splitting, shuffling, and sampling. Existing tools only implement some of these manipulations, and not particularly efficiently, and some are only available for certain operating systems. Furthermore, the complicated installation process of required packages and running environments can render these programs less user friendly. SeqKit demonstrates competitive performance in execution time and memory usage compared to similar tools. The efficiency and usability of SeqKit enable researchers to rapidly accomplish common FASTA/Q file manipulations.", + "EDAM operation": [ + "DNA transcription", + "Sequence trimming", + "DNA translation", + "Sequence conversion" + ], + "EDAM topic": [ + "Database management", + "Sequence analysis" + ], + "Status": "Up-to-date", + "Source": "https://bioinf.shenwei.me/seqkit/", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "seqkit", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/seqkit", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/seqkit", + "Galaxy wrapper version": "2.8.2", + "Conda id": "seqkit", + "Conda version": "2.8.2" + }, + { + "Galaxy wrapper id": "seqprep", + "Galaxy tool ids": [ + "seqprep" + ], + "Description": "Tool for merging paired-end Illumina reads and trimming adapters.", + "bio.tool id": "seqprep", + "bio.tool ids": [ + "seqprep" + ], + "biii": null, + "bio.tool name": "SeqPrep", + "bio.tool description": "Strips adapters and optionally merges overlapping paired-end (or paired-end contamination in mate-pair libraries) illumina style reads.", + "EDAM operation": [ + "Nucleic acid design" + ], + "EDAM topic": [ + "Genomics", + "Sequence assembly", + "Sequencing", + "Probes and primers" + ], + "Status": "Up-to-date", + "Source": "https://github.com/jstjohn/SeqPrep", + "ToolShed categories": [ + "Fastq Manipulation", + "Sequence Analysis" + ], + "ToolShed id": "seqprep", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/seqprep", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/seqprep", + "Galaxy wrapper version": "1.3.2", + "Conda id": "seqprep", + "Conda version": "1.3.2" + }, + { + "Galaxy wrapper id": "seqsero2", + "Galaxy tool ids": [ + "seqsero2" + ], + "Description": "Salmonella serotype prediction from genome sequencing data", + "bio.tool id": "seqsero2", + "bio.tool ids": [ + "seqsero2" + ], + "biii": null, + "bio.tool name": "SeqSero2", + "bio.tool description": "rapid and improved Salmonella serotype determination using whole genome sequencing data | SeqSero-Salmonella Serotyping by Whole Genome Sequencing | Salmonella Serotyping by Whole Genome Sequencing | Online version: http://www.denglab.info/SeqSero2 | Salmonella serotype prediction from genome sequencing data | Citation: SeqSero, Zhang et al. 2015; SeqSero2, Zhang et al. 2019 | Salmonella serotype derterminants databases | Upon executing the command, a directory named 'SeqSero_result_Time_your_run' will be created. Your result will be stored in 'SeqSero_result.txt' in that directory. And the assembled alleles can also be found in the directory if using \"-m a\" (allele mode)", + "EDAM operation": [ + "Genome indexing", + "Antimicrobial resistance prediction", + "Genome alignment" + ], + "EDAM topic": [ + "Whole genome sequencing", + "Sequence assembly", + "Genomics" + ], + "Status": "Up-to-date", + "Source": "https://github.com/denglab/SeqSero2", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "seqsero2", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/seqsero2", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/seqsero2", + "Galaxy wrapper version": "1.3.1", + "Conda id": "seqsero2", + "Conda version": "1.3.1" + }, + { + "Galaxy wrapper id": "seqtk", + "Galaxy tool ids": [ + "seqtk_comp", + "seqtk_cutN", + "seqtk_dropse", + "seqtk_fqchk", + "seqtk_hety", + "seqtk_listhet", + "seqtk_mergefa", + "seqtk_mergepe", + "seqtk_mutfa", + "seqtk_randbase", + "seqtk_sample", + "seqtk_seq", + "seqtk_subseq", + "seqtk_telo", + "seqtk_trimfq" + ], + "Description": "Toolkit for processing sequences in FASTA/Q formats", + "bio.tool id": "seqtk", + "bio.tool ids": [ + "seqtk" + ], + "biii": null, + "bio.tool name": "seqtk", + "bio.tool description": "A tool for processing sequences in the FASTA or FASTQ format. It parses both FASTA and FASTQ files which can also be optionally compressed by gzip.", + "EDAM operation": [ + "Data handling", + "Sequence file editing" + ], + "EDAM topic": [ + "Data management" + ], + "Status": "Up-to-date", + "Source": "https://github.com/lh3/seqtk", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "seqtk", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/seqtk", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/seqtk", + "Galaxy wrapper version": "1.4", + "Conda id": "seqtk", + "Conda version": "1.4" + }, + { + "Galaxy wrapper id": "seqwish", + "Galaxy tool ids": [ + "seqwish" + ], + "Description": "Alignment to variation graph inducer", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/ekg/seqwish", + "ToolShed categories": [ + "Sequence Analysis", + "Variant Analysis" + ], + "ToolShed id": null, + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/seqwish/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/seqwish", + "Galaxy wrapper version": "0.7.5", + "Conda id": "seqwish", + "Conda version": "0.7.10" + }, + { + "Galaxy wrapper id": "seurat", + "Galaxy tool ids": [ + "seurat" + ], + "Description": "A toolkit for quality control, analysis, and exploration of single cell RNA sequencing data", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/satijalab/seurat", + "ToolShed categories": [ + "Transcriptomics", + "RNA", + "Statistics" + ], + "ToolShed id": "seurat", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/seurat", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/seurat", + "Galaxy wrapper version": "4.3.0.1", + "Conda id": "r-seurat", + "Conda version": "3.0.2" + }, + { + "Galaxy wrapper id": "shasta", + "Galaxy tool ids": [ + "shasta" + ], + "Description": "Fast de novo assembly of long read sequencing data", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/chanzuckerberg/shasta", + "ToolShed categories": [ + "Assembly", + "Nanopore" + ], + "ToolShed id": "shasta", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/shasta", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/shasta", + "Galaxy wrapper version": "0.6.0", + "Conda id": "shasta", + "Conda version": "0.12.0" + }, + { + "Galaxy wrapper id": "shorah", + "Galaxy tool ids": [ + "shorah_amplicon" + ], + "Description": "Reconstruct haplotypes using ShoRAH in amplicon mode", + "bio.tool id": "shorah", + "bio.tool ids": [ + "shorah" + ], + "biii": null, + "bio.tool name": "ShoRAH", + "bio.tool description": "Inference of a population from a set of short reads. The package contains programs that support mapping of reads to a reference genome, correcting sequencing errors by locally clustering reads in small windows of the alignment, reconstructing a minimal set of global haplotypes that explain the reads, and estimating the frequencies of the inferred haplotypes.", + "EDAM operation": [ + "Haplotype mapping", + "Variant calling" + ], + "EDAM topic": [ + "Metagenomics", + "Sequencing", + "Genetics" + ], + "Status": "To update", + "Source": "https://github.com/cbg-ethz/shorah/blob/master/README.md", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "shorah_amplicon", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/shorah", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/shorah", + "Galaxy wrapper version": "1.1.3", + "Conda id": "shorah", + "Conda version": "1.99.2" + }, + { + "Galaxy wrapper id": "shovill", + "Galaxy tool ids": [ + "shovill" + ], + "Description": "Faster de novo assembly pipeline based around Spades", + "bio.tool id": "shovill", + "bio.tool ids": [ + "shovill" + ], + "biii": null, + "bio.tool name": "shovill", + "bio.tool description": "Shovill is a pipeline for assembly of bacterial isolate genomes from Illumina paired-end reads. Shovill uses SPAdes at its core, but alters the steps before and after the primary assembly step to get similar results in less time. Shovill also supports other assemblers like SKESA, Velvet and Megahit, so you can take advantage of the pre- and post-processing the Shovill provides with those too.", + "EDAM operation": [ + "Genome assembly" + ], + "EDAM topic": [ + "Genomics", + "Microbiology", + "Sequence assembly" + ], + "Status": "Up-to-date", + "Source": "https://github.com/tseemann/shovill", + "ToolShed categories": [ + "Assembly" + ], + "ToolShed id": "shovill", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/shovill", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/shovill", + "Galaxy wrapper version": "1.1.0", + "Conda id": "shovill", + "Conda version": "1.1.0" + }, + { + "Galaxy wrapper id": "sickle", + "Galaxy tool ids": [ + "sickle" + ], + "Description": "A windowed adaptive trimming tool for FASTQ files using quality", + "bio.tool id": "sickle", + "bio.tool ids": [ + "sickle" + ], + "biii": null, + "bio.tool name": "sickle", + "bio.tool description": "A tool that uses sliding windows along with quality and length thresholds to determine when quality is sufficiently low to trim the 3'-end of reads and also determines when the quality is sufficiently high enough to trim the 5'-end of reads.", + "EDAM operation": [ + "Sequence trimming" + ], + "EDAM topic": [ + "Data quality management" + ], + "Status": "To update", + "Source": "https://github.com/najoshi/sickle", + "ToolShed categories": [ + "Fastq Manipulation", + "Sequence Analysis" + ], + "ToolShed id": "sickle", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/sickle", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/sickle", + "Galaxy wrapper version": "1.33.2", + "Conda id": "sickle-trim", + "Conda version": "1.33" + }, + { + "Galaxy wrapper id": "simtext", + "Galaxy tool ids": [ + "abstracts_by_pmids", + "pmids_to_pubtator_matrix", + "pubmed_by_queries", + "text_to_wordmatrix" + ], + "Description": "A text mining framework for interactive analysis and visualization of similarities among biomedical entities.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/dlal-group/simtext", + "ToolShed categories": [ + "Text Manipulation" + ], + "ToolShed id": "simtext", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tools/simtext", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/simtext", + "Galaxy wrapper version": "0.0.2", + "Conda id": "r-argparse", + "Conda version": "1.0.1" + }, + { + "Galaxy wrapper id": "sina", + "Galaxy tool ids": [ + "sina" + ], + "Description": "SINA reference based multiple sequence alignment", + "bio.tool id": "sina", + "bio.tool ids": [ + "sina" + ], + "biii": null, + "bio.tool name": "SINA", + "bio.tool description": "Aligns and optionally taxonomically classifies your rRNA gene sequences.Reference based multiple sequence alignment", + "EDAM operation": [ + "Sequence alignment analysis", + "Multiple sequence alignment", + "Taxonomic classification", + "Structure-based sequence alignment" + ], + "EDAM topic": [ + "Sequencing", + "RNA", + "Nucleic acid structure analysis", + "Taxonomy", + "Sequence analysis", + "Taxonomy" + ], + "Status": "Up-to-date", + "Source": "https://sina.readthedocs.io/en/latest/", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "sina", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/sina", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/sina", + "Galaxy wrapper version": "1.7.2", + "Conda id": "sina", + "Conda version": "1.7.2" + }, + { + "Galaxy wrapper id": "sinto", + "Galaxy tool ids": [ + "sinto_barcode", + "sinto_fragments" + ], + "Description": "Sinto single-cell analysis tools", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/timoast/sinto", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": null, + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/sinto", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/sinto", + "Galaxy wrapper version": "0.9.0", + "Conda id": "sinto", + "Conda version": "0.10.1" + }, + { + "Galaxy wrapper id": "slamdunk", + "Galaxy tool ids": [ + "alleyoop", + "slamdunk" + ], + "Description": "Slamdunk maps and quantifies SLAMseq reads", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "http://t-neumann.github.io/slamdunk", + "ToolShed categories": [ + "RNA", + "Transcriptomics", + "Sequence Analysis", + "Next Gen Mappers" + ], + "ToolShed id": "slamdunk", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/slamdunk", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/slamdunk", + "Galaxy wrapper version": "0.4.3", + "Conda id": "slamdunk", + "Conda version": "0.4.3" + }, + { + "Galaxy wrapper id": "sleuth", + "Galaxy tool ids": [ + "sleuth" + ], + "Description": "Sleuth is a program for differential analysis of RNA-Seq data.", + "bio.tool id": "sleuth", + "bio.tool ids": [ + "sleuth" + ], + "biii": null, + "bio.tool name": "sleuth", + "bio.tool description": "A statistical model and software application for RNA-seq differential expression analysis.", + "EDAM operation": [ + "Expression data visualisation", + "Differential gene expression analysis", + "Gene expression profiling", + "Statistical calculation" + ], + "EDAM topic": [ + "RNA-seq", + "Gene expression", + "Statistics and probability" + ], + "Status": "Up-to-date", + "Source": "https://github.com/pachterlab/sleuth", + "ToolShed categories": [ + "Transcriptomics", + "RNA", + "Statistics" + ], + "ToolShed id": "sleuth", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/sleuth", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/sleuth", + "Galaxy wrapper version": "0.30.1", + "Conda id": "r-sleuth", + "Conda version": "0.30.1" + }, + { + "Galaxy wrapper id": "smallgenomeutilities", + "Galaxy tool ids": [ + "smgu_frameshift_deletions_checks" + ], + "Description": "Set of utilities for manipulating small viral genome data.", + "bio.tool id": "v-pipe", + "bio.tool ids": [ + "v-pipe" + ], + "biii": null, + "bio.tool name": "V-pipe", + "bio.tool description": "Bioinformatics pipeline for the analysis of next-generation sequencing data derived from intra-host viral populations.", + "EDAM operation": [ + "Read pre-processing", + "Sequence alignment", + "Genetic variation analysis" + ], + "EDAM topic": [ + "Genomics", + "Population genetics", + "Workflows", + "Virology", + "Sequencing" + ], + "Status": "Up-to-date", + "Source": "https://github.com/cbg-ethz/smallgenomeutilities", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "smallgenomeutilities", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/smallgenomeutilities", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/smallgenomeutilities", + "Galaxy wrapper version": "0.4.1", + "Conda id": "smallgenomeutilities", + "Conda version": "0.4.1" + }, + { + "Galaxy wrapper id": "smudgeplot", + "Galaxy tool ids": [ + "smudgeplot" + ], + "Description": "Inference of ploidy and heterozygosity structure using whole genome sequencing", + "bio.tool id": "smudgeplots", + "bio.tool ids": [ + "smudgeplots" + ], + "biii": null, + "bio.tool name": "Smudgeplots", + "bio.tool description": "Reference-free profiling of polyploid genomes | Inference of ploidy and heterozygosity structure using whole genome sequencing data | Smudgeplots are computed from raw or even better from trimmed reads and show the haplotype structure using heterozygous kmer pairs. For example: | This tool extracts heterozygous kmer pairs from kmer dump files and performs gymnastics with them. We are able to disentangle genome structure by comparing the sum of kmer pair coverages (CovA + CovB) to their relative coverage (CovA / (CovA + CovB)). Such an approach also allows us to analyze obscure genomes with duplications, various ploidy levels, etc | GenomeScope 2.0 and Smudgeplots: Reference-free profiling of polyploid genomes Timothy Rhyker Ranallo-Benavidez, Kamil S. Jaron, Michael C. Schatz bioRxiv 747568; doi: https://doi.org/10.1101/747568", + "EDAM operation": [ + "Sequence trimming", + "Genotyping", + "k-mer counting" + ], + "EDAM topic": [ + "Sequence assembly", + "Genetic variation", + "Mathematics" + ], + "Status": "Up-to-date", + "Source": "https://github.com/KamilSJaron/smudgeplot", + "ToolShed categories": [ + "Assembly" + ], + "ToolShed id": "smudgeplot", + "Galaxy wrapper owner": "galaxy-australia", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/smudgeplot", + "Galaxy wrapper version": "0.2.5", + "Conda id": "smudgeplot", + "Conda version": "0.2.5" + }, + { + "Galaxy wrapper id": "snap", + "Galaxy tool ids": [ + "snap", + "snap_training" + ], + "Description": "SNAP is a general purpose gene finding program suitable for both eukaryotic and prokaryotic genomes.", + "bio.tool id": "snap", + "bio.tool ids": [ + "snap" + ], + "biii": null, + "bio.tool name": "SNAP", + "bio.tool description": "The Semi-HMM-based Nucleic Acid Parser is a gene prediction tool.", + "EDAM operation": [ + "Gene prediction" + ], + "EDAM topic": [ + "DNA", + "DNA polymorphism", + "Genetics" + ], + "Status": "Up-to-date", + "Source": "https://github.com/KorfLab/SNAP", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "snap", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/snap", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/snap", + "Galaxy wrapper version": "2013_11_29", + "Conda id": "snap", + "Conda version": "2013_11_29" + }, + { + "Galaxy wrapper id": "snapatac2", + "Galaxy tool ids": [ + "snapatac2_clustering", + "snapatac2_peaks_and_motif", + "snapatac2_plotting", + "snapatac2_preprocessing" + ], + "Description": "SnapATAC2 \u2013 A Python/Rust package for single-cell epigenomics analysis", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://kzhang.org/SnapATAC2/", + "ToolShed categories": [ + "Epigenetics", + "Sequence Analysis" + ], + "ToolShed id": "snapatac2", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/snapatac2", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/snapatac2", + "Galaxy wrapper version": "2.5.3", + "Conda id": null, + "Conda version": null + }, + { + "Galaxy wrapper id": "sniffles", + "Galaxy tool ids": [ + "sniffles" + ], + "Description": "Galaxy wrapper for sniffles", + "bio.tool id": "sniffles", + "bio.tool ids": [ + "sniffles" + ], + "biii": null, + "bio.tool name": "Sniffles", + "bio.tool description": "An algorithm for structural variation detection from third generation sequencing alignment.", + "EDAM operation": [ + "Sequence analysis", + "Structural variation detection" + ], + "EDAM topic": [ + "DNA structural variation", + "Sequencing" + ], + "Status": "To update", + "Source": "https://github.com/fritzsedlazeck/Sniffles", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "sniffles", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/sniffles", + "Galaxy wrapper version": "1.0.12", + "Conda id": "sniffles", + "Conda version": "2.3.3" + }, + { + "Galaxy wrapper id": "snipit", + "Galaxy tool ids": [ + "snipit" + ], + "Description": "Summarise snps relative to a reference sequence", + "bio.tool id": "snipit", + "bio.tool ids": [ + "snipit" + ], + "biii": null, + "bio.tool name": "snipit", + "bio.tool description": "Summarise snps relative to a reference sequence", + "EDAM operation": [ + "Base position variability plotting" + ], + "EDAM topic": [ + "Virology" + ], + "Status": "Up-to-date", + "Source": "https://github.com/aineniamh/snipit", + "ToolShed categories": [ + "Variant Analysis", + "Sequence Analysis" + ], + "ToolShed id": "snipit", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/snipit", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/snipit", + "Galaxy wrapper version": "1.2", + "Conda id": "snipit", + "Conda version": "1.2" + }, + { + "Galaxy wrapper id": "snippy", + "Galaxy tool ids": [ + "snippy_core", + "snippy", + "snippy_clean_full_aln" + ], + "Description": "Contains the snippy tool for characterising microbial snps", + "bio.tool id": "snippy", + "bio.tool ids": [ + "snippy" + ], + "biii": null, + "bio.tool name": "snippy", + "bio.tool description": "Rapid haploid variant calling and core SNP phylogeny generation.", + "EDAM operation": [ + "Phylogenetic tree visualisation", + "Phylogenetic tree generation", + "Variant calling" + ], + "EDAM topic": [ + "Genomics", + "Model organisms", + "DNA polymorphism", + "Phylogenetics" + ], + "Status": "To update", + "Source": "https://github.com/tseemann/snippy", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "snippy", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/snippy", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/snippy", + "Galaxy wrapper version": null, + "Conda id": "snippy", + "Conda version": "4.6.0" + }, + { + "Galaxy wrapper id": "snp-dists", + "Galaxy tool ids": [ + "snp_dists" + ], + "Description": "Compute pairwise SNP distance matrix from a FASTA sequence alignment", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/tseemann/snp-dists", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "snp_dists", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/snp-dists", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/snp-dists", + "Galaxy wrapper version": "0.8.2", + "Conda id": "snp-dists", + "Conda version": "0.8.2" + }, + { + "Galaxy wrapper id": "snp-sites", + "Galaxy tool ids": [ + "snp_sites" + ], + "Description": "Finds SNP sites from a multi-FASTA alignment file", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/sanger-pathogens/snp-sites", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "snp_sites", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/snp-sites", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/snp-sites", + "Galaxy wrapper version": "2.5.1", + "Conda id": "snp-sites", + "Conda version": "2.5.1" + }, + { + "Galaxy wrapper id": "snpeff-covid19", + "Galaxy tool ids": [ + "snpeff_sars_cov_2" + ], + "Description": "SnpEff, the COVID-19 version, is a genetic variant annotation and effect prediction toolbox", + "bio.tool id": "snpeff", + "bio.tool ids": [ + "snpeff" + ], + "biii": null, + "bio.tool name": "snpEff", + "bio.tool description": "Variant annotation and effect prediction tool. It annotates and predicts the effects of variants on genes and proteins (such as amino acid changes).", + "EDAM operation": [ + "SNP detection" + ], + "EDAM topic": [ + "DNA polymorphism", + "Genetic variation", + "Nucleic acid sites, features and motifs" + ], + "Status": "To update", + "Source": "http://snpeff.sourceforge.net/", + "ToolShed categories": [ + "Genome-Wide Association Study", + "Variant Analysis" + ], + "ToolShed id": "snpeff_sars_cov_2", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/snpeff", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/snpeff-covid19", + "Galaxy wrapper version": null, + "Conda id": null, + "Conda version": null + }, + { + "Galaxy wrapper id": "snpfreqplot", + "Galaxy tool ids": [ + "snpfreqplot" + ], + "Description": "Generates a heatmap of allele frequencies grouped by variant type for SARS-CoV-2 data", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/snpfreqplot/", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "snpfreqplot", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/snpfreqplot/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/snpfreqplot", + "Galaxy wrapper version": "1.0", + "Conda id": "r-base", + "Conda version": null + }, + { + "Galaxy wrapper id": "socru", + "Galaxy tool ids": [ + "socru" + ], + "Description": "Order and orientation of complete bacterial genomes", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/quadram-institute-bioscience/socru", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "socru", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/socru", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/socru", + "Galaxy wrapper version": "2.1.7", + "Conda id": "socru", + "Conda version": "2.2.4" + }, + { + "Galaxy wrapper id": "sonneityping", + "Galaxy tool ids": [ + "sonneityping" + ], + "Description": "Scripts for parsing Mykrobe predict results for Shigella sonnei.", + "bio.tool id": "sonneityping", + "bio.tool ids": [ + "sonneityping" + ], + "biii": null, + "bio.tool name": "sonneityping", + "bio.tool description": "Scripts for parsing Mykrobe predict results for Shigella sonnei.", + "EDAM operation": [ + "Antimicrobial resistance prediction", + "Variant calling", + "Genotyping" + ], + "EDAM topic": [ + "Whole genome sequencing", + "Genotype and phenotype", + "Genetic variation", + "Metagenomics" + ], + "Status": "Up-to-date", + "Source": "https://github.com/katholt/sonneityping", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "sonneityping", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/katholt/sonneityping", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/sonneityping", + "Galaxy wrapper version": "20210201", + "Conda id": "sonneityping", + "Conda version": "20210201" + }, + { + "Galaxy wrapper id": "spades", + "Galaxy tool ids": [ + "spades_biosyntheticspades", + "spades_coronaspades", + "spades_metaplasmidspades", + "metaspades", + "spades_metaviralspades", + "spades_plasmidspades", + "rnaspades", + "spades_rnaviralspades", + "spades" + ], + "Description": "SPAdes is an assembly toolkit containing various assembly pipelines. It implements the following 4 stages: assembly graph construction, k-bimer adjustment, construction of paired assembly graph and contig construction.", + "bio.tool id": "spades", + "bio.tool ids": [ + "coronaspades", + "biosyntheticspades", + "metaviralspades", + "metaspades", + "rnaspades", + "rnaviralspades", + "spades", + "plasmidspades", + "metaplasmidspades" + ], + "biii": null, + "bio.tool name": "SPAdes", + "bio.tool description": "St. Petersburg genome assembler \u2013 is intended for both standard isolates and single-cell MDA bacteria assemblies. SPAdes 3.9 works with Illumina or IonTorrent reads and is capable of providing hybrid assemblies using PacBio, Oxford Nanopore and Sanger reads. Additional contigs can be provided and can be used as long reads.", + "EDAM operation": [ + "Genome assembly" + ], + "EDAM topic": [ + "Sequence assembly" + ], + "Status": "Up-to-date", + "Source": "https://github.com/ablab/spades", + "ToolShed categories": [ + "Assembly", + "RNA", + "Metagenomics" + ], + "ToolShed id": "spades", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/spades", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/spades", + "Galaxy wrapper version": "3.15.5", + "Conda id": "spades", + "Conda version": "3.15.5" + }, + { + "Galaxy wrapper id": "spaln", + "Galaxy tool ids": [ + "list_spaln_tables", + "spaln" + ], + "Description": "Spaln (space-efficient spliced alignment) maps and aligns a set of cDNA or protein sequences onto a whole genomic sequence.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "http://www.genome.ist.i.kyoto-u.ac.jp/~aln_user/spaln/", + "ToolShed categories": [ + "Sequence Analysis", + "Genome annotation" + ], + "ToolShed id": "spaln", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/ogotoh/spaln", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/spaln", + "Galaxy wrapper version": "2.4.9", + "Conda id": "python", + "Conda version": null + }, + { + "Galaxy wrapper id": "spotyping", + "Galaxy tool ids": [ + "spotyping" + ], + "Description": "SpoTyping allows fast and accurate in silico Mycobacterium spoligotyping from sequence reads", + "bio.tool id": "spotyping", + "bio.tool ids": [ + "spotyping" + ], + "biii": null, + "bio.tool name": "SpoTyping", + "bio.tool description": "Fast and accurate in silico Mycobacterium spoligotyping from sequence reads.", + "EDAM operation": [ + "Variant pattern analysis" + ], + "EDAM topic": [ + "Microbiology", + "Sequencing", + "Sequence composition, complexity and repeats", + "Genetic variation" + ], + "Status": "Up-to-date", + "Source": "https://github.com/xiaeryu/SpoTyping-v2.0", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "spotyping", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/xiaeryu/SpoTyping-v2.0/tree/master/SpoTyping-v2.0-commandLine", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/spotyping", + "Galaxy wrapper version": "2.1", + "Conda id": "spotyping", + "Conda version": "2.1" + }, + { + "Galaxy wrapper id": "spyboat", + "Galaxy tool ids": [ + "spyboat" + ], + "Description": "Wavelet analysis for 3d-image stacks", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "http://github.com/tensionhead/spyboat", + "ToolShed categories": [ + "Imaging", + "Graphics" + ], + "ToolShed id": "spyboat", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/packages/spyboat", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/spyboat", + "Galaxy wrapper version": "0.1.2", + "Conda id": "spyboat", + "Conda version": null + }, + { + "Galaxy wrapper id": "sra-tools", + "Galaxy tool ids": [ + "fasterq_dump", + "fastq_dump", + "sam_dump" + ], + "Description": "NCBI Sequence Read Archive toolkit utilities", + "bio.tool id": "sra-tools", + "bio.tool ids": [ + "sra-tools" + ], + "biii": null, + "bio.tool name": "SRA Software Toolkit", + "bio.tool description": "The SRA Toolkit and SDK from NCBI is a collection of tools and libraries for using data in the INSDC Sequence Read Archives.", + "EDAM operation": [ + "Data handling" + ], + "EDAM topic": [ + "DNA", + "Genomics", + "Sequencing" + ], + "Status": "Up-to-date", + "Source": "https://github.com/ncbi/sra-tools", + "ToolShed categories": [ + "Data Source", + "Fastq Manipulation" + ], + "ToolShed id": "sra_tools", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/sra-tools", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/sra-tools", + "Galaxy wrapper version": "3.1.1", + "Conda id": "sra-tools", + "Conda version": "3.1.1" + }, + { + "Galaxy wrapper id": "srst2", + "Galaxy tool ids": [ + "srst2" + ], + "Description": "SRST2 Short Read Sequence Typing for Bacterial Pathogens", + "bio.tool id": "srst2", + "bio.tool ids": [ + "srst2" + ], + "biii": null, + "bio.tool name": "srst2", + "bio.tool description": "Short Read Sequence Typing for Bacterial Pathogens", + "EDAM operation": [ + "Multilocus sequence typing" + ], + "EDAM topic": [ + "Whole genome sequencing", + "Public health and epidemiology" + ], + "Status": "To update", + "Source": "http://katholt.github.io/srst2/", + "ToolShed categories": [ + "Metagenomics" + ], + "ToolShed id": "srst2", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/katholt/srst2", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/srst2", + "Galaxy wrapper version": "0.2.0", + "Conda id": "samtools", + "Conda version": "1.20" + }, + { + "Galaxy wrapper id": "stacks", + "Galaxy tool ids": [ + "stacks_assembleperead", + "stacks_clonefilter", + "stacks_cstacks", + "stacks_denovomap", + "stacks_genotypes", + "stacks_populations", + "stacks_procrad", + "stacks_pstacks", + "stacks_refmap", + "stacks_rxstacks", + "stacks_sstacks", + "stacks_stats", + "stacks_ustacks" + ], + "Description": "Stacks is a software pipeline for building loci from short-read sequences, such as RAD-seq", + "bio.tool id": "stacks", + "bio.tool ids": [ + "stacks" + ], + "biii": null, + "bio.tool name": "Stacks", + "bio.tool description": "Developed to work with restriction enzyme based sequence data, such as RADseq, for building genetic maps and conducting population genomics and phylogeography analysis.", + "EDAM operation": [ + "Data handling" + ], + "EDAM topic": [ + "Mapping", + "Population genetics" + ], + "Status": "To update", + "Source": "http://catchenlab.life.illinois.edu/stacks/", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "stacks", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/stacks", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/stacks", + "Galaxy wrapper version": null, + "Conda id": "stacks", + "Conda version": "2.65" + }, + { + "Galaxy wrapper id": "stacks2", + "Galaxy tool ids": [ + "stacks2_clonefilter", + "stacks2_cstacks", + "stacks2_denovomap", + "stacks2_gstacks", + "stacks2_kmerfilter", + "stacks2_populations", + "stacks2_procrad", + "stacks2_refmap", + "stacks2_shortreads", + "stacks2_sstacks", + "stacks2_tsv2bam", + "stacks2_ustacks" + ], + "Description": "Stacks is a software pipeline for building loci from short-read sequences, such as RAD-seq", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "http://catchenlab.life.illinois.edu/stacks/", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": null, + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/stacks2", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/stacks2", + "Galaxy wrapper version": "2.55", + "Conda id": "stacks", + "Conda version": "2.65" + }, + { + "Galaxy wrapper id": "star_fusion", + "Galaxy tool ids": [ + "star_fusion" + ], + "Description": "STAR Fusion detects fusion genes in RNA-Seq data after running RNA-STAR", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": null, + "ToolShed categories": [ + "Sequence Analysis", + "Transcriptomics" + ], + "ToolShed id": "star_fusion", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/star_fusion", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/star_fusion", + "Galaxy wrapper version": "0.5.4-3+galaxy1", + "Conda id": "star-fusion", + "Conda version": "1.13.0" + }, + { + "Galaxy wrapper id": "straindesign", + "Galaxy tool ids": [ + "straindesign_analyzing_model", + "straindesign_reduce_model", + "straindesign_simulate_deletion" + ], + "Description": "Toolbox to optimize biological model", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/brsynth/straindesign", + "ToolShed categories": [ + "Systems Biology", + "Synthetic Biology" + ], + "ToolShed id": "straindesign", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/brsynth/straindesign", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/straindesign", + "Galaxy wrapper version": "3.2.2", + "Conda id": "straindesign", + "Conda version": "3.2.3" + }, + { + "Galaxy wrapper id": "strelka", + "Galaxy tool ids": [ + "strelka_germline", + "strelka_somatic" + ], + "Description": null, + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/Illumina/strelka/", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "strelka", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/strelka", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/strelka", + "Galaxy wrapper version": "2.9.10", + "Conda id": "strelka", + "Conda version": "2.9.10" + }, + { + "Galaxy wrapper id": "stringtie", + "Galaxy tool ids": [ + "stringtie", + "stringtie_merge" + ], + "Description": "StringTie is a fast and highly efficient assembler of RNA-Seq alignments into potential transcripts.", + "bio.tool id": "stringtie", + "bio.tool ids": [ + "stringtie" + ], + "biii": null, + "bio.tool name": "StringTie", + "bio.tool description": "Fast and highly efficient assembler of RNA-Seq alignments into potential transcripts. It uses a novel network flow algorithm as well as an optional de novo assembly step to assemble and quantitate full-length transcripts representing multiple splice variants for each gene locus.", + "EDAM operation": [ + "Transcriptome assembly", + "RNA-Seq analysis" + ], + "EDAM topic": [ + "Transcriptomics", + "RNA-seq" + ], + "Status": "Up-to-date", + "Source": "http://ccb.jhu.edu/software/stringtie/", + "ToolShed categories": [ + "Transcriptomics" + ], + "ToolShed id": "stringtie", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/stringtie", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/stringtie", + "Galaxy wrapper version": "2.2.3", + "Conda id": "stringtie", + "Conda version": "2.2.3" + }, + { + "Galaxy wrapper id": "structure", + "Galaxy tool ids": [ + "structure" + ], + "Description": "for using multi-locus genotype data to investigate population structure.", + "bio.tool id": "structure", + "bio.tool ids": [ + "structure" + ], + "biii": null, + "bio.tool name": "Structure", + "bio.tool description": "The program structureis a free software package for using multi-locus genotype data to investigate population structure. Its uses include inferring the presence of distinct populations, assigning individuals to populations, studying hybrid zones, identifying migrants and admixed individuals, and estimating population allele frequencies in situations where many individuals are migrants or admixed.", + "EDAM operation": [ + "Genetic variation analysis" + ], + "EDAM topic": [ + "Population genetics" + ], + "Status": "Up-to-date", + "Source": null, + "ToolShed categories": [ + "Phylogenetics", + "Variant Analysis" + ], + "ToolShed id": "structure", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/structure", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/structure", + "Galaxy wrapper version": "2.3.4", + "Conda id": "structure", + "Conda version": "2.3.4" + }, + { + "Galaxy wrapper id": "structureharvester", + "Galaxy tool ids": [ + "structureharvester" + ], + "Description": "for parsing STRUCTURE outputs and for performing the Evanno method", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": null, + "ToolShed categories": [ + "Phylogenetics", + "Variant Analysis" + ], + "ToolShed id": "structureharvester", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/structureharvester", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/structureharvester", + "Galaxy wrapper version": "0.6.94", + "Conda id": "structureharvester", + "Conda version": "0.6.94" + }, + { + "Galaxy wrapper id": "swift", + "Galaxy tool ids": [ + "swiftlink" + ], + "Description": "Parallel MCMC Linkage Analysis", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/ajm/swiftlink", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "swiftlink", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/swiftlink/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/swift", + "Galaxy wrapper version": "1.0", + "Conda id": "swiftlink", + "Conda version": "1.0" + }, + { + "Galaxy wrapper id": "syndiva", + "Galaxy tool ids": [ + "syndiva" + ], + "Description": "SynDivA was developed to analyze the diversity of synthetic libraries of a Fibronectin domain.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": null, + "ToolShed categories": [ + "Proteomics" + ], + "ToolShed id": "syndiva", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/SynDivA", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/syndiva", + "Galaxy wrapper version": "1.0", + "Conda id": "clustalo", + "Conda version": "1.2.4" + }, + { + "Galaxy wrapper id": "table_compute", + "Galaxy tool ids": [ + "table_compute" + ], + "Description": "Perform general-purpose table operations", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": null, + "ToolShed categories": [ + "Text Manipulation" + ], + "ToolShed id": "table_compute", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/table_compute", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/table_compute", + "Galaxy wrapper version": "1.2.4", + "Conda id": "pandas", + "Conda version": null + }, + { + "Galaxy wrapper id": "tag_pileup_frequency", + "Galaxy tool ids": [ + "tag_pileup_frequency" + ], + "Description": "Contains a tool that generates a frequency pileup of the 5' ends of aligned reads in a BAM filerelative to reference points in a BED file.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/seqcode/cegr-tools/tree/master/src/org/seqcode/cegrtools/tagpileup", + "ToolShed categories": [ + "Statistics", + "SAM", + "Genomic Interval Operations" + ], + "ToolShed id": "tag_pileup_frequency", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/tag_pileup_frequency", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/tag_pileup_frequency", + "Galaxy wrapper version": "1.0.2", + "Conda id": "openjdk", + "Conda version": null + }, + { + "Galaxy wrapper id": "tasmanian_mismatch", + "Galaxy tool ids": [ + "tasmanian_mismatch" + ], + "Description": "Analysis of positional mismatches", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": null, + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "tasmanian_mismatch", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/nebiolabs/tasmanian-mismatch", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/tasmanian_mismatch", + "Galaxy wrapper version": "1.0.7", + "Conda id": "tasmanian-mismatch", + "Conda version": "1.0.7" + }, + { + "Galaxy wrapper id": "taxonomy_filter_refseq", + "Galaxy tool ids": [ + "taxonomy_filter_refseq" + ], + "Description": "Filter RefSeq by taxonomy", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/pvanheus/ncbitaxonomy", + "ToolShed categories": [ + "Sequence Analysis", + "Genome annotation" + ], + "ToolShed id": "taxonomy_filter_refseq", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/taxonomy_filter_refseq", + "Galaxy wrapper version": "0.3.0", + "Conda id": "rust-ncbitaxonomy", + "Conda version": "1.0.7" + }, + { + "Galaxy wrapper id": "taxonomy_krona_chart", + "Galaxy tool ids": [ + "taxonomy_krona_chart" + ], + "Description": "Krona pie chart from taxonomic profile", + "bio.tool id": "krona", + "bio.tool ids": [ + "krona" + ], + "biii": null, + "bio.tool name": "Krona", + "bio.tool description": "Krona creates interactive HTML5 charts of hierarchical data (such as taxonomic abundance in a metagenome).", + "EDAM operation": [ + "Visualisation" + ], + "EDAM topic": [ + "Metagenomics" + ], + "Status": "To update", + "Source": "http://sourceforge.net/projects/krona/", + "ToolShed categories": [ + "Assembly" + ], + "ToolShed id": "taxonomy_krona_chart", + "Galaxy wrapper owner": "crs4", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/taxonomy_krona_chart", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/taxonomy_krona_chart", + "Galaxy wrapper version": "2.7.1+galaxy0", + "Conda id": "krona", + "Conda version": "2.8.1" + }, + { + "Galaxy wrapper id": "tb-profiler", + "Galaxy tool ids": [ + "tb_profiler_profile" + ], + "Description": "Processes M. tuberculosis sequence data to infer strain type and identify known drug resistance markers.", + "bio.tool id": "tb-profiler", + "bio.tool ids": [ + "tb-profiler" + ], + "biii": null, + "bio.tool name": "tb-profiler", + "bio.tool description": "A tool for drug resistance prediction from _M. tuberculosis_ genomic data (sequencing reads, alignments or variants).", + "EDAM operation": [ + "Antimicrobial resistance prediction" + ], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/jodyphelan/TBProfiler", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "tbprofiler", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/blob/master/tools/tb-profiler", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/tb-profiler", + "Galaxy wrapper version": "6.2.1", + "Conda id": "tb-profiler", + "Conda version": "6.2.1" + }, + { + "Galaxy wrapper id": "tb_variant_filter", + "Galaxy tool ids": [ + "tb_variant_filter" + ], + "Description": "M. tuberculosis H37Rv VCF filter", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/COMBAT-TB/tb_variant_filter", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "tb_variant_filter", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/COMBAT-TB/tb_variant_filter", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/tb_variant_filter", + "Galaxy wrapper version": "0.4.0", + "Conda id": "tb_variant_filter", + "Conda version": "0.4.0" + }, + { + "Galaxy wrapper id": "tbl2gff3", + "Galaxy tool ids": [ + "tbl2gff3" + ], + "Description": "Table to GFF3", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/tbl2gff3", + "ToolShed categories": [ + "Convert Formats", + "Sequence Analysis" + ], + "ToolShed id": "tbl2gff3", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/tbl2gff3", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/tbl2gff3", + "Galaxy wrapper version": "1.2", + "Conda id": "bcbiogff", + "Conda version": "0.6.6" + }, + { + "Galaxy wrapper id": "tbvcfreport", + "Galaxy tool ids": [ + "tbvcfreport" + ], + "Description": "Generate HTML report from SnpEff M.tuberculosis VCF(s)", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/COMBAT-TB/tbvcfreport", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "tbvcfreport", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/blob/master/tools/tbvcfreport", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/tbvcfreport", + "Galaxy wrapper version": "1.0.0", + "Conda id": "tbvcfreport", + "Conda version": "1.0.0" + }, + { + "Galaxy wrapper id": "te_finder", + "Galaxy tool ids": [ + "te_finder" + ], + "Description": "Transposable element insertions finder", + "bio.tool id": "tefinder", + "bio.tool ids": [ + "tefinder" + ], + "biii": null, + "bio.tool name": "TEfinder", + "bio.tool description": "A Bioinformatics Pipeline for Detecting New Transposable Element Insertion Events in Next-Generation Sequencing Data.A bioinformatics tool for detecting novel transposable element insertions.TEfinder uses discordant reads to detect novel transposable element insertion events in paired-end sample sequencing data.", + "EDAM operation": [ + "Genome indexing", + "Variant calling", + "PCR primer design" + ], + "EDAM topic": [ + "Sequencing", + "Mobile genetic elements", + "Workflows", + "Evolutionary biology", + "Genetic variation" + ], + "Status": "To update", + "Source": "https://github.com/VistaSohrab/TEfinder", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "te_finder", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/te_finder/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/te_finder", + "Galaxy wrapper version": "1.0.1", + "Conda id": "samtools", + "Conda version": "1.20" + }, + { + "Galaxy wrapper id": "telescope", + "Galaxy tool ids": [ + "telescope_assign" + ], + "Description": "Single locus resolution of Transposable ELEment expression.", + "bio.tool id": "Telescope-expression", + "bio.tool ids": [ + "Telescope-expression" + ], + "biii": null, + "bio.tool name": "Telescope", + "bio.tool description": "Telescope is a tool for the characterization of the retrotranscriptome by accurate estimation of transposable element expression and the quantification of transposable element expression using RNA-seq.It can be used for Statistical Performance of TE Quantification Methods.All scripts needed to examine the sensitivity and biases of computational approaches for quantifying TE expression: 1) unique counts, 2) best counts, 3) RepEnrich, 4) TEtranscripts, 5) RSEM, 6) SalmonTE, and 7) Telescope.", + "EDAM operation": [ + "Essential dynamics", + "Sequence trimming", + "RNA-Seq quantification", + "Expression analysis", + "Read mapping" + ], + "EDAM topic": [ + "RNA-Seq", + "Transcriptomics", + "Mapping", + "Gene transcripts", + "Sequence assembly" + ], + "Status": "Up-to-date", + "Source": "https://github.com/mlbendall/telescope/", + "ToolShed categories": [ + "Genome annotation" + ], + "ToolShed id": "telescope_assign", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/telescope", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/telescope", + "Galaxy wrapper version": "1.0.3", + "Conda id": "telescope", + "Conda version": "1.0.3" + }, + { + "Galaxy wrapper id": "tetoolkit", + "Galaxy tool ids": [ + "tetoolkit_tetranscripts" + ], + "Description": "The TEToolkit suite improves the bioinformatic analysis of repetitive sequences, particularly transposable elements, in order to elucidate novel (and previously ignored) biological insights of their functions in development and diseases.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "http://hammelllab.labsites.cshl.edu/software/", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "tetoolkit", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/mhammell-laboratory/TEtranscripts", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/tetoolkit", + "Galaxy wrapper version": "2.2.3", + "Conda id": "tetranscripts", + "Conda version": "2.2.3" + }, + { + "Galaxy wrapper id": "tetyper", + "Galaxy tool ids": [ + "tetyper" + ], + "Description": "Type a specific transposable element (TE) of interest from paired-end sequencing data.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/aesheppard/TETyper", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "tetyper", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/tetyper", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/tetyper", + "Galaxy wrapper version": "1.1", + "Conda id": "tetyper", + "Conda version": "1.1" + }, + { + "Galaxy wrapper id": "tn93", + "Galaxy tool ids": [ + "tn93_readreduce", + "tn93", + "tn93_cluster", + "tn93_filter" + ], + "Description": "Compute distances between sequences", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/veg/tn93/", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "tn93", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/tn93/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/tn93", + "Galaxy wrapper version": "1.0.6", + "Conda id": "tn93", + "Conda version": "1.0.14" + }, + { + "Galaxy wrapper id": "tooldistillator", + "Galaxy tool ids": [ + "tooldistillator", + "tooldistillator_summarize" + ], + "Description": "ToolDistillator extract and aggregate information from different tool outputs to JSON parsable files", + "bio.tool id": "tooldistillator", + "bio.tool ids": [ + "tooldistillator" + ], + "biii": null, + "bio.tool name": "ToolDistillator", + "bio.tool description": "ToolDistillator is a tool to extract information from output files of specific tools, expose it as JSON files, and aggregate over several tools.It can produce both a single file to each tool or a summarized file from a set of reports.", + "EDAM operation": [ + "Data handling", + "Parsing" + ], + "EDAM topic": [ + "Microbiology", + "Bioinformatics", + "Sequence analysis" + ], + "Status": "Up-to-date", + "Source": "https://gitlab.com/ifb-elixirfr/abromics/tooldistillator", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "tooldistillator", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/tooldistillator", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/tooldistillator", + "Galaxy wrapper version": "0.8.5.0", + "Conda id": "tooldistillator", + "Conda version": "0.8.5.0" + }, + { + "Galaxy wrapper id": "tracegroomer", + "Galaxy tool ids": [ + "tracegroomer" + ], + "Description": "TraceGroomer is a solution for formatting and normalising Tracer metabolomics given file(s), to produce the .csv files which are ready for DIMet tool.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/cbib/TraceGroomer", + "ToolShed categories": [ + "Metabolomics" + ], + "ToolShed id": null, + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/Tracegroomer", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/tracegroomer", + "Galaxy wrapper version": "0.1.3", + "Conda id": "tracegroomer", + "Conda version": "0.1.3" + }, + { + "Galaxy wrapper id": "tracy", + "Galaxy tool ids": [ + "tracy_align", + "tracy_assemble", + "tracy_basecall", + "tracy_decompose" + ], + "Description": null, + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": null, + "ToolShed categories": [], + "ToolShed id": null, + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/tracy", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/tracy", + "Galaxy wrapper version": "0.6.1", + "Conda id": "tracy", + "Conda version": "0.7.6" + }, + { + "Galaxy wrapper id": "transdecoder", + "Galaxy tool ids": [ + "transdecoder" + ], + "Description": "TransDecoder finds coding regions within transcripts", + "bio.tool id": "TransDecoder", + "bio.tool ids": [ + "TransDecoder" + ], + "biii": null, + "bio.tool name": "TransDecoder", + "bio.tool description": "TransDecoder identifies candidate coding regions within transcript sequences, such as those generated by de novo RNA-Seq transcript assembly using Trinity, or constructed based on RNA-Seq alignments to the genome using Tophat and Cufflinks.", + "EDAM operation": [ + "Coding region prediction", + "de Novo sequencing", + "De-novo assembly" + ], + "EDAM topic": [ + "Genomics", + "Gene transcripts", + "RNA-Seq", + "Gene expression", + "Sequence assembly", + "Whole genome sequencing" + ], + "Status": "To update", + "Source": "https://transdecoder.github.io/", + "ToolShed categories": [ + "Transcriptomics", + "RNA" + ], + "ToolShed id": "transdecoder", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/transdecoder", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/transdecoder", + "Galaxy wrapper version": "5.5.0", + "Conda id": "transdecoder", + "Conda version": "5.7.1" + }, + { + "Galaxy wrapper id": "transit", + "Galaxy tool ids": [ + "gff_to_prot", + "transit_gumbel", + "transit_hmm", + "transit_resampling", + "transit_tn5gaps" + ], + "Description": "TRANSIT", + "bio.tool id": "transit", + "bio.tool ids": [ + "transit" + ], + "biii": null, + "bio.tool name": "TRANSIT", + "bio.tool description": "A tool for the analysis of Tn-Seq data. It provides an easy to use graphical interface and access to three different analysis methods that allow the user to determine essentiality in a single condition as well as between conditions.", + "EDAM operation": [ + "Transposon prediction" + ], + "EDAM topic": [ + "DNA", + "Sequencing", + "Mobile genetic elements" + ], + "Status": "To update", + "Source": "https://github.com/mad-lab/transit/", + "ToolShed categories": [ + "Genome annotation" + ], + "ToolShed id": null, + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/transit/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/transit", + "Galaxy wrapper version": "3.0.2", + "Conda id": "transit", + "Conda version": "3.2.3" + }, + { + "Galaxy wrapper id": "transtermhp", + "Galaxy tool ids": [ + "transtermhp" + ], + "Description": "Finds rho-independent transcription terminators in bacterial genomes", + "bio.tool id": "transtermhp", + "bio.tool ids": [ + "transtermhp" + ], + "biii": null, + "bio.tool name": "TransTermHP", + "bio.tool description": "TransTermHP finds rho-independent transcription terminators in bacterial genomes. Each terminator found by the program is assigned a confidence value that estimates its probability of being a true terminator", + "EDAM operation": [ + "Transcriptional regulatory element prediction" + ], + "EDAM topic": [ + "Transcription factors and regulatory sites" + ], + "Status": "To update", + "Source": "https://transterm.cbcb.umd.edu", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "transtermhp", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/transtermhp", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/transtermhp", + "Galaxy wrapper version": null, + "Conda id": "transtermhp", + "Conda version": "2.09" + }, + { + "Galaxy wrapper id": "trimmomatic", + "Galaxy tool ids": [ + "trimmomatic" + ], + "Description": "A flexible read trimming tool for Illumina NGS data", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "http://www.usadellab.org/cms/?page=trimmomatic", + "ToolShed categories": [ + "Fastq Manipulation" + ], + "ToolShed id": "trimmomatic", + "Galaxy wrapper owner": "pjbriggs", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/main/packages/trimmomatic", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/trimmomatic", + "Galaxy wrapper version": "0.39", + "Conda id": "trimmomatic", + "Conda version": "0.39" + }, + { + "Galaxy wrapper id": "trinity", + "Galaxy tool ids": [ + "trinity_abundance_estimates_to_matrix", + "trinity_align_and_estimate_abundance", + "trinity_analyze_diff_expr", + "trinity_contig_exn50_statistic", + "trinity_define_clusters_by_cutting_tree", + "describe_samples", + "trinity_filter_low_expr_transcripts", + "trinity_gene_to_trans_map", + "trinity_run_de_analysis", + "trinity_samples_qccheck", + "trinity_super_transcripts", + "trinity", + "trinity_stats" + ], + "Description": "Trinity represents a method for the efficient and robust de novo reconstruction of transcriptomes from RNA-seq datahttps://github.com/trinityrnaseq/trinityrnaseq", + "bio.tool id": "trinity", + "bio.tool ids": [ + "trinity" + ], + "biii": null, + "bio.tool name": "Trinity", + "bio.tool description": "Trinity is a transcriptome assembler which relies on three different tools, inchworm an assembler, chrysalis which pools contigs and butterfly which amongst others compacts a graph resulting from butterfly with reads.", + "EDAM operation": [ + "Transcriptome assembly" + ], + "EDAM topic": [ + "Transcriptomics", + "Gene expression", + "Gene transcripts" + ], + "Status": "Up-to-date", + "Source": "https://github.com/trinityrnaseq/trinityrnaseq", + "ToolShed categories": [ + "Transcriptomics", + "RNA" + ], + "ToolShed id": null, + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/trinity", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/trinity", + "Galaxy wrapper version": "2.15.1", + "Conda id": "trinity", + "Conda version": "2.15.1" + }, + { + "Galaxy wrapper id": "trinotate", + "Galaxy tool ids": [ + "trinotate" + ], + "Description": "Trinotate is a comprehensive annotation suite designed for automatic functional annotation of de novo transcriptomes.", + "bio.tool id": "trinotate", + "bio.tool ids": [ + "trinotate" + ], + "biii": null, + "bio.tool name": "Trinotate", + "bio.tool description": "Comprehensive annotation suite designed for automatic functional annotation of transcriptomes, particularly de novo assembled transcriptomes, from model or non-model organisms.", + "EDAM operation": [ + "Gene functional annotation" + ], + "EDAM topic": [ + "Gene expression", + "Transcriptomics" + ], + "Status": "To update", + "Source": "https://trinotate.github.io/", + "ToolShed categories": [ + "Transcriptomics", + "RNA" + ], + "ToolShed id": "trinotate", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/trinotate", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/trinotate", + "Galaxy wrapper version": "3.2.2", + "Conda id": "trinotate", + "Conda version": "4.0.2" + }, + { + "Galaxy wrapper id": "trycycler", + "Galaxy tool ids": [ + "trycycler_cluster", + "trycycler_consensus", + "trycycler_partition", + "trycycler_reconcile_msa", + "trycycler_subsample" + ], + "Description": "Trycycler toolkit wrappers", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/rrwick/Trycycler", + "ToolShed categories": [ + "Assembly" + ], + "ToolShed id": "trycycler", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/trycycler", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/trycycler", + "Galaxy wrapper version": "0.5.5", + "Conda id": "trycycler", + "Conda version": "0.5.5" + }, + { + "Galaxy wrapper id": "tsebra", + "Galaxy tool ids": [ + "tsebra" + ], + "Description": "This tool has been developed to combine BRAKER predictions.", + "bio.tool id": "tsebra", + "bio.tool ids": [ + "tsebra" + ], + "biii": null, + "bio.tool name": "TSEBRA", + "bio.tool description": "TSEBRA is a combiner tool that selects transcripts from gene predictions based on the support by extrisic evidence in form of introns and start/stop codons. It was developed to combine BRAKER1 and BRAKER2 predicitons to increase their accuracies.", + "EDAM operation": [ + "Homology-based gene prediction", + "Alternative splicing prediction" + ], + "EDAM topic": [ + "Gene expression", + "RNA-Seq", + "Gene transcripts", + "Model organisms" + ], + "Status": "To update", + "Source": "https://github.com/Gaius-Augustus/TSEBRA", + "ToolShed categories": [ + "Genome annotation" + ], + "ToolShed id": null, + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/tsebra", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/tsebra", + "Galaxy wrapper version": "1.1.2.4", + "Conda id": "tsebra", + "Conda version": "1.1.2.5" + }, + { + "Galaxy wrapper id": "tsne", + "Galaxy tool ids": [ + "tsne" + ], + "Description": "T-Distributed Stochastic Neighbor Embedding using a Barnes-Hut Implementation", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://cran.r-project.org/web/packages/Rtsne/", + "ToolShed categories": [ + "Text Manipulation" + ], + "ToolShed id": "tsne", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/tsne", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/tsne", + "Galaxy wrapper version": "0.0.2", + "Conda id": "r-rtsne", + "Conda version": "0.13" + }, + { + "Galaxy wrapper id": "tximport", + "Galaxy tool ids": [ + "tximport" + ], + "Description": "Wrapper for the Bioconductor package tximport", + "bio.tool id": "tximport", + "bio.tool ids": [ + "tximport" + ], + "biii": null, + "bio.tool name": "tximport", + "bio.tool description": "An R/Bioconductor package that imports transcript-level abundance, estimated counts and transcript lengths, and summarizes into matrices for use with downstream gene-level analysis packages.", + "EDAM operation": [ + "Pathway or network analysis", + "Formatting", + "RNA-Seq analysis" + ], + "EDAM topic": [ + "Transcriptomics", + "Gene transcripts", + "Workflows" + ], + "Status": "To update", + "Source": "http://bioconductor.org/packages/tximport/", + "ToolShed categories": [ + "Transcriptomics" + ], + "ToolShed id": "tximport", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/tximport", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/tximport", + "Galaxy wrapper version": "1.22.0", + "Conda id": "bioconductor-tximport", + "Conda version": "1.30.0" + }, + { + "Galaxy wrapper id": "ucsc_blat", + "Galaxy tool ids": [ + "ucsc_blat" + ], + "Description": "Standalone blat sequence search command line tool", + "bio.tool id": "blat", + "bio.tool ids": [ + "blat" + ], + "biii": null, + "bio.tool name": "BLAT", + "bio.tool description": "Fast, accurate spliced alignment of DNA sequences.", + "EDAM operation": [ + "Sequence alignment" + ], + "EDAM topic": [ + "Sequence analysis" + ], + "Status": "To update", + "Source": "http://genome.ucsc.edu/goldenPath/help/blatSpec.html", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "ucsc_blat", + "Galaxy wrapper owner": "yating-l", + "Galaxy wrapper source": null, + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/ucsc_blat", + "Galaxy wrapper version": "377", + "Conda id": "ucsc-blat", + "Conda version": "445" + }, + { + "Galaxy wrapper id": "fasplit", + "Galaxy tool ids": [ + "fasplit" + ], + "Description": "faSplit is a tool to split a single FASTA file into several files", + "bio.tool id": "UCSC_Genome_Browser_Utilities", + "bio.tool ids": [ + "UCSC_Genome_Browser_Utilities" + ], + "biii": null, + "bio.tool name": "UCSC Genome Browser Utilities", + "bio.tool description": "Utilities for handling sequences and assemblies from the UCSC Genome Browser project.", + "EDAM operation": [], + "EDAM topic": [ + "Sequence analysis" + ], + "Status": "Up-to-date", + "Source": "http://hgdownload.cse.ucsc.edu/admin/exe/", + "ToolShed categories": [ + "Fasta Manipulation" + ], + "ToolShed id": "ucsc_fasplit", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/ucsc-tools/fasplit", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/ucsc_tools/fasplit", + "Galaxy wrapper version": "377", + "Conda id": "ucsc-fasplit", + "Conda version": "377" + }, + { + "Galaxy wrapper id": "fatovcf", + "Galaxy tool ids": [ + "fatovcf" + ], + "Description": "Convert a FASTA alignment file to Variant Call Format (VCF) single-nucleotide diffs", + "bio.tool id": "UCSC_Genome_Browser_Utilities", + "bio.tool ids": [ + "UCSC_Genome_Browser_Utilities" + ], + "biii": null, + "bio.tool name": "UCSC Genome Browser Utilities", + "bio.tool description": "Utilities for handling sequences and assemblies from the UCSC Genome Browser project.", + "EDAM operation": [], + "EDAM topic": [ + "Sequence analysis" + ], + "Status": "Up-to-date", + "Source": "http://hgdownload.cse.ucsc.edu/admin/exe/", + "ToolShed categories": [ + "Convert Formats" + ], + "ToolShed id": "ucsc_fatovcf", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/ucsc-tools/fatovcf", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/ucsc_tools/fatovcf", + "Galaxy wrapper version": "448", + "Conda id": "ucsc-fatovcf", + "Conda version": "448" + }, + { + "Galaxy wrapper id": "twobittofa", + "Galaxy tool ids": [ + "ucsc-twobittofa" + ], + "Description": "twoBitToFa is a tool to convert all or part of .2bit file to FASTA", + "bio.tool id": "UCSC_Genome_Browser_Utilities", + "bio.tool ids": [ + "UCSC_Genome_Browser_Utilities" + ], + "biii": null, + "bio.tool name": "UCSC Genome Browser Utilities", + "bio.tool description": "Utilities for handling sequences and assemblies from the UCSC Genome Browser project.", + "EDAM operation": [], + "EDAM topic": [ + "Sequence analysis" + ], + "Status": "To update", + "Source": "https://genome.ucsc.edu/goldenpath/help/twoBit.html", + "ToolShed categories": [ + "Convert Formats" + ], + "ToolShed id": "ucsc_twobittofa", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/ucsc-tools/twobittofa", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/ucsc_tools/twobittofa", + "Galaxy wrapper version": "377", + "Conda id": "ucsc-twobittofa", + "Conda version": "455" + }, + { + "Galaxy wrapper id": "wigtobigwig", + "Galaxy tool ids": [ + "ucsc_wigtobigwig" + ], + "Description": "converts bedGraph (wig) files into binary bigwig", + "bio.tool id": "UCSC_Genome_Browser_Utilities", + "bio.tool ids": [ + "UCSC_Genome_Browser_Utilities" + ], + "biii": null, + "bio.tool name": "UCSC Genome Browser Utilities", + "bio.tool description": "Utilities for handling sequences and assemblies from the UCSC Genome Browser project.", + "EDAM operation": [], + "EDAM topic": [ + "Sequence analysis" + ], + "Status": "Up-to-date", + "Source": "https://genome.ucsc.edu/goldenPath/help/bigWig.html", + "ToolShed categories": [ + "Convert Formats" + ], + "ToolShed id": "ucsc_wigtobigwig", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/wigtobigwig", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/ucsc_tools/wigtobigwig", + "Galaxy wrapper version": "447", + "Conda id": "ucsc-wigtobigwig", + "Conda version": "447" + }, + { + "Galaxy wrapper id": "umi_tools", + "Galaxy tool ids": [ + "umi_tools_count", + "umi_tools_dedup", + "umi_tools_extract", + "umi_tools_group", + "umi_tools_whitelist" + ], + "Description": "UMI-tools extract - Extract UMIs from fastq", + "bio.tool id": "umi-tools", + "bio.tool ids": [ + "umi-tools" + ], + "biii": null, + "bio.tool name": "UMI-tools", + "bio.tool description": "Tools for handling Unique Molecular Identifiers in NGS data sets.", + "EDAM operation": [ + "Sequencing quality control" + ], + "EDAM topic": [ + "NGS", + "Sequence sites, features and motifs", + "Quality affairs" + ], + "Status": "To update", + "Source": "https://github.com/CGATOxford/UMI-tools", + "ToolShed categories": [ + "Sequence Analysis", + "Transcriptomics" + ], + "ToolShed id": null, + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/umi_tools", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/umi_tools", + "Galaxy wrapper version": "1.1.2", + "Conda id": "umi_tools", + "Conda version": "1.1.5" + }, + { + "Galaxy wrapper id": "unicycler", + "Galaxy tool ids": [ + "unicycler" + ], + "Description": "Unicycler is a hybrid assembly pipeline for bacterial genomes.", + "bio.tool id": "unicycler", + "bio.tool ids": [ + "unicycler" + ], + "biii": null, + "bio.tool name": "Unicycler", + "bio.tool description": "A tool for assembling bacterial genomes from a combination of short (2nd generation) and long (3rd generation) sequencing reads.", + "EDAM operation": [ + "Genome assembly", + "Aggregation" + ], + "EDAM topic": [ + "Microbiology", + "Genomics", + "Sequencing", + "Sequence assembly" + ], + "Status": "Up-to-date", + "Source": "https://github.com/rrwick/Unicycler", + "ToolShed categories": [ + "Assembly" + ], + "ToolShed id": "unicycler", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/unicycler", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/unicycler", + "Galaxy wrapper version": "0.5.0", + "Conda id": "unicycler", + "Conda version": "0.5.0" + }, + { + "Galaxy wrapper id": "usher", + "Galaxy tool ids": [ + "usher_matutils", + "usher" + ], + "Description": "UShER toolkit wrappers", + "bio.tool id": "usher", + "bio.tool ids": [ + "usher" + ], + "biii": null, + "bio.tool name": "usher", + "bio.tool description": "The UShER toolkit includes a set of tools for for rapid, accurate placement of samples to existing phylogenies. While not restricted to SARS-CoV-2 phylogenetic analyses, it has enabled real-time phylogenetic analyses and genomic contact tracing in that its placement is orders of magnitude faster and more memory-efficient than previous methods.", + "EDAM operation": [ + "Classification", + "Phylogenetic tree visualisation", + "Phylogenetic inference (from molecular sequences)" + ], + "EDAM topic": [ + "Phylogeny", + "Evolutionary biology", + "Cladistics", + "Genotype and phenotype", + "Phylogenomics" + ], + "Status": "To update", + "Source": "https://github.com/yatisht/usher", + "ToolShed categories": [ + "Phylogenetics" + ], + "ToolShed id": "usher", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/usher", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/usher", + "Galaxy wrapper version": "0.2.1", + "Conda id": "usher", + "Conda version": "0.6.3" + }, + { + "Galaxy wrapper id": "valet", + "Galaxy tool ids": [ + "valet" + ], + "Description": "A pipeline for detecting mis-assemblies in metagenomic assemblies.", + "bio.tool id": "valet", + "bio.tool ids": [ + "valet" + ], + "biii": null, + "bio.tool name": "VALET", + "bio.tool description": "VALET is a pipeline for detecting mis-assemblies in metagenomic assemblies.", + "EDAM operation": [ + "Sequence assembly", + "Sequence assembly visualisation" + ], + "EDAM topic": [ + "Metagenomics", + "Sequence assembly" + ], + "Status": "To update", + "Source": "https://github.com/marbl/VALET", + "ToolShed categories": [ + "Metagenomics" + ], + "ToolShed id": "valet", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/valet", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/valet", + "Galaxy wrapper version": null, + "Conda id": "valet", + "Conda version": "1.0" + }, + { + "Galaxy wrapper id": "vapor", + "Galaxy tool ids": [ + "vapor" + ], + "Description": "Classify Influenza samples from raw short read sequence data", + "bio.tool id": "vapor", + "bio.tool ids": [ + "vapor" + ], + "biii": null, + "bio.tool name": "VAPOR", + "bio.tool description": "VAPOR is a tool for classification of Influenza samples from raw short read sequence data for downstream bioinformatics analysis. VAPOR is provided with a fasta file of full-length sequences (> 20,000) for a given segment, a set of reads, and attempts to retrieve a reference that is closest to the sample strain.", + "EDAM operation": [ + "Data retrieval", + "De-novo assembly", + "Read mapping" + ], + "EDAM topic": [ + "Whole genome sequencing", + "Mapping", + "Sequence assembly" + ], + "Status": "Up-to-date", + "Source": "https://github.com/connor-lab/vapor", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "vapor", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/vapor", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/vapor", + "Galaxy wrapper version": "1.0.2", + "Conda id": "vapor", + "Conda version": "1.0.2" + }, + { + "Galaxy wrapper id": "vardict", + "Galaxy tool ids": [ + "vardict_java" + ], + "Description": "VarDict - calls SNVs and indels for tumour-normal pairs", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/AstraZeneca-NGS/VarDictJava", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "vardict_java", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/vardict", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/vardict", + "Galaxy wrapper version": "1.8.3", + "Conda id": "python", + "Conda version": null + }, + { + "Galaxy wrapper id": "variant_analyzer", + "Galaxy tool ids": [ + "mut2read", + "mut2sscs", + "read2mut" + ], + "Description": "Collection of tools for analyzing variants in duplex consensus sequencing (DCS) data", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": null, + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "variant_analyzer", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/variant_analyzer", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/variant_analyzer", + "Galaxy wrapper version": "2.0.0", + "Conda id": "matplotlib", + "Conda version": null + }, + { + "Galaxy wrapper id": "varscan", + "Galaxy tool ids": [ + "varscan_copynumber", + "varscan_mpileup", + "varscan_somatic" + ], + "Description": "VarScan is a variant caller for high-throughput sequencing data", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://dkoboldt.github.io/varscan/", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "varscan", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/iuc/tree/master/tools/varscan", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/varscan", + "Galaxy wrapper version": "2.4.3", + "Conda id": "varscan", + "Conda version": "2.4.6" + }, + { + "Galaxy wrapper id": "varvamp", + "Galaxy tool ids": [ + "varvamp" + ], + "Description": "Variable VirusAMPlicons (varVAMP) is a tool to design primers for highly diverse viruses", + "bio.tool id": "varvamp", + "bio.tool ids": [ + "varvamp" + ], + "biii": null, + "bio.tool name": "varVAMP", + "bio.tool description": "variable VirusAMPlicons (varVAMP) is a tool to design primers for highly diverse viruses. The input is an alignment of your viral (full-genome) sequences.", + "EDAM operation": [ + "PCR primer design" + ], + "EDAM topic": [ + "Virology" + ], + "Status": "Up-to-date", + "Source": "https://github.com/jonas-fuchs/varVAMP/", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "varvamp", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/jonas-fuchs/varVAMP", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/varvamp", + "Galaxy wrapper version": "1.2.0", + "Conda id": "varvamp", + "Conda version": "1.2.0" + }, + { + "Galaxy wrapper id": "vcf2maf", + "Galaxy tool ids": [ + "vcf2maf" + ], + "Description": "vcf2maf: Convert VCF into MAF", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": null, + "ToolShed categories": [ + "Convert Formats" + ], + "ToolShed id": "vcf2maf", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/vcf2maf", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/vcf2maf", + "Galaxy wrapper version": "1.6.21", + "Conda id": "vcf2maf", + "Conda version": "1.6.22" + }, + { + "Galaxy wrapper id": "vcfanno", + "Galaxy tool ids": [ + "vcfanno" + ], + "Description": "Annotate VCF files", + "bio.tool id": "vcfanno", + "bio.tool ids": [ + "vcfanno" + ], + "biii": null, + "bio.tool name": "vcfanno", + "bio.tool description": "Fast, flexible annotation of genetic variants.", + "EDAM operation": [ + "SNP annotation" + ], + "EDAM topic": [ + "Genetic variation", + "Data submission, annotation and curation" + ], + "Status": "Up-to-date", + "Source": "https://github.com/brentp/vcfanno", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "vcfanno", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/vcfanno/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/vcfanno", + "Galaxy wrapper version": "0.3.5", + "Conda id": "vcfanno", + "Conda version": "0.3.5" + }, + { + "Galaxy wrapper id": "vegan", + "Galaxy tool ids": [ + "vegan_diversity", + "vegan_fisher_alpha", + "vegan_rarefaction" + ], + "Description": "an R package fo community ecologist", + "bio.tool id": "vegan", + "bio.tool ids": [ + "vegan" + ], + "biii": null, + "bio.tool name": "vegan", + "bio.tool description": "Ordination methods, diversity analysis and other functions for community and vegetation ecologists", + "EDAM operation": [ + "Standardisation and normalisation", + "Analysis" + ], + "EDAM topic": [ + "Ecology", + "Phylogenetics", + "Environmental science" + ], + "Status": "To update", + "Source": "https://cran.r-project.org/package=vegan", + "ToolShed categories": [ + "Metagenomics" + ], + "ToolShed id": null, + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/vegan/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/vegan", + "Galaxy wrapper version": "2.4-3", + "Conda id": "r-vegan", + "Conda version": "2.3_4" + }, + { + "Galaxy wrapper id": "velocyto", + "Galaxy tool ids": [ + "velocyto_cli" + ], + "Description": "Velocyto is a library for the analysis of RNA velocity.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "http://velocyto.org/", + "ToolShed categories": [ + "Transcriptomics" + ], + "ToolShed id": "velocyto", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/velocyto", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/velocyto", + "Galaxy wrapper version": "0.17.17", + "Conda id": "velocyto.py", + "Conda version": "0.17.17" + }, + { + "Galaxy wrapper id": "velvet", + "Galaxy tool ids": [ + "velvetg", + "velveth" + ], + "Description": "de novo genomic assembler specially designed for short read sequencing technologies", + "bio.tool id": "velvet", + "bio.tool ids": [ + "velvet" + ], + "biii": null, + "bio.tool name": "Velvet", + "bio.tool description": "A de novo genomic assembler specially designed for short read sequencing technologies, such as Solexa or 454 or SOLiD.", + "EDAM operation": [ + "Formatting", + "De-novo assembly" + ], + "EDAM topic": [ + "Sequence assembly" + ], + "Status": "To update", + "Source": "https://www.ebi.ac.uk/~zerbino/velvet/", + "ToolShed categories": [ + "Assembly" + ], + "ToolShed id": "velvet", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/velvet", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/velvet", + "Galaxy wrapper version": null, + "Conda id": "velvet", + "Conda version": "1.2.10" + }, + { + "Galaxy wrapper id": "velvet_optimiser", + "Galaxy tool ids": [ + "velvetoptimiser" + ], + "Description": "Automatically optimize Velvet assemblies", + "bio.tool id": "velvetoptimiser", + "bio.tool ids": [ + "velvetoptimiser" + ], + "biii": null, + "bio.tool name": "VelvetOptimiser", + "bio.tool description": "This tool is designed to run as a wrapper script for the Velvet assembler (Daniel Zerbino, EBI UK) and to assist with optimising the assembly.", + "EDAM operation": [ + "Optimisation and refinement", + "Sequence assembly" + ], + "EDAM topic": [ + "Genomics", + "Sequence assembly" + ], + "Status": "To update", + "Source": null, + "ToolShed categories": [ + "Assembly" + ], + "ToolShed id": "velvetoptimiser", + "Galaxy wrapper owner": "simon-gladman", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/velvetoptimiser", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/velvet_optimiser", + "Galaxy wrapper version": "2.2.6+galaxy2", + "Conda id": "velvet", + "Conda version": "1.2.10" + }, + { + "Galaxy wrapper id": "verkko", + "Galaxy tool ids": [ + "verkko" + ], + "Description": "Telomere-to-telomere assembly pipeline", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/marbl/verkko", + "ToolShed categories": [ + "Assembly" + ], + "ToolShed id": "verkko", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/verkko", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/verkko", + "Galaxy wrapper version": "1.3.1", + "Conda id": "verkko", + "Conda version": "2.1" + }, + { + "Galaxy wrapper id": "vg", + "Galaxy tool ids": [ + "vg_convert", + "vg_deconstruct", + "vg_view" + ], + "Description": "Variation graph data structures, interchange formats, alignment, genotyping, and variant calling methods", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/vgteam/vg", + "ToolShed categories": [ + "Sequence Analysis", + "Variant Analysis" + ], + "ToolShed id": null, + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/vg", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/vg", + "Galaxy wrapper version": "1.23.0", + "Conda id": "vg", + "Conda version": "1.56.0" + }, + { + "Galaxy wrapper id": "virAnnot", + "Galaxy tool ids": [ + "virannot_blast2tsv", + "virannot_otu", + "virAnnot_rps2tsv" + ], + "Description": "virAnnot wrappers", + "bio.tool id": "virannot", + "bio.tool ids": [ + "virannot" + ], + "biii": null, + "bio.tool name": "virAnnot", + "bio.tool description": "VirAnnot was build to ease the assembly, blast search, taxonomic annotation and OTUs assignation of viral metagenomic HTS data. It is used in Virologie team of UMR1332 BFP laboratory at INRAE. VirAnnot also takes part of the Euphresco project \"Plant Health Bioinformatics Network\". See more.It is designed to identify viruses in plant metagenomic data but it can be used to assemble and annotate any sequences with the NCBI taxonomy.", + "EDAM operation": [ + "Sequence annotation", + "Sequence clustering", + "Sequence cluster visualisation" + ], + "EDAM topic": [ + "Metagenomics", + "Virology", + "Microbial ecology" + ], + "Status": "To update", + "Source": "https://github.com/marieBvr/virAnnot", + "ToolShed categories": [ + "Metagenomics" + ], + "ToolShed id": "virannot", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/virAnnot", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/virAnnot", + "Galaxy wrapper version": "1.0.0+galaxy0", + "Conda id": "biopython", + "Conda version": "1.70" + }, + { + "Galaxy wrapper id": "virheat", + "Galaxy tool ids": [ + "virheat" + ], + "Description": "generates a heatmap of allele frequencies from vcf files", + "bio.tool id": "virheat", + "bio.tool ids": [ + "virheat" + ], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/jonas-fuchs/virHEAT", + "ToolShed categories": [ + "Visualization", + "Variant Analysis" + ], + "ToolShed id": "virheat", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/virheat", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/virheat", + "Galaxy wrapper version": "0.7", + "Conda id": "virheat", + "Conda version": "0.7" + }, + { + "Galaxy wrapper id": "virhunter", + "Galaxy tool ids": [ + "virhunter" + ], + "Description": "Deep Learning method for novel virus detection in sequencing data", + "bio.tool id": "virhunter", + "bio.tool ids": [ + "virhunter" + ], + "biii": null, + "bio.tool name": "VirHunter", + "bio.tool description": "VirHunter is a deep learning method that uses Convolutional Neural Networks (CNNs) and a Random Forest Classifier to identify viruses in sequencing datasets. More precisely, VirHunter classifies previously assembled contigs as viral, host, and bacterial (contamination).", + "EDAM operation": [ + "Sequence classification" + ], + "EDAM topic": [ + "Virology" + ], + "Status": "To update", + "Source": "https://github.com/cbib/virhunter", + "ToolShed categories": [ + "Machine Learning" + ], + "ToolShed id": "virhunter", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/VirHunter", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/virhunter", + "Galaxy wrapper version": "1.0.0", + "Conda id": "numpy", + "Conda version": null + }, + { + "Galaxy wrapper id": "volcanoplot", + "Galaxy tool ids": [ + "volcanoplot" + ], + "Description": "Tool to create a Volcano Plot", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://ggplot2.tidyverse.org/", + "ToolShed categories": [ + "Visualization", + "Transcriptomics", + "Statistics" + ], + "ToolShed id": "volcanoplot", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/volcanoplot", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/volcanoplot", + "Galaxy wrapper version": "0.0.6", + "Conda id": "r-ggplot2", + "Conda version": "2.2.1" + }, + { + "Galaxy wrapper id": "vsearch", + "Galaxy tool ids": [ + "vsearch_alignment", + "vsearch_chimera_detection", + "vsearch_clustering", + "vsearch_dereplication", + "vsearch_masking", + "vsearch_search", + "vsearch_shuffling", + "vsearch_sorting" + ], + "Description": "VSEARCH including searching, clustering, chimera detection, dereplication, sorting, masking and shuffling of sequences.", + "bio.tool id": "vsearch", + "bio.tool ids": [ + "vsearch" + ], + "biii": null, + "bio.tool name": "VSEARCH", + "bio.tool description": "High-throughput search and clustering sequence analysis tool. It supports de novo and reference based chimera detection, clustering, full-length and prefix dereplication, reverse complementation, masking, all-vs-all pairwise global alignment, exact and global alignment searching, shuffling, subsampling and sorting. It also supports FASTQ file analysis, filtering and conversion.", + "EDAM operation": [ + "DNA mapping", + "Chimera detection" + ], + "EDAM topic": [ + "Metagenomics", + "Sequence analysis" + ], + "Status": "To update", + "Source": "https://github.com/torognes/vsearch", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "vsearch", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/vsearch", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/vsearch", + "Galaxy wrapper version": "2.8.3", + "Conda id": "vsearch", + "Conda version": "2.28.1" + }, + { + "Galaxy wrapper id": "vsnp", + "Galaxy tool ids": [ + "vsnp_add_zero_coverage", + "vsnp_build_tables", + "vsnp_determine_ref_from_data", + "vsnp_get_snps", + "vsnp_statistics" + ], + "Description": "The vSNP tools are critical components of several workflows that validate SNPs and produce annotatedSNP tables and corresponding phylogenetic trees.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/USDA-VS/vSNP", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "vsnp", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/vsnp", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/vsnp", + "Galaxy wrapper version": "3.0.6", + "Conda id": "pysam", + "Conda version": "0.22.1" + }, + { + "Galaxy wrapper id": "weather_app", + "Galaxy tool ids": [ + "simple_weather" + ], + "Description": "provides simple weather in text format", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "http://wttr.in/", + "ToolShed categories": [ + "Visualization", + "Web Services" + ], + "ToolShed id": "simpleweather", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/weather_app", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/weather_app", + "Galaxy wrapper version": "0.1.2", + "Conda id": "curl", + "Conda version": null + }, + { + "Galaxy wrapper id": "weblogo3", + "Galaxy tool ids": [ + "rgweblogo3" + ], + "Description": "Sequence Logo generator for fasta", + "bio.tool id": "weblogo", + "bio.tool ids": [ + "weblogo" + ], + "biii": null, + "bio.tool name": "WebLogo", + "bio.tool description": "Web-based application designed to make generate sequence logos.", + "EDAM operation": [ + "Sequence cluster visualisation", + "Sequence visualisation", + "Sequence motif recognition" + ], + "EDAM topic": [ + "Nucleic acid sites, features and motifs", + "Sequence analysis" + ], + "Status": "To update", + "Source": null, + "ToolShed categories": [ + "Graphics" + ], + "ToolShed id": "weblogo3", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/weblogo3", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/weblogo3", + "Galaxy wrapper version": "3.5.0", + "Conda id": "weblogo", + "Conda version": "3.7.9" + }, + { + "Galaxy wrapper id": "windowmasker", + "Galaxy tool ids": [ + "windowmasker_mkcounts", + "windowmasker_ustat" + ], + "Description": "Identify repetitive regions using WindowMasker", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://www.ncbi.nlm.nih.gov/IEB/ToolBox/CPP_DOC/lxr/source/src/app/winmasker/", + "ToolShed categories": [ + "Sequence Analysis" + ], + "ToolShed id": "windowmasker", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/windowmasker/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/windowmasker", + "Galaxy wrapper version": "1.0", + "Conda id": "blast", + "Conda version": "2.15.0" + }, + { + "Galaxy wrapper id": "winnowmap", + "Galaxy tool ids": [ + "winnowmap" + ], + "Description": "A long-read mapping tool optimized for mapping ONT and PacBio reads to repetitive reference sequences.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/marbl/Winnowmap", + "ToolShed categories": [ + "Next Gen Mappers" + ], + "ToolShed id": "winnowmap", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/winnowmap", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/winnowmap", + "Galaxy wrapper version": "2.03", + "Conda id": "winnowmap", + "Conda version": "2.03" + }, + { + "Galaxy wrapper id": "xpath", + "Galaxy tool ids": [ + "xpath" + ], + "Description": "XPath XML querying tool", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "http://search.cpan.org/dist/XML-XPath/", + "ToolShed categories": [ + "Text Manipulation" + ], + "ToolShed id": "xpath", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/xpath", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/xpath", + "Galaxy wrapper version": null, + "Conda id": "perl-xml-xpath", + "Conda version": "1.47" + }, + { + "Galaxy wrapper id": "yahs", + "Galaxy tool ids": [ + "yahs" + ], + "Description": "Yet Another Hi-C scaffolding tool", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/c-zhou/yahs", + "ToolShed categories": [ + "Assembly" + ], + "ToolShed id": "yahs", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/yahs", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/yahs", + "Galaxy wrapper version": "1.2a.2", + "Conda id": "yahs", + "Conda version": "1.2a.2" + }, + { + "Galaxy wrapper id": "zerone", + "Galaxy tool ids": [ + "zerone" + ], + "Description": "ChIP-seq discretization and quality control", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/nanakiksc/zerone", + "ToolShed categories": [ + "ChIP-seq" + ], + "ToolShed id": "zerone", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tools/zerone", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tools/zerone", + "Galaxy wrapper version": "1.0", + "Conda id": "zerone", + "Conda version": "1.0" + }, + { + "Galaxy wrapper id": "bamtools", + "Galaxy tool ids": [ + "bamtools" + ], + "Description": "Operate on and transform BAM datasets in various ways using bamtools", + "bio.tool id": "bamtools", + "bio.tool ids": [ + "bamtools" + ], + "biii": null, + "bio.tool name": "BamTools", + "bio.tool description": "BamTools provides a fast, flexible C++ API & toolkit for reading, writing, and managing BAM files.", + "EDAM operation": [ + "Data handling", + "Sequence alignment analysis" + ], + "EDAM topic": [ + "Sequencing", + "Data management", + "Sequence analysis" + ], + "Status": "Up-to-date", + "Source": "https://github.com/pezmaster31/bamtools", + "ToolShed categories": [ + "Sequence Analysis", + "SAM" + ], + "ToolShed id": "bamtools", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/bamtools/bamtools", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/bamtools/bamtools", + "Galaxy wrapper version": "2.5.2", + "Conda id": "bamtools", + "Conda version": "2.5.2" + }, + { + "Galaxy wrapper id": "bamtools_filter", + "Galaxy tool ids": [ + "bamFilter" + ], + "Description": "Filter BAM datasets on various attributes using bamtools filter", + "bio.tool id": "bamtools", + "bio.tool ids": [ + "bamtools" + ], + "biii": null, + "bio.tool name": "BamTools", + "bio.tool description": "BamTools provides a fast, flexible C++ API & toolkit for reading, writing, and managing BAM files.", + "EDAM operation": [ + "Data handling", + "Sequence alignment analysis" + ], + "EDAM topic": [ + "Sequencing", + "Data management", + "Sequence analysis" + ], + "Status": "Up-to-date", + "Source": "https://github.com/pezmaster31/bamtools", + "ToolShed categories": [ + "Sequence Analysis", + "SAM" + ], + "ToolShed id": "bamtools_filter", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/bamtools/bamtools_filter", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/bamtools/bamtools_filter", + "Galaxy wrapper version": "2.5.2", + "Conda id": "bamtools", + "Conda version": "2.5.2" + }, + { + "Galaxy wrapper id": "bamtools_split", + "Galaxy tool ids": [ + "bamtools_split_mapped", + "bamtools_split_paired", + "bamtools_split_ref", + "bamtools_split_tag" + ], + "Description": "Utility for filtering BAM files. It is based on the BAMtools suiteof tools by Derek Barnett.", + "bio.tool id": "bamtools", + "bio.tool ids": [ + "bamtools" + ], + "biii": null, + "bio.tool name": "BamTools", + "bio.tool description": "BamTools provides a fast, flexible C++ API & toolkit for reading, writing, and managing BAM files.", + "EDAM operation": [ + "Data handling", + "Sequence alignment analysis" + ], + "EDAM topic": [ + "Sequencing", + "Data management", + "Sequence analysis" + ], + "Status": "Up-to-date", + "Source": "https://github.com/pezmaster31/bamtools", + "ToolShed categories": [ + "Sequence Analysis", + "SAM" + ], + "ToolShed id": null, + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/bamtools/bamtools_split", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/bamtools/bamtools_split", + "Galaxy wrapper version": "2.5.2", + "Conda id": "bamtools", + "Conda version": "2.5.2" + }, + { + "Galaxy wrapper id": "biotradis", + "Galaxy tool ids": [ + "bacteria_tradis", + "tradis_essentiality", + "tradis_gene_insert_sites" + ], + "Description": "Bio-Tradis is a tool suite dedicated to essentiality analyses with TraDis data.", + "bio.tool id": "biotradis", + "bio.tool ids": [ + "biotradis" + ], + "biii": null, + "bio.tool name": "biotradis", + "bio.tool description": "The Bio::TraDIS pipeline provides software utilities for the processing, mapping, and analysis of transposon insertion sequencing data. The pipeline was designed with the data from the TraDIS sequencing protocol in mind, but should work with a variety of transposon insertion sequencing protocols as long as they produce data in the expected format.", + "EDAM operation": [ + "Sequence analysis" + ], + "EDAM topic": [ + "Mobile genetic elements", + "Workflows" + ], + "Status": "Up-to-date", + "Source": "https://www.sanger.ac.uk/science/tools/bio-tradis", + "ToolShed categories": [ + "Genome annotation" + ], + "ToolShed id": "biotradis", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/biotradis", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/biotradis", + "Galaxy wrapper version": "1.4.5", + "Conda id": "biotradis", + "Conda version": "1.4.5" + }, + { + "Galaxy wrapper id": "cuffcompare", + "Galaxy tool ids": [ + "cuffcompare" + ], + "Description": "Galaxy wrappers for the Cuffcompare tool.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "http://cole-trapnell-lab.github.io/cufflinks/", + "ToolShed categories": [ + "Transcriptomics" + ], + "ToolShed id": "cuffcompare", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/cufflinks/cuffcompare", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/cufflinks/cuffcompare", + "Galaxy wrapper version": "2.2.1", + "Conda id": "cufflinks", + "Conda version": "2.2.1" + }, + { + "Galaxy wrapper id": "cuffdiff", + "Galaxy tool ids": [ + "cuffdiff" + ], + "Description": "Galaxy wrappers for the Cuffdiff tool.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "http://cole-trapnell-lab.github.io/cufflinks/", + "ToolShed categories": [ + "Transcriptomics" + ], + "ToolShed id": "cuffdiff", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/cufflinks/cuffdiff", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/cufflinks/cuffdiff", + "Galaxy wrapper version": "2.2.1", + "Conda id": "cufflinks", + "Conda version": "2.2.1" + }, + { + "Galaxy wrapper id": "cufflinks", + "Galaxy tool ids": [ + "cufflinks" + ], + "Description": "Galaxy wrappers for the Cufflinks tool.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "http://cole-trapnell-lab.github.io/cufflinks/", + "ToolShed categories": [ + "Transcriptomics" + ], + "ToolShed id": "cufflinks", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/cufflinks/cufflinks", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/cufflinks/cufflinks", + "Galaxy wrapper version": "2.2.1", + "Conda id": "cufflinks", + "Conda version": "2.2.1" + }, + { + "Galaxy wrapper id": "cuffmerge", + "Galaxy tool ids": [ + "cuffmerge" + ], + "Description": "Galaxy wrappers for the Cuffmerge tool.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "http://cole-trapnell-lab.github.io/cufflinks/", + "ToolShed categories": [ + "Transcriptomics" + ], + "ToolShed id": "cuffmerge", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/cufflinks/cuffmerge", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/cufflinks/cuffmerge", + "Galaxy wrapper version": "2.2.1", + "Conda id": "cufflinks", + "Conda version": "2.2.1" + }, + { + "Galaxy wrapper id": "cuffnorm", + "Galaxy tool ids": [ + "cuffnorm" + ], + "Description": "The Cuffnorm tool", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "http://cole-trapnell-lab.github.io/cufflinks/", + "ToolShed categories": [ + "Transcriptomics" + ], + "ToolShed id": "cuffnorm", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/cufflinks/cuffnorm", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/cufflinks/cuffnorm", + "Galaxy wrapper version": "2.2.1", + "Conda id": "cufflinks", + "Conda version": "2.2.1" + }, + { + "Galaxy wrapper id": "cuffquant", + "Galaxy tool ids": [ + "cuffquant" + ], + "Description": "The Cuffquant tool", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "http://cole-trapnell-lab.github.io/cufflinks/", + "ToolShed categories": [ + "Transcriptomics" + ], + "ToolShed id": "cuffquant", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/cufflinks/cuffquant", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/cufflinks/cuffquant", + "Galaxy wrapper version": "2.2.1", + "Conda id": "cufflinks", + "Conda version": "2.2.1" + }, + { + "Galaxy wrapper id": "fasta_clipping_histogram", + "Galaxy tool ids": [ + "cshl_fasta_clipping_histogram" + ], + "Description": "Length Distribution chart", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "http://hannonlab.cshl.edu/fastx_toolkit/", + "ToolShed categories": [ + "Fasta Manipulation", + "Graphics", + "Statistics" + ], + "ToolShed id": "fasta_clipping_histogram", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/fastx_toolkit/fasta_clipping_histogram", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/fastx_toolkit/fasta_clipping_histogram", + "Galaxy wrapper version": "0.0.14", + "Conda id": "fastx_toolkit", + "Conda version": "0.0.14" + }, + { + "Galaxy wrapper id": "fasta_formatter", + "Galaxy tool ids": [ + "cshl_fasta_formatter" + ], + "Description": "FASTA Width formatter", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "http://hannonlab.cshl.edu/fastx_toolkit/", + "ToolShed categories": [ + "Fasta Manipulation" + ], + "ToolShed id": "fasta_formatter", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/fastx_toolkit/fasta_formatter", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/fastx_toolkit/fasta_formatter", + "Galaxy wrapper version": "0.0.14", + "Conda id": "fastx_toolkit", + "Conda version": "0.0.14" + }, + { + "Galaxy wrapper id": "fasta_nucleotide_changer", + "Galaxy tool ids": [ + "cshl_fasta_nucleotides_changer" + ], + "Description": "RNA/DNA converter.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "http://hannonlab.cshl.edu/fastx_toolkit/", + "ToolShed categories": [ + "Fasta Manipulation" + ], + "ToolShed id": "fasta_nucleotide_changer", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/fastx_toolkit/fasta_nucleotide_changer", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/fastx_toolkit/fasta_nucleotide_changer", + "Galaxy wrapper version": "0.0.14", + "Conda id": "fastx_toolkit", + "Conda version": "0.0.14" + }, + { + "Galaxy wrapper id": "fastq_quality_boxplot", + "Galaxy tool ids": [ + "cshl_fastq_quality_boxplot" + ], + "Description": "Draw quality score boxplot", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "http://hannonlab.cshl.edu/fastx_toolkit/", + "ToolShed categories": [ + "Fastq Manipulation", + "Graphics", + "Statistics" + ], + "ToolShed id": "fastq_quality_boxplot", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/fastx_toolkit/fastq_quality_boxplot", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/fastx_toolkit/fastq_quality_boxplot", + "Galaxy wrapper version": "0.0.14", + "Conda id": "fastx_toolkit", + "Conda version": "0.0.14" + }, + { + "Galaxy wrapper id": "fastq_quality_converter", + "Galaxy tool ids": [ + "cshl_fastq_quality_converter" + ], + "Description": "Quality format converter (ASCII-Numeric)", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "http://hannonlab.cshl.edu/fastx_toolkit/", + "ToolShed categories": [ + "Fastq Manipulation" + ], + "ToolShed id": "fastq_quality_converter", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/fastx_toolkit/fastq_quality_converter", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/fastx_toolkit/fastq_quality_converter", + "Galaxy wrapper version": "0.0.14", + "Conda id": "fastx_toolkit", + "Conda version": "0.0.14" + }, + { + "Galaxy wrapper id": "fastq_quality_filter", + "Galaxy tool ids": [ + "cshl_fastq_quality_filter" + ], + "Description": "Filter by quality", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "http://hannonlab.cshl.edu/fastx_toolkit/", + "ToolShed categories": [ + "Fastq Manipulation" + ], + "ToolShed id": "fastq_quality_filter", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/fastx_toolkit/fastq_quality_filter", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/fastx_toolkit/fastq_quality_filter", + "Galaxy wrapper version": "0.0.14", + "Conda id": "fastx_toolkit", + "Conda version": "0.0.14" + }, + { + "Galaxy wrapper id": "fastq_to_fasta", + "Galaxy tool ids": [ + "cshl_fastq_to_fasta" + ], + "Description": "FASTQ to FASTA converter", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "http://hannonlab.cshl.edu/fastx_toolkit/", + "ToolShed categories": [ + "Fasta Manipulation", + "Convert Formats" + ], + "ToolShed id": "fastq_to_fasta", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/fastx_toolkit/fastq_to_fasta", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/fastx_toolkit/fastq_to_fasta", + "Galaxy wrapper version": "0.0.14", + "Conda id": "fastx_toolkit", + "Conda version": "0.0.14" + }, + { + "Galaxy wrapper id": "fastx_artifacts_filter", + "Galaxy tool ids": [ + "cshl_fastx_artifacts_filter" + ], + "Description": "Remove sequencing artifacts", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "http://hannonlab.cshl.edu/fastx_toolkit/", + "ToolShed categories": [ + "Fasta Manipulation", + "Fastq Manipulation" + ], + "ToolShed id": "fastx_artifacts_filter", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/fastx_toolkit/fastx_artifacts_filter", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/fastx_toolkit/fastx_artifacts_filter", + "Galaxy wrapper version": "0.0.14", + "Conda id": "fastx_toolkit", + "Conda version": "0.0.14" + }, + { + "Galaxy wrapper id": "fastx_barcode_splitter", + "Galaxy tool ids": [ + "cshl_fastx_barcode_splitter" + ], + "Description": "Barcode Splitter", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "http://hannonlab.cshl.edu/fastx_toolkit/", + "ToolShed categories": [ + "Fasta Manipulation", + "Fastq Manipulation" + ], + "ToolShed id": "fastx_barcode_splitter", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/fastx_toolkit/fastx_barcode_splitter", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/fastx_toolkit/fastx_barcode_splitter", + "Galaxy wrapper version": "0.0.14", + "Conda id": "fastx_toolkit", + "Conda version": "0.0.14" + }, + { + "Galaxy wrapper id": "fastx_clipper", + "Galaxy tool ids": [ + "cshl_fastx_clipper" + ], + "Description": "Clip adapter sequences", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "http://hannonlab.cshl.edu/fastx_toolkit/", + "ToolShed categories": [ + "Fasta Manipulation", + "Fastq Manipulation" + ], + "ToolShed id": "fastx_clipper", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/fastx_toolkit/fastx_clipper", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/fastx_toolkit/fastx_clipper", + "Galaxy wrapper version": "0.0.14", + "Conda id": "fastx_toolkit", + "Conda version": "0.0.14" + }, + { + "Galaxy wrapper id": "fastx_collapser", + "Galaxy tool ids": [ + "cshl_fastx_collapser" + ], + "Description": "Collapse sequences", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "http://hannonlab.cshl.edu/fastx_toolkit/", + "ToolShed categories": [ + "Fasta Manipulation" + ], + "ToolShed id": "fastx_collapser", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/fastx_toolkit/fastx_collapser", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/fastx_toolkit/fastx_collapser", + "Galaxy wrapper version": "0.0.14", + "Conda id": "fastx_toolkit", + "Conda version": "0.0.14" + }, + { + "Galaxy wrapper id": "fastx_nucleotides_distribution", + "Galaxy tool ids": [ + "cshl_fastx_nucleotides_distribution" + ], + "Description": "Draw nucleotides distribution chart", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "http://hannonlab.cshl.edu/fastx_toolkit/", + "ToolShed categories": [ + "Fastq Manipulation", + "Graphics" + ], + "ToolShed id": "fastx_nucleotides_distribution", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/fastx_toolkit/fastx_nucleotides_distribution", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/fastx_toolkit/fastx_nucleotides_distribution", + "Galaxy wrapper version": "0.0.14", + "Conda id": "fastx_toolkit", + "Conda version": "0.0.14" + }, + { + "Galaxy wrapper id": "fastx_quality_statistics", + "Galaxy tool ids": [ + "cshl_fastx_quality_statistics" + ], + "Description": "Compute quality statistics", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "http://hannonlab.cshl.edu/fastx_toolkit/", + "ToolShed categories": [ + "Fastq Manipulation", + "Statistics" + ], + "ToolShed id": "fastx_quality_statistics", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/fastx_toolkit/fastx_quality_statistics", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/fastx_toolkit/fastx_quality_statistics", + "Galaxy wrapper version": "0.0.14", + "Conda id": "fastx_toolkit", + "Conda version": "0.0.14" + }, + { + "Galaxy wrapper id": "fastx_renamer", + "Galaxy tool ids": [ + "cshl_fastx_renamer" + ], + "Description": "Rename sequences", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "http://hannonlab.cshl.edu/fastx_toolkit/", + "ToolShed categories": [ + "Fasta Manipulation", + "Fastq Manipulation" + ], + "ToolShed id": "fastx_renamer", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/fastx_toolkit/fastx_renamer", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/fastx_toolkit/fastx_renamer", + "Galaxy wrapper version": "0.0.14", + "Conda id": "fastx_toolkit", + "Conda version": "0.0.14" + }, + { + "Galaxy wrapper id": "fastx_reverse_complement", + "Galaxy tool ids": [ + "cshl_fastx_reverse_complement" + ], + "Description": "Reverse-Complement", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "http://hannonlab.cshl.edu/fastx_toolkit/", + "ToolShed categories": [ + "Fastq Manipulation", + "Fasta Manipulation" + ], + "ToolShed id": "fastx_reverse_complement", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/fastx_toolkit/fastx_reverse_complement", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/fastx_toolkit/fastx_reverse_complement", + "Galaxy wrapper version": "0.0.14", + "Conda id": "fastx_toolkit", + "Conda version": "0.0.14" + }, + { + "Galaxy wrapper id": "fastx_trimmer", + "Galaxy tool ids": [ + "cshl_fastx_trimmer" + ], + "Description": "Trim sequences", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "http://hannonlab.cshl.edu/fastx_toolkit/", + "ToolShed categories": [ + "Fasta Manipulation", + "Fastq Manipulation" + ], + "ToolShed id": "fastx_trimmer", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/fastx_toolkit/fastx_trimmer", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/fastx_toolkit/fastx_trimmer", + "Galaxy wrapper version": "0.0.14", + "Conda id": "fastx_toolkit", + "Conda version": "0.0.14" + }, + { + "Galaxy wrapper id": "fastq_combiner", + "Galaxy tool ids": [ + "fastq_combiner" + ], + "Description": "Combine FASTA and QUAL into FASTQ", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/galaxyproject/sequence_utils", + "ToolShed categories": [ + "Fastq Manipulation", + "Fasta Manipulation" + ], + "ToolShed id": "fastq_combiner", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/galaxy_sequence_utils/fastq_combiner", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/galaxy_sequence_utils/fastq_combiner", + "Galaxy wrapper version": "1.1.5", + "Conda id": "galaxy_sequence_utils", + "Conda version": "1.1.5" + }, + { + "Galaxy wrapper id": "fastq_filter", + "Galaxy tool ids": [ + "fastq_filter" + ], + "Description": "Filter FASTQ reads by quality score and length", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/galaxyproject/sequence_utils", + "ToolShed categories": [ + "Fastq Manipulation" + ], + "ToolShed id": "fastq_filter", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/galaxy_sequence_utils/fastq_filter", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/galaxy_sequence_utils/fastq_filter", + "Galaxy wrapper version": "1.1.5", + "Conda id": "galaxy_sequence_utils", + "Conda version": "1.1.5" + }, + { + "Galaxy wrapper id": "fastq_groomer", + "Galaxy tool ids": [ + "fastq_groomer" + ], + "Description": "Convert between various FASTQ quality formats.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/galaxyproject/sequence_utils", + "ToolShed categories": [ + "Fastq Manipulation" + ], + "ToolShed id": "fastq_groomer", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/galaxy_sequence_utils/fastq_groomer", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/galaxy_sequence_utils/fastq_groomer", + "Galaxy wrapper version": "1.1.5", + "Conda id": "galaxy_sequence_utils", + "Conda version": "1.1.5" + }, + { + "Galaxy wrapper id": "fastq_manipulation", + "Galaxy tool ids": [ + "fastq_manipulation" + ], + "Description": "Manipulate FASTQ reads on various attributes.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/galaxyproject/sequence_utils", + "ToolShed categories": [ + "Fastq Manipulation" + ], + "ToolShed id": "fastq_manipulation", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/galaxy_sequence_utils/fastq_manipulation", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/galaxy_sequence_utils/fastq_manipulation", + "Galaxy wrapper version": "1.1.5", + "Conda id": "galaxy_sequence_utils", + "Conda version": "1.1.5" + }, + { + "Galaxy wrapper id": "fastq_masker_by_quality", + "Galaxy tool ids": [ + "fastq_masker_by_quality" + ], + "Description": "FASTQ Masker by quality score", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/galaxyproject/sequence_utils", + "ToolShed categories": [ + "Fastq Manipulation" + ], + "ToolShed id": "fastq_masker_by_quality", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/galaxy_sequence_utils/fastq_masker_by_quality", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/galaxy_sequence_utils/fastq_masker_by_quality", + "Galaxy wrapper version": "1.1.5", + "Conda id": "galaxy_sequence_utils", + "Conda version": "1.1.5" + }, + { + "Galaxy wrapper id": "fastq_paired_end_deinterlacer", + "Galaxy tool ids": [ + "fastq_paired_end_deinterlacer" + ], + "Description": "FASTQ de-interlacer on paired end reads.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/galaxyproject/sequence_utils", + "ToolShed categories": [ + "Fastq Manipulation" + ], + "ToolShed id": "fastq_paired_end_deinterlacer", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/galaxy_sequence_utils/fastq_paired_end_deinterlacer", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/galaxy_sequence_utils/fastq_paired_end_deinterlacer", + "Galaxy wrapper version": "1.1.5", + "Conda id": "galaxy_sequence_utils", + "Conda version": "1.1.5" + }, + { + "Galaxy wrapper id": "fastq_paired_end_interlacer", + "Galaxy tool ids": [ + "fastq_paired_end_interlacer" + ], + "Description": "FASTQ interlacer on paired end reads", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/galaxyproject/sequence_utils", + "ToolShed categories": [ + "Fastq Manipulation" + ], + "ToolShed id": "fastq_paired_end_interlacer", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/galaxy_sequence_utils/fastq_paired_end_interlacer", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/galaxy_sequence_utils/fastq_paired_end_interlacer", + "Galaxy wrapper version": "1.1.5", + "Conda id": "galaxy_sequence_utils", + "Conda version": "1.1.5" + }, + { + "Galaxy wrapper id": "fastq_paired_end_joiner", + "Galaxy tool ids": [ + "fastq_paired_end_joiner" + ], + "Description": "FASTQ joiner on paired end reads", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/galaxyproject/sequence_utils", + "ToolShed categories": [ + "Fastq Manipulation" + ], + "ToolShed id": "fastq_paired_end_joiner", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/galaxy_sequence_utils/fastq_paired_end_joiner", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/galaxy_sequence_utils/fastq_paired_end_joiner", + "Galaxy wrapper version": "1.1.5", + "Conda id": "galaxy_sequence_utils", + "Conda version": "1.1.5" + }, + { + "Galaxy wrapper id": "fastq_paired_end_splitter", + "Galaxy tool ids": [ + "fastq_paired_end_splitter" + ], + "Description": "FASTQ splitter on joined paired end reads", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/galaxyproject/sequence_utils", + "ToolShed categories": [ + "Fastq Manipulation" + ], + "ToolShed id": "fastq_paired_end_splitter", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/galaxy_sequence_utils/fastq_paired_end_splitter", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/galaxy_sequence_utils/fastq_paired_end_splitter", + "Galaxy wrapper version": "1.1.5", + "Conda id": "galaxy_sequence_utils", + "Conda version": "1.1.5" + }, + { + "Galaxy wrapper id": "fastq_stats", + "Galaxy tool ids": [ + "fastq_stats" + ], + "Description": "FASTQ Summary Statistics by column", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/galaxyproject/sequence_utils", + "ToolShed categories": [ + "Fastq Manipulation" + ], + "ToolShed id": "fastq_stats", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/galaxy_sequence_utils/fastq_stats", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/galaxy_sequence_utils/fastq_stats", + "Galaxy wrapper version": "1.1.5", + "Conda id": "galaxy_sequence_utils", + "Conda version": "1.1.5" + }, + { + "Galaxy wrapper id": "fastq_to_tabular", + "Galaxy tool ids": [ + "fastq_to_tabular" + ], + "Description": "FASTQ to Tabular converter", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/galaxyproject/sequence_utils", + "ToolShed categories": [ + "Fastq Manipulation" + ], + "ToolShed id": "fastq_to_tabular", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/galaxy_sequence_utils/fastq_to_tabular", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/galaxy_sequence_utils/fastq_to_tabular", + "Galaxy wrapper version": "1.1.5", + "Conda id": "galaxy_sequence_utils", + "Conda version": "1.1.5" + }, + { + "Galaxy wrapper id": "fastq_trimmer", + "Galaxy tool ids": [ + "fastq_trimmer" + ], + "Description": "FASTQ Trimmer by quality", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/galaxyproject/sequence_utils", + "ToolShed categories": [ + "Fastq Manipulation" + ], + "ToolShed id": "fastq_trimmer", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/galaxy_sequence_utils/fastq_trimmer", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/galaxy_sequence_utils/fastq_trimmer", + "Galaxy wrapper version": "1.1.5", + "Conda id": "galaxy_sequence_utils", + "Conda version": "1.1.5" + }, + { + "Galaxy wrapper id": "fastqtofasta", + "Galaxy tool ids": [ + "fastq_to_fasta_python" + ], + "Description": "FASTQ to FASTA converter", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/galaxyproject/sequence_utils", + "ToolShed categories": [ + "Fastq Manipulation" + ], + "ToolShed id": "fastqtofasta", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/galaxy_sequence_utils/fastqtofasta", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/galaxy_sequence_utils/fastqtofasta", + "Galaxy wrapper version": "1.1.5", + "Conda id": "galaxy_sequence_utils", + "Conda version": "1.1.5" + }, + { + "Galaxy wrapper id": "tabular_to_fastq", + "Galaxy tool ids": [ + "tabular_to_fastq" + ], + "Description": "Tabular to FASTQ converter", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "Up-to-date", + "Source": "https://github.com/galaxyproject/sequence_utils", + "ToolShed categories": [ + "Fastq Manipulation" + ], + "ToolShed id": "tabular_to_fastq", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/galaxy_sequence_utils/tabular_to_fastq", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/galaxy_sequence_utils/tabular_to_fastq", + "Galaxy wrapper version": "1.1.5", + "Conda id": "galaxy_sequence_utils", + "Conda version": "1.1.5" + }, + { + "Galaxy wrapper id": "kraken", + "Galaxy tool ids": [ + "kraken-filter", + "kraken-mpa-report", + "kraken-report", + "kraken-translate", + "kraken" + ], + "Description": "Kraken is a system for assigning taxonomic labels to short DNAsequences, usually obtained through metagenomic studies. Previous attempts by otherbioinformatics software to accomplish this task have often used sequence alignmentor machine learning techniques that were quite slow, leading to the developmentof less sensitive but much faster abundance estimation programs. Kraken aims toachieve high sensitivity and high speed by utilizing exact alignments of k-mersand a novel classification algorithm.", + "bio.tool id": "kraken", + "bio.tool ids": [ + "kraken" + ], + "biii": null, + "bio.tool name": "Kraken", + "bio.tool description": "System for assigning taxonomic labels to short DNA sequences, usually obtained through metagenomic studies. Previous attempts by other bioinformatics software to accomplish this task have often used sequence alignment or machine learning techniques that were quite slow, leading to the development of less sensitive but much faster abundance estimation programs. It aims to achieve high sensitivity and high speed by utilizing exact alignments of k-mers and a novel classification algorithm.", + "EDAM operation": [ + "Taxonomic classification" + ], + "EDAM topic": [ + "Taxonomy", + "Metagenomics" + ], + "Status": "To update", + "Source": "http://ccb.jhu.edu/software/kraken/", + "ToolShed categories": [ + "Metagenomics" + ], + "ToolShed id": "kraken", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/blob/master/tool_collections/kraken/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/kraken", + "Galaxy wrapper version": null, + "Conda id": "kraken", + "Conda version": "1.1.1" + }, + { + "Galaxy wrapper id": "kraken2", + "Galaxy tool ids": [ + "kraken2" + ], + "Description": "Kraken2 for taxonomic designation.", + "bio.tool id": "kraken2", + "bio.tool ids": [ + "kraken2" + ], + "biii": null, + "bio.tool name": "kraken2", + "bio.tool description": "Kraken 2 is the newest version of Kraken, a taxonomic classification system using exact k-mer matches to achieve high accuracy and fast classification speeds. This classifier matches each k-mer within a query sequence to the lowest common ancestor (LCA) of all genomes containing the given k-mer. The k-mer assignments inform the classification algorithm.", + "EDAM operation": [ + "Taxonomic classification" + ], + "EDAM topic": [ + "Taxonomy", + "Metagenomics" + ], + "Status": "To update", + "Source": "http://ccb.jhu.edu/software/kraken/", + "ToolShed categories": [ + "Metagenomics" + ], + "ToolShed id": "kraken2", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/blob/master/tool_collections/kraken2/kraken2/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/kraken2/kraken2", + "Galaxy wrapper version": "2.1.1", + "Conda id": "kraken2", + "Conda version": "2.1.3" + }, + { + "Galaxy wrapper id": "samtools", + "Galaxy tool ids": [], + "Description": null, + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/samtools/samtools", + "ToolShed categories": [ + "SAM" + ], + "ToolShed id": null, + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/samtools", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/samtools", + "Galaxy wrapper version": "1.15.1", + "Conda id": "samtools", + "Conda version": "1.20" + }, + { + "Galaxy wrapper id": "snpeff", + "Galaxy tool ids": [ + "snpEff", + "snpEff_build_gb", + "snpEff_databases", + "snpEff_download", + "snpEff_get_chr_names" + ], + "Description": "SnpEff is a genetic variant annotation and effect prediction toolbox", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "http://snpeff.sourceforge.net/", + "ToolShed categories": [ + "Genome-Wide Association Study", + "Variant Analysis" + ], + "ToolShed id": "snpeff", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/snpeff", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/snpeff", + "Galaxy wrapper version": null, + "Conda id": "biopython", + "Conda version": "1.70" + }, + { + "Galaxy wrapper id": "snpsift", + "Galaxy tool ids": [ + "snpSift_annotate", + "snpSift_caseControl", + "snpSift_extractFields", + "snpSift_filter", + "snpSift_int", + "snpSift_rmInfo", + "snpsift_vartype", + "snpSift_vcfCheck" + ], + "Description": "snpEff SnpSift tools from Pablo Cingolani", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "http://snpeff.sourceforge.net/SnpSift.html", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "snpsift", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/snpsift/snpsift", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/snpsift/snpsift", + "Galaxy wrapper version": null, + "Conda id": "snpsift", + "Conda version": "5.2" + }, + { + "Galaxy wrapper id": "snpsift_dbnsfp", + "Galaxy tool ids": [ + "snpSift_dbnsfp" + ], + "Description": "snpEff SnpSift dbnsfp tool from Pablo Cingolani", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "http://snpeff.sourceforge.net/SnpSift.html#dbNSFP", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "snpsift_dbnsfp", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/snpsift/snpsift_dbnsfp", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/snpsift/snpsift_dbnsfp", + "Galaxy wrapper version": null, + "Conda id": "snpsift", + "Conda version": "5.2" + }, + { + "Galaxy wrapper id": "snpsift_genesets", + "Galaxy tool ids": [ + "snpSift_geneSets" + ], + "Description": "Annotate SnpEff vcf with genesets such as Gene Ontology (GO), KEGG, Reactome", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "http://snpeff.sourceforge.net/SnpSift.html#geneSets", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "snpsift_genesets", + "Galaxy wrapper owner": "iuc", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/snpsift/snpsift_genesets/", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/snpsift/snpsift_genesets", + "Galaxy wrapper version": null, + "Conda id": "snpsift", + "Conda version": "5.2" + }, + { + "Galaxy wrapper id": "vcf2tsv", + "Galaxy tool ids": [ + "vcf2tsv" + ], + "Description": "Converts VCF files into tab-delimited format", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/ekg/vcflib", + "ToolShed categories": [ + "Variant Analysis", + "Convert Formats" + ], + "ToolShed id": "vcf2tsv", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/vcflib/vcf2tsv", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/vcflib/vcf2tsv", + "Galaxy wrapper version": null, + "Conda id": "vcflib", + "Conda version": "1.0.9" + }, + { + "Galaxy wrapper id": "vcfaddinfo", + "Galaxy tool ids": [ + "vcfaddinfo" + ], + "Description": "Adds info fields from the second dataset which are not present in the first dataset.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/ekg/vcflib", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "vcfaddinfo", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/vcflib/vcfaddinfo", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/vcflib/vcfaddinfo", + "Galaxy wrapper version": null, + "Conda id": "vcflib", + "Conda version": "1.0.9" + }, + { + "Galaxy wrapper id": "vcfallelicprimitives", + "Galaxy tool ids": [ + "vcfallelicprimitives" + ], + "Description": "Splits alleleic primitives (gaps or mismatches) into multiple VCF lines", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/ekg/vcflib", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "vcfallelicprimitives", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/vcflib/vcfallelicprimitives", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/vcflib/vcfallelicprimitives", + "Galaxy wrapper version": null, + "Conda id": "vcflib", + "Conda version": "1.0.9" + }, + { + "Galaxy wrapper id": "vcfannotate", + "Galaxy tool ids": [ + "vcfannotate" + ], + "Description": "Intersect VCF records with BED annotations", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/ekg/vcflib", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "vcfannotate", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/vcflib/vcfannotate", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/vcflib/vcfannotate", + "Galaxy wrapper version": null, + "Conda id": "vcflib", + "Conda version": "1.0.9" + }, + { + "Galaxy wrapper id": "vcfannotategenotypes", + "Galaxy tool ids": [ + "vcfannotategenotypes" + ], + "Description": "Annotate genotypes in a VCF dataset using genotypes from another VCF dataset.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/ekg/vcflib", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "vcfannotategenotypes", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/vcflib/vcfannotategenotypes", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/vcflib/vcfannotategenotypes", + "Galaxy wrapper version": null, + "Conda id": "vcflib", + "Conda version": "1.0.9" + }, + { + "Galaxy wrapper id": "vcfbedintersect", + "Galaxy tool ids": [ + "vcfbedintersect" + ], + "Description": "Intersect VCF and BED datasets", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/ekg/vcflib", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "vcfbedintersect", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/vcflib/vcfbedintersect", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/vcflib/vcfbedintersect", + "Galaxy wrapper version": null, + "Conda id": "vcflib", + "Conda version": "1.0.9" + }, + { + "Galaxy wrapper id": "vcfbreakcreatemulti", + "Galaxy tool ids": [ + "vcfbreakcreatemulti" + ], + "Description": "Break multiple alleles into multiple records, or combine overallpoing alleles into a single record", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/ekg/vcflib", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "vcfbreakcreatemulti", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/vcflib/vcfbreakcreatemulti", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/vcflib/vcfbreakcreatemulti", + "Galaxy wrapper version": null, + "Conda id": "vcflib", + "Conda version": "1.0.9" + }, + { + "Galaxy wrapper id": "vcfcheck", + "Galaxy tool ids": [ + "vcfcheck" + ], + "Description": "Verify that the reference allele matches the reference genome", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/ekg/vcflib", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "vcfcheck", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/vcflib/vcfcheck", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/vcflib/vcfcheck", + "Galaxy wrapper version": null, + "Conda id": "vcflib", + "Conda version": "1.0.9" + }, + { + "Galaxy wrapper id": "vcfcombine", + "Galaxy tool ids": [ + "vcfcombine" + ], + "Description": "Combine multiple VCF datasets", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/ekg/vcflib", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "vcfcombine", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/vcflib/vcfcombine", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/vcflib/vcfcombine", + "Galaxy wrapper version": null, + "Conda id": "vcflib", + "Conda version": "1.0.9" + }, + { + "Galaxy wrapper id": "vcfcommonsamples", + "Galaxy tool ids": [ + "vcfcommonsamples" + ], + "Description": "Output records belonging to samples commong between two datasets.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/ekg/vcflib", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "vcfcommonsamples", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/vcflib/vcfcommonsamples", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/vcflib/vcfcommonsamples", + "Galaxy wrapper version": null, + "Conda id": "vcflib", + "Conda version": "1.0.9" + }, + { + "Galaxy wrapper id": "vcfdistance", + "Galaxy tool ids": [ + "vcfdistance" + ], + "Description": "Calculate distance to the nearest variant.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/ekg/vcflib", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "vcfdistance", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/vcflib/vcfdistance", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/vcflib/vcfdistance", + "Galaxy wrapper version": null, + "Conda id": "vcflib", + "Conda version": "1.0.9" + }, + { + "Galaxy wrapper id": "vcffilter", + "Galaxy tool ids": [ + "vcffilter2" + ], + "Description": "Tool for filtering VCF files", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/ekg/vcflib", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "vcffilter", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/vcflib/vcffilter", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/vcflib/vcffilter", + "Galaxy wrapper version": null, + "Conda id": "vcflib", + "Conda version": "1.0.9" + }, + { + "Galaxy wrapper id": "vcffixup", + "Galaxy tool ids": [ + "vcffixup" + ], + "Description": "Count the allele frequencies across alleles present in each record in the VCF file.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/ekg/vcflib", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "vcffixup", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/vcflib/vcffixup", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/vcflib/vcffixup", + "Galaxy wrapper version": null, + "Conda id": "vcflib", + "Conda version": "1.0.9" + }, + { + "Galaxy wrapper id": "vcfflatten", + "Galaxy tool ids": [ + "vcfflatten2" + ], + "Description": "Removes multi-allelic sites by picking the most common alternate", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/ekg/vcflib", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "vcfflatten", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/vcflib/vcfflatten", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/vcflib/vcfflatten", + "Galaxy wrapper version": null, + "Conda id": "vcflib", + "Conda version": "1.0.9" + }, + { + "Galaxy wrapper id": "vcfgeno2haplo", + "Galaxy tool ids": [ + "vcfgeno2haplo" + ], + "Description": "Convert genotype-based phased alleles into haplotype alleles", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/ekg/vcflib", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "vcfgeno2haplo", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/vcflib/vcfgeno2haplo", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/vcflib/vcfgeno2haplo", + "Galaxy wrapper version": null, + "Conda id": "vcflib", + "Conda version": "1.0.9" + }, + { + "Galaxy wrapper id": "vcfgenotypes", + "Galaxy tool ids": [ + "vcfgenotypes" + ], + "Description": "Convert numerical representation of genotypes to allelic.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/ekg/vcflib", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "vcfgenotypes", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/vcflib/vcfgenotypes", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/vcflib/vcfgenotypes", + "Galaxy wrapper version": null, + "Conda id": "vcflib", + "Conda version": "1.0.9" + }, + { + "Galaxy wrapper id": "vcfhethom", + "Galaxy tool ids": [ + "vcfhethom" + ], + "Description": "Count the number of heterozygotes and alleles, compute het/hom ratio.", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/ekg/vcflib", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "vcfhethom", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/vcflib/vcfhethom", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/vcflib/vcfhethom", + "Galaxy wrapper version": null, + "Conda id": "vcflib", + "Conda version": "1.0.9" + }, + { + "Galaxy wrapper id": "vcfleftalign", + "Galaxy tool ids": [ + "vcfleftalign" + ], + "Description": "Left-align indels and complex variants in VCF dataset", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/ekg/vcflib", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "vcfleftalign", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/vcflib/vcfleftalign", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/vcflib/vcfleftalign", + "Galaxy wrapper version": null, + "Conda id": "vcflib", + "Conda version": "1.0.9" + }, + { + "Galaxy wrapper id": "vcfprimers", + "Galaxy tool ids": [ + "vcfprimers" + ], + "Description": "Extract flanking sequences for each VCF record", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/ekg/vcflib", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "vcfprimers", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/vcflib/vcfprimers", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/vcflib/vcfprimers", + "Galaxy wrapper version": null, + "Conda id": "vcflib", + "Conda version": "1.0.9" + }, + { + "Galaxy wrapper id": "vcfrandomsample", + "Galaxy tool ids": [ + "vcfrandomsample" + ], + "Description": "Randomly sample sites from VCF dataset", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/ekg/vcflib", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "vcfrandomsample", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/vcflib/vcfrandomsample", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/vcflib/vcfrandomsample", + "Galaxy wrapper version": null, + "Conda id": "vcflib", + "Conda version": "1.0.9" + }, + { + "Galaxy wrapper id": "vcfselectsamples", + "Galaxy tool ids": [ + "vcfselectsamples" + ], + "Description": "Select samples from a VCF file", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/ekg/vcflib", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "vcfselectsamples", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/vcflib/vcfselectsamples", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/vcflib/vcfselectsamples", + "Galaxy wrapper version": null, + "Conda id": "vcflib", + "Conda version": "1.0.9" + }, + { + "Galaxy wrapper id": "vcfsort", + "Galaxy tool ids": [ + "vcfsort" + ], + "Description": "Sort VCF dataset by coordinate", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/ekg/vcflib", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "vcfsort", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/vcflib/vcfsort", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/vcflib/vcfsort", + "Galaxy wrapper version": null, + "Conda id": "vcflib", + "Conda version": "1.0.9" + }, + { + "Galaxy wrapper id": "vcfvcfintersect", + "Galaxy tool ids": [ + "vcfvcfintersect" + ], + "Description": "Intersect two VCF datasets", + "bio.tool id": null, + "bio.tool ids": [], + "biii": null, + "bio.tool name": null, + "bio.tool description": null, + "EDAM operation": [], + "EDAM topic": [], + "Status": "To update", + "Source": "https://github.com/ekg/vcflib", + "ToolShed categories": [ + "Variant Analysis" + ], + "ToolShed id": "vcfvcfintersect", + "Galaxy wrapper owner": "devteam", + "Galaxy wrapper source": "https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/vcflib/vcfvcfintersect", + "Galaxy wrapper parsed folder": "https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/vcflib/vcfvcfintersect", + "Galaxy wrapper version": null, + "Conda id": "vcflib", + "Conda version": "1.0.9" + } +] \ No newline at end of file diff --git a/results/repositories03.list_tools.tsv b/results/repositories03.list_tools.tsv index 3d05a27c..6022d85e 100644 --- a/results/repositories03.list_tools.tsv +++ b/results/repositories03.list_tools.tsv @@ -22,6 +22,9 @@ augustus 8864.0 516.0 augustus, augustus_training AUGUSTUS is a program that pre b2btools b2btools_single_sequence This software suite provides structural predictions for protein sequences made by Bio2Byte group.About Bio2Byte: We investigate how the dynamics, conformational states, and available experimental data of proteins relate to their amino acid sequence.Underlying physical and chemical principles are computationally unraveled through data integration, analysis, and machine learning, so connecting themto biological events and improving our understanding of the way proteins work. b2btools b2btools b2bTools The bio2byte tools server (b2btools) offers the following single protein sequence based predictions:- Backbone and sidechain dynamics (DynaMine)- Helix, sheet, coil and polyproline-II propensity- Early folding propensity (EFoldMine)- Disorder (DisoMine)- Beta-sheet aggregation (Agmata)In addition, multiple sequence alignments (MSAs) can be uploaded to scan the 'biophysical limits' of a protein family as defined in the MSA Protein disorder prediction, Protein secondary structure prediction, Protein feature detection To update https://bio2byte.be Computational chemistry, Molecular Dynamics, Proteomics, Sequence Analysis, Synthetic Biology iuc https://github.com/galaxyproject/tools-iuc/tree/main/tools/b2btools 3.0.5+galaxy0 b2btools 3.0.6 (0/1) (0/1) (1/1) (0/1) bakta 2982.0 151.0 bakta """Bakta is a tool for the rapid & standardized annotation of bacterial genomes and plasmids from both isolates and MAGs.It provides dbxref-rich and sORF-including annotations in machine-readable JSON & bioinformatics standard file formats for automatic downstream analysis.""" bakta bakta Bakta Rapid & standardized annotation of bacterial genomes, MAGs & plasmids Genome annotation Genomics, Data submission, annotation and curation, Sequence analysis Up-to-date https://github.com/oschwengers/bakta Sequence Analysis bakta iuc https://github.com/galaxyproject/tools-iuc/blob/master/tools/bakta https://github.com/galaxyproject/tools-iuc/tree/main/tools/bakta 1.9.3 bakta 1.9.3 (0/1) (1/1) (1/1) (1/1) bam_to_scidx 128.0 4.0 bam_to_scidx Contains a tool that converts a BAM file to an ScIdx file. To update https://github.com/seqcode/cegr-tools/tree/master/src/org/seqcode/cegrtools/bamtoscidx Convert Formats bam_to_scidx iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/bam_to_scidx https://github.com/galaxyproject/tools-iuc/tree/main/tools/bam_to_scidx 1.0.1 openjdk (1/1) (0/1) (1/1) (0/1) +bamtools 14039.0 208.0 bamtools Operate on and transform BAM datasets in various ways using bamtools bamtools bamtools BamTools BamTools provides a fast, flexible C++ API & toolkit for reading, writing, and managing BAM files. Data handling, Sequence alignment analysis Sequencing, Data management, Sequence analysis Up-to-date https://github.com/pezmaster31/bamtools Sequence Analysis, SAM bamtools devteam https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/bamtools/bamtools https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/bamtools/bamtools 2.5.2 bamtools 2.5.2 (1/1) (0/1) (1/1) (1/1) +bamtools_filter 114845.0 1195.0 bamFilter Filter BAM datasets on various attributes using bamtools filter bamtools bamtools BamTools BamTools provides a fast, flexible C++ API & toolkit for reading, writing, and managing BAM files. Data handling, Sequence alignment analysis Sequencing, Data management, Sequence analysis Up-to-date https://github.com/pezmaster31/bamtools Sequence Analysis, SAM bamtools_filter devteam https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/bamtools/bamtools_filter https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/bamtools/bamtools_filter 2.5.2 bamtools 2.5.2 (1/1) (1/1) (1/1) (1/1) +bamtools_split 1434.0 47.0 bamtools_split_mapped, bamtools_split_paired, bamtools_split_ref, bamtools_split_tag Utility for filtering BAM files. It is based on the BAMtools suiteof tools by Derek Barnett. bamtools bamtools BamTools BamTools provides a fast, flexible C++ API & toolkit for reading, writing, and managing BAM files. Data handling, Sequence alignment analysis Sequencing, Data management, Sequence analysis Up-to-date https://github.com/pezmaster31/bamtools Sequence Analysis, SAM iuc https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/bamtools/bamtools_split https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/bamtools/bamtools_split 2.5.2 bamtools 2.5.2 (4/4) (2/4) (4/4) (0/4) bamutil bamutil_clip_overlap, bamutil_diff bamUtil is a repository that contains several programs that perform operations on SAM/BAM files. To update https://github.com/statgen/bamUtil Sequence Analysis bamutil iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/bamutil https://github.com/galaxyproject/tools-iuc/tree/main/tools/bamutil bamutil 1.0.15 (1/2) (1/2) (1/2) (0/2) bandage 44390.0 2016.0 bandage_image, bandage_info Bandage - A Bioinformatics Application for Navigating De novo Assembly Graphs Easily bandage bandage Bandage GUI program that allows users to interact with the assembly graphs made by de novo assemblers such as Velvet, SPAdes, MEGAHIT and others. It visualises assembly graphs, with connections, using graph layout algorithms. Sequence assembly visualisation Genomics, Sequence assembly Up-to-date https://github.com/rrwick/Bandage Visualization bandage iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/bandage https://github.com/galaxyproject/tools-iuc/tree/main/tools/bandage 2022.09 bandage_ng 2022.09 (2/2) (2/2) (2/2) (2/2) barcode_splitter barcode_splitter A utility to split sequence files using multiple sets of barcodes To update https://bitbucket.org/princeton_genomics/barcode_splitter/ Fastq Manipulation barcode_splitter iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/barcode_splitter https://github.com/galaxyproject/tools-iuc/tree/main/tools/barcode_splitter 0.18.4.0 barcode_splitter 0.18.6 (0/1) (0/1) (0/1) (0/1) @@ -38,13 +41,14 @@ beagle 54.0 10.0 beagle Beagle is a program for phasing and imputing missing gen bedops bedops-sort-bed BEDOPS: high-performance genomic feature operations Up-to-date https://bedops.readthedocs.io/en/latest/ Genomic Interval Operations bedops_sortbed iuc https://bedops.readthedocs.io/ https://github.com/galaxyproject/tools-iuc/tree/main/tools/bedops 2.4.41 bedops 2.4.41 (1/1) (0/1) (1/1) (0/1) bedtools 936832.0 6318.0 bedtools_annotatebed, bedtools_bamtobed, bedtools_bed12tobed6, bedtools_bedtobam, bedtools_bedtoigv, bedtools_bedpetobam, bedtools_closestbed, bedtools_clusterbed, bedtools_complementbed, bedtools_coveragebed, bedtools_expandbed, bedtools_fisher, bedtools_flankbed, bedtools_genomecoveragebed, bedtools_getfastabed, bedtools_groupbybed, bedtools_intersectbed, bedtools_jaccard, bedtools_links, bedtools_makewindowsbed, bedtools_map, bedtools_maskfastabed, bedtools_mergebed, bedtools_multicovtbed, bedtools_multiintersectbed, bedtools_nucbed, bedtools_overlapbed, bedtools_randombed, bedtools_reldistbed, bedtools_shufflebed, bedtools_slopbed, bedtools_sortbed, bedtools_spacingbed, bedtools_subtractbed, bedtools_tagbed, bedtools_unionbedgraph, bedtools_windowbed bedtools is a powerful toolset for genome arithmetic bedtools bedtools BEDTools BEDTools is an extensive suite of utilities for comparing genomic features in BED format. Mapping Genomics Up-to-date https://github.com/arq5x/bedtools2 Genomic Interval Operations, Text Manipulation bedtools iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/bedtools https://github.com/galaxyproject/tools-iuc/tree/main/tools/bedtools 2.31.1 bedtools 2.31.1 (37/37) (37/37) (37/37) (37/37) bellerophon 1194.0 123.0 bellerophon Filter mapped reads where the mapping spans a junction, retaining the 5-prime read. Up-to-date https://github.com/davebx/bellerophon Sequence Analysis bellerophon iuc https://github.com/davebx/bellerophon https://github.com/galaxyproject/tools-iuc/tree/main/tools/bellerophon 1.0 bellerophon 1.0 (1/1) (1/1) (1/1) (0/1) -berokka berokka Berokka is used to trim, circularise, orient & filter long read bacterial genome assemblies. Up-to-date https://github.com/tseemann/berokka Fasta Manipulation berokka iuc https://github.com/galaxyproject/tools-iuc/blob/master/tools/berokka https://github.com/galaxyproject/tools-iuc/tree/main/tools/berokka 0.2.3 berokka 0.2.3 (0/1) (1/1) (0/1) (0/1) +berokka berokka Berokka is used to trim, circularise, orient & filter long read bacterial genome assemblies. To update https://github.com/tseemann/berokka Fasta Manipulation berokka iuc https://github.com/galaxyproject/tools-iuc/blob/master/tools/berokka https://github.com/galaxyproject/tools-iuc/tree/main/tools/berokka 0.2.3 berokka (0/1) (1/1) (0/1) (0/1) bigscape bigscape Construct sequence similarity networks of BGCs and groups them into GCF BiG-SCAPE BiG-SCAPE BiG-SCAPE A computational framework to explore large-scale biosynthetic diversity.BiG-SCAPE (Biosynthetic Gene Similarity Clustering and Prospecting Engine) is a software package, written in Python, that constructs sequence similarity networks of Biosynthetic Gene Clusters (BGCs) and groups them into Gene Cluster Families (GCFs). BiG-SCAPE does this by rapidly calculating a distance matrix between gene clusters based on a comparison of their protein domain content, order, copy number and sequence identity.It defines a distance metric between Gene Clusters using a combination of three indices (Jaccard Index of domain types, Domain Sequence Similarity the Adjacency...BiG-SCAPE and CORASON provide a set of tools to explore the diversity of biosynthetic gene clusters (BGCs) across large numbers of genomes, by constructing BGC sequence similarity networks, grouping BGCs into gene cluster families, and exploring gene cluster diversity linked to enzyme phylogenies. Clustering, Global alignment, Fold recognition Phylogeny, Microbial ecology, Mapping, Metabolomics, Bioinformatics, Gene and protein families Up-to-date https://github.com/medema-group/BiG-SCAPE Metagenomics bigscape iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/bigscape/ https://github.com/galaxyproject/tools-iuc/tree/main/tools/bigscape 1.1.9 bigscape 1.1.9 (0/1) (0/1) (1/1) (0/1) binning_refiner 81.0 21.0 bin_refiner Reconciles the outputs of different binning programs with the aim to improve the quality of genome bins,especially with respect to contamination levels. binning_refiner binning_refiner Binning_refiner Improving genome bins through the combination of different binning programs Read binning, Sequence clustering Metagenomics, Sequence assembly, Microbial ecology Up-to-date https://github.com/songweizhi/Binning_refiner Metagenomics binning_refiner iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/binning_refiner/ https://github.com/galaxyproject/tools-iuc/tree/main/tools/binning_refiner 1.4.3 binning_refiner 1.4.3 (0/1) (0/1) (1/1) (0/1) -bioext bioext_bam2msa, bioext_bealign A suite of Galaxy tools designed around the BioExt extension to BioPython. Align sequences, merge duplicate sequences into one, and more! Up-to-date https://pypi.python.org/pypi/biopython-extensions/ Next Gen Mappers iuc https://github.com/davebx/bioext-gx/ https://github.com/galaxyproject/tools-iuc/tree/main/tools/bioext 0.21.2 python-bioext 0.21.2 (2/2) (0/2) (2/2) (0/2) +bioext bioext_bam2msa, bioext_bealign A suite of Galaxy tools designed around the BioExt extension to BioPython. Align sequences, merge duplicate sequences into one, and more! To update https://pypi.python.org/pypi/biopython-extensions/ Next Gen Mappers iuc https://github.com/davebx/bioext-gx/ https://github.com/galaxyproject/tools-iuc/tree/main/tools/bioext 0.21.2 python-bioext (2/2) (0/2) (2/2) (0/2) bioinformatics_cafe fasta_regex_finder Miscellanea of scripts for bioinformatics To update https://github.com/dariober/bioinformatics-cafe/ Sequence Analysis bioinformatics_cafe mbernt https://github.com/galaxyproject/tools-iuc/tree/main/tools/bioinformatics-cafe https://github.com/galaxyproject/tools-iuc/tree/main/tools/bioinformatics_cafe 0.1.0 python (1/1) (0/1) (1/1) (0/1) biom_format biom_add_metadata, biom_convert, biom_from_uc, biom_normalize_table, biom_subset_table, biom_summarize_table The biom-format package provides a command line interface and Python API for working with BIOM files. biomformat biomformat biomformat "This package includes basic tools for reading biom-format files, accessing and subsetting data tables from a biom object, as well as limited support for writing a biom-object back to a biom-format file. The design of this API is intended to match the python API and other tools included with the biom-format project, but with a decidedly ""R flavor"" that should be familiar to R users. This includes S4 classes and methods, as well as extensions of common core functions/methods." Formatting Laboratory information management, Sequence analysis To update https://github.com/biocore/biom-format Metagenomics iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/biom_format https://github.com/galaxyproject/tools-iuc/tree/main/tools/biom_format 2.1.15 biom-format 2.1.7 (2/6) (2/6) (6/6) (0/6) bioperl bp_genbank2gff3 Converts GenBank format files to GFF3 bioperl bioperl BioPerl A collection of Perl modules that facilitate the development of Perl scripts for bioinformatics applications. It provides software modules for many of the typical tasks of bioinformatics programming. Data handling, Service invocation Genomics, Software engineering, Data management To update https://bioperl.org/ Sequence Analysis bp_genbank2gff3 iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/bioperl https://github.com/galaxyproject/tools-iuc/tree/main/tools/bioperl 1.1 perl-bioperl 1.7.8 (1/1) (1/1) (1/1) (1/1) +biotradis bacteria_tradis, tradis_essentiality, tradis_gene_insert_sites Bio-Tradis is a tool suite dedicated to essentiality analyses with TraDis data. biotradis biotradis biotradis The Bio::TraDIS pipeline provides software utilities for the processing, mapping, and analysis of transposon insertion sequencing data. The pipeline was designed with the data from the TraDIS sequencing protocol in mind, but should work with a variety of transposon insertion sequencing protocols as long as they produce data in the expected format. Sequence analysis Mobile genetic elements, Workflows Up-to-date https://www.sanger.ac.uk/science/tools/bio-tradis Genome annotation biotradis iuc https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/biotradis https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/biotradis 1.4.5 biotradis 1.4.5 (3/3) (0/3) (0/3) (0/3) biscot 3.0 1.0 biscot Bionano scaffolding correction tool Up-to-date https://github.com/institut-de-genomique/biscot Assembly biscot iuc https://github.com/bgruening/iuc/tree/master/tools/biscot https://github.com/galaxyproject/tools-iuc/tree/main/tools/biscot 2.3.3 biscot 2.3.3 (0/1) (0/1) (1/1) (0/1) blast magicblast Maps large next-generation RNA or DNA sequencing runs against a whole genome or transcriptome Up-to-date https://ncbi.github.io/magicblast/ Next Gen Mappers magicblast iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/blast https://github.com/galaxyproject/tools-iuc/tree/main/tools/blast 1.7.0 magicblast 1.7.0 (0/1) (0/1) (1/1) (0/1) blastxml_to_gapped_gff3 185.0 24.0 blastxml_to_gapped_gff3 BlastXML to gapped GFF3 To update Convert Formats, Sequence Analysis blastxml_to_gapped_gff3 iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/blastxml_to_gapped_gff3 https://github.com/galaxyproject/tools-iuc/tree/main/tools/blastxml_to_gapped_gff3 1.1 bcbiogff 0.6.6 (1/1) (1/1) (1/1) (0/1) @@ -54,7 +58,7 @@ breseq 1871.0 50.0 breseq Predicts mutations in microbial genomes breseq breseq busco 86180.0 1804.0 busco BUSCO assess genome and annotation completeness busco busco BUSCO Provides measures for quantitative assessment of genome assembly, gene set, and transcriptome completeness based on evolutionarily informed expectations of gene content from near-universal single-copy orthologs. Sequence assembly validation, Scaffolding, Genome assembly, Transcriptome assembly Sequence assembly, Genomics, Transcriptomics, Sequence analysis To update https://gitlab.com/ezlab/busco/-/releases Sequence Analysis busco iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/busco/ https://github.com/galaxyproject/tools-iuc/tree/main/tools/busco 5.5.0 busco 5.7.1 (1/1) (1/1) (1/1) (1/1) bwa 957912.0 5279.0 bwa_mem, bwa Wrapper for bwa mem, aln, sampe, and samse bwa bwa BWA Fast, accurate, memory-efficient aligner for short and long sequencing reads Genome indexing, Sequence alignment, Read mapping, Sequence alignment, Generation, Sequence alignment, Generation, Sequence alignment, Sequence alignment Mapping Up-to-date http://bio-bwa.sourceforge.net/ Next Gen Mappers bwa devteam https://github.com/galaxyproject/tools-iuc/tree/master/tools/bwa https://github.com/galaxyproject/tools-iuc/tree/main/tools/bwa 0.7.18 bwa 0.7.18 (2/2) (2/2) (2/2) (2/2) bwa_mem2 44386.0 1220.0 bwa_mem2 Bwa-mem2 is the next version of the bwa-mem algorithm in bwa. bwa-mem2 bwa-mem2 Bwa-mem2 Bwa-mem2 is the next version of the bwa-mem algorithm in bwa. It produces alignment identical to bwa and is ~1.3-3.1x faster depending on the use-case, dataset and the running machine. Sequence alignment Mapping Up-to-date https://github.com/bwa-mem2/bwa-mem2 Next Gen Mappers bwa_mem2 iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/bwa_mem2 https://github.com/galaxyproject/tools-iuc/tree/main/tools/bwa_mem2 2.2.1 bwa-mem2 2.2.1 (1/1) (1/1) (1/1) (1/1) -bwameth 10619.0 201.0 bwameth Fast and accurate alignment of BS-seq reads To update https://github.com/brentp/bwa-meth Sequence Analysis, Next Gen Mappers bwameth iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/bwameth https://github.com/galaxyproject/tools-iuc/tree/main/tools/bwameth 0.2.6 bwameth 0.2.7 (1/1) (1/1) (1/1) (0/1) +bwameth 10619.0 201.0 bwameth Fast and accurate alignment of BS-seq reads Up-to-date https://github.com/brentp/bwa-meth Sequence Analysis, Next Gen Mappers bwameth iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/bwameth https://github.com/galaxyproject/tools-iuc/tree/main/tools/bwameth 0.2.7 bwameth 0.2.7 (1/1) (1/1) (1/1) (0/1) cactus cactus_cactus, cactus_export Cactus is a reference-free whole-genome multiple alignment program cactus cactus Cactus Cactus is a reference-free whole-genome multiple alignment program. Multiple sequence alignment, Genome alignment Genomics, Sequence analysis, Phylogeny, Sequence assembly, Mapping, Phylogenetics To update https://github.com/ComparativeGenomicsToolkit/cactus Sequence Analysis cactus galaxy-australia https://github.com/galaxyproject/tools-iuc/tree/main/tools/cactus https://github.com/galaxyproject/tools-iuc/tree/main/tools/cactus 2.7.1 (0/2) (2/2) (2/2) (1/2) calculate_contrast_threshold calculate_contrast_threshold Calculates a contrast threshold from the CDT file generated by ``tag_pileup_frequency``. The calculated values are then used to set a uniform contrast for all the heatmaps generated downstream. To update https://github.com/CEGRcode/ChIP-QC-tools/tree/master/calculate_contrast_threshold Visualization, Genomic Interval Operations, SAM calculate_contrast_threshold iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/calculate_contrast_threshold https://github.com/galaxyproject/tools-iuc/tree/main/tools/calculate_contrast_threshold 1.0.0 numpy (0/1) (0/1) (0/1) (0/1) calculate_numeric_param 1393.0 8.0 calculate_numeric_param Calculate a numeric parameter value using integer and float values. To update Text Manipulation calculate_numeric_param iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/calculate_numeric_param https://github.com/galaxyproject/tools-iuc/tree/main/tools/calculate_numeric_param 0.1.0 (0/1) (0/1) (1/1) (0/1) @@ -78,7 +82,7 @@ cnv-phenopacket cnv_phenopacket cnv-phenopacket Converts TSV metadata file to cnv-vcf2json cnv_vcf2json cnv-vcf2json Converts structural variants VCF file to JSON. To update https://pypi.org/project/cnv-phenopacket/ Variant Analysis cnv-vcf2json iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/cnv-vcf2json https://github.com/galaxyproject/tools-iuc/tree/main/tools/cnv-vcf2json 1.0.4 cnv-vcf2json (0/1) (0/1) (1/1) (0/1) cnvkit cnvkit_access, cnvkit_antitarget, cnvkit_autobin, cnvkit_batch, cnvkit_breaks, cnvkit_call, cnvkit_coverage, cnvkit_diagram, cnvkit_fix, cnvkit_genemetrics, cnvkit_heatmap, cnvkit_reference, cnvkit_scatter, cnvkit_segment, cnvkit_segmetrics, cnvkit_sex, cnvkit_target detecting copy number variants and alterations genome-wide from high-throughput sequencing cnvkit cnvkit CNVkit CNVkit is a software toolkit to infer and visualize copy number from targeted DNA sequencing data. Variant calling DNA structural variation Up-to-date https://github.com/etal/cnvkit Variant Analysis cnvkit iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/cnvkit https://github.com/galaxyproject/tools-iuc/tree/main/tools/cnvkit 0.9.11 cnvkit 0.9.11 (0/17) (0/17) (17/17) (0/17) codeml 60901.0 29.0 codeml Detects positive selection paml paml PAML Package of programs for phylogenetic analyses of DNA or protein sequences using maximum likelihood. Probabilistic sequence generation, Phylogenetic tree generation (maximum likelihood and Bayesian methods), Phylogenetic tree analysis Phylogenetics, Sequence analysis To update http://abacus.gene.ucl.ac.uk/software/paml.html Phylogenetics codeml iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/codeml https://github.com/galaxyproject/tools-iuc/tree/main/tools/codeml 4.9 paml 4.10.7 (0/1) (0/1) (1/1) (0/1) -cojac cooc_mutbamscan, cooc_pubmut, cooc_tabmut co-occurrence of mutations on amplicons cojac cojac COJAC CoOccurrence adJusted Analysis and Calling - The cojac package comprises a set of command-line tools to analyse co-occurrence of mutations on amplicons. It is useful, for example, for early detection of viral variants of concern (e.g. Alpha, Delta, Omicron) in environmental samples, and has been designed to scan for multiple SARS-CoV-2 variants in wastewater samples, as analyzed jointly by ETH Zurich, EPFL and Eawag. Genetic variation Up-to-date https://github.com/cbg-ethz/cojac Metagenomics, Sequence Analysis cojac iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/cojac https://github.com/galaxyproject/tools-iuc/tree/main/tools/cojac 0.9.1 cojac 0.9.1 (2/3) (0/3) (3/3) (0/3) +cojac cooc_mutbamscan, cooc_pubmut, cooc_tabmut co-occurrence of mutations on amplicons cojac cojac COJAC CoOccurrence adJusted Analysis and Calling - The cojac package comprises a set of command-line tools to analyse co-occurrence of mutations on amplicons. It is useful, for example, for early detection of viral variants of concern (e.g. Alpha, Delta, Omicron) in environmental samples, and has been designed to scan for multiple SARS-CoV-2 variants in wastewater samples, as analyzed jointly by ETH Zurich, EPFL and Eawag. Genetic variation To update https://github.com/cbg-ethz/cojac Metagenomics, Sequence Analysis cojac iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/cojac https://github.com/galaxyproject/tools-iuc/tree/main/tools/cojac 0.9.1 cojac 0.9.2 (2/3) (0/3) (3/3) (0/3) colabfold colabfold_alphafold, colabfold_msa Protein prediction based on AlphaFold2 Colabfold Colabfold ColabFold ColabFold databases are MMseqs2 expandable profile databases to generate diverse multiple sequence alignments to predict protein structures. Database search, Protein structure prediction, Fold recognition Protein folds and structural domains, Protein folding, stability and design, Structure prediction, Sequence sites, features and motifs, Metagenomics To update https://github.com/sokrypton/ColabFold Proteomics, Graphics colabfold iuc https://github.com/sokrypton/ColabFold https://github.com/galaxyproject/tools-iuc/tree/main/tools/colabfold 1.5.5 (2/2) (0/2) (0/2) (0/2) colibread commet, discosnp_rad, discosnp_pp, kissplice, lordec, mapsembler2, takeabreak Colib'read tools are all dedicated to the analysis of NGS datasets without the need of any reference genome To update https://colibread.inria.fr/ Sequence Analysis, Variant Analysis colibread iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/colibread https://github.com/galaxyproject/tools-iuc/tree/main/tools/colibread 24.7.14+galaxy0 commet 24.7.14 (0/7) (0/7) (1/7) (1/7) collection_column_join 20857.0 1483.0 collection_column_join Column Join on Collections To update Text Manipulation collection_column_join iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/collection_column_join https://github.com/galaxyproject/tools-iuc/tree/main/tools/collection_column_join 0.0.3 coreutils 8.25 (1/1) (1/1) (1/1) (1/1) @@ -96,8 +100,14 @@ coverm coverm_contig, coverm_genome CoverM genome and contig wrappers coverm c crispr_studio 636.0 30.0 crispr_studio CRISPR Studio is a program developed to facilitate and accelerate CRISPR array visualization. crisprstudio crisprstudio CRISPRStudio CRISPRStudio is a program developed to facilitate and accelerate CRISPR array visualization. It works by first comparing spacers sequence homology in a dataset, then assigning a two-color-code to each cluster of spacers and finally writing an svg file, which can be opened in graphics vector editor. Visualisation Sequence analysis, Genomics, Data visualisation To update https://github.com/moineaulab/CRISPRStudio Sequence Analysis crispr_studio iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/crispr_studio/ https://github.com/galaxyproject/tools-iuc/tree/main/tools/crispr_studio 1+galaxy0 crispr_studio 1 (0/1) (0/1) (1/1) (0/1) crosscontamination_barcode_filter 347.0 17.0 crosscontamination_barcode_filter Barcode contamination discovery tool To update Transcriptomics, Visualization crosscontamination_barcode_filter iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/crosscontamination_barcode_filter https://github.com/galaxyproject/tools-iuc/tree/main/tools/crosscontamination_barcode_filter 0.3 r-ggplot2 2.2.1 (1/1) (0/1) (1/1) (0/1) crossmap crossmap_bam, crossmap_bed, crossmap_bw, crossmap_gff, crossmap_region, crossmap_vcf, crossmap_wig CrossMap converts genome coordinates or annotation files between genome assemblies To update http://crossmap.sourceforge.net/ Convert Formats, Genomic Interval Operations crossmap iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/crossmap https://github.com/galaxyproject/tools-iuc/tree/main/tools/crossmap 0.6.1 crossmap 0.7.0 (5/7) (0/7) (6/7) (0/7) +cuffcompare 1130.0 65.0 cuffcompare Galaxy wrappers for the Cuffcompare tool. Up-to-date http://cole-trapnell-lab.github.io/cufflinks/ Transcriptomics cuffcompare devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/cufflinks/cuffcompare https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/cufflinks/cuffcompare 2.2.1 cufflinks 2.2.1 (1/1) (1/1) (1/1) (1/1) +cuffdiff 5831.0 228.0 cuffdiff Galaxy wrappers for the Cuffdiff tool. Up-to-date http://cole-trapnell-lab.github.io/cufflinks/ Transcriptomics cuffdiff devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/cufflinks/cuffdiff https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/cufflinks/cuffdiff 2.2.1 cufflinks 2.2.1 (1/1) (0/1) (1/1) (0/1) +cufflinks 32218.0 319.0 cufflinks Galaxy wrappers for the Cufflinks tool. Up-to-date http://cole-trapnell-lab.github.io/cufflinks/ Transcriptomics cufflinks devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/cufflinks/cufflinks https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/cufflinks/cufflinks 2.2.1 cufflinks 2.2.1 (1/1) (1/1) (1/1) (1/1) +cuffmerge 3292.0 122.0 cuffmerge Galaxy wrappers for the Cuffmerge tool. Up-to-date http://cole-trapnell-lab.github.io/cufflinks/ Transcriptomics cuffmerge devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/cufflinks/cuffmerge https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/cufflinks/cuffmerge 2.2.1 cufflinks 2.2.1 (1/1) (1/1) (1/1) (1/1) +cuffnorm 660.0 27.0 cuffnorm The Cuffnorm tool Up-to-date http://cole-trapnell-lab.github.io/cufflinks/ Transcriptomics cuffnorm devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/cufflinks/cuffnorm https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/cufflinks/cuffnorm 2.2.1 cufflinks 2.2.1 (1/1) (1/1) (1/1) (0/1) +cuffquant 688.0 18.0 cuffquant The Cuffquant tool Up-to-date http://cole-trapnell-lab.github.io/cufflinks/ Transcriptomics cuffquant devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/cufflinks/cuffquant https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/cufflinks/cuffquant 2.2.1 cufflinks 2.2.1 (1/1) (1/1) (1/1) (0/1) cutadapt 232004.0 5090.0 cutadapt Flexible tool to remove adapter sequences (and quality trim) high throughput sequencing reads (fasta/fastq). cutadapt cutadapt Cutadapt Find and remove adapter sequences, primers, poly-A tails and other types of unwanted sequence from your high-throughput sequencing reads. Sequence trimming, Primer removal, Read pre-processing Genomics, Probes and primers, Sequencing Up-to-date https://cutadapt.readthedocs.org/en/stable/ Fasta Manipulation, Fastq Manipulation, Sequence Analysis cutadapt lparsons https://github.com/galaxyproject/tools-iuc/tree/master/tools/cutadapt https://github.com/galaxyproject/tools-iuc/tree/main/tools/cutadapt 4.8 cutadapt 4.8 (1/1) (1/1) (1/1) (1/1) -cutesv 235.0 17.0 cutesv Long-read sequencing enables the comprehensive discovery of structural variations (SVs). However, it is still non-trivial to achieve high sensitivity and performance simultaneously due to the complex SV characteristics implied by noisy long reads. Therefore, we propose cuteSV, a sensitive, fast and scalable long-read-based SV detection approach. cuteSV uses tailored methods to collect the signatures of various types of SVs and employs a clustering-and-refinement method to analyze the signatures to implement sensitive SV detection. Benchmarks on real Pacific Biosciences (PacBio) and Oxford Nanopore Technology (ONT) datasets demonstrate that cuteSV has better yields and scalability than state-of-the-art tools. cuteSV cuteSV cuteSV Long Read based Human Genomic Structural Variation Detection with cuteSV | Long-read sequencing technologies enable to comprehensively discover structural variations (SVs). However, it is still non-trivial for state-of-the-art approaches to detect SVs with high sensitivity or high performance or both. Herein, we propose cuteSV, a sensitive, fast and lightweight SV detection approach. cuteSV uses tailored methods to comprehensively collect various types of SV signatures, and a clustering-and-refinement method to implement a stepwise SV detection, which enables to achieve high sensitivity without loss of accuracy. Benchmark results demonstrate that cuteSV has better yields on real datasets. Further, its speed and scalability are outstanding and promising to large-scale data analysis Split read mapping, Genotyping, Structural variation detection DNA structural variation, Sequencing, Computer science To update https://github.com/tjiangHIT/cuteSV Variant Analysis cutesv iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/cutesv https://github.com/galaxyproject/tools-iuc/tree/main/tools/cutesv 1.0.8 cutesv 2.1.1 (0/1) (1/1) (1/1) (0/1) +cutesv 235.0 17.0 cutesv Long-read sequencing enables the comprehensive discovery of structural variations (SVs). However, it is still non-trivial to achieve high sensitivity and performance simultaneously due to the complex SV characteristics implied by noisy long reads. Therefore, we propose cuteSV, a sensitive, fast and scalable long-read-based SV detection approach. cuteSV uses tailored methods to collect the signatures of various types of SVs and employs a clustering-and-refinement method to analyze the signatures to implement sensitive SV detection. Benchmarks on real Pacific Biosciences (PacBio) and Oxford Nanopore Technology (ONT) datasets demonstrate that cuteSV has better yields and scalability than state-of-the-art tools. cuteSV cuteSV cuteSV Long Read based Human Genomic Structural Variation Detection with cuteSV | Long-read sequencing technologies enable to comprehensively discover structural variations (SVs). However, it is still non-trivial for state-of-the-art approaches to detect SVs with high sensitivity or high performance or both. Herein, we propose cuteSV, a sensitive, fast and lightweight SV detection approach. cuteSV uses tailored methods to comprehensively collect various types of SV signatures, and a clustering-and-refinement method to implement a stepwise SV detection, which enables to achieve high sensitivity without loss of accuracy. Benchmark results demonstrate that cuteSV has better yields on real datasets. Further, its speed and scalability are outstanding and promising to large-scale data analysis Split read mapping, Genotyping, Structural variation detection DNA structural variation, Sequencing, Computer science To update https://github.com/tjiangHIT/cuteSV Variant Analysis cutesv iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/cutesv https://github.com/galaxyproject/tools-iuc/tree/main/tools/cutesv 1.0.8 cutesv (0/1) (1/1) (1/1) (0/1) cwpair2 cwpair2 Contains a tool that takes a list of called peaks on both strands and produces a list of matched pairsand a list of unmatched orphans. To update ChIP-seq cwpair2 iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/cwpair2 https://github.com/galaxyproject/tools-iuc/tree/main/tools/cwpair2 1.1.1 matplotlib (1/1) (0/1) (0/1) (0/1) dada2 dada2_assignTaxonomyAddspecies, dada2_dada, dada2_filterAndTrim, dada2_learnErrors, dada2_makeSequenceTable, dada2_mergePairs, dada2_plotComplexity, dada2_plotQualityProfile, dada2_removeBimeraDenovo, dada2_seqCounts DADA2 wrappers dada2 dada2 dada2 This package infers exact sequence variants (SVs) from amplicon data, replacing the commonly used and coarser OTU clustering approach. This pipeline inputs demultiplexed fastq files, and outputs the sequence variants and their sample-wise abundances after removing substitution and chimera errors. Taxonomic classification is available via a native implementation of the RDP naive Bayesian classifier. Variant calling, DNA barcoding Sequencing, Genetic variation, Microbial ecology, Metagenomics To update https://benjjneb.github.io/dada2/index.html Metagenomics dada2 iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/dada2 https://github.com/galaxyproject/tools-iuc/tree/main/tools/dada2 bioconductor-dada2 1.30.0 (10/10) (10/10) (10/10) (10/10) das_tool 550.0 17.0 Fasta_to_Contig2Bin, das_tool DAS Tool for genome resolved metagenomics dastool dastool dastool DAS Tool is an automated method that integrates the results of a flexible number of binning algorithms to calculate an optimized, non-redundant set of bins from a single assembly. Read binning Metagenomics Up-to-date https://github.com/cmks/DAS_Tool Metagenomics das_tool iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/das_tool https://github.com/galaxyproject/tools-iuc/tree/main/tools/das_tool 1.1.7 das_tool 1.1.7 (0/2) (0/2) (2/2) (2/2) @@ -133,14 +143,45 @@ exonerate 988.0 59.0 exonerate Exonerate is a generic tool for pairwise sequence export2graphlan 5265.0 200.0 export2graphlan export2graphlan is a conversion software tool for producing both annotation and tree file for GraPhlAn export2graphlan export2graphlan export2graphlan export2graphlan is a conversion software tool for producing both annotation and tree file for GraPhlAn. In particular, the annotation file tries to highlight specific sub-trees deriving automatically from input file what nodes are important. Conversion Taxonomy, Metabolomics, Biomarkers To update https://bitbucket.org/CibioCM/export2graphlan/overview Metagenomics export2graphlan iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/export2graphlan/ https://github.com/galaxyproject/tools-iuc/tree/main/tools/export2graphlan 0.20 export2graphlan 0.22 (1/1) (1/1) (1/1) (1/1) extract_genomic_dna 11348.0 285.0 Extract genomic DNA 1 Contains a tool that extracts genomic DNA using coordinates from ASSEMBLED genomes and UNassembled genomes. To update Genomic Interval Operations extract_genomic_dna iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/extract_genomic_dna https://github.com/galaxyproject/tools-iuc/tree/main/tools/extract_genomic_dna 3.0.3+galaxy2 bx-python 0.11.0 (1/1) (0/1) (1/1) (0/1) fargene 459.0 52.0 fargene fARGene (Fragmented Antibiotic Resistance Gene iENntifiEr ) fargene fargene fARGene fARGene (Fragmented Antibiotic Resistance Gene iENntifiEr ) is a tool that takes either fragmented metagenomic data or longer sequences as input and predicts and delivers full-length antiobiotic resistance genes as output. Antimicrobial resistance prediction Metagenomics, Microbiology, Public health and epidemiology Up-to-date https://github.com/fannyhb/fargene Sequence Analysis fargene iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/fargene https://github.com/galaxyproject/tools-iuc/tree/main/tools/fargene 0.1 fargene 0.1 (1/1) (0/1) (1/1) (0/1) +fasplit fasplit faSplit is a tool to split a single FASTA file into several files UCSC_Genome_Browser_Utilities UCSC_Genome_Browser_Utilities UCSC Genome Browser Utilities Utilities for handling sequences and assemblies from the UCSC Genome Browser project. Sequence analysis Up-to-date http://hgdownload.cse.ucsc.edu/admin/exe/ Fasta Manipulation ucsc_fasplit iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/ucsc-tools/fasplit https://github.com/galaxyproject/tools-iuc/tree/main/tools/ucsc_tools/fasplit 377 ucsc-fasplit 377 (1/1) (1/1) (1/1) (1/1) +fasta_clipping_histogram cshl_fasta_clipping_histogram Length Distribution chart Up-to-date http://hannonlab.cshl.edu/fastx_toolkit/ Fasta Manipulation, Graphics, Statistics fasta_clipping_histogram devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/fastx_toolkit/fasta_clipping_histogram https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/fastx_toolkit/fasta_clipping_histogram 0.0.14 fastx_toolkit 0.0.14 (0/1) (1/1) (0/1) (0/1) +fasta_formatter 2912.0 68.0 cshl_fasta_formatter FASTA Width formatter Up-to-date http://hannonlab.cshl.edu/fastx_toolkit/ Fasta Manipulation fasta_formatter devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/fastx_toolkit/fasta_formatter https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/fastx_toolkit/fasta_formatter 0.0.14 fastx_toolkit 0.0.14 (1/1) (1/1) (1/1) (1/1) +fasta_nucleotide_changer 774.0 29.0 cshl_fasta_nucleotides_changer RNA/DNA converter. Up-to-date http://hannonlab.cshl.edu/fastx_toolkit/ Fasta Manipulation fasta_nucleotide_changer devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/fastx_toolkit/fasta_nucleotide_changer https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/fastx_toolkit/fasta_nucleotide_changer 0.0.14 fastx_toolkit 0.0.14 (1/1) (1/1) (1/1) (1/1) fasta_nucleotide_color_plot 322.0 39.0 fasta_nucleotide_color_plot Contains a tool that produces a graphical representation of FASTA data with each nucleotide represented by a selected color. To update https://github.com/seqcode/cegr-tools/tree/master/src/org/seqcode/cegrtools/fourcolorplot Visualization fasta_nucleotide_color_plot iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/fasta_nucleotide_color_plot https://github.com/galaxyproject/tools-iuc/tree/main/tools/fasta_nucleotide_color_plot 1.0.1 openjdk (1/1) (0/1) (1/1) (0/1) fasta_stats 35332.0 1080.0 fasta-stats Display summary statistics for a fasta file. To update https://github.com/galaxyproject/tools-iuc/tree/master/tools/fasta_stats/ Sequence Analysis fasta_stats iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/fasta_stats/ https://github.com/galaxyproject/tools-iuc/tree/main/tools/fasta_stats 2.0 numpy (1/1) (1/1) (1/1) (1/1) fastani 3498.0 250.0 fastani Fast alignment-free computation of whole-genome Average Nucleotide Identity fastani fastani FastANI FastANI is developed for fast alignment-free computation of whole-genome Average Nucleotide Identity (ANI). ANI is defined as mean nucleotide identity of orthologous gene pairs shared between two microbial genomes. FastANI supports pairwise comparison of both complete and draft genome assemblies. Genome alignment, Sequence similarity search Microbiology, Genetic variation To update https://github.com/ParBLiSS/FastANI Sequence Analysis fastani iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/fastani https://github.com/galaxyproject/tools-iuc/tree/main/tools/fastani 1.3 fastani 1.34 (0/1) (0/1) (1/1) (1/1) fastk fastk_fastk FastK: A K-mer counter (for HQ assembly data sets) To update https://github.com/thegenemyers/FASTK Assembly fastk iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/fastk https://github.com/galaxyproject/tools-iuc/tree/main/tools/fastk 1.0.0 fastk 1.0 (0/1) (0/1) (1/1) (0/1) fastp 1055760.0 2803.0 fastp Fast all-in-one preprocessing for FASTQ files fastp fastp fastp A tool designed to provide fast all-in-one preprocessing for FastQ files. This tool is developed in C++ with multithreading supported to afford high performance. Sequencing quality control, Sequence contamination filtering Sequence analysis, Probes and primers Up-to-date https://github.com/OpenGene/fastp Sequence Analysis fastp iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/fastp https://github.com/galaxyproject/tools-iuc/tree/main/tools/fastp 0.23.4 fastp 0.23.4 (1/1) (1/1) (1/1) (1/1) -fastqc 1556625.0 17447.0 fastqc Read QC reports using FastQC fastqc fastqc FastQC This tool aims to provide a QC report which can spot problems or biases which originate either in the sequencer or in the starting library material. It can be run in one of two modes. It can either run as a stand alone interactive application for the immediate analysis of small numbers of FastQ files, or it can be run in a non-interactive mode where it would be suitable for integrating into a larger analysis pipeline for the systematic processing of large numbers of files. Sequence composition calculation, Sequencing quality control, Statistical calculation Sequencing, Data quality management, Sequence analysis To update http://www.bioinformatics.babraham.ac.uk/projects/fastqc/ Fastq Manipulation fastqc devteam https://github.com/galaxyproject/tools-iuc/tree/master/tools/fastqc https://github.com/galaxyproject/tools-iuc/tree/main/tools/fastqc 0.74+galaxy0 fastqc (1/1) (1/1) (1/1) (1/1) +fastq_combiner 8676.0 66.0 fastq_combiner Combine FASTA and QUAL into FASTQ Up-to-date https://github.com/galaxyproject/sequence_utils Fastq Manipulation, Fasta Manipulation fastq_combiner devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/galaxy_sequence_utils/fastq_combiner https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/galaxy_sequence_utils/fastq_combiner 1.1.5 galaxy_sequence_utils 1.1.5 (1/1) (1/1) (1/1) (1/1) +fastq_filter 14222.0 266.0 fastq_filter Filter FASTQ reads by quality score and length Up-to-date https://github.com/galaxyproject/sequence_utils Fastq Manipulation fastq_filter devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/galaxy_sequence_utils/fastq_filter https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/galaxy_sequence_utils/fastq_filter 1.1.5 galaxy_sequence_utils 1.1.5 (1/1) (1/1) (1/1) (1/1) +fastq_groomer 94802.0 1028.0 fastq_groomer Convert between various FASTQ quality formats. Up-to-date https://github.com/galaxyproject/sequence_utils Fastq Manipulation fastq_groomer devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/galaxy_sequence_utils/fastq_groomer https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/galaxy_sequence_utils/fastq_groomer 1.1.5 galaxy_sequence_utils 1.1.5 (1/1) (1/1) (1/1) (1/1) +fastq_manipulation 2503.0 69.0 fastq_manipulation Manipulate FASTQ reads on various attributes. Up-to-date https://github.com/galaxyproject/sequence_utils Fastq Manipulation fastq_manipulation devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/galaxy_sequence_utils/fastq_manipulation https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/galaxy_sequence_utils/fastq_manipulation 1.1.5 galaxy_sequence_utils 1.1.5 (1/1) (1/1) (1/1) (1/1) +fastq_masker_by_quality 170.0 16.0 fastq_masker_by_quality FASTQ Masker by quality score Up-to-date https://github.com/galaxyproject/sequence_utils Fastq Manipulation fastq_masker_by_quality devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/galaxy_sequence_utils/fastq_masker_by_quality https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/galaxy_sequence_utils/fastq_masker_by_quality 1.1.5 galaxy_sequence_utils 1.1.5 (1/1) (1/1) (1/1) (1/1) +fastq_paired_end_deinterlacer 8410.0 122.0 fastq_paired_end_deinterlacer FASTQ de-interlacer on paired end reads. Up-to-date https://github.com/galaxyproject/sequence_utils Fastq Manipulation fastq_paired_end_deinterlacer devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/galaxy_sequence_utils/fastq_paired_end_deinterlacer https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/galaxy_sequence_utils/fastq_paired_end_deinterlacer 1.1.5 galaxy_sequence_utils 1.1.5 (1/1) (1/1) (1/1) (1/1) +fastq_paired_end_interlacer 17024.0 1087.0 fastq_paired_end_interlacer FASTQ interlacer on paired end reads Up-to-date https://github.com/galaxyproject/sequence_utils Fastq Manipulation fastq_paired_end_interlacer devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/galaxy_sequence_utils/fastq_paired_end_interlacer https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/galaxy_sequence_utils/fastq_paired_end_interlacer 1.1.5 galaxy_sequence_utils 1.1.5 (1/1) (1/1) (1/1) (1/1) +fastq_paired_end_joiner 16635.0 245.0 fastq_paired_end_joiner FASTQ joiner on paired end reads Up-to-date https://github.com/galaxyproject/sequence_utils Fastq Manipulation fastq_paired_end_joiner devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/galaxy_sequence_utils/fastq_paired_end_joiner https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/galaxy_sequence_utils/fastq_paired_end_joiner 1.1.5 galaxy_sequence_utils 1.1.5 (1/1) (1/1) (1/1) (1/1) +fastq_paired_end_splitter 3092.0 196.0 fastq_paired_end_splitter FASTQ splitter on joined paired end reads Up-to-date https://github.com/galaxyproject/sequence_utils Fastq Manipulation fastq_paired_end_splitter devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/galaxy_sequence_utils/fastq_paired_end_splitter https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/galaxy_sequence_utils/fastq_paired_end_splitter 1.1.5 galaxy_sequence_utils 1.1.5 (1/1) (1/1) (1/1) (1/1) +fastq_quality_boxplot 1175.0 51.0 cshl_fastq_quality_boxplot Draw quality score boxplot Up-to-date http://hannonlab.cshl.edu/fastx_toolkit/ Fastq Manipulation, Graphics, Statistics fastq_quality_boxplot devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/fastx_toolkit/fastq_quality_boxplot https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/fastx_toolkit/fastq_quality_boxplot 0.0.14 fastx_toolkit 0.0.14 (1/1) (1/1) (1/1) (1/1) +fastq_quality_converter 220.0 11.0 cshl_fastq_quality_converter Quality format converter (ASCII-Numeric) Up-to-date http://hannonlab.cshl.edu/fastx_toolkit/ Fastq Manipulation fastq_quality_converter devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/fastx_toolkit/fastq_quality_converter https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/fastx_toolkit/fastq_quality_converter 0.0.14 fastx_toolkit 0.0.14 (1/1) (1/1) (1/1) (1/1) +fastq_quality_filter 15153.0 1509.0 cshl_fastq_quality_filter Filter by quality Up-to-date http://hannonlab.cshl.edu/fastx_toolkit/ Fastq Manipulation fastq_quality_filter devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/fastx_toolkit/fastq_quality_filter https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/fastx_toolkit/fastq_quality_filter 0.0.14 fastx_toolkit 0.0.14 (1/1) (1/1) (1/1) (1/1) +fastq_stats 4246.0 221.0 fastq_stats FASTQ Summary Statistics by column Up-to-date https://github.com/galaxyproject/sequence_utils Fastq Manipulation fastq_stats devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/galaxy_sequence_utils/fastq_stats https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/galaxy_sequence_utils/fastq_stats 1.1.5 galaxy_sequence_utils 1.1.5 (1/1) (1/1) (1/1) (1/1) +fastq_to_fasta 13599.0 419.0 cshl_fastq_to_fasta FASTQ to FASTA converter Up-to-date http://hannonlab.cshl.edu/fastx_toolkit/ Fasta Manipulation, Convert Formats fastq_to_fasta devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/fastx_toolkit/fastq_to_fasta https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/fastx_toolkit/fastq_to_fasta 0.0.14 fastx_toolkit 0.0.14 (1/1) (1/1) (1/1) (1/1) +fastq_to_tabular 12593.0 93.0 fastq_to_tabular FASTQ to Tabular converter Up-to-date https://github.com/galaxyproject/sequence_utils Fastq Manipulation fastq_to_tabular devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/galaxy_sequence_utils/fastq_to_tabular https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/galaxy_sequence_utils/fastq_to_tabular 1.1.5 galaxy_sequence_utils 1.1.5 (1/1) (1/1) (1/1) (1/1) +fastq_trimmer 9757.0 210.0 fastq_trimmer FASTQ Trimmer by quality Up-to-date https://github.com/galaxyproject/sequence_utils Fastq Manipulation fastq_trimmer devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/galaxy_sequence_utils/fastq_trimmer https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/galaxy_sequence_utils/fastq_trimmer 1.1.5 galaxy_sequence_utils 1.1.5 (1/1) (1/1) (1/1) (1/1) +fastqc 1556625.0 17447.0 fastqc Read QC reports using FastQC fastqc fastqc FastQC This tool aims to provide a QC report which can spot problems or biases which originate either in the sequencer or in the starting library material. It can be run in one of two modes. It can either run as a stand alone interactive application for the immediate analysis of small numbers of FastQ files, or it can be run in a non-interactive mode where it would be suitable for integrating into a larger analysis pipeline for the systematic processing of large numbers of files. Sequence composition calculation, Sequencing quality control, Statistical calculation Sequencing, Data quality management, Sequence analysis To update http://www.bioinformatics.babraham.ac.uk/projects/fastqc/ Fastq Manipulation fastqc devteam https://github.com/galaxyproject/tools-iuc/tree/master/tools/fastqc https://github.com/galaxyproject/tools-iuc/tree/main/tools/fastqc 0.74+galaxy0 fastqc 0.12.1 (1/1) (1/1) (1/1) (1/1) fastqe 4333.0 1266.0 fastqe FASTQE fastqe fastqe FASTQE Compute quality stats for FASTQ files and print those stats as emoji... for some reason. Sequencing quality control Sequence analysis, Sequencing To update https://fastqe.com/ Sequence Analysis fastqe iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/fastqe https://github.com/galaxyproject/tools-iuc/tree/main/tools/fastqe 0.3.1+galaxy0 fastqe 0.3.1 (1/1) (1/1) (1/1) (1/1) +fastqtofasta 178172.0 1371.0 fastq_to_fasta_python FASTQ to FASTA converter Up-to-date https://github.com/galaxyproject/sequence_utils Fastq Manipulation fastqtofasta devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/galaxy_sequence_utils/fastqtofasta https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/galaxy_sequence_utils/fastqtofasta 1.1.5 galaxy_sequence_utils 1.1.5 (1/1) (1/1) (1/1) (0/1) fasttree 55434.0 379.0 fasttree FastTree infers approximately-maximum-likelihood phylogenetic trees from alignments of nucleotide or protein sequences - GVL fasttree fasttree FastTree Infers approximately-maximum-likelihood phylogenetic trees from alignments of nucleotide or protein sequences. Phylogenetic tree generation (from molecular sequences), Phylogenetic tree generation (maximum likelihood and Bayesian methods) Phylogenetics, Sequence analysis To update http://www.microbesonline.org/fasttree/ Phylogenetics fasttree iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/fasttree https://github.com/galaxyproject/tools-iuc/tree/main/tools/fasttree 2.1.10 fasttree 2.1.11 (1/1) (1/1) (1/1) (1/1) +fastx_artifacts_filter 1809.0 27.0 cshl_fastx_artifacts_filter Remove sequencing artifacts Up-to-date http://hannonlab.cshl.edu/fastx_toolkit/ Fasta Manipulation, Fastq Manipulation fastx_artifacts_filter devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/fastx_toolkit/fastx_artifacts_filter https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/fastx_toolkit/fastx_artifacts_filter 0.0.14 fastx_toolkit 0.0.14 (1/1) (1/1) (1/1) (1/1) +fastx_barcode_splitter 16589.0 128.0 cshl_fastx_barcode_splitter Barcode Splitter Up-to-date http://hannonlab.cshl.edu/fastx_toolkit/ Fasta Manipulation, Fastq Manipulation fastx_barcode_splitter devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/fastx_toolkit/fastx_barcode_splitter https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/fastx_toolkit/fastx_barcode_splitter 0.0.14 fastx_toolkit 0.0.14 (1/1) (1/1) (1/1) (1/1) +fastx_clipper 3321.0 96.0 cshl_fastx_clipper Clip adapter sequences Up-to-date http://hannonlab.cshl.edu/fastx_toolkit/ Fasta Manipulation, Fastq Manipulation fastx_clipper devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/fastx_toolkit/fastx_clipper https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/fastx_toolkit/fastx_clipper 0.0.14 fastx_toolkit 0.0.14 (1/1) (1/1) (1/1) (1/1) +fastx_collapser 61218.0 114.0 cshl_fastx_collapser Collapse sequences Up-to-date http://hannonlab.cshl.edu/fastx_toolkit/ Fasta Manipulation fastx_collapser devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/fastx_toolkit/fastx_collapser https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/fastx_toolkit/fastx_collapser 0.0.14 fastx_toolkit 0.0.14 (1/1) (1/1) (1/1) (1/1) +fastx_nucleotides_distribution 249.0 25.0 cshl_fastx_nucleotides_distribution Draw nucleotides distribution chart Up-to-date http://hannonlab.cshl.edu/fastx_toolkit/ Fastq Manipulation, Graphics fastx_nucleotides_distribution devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/fastx_toolkit/fastx_nucleotides_distribution https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/fastx_toolkit/fastx_nucleotides_distribution 0.0.14 fastx_toolkit 0.0.14 (1/1) (1/1) (1/1) (1/1) +fastx_quality_statistics 2162.0 63.0 cshl_fastx_quality_statistics Compute quality statistics Up-to-date http://hannonlab.cshl.edu/fastx_toolkit/ Fastq Manipulation, Statistics fastx_quality_statistics devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/fastx_toolkit/fastx_quality_statistics https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/fastx_toolkit/fastx_quality_statistics 0.0.14 fastx_toolkit 0.0.14 (1/1) (1/1) (1/1) (1/1) +fastx_renamer 2280.0 68.0 cshl_fastx_renamer Rename sequences Up-to-date http://hannonlab.cshl.edu/fastx_toolkit/ Fasta Manipulation, Fastq Manipulation fastx_renamer devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/fastx_toolkit/fastx_renamer https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/fastx_toolkit/fastx_renamer 0.0.14 fastx_toolkit 0.0.14 (1/1) (1/1) (1/1) (1/1) +fastx_reverse_complement 10831.0 156.0 cshl_fastx_reverse_complement Reverse-Complement Up-to-date http://hannonlab.cshl.edu/fastx_toolkit/ Fastq Manipulation, Fasta Manipulation fastx_reverse_complement devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/fastx_toolkit/fastx_reverse_complement https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/fastx_toolkit/fastx_reverse_complement 0.0.14 fastx_toolkit 0.0.14 (1/1) (1/1) (1/1) (1/1) +fastx_trimmer 13148.0 205.0 cshl_fastx_trimmer Trim sequences Up-to-date http://hannonlab.cshl.edu/fastx_toolkit/ Fasta Manipulation, Fastq Manipulation fastx_trimmer devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/fastx_toolkit/fastx_trimmer https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/fastx_toolkit/fastx_trimmer 0.0.14 fastx_toolkit 0.0.14 (1/1) (1/1) (1/1) (1/1) +fatovcf fatovcf Convert a FASTA alignment file to Variant Call Format (VCF) single-nucleotide diffs UCSC_Genome_Browser_Utilities UCSC_Genome_Browser_Utilities UCSC Genome Browser Utilities Utilities for handling sequences and assemblies from the UCSC Genome Browser project. Sequence analysis Up-to-date http://hgdownload.cse.ucsc.edu/admin/exe/ Convert Formats ucsc_fatovcf iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/ucsc-tools/fatovcf https://github.com/galaxyproject/tools-iuc/tree/main/tools/ucsc_tools/fatovcf 448 ucsc-fatovcf 448 (1/1) (1/1) (1/1) (0/1) featurecounts 696399.0 4679.0 featurecounts featureCounts counts the number of reads aligned to defined masked regions in a reference genome featurecounts featurecounts FeatureCounts featureCounts is a very efficient read quantifier. It can be used to summarize RNA-seq reads and gDNA-seq reads to a variety of genomic features such as genes, exons, promoters, gene bodies and genomic bins. It is included in the Bioconductor Rsubread package and also in the SourceForge Subread package. Read summarisation, RNA-Seq quantification RNA-Seq To update http://bioinf.wehi.edu.au/featureCounts RNA, Transcriptomics, Sequence Analysis featurecounts iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/featurecounts https://github.com/galaxyproject/tools-iuc/tree/main/tools/featurecounts 2.0.3 subread 2.0.6 (1/1) (1/1) (1/1) (1/1) feelnc 1191.0 46.0 feelnc Galaxy wrapper for FEELnc feelnc feelnc FEELnc A tool to annotate long non-coding RNAs from RNA-seq assembled transcripts. Annotation, Classification RNA-seq, Functional, regulatory and non-coding RNA To update https://github.com/tderrien/FEELnc Sequence Analysis feelnc iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/feelnc https://github.com/galaxyproject/tools-iuc/tree/main/tools/feelnc 0.2.1 feelnc 0.2 (1/1) (1/1) (1/1) (1/1) fermikit fermi2, fermikit_variants FermiKit is a de novo assembly based variant calling pipeline for deep Illumina resequencing data. Up-to-date https://github.com/lh3/fermikit Assembly, Variant Analysis fermikit iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/fermikit https://github.com/galaxyproject/tools-iuc/tree/main/tools/fermikit r193 fermi2 r193 (0/2) (0/2) (0/2) (0/2) @@ -190,7 +231,7 @@ hapcut2 hapcut2 Robust and accurate haplotype assembly for diverse sequencing hapog 295.0 36.0 hapog Hapo-G - Haplotype-Aware Polishing of Genomes hapog hapog Hapo-G Hapo-G is a tool that aims to improve the quality of genome assemblies by polishing the consensus with accurate reads. It capable of incorporating phasing information from high-quality reads (short or long-reads) to polish genome assemblies and in particular assemblies of diploid and heterozygous genomes. Genome assembly, Optimisation and refinement Sequence assembly, Genomics Up-to-date https://github.com/institut-de-genomique/HAPO-G Assembly hapog iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/hapog https://github.com/galaxyproject/tools-iuc/tree/main/tools/hapog 1.3.8 hapog 1.3.8 (0/1) (0/1) (1/1) (1/1) happy som.py A tool to perform comparisons only based on chromosome, position, and allele identity for comparison of somatic callsets. hap.py hap.py hap.py This is a set of programs based on htslib to benchmark variant calls against gold standard truth datasets.To compare a VCF against a gold standard dataset, use the following commmand line to perform genotype-level haplotype comparison. Variant calling, Sequence analysis, Genotyping Genomics, DNA polymorphism To update https://github.com/Illumina/hap.py Variant Analysis happy iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/happy https://github.com/galaxyproject/tools-iuc/tree/main/tools/happy 0.3.14 hap.py 0.3.15 (0/1) (0/1) (0/1) (0/1) heatmap2 ggplot2_heatmap2 heatmap.2 function from the R gplots package To update https://github.com/cran/gplots Visualization ggplot2_heatmap2 iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/heatmap2 https://github.com/galaxyproject/tools-iuc/tree/main/tools/heatmap2 3.1.3.1 r-gplots 2.17.0 (1/1) (1/1) (1/1) (1/1) -heinz 1186.0 242.0 heinz_bum, heinz, heinz_scoring, heinz_visualization An algorithm for identification of the optimal scoring subnetwork. heinz heinz, bionet Heinz Tool for single-species active module discovery. Pathway or network analysis Genetics, Gene expression, Molecular interactions, pathways and networks To update https://github.com/ls-cwi/heinz Transcriptomics, Visualization, Statistics heinz iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/heinz https://github.com/galaxyproject/tools-iuc/tree/main/tools/heinz 1.0 bioconductor-bionet 1.62.0 (4/4) (4/4) (4/4) (0/4) +heinz 1186.0 242.0 heinz_bum, heinz, heinz_scoring, heinz_visualization An algorithm for identification of the optimal scoring subnetwork. heinz bionet, heinz Heinz Tool for single-species active module discovery. Pathway or network analysis Genetics, Gene expression, Molecular interactions, pathways and networks To update https://github.com/ls-cwi/heinz Transcriptomics, Visualization, Statistics heinz iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/heinz https://github.com/galaxyproject/tools-iuc/tree/main/tools/heinz 1.0 bioconductor-bionet 1.62.0 (4/4) (4/4) (4/4) (0/4) hicexplorer hicexplorer_chicaggregatestatistic, hicexplorer_chicdifferentialtest, hicexplorer_chicexportdata, hicexplorer_chicplotviewpoint, hicexplorer_chicqualitycontrol, hicexplorer_chicsignificantinteractions, hicexplorer_chicviewpoint, hicexplorer_chicviewpointbackgroundmodel, hicexplorer_hicadjustmatrix, hicexplorer_hicaggregatecontacts, hicexplorer_hicaverageregions, hicexplorer_hicbuildmatrix, hicexplorer_hiccomparematrices, hicexplorer_hiccompartmentspolarization, hicexplorer_hicconvertformat, hicexplorer_hiccorrectmatrix, hicexplorer_hiccorrelate, hicexplorer_hicdetectloops, hicexplorer_hicdifferentialtad, hicexplorer_hicfindrestrictionsites, hicexplorer_hicfindtads, hicexplorer_hichyperoptDetectLoops, hicexplorer_hicinfo, hicexplorer_hicinterintratad, hicexplorer_hicmergedomains, hicexplorer_hicmergeloops, hicexplorer_hicmergematrixbins, hicexplorer_hicnormalize, hicexplorer_hicpca, hicexplorer_hicplotaverageregions, hicexplorer_hicplotdistvscounts, hicexplorer_hicplotmatrix, hicexplorer_hicplotsvl, hicexplorer_hicplotviewpoint, hicexplorer_hicquickqc, hicexplorer_hicsummatrices, hicexplorer_hictadclassifier, hicexplorer_hictraintadclassifier, hicexplorer_hictransform, hicexplorer_hicvalidatelocations HiCExplorer: Set of programs to process, analyze and visualize Hi-C data. To update https://github.com/deeptools/HiCExplorer Sequence Analysis, Visualization hicexplorer bgruening https://github.com/galaxyproject/tools-iuc/tree/master/tools/hicexplorer https://github.com/galaxyproject/tools-iuc/tree/main/tools/hicexplorer 3.7.2 hicexplorer 3.7.4 (0/40) (5/40) (40/40) (4/40) hicstuff hicstuff_pipeline To update https://github.com/koszullab/hicstuff Sequence Analysis iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/hicstuff https://github.com/galaxyproject/tools-iuc/tree/main/tools/hicstuff 3.1.5 hicstuff 3.2.2 (0/1) (0/1) (0/1) (0/1) hifiasm_meta 137.0 12.0 hifiasm_meta A hifiasm fork for metagenome assembly using Hifi reads. hifiasm-meta hifiasm-meta Hifiasm-meta Hifiasm_meta - de novo metagenome assembler, based on hifiasm, a haplotype-resolved de novo assembler for PacBio Hifi reads. Sequence assembly Sequence assembly, Metagenomics To update https://github.com/xfengnefx/hifiasm-meta Metagenomics hifiasm_meta galaxy-australia https://github.com/galaxyproject/tools-iuc/tree/master/tools/hifiasm_meta https://github.com/galaxyproject/tools-iuc/tree/main/tools/hifiasm_meta 0.3.1 hifiasm_meta hamtv0.3.1 (0/1) (1/1) (1/1) (0/1) @@ -222,7 +263,7 @@ ivar ivar_consensus, ivar_filtervariants, ivar_removereads, ivar_trim, ivar_va iwtomics iwtomics_loadandplot, iwtomics_plotwithscale, iwtomics_testandplot Interval-Wise Testing for Omics Data iwtomics iwtomics IWTomics "Implementation of the Interval-Wise Testing (IWT) for omics data. This inferential procedure tests for differences in ""Omics"" data between two groups of genomic regions (or between a group of genomic regions and a reference center of symmetry), and does not require fixing location and scale at the outset." Differential gene expression analysis, Differentially-methylated region identification, Peak calling, Genome annotation, Comparison Statistics and probability To update https://bioconductor.org/packages/release/bioc/html/IWTomics.html Statistics iwtomics iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/iwtomics https://github.com/galaxyproject/tools-iuc/tree/main/tools/iwtomics 1.0.0 bioconductor-iwtomics 1.26.0 (3/3) (3/3) (3/3) (0/3) jasminesv 30.0 3.0 jasminesv Merge structural variants across samples To update https://github.com/mkirsche/Jasmine/ Variant Analysis jasminesv iuc https://github.com/galaxyproject/tools-iuc/jasminesv/ https://github.com/galaxyproject/tools-iuc/tree/main/tools/jasminesv 1.0.11 jasminesv 1.1.5 (1/1) (0/1) (1/1) (0/1) jbrowse 18229.0 2346.0 jbrowse_to_standalone, jbrowse JBrowse Genome Browser integrated as a Galaxy Tool jbrowse jbrowse JBrowse Slick, speedy genome browser with a responsive and dynamic AJAX interface for visualization of genome data. Being developed by the GMOD project as a successor to GBrowse. Genome visualisation Genomics Up-to-date https://jbrowse.org Sequence Analysis jbrowse iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/jbrowse https://github.com/galaxyproject/tools-iuc/tree/main/tools/jbrowse 1.16.11 jbrowse 1.16.11 (2/2) (2/2) (2/2) (2/2) -jcvi_gff_stats 2469.0 255.0 jcvi_gff_stats Compute statistics from a genome annotation in GFF3 format (using JCVI Python utilities) To update https://github.com/tanghaibao/jcvi Sequence Analysis jcvi_gff_stats iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/jcvi_gff_stats https://github.com/galaxyproject/tools-iuc/tree/main/tools/jcvi_gff_stats 0.8.4 jcvi 1.4.11 (1/1) (1/1) (1/1) (1/1) +jcvi_gff_stats 2469.0 255.0 jcvi_gff_stats Compute statistics from a genome annotation in GFF3 format (using JCVI Python utilities) To update https://github.com/tanghaibao/jcvi Sequence Analysis jcvi_gff_stats iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/jcvi_gff_stats https://github.com/galaxyproject/tools-iuc/tree/main/tools/jcvi_gff_stats 0.8.4 jcvi 1.4.15 (1/1) (1/1) (1/1) (1/1) jellyfish 1138.0 91.0 jellyfish Jellyfish is a tool for fast, memory-efficient counting of k-mers in DNA Jellyfish Jellyfish Jellyfish A command-line algorithm for counting k-mers in DNA sequence. k-mer counting Sequence analysis, Genomics To update https://github.com/gmarcais/Jellyfish Assembly jellyfish iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/jellyfish https://github.com/galaxyproject/tools-iuc/tree/main/tools/jellyfish kmer-jellyfish 2.3.1 (0/1) (1/1) (1/1) (1/1) join_files_by_id join_files_by_id This tool will join datasets according to a column with identifier To update Text Manipulation join_files_by_id iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/join_files_by_id https://github.com/galaxyproject/tools-iuc/tree/main/tools/join_files_by_id 1.0 r-data.table 1.11.6 (0/1) (0/1) (0/1) (0/1) jq 2312.0 21.0 jq JQ is a lightweight and flexible command-line JSON processor To update https://stedolan.github.io/jq/ Text Manipulation jq iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/jq https://github.com/galaxyproject/tools-iuc/tree/main/tools/jq 1.0 jq 1.5 (1/1) (1/1) (1/1) (1/1) @@ -234,6 +275,8 @@ king 5.0 3.0 king Kinship-based INference for Gwas Up-to-date http://peop kleborate 319.0 38.0 kleborate Screen genome assemblies of Klebsiella pneumoniae and the Klebsiella pneumoniae species complex (KpSC) kleborate kleborate Kleborate Genomic surveillance framework and global population structure for Klebsiella pneumoniae.Kleborate is a tool to screen genome assemblies of Klebsiella pneumoniae and the Klebsiella pneumoniae species complex (KpSC) for:.A manuscript describing the Kleborate software in full is currently in preparation. In the meantime, if you use Kleborate, please cite the preprint: Lam, MMC. et al. Genomic surveillance framework and global population structure for Klebsiella pneumoniae. bioRxiv (2020). Multilocus sequence typing, Genome assembly, Virulence prediction Public health and epidemiology, Metagenomics, Population genomics, Sequence assembly, Whole genome sequencing Up-to-date https://github.com/katholt/Kleborate/wiki Metagenomics kleborate iuc https://github.com/katholt/Kleborate https://github.com/galaxyproject/tools-iuc/tree/main/tools/kleborate 2.3.2 kleborate 2.3.2 (0/1) (0/1) (1/1) (0/1) kma kma_map Map with KMA To update https://bitbucket.org/genomicepidemiology/kma Next Gen Mappers kma iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/kma https://github.com/galaxyproject/tools-iuc/tree/main/tools/kma 1.2.21 kma 1.4.14 (0/1) (0/1) (1/1) (0/1) kofamscan 594.0 33.0 kofamscan Gene function annotation tool based on KEGG Orthology and hidden Markov model kofamscan kofamscan kofamscan KofamScan is a gene function annotation tool based on KEGG Orthology and hidden Markov model. You need KOfam database to use this tool. Sequence analysis, Gene functional annotation Genomics Up-to-date https://github.com/takaram/kofam_scan Sequence Analysis kofamscan iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/kofamscan https://github.com/galaxyproject/tools-iuc/tree/main/tools/kofamscan 1.3.0 kofamscan 1.3.0 (0/1) (0/1) (1/1) (1/1) +kraken 13938.0 404.0 kraken-filter, kraken-mpa-report, kraken-report, kraken-translate, kraken Kraken is a system for assigning taxonomic labels to short DNAsequences, usually obtained through metagenomic studies. Previous attempts by otherbioinformatics software to accomplish this task have often used sequence alignmentor machine learning techniques that were quite slow, leading to the developmentof less sensitive but much faster abundance estimation programs. Kraken aims toachieve high sensitivity and high speed by utilizing exact alignments of k-mersand a novel classification algorithm. kraken kraken Kraken System for assigning taxonomic labels to short DNA sequences, usually obtained through metagenomic studies. Previous attempts by other bioinformatics software to accomplish this task have often used sequence alignment or machine learning techniques that were quite slow, leading to the development of less sensitive but much faster abundance estimation programs. It aims to achieve high sensitivity and high speed by utilizing exact alignments of k-mers and a novel classification algorithm. Taxonomic classification Taxonomy, Metagenomics To update http://ccb.jhu.edu/software/kraken/ Metagenomics kraken devteam https://github.com/galaxyproject/tools-iuc/blob/master/tool_collections/kraken/ https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/kraken kraken 1.1.1 (5/5) (5/5) (5/5) (5/5) +kraken2 185308.0 2367.0 kraken2 Kraken2 for taxonomic designation. kraken2 kraken2 kraken2 Kraken 2 is the newest version of Kraken, a taxonomic classification system using exact k-mer matches to achieve high accuracy and fast classification speeds. This classifier matches each k-mer within a query sequence to the lowest common ancestor (LCA) of all genomes containing the given k-mer. The k-mer assignments inform the classification algorithm. Taxonomic classification Taxonomy, Metagenomics To update http://ccb.jhu.edu/software/kraken/ Metagenomics kraken2 iuc https://github.com/galaxyproject/tools-iuc/blob/master/tool_collections/kraken2/kraken2/ https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/kraken2/kraken2 2.1.1 kraken2 2.1.3 (1/1) (1/1) (1/1) (1/1) kraken_biom 1444.0 182.0 kraken_biom Create BIOM-format tables (http://biom-format.org) from Kraken output (http://ccb.jhu.edu/software/kraken/) Up-to-date https://github.com/smdabdoub/kraken-biom Metagenomics kraken_biom iuc https://github.com/smdabdoub/kraken-biom https://github.com/galaxyproject/tools-iuc/tree/main/tools/kraken_biom 1.2.0 kraken-biom 1.2.0 (0/1) (1/1) (1/1) (1/1) kraken_taxonomy_report 2527.0 354.0 kraken_taxonomy_report Kraken taxonomy report Kraken-Taxonomy-Report Kraken-Taxonomy-Report Kraken-Taxonomy-Report view report of classification for multiple samples Visualisation, Classification Metagenomics, Taxonomy To update https://github.com/blankenberg/Kraken-Taxonomy-Report Metagenomics kraken_taxonomy_report iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/kraken_taxonomy_report https://github.com/galaxyproject/tools-iuc/tree/main/tools/kraken_taxonomy_report 0.0.3 biopython 1.70 (1/1) (1/1) (1/1) (0/1) krakentools krakentools_alpha_diversity, krakentools_beta_diversity, krakentools_combine_kreports, krakentools_extract_kraken_reads, krakentools_kreport2krona, krakentools_kreport2mpa KrakenTools is a suite of scripts to be used alongside the Kraken krakentools krakentools KrakenTools KrakenTools provides individual scripts to analyze Kraken/Kraken2/Bracken/KrakenUniq output files Visualisation, Aggregation Taxonomy, Metagenomics Up-to-date https://github.com/jenniferlu717/KrakenTools Metagenomics krakentools iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/krakentools https://github.com/galaxyproject/tools-iuc/tree/main/tools/krakentools 1.2 krakentools 1.2 (1/6) (6/6) (6/6) (6/6) @@ -253,7 +296,7 @@ m6anet 3.0 m6anet m6anet to detect m6A RNA modifications from nanopore data m6A maaslin2 188.0 29.0 maaslin2 MaAsLin2 is comprehensive R package for efficiently determining multivariable association between microbial meta'omic features and clinical metadata. maaslin2 maaslin2 MaAsLin2 MaAsLin2 is comprehensive R package for efficiently determining multivariable association between phenotypes, environments, exposures, covariates and microbial meta’omic features. MaAsLin2 relies on general linear models to accommodate most modern epidemiological study designs, including cross-sectional and longitudinal, and offers a variety of data exploration, normalization, and transformation methods. Filtering, Statistical calculation, Standardisation and normalisation, Visualisation Metagenomics, Statistics and probability To update http://huttenhower.sph.harvard.edu/maaslin Metagenomics maaslin2 iuc https://github.com/biobakery/Maaslin2 https://github.com/galaxyproject/tools-iuc/tree/main/tools/maaslin2 0.99.12 maaslin2 1.16.0 (0/1) (0/1) (1/1) (0/1) macs2 84202.0 1968.0 macs2_bdgbroadcall, macs2_bdgcmp, macs2_bdgdiff, macs2_bdgpeakcall, macs2_callpeak, macs2_filterdup, macs2_predictd, macs2_randsample, macs2_refinepeak MACS - Model-based Analysis of ChIP-Seq macs macs MACS Model-based Analysis of ChIP-seq data. Peak calling, Enrichment analysis, Gene regulatory network analysis ChIP-seq, Molecular interactions, pathways and networks, Transcription factors and regulatory sites Up-to-date https://github.com/taoliu/MACS Sequence Analysis, Statistics macs2 iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/macs2 https://github.com/galaxyproject/tools-iuc/tree/main/tools/macs2 2.2.9.1 macs2 2.2.9.1 (9/9) (9/9) (9/9) (9/9) maf_stats 8.0 2.0 maf_stats1 MAF Coverage statistics To update https://github.com/galaxyproject/tools-iuc/tree/master/tools/interval2maf/ Genomic Interval Operations maf_stats iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/interval2maf/ https://github.com/galaxyproject/tools-iuc/tree/main/tools/maf_stats 1.0.2+galaxy0 (1/1) (1/1) (1/1) (1/1) -mageck mageck_count, mageck_gsea, mageck_mle, mageck_pathway, mageck_test Model-based Analysis of Genome-wide CRISPR-Cas9 Knockout (MAGeCK) is a computational tool to identifyimportant genes from the recent genome-scale CRISPR-Cas9 knockout screens technology. mageck mageck MAGeCK Computational tool to identify important genes from the recent genome-scale CRISPR-Cas9 knockout screens technology. Genetic variation analysis Genetics, Genetic variation, Genomics To update https://sourceforge.net/projects/mageck/ Genome editing iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/mageck https://github.com/galaxyproject/tools-iuc/tree/main/tools/mageck 0.5.9.2 mageck 0.5.9.5 (3/5) (5/5) (5/5) (0/5) +mageck mageck_count, mageck_gsea, mageck_mle, mageck_pathway, mageck_test Model-based Analysis of Genome-wide CRISPR-Cas9 Knockout (MAGeCK) is a computational tool to identifyimportant genes from the recent genome-scale CRISPR-Cas9 knockout screens technology. mageck mageck MAGeCK Computational tool to identify important genes from the recent genome-scale CRISPR-Cas9 knockout screens technology. Genetic variation analysis Genetics, Genetic variation, Genomics To update https://sourceforge.net/projects/mageck/ Genome editing iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/mageck https://github.com/galaxyproject/tools-iuc/tree/main/tools/mageck 0.5.9.2 mageck 0.5.9.5 (3/5) (5/5) (5/5) (5/5) maker 4950.0 419.0 maker, maker_map_ids MAKER is a portable and easily configurable genome annotation pipeline.Its purpose is to allow smaller eukaryotic and prokaryotic genome projects to independently annotate their genomes and to create genome databases. maker maker MAKER Portable and easily configurable genome annotation pipeline. It’s purpose is to allow smaller eukaryotic and prokaryotic genome projects to independently annotate their genomes and to create genome databases. Genome annotation Genomics, DNA, Sequence analysis To update http://www.yandell-lab.org/software/maker.html Sequence Analysis iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/maker https://github.com/galaxyproject/tools-iuc/tree/main/tools/maker 2.31.11 maker 3.01.03 (2/2) (2/2) (2/2) (2/2) malt malt_run Aligns an input sequence (DNA or proteins) against an index representing a collection of reference DNA or protein sequences. To update https://github.com/husonlab/malt Next Gen Mappers malt_run iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/malt https://github.com/galaxyproject/tools-iuc/tree/main/tools/malt 0.5.3 malt 0.62 (0/1) (0/1) (1/1) (0/1) map_param_value 1528.0 9.0 map_param_value Map a parameter value to another value To update Text Manipulation map_param_value iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/map_param_value https://github.com/galaxyproject/tools-iuc/tree/main/tools/map_param_value 0.2.0 (1/1) (0/1) (1/1) (0/1) @@ -265,7 +308,7 @@ maxbin2 2059.0 118.0 maxbin2 clusters metagenomic contigs into bins maxbin maxbi mcl 29.0 10.0 mcl The Markov Cluster Algorithm, a cluster algorithm for graphs mcl mcl MCL MCL is a clustering algorithm widely used in bioinformatics and gaining traction in other fields. Clustering, Network analysis, Gene regulatory network analysis Molecular interactions, pathways and networks Up-to-date https://micans.org/mcl/man/mcl.html Sequence Analysis mcl iuc https://github.com/galaxyproject/tools-iuc/tree/master/mcl https://github.com/galaxyproject/tools-iuc/tree/main/tools/mcl 22.282 mcl 22.282 (0/1) (0/1) (1/1) (0/1) medaka medaka_consensus, medaka_consensus_pipeline, medaka_snp, medaka_variant Sequence correction provided by ONT Research medaka medaka Medaka medaka is a tool to create consensus sequences and variant calls from nanopore sequencing data. This task is performed using neural networks applied a pileup of individual sequencing reads against a draft assembly. Base-calling, Variant calling, Sequence assembly Sequence assembly, Machine learning To update https://github.com/nanoporetech/medaka Sequence Analysis iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/medaka https://github.com/galaxyproject/tools-iuc/tree/main/tools/medaka 1.7.2 medaka 1.11.3 (3/4) (3/4) (3/4) (3/4) megahit 9530.0 548.0 megahit An ultra-fast single-node solution for large and complex metagenomics assembly via succinct de Bruijn graph. megahit megahit MEGAHIT Single node assembler for large and complex metagenomics NGS reads, such as soil. It makes use of succinct de Bruijn graph to achieve low memory usage, whereas its goal is not to make memory usage as low as possible. Genome assembly Metagenomics, Sequencing, Ecology, Sequence assembly Up-to-date https://github.com/voutcn/megahit Sequence Analysis, Assembly, Metagenomics megahit iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/megahit https://github.com/galaxyproject/tools-iuc/tree/main/tools/megahit 1.2.9 megahit 1.2.9 (1/1) (1/1) (1/1) (1/1) -megahit_contig2fastg 475.0 54.0 megahit_contig2fastg A subprogram within the Megahit toolkit for converting contigs to assembly graphs (fastg) megahit megahit MEGAHIT Single node assembler for large and complex metagenomics NGS reads, such as soil. It makes use of succinct de Bruijn graph to achieve low memory usage, whereas its goal is not to make memory usage as low as possible. Genome assembly Metagenomics, Sequencing, Ecology, Sequence assembly To update https://github.com/voutcn/megahit/blob/master/tools/toolkit.cpp Sequence Analysis, Assembly, Metagenomics megahit_contig2fastg iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/megahit_contig2fastg https://github.com/galaxyproject/tools-iuc/tree/main/tools/megahit_contig2fastg 1.1.3 megahit 1.2.9 (1/1) (0/1) (1/1) (0/1) +megahit_contig2fastg 475.0 54.0 megahit_contig2fastg A subprogram within the Megahit toolkit for converting contigs to assembly graphs (fastg) megahit megahit MEGAHIT Single node assembler for large and complex metagenomics NGS reads, such as soil. It makes use of succinct de Bruijn graph to achieve low memory usage, whereas its goal is not to make memory usage as low as possible. Genome assembly Metagenomics, Sequencing, Ecology, Sequence assembly To update https://github.com/voutcn/megahit/blob/master/tools/toolkit.cpp Sequence Analysis, Assembly, Metagenomics megahit_contig2fastg iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/megahit_contig2fastg https://github.com/galaxyproject/tools-iuc/tree/main/tools/megahit_contig2fastg 1.1.3 megahit 1.2.9 (1/1) (0/1) (1/1) (1/1) megan megan_blast2lca, megan_blast2rma, megan_daa2info, megan_daa2rma, megan_daa_meganizer, megan_read_extractor, megan_sam2rma MEGAN Community Edition - Interactive exploration and analysis of large-scale microbiome sequencing data. MEGAN is a tool for studying the taxonomic content of a set of DNA reads, typically collected in a metagenomics project.In a preprocessing step, a sequence alignment of all reads against a suitable database of reference DNA or proteinsequences must be performed to produce an input file for the program. MEGAN is suitable for DNA reads (metagenomedata), RNA reads (metatranscriptome data), peptide sequences (metaproteomics data) and, using a suitable synonymsfile that maps SILVA ids to taxon ids, for 16S rRNA data (amplicon sequencing). megan megan MEGAN Metagenome Analysis Software - MEGAN (MEtaGenome ANalyzer) is a new computer program that allows laptop analysis of large metagenomic datasets. In a preprocessing step, the set of DNA reads (or contigs) is compared against databases of known sequences using BLAST or another comparison tool. MEGAN can then be used to compute and interactively explore the taxonomical content of the dataset, employing the NCBI taxonomy to summarize and order the results. Sequence analysis, Taxonomic classification Sequence analysis To update https://github.com/husonlab/megan-ce Sequence Analysis megan iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/megan https://github.com/galaxyproject/tools-iuc/tree/main/tools/megan 6.21.7 megan 6.25.9 (0/7) (0/7) (7/7) (0/7) meme meme_dreme, meme_fimo, meme_meme, meme_psp_gen The MEME Suite allows the biologist to discover novel motifs in collections of unaligned nucleotideor protein sequences, and to perform a wide variety of other motif-based analyses. meme_meme meme_meme, meme_fimo meme_meme An algorithm that discovers one or more motifs in a collection of DNA or protein sequences by using the technique of expectation maximization to fit a two-component finite mixture model to the set of sequences. Nucleic acid feature detection, Protein feature detection, Statistical calculation Data mining, Sequence analysis, Genetic variation, Statistics and probability To update http://meme-suite.org/ ChIP-seq meme iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/meme https://github.com/galaxyproject/tools-iuc/tree/main/tools/meme 5.4.1 meme 5.5.5 (3/4) (0/4) (4/4) (0/4) meme_chip 6584.0 287.0 meme_chip Performs motif discovery, motif enrichment analysis and clustering on large nucleotide datasets. To update http://meme-suite.org/ ChIP-seq meme_chip iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/meme_chip https://github.com/galaxyproject/tools-iuc/tree/main/tools/meme_chip 4.11.2 graphicsmagick 1.3.26 (1/1) (0/1) (1/1) (0/1) @@ -341,7 +384,7 @@ pharokka 2565.0 74.0 pharokka rapid standardised annotation tool for bacteriopha " (0/1) (1/1) (1/1) (0/1) phyloseq phyloseq_from_biom, phyloseq_from_dada2, phyloseq_plot_ordination, phyloseq_plot_richness Handling and analysis of high-throughput microbiome census data phyloseq phyloseq phyloseq Provides a set of classes and tools to facilitate the import, storage, analysis, and graphical display of microbiome census data. Deposition, Analysis, Visualisation Microbiology, Sequence analysis, Metagenomics Up-to-date https://www.bioconductor.org/packages/release/bioc/html/phyloseq.html Metagenomics phyloseq iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/phyloseq https://github.com/galaxyproject/tools-iuc/tree/main/tools/phyloseq 1.46.0 bioconductor-phyloseq 1.46.0 (0/4) (0/4) (4/4) (0/4) phyml 1770.0 104.0 phyml PhyML is a phylogeny software based on the maximum-likelihood principle. phyml phyml PhyML Phylogenetic estimation software using Maximum Likelihood Phylogenetic tree generation (maximum likelihood and Bayesian methods) Phylogenetics, Bioinformatics, Phylogenetics Up-to-date http://www.atgc-montpellier.fr/phyml/ Phylogenetics phyml iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/phyml https://github.com/galaxyproject/tools-iuc/tree/main/tools/phyml 3.3.20220408 phyml 3.3.20220408 (0/1) (1/1) (1/1) (1/1) -picard 379429.0 3956.0 picard_AddCommentsToBam, picard_AddOrReplaceReadGroups, picard_BedToIntervalList, picard_CleanSam, picard_CASM, picard_CollectBaseDistributionByCycle, picard_CollectGcBiasMetrics, picard_CollectHsMetrics, picard_CollectInsertSizeMetrics, picard_CollectRnaSeqMetrics, picard_artifact_metrics, picard_CollectWgsMetrics, picard_DownsampleSam, picard_EstimateLibraryComplexity, picard_FastqToSam, picard_FilterSamReads, picard_FixMateInformation, picard_MarkDuplicates, picard_MarkDuplicatesWithMateCigar, picard_MeanQualityByCycle, picard_MergeBamAlignment, picard_MergeSamFiles, picard_NormalizeFasta, picard_QualityScoreDistribution, picard_ReorderSam, picard_ReplaceSamHeader, picard_RevertOriginalBaseQualitiesAndAddMateCigar, picard_RevertSam, picard_SamToFastq, picard_SortSam, picard_ValidateSamFile Picard SAM/BAM manipulation tools. picard_samtofastq picard_samtofastq, picard_reordersam, picard_replacesamheader, picard_fastqtosam picard_samtofastq Create a FASTQ file. Formatting Sequencing Up-to-date http://broadinstitute.github.io/picard/ SAM picard devteam https://github.com/galaxyproject/tools-iuc/tree/master/tools/picard https://github.com/galaxyproject/tools-iuc/tree/main/tools/picard 3.1.1 picard 3.1.1 (31/31) (31/31) (31/31) (31/31) +picard 379429.0 3956.0 picard_AddCommentsToBam, picard_AddOrReplaceReadGroups, picard_BedToIntervalList, picard_CleanSam, picard_CASM, picard_CollectBaseDistributionByCycle, picard_CollectGcBiasMetrics, picard_CollectHsMetrics, picard_CollectInsertSizeMetrics, picard_CollectRnaSeqMetrics, picard_artifact_metrics, picard_CollectWgsMetrics, picard_DownsampleSam, picard_EstimateLibraryComplexity, picard_FastqToSam, picard_FilterSamReads, picard_FixMateInformation, picard_MarkDuplicates, picard_MarkDuplicatesWithMateCigar, picard_MeanQualityByCycle, picard_MergeBamAlignment, picard_MergeSamFiles, picard_NormalizeFasta, picard_QualityScoreDistribution, picard_ReorderSam, picard_ReplaceSamHeader, picard_RevertOriginalBaseQualitiesAndAddMateCigar, picard_RevertSam, picard_SamToFastq, picard_SortSam, picard_ValidateSamFile Picard SAM/BAM manipulation tools. picard_samtofastq picard_fastqtosam, picard_replacesamheader, picard_samtofastq, picard_reordersam picard_samtofastq Create a FASTQ file. Formatting Sequencing Up-to-date http://broadinstitute.github.io/picard/ SAM picard devteam https://github.com/galaxyproject/tools-iuc/tree/master/tools/picard https://github.com/galaxyproject/tools-iuc/tree/main/tools/picard 3.1.1 picard 3.1.1 (31/31) (31/31) (31/31) (31/31) pick_value 116.0 2.0 pick_value Compose a text parameter value using text, integer and float values To update Text Manipulation pick_value iuc https://github.com/galaxyproject/tools-iuc/tree/main/tools/pick_value https://github.com/galaxyproject/tools-iuc/tree/main/tools/pick_value 0.2.0 (1/1) (1/1) (1/1) (0/1) picrust picrust_categorize, picrust_compare_biom, picrust_format_tree_and_trait_table, picrust_metagenome_contributions, picrust_normalize_by_copy_number, picrust_predict_metagenomes PICRUSt wrappers picrust picrust PICRUSt PICRUSt (Phylogenetic Investigation of Communities by Reconstruction of Unobserved States) is a bioinformatics software package designed to predict metagenome functional content from marker gene (e.g., 16S rRNA) surveys and full genomes. Phylogenetic reconstruction, Expression analysis, Genome annotation, DNA barcoding Metagenomics, Microbial ecology, Functional, regulatory and non-coding RNA, Metagenomic sequencing To update https://picrust.github.io/picrust/ Metagenomics picrust iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/picrust https://github.com/galaxyproject/tools-iuc/tree/main/tools/picrust 1.1.1 picrust 1.1.4 (0/6) (6/6) (5/6) (6/6) picrust2 picrust2_add_descriptions, picrust2_hsp, picrust2_metagenome_pipeline, picrust2_pathway_pipeline, picrust2_pipeline, picrust2_place_seqs, picrust2_shuffle_predictions PICRUSt2: Phylogenetic Investigation of Communities by Reconstruction of Unobserved States picrust2 picrust2 PICRUSt2 PICRUSt2 (Phylogenetic Investigation of Communities by Reconstruction of Unobserved States) is a software for predicting functional abundances based only on marker gene sequences. Phylogenetic reconstruction, Expression analysis, Rarefaction, Pathway analysis Metagenomics, Microbiology, Phylogenetics, Metagenomic sequencing To update https://github.com/picrust/picrust2/wiki Metagenomics picrust2 iuc https://github.com/picrust/picrust2 https://github.com/galaxyproject/tools-iuc/tree/main/tools/picrust2 2.5.1 picrust2 2.5.2 (0/7) (7/7) (7/7) (0/7) @@ -370,8 +413,8 @@ pyega3 pyega3 EGA python client uses the EGA REST API to download authorized d pygenometracks 11332.0 377.0 pygenomeTracks pyGenomeTracks: Standalone program and library to plot beautiful genome browser tracks. pygenometracks pygenometracks pyGenomeTracks reproducible plots for multivariate genomic data sets.Standalone program and library to plot beautiful genome browser tracks.pyGenomeTracks aims to produce high-quality genome browser tracks that are highly customizable. Currently, it is possible to plot:. Visualisation, Formatting Model organisms, Imaging, Workflows To update https://github.com/deeptools/pyGenomeTracks Visualization pygenometracks iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/pygenometracks https://github.com/galaxyproject/tools-iuc/tree/main/tools/pygenometracks 3.8 pygenometracks 3.9 (1/1) (1/1) (1/1) (1/1) pysradb pysradb_search pysradb allows to retrieve metadata, such as run accession numbers, from SRA and ENA based on multiple criteria. pysradb pysradb pysradb Python package to query next-generation sequencing metadata and data from NCBI Sequence Read Archive. Deposition, Data retrieval Sequencing, Gene transcripts, Bioinformatics To update https://github.com/saketkc/pysradb Sequence Analysis pysradb_search iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/pysradb https://github.com/galaxyproject/tools-iuc/tree/main/tools/pysradb 1.4.2 pysradb 2.2.0 (0/1) (0/1) (1/1) (0/1) qfilt qfilt Filter sequencing data To update https://github.com/veg/qfilt Fastq Manipulation qfilt iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/qfilt https://github.com/galaxyproject/tools-iuc/tree/main/tools/qfilt 1.0.0+galaxy1 qfilt 0.0.1 (0/1) (0/1) (0/1) (0/1) -qiime_add_on qiime_collapse_samples, qiime_make_otu_table QIIME to perform microbial community analysis qiime_add_on qiime_add_on qiime_add_on QIIME 2 is a next-generation microbiome bioinformatics platform that is extensible, free, open source, and community developed. Demultiplexing, Visualisation, Taxonomic classification, Phylogenetic analysis, Sequencing quality control Microbial ecology, Phylogeny, Metagenomics, Metatranscriptomics To update http://www.qiime.org Metagenomics qiime iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/qiime/ https://github.com/galaxyproject/tools-iuc/tree/main/tools/qiime/qiime_add_on qiime 1.9.1 (0/2) (0/2) (2/2) (2/2) -qiime_core qiime_align_seqs, qiime_alpha_diversity, qiime_alpha_rarefaction, qiime_assign_taxonomy, qiime_beta_diversity, qiime_beta_diversity_through_plots, qiime_compare_categories, qiime_core_diversity, qiime_count_seqs, qiime_extract_barcodes, qiime_filter_alignment, qiime_filter_fasta, qiime_filter_otus_from_otu_table, qiime_filter_samples_from_otu_table, qiime_filter_taxa_from_otu_table, qiime_jackknifed_beta_diversity, qiime_make_emperor, qiime_make_otu_heatmap, qiime_make_phylogeny, qiime_multiple_join_paired_ends, qiime_multiple_split_libraries_fastq, qiime_pick_closed_reference_otus, qiime_pick_open_reference_otus, qiime_pick_otus, qiime_pick_rep_set, qiime_plot_taxa_summary, qiime_split_libraries, qiime_split_libraries_fastq, qiime_summarize_taxa, qiime_summarize_taxa_through_plots, qiime_upgma_cluster, qiime_validate_mapping_file QIIME to perform microbial community analysis To update http://www.qiime.org Metagenomics qiime iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/qiime/ https://github.com/galaxyproject/tools-iuc/tree/main/tools/qiime/qiime_core qiime 1.9.1 (0/32) (0/32) (32/32) (32/32) +qiime_add_on qiime_collapse_samples, qiime_make_otu_table QIIME to perform microbial community analysis qiime_add_on qiime_add_on, qiime_core qiime_add_on QIIME 2 is a next-generation microbiome bioinformatics platform that is extensible, free, open source, and community developed. Demultiplexing, Visualisation, Taxonomic classification, Phylogenetic analysis, Sequencing quality control Microbial ecology, Phylogeny, Metagenomics, Metatranscriptomics To update http://www.qiime.org Metagenomics qiime iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/qiime/ https://github.com/galaxyproject/tools-iuc/tree/main/tools/qiime/qiime_add_on qiime 1.9.1 (0/2) (0/2) (2/2) (2/2) +qiime_core qiime_align_seqs, qiime_alpha_diversity, qiime_alpha_rarefaction, qiime_assign_taxonomy, qiime_beta_diversity, qiime_beta_diversity_through_plots, qiime_compare_categories, qiime_core_diversity, qiime_count_seqs, qiime_extract_barcodes, qiime_filter_alignment, qiime_filter_fasta, qiime_filter_otus_from_otu_table, qiime_filter_samples_from_otu_table, qiime_filter_taxa_from_otu_table, qiime_jackknifed_beta_diversity, qiime_make_emperor, qiime_make_otu_heatmap, qiime_make_phylogeny, qiime_multiple_join_paired_ends, qiime_multiple_split_libraries_fastq, qiime_pick_closed_reference_otus, qiime_pick_open_reference_otus, qiime_pick_otus, qiime_pick_rep_set, qiime_plot_taxa_summary, qiime_split_libraries, qiime_split_libraries_fastq, qiime_summarize_taxa, qiime_summarize_taxa_through_plots, qiime_upgma_cluster, qiime_validate_mapping_file QIIME to perform microbial community analysis qiime_core qiime_core qiime_core QIIME 2™ is a next-generation microbiome bioinformatics platform that is extensible, free, open source, and community developed. Demultiplexing, Visualisation, Taxonomic classification, Phylogenetic analysis, Sequencing quality control Microbial ecology, Phylogeny, Metagenomics, Metatranscriptomics To update http://www.qiime.org Metagenomics qiime iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/qiime/ https://github.com/galaxyproject/tools-iuc/tree/main/tools/qiime/qiime_core qiime 1.9.1 (0/32) (0/32) (32/32) (32/32) qiime_extract_viz qiime_extract_viz Extract vizualization from QIIME artifacts To update http://www.qiime.org Metagenomics qiime_extract_viz iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/qiimme_extract_viz https://github.com/galaxyproject/tools-iuc/tree/main/tools/qiime_extract_viz 0.1.0 unzip (0/1) (0/1) (1/1) (0/1) qq_tools qq_manhattan To update https://CRAN.R-project.org/package=qqman Visualization, Variant Analysis iuc https://github.com/galaxyproject/tools-iuc/tree/main/tools/qq_tools 0.1.0 r-qqman 0.1.4 (0/1) (0/1) (0/1) (0/1) qualimap qualimap_bamqc, qualimap_counts, qualimap_multi_bamqc, qualimap_rnaseq qualimap qualimap QualiMap Platform-independent application written in Java and R that provides both a Graphical User Inteface (GUI) and a command-line interface to facilitate the quality control of alignment sequencing data. Sequencing quality control Data quality management To update http://qualimap.bioinfo.cipf.es/ Sequence Analysis, Transcriptomics, SAM qualimap iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/qualimap https://github.com/galaxyproject/tools-iuc/tree/main/tools/qualimap 2.2.2d qualimap 2.3 (4/4) (4/4) (4/4) (1/4) @@ -410,6 +453,7 @@ rseqc 135036.0 3269.0 rseqc_FPKM_count, rseqc_RNA_fragment_size, rseqc_RPKM_satu ruvseq 1236.0 76.0 ruvseq Remove Unwanted Variation from RNA-Seq Data ruvseq ruvseq RUVSeq This package implements the remove unwanted variation (RUV) methods for the normalization of RNA-Seq read counts between samples. Differential gene expression analysis Gene expression, RNA-seq To update https://www.bioconductor.org/packages/release/bioc/html/DESeq2.html Transcriptomics, RNA, Statistics ruvseq iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/ruvseq https://github.com/galaxyproject/tools-iuc/tree/main/tools/ruvseq 1.26.0 bioconductor-ruvseq 1.36.0 (1/1) (0/1) (1/1) (0/1) salsa2 salsa A tool to scaffold long read assemblies with Hi-C SALSA SALSA SALSA > VERY_LOW CONFIDENCE! | > CORRECT NAME OF TOOL COULD ALSO BE 'chromosome-scale', 'reference-quality', 'Hi-C', 'scaffolder' | Integrating Hi-C links with assembly graphs for chromosome-scale assembly | SALSA: A tool to scaffold long read assemblies with Hi-C data | SALSA: A tool to scaffold long read assemblies with Hi-C | This code is used to scaffold your assemblies using Hi-C data. This version implements some improvements in the original SALSA algorithm. If you want to use the old version, it can be found in the old_salsa branch Genome assembly, De-novo assembly, Scaffolding Sequence assembly, DNA binding sites, Mapping Up-to-date https://github.com/marbl/SALSA Assembly salsa iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/salsa2 https://github.com/galaxyproject/tools-iuc/tree/main/tools/salsa2 2.3 salsa2 2.3 (1/1) (1/1) (1/1) (0/1) samblaster samblaster samblaster marks duplicates and can output split and discordant alignments from SAM/BAM files samblaster samblaster SAMBLASTER A tool to mark duplicates and extract discordant and split reads from SAM files. Split read mapping DNA, Sequencing, Mapping To update https://github.com/GregoryFaust/samblaster SAM, Fastq Manipulation, Variant Analysis samblaster iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/samblaster https://github.com/galaxyproject/tools-iuc/tree/main/tools/samblaster 0.1.24 samblaster 0.1.26 (0/1) (0/1) (0/1) (0/1) +samtools To update https://github.com/samtools/samtools SAM iuc https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/samtools https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/samtools 1.15.1 samtools 1.20 (0/1) (0/1) (0/1) (0/1) sansa sansa_annotate Sansa is a tool for structural variant annotation. Up-to-date https://github.com/dellytools/sansa Variant Analysis sansa iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/sansa https://github.com/galaxyproject/tools-iuc/tree/main/tools/sansa 0.2.1 sansa 0.2.1 (0/1) (0/1) (1/1) (0/1) sarscov2formatter 173.0 7.0 sarscov2formatter sarscov2formatter custom script Up-to-date https://github.com/nickeener/sarscov2formatter Sequence Analysis sarscov2formatter iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/sarscov2formatter https://github.com/galaxyproject/tools-iuc/tree/main/tools/sarscov2formatter 1.0 sarscov2formatter 1.0 (1/1) (0/1) (1/1) (0/1) sarscov2summary 140.0 1.0 sarscov2summary sarscov2summary custom script To update https://github.com/nickeener/sarscov2summary Sequence Analysis sarscov2summary iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/sarscov2summary https://github.com/galaxyproject/tools-iuc/tree/main/tools/sarscov2summary 0.1 sarscov2summary 0.5 (1/1) (0/1) (1/1) (0/1) @@ -441,7 +485,7 @@ sina 1128.0 42.0 sina SINA reference based multiple sequence alignment sina sina sinto sinto_barcode, sinto_fragments Sinto single-cell analysis tools To update https://github.com/timoast/sinto Sequence Analysis iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/sinto https://github.com/galaxyproject/tools-iuc/tree/main/tools/sinto 0.9.0 sinto 0.10.1 (2/2) (0/2) (2/2) (0/2) slamdunk 361.0 2.0 alleyoop, slamdunk Slamdunk maps and quantifies SLAMseq reads Up-to-date http://t-neumann.github.io/slamdunk RNA, Transcriptomics, Sequence Analysis, Next Gen Mappers slamdunk iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/slamdunk https://github.com/galaxyproject/tools-iuc/tree/main/tools/slamdunk 0.4.3 slamdunk 0.4.3 (2/2) (0/2) (2/2) (0/2) sleuth 64.0 8.0 sleuth Sleuth is a program for differential analysis of RNA-Seq data. sleuth sleuth sleuth A statistical model and software application for RNA-seq differential expression analysis. Expression data visualisation, Differential gene expression analysis, Gene expression profiling, Statistical calculation RNA-seq, Gene expression, Statistics and probability Up-to-date https://github.com/pachterlab/sleuth Transcriptomics, RNA, Statistics sleuth iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/sleuth https://github.com/galaxyproject/tools-iuc/tree/main/tools/sleuth 0.30.1 r-sleuth 0.30.1 (0/1) (0/1) (1/1) (0/1) -smallgenomeutilities smgu_frameshift_deletions_checks Set of utilities for manipulating small viral genome data. v-pipe v-pipe V-pipe Bioinformatics pipeline for the analysis of next-generation sequencing data derived from intra-host viral populations. Read pre-processing, Sequence alignment, Genetic variation analysis Genomics, Population genetics, Workflows, Virology, Sequencing To update https://github.com/cbg-ethz/smallgenomeutilities Sequence Analysis smallgenomeutilities iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/smallgenomeutilities https://github.com/galaxyproject/tools-iuc/tree/main/tools/smallgenomeutilities 0.4.0 smallgenomeutilities 0.4.1 (0/1) (0/1) (1/1) (0/1) +smallgenomeutilities smgu_frameshift_deletions_checks Set of utilities for manipulating small viral genome data. v-pipe v-pipe V-pipe Bioinformatics pipeline for the analysis of next-generation sequencing data derived from intra-host viral populations. Read pre-processing, Sequence alignment, Genetic variation analysis Genomics, Population genetics, Workflows, Virology, Sequencing Up-to-date https://github.com/cbg-ethz/smallgenomeutilities Sequence Analysis smallgenomeutilities iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/smallgenomeutilities https://github.com/galaxyproject/tools-iuc/tree/main/tools/smallgenomeutilities 0.4.1 smallgenomeutilities 0.4.1 (0/1) (0/1) (1/1) (0/1) smudgeplot 203.0 22.0 smudgeplot Inference of ploidy and heterozygosity structure using whole genome sequencing smudgeplots smudgeplots Smudgeplots Reference-free profiling of polyploid genomes | Inference of ploidy and heterozygosity structure using whole genome sequencing data | Smudgeplots are computed from raw or even better from trimmed reads and show the haplotype structure using heterozygous kmer pairs. For example: | This tool extracts heterozygous kmer pairs from kmer dump files and performs gymnastics with them. We are able to disentangle genome structure by comparing the sum of kmer pair coverages (CovA + CovB) to their relative coverage (CovA / (CovA + CovB)). Such an approach also allows us to analyze obscure genomes with duplications, various ploidy levels, etc | GenomeScope 2.0 and Smudgeplots: Reference-free profiling of polyploid genomes Timothy Rhyker Ranallo-Benavidez, Kamil S. Jaron, Michael C. Schatz bioRxiv 747568; doi: https://doi.org/10.1101/747568 Sequence trimming, Genotyping, k-mer counting Sequence assembly, Genetic variation, Mathematics Up-to-date https://github.com/KamilSJaron/smudgeplot Assembly smudgeplot galaxy-australia https://github.com/galaxyproject/tools-iuc https://github.com/galaxyproject/tools-iuc/tree/main/tools/smudgeplot 0.2.5 smudgeplot 0.2.5 (1/1) (1/1) (1/1) (0/1) snap snap, snap_training SNAP is a general purpose gene finding program suitable for both eukaryotic and prokaryotic genomes. snap snap SNAP The Semi-HMM-based Nucleic Acid Parser is a gene prediction tool. Gene prediction DNA, DNA polymorphism, Genetics Up-to-date https://github.com/KorfLab/SNAP Sequence Analysis snap iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/snap https://github.com/galaxyproject/tools-iuc/tree/main/tools/snap 2013_11_29 snap 2013_11_29 (1/2) (1/2) (1/2) (0/2) snapatac2 snapatac2_clustering, snapatac2_peaks_and_motif, snapatac2_plotting, snapatac2_preprocessing SnapATAC2 – A Python/Rust package for single-cell epigenomics analysis To update https://kzhang.org/SnapATAC2/ Epigenetics, Sequence Analysis snapatac2 iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/snapatac2 https://github.com/galaxyproject/tools-iuc/tree/main/tools/snapatac2 2.5.3 (0/4) (0/4) (4/4) (0/4) @@ -450,15 +494,19 @@ snipit 669.0 22.0 snipit Summarise snps relative to a reference sequence snipit snippy 105708.0 1372.0 snippy_core, snippy, snippy_clean_full_aln Contains the snippy tool for characterising microbial snps snippy snippy snippy Rapid haploid variant calling and core SNP phylogeny generation. Phylogenetic tree visualisation, Phylogenetic tree generation, Variant calling Genomics, Model organisms, DNA polymorphism, Phylogenetics To update https://github.com/tseemann/snippy Sequence Analysis snippy iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/snippy https://github.com/galaxyproject/tools-iuc/tree/main/tools/snippy snippy 4.6.0 (3/3) (3/3) (3/3) (3/3) snp-dists snp_dists Compute pairwise SNP distance matrix from a FASTA sequence alignment Up-to-date https://github.com/tseemann/snp-dists Variant Analysis snp_dists iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/snp-dists https://github.com/galaxyproject/tools-iuc/tree/main/tools/snp-dists 0.8.2 snp-dists 0.8.2 (1/1) (1/1) (1/1) (0/1) snp-sites snp_sites Finds SNP sites from a multi-FASTA alignment file Up-to-date https://github.com/sanger-pathogens/snp-sites Variant Analysis snp_sites iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/snp-sites https://github.com/galaxyproject/tools-iuc/tree/main/tools/snp-sites 2.5.1 snp-sites 2.5.1 (1/1) (1/1) (1/1) (0/1) +snpeff 101254.0 2843.0 snpEff, snpEff_build_gb, snpEff_databases, snpEff_download, snpEff_get_chr_names SnpEff is a genetic variant annotation and effect prediction toolbox To update http://snpeff.sourceforge.net/ Genome-Wide Association Study, Variant Analysis snpeff iuc https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/snpeff https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/snpeff biopython 1.70 (5/5) (5/5) (5/5) (5/5) snpeff-covid19 snpeff_sars_cov_2 SnpEff, the COVID-19 version, is a genetic variant annotation and effect prediction toolbox snpeff snpeff snpEff Variant annotation and effect prediction tool. It annotates and predicts the effects of variants on genes and proteins (such as amino acid changes). SNP detection DNA polymorphism, Genetic variation, Nucleic acid sites, features and motifs To update http://snpeff.sourceforge.net/ Genome-Wide Association Study, Variant Analysis snpeff_sars_cov_2 iuc https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/snpeff https://github.com/galaxyproject/tools-iuc/tree/main/tools/snpeff-covid19 (1/1) (1/1) (1/1) (1/1) snpfreqplot 3530.0 156.0 snpfreqplot Generates a heatmap of allele frequencies grouped by variant type for SARS-CoV-2 data To update https://github.com/galaxyproject/tools-iuc/tree/master/tools/snpfreqplot/ Variant Analysis snpfreqplot iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/snpfreqplot/ https://github.com/galaxyproject/tools-iuc/tree/main/tools/snpfreqplot 1.0 r-base (1/1) (1/1) (1/1) (1/1) +snpsift 5109063.0 1185.0 snpSift_annotate, snpSift_caseControl, snpSift_extractFields, snpSift_filter, snpSift_int, snpSift_rmInfo, snpsift_vartype, snpSift_vcfCheck snpEff SnpSift tools from Pablo Cingolani To update http://snpeff.sourceforge.net/SnpSift.html Variant Analysis snpsift iuc https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/snpsift/snpsift https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/snpsift/snpsift snpsift 5.2 (8/8) (8/8) (8/8) (8/8) +snpsift_dbnsfp 46.0 11.0 snpSift_dbnsfp snpEff SnpSift dbnsfp tool from Pablo Cingolani To update http://snpeff.sourceforge.net/SnpSift.html#dbNSFP Variant Analysis snpsift_dbnsfp iuc https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/snpsift/snpsift_dbnsfp https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/snpsift/snpsift_dbnsfp snpsift 5.2 (1/1) (0/1) (1/1) (0/1) +snpsift_genesets 390.0 11.0 snpSift_geneSets Annotate SnpEff vcf with genesets such as Gene Ontology (GO), KEGG, Reactome To update http://snpeff.sourceforge.net/SnpSift.html#geneSets Variant Analysis snpsift_genesets iuc https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/snpsift/snpsift_genesets/ https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/snpsift/snpsift_genesets snpsift 5.2 (1/1) (0/1) (1/1) (0/1) socru 621.0 13.0 socru Order and orientation of complete bacterial genomes To update https://github.com/quadram-institute-bioscience/socru Sequence Analysis socru iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/socru https://github.com/galaxyproject/tools-iuc/tree/main/tools/socru 2.1.7 socru 2.2.4 (1/1) (0/1) (1/1) (0/1) sonneityping 1.0 1.0 sonneityping Scripts for parsing Mykrobe predict results for Shigella sonnei. sonneityping sonneityping sonneityping Scripts for parsing Mykrobe predict results for Shigella sonnei. Antimicrobial resistance prediction, Variant calling, Genotyping Whole genome sequencing, Genotype and phenotype, Genetic variation, Metagenomics Up-to-date https://github.com/katholt/sonneityping Sequence Analysis sonneityping iuc https://github.com/katholt/sonneityping https://github.com/galaxyproject/tools-iuc/tree/main/tools/sonneityping 20210201 sonneityping 20210201 (0/1) (0/1) (1/1) (0/1) -spades 58834.0 2309.0 spades_biosyntheticspades, spades_coronaspades, spades_metaplasmidspades, metaspades, spades_metaviralspades, spades_plasmidspades, rnaspades, spades_rnaviralspades, spades SPAdes is an assembly toolkit containing various assembly pipelines. It implements the following 4 stages: assembly graph construction, k-bimer adjustment, construction of paired assembly graph and contig construction. spades rnaspades, biosyntheticspades, spades, plasmidspades, metaplasmidspades, rnaviralspades, coronaspades, metaviralspades, metaspades SPAdes St. Petersburg genome assembler – is intended for both standard isolates and single-cell MDA bacteria assemblies. SPAdes 3.9 works with Illumina or IonTorrent reads and is capable of providing hybrid assemblies using PacBio, Oxford Nanopore and Sanger reads. Additional contigs can be provided and can be used as long reads. Genome assembly Sequence assembly Up-to-date https://github.com/ablab/spades Assembly, RNA, Metagenomics spades iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/spades https://github.com/galaxyproject/tools-iuc/tree/main/tools/spades 3.15.5 spades 3.15.5 (9/9) (9/9) (9/9) (9/9) +spades 58834.0 2309.0 spades_biosyntheticspades, spades_coronaspades, spades_metaplasmidspades, metaspades, spades_metaviralspades, spades_plasmidspades, rnaspades, spades_rnaviralspades, spades SPAdes is an assembly toolkit containing various assembly pipelines. It implements the following 4 stages: assembly graph construction, k-bimer adjustment, construction of paired assembly graph and contig construction. spades coronaspades, biosyntheticspades, metaviralspades, metaspades, rnaspades, rnaviralspades, spades, plasmidspades, metaplasmidspades SPAdes St. Petersburg genome assembler – is intended for both standard isolates and single-cell MDA bacteria assemblies. SPAdes 3.9 works with Illumina or IonTorrent reads and is capable of providing hybrid assemblies using PacBio, Oxford Nanopore and Sanger reads. Additional contigs can be provided and can be used as long reads. Genome assembly Sequence assembly Up-to-date https://github.com/ablab/spades Assembly, RNA, Metagenomics spades iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/spades https://github.com/galaxyproject/tools-iuc/tree/main/tools/spades 3.15.5 spades 3.15.5 (9/9) (9/9) (9/9) (9/9) spaln 446.0 34.0 list_spaln_tables, spaln Spaln (space-efficient spliced alignment) maps and aligns a set of cDNA or protein sequences onto a whole genomic sequence. To update http://www.genome.ist.i.kyoto-u.ac.jp/~aln_user/spaln/ Sequence Analysis, Genome annotation spaln iuc https://github.com/ogotoh/spaln https://github.com/galaxyproject/tools-iuc/tree/main/tools/spaln 2.4.9 python (2/2) (0/2) (2/2) (0/2) spotyping 1278.0 12.0 spotyping SpoTyping allows fast and accurate in silico Mycobacterium spoligotyping from sequence reads spotyping spotyping SpoTyping Fast and accurate in silico Mycobacterium spoligotyping from sequence reads. Variant pattern analysis Microbiology, Sequencing, Sequence composition, complexity and repeats, Genetic variation Up-to-date https://github.com/xiaeryu/SpoTyping-v2.0 Sequence Analysis spotyping iuc https://github.com/xiaeryu/SpoTyping-v2.0/tree/master/SpoTyping-v2.0-commandLine https://github.com/galaxyproject/tools-iuc/tree/main/tools/spotyping 2.1 spotyping 2.1 (0/1) (0/1) (1/1) (0/1) spyboat 67.0 1.0 spyboat Wavelet analysis for 3d-image stacks To update http://github.com/tensionhead/spyboat Imaging, Graphics spyboat iuc https://github.com/galaxyproject/tools-iuc/tree/master/packages/spyboat https://github.com/galaxyproject/tools-iuc/tree/main/tools/spyboat 0.1.2 spyboat (0/1) (0/1) (1/1) (0/1) -sra-tools fasterq_dump, fastq_dump, sam_dump NCBI Sequence Read Archive toolkit utilities sra-tools sra-tools SRA Software Toolkit The SRA Toolkit and SDK from NCBI is a collection of tools and libraries for using data in the INSDC Sequence Read Archives. Data handling DNA, Genomics, Sequencing To update https://github.com/ncbi/sra-tools Data Source, Fastq Manipulation sra_tools iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/sra-tools https://github.com/galaxyproject/tools-iuc/tree/main/tools/sra-tools 3.1.0 sra-tools 3.1.1 (3/3) (3/3) (3/3) (3/3) +sra-tools fasterq_dump, fastq_dump, sam_dump NCBI Sequence Read Archive toolkit utilities sra-tools sra-tools SRA Software Toolkit The SRA Toolkit and SDK from NCBI is a collection of tools and libraries for using data in the INSDC Sequence Read Archives. Data handling DNA, Genomics, Sequencing Up-to-date https://github.com/ncbi/sra-tools Data Source, Fastq Manipulation sra_tools iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/sra-tools https://github.com/galaxyproject/tools-iuc/tree/main/tools/sra-tools 3.1.1 sra-tools 3.1.1 (3/3) (3/3) (3/3) (3/3) srst2 205.0 22.0 srst2 SRST2 Short Read Sequence Typing for Bacterial Pathogens srst2 srst2 srst2 Short Read Sequence Typing for Bacterial Pathogens Multilocus sequence typing Whole genome sequencing, Public health and epidemiology To update http://katholt.github.io/srst2/ Metagenomics srst2 iuc https://github.com/katholt/srst2 https://github.com/galaxyproject/tools-iuc/tree/main/tools/srst2 0.2.0 samtools 1.20 (0/1) (0/1) (1/1) (0/1) stacks stacks_assembleperead, stacks_clonefilter, stacks_cstacks, stacks_denovomap, stacks_genotypes, stacks_populations, stacks_procrad, stacks_pstacks, stacks_refmap, stacks_rxstacks, stacks_sstacks, stacks_stats, stacks_ustacks Stacks is a software pipeline for building loci from short-read sequences, such as RAD-seq stacks stacks Stacks Developed to work with restriction enzyme based sequence data, such as RADseq, for building genetic maps and conducting population genomics and phylogeography analysis. Data handling Mapping, Population genetics To update http://catchenlab.life.illinois.edu/stacks/ Sequence Analysis stacks iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/stacks https://github.com/galaxyproject/tools-iuc/tree/main/tools/stacks stacks 2.65 (0/13) (13/13) (13/13) (12/13) stacks2 stacks2_clonefilter, stacks2_cstacks, stacks2_denovomap, stacks2_gstacks, stacks2_kmerfilter, stacks2_populations, stacks2_procrad, stacks2_refmap, stacks2_shortreads, stacks2_sstacks, stacks2_tsv2bam, stacks2_ustacks Stacks is a software pipeline for building loci from short-read sequences, such as RAD-seq To update http://catchenlab.life.illinois.edu/stacks/ Sequence Analysis iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/stacks2 https://github.com/galaxyproject/tools-iuc/tree/main/tools/stacks2 2.55 stacks 2.65 (0/12) (12/12) (12/12) (12/12) @@ -471,6 +519,7 @@ structureharvester structureharvester for parsing STRUCTURE outputs and for pe swift swiftlink Parallel MCMC Linkage Analysis Up-to-date https://github.com/ajm/swiftlink Variant Analysis swiftlink iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/swiftlink/ https://github.com/galaxyproject/tools-iuc/tree/main/tools/swift 1.0 swiftlink 1.0 (0/1) (0/1) (0/1) (0/1) syndiva 30.0 2.0 syndiva SynDivA was developed to analyze the diversity of synthetic libraries of a Fibronectin domain. To update Proteomics syndiva iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/SynDivA https://github.com/galaxyproject/tools-iuc/tree/main/tools/syndiva 1.0 clustalo 1.2.4 (0/1) (0/1) (1/1) (0/1) table_compute 208652.0 741.0 table_compute Perform general-purpose table operations To update Text Manipulation table_compute iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/table_compute https://github.com/galaxyproject/tools-iuc/tree/main/tools/table_compute 1.2.4 pandas (1/1) (1/1) (1/1) (1/1) +tabular_to_fastq 7388.0 200.0 tabular_to_fastq Tabular to FASTQ converter Up-to-date https://github.com/galaxyproject/sequence_utils Fastq Manipulation tabular_to_fastq devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/galaxy_sequence_utils/tabular_to_fastq https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/galaxy_sequence_utils/tabular_to_fastq 1.1.5 galaxy_sequence_utils 1.1.5 (1/1) (1/1) (1/1) (1/1) tag_pileup_frequency 164.0 7.0 tag_pileup_frequency Contains a tool that generates a frequency pileup of the 5' ends of aligned reads in a BAM filerelative to reference points in a BED file. To update https://github.com/seqcode/cegr-tools/tree/master/src/org/seqcode/cegrtools/tagpileup Statistics, SAM, Genomic Interval Operations tag_pileup_frequency iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/tag_pileup_frequency https://github.com/galaxyproject/tools-iuc/tree/main/tools/tag_pileup_frequency 1.0.2 openjdk (1/1) (0/1) (1/1) (0/1) tasmanian_mismatch tasmanian_mismatch Analysis of positional mismatches Up-to-date Sequence Analysis tasmanian_mismatch iuc https://github.com/nebiolabs/tasmanian-mismatch https://github.com/galaxyproject/tools-iuc/tree/main/tools/tasmanian_mismatch 1.0.7 tasmanian-mismatch 1.0.7 (0/1) (0/1) (0/1) (0/1) taxonomy_filter_refseq taxonomy_filter_refseq Filter RefSeq by taxonomy To update https://github.com/pvanheus/ncbitaxonomy Sequence Analysis, Genome annotation taxonomy_filter_refseq iuc https://github.com/galaxyproject/tools-iuc https://github.com/galaxyproject/tools-iuc/tree/main/tools/taxonomy_filter_refseq 0.3.0 rust-ncbitaxonomy 1.0.7 (0/1) (0/1) (0/1) (0/1) @@ -496,12 +545,9 @@ trinotate 1796.0 151.0 trinotate Trinotate is a comprehensive annotation suite d trycycler trycycler_cluster, trycycler_consensus, trycycler_partition, trycycler_reconcile_msa, trycycler_subsample Trycycler toolkit wrappers Up-to-date https://github.com/rrwick/Trycycler Assembly trycycler iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/trycycler https://github.com/galaxyproject/tools-iuc/tree/main/tools/trycycler 0.5.5 trycycler 0.5.5 (0/5) (5/5) (5/5) (5/5) tsebra 5.0 tsebra This tool has been developed to combine BRAKER predictions. tsebra tsebra TSEBRA TSEBRA is a combiner tool that selects transcripts from gene predictions based on the support by extrisic evidence in form of introns and start/stop codons. It was developed to combine BRAKER1 and BRAKER2 predicitons to increase their accuracies. Homology-based gene prediction, Alternative splicing prediction Gene expression, RNA-Seq, Gene transcripts, Model organisms To update https://github.com/Gaius-Augustus/TSEBRA Genome annotation iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/tsebra https://github.com/galaxyproject/tools-iuc/tree/main/tools/tsebra 1.1.2.4 tsebra 1.1.2.5 (0/1) (0/1) (1/1) (1/1) tsne 368.0 10.0 tsne T-Distributed Stochastic Neighbor Embedding using a Barnes-Hut Implementation To update https://cran.r-project.org/web/packages/Rtsne/ Text Manipulation tsne iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/tsne https://github.com/galaxyproject/tools-iuc/tree/main/tools/tsne 0.0.2 r-rtsne 0.13 (1/1) (0/1) (1/1) (1/1) +twobittofa ucsc-twobittofa twoBitToFa is a tool to convert all or part of .2bit file to FASTA UCSC_Genome_Browser_Utilities UCSC_Genome_Browser_Utilities UCSC Genome Browser Utilities Utilities for handling sequences and assemblies from the UCSC Genome Browser project. Sequence analysis To update https://genome.ucsc.edu/goldenpath/help/twoBit.html Convert Formats ucsc_twobittofa iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/ucsc-tools/twobittofa https://github.com/galaxyproject/tools-iuc/tree/main/tools/ucsc_tools/twobittofa 377 ucsc-twobittofa 455 (1/1) (1/1) (1/1) (0/1) tximport 1408.0 88.0 tximport Wrapper for the Bioconductor package tximport tximport tximport tximport An R/Bioconductor package that imports transcript-level abundance, estimated counts and transcript lengths, and summarizes into matrices for use with downstream gene-level analysis packages. Pathway or network analysis, Formatting, RNA-Seq analysis Transcriptomics, Gene transcripts, Workflows To update http://bioconductor.org/packages/tximport/ Transcriptomics tximport iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/tximport https://github.com/galaxyproject/tools-iuc/tree/main/tools/tximport 1.22.0 bioconductor-tximport 1.30.0 (1/1) (0/1) (1/1) (0/1) ucsc_blat ucsc_blat Standalone blat sequence search command line tool blat blat BLAT Fast, accurate spliced alignment of DNA sequences. Sequence alignment Sequence analysis To update http://genome.ucsc.edu/goldenPath/help/blatSpec.html Sequence Analysis ucsc_blat yating-l https://github.com/galaxyproject/tools-iuc/tree/main/tools/ucsc_blat 377 ucsc-blat 445 (0/1) (0/1) (0/1) (0/1) -fasplit fasplit faSplit is a tool to split a single FASTA file into several files UCSC_Genome_Browser_Utilities UCSC_Genome_Browser_Utilities UCSC Genome Browser Utilities Utilities for handling sequences and assemblies from the UCSC Genome Browser project. Sequence analysis Up-to-date http://hgdownload.cse.ucsc.edu/admin/exe/ Fasta Manipulation ucsc_fasplit iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/ucsc-tools/fasplit https://github.com/galaxyproject/tools-iuc/tree/main/tools/ucsc_tools/fasplit 377 ucsc-fasplit 377 (1/1) (1/1) (1/1) (1/1) -fatovcf fatovcf Convert a FASTA alignment file to Variant Call Format (VCF) single-nucleotide diffs UCSC_Genome_Browser_Utilities UCSC_Genome_Browser_Utilities UCSC Genome Browser Utilities Utilities for handling sequences and assemblies from the UCSC Genome Browser project. Sequence analysis Up-to-date http://hgdownload.cse.ucsc.edu/admin/exe/ Convert Formats ucsc_fatovcf iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/ucsc-tools/fatovcf https://github.com/galaxyproject/tools-iuc/tree/main/tools/ucsc_tools/fatovcf 448 ucsc-fatovcf 448 (1/1) (1/1) (1/1) (0/1) -twobittofa ucsc-twobittofa twoBitToFa is a tool to convert all or part of .2bit file to FASTA UCSC_Genome_Browser_Utilities UCSC_Genome_Browser_Utilities UCSC Genome Browser Utilities Utilities for handling sequences and assemblies from the UCSC Genome Browser project. Sequence analysis To update https://genome.ucsc.edu/goldenpath/help/twoBit.html Convert Formats ucsc_twobittofa iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/ucsc-tools/twobittofa https://github.com/galaxyproject/tools-iuc/tree/main/tools/ucsc_tools/twobittofa 377 ucsc-twobittofa 455 (1/1) (1/1) (1/1) (0/1) -wigtobigwig ucsc_wigtobigwig converts bedGraph (wig) files into binary bigwig UCSC_Genome_Browser_Utilities UCSC_Genome_Browser_Utilities UCSC Genome Browser Utilities Utilities for handling sequences and assemblies from the UCSC Genome Browser project. Sequence analysis Up-to-date https://genome.ucsc.edu/goldenPath/help/bigWig.html Convert Formats ucsc_wigtobigwig iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/wigtobigwig https://github.com/galaxyproject/tools-iuc/tree/main/tools/ucsc_tools/wigtobigwig 447 ucsc-wigtobigwig 447 (1/1) (1/1) (1/1) (0/1) umi_tools umi_tools_count, umi_tools_dedup, umi_tools_extract, umi_tools_group, umi_tools_whitelist UMI-tools extract - Extract UMIs from fastq umi-tools umi-tools UMI-tools Tools for handling Unique Molecular Identifiers in NGS data sets. Sequencing quality control NGS, Sequence sites, features and motifs, Quality affairs To update https://github.com/CGATOxford/UMI-tools Sequence Analysis, Transcriptomics iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/umi_tools https://github.com/galaxyproject/tools-iuc/tree/main/tools/umi_tools 1.1.2 umi_tools 1.1.5 (5/5) (5/5) (5/5) (5/5) unicycler 65732.0 1558.0 unicycler Unicycler is a hybrid assembly pipeline for bacterial genomes. unicycler unicycler Unicycler A tool for assembling bacterial genomes from a combination of short (2nd generation) and long (3rd generation) sequencing reads. Genome assembly, Aggregation Microbiology, Genomics, Sequencing, Sequence assembly Up-to-date https://github.com/rrwick/Unicycler Assembly unicycler iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/unicycler https://github.com/galaxyproject/tools-iuc/tree/main/tools/unicycler 0.5.0 unicycler 0.5.0 (1/1) (1/1) (1/1) (1/1) usher 1060.0 5.0 usher_matutils, usher UShER toolkit wrappers usher usher usher The UShER toolkit includes a set of tools for for rapid, accurate placement of samples to existing phylogenies. While not restricted to SARS-CoV-2 phylogenetic analyses, it has enabled real-time phylogenetic analyses and genomic contact tracing in that its placement is orders of magnitude faster and more memory-efficient than previous methods. Classification, Phylogenetic tree visualisation, Phylogenetic inference (from molecular sequences) Phylogeny, Evolutionary biology, Cladistics, Genotype and phenotype, Phylogenomics To update https://github.com/yatisht/usher Phylogenetics usher iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/usher https://github.com/galaxyproject/tools-iuc/tree/main/tools/usher 0.2.1 usher 0.6.3 (0/2) (0/2) (2/2) (0/2) @@ -512,76 +558,10 @@ variant_analyzer 88.0 3.0 mut2read, mut2sscs, read2mut Collection of tools for a varscan 208.0 16.0 varscan_copynumber, varscan_mpileup, varscan_somatic VarScan is a variant caller for high-throughput sequencing data To update https://dkoboldt.github.io/varscan/ Variant Analysis varscan iuc https://github.com/galaxyproject/iuc/tree/master/tools/varscan https://github.com/galaxyproject/tools-iuc/tree/main/tools/varscan 2.4.3 varscan 2.4.6 (3/3) (3/3) (3/3) (3/3) varvamp varvamp Variable VirusAMPlicons (varVAMP) is a tool to design primers for highly diverse viruses varvamp varvamp varVAMP variable VirusAMPlicons (varVAMP) is a tool to design primers for highly diverse viruses. The input is an alignment of your viral (full-genome) sequences. PCR primer design Virology Up-to-date https://github.com/jonas-fuchs/varVAMP/ Sequence Analysis varvamp iuc https://github.com/jonas-fuchs/varVAMP https://github.com/galaxyproject/tools-iuc/tree/main/tools/varvamp 1.2.0 varvamp 1.2.0 (0/1) (0/1) (1/1) (0/1) vcf2maf 751.0 29.0 vcf2maf vcf2maf: Convert VCF into MAF To update Convert Formats vcf2maf iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/vcf2maf https://github.com/galaxyproject/tools-iuc/tree/main/tools/vcf2maf 1.6.21 vcf2maf 1.6.22 (0/1) (1/1) (1/1) (0/1) -vcfanno 872.0 87.0 vcfanno Annotate VCF files vcfanno vcfanno vcfanno Fast, flexible annotation of genetic variants. SNP annotation Genetic variation, Data submission, annotation and curation Up-to-date https://github.com/brentp/vcfanno Variant Analysis vcfanno iuc https://github.com/galaxyproject/tools-iuc/vcfanno/ https://github.com/galaxyproject/tools-iuc/tree/main/tools/vcfanno 0.3.5 vcfanno 0.3.5 (0/1) (0/1) (1/1) (0/1) -vegan vegan_diversity, vegan_fisher_alpha, vegan_rarefaction an R package fo community ecologist vegan vegan vegan Ordination methods, diversity analysis and other functions for community and vegetation ecologists Standardisation and normalisation, Analysis Ecology, Phylogenetics, Environmental science To update https://cran.r-project.org/package=vegan Metagenomics iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/vegan/ https://github.com/galaxyproject/tools-iuc/tree/main/tools/vegan 2.4-3 r-vegan 2.3_4 (3/3) (0/3) (3/3) (0/3) -velocyto velocyto_cli Velocyto is a library for the analysis of RNA velocity. Up-to-date http://velocyto.org/ Transcriptomics velocyto iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/velocyto https://github.com/galaxyproject/tools-iuc/tree/main/tools/velocyto 0.17.17 velocyto.py 0.17.17 (1/1) (0/1) (1/1) (0/1) -velvet 12218.0 1280.0 velvetg, velveth de novo genomic assembler specially designed for short read sequencing technologies velvet velvet Velvet A de novo genomic assembler specially designed for short read sequencing technologies, such as Solexa or 454 or SOLiD. Formatting, De-novo assembly Sequence assembly To update https://www.ebi.ac.uk/~zerbino/velvet/ Assembly velvet devteam https://github.com/galaxyproject/tools-iuc/tree/master/tools/velvet https://github.com/galaxyproject/tools-iuc/tree/main/tools/velvet velvet 1.2.10 (2/2) (2/2) (2/2) (2/2) -velvet_optimiser velvetoptimiser Automatically optimize Velvet assemblies velvetoptimiser velvetoptimiser VelvetOptimiser This tool is designed to run as a wrapper script for the Velvet assembler (Daniel Zerbino, EBI UK) and to assist with optimising the assembly. Optimisation and refinement, Sequence assembly Genomics, Sequence assembly To update Assembly velvetoptimiser simon-gladman https://github.com/galaxyproject/tools-iuc/tree/master/tools/velvetoptimiser https://github.com/galaxyproject/tools-iuc/tree/main/tools/velvet_optimiser 2.2.6+galaxy2 velvet 1.2.10 (1/1) (1/1) (1/1) (0/1) -verkko 22.0 9.0 verkko Telomere-to-telomere assembly pipeline To update https://github.com/marbl/verkko Assembly verkko iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/verkko https://github.com/galaxyproject/tools-iuc/tree/main/tools/verkko 1.3.1 verkko 2.1 (0/1) (0/1) (1/1) (0/1) -vg vg_convert, vg_deconstruct, vg_view Variation graph data structures, interchange formats, alignment, genotyping, and variant calling methods To update https://github.com/vgteam/vg Sequence Analysis, Variant Analysis iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/vg https://github.com/galaxyproject/tools-iuc/tree/main/tools/vg 1.23.0 vg 1.56.0 (0/3) (0/3) (3/3) (3/3) -virAnnot virannot_blast2tsv, virannot_otu, virAnnot_rps2tsv virAnnot wrappers virannot virannot virAnnot "VirAnnot was build to ease the assembly, blast search, taxonomic annotation and OTUs assignation of viral metagenomic HTS data. It is used in Virologie team of UMR1332 BFP laboratory at INRAE. VirAnnot also takes part of the Euphresco project ""Plant Health Bioinformatics Network"". See more.It is designed to identify viruses in plant metagenomic data but it can be used to assemble and annotate any sequences with the NCBI taxonomy." Sequence annotation, Sequence clustering, Sequence cluster visualisation Metagenomics, Virology, Microbial ecology To update https://github.com/marieBvr/virAnnot Metagenomics virannot iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/virAnnot https://github.com/galaxyproject/tools-iuc/tree/main/tools/virAnnot 1.0.0+galaxy0 biopython 1.70 (0/3) (0/3) (3/3) (3/3) -virheat virheat generates a heatmap of allele frequencies from vcf files virheat virheat Up-to-date https://github.com/jonas-fuchs/virHEAT Visualization, Variant Analysis virheat iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/virheat https://github.com/galaxyproject/tools-iuc/tree/main/tools/virheat 0.7 virheat 0.7 (0/1) (0/1) (0/1) (0/1) -virhunter 234.0 40.0 virhunter Deep Learning method for novel virus detection in sequencing data virhunter virhunter VirHunter VirHunter is a deep learning method that uses Convolutional Neural Networks (CNNs) and a Random Forest Classifier to identify viruses in sequencing datasets. More precisely, VirHunter classifies previously assembled contigs as viral, host, and bacterial (contamination). Sequence classification Virology To update https://github.com/cbib/virhunter Machine Learning virhunter iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/VirHunter https://github.com/galaxyproject/tools-iuc/tree/main/tools/virhunter 1.0.0 numpy (0/1) (0/1) (1/1) (0/1) -volcanoplot 30946.0 1749.0 volcanoplot Tool to create a Volcano Plot To update https://ggplot2.tidyverse.org/ Visualization, Transcriptomics, Statistics volcanoplot iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/volcanoplot https://github.com/galaxyproject/tools-iuc/tree/main/tools/volcanoplot 0.0.6 r-ggplot2 2.2.1 (1/1) (1/1) (1/1) (1/1) -vsearch 8507.0 182.0 vsearch_alignment, vsearch_chimera_detection, vsearch_clustering, vsearch_dereplication, vsearch_masking, vsearch_search, vsearch_shuffling, vsearch_sorting VSEARCH including searching, clustering, chimera detection, dereplication, sorting, masking and shuffling of sequences. vsearch vsearch VSEARCH High-throughput search and clustering sequence analysis tool. It supports de novo and reference based chimera detection, clustering, full-length and prefix dereplication, reverse complementation, masking, all-vs-all pairwise global alignment, exact and global alignment searching, shuffling, subsampling and sorting. It also supports FASTQ file analysis, filtering and conversion. DNA mapping, Chimera detection Metagenomics, Sequence analysis To update https://github.com/torognes/vsearch Sequence Analysis vsearch iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/vsearch https://github.com/galaxyproject/tools-iuc/tree/main/tools/vsearch 2.8.3 vsearch 2.28.1 (8/8) (8/8) (8/8) (8/8) -vsnp vsnp_add_zero_coverage, vsnp_build_tables, vsnp_determine_ref_from_data, vsnp_get_snps, vsnp_statistics The vSNP tools are critical components of several workflows that validate SNPs and produce annotatedSNP tables and corresponding phylogenetic trees. To update https://github.com/USDA-VS/vSNP Sequence Analysis vsnp iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/vsnp https://github.com/galaxyproject/tools-iuc/tree/main/tools/vsnp 3.0.6 pysam 0.22.1 (0/5) (0/5) (0/5) (0/5) -weather_app simple_weather provides simple weather in text format To update http://wttr.in/ Visualization, Web Services simpleweather iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/weather_app https://github.com/galaxyproject/tools-iuc/tree/main/tools/weather_app 0.1.2 curl (0/1) (0/1) (0/1) (0/1) -weblogo3 2370.0 74.0 rgweblogo3 Sequence Logo generator for fasta weblogo weblogo WebLogo Web-based application designed to make generate sequence logos. Sequence cluster visualisation, Sequence visualisation, Sequence motif recognition Nucleic acid sites, features and motifs, Sequence analysis To update Graphics weblogo3 devteam https://github.com/galaxyproject/tools-iuc/tree/master/tools/weblogo3 https://github.com/galaxyproject/tools-iuc/tree/main/tools/weblogo3 3.5.0 weblogo 3.7.9 (1/1) (1/1) (1/1) (1/1) -windowmasker 85.0 windowmasker_mkcounts, windowmasker_ustat Identify repetitive regions using WindowMasker To update https://www.ncbi.nlm.nih.gov/IEB/ToolBox/CPP_DOC/lxr/source/src/app/winmasker/ Sequence Analysis windowmasker iuc https://github.com/galaxyproject/tools-iuc/tree/main/tools/windowmasker/ https://github.com/galaxyproject/tools-iuc/tree/main/tools/windowmasker 1.0 blast 2.15.0 (0/2) (2/2) (2/2) (0/2) -winnowmap 248.0 27.0 winnowmap A long-read mapping tool optimized for mapping ONT and PacBio reads to repetitive reference sequences. Up-to-date https://github.com/marbl/Winnowmap Next Gen Mappers winnowmap iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/winnowmap https://github.com/galaxyproject/tools-iuc/tree/main/tools/winnowmap 2.03 winnowmap 2.03 (0/1) (0/1) (1/1) (0/1) -xpath 234.0 3.0 xpath XPath XML querying tool To update http://search.cpan.org/dist/XML-XPath/ Text Manipulation xpath iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/xpath https://github.com/galaxyproject/tools-iuc/tree/main/tools/xpath perl-xml-xpath 1.47 (0/1) (0/1) (1/1) (0/1) -yahs 344.0 64.0 yahs Yet Another Hi-C scaffolding tool Up-to-date https://github.com/c-zhou/yahs Assembly yahs iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/yahs https://github.com/galaxyproject/tools-iuc/tree/main/tools/yahs 1.2a.2 yahs 1.2a.2 (1/1) (1/1) (1/1) (0/1) -zerone 90.0 2.0 zerone ChIP-seq discretization and quality control Up-to-date https://github.com/nanakiksc/zerone ChIP-seq zerone iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/zerone https://github.com/galaxyproject/tools-iuc/tree/main/tools/zerone 1.0 zerone 1.0 (0/1) (0/1) (1/1) (0/1) -bamtools 14039.0 208.0 bamtools Operate on and transform BAM datasets in various ways using bamtools bamtools bamtools BamTools BamTools provides a fast, flexible C++ API & toolkit for reading, writing, and managing BAM files. Data handling, Sequence alignment analysis Sequencing, Data management, Sequence analysis Up-to-date https://github.com/pezmaster31/bamtools Sequence Analysis, SAM bamtools devteam https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/bamtools/bamtools https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/bamtools/bamtools 2.5.2 bamtools 2.5.2 (1/1) (0/1) (1/1) (1/1) -bamtools_filter 114845.0 1195.0 bamFilter Filter BAM datasets on various attributes using bamtools filter bamtools bamtools BamTools BamTools provides a fast, flexible C++ API & toolkit for reading, writing, and managing BAM files. Data handling, Sequence alignment analysis Sequencing, Data management, Sequence analysis Up-to-date https://github.com/pezmaster31/bamtools Sequence Analysis, SAM bamtools_filter devteam https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/bamtools/bamtools_filter https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/bamtools/bamtools_filter 2.5.2 bamtools 2.5.2 (1/1) (1/1) (1/1) (1/1) -bamtools_split 1434.0 47.0 bamtools_split_mapped, bamtools_split_paired, bamtools_split_ref, bamtools_split_tag Utility for filtering BAM files. It is based on the BAMtools suiteof tools by Derek Barnett. bamtools bamtools BamTools BamTools provides a fast, flexible C++ API & toolkit for reading, writing, and managing BAM files. Data handling, Sequence alignment analysis Sequencing, Data management, Sequence analysis Up-to-date https://github.com/pezmaster31/bamtools Sequence Analysis, SAM iuc https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/bamtools/bamtools_split https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/bamtools/bamtools_split 2.5.2 bamtools 2.5.2 (4/4) (2/4) (4/4) (0/4) -biotradis bacteria_tradis, tradis_essentiality, tradis_gene_insert_sites Bio-Tradis is a tool suite dedicated to essentiality analyses with TraDis data. biotradis biotradis biotradis The Bio::TraDIS pipeline provides software utilities for the processing, mapping, and analysis of transposon insertion sequencing data. The pipeline was designed with the data from the TraDIS sequencing protocol in mind, but should work with a variety of transposon insertion sequencing protocols as long as they produce data in the expected format. Sequence analysis Mobile genetic elements, Workflows Up-to-date https://www.sanger.ac.uk/science/tools/bio-tradis Genome annotation biotradis iuc https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/biotradis https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/biotradis 1.4.5 biotradis 1.4.5 (3/3) (0/3) (0/3) (0/3) -cuffcompare 1130.0 65.0 cuffcompare Galaxy wrappers for the Cuffcompare tool. Up-to-date http://cole-trapnell-lab.github.io/cufflinks/ Transcriptomics cuffcompare devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/cufflinks/cuffcompare https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/cufflinks/cuffcompare 2.2.1 cufflinks 2.2.1 (1/1) (1/1) (1/1) (1/1) -cuffdiff 5831.0 228.0 cuffdiff Galaxy wrappers for the Cuffdiff tool. Up-to-date http://cole-trapnell-lab.github.io/cufflinks/ Transcriptomics cuffdiff devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/cufflinks/cuffdiff https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/cufflinks/cuffdiff 2.2.1 cufflinks 2.2.1 (1/1) (0/1) (1/1) (0/1) -cufflinks 32218.0 319.0 cufflinks Galaxy wrappers for the Cufflinks tool. Up-to-date http://cole-trapnell-lab.github.io/cufflinks/ Transcriptomics cufflinks devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/cufflinks/cufflinks https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/cufflinks/cufflinks 2.2.1 cufflinks 2.2.1 (1/1) (1/1) (1/1) (1/1) -cuffmerge 3292.0 122.0 cuffmerge Galaxy wrappers for the Cuffmerge tool. Up-to-date http://cole-trapnell-lab.github.io/cufflinks/ Transcriptomics cuffmerge devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/cufflinks/cuffmerge https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/cufflinks/cuffmerge 2.2.1 cufflinks 2.2.1 (1/1) (1/1) (1/1) (1/1) -cuffnorm 660.0 27.0 cuffnorm The Cuffnorm tool Up-to-date http://cole-trapnell-lab.github.io/cufflinks/ Transcriptomics cuffnorm devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/cufflinks/cuffnorm https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/cufflinks/cuffnorm 2.2.1 cufflinks 2.2.1 (1/1) (1/1) (1/1) (0/1) -cuffquant 688.0 18.0 cuffquant The Cuffquant tool Up-to-date http://cole-trapnell-lab.github.io/cufflinks/ Transcriptomics cuffquant devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/cufflinks/cuffquant https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/cufflinks/cuffquant 2.2.1 cufflinks 2.2.1 (1/1) (1/1) (1/1) (0/1) -fasta_clipping_histogram cshl_fasta_clipping_histogram Length Distribution chart Up-to-date http://hannonlab.cshl.edu/fastx_toolkit/ Fasta Manipulation, Graphics, Statistics fasta_clipping_histogram devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/fastx_toolkit/fasta_clipping_histogram https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/fastx_toolkit/fasta_clipping_histogram 0.0.14 fastx_toolkit 0.0.14 (0/1) (1/1) (0/1) (0/1) -fasta_formatter 2912.0 68.0 cshl_fasta_formatter FASTA Width formatter Up-to-date http://hannonlab.cshl.edu/fastx_toolkit/ Fasta Manipulation fasta_formatter devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/fastx_toolkit/fasta_formatter https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/fastx_toolkit/fasta_formatter 0.0.14 fastx_toolkit 0.0.14 (1/1) (1/1) (1/1) (1/1) -fasta_nucleotide_changer 774.0 29.0 cshl_fasta_nucleotides_changer RNA/DNA converter. Up-to-date http://hannonlab.cshl.edu/fastx_toolkit/ Fasta Manipulation fasta_nucleotide_changer devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/fastx_toolkit/fasta_nucleotide_changer https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/fastx_toolkit/fasta_nucleotide_changer 0.0.14 fastx_toolkit 0.0.14 (1/1) (1/1) (1/1) (1/1) -fastq_quality_boxplot 1175.0 51.0 cshl_fastq_quality_boxplot Draw quality score boxplot Up-to-date http://hannonlab.cshl.edu/fastx_toolkit/ Fastq Manipulation, Graphics, Statistics fastq_quality_boxplot devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/fastx_toolkit/fastq_quality_boxplot https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/fastx_toolkit/fastq_quality_boxplot 0.0.14 fastx_toolkit 0.0.14 (1/1) (1/1) (1/1) (1/1) -fastq_quality_converter 220.0 11.0 cshl_fastq_quality_converter Quality format converter (ASCII-Numeric) Up-to-date http://hannonlab.cshl.edu/fastx_toolkit/ Fastq Manipulation fastq_quality_converter devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/fastx_toolkit/fastq_quality_converter https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/fastx_toolkit/fastq_quality_converter 0.0.14 fastx_toolkit 0.0.14 (1/1) (1/1) (1/1) (1/1) -fastq_quality_filter 15153.0 1509.0 cshl_fastq_quality_filter Filter by quality Up-to-date http://hannonlab.cshl.edu/fastx_toolkit/ Fastq Manipulation fastq_quality_filter devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/fastx_toolkit/fastq_quality_filter https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/fastx_toolkit/fastq_quality_filter 0.0.14 fastx_toolkit 0.0.14 (1/1) (1/1) (1/1) (1/1) -fastq_to_fasta 13599.0 419.0 cshl_fastq_to_fasta FASTQ to FASTA converter Up-to-date http://hannonlab.cshl.edu/fastx_toolkit/ Fasta Manipulation, Convert Formats fastq_to_fasta devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/fastx_toolkit/fastq_to_fasta https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/fastx_toolkit/fastq_to_fasta 0.0.14 fastx_toolkit 0.0.14 (1/1) (1/1) (1/1) (1/1) -fastx_artifacts_filter 1809.0 27.0 cshl_fastx_artifacts_filter Remove sequencing artifacts Up-to-date http://hannonlab.cshl.edu/fastx_toolkit/ Fasta Manipulation, Fastq Manipulation fastx_artifacts_filter devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/fastx_toolkit/fastx_artifacts_filter https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/fastx_toolkit/fastx_artifacts_filter 0.0.14 fastx_toolkit 0.0.14 (1/1) (1/1) (1/1) (1/1) -fastx_barcode_splitter 16589.0 128.0 cshl_fastx_barcode_splitter Barcode Splitter Up-to-date http://hannonlab.cshl.edu/fastx_toolkit/ Fasta Manipulation, Fastq Manipulation fastx_barcode_splitter devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/fastx_toolkit/fastx_barcode_splitter https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/fastx_toolkit/fastx_barcode_splitter 0.0.14 fastx_toolkit 0.0.14 (1/1) (1/1) (1/1) (1/1) -fastx_clipper 3321.0 96.0 cshl_fastx_clipper Clip adapter sequences Up-to-date http://hannonlab.cshl.edu/fastx_toolkit/ Fasta Manipulation, Fastq Manipulation fastx_clipper devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/fastx_toolkit/fastx_clipper https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/fastx_toolkit/fastx_clipper 0.0.14 fastx_toolkit 0.0.14 (1/1) (1/1) (1/1) (1/1) -fastx_collapser 61218.0 114.0 cshl_fastx_collapser Collapse sequences Up-to-date http://hannonlab.cshl.edu/fastx_toolkit/ Fasta Manipulation fastx_collapser devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/fastx_toolkit/fastx_collapser https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/fastx_toolkit/fastx_collapser 0.0.14 fastx_toolkit 0.0.14 (1/1) (1/1) (1/1) (1/1) -fastx_nucleotides_distribution 249.0 25.0 cshl_fastx_nucleotides_distribution Draw nucleotides distribution chart Up-to-date http://hannonlab.cshl.edu/fastx_toolkit/ Fastq Manipulation, Graphics fastx_nucleotides_distribution devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/fastx_toolkit/fastx_nucleotides_distribution https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/fastx_toolkit/fastx_nucleotides_distribution 0.0.14 fastx_toolkit 0.0.14 (1/1) (1/1) (1/1) (1/1) -fastx_quality_statistics 2162.0 63.0 cshl_fastx_quality_statistics Compute quality statistics Up-to-date http://hannonlab.cshl.edu/fastx_toolkit/ Fastq Manipulation, Statistics fastx_quality_statistics devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/fastx_toolkit/fastx_quality_statistics https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/fastx_toolkit/fastx_quality_statistics 0.0.14 fastx_toolkit 0.0.14 (1/1) (1/1) (1/1) (1/1) -fastx_renamer 2280.0 68.0 cshl_fastx_renamer Rename sequences Up-to-date http://hannonlab.cshl.edu/fastx_toolkit/ Fasta Manipulation, Fastq Manipulation fastx_renamer devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/fastx_toolkit/fastx_renamer https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/fastx_toolkit/fastx_renamer 0.0.14 fastx_toolkit 0.0.14 (1/1) (1/1) (1/1) (1/1) -fastx_reverse_complement 10831.0 156.0 cshl_fastx_reverse_complement Reverse-Complement Up-to-date http://hannonlab.cshl.edu/fastx_toolkit/ Fastq Manipulation, Fasta Manipulation fastx_reverse_complement devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/fastx_toolkit/fastx_reverse_complement https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/fastx_toolkit/fastx_reverse_complement 0.0.14 fastx_toolkit 0.0.14 (1/1) (1/1) (1/1) (1/1) -fastx_trimmer 13148.0 205.0 cshl_fastx_trimmer Trim sequences Up-to-date http://hannonlab.cshl.edu/fastx_toolkit/ Fasta Manipulation, Fastq Manipulation fastx_trimmer devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/fastx_toolkit/fastx_trimmer https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/fastx_toolkit/fastx_trimmer 0.0.14 fastx_toolkit 0.0.14 (1/1) (1/1) (1/1) (1/1) -fastq_combiner 8676.0 66.0 fastq_combiner Combine FASTA and QUAL into FASTQ Up-to-date https://github.com/galaxyproject/sequence_utils Fastq Manipulation, Fasta Manipulation fastq_combiner devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/galaxy_sequence_utils/fastq_combiner https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/galaxy_sequence_utils/fastq_combiner 1.1.5 galaxy_sequence_utils 1.1.5 (1/1) (1/1) (1/1) (1/1) -fastq_filter 14222.0 266.0 fastq_filter Filter FASTQ reads by quality score and length Up-to-date https://github.com/galaxyproject/sequence_utils Fastq Manipulation fastq_filter devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/galaxy_sequence_utils/fastq_filter https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/galaxy_sequence_utils/fastq_filter 1.1.5 galaxy_sequence_utils 1.1.5 (1/1) (1/1) (1/1) (1/1) -fastq_groomer 94802.0 1028.0 fastq_groomer Convert between various FASTQ quality formats. Up-to-date https://github.com/galaxyproject/sequence_utils Fastq Manipulation fastq_groomer devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/galaxy_sequence_utils/fastq_groomer https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/galaxy_sequence_utils/fastq_groomer 1.1.5 galaxy_sequence_utils 1.1.5 (1/1) (1/1) (1/1) (1/1) -fastq_manipulation 2503.0 69.0 fastq_manipulation Manipulate FASTQ reads on various attributes. Up-to-date https://github.com/galaxyproject/sequence_utils Fastq Manipulation fastq_manipulation devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/galaxy_sequence_utils/fastq_manipulation https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/galaxy_sequence_utils/fastq_manipulation 1.1.5 galaxy_sequence_utils 1.1.5 (1/1) (1/1) (1/1) (1/1) -fastq_masker_by_quality 170.0 16.0 fastq_masker_by_quality FASTQ Masker by quality score Up-to-date https://github.com/galaxyproject/sequence_utils Fastq Manipulation fastq_masker_by_quality devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/galaxy_sequence_utils/fastq_masker_by_quality https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/galaxy_sequence_utils/fastq_masker_by_quality 1.1.5 galaxy_sequence_utils 1.1.5 (1/1) (1/1) (1/1) (1/1) -fastq_paired_end_deinterlacer 8410.0 122.0 fastq_paired_end_deinterlacer FASTQ de-interlacer on paired end reads. Up-to-date https://github.com/galaxyproject/sequence_utils Fastq Manipulation fastq_paired_end_deinterlacer devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/galaxy_sequence_utils/fastq_paired_end_deinterlacer https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/galaxy_sequence_utils/fastq_paired_end_deinterlacer 1.1.5 galaxy_sequence_utils 1.1.5 (1/1) (1/1) (1/1) (1/1) -fastq_paired_end_interlacer 17024.0 1087.0 fastq_paired_end_interlacer FASTQ interlacer on paired end reads Up-to-date https://github.com/galaxyproject/sequence_utils Fastq Manipulation fastq_paired_end_interlacer devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/galaxy_sequence_utils/fastq_paired_end_interlacer https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/galaxy_sequence_utils/fastq_paired_end_interlacer 1.1.5 galaxy_sequence_utils 1.1.5 (1/1) (1/1) (1/1) (1/1) -fastq_paired_end_joiner 16635.0 245.0 fastq_paired_end_joiner FASTQ joiner on paired end reads Up-to-date https://github.com/galaxyproject/sequence_utils Fastq Manipulation fastq_paired_end_joiner devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/galaxy_sequence_utils/fastq_paired_end_joiner https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/galaxy_sequence_utils/fastq_paired_end_joiner 1.1.5 galaxy_sequence_utils 1.1.5 (1/1) (1/1) (1/1) (1/1) -fastq_paired_end_splitter 3092.0 196.0 fastq_paired_end_splitter FASTQ splitter on joined paired end reads Up-to-date https://github.com/galaxyproject/sequence_utils Fastq Manipulation fastq_paired_end_splitter devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/galaxy_sequence_utils/fastq_paired_end_splitter https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/galaxy_sequence_utils/fastq_paired_end_splitter 1.1.5 galaxy_sequence_utils 1.1.5 (1/1) (1/1) (1/1) (1/1) -fastq_stats 4246.0 221.0 fastq_stats FASTQ Summary Statistics by column Up-to-date https://github.com/galaxyproject/sequence_utils Fastq Manipulation fastq_stats devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/galaxy_sequence_utils/fastq_stats https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/galaxy_sequence_utils/fastq_stats 1.1.5 galaxy_sequence_utils 1.1.5 (1/1) (1/1) (1/1) (1/1) -fastq_to_tabular 12593.0 93.0 fastq_to_tabular FASTQ to Tabular converter Up-to-date https://github.com/galaxyproject/sequence_utils Fastq Manipulation fastq_to_tabular devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/galaxy_sequence_utils/fastq_to_tabular https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/galaxy_sequence_utils/fastq_to_tabular 1.1.5 galaxy_sequence_utils 1.1.5 (1/1) (1/1) (1/1) (1/1) -fastq_trimmer 9757.0 210.0 fastq_trimmer FASTQ Trimmer by quality Up-to-date https://github.com/galaxyproject/sequence_utils Fastq Manipulation fastq_trimmer devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/galaxy_sequence_utils/fastq_trimmer https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/galaxy_sequence_utils/fastq_trimmer 1.1.5 galaxy_sequence_utils 1.1.5 (1/1) (1/1) (1/1) (1/1) -fastqtofasta 178172.0 1371.0 fastq_to_fasta_python FASTQ to FASTA converter Up-to-date https://github.com/galaxyproject/sequence_utils Fastq Manipulation fastqtofasta devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/galaxy_sequence_utils/fastqtofasta https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/galaxy_sequence_utils/fastqtofasta 1.1.5 galaxy_sequence_utils 1.1.5 (1/1) (1/1) (1/1) (0/1) -tabular_to_fastq 7388.0 200.0 tabular_to_fastq Tabular to FASTQ converter Up-to-date https://github.com/galaxyproject/sequence_utils Fastq Manipulation tabular_to_fastq devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/galaxy_sequence_utils/tabular_to_fastq https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/galaxy_sequence_utils/tabular_to_fastq 1.1.5 galaxy_sequence_utils 1.1.5 (1/1) (1/1) (1/1) (1/1) -kraken 13938.0 404.0 kraken-filter, kraken-mpa-report, kraken-report, kraken-translate, kraken Kraken is a system for assigning taxonomic labels to short DNAsequences, usually obtained through metagenomic studies. Previous attempts by otherbioinformatics software to accomplish this task have often used sequence alignmentor machine learning techniques that were quite slow, leading to the developmentof less sensitive but much faster abundance estimation programs. Kraken aims toachieve high sensitivity and high speed by utilizing exact alignments of k-mersand a novel classification algorithm. kraken kraken Kraken System for assigning taxonomic labels to short DNA sequences, usually obtained through metagenomic studies. Previous attempts by other bioinformatics software to accomplish this task have often used sequence alignment or machine learning techniques that were quite slow, leading to the development of less sensitive but much faster abundance estimation programs. It aims to achieve high sensitivity and high speed by utilizing exact alignments of k-mers and a novel classification algorithm. Taxonomic classification Taxonomy, Metagenomics To update http://ccb.jhu.edu/software/kraken/ Metagenomics kraken devteam https://github.com/galaxyproject/tools-iuc/blob/master/tool_collections/kraken/ https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/kraken kraken 1.1.1 (5/5) (5/5) (5/5) (5/5) -kraken2 185308.0 2367.0 kraken2 Kraken2 for taxonomic designation. kraken2 kraken2 kraken2 Kraken 2 is the newest version of Kraken, a taxonomic classification system using exact k-mer matches to achieve high accuracy and fast classification speeds. This classifier matches each k-mer within a query sequence to the lowest common ancestor (LCA) of all genomes containing the given k-mer. The k-mer assignments inform the classification algorithm. Taxonomic classification Taxonomy, Metagenomics To update http://ccb.jhu.edu/software/kraken/ Metagenomics kraken2 iuc https://github.com/galaxyproject/tools-iuc/blob/master/tool_collections/kraken2/kraken2/ https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/kraken2/kraken2 2.1.1 kraken2 2.1.3 (1/1) (1/1) (1/1) (1/1) -samtools To update https://github.com/samtools/samtools SAM iuc https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/samtools https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/samtools 1.15.1 samtools 1.20 (0/1) (0/1) (0/1) (0/1) -snpeff 101254.0 2843.0 snpEff, snpEff_build_gb, snpEff_databases, snpEff_download, snpEff_get_chr_names SnpEff is a genetic variant annotation and effect prediction toolbox To update http://snpeff.sourceforge.net/ Genome-Wide Association Study, Variant Analysis snpeff iuc https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/snpeff https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/snpeff biopython 1.70 (5/5) (5/5) (5/5) (5/5) -snpsift 5109063.0 1185.0 snpSift_annotate, snpSift_caseControl, snpSift_extractFields, snpSift_filter, snpSift_int, snpSift_rmInfo, snpsift_vartype, snpSift_vcfCheck snpEff SnpSift tools from Pablo Cingolani To update http://snpeff.sourceforge.net/SnpSift.html Variant Analysis snpsift iuc https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/snpsift/snpsift https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/snpsift/snpsift snpsift 5.2 (8/8) (8/8) (8/8) (8/8) -snpsift_dbnsfp 46.0 11.0 snpSift_dbnsfp snpEff SnpSift dbnsfp tool from Pablo Cingolani To update http://snpeff.sourceforge.net/SnpSift.html#dbNSFP Variant Analysis snpsift_dbnsfp iuc https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/snpsift/snpsift_dbnsfp https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/snpsift/snpsift_dbnsfp snpsift 5.2 (1/1) (0/1) (1/1) (0/1) -snpsift_genesets 390.0 11.0 snpSift_geneSets Annotate SnpEff vcf with genesets such as Gene Ontology (GO), KEGG, Reactome To update http://snpeff.sourceforge.net/SnpSift.html#geneSets Variant Analysis snpsift_genesets iuc https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/snpsift/snpsift_genesets/ https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/snpsift/snpsift_genesets snpsift 5.2 (1/1) (0/1) (1/1) (0/1) vcf2tsv 167913.0 352.0 vcf2tsv Converts VCF files into tab-delimited format To update https://github.com/ekg/vcflib Variant Analysis, Convert Formats vcf2tsv devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/vcflib/vcf2tsv https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/vcflib/vcf2tsv vcflib 1.0.9 (1/1) (1/1) (1/1) (1/1) vcfaddinfo 357.0 8.0 vcfaddinfo Adds info fields from the second dataset which are not present in the first dataset. To update https://github.com/ekg/vcflib Variant Analysis vcfaddinfo devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/vcflib/vcfaddinfo https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/vcflib/vcfaddinfo vcflib 1.0.9 (1/1) (1/1) (1/1) (1/1) vcfallelicprimitives 15803.0 286.0 vcfallelicprimitives Splits alleleic primitives (gaps or mismatches) into multiple VCF lines To update https://github.com/ekg/vcflib Variant Analysis vcfallelicprimitives devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/vcflib/vcfallelicprimitives https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/vcflib/vcfallelicprimitives vcflib 1.0.9 (1/1) (1/1) (1/1) (1/1) +vcfanno 872.0 87.0 vcfanno Annotate VCF files vcfanno vcfanno vcfanno Fast, flexible annotation of genetic variants. SNP annotation Genetic variation, Data submission, annotation and curation Up-to-date https://github.com/brentp/vcfanno Variant Analysis vcfanno iuc https://github.com/galaxyproject/tools-iuc/vcfanno/ https://github.com/galaxyproject/tools-iuc/tree/main/tools/vcfanno 0.3.5 vcfanno 0.3.5 (0/1) (0/1) (1/1) (0/1) vcfannotate 2181.0 77.0 vcfannotate Intersect VCF records with BED annotations To update https://github.com/ekg/vcflib Variant Analysis vcfannotate devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/vcflib/vcfannotate https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/vcflib/vcfannotate vcflib 1.0.9 (1/1) (1/1) (1/1) (1/1) vcfannotategenotypes 192.0 28.0 vcfannotategenotypes Annotate genotypes in a VCF dataset using genotypes from another VCF dataset. To update https://github.com/ekg/vcflib Variant Analysis vcfannotategenotypes devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/vcflib/vcfannotategenotypes https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/vcflib/vcfannotategenotypes vcflib 1.0.9 (1/1) (1/1) (1/1) (1/1) vcfbedintersect 3217.0 80.0 vcfbedintersect Intersect VCF and BED datasets To update https://github.com/ekg/vcflib Variant Analysis vcfbedintersect devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/vcflib/vcfbedintersect https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/vcflib/vcfbedintersect vcflib 1.0.9 (1/1) (1/1) (1/1) (1/1) @@ -596,33 +576,29 @@ vcfflatten 177.0 6.0 vcfflatten2 Removes multi-allelic sites by picking the most vcfgeno2haplo 718.0 36.0 vcfgeno2haplo Convert genotype-based phased alleles into haplotype alleles To update https://github.com/ekg/vcflib Variant Analysis vcfgeno2haplo devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/vcflib/vcfgeno2haplo https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/vcflib/vcfgeno2haplo vcflib 1.0.9 (1/1) (1/1) (1/1) (1/1) vcfgenotypes 451.0 48.0 vcfgenotypes Convert numerical representation of genotypes to allelic. To update https://github.com/ekg/vcflib Variant Analysis vcfgenotypes devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/vcflib/vcfgenotypes https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/vcflib/vcfgenotypes vcflib 1.0.9 (1/1) (1/1) (1/1) (1/1) vcfhethom 1370.0 90.0 vcfhethom Count the number of heterozygotes and alleles, compute het/hom ratio. To update https://github.com/ekg/vcflib Variant Analysis vcfhethom devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/vcflib/vcfhethom https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/vcflib/vcfhethom vcflib 1.0.9 (1/1) (1/1) (1/1) (1/1) -vcfleftalign 279.0 10.0 vcfleftalign Left-align indels and complex variants in VCF dataset To update https://github.com/ekg/vcflib Variant Analysis vcfleftalign devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/vcflib/vcfleftalign https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/vcflib/vcfleftalign vcflib (1/1) (1/1) (1/1) (1/1) +vcfleftalign 279.0 10.0 vcfleftalign Left-align indels and complex variants in VCF dataset To update https://github.com/ekg/vcflib Variant Analysis vcfleftalign devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/vcflib/vcfleftalign https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/vcflib/vcfleftalign vcflib 1.0.9 (1/1) (1/1) (1/1) (1/1) vcfprimers 708.0 12.0 vcfprimers Extract flanking sequences for each VCF record To update https://github.com/ekg/vcflib Variant Analysis vcfprimers devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/vcflib/vcfprimers https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/vcflib/vcfprimers vcflib 1.0.9 (1/1) (1/1) (1/1) (1/1) vcfrandomsample 159.0 5.0 vcfrandomsample Randomly sample sites from VCF dataset To update https://github.com/ekg/vcflib Variant Analysis vcfrandomsample devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/vcflib/vcfrandomsample https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/vcflib/vcfrandomsample vcflib 1.0.9 (1/1) (1/1) (1/1) (1/1) vcfselectsamples 854.0 29.0 vcfselectsamples Select samples from a VCF file To update https://github.com/ekg/vcflib Variant Analysis vcfselectsamples devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/vcflib/vcfselectsamples https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/vcflib/vcfselectsamples vcflib 1.0.9 (1/1) (1/1) (1/1) (1/1) vcfsort 1852.0 63.0 vcfsort Sort VCF dataset by coordinate To update https://github.com/ekg/vcflib Variant Analysis vcfsort devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/vcflib/vcfsort https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/vcflib/vcfsort vcflib 1.0.9 (1/1) (1/1) (1/1) (1/1) vcfvcfintersect 972774.0 265.0 vcfvcfintersect Intersect two VCF datasets To update https://github.com/ekg/vcflib Variant Analysis vcfvcfintersect devteam https://github.com/galaxyproject/tools-iuc/tree/master/tool_collections/vcflib/vcfvcfintersect https://github.com/galaxyproject/tools-iuc/tree/main/tool_collections/vcflib/vcfvcfintersect vcflib 1.0.9 (1/1) (1/1) (1/1) (1/1) -suite_qiime2__alignment qiime2__alignment__mafft, qiime2__alignment__mafft_add, qiime2__alignment__mask To update https://github.com/qiime2/q2-alignment Metagenomics, Sequence Analysis, Statistics q2d2 https://github.com/qiime2/galaxy-tools/tree/main/tools/suite_qiime2__alignment https://github.com/qiime2/galaxy-tools/tree/main/tools/suite_qiime2__alignment 2024.2.0+q2galaxy.2024.2.1 (3/3) (3/3) (3/3) (3/3) -suite_qiime2__composition qiime2__composition__add_pseudocount, qiime2__composition__ancom, qiime2__composition__ancombc, qiime2__composition__da_barplot, qiime2__composition__tabulate To update https://github.com/qiime2/q2-composition Metagenomics, Sequence Analysis, Statistics q2d2 https://github.com/qiime2/galaxy-tools/tree/main/tools/suite_qiime2__composition https://github.com/qiime2/galaxy-tools/tree/main/tools/suite_qiime2__composition 2024.2.0+q2galaxy.2024.2.1 (4/5) (4/5) (4/5) (2/5) -suite_qiime2__cutadapt qiime2__cutadapt__demux_paired, qiime2__cutadapt__demux_single, qiime2__cutadapt__trim_paired, qiime2__cutadapt__trim_single To update https://github.com/qiime2/q2-cutadapt Metagenomics, Sequence Analysis, Statistics q2d2 https://github.com/qiime2/galaxy-tools/tree/main/tools/suite_qiime2__cutadapt https://github.com/qiime2/galaxy-tools/tree/main/tools/suite_qiime2__cutadapt 2024.2.0+q2galaxy.2024.2.1 (4/4) (4/4) (4/4) (4/4) -suite_qiime2__dada2 qiime2__dada2__denoise_ccs, qiime2__dada2__denoise_paired, qiime2__dada2__denoise_pyro, qiime2__dada2__denoise_single To update http://benjjneb.github.io/dada2/ Metagenomics, Sequence Analysis, Statistics q2d2 https://github.com/qiime2/galaxy-tools/tree/main/tools/suite_qiime2__dada2 https://github.com/qiime2/galaxy-tools/tree/main/tools/suite_qiime2__dada2 2024.2.0+q2galaxy.2024.2.1 (4/4) (4/4) (4/4) (4/4) -suite_qiime2__deblur qiime2__deblur__denoise_16S, qiime2__deblur__denoise_other, qiime2__deblur__visualize_stats To update https://github.com/biocore/deblur Metagenomics, Sequence Analysis, Statistics q2d2 https://github.com/qiime2/galaxy-tools/tree/main/tools/suite_qiime2__deblur https://github.com/qiime2/galaxy-tools/tree/main/tools/suite_qiime2__deblur 2024.2.0+q2galaxy.2024.2.1 (3/3) (3/3) (3/3) (3/3) -suite_qiime2__demux qiime2__demux__emp_paired, qiime2__demux__emp_single, qiime2__demux__filter_samples, qiime2__demux__partition_samples_paired, qiime2__demux__partition_samples_single, qiime2__demux__subsample_paired, qiime2__demux__subsample_single, qiime2__demux__summarize, qiime2__demux__tabulate_read_counts To update https://github.com/qiime2/q2-demux Metagenomics, Sequence Analysis, Statistics q2d2 https://github.com/qiime2/galaxy-tools/tree/main/tools/suite_qiime2__demux https://github.com/qiime2/galaxy-tools/tree/main/tools/suite_qiime2__demux 2024.2.0+q2galaxy.2024.2.1 (6/9) (6/9) (6/9) (6/9) -suite_qiime2__diversity qiime2__diversity__adonis, qiime2__diversity__alpha, qiime2__diversity__alpha_correlation, qiime2__diversity__alpha_group_significance, qiime2__diversity__alpha_phylogenetic, qiime2__diversity__alpha_rarefaction, qiime2__diversity__beta, qiime2__diversity__beta_correlation, qiime2__diversity__beta_group_significance, qiime2__diversity__beta_phylogenetic, qiime2__diversity__beta_rarefaction, qiime2__diversity__bioenv, qiime2__diversity__core_metrics, qiime2__diversity__core_metrics_phylogenetic, qiime2__diversity__filter_distance_matrix, qiime2__diversity__mantel, qiime2__diversity__partial_procrustes, qiime2__diversity__pcoa, qiime2__diversity__pcoa_biplot, qiime2__diversity__procrustes_analysis, qiime2__diversity__tsne, qiime2__diversity__umap To update https://github.com/qiime2/q2-diversity Metagenomics, Sequence Analysis, Statistics q2d2 https://github.com/qiime2/galaxy-tools/tree/main/tools/suite_qiime2__diversity https://github.com/qiime2/galaxy-tools/tree/main/tools/suite_qiime2__diversity 2024.2.0+q2galaxy.2024.2.1 (21/22) (21/22) (21/22) (21/22) -suite_qiime2__diversity_lib qiime2__diversity_lib__alpha_passthrough, qiime2__diversity_lib__beta_passthrough, qiime2__diversity_lib__beta_phylogenetic_meta_passthrough, qiime2__diversity_lib__beta_phylogenetic_passthrough, qiime2__diversity_lib__bray_curtis, qiime2__diversity_lib__faith_pd, qiime2__diversity_lib__jaccard, qiime2__diversity_lib__observed_features, qiime2__diversity_lib__pielou_evenness, qiime2__diversity_lib__shannon_entropy, qiime2__diversity_lib__unweighted_unifrac, qiime2__diversity_lib__weighted_unifrac To update https://github.com/qiime2/q2-diversity-lib Metagenomics, Sequence Analysis, Statistics q2d2 https://github.com/qiime2/galaxy-tools/tree/main/tools/suite_qiime2__diversity_lib https://github.com/qiime2/galaxy-tools/tree/main/tools/suite_qiime2__diversity_lib 2024.2.0+q2galaxy.2024.2.1 (12/12) (12/12) (12/12) (12/12) -suite_qiime2__emperor qiime2__emperor__biplot, qiime2__emperor__plot, qiime2__emperor__procrustes_plot To update http://emperor.microbio.me Metagenomics, Sequence Analysis, Statistics q2d2 https://github.com/qiime2/galaxy-tools/tree/main/tools/suite_qiime2__emperor https://github.com/qiime2/galaxy-tools/tree/main/tools/suite_qiime2__emperor 2024.2.0+q2galaxy.2024.2.1 (3/3) (3/3) (3/3) (3/3) -suite_qiime2__feature_classifier qiime2__feature_classifier__blast, qiime2__feature_classifier__classify_consensus_blast, qiime2__feature_classifier__classify_consensus_vsearch, qiime2__feature_classifier__classify_hybrid_vsearch_sklearn, qiime2__feature_classifier__classify_sklearn, qiime2__feature_classifier__extract_reads, qiime2__feature_classifier__find_consensus_annotation, qiime2__feature_classifier__fit_classifier_naive_bayes, qiime2__feature_classifier__fit_classifier_sklearn, qiime2__feature_classifier__makeblastdb, qiime2__feature_classifier__vsearch_global To update https://github.com/qiime2/q2-feature-classifier Metagenomics, Sequence Analysis, Statistics q2d2 https://github.com/qiime2/galaxy-tools/tree/main/tools/suite_qiime2__feature_classifier https://github.com/qiime2/galaxy-tools/tree/main/tools/suite_qiime2__feature_classifier 2024.2.0+q2galaxy.2024.2.1 (10/11) (10/11) (10/11) (10/11) -suite_qiime2__feature_table qiime2__feature_table__core_features, qiime2__feature_table__filter_features, qiime2__feature_table__filter_features_conditionally, qiime2__feature_table__filter_samples, qiime2__feature_table__filter_seqs, qiime2__feature_table__group, qiime2__feature_table__heatmap, qiime2__feature_table__merge, qiime2__feature_table__merge_seqs, qiime2__feature_table__merge_taxa, qiime2__feature_table__presence_absence, qiime2__feature_table__rarefy, qiime2__feature_table__relative_frequency, qiime2__feature_table__rename_ids, qiime2__feature_table__split, qiime2__feature_table__subsample_ids, qiime2__feature_table__summarize, qiime2__feature_table__summarize_plus, qiime2__feature_table__tabulate_feature_frequencies, qiime2__feature_table__tabulate_sample_frequencies, qiime2__feature_table__tabulate_seqs, qiime2__feature_table__transpose To update https://github.com/qiime2/q2-feature-table Metagenomics, Sequence Analysis, Statistics q2d2 https://github.com/qiime2/galaxy-tools/tree/main/tools/suite_qiime2__feature_table https://github.com/qiime2/galaxy-tools/tree/main/tools/suite_qiime2__feature_table 2024.2.2+q2galaxy.2024.2.1 (17/22) (17/22) (17/22) (17/22) -suite_qiime2__fragment_insertion qiime2__fragment_insertion__classify_otus_experimental, qiime2__fragment_insertion__filter_features, qiime2__fragment_insertion__sepp To update https://github.com/qiime2/q2-fragment-insertion Metagenomics, Sequence Analysis, Statistics q2d2 https://github.com/qiime2/galaxy-tools/tree/main/tools/suite_qiime2__fragment_insertion https://github.com/qiime2/galaxy-tools/tree/main/tools/suite_qiime2__fragment_insertion 2024.2.0+q2galaxy.2024.2.1 (3/3) (3/3) (3/3) (3/3) -suite_qiime2__longitudinal qiime2__longitudinal__anova, qiime2__longitudinal__feature_volatility, qiime2__longitudinal__first_differences, qiime2__longitudinal__first_distances, qiime2__longitudinal__linear_mixed_effects, qiime2__longitudinal__maturity_index, qiime2__longitudinal__nmit, qiime2__longitudinal__pairwise_differences, qiime2__longitudinal__pairwise_distances, qiime2__longitudinal__plot_feature_volatility, qiime2__longitudinal__volatility To update https://github.com/qiime2/q2-longitudinal Metagenomics, Sequence Analysis, Statistics q2d2 https://github.com/qiime2/galaxy-tools/tree/main/tools/suite_qiime2__longitudinal https://github.com/qiime2/galaxy-tools/tree/main/tools/suite_qiime2__longitudinal 2024.2.0+q2galaxy.2024.2.1 (11/11) (11/11) (11/11) (11/11) -suite_qiime2__metadata qiime2__metadata__distance_matrix, qiime2__metadata__merge, qiime2__metadata__shuffle_groups, qiime2__metadata__tabulate To update https://github.com/qiime2/q2-metadata Metagenomics, Sequence Analysis, Statistics q2d2 https://github.com/qiime2/galaxy-tools/tree/main/tools/suite_qiime2__metadata https://github.com/qiime2/galaxy-tools/tree/main/tools/suite_qiime2__metadata 2024.2.0+q2galaxy.2024.2.1 (3/4) (3/4) (3/4) (3/4) -suite_qiime2__phylogeny qiime2__phylogeny__align_to_tree_mafft_fasttree, qiime2__phylogeny__align_to_tree_mafft_iqtree, qiime2__phylogeny__align_to_tree_mafft_raxml, qiime2__phylogeny__fasttree, qiime2__phylogeny__filter_table, qiime2__phylogeny__filter_tree, qiime2__phylogeny__iqtree, qiime2__phylogeny__iqtree_ultrafast_bootstrap, qiime2__phylogeny__midpoint_root, qiime2__phylogeny__raxml, qiime2__phylogeny__raxml_rapid_bootstrap, qiime2__phylogeny__robinson_foulds To update https://github.com/qiime2/q2-phylogeny Metagenomics, Sequence Analysis, Statistics q2d2 https://github.com/qiime2/galaxy-tools/tree/main/tools/suite_qiime2__phylogeny https://github.com/qiime2/galaxy-tools/tree/main/tools/suite_qiime2__phylogeny 2024.2.0+q2galaxy.2024.2.1 (12/12) (12/12) (12/12) (12/12) -suite_qiime2__quality_control qiime2__quality_control__bowtie2_build, qiime2__quality_control__decontam_identify, qiime2__quality_control__decontam_identify_batches, qiime2__quality_control__decontam_remove, qiime2__quality_control__decontam_score_viz, qiime2__quality_control__evaluate_composition, qiime2__quality_control__evaluate_seqs, qiime2__quality_control__evaluate_taxonomy, qiime2__quality_control__exclude_seqs, qiime2__quality_control__filter_reads To update https://github.com/qiime2/q2-quality-control Metagenomics, Sequence Analysis, Statistics q2d2 https://github.com/qiime2/galaxy-tools/tree/main/tools/suite_qiime2__quality_control https://github.com/qiime2/galaxy-tools/tree/main/tools/suite_qiime2__quality_control 2024.2.0+q2galaxy.2024.2.1 (6/10) (6/10) (6/10) (6/10) -suite_qiime2__quality_filter qiime2__quality_filter__q_score To update https://github.com/qiime2/q2-quality-filter Metagenomics, Sequence Analysis, Statistics q2d2 https://github.com/qiime2/galaxy-tools/tree/main/tools/suite_qiime2__quality_filter https://github.com/qiime2/galaxy-tools/tree/main/tools/suite_qiime2__quality_filter 2024.2.0+q2galaxy.2024.2.1 (1/1) (1/1) (1/1) (1/1) -suite_qiime2__rescript qiime2__rescript__cull_seqs, qiime2__rescript__degap_seqs, qiime2__rescript__dereplicate, qiime2__rescript__edit_taxonomy, qiime2__rescript__evaluate_classifications, qiime2__rescript__evaluate_cross_validate, qiime2__rescript__evaluate_fit_classifier, qiime2__rescript__evaluate_seqs, qiime2__rescript__evaluate_taxonomy, qiime2__rescript__extract_seq_segments, qiime2__rescript__filter_seqs_length, qiime2__rescript__filter_seqs_length_by_taxon, qiime2__rescript__filter_taxa, qiime2__rescript__get_gtdb_data, qiime2__rescript__get_ncbi_data, qiime2__rescript__get_ncbi_data_protein, qiime2__rescript__get_ncbi_genomes, qiime2__rescript__get_silva_data, qiime2__rescript__get_unite_data, qiime2__rescript__merge_taxa, qiime2__rescript__orient_seqs, qiime2__rescript__parse_silva_taxonomy, qiime2__rescript__reverse_transcribe, qiime2__rescript__subsample_fasta, qiime2__rescript__trim_alignment To update https://github.com/nbokulich/RESCRIPt Metagenomics, Sequence Analysis, Statistics q2d2 https://github.com/qiime2/galaxy-tools/tree/main/tools/suite_qiime2__rescript https://github.com/qiime2/galaxy-tools/tree/main/tools/suite_qiime2__rescript 2024.2.2+q2galaxy.2024.2.1 (0/25) (0/25) (0/25) (0/25) -suite_qiime2__sample_classifier qiime2__sample_classifier__classify_samples, qiime2__sample_classifier__classify_samples_from_dist, qiime2__sample_classifier__classify_samples_ncv, qiime2__sample_classifier__confusion_matrix, qiime2__sample_classifier__fit_classifier, qiime2__sample_classifier__fit_regressor, qiime2__sample_classifier__heatmap, qiime2__sample_classifier__metatable, qiime2__sample_classifier__predict_classification, qiime2__sample_classifier__predict_regression, qiime2__sample_classifier__regress_samples, qiime2__sample_classifier__regress_samples_ncv, qiime2__sample_classifier__scatterplot, qiime2__sample_classifier__split_table, qiime2__sample_classifier__summarize To update https://github.com/qiime2/q2-sample-classifier Metagenomics, Sequence Analysis, Statistics q2d2 https://github.com/qiime2/galaxy-tools/tree/main/tools/suite_qiime2__sample_classifier https://github.com/qiime2/galaxy-tools/tree/main/tools/suite_qiime2__sample_classifier 2024.2.0+q2galaxy.2024.2.1 (15/15) (15/15) (15/15) (15/15) -suite_qiime2__taxa qiime2__taxa__barplot, qiime2__taxa__collapse, qiime2__taxa__filter_seqs, qiime2__taxa__filter_table To update https://github.com/qiime2/q2-taxa Metagenomics, Sequence Analysis, Statistics q2d2 https://github.com/qiime2/galaxy-tools/tree/main/tools/suite_qiime2__taxa https://github.com/qiime2/galaxy-tools/tree/main/tools/suite_qiime2__taxa 2024.2.0+q2galaxy.2024.2.1 (4/4) (4/4) (4/4) (4/4) -suite_qiime2__vsearch qiime2__vsearch__cluster_features_closed_reference, qiime2__vsearch__cluster_features_de_novo, qiime2__vsearch__cluster_features_open_reference, qiime2__vsearch__dereplicate_sequences, qiime2__vsearch__fastq_stats, qiime2__vsearch__merge_pairs, qiime2__vsearch__uchime_denovo, qiime2__vsearch__uchime_ref To update https://github.com/qiime2/q2-vsearch Metagenomics, Sequence Analysis, Statistics q2d2 https://github.com/qiime2/galaxy-tools/tree/main/tools/suite_qiime2__vsearch https://github.com/qiime2/galaxy-tools/tree/main/tools/suite_qiime2__vsearch 2024.2.0+q2galaxy.2024.2.1 (8/8) (8/8) (8/8) (7/8) -suite_qiime2_core__tools qiime2_core__tools__export, qiime2_core__tools__import, qiime2_core__tools__import_fastq To update https://qiime2.org Metagenomics, Sequence Analysis, Statistics q2d2 https://github.com/qiime2/galaxy-tools/tree/main/tools/suite_qiime2_core__tools https://github.com/qiime2/galaxy-tools/tree/main/tools/suite_qiime2_core__tools 2024.2.1+dist.he188c3c2 (2/3) (2/3) (2/3) (2/3) -suite_qiime2_core To update Statistics, Metagenomics, Sequence Analysis q2d2 https://github.com/qiime2/galaxy-tools/tree/main/tool_collections/suite_qiime2_core (0/1) (0/1) (0/1) (0/1) -frogs FROGS_affiliation_filters, FROGS_affiliation_postprocess, FROGS_affiliation_stats, FROGS_biom_to_stdBiom, FROGS_biom_to_tsv, FROGS_cluster_filters, FROGS_cluster_stats, FROGS_clustering, FROGS_demultiplex, FROGSSTAT_DESeq2_Preprocess, FROGSSTAT_DESeq2_Visualisation, FROGSFUNC_step2_functions, FROGSFUNC_step3_pathways, FROGSFUNC_step1_placeseqs, FROGS_itsx, FROGS_normalisation, FROGSSTAT_Phyloseq_Alpha_Diversity, FROGSSTAT_Phyloseq_Beta_Diversity, FROGSSTAT_Phyloseq_Sample_Clustering, FROGSSTAT_Phyloseq_Composition_Visualisation, FROGSSTAT_Phyloseq_Import_Data, FROGSSTAT_Phyloseq_Multivariate_Analysis_Of_Variance, FROGSSTAT_Phyloseq_Structure_Visualisation, FROGS_preprocess, FROGS_remove_chimera, FROGS_taxonomic_affiliation, FROGS_Tree, FROGS_tsv_to_biom Suite for metabarcoding analysis frogs frogs FROGS The user-friendly and Galaxy-supported pipeline FROGS analyses large sets of DNA amplicons sequences accurately and rapidly, essential for microbe community studies. Taxonomic classification Metagenomics, Microbial ecology, Taxonomy, Evolutionary biology, Sequencing Up-to-date http://frogs.toulouse.inrae.fr/ Metagenomics frogs frogs https://github.com/geraldinepascal/FROGS-wrappers/ https://github.com/geraldinepascal/FROGS-wrappers/tree/master/tools/frogs 4.1.0 frogs 4.1.0 (0/28) (0/28) (0/28) (28/28) +vegan vegan_diversity, vegan_fisher_alpha, vegan_rarefaction an R package fo community ecologist vegan vegan vegan Ordination methods, diversity analysis and other functions for community and vegetation ecologists Standardisation and normalisation, Analysis Ecology, Phylogenetics, Environmental science To update https://cran.r-project.org/package=vegan Metagenomics iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/vegan/ https://github.com/galaxyproject/tools-iuc/tree/main/tools/vegan 2.4-3 r-vegan 2.3_4 (3/3) (0/3) (3/3) (0/3) +velocyto velocyto_cli Velocyto is a library for the analysis of RNA velocity. Up-to-date http://velocyto.org/ Transcriptomics velocyto iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/velocyto https://github.com/galaxyproject/tools-iuc/tree/main/tools/velocyto 0.17.17 velocyto.py 0.17.17 (1/1) (0/1) (1/1) (0/1) +velvet 12218.0 1280.0 velvetg, velveth de novo genomic assembler specially designed for short read sequencing technologies velvet velvet Velvet A de novo genomic assembler specially designed for short read sequencing technologies, such as Solexa or 454 or SOLiD. Formatting, De-novo assembly Sequence assembly To update https://www.ebi.ac.uk/~zerbino/velvet/ Assembly velvet devteam https://github.com/galaxyproject/tools-iuc/tree/master/tools/velvet https://github.com/galaxyproject/tools-iuc/tree/main/tools/velvet velvet 1.2.10 (2/2) (2/2) (2/2) (2/2) +velvet_optimiser velvetoptimiser Automatically optimize Velvet assemblies velvetoptimiser velvetoptimiser VelvetOptimiser This tool is designed to run as a wrapper script for the Velvet assembler (Daniel Zerbino, EBI UK) and to assist with optimising the assembly. Optimisation and refinement, Sequence assembly Genomics, Sequence assembly To update Assembly velvetoptimiser simon-gladman https://github.com/galaxyproject/tools-iuc/tree/master/tools/velvetoptimiser https://github.com/galaxyproject/tools-iuc/tree/main/tools/velvet_optimiser 2.2.6+galaxy2 velvet 1.2.10 (1/1) (1/1) (1/1) (0/1) +verkko 22.0 9.0 verkko Telomere-to-telomere assembly pipeline To update https://github.com/marbl/verkko Assembly verkko iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/verkko https://github.com/galaxyproject/tools-iuc/tree/main/tools/verkko 1.3.1 verkko 2.1 (0/1) (0/1) (1/1) (0/1) +vg vg_convert, vg_deconstruct, vg_view Variation graph data structures, interchange formats, alignment, genotyping, and variant calling methods To update https://github.com/vgteam/vg Sequence Analysis, Variant Analysis iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/vg https://github.com/galaxyproject/tools-iuc/tree/main/tools/vg 1.23.0 vg 1.56.0 (0/3) (0/3) (3/3) (3/3) +virAnnot virannot_blast2tsv, virannot_otu, virAnnot_rps2tsv virAnnot wrappers virannot virannot virAnnot "VirAnnot was build to ease the assembly, blast search, taxonomic annotation and OTUs assignation of viral metagenomic HTS data. It is used in Virologie team of UMR1332 BFP laboratory at INRAE. VirAnnot also takes part of the Euphresco project ""Plant Health Bioinformatics Network"". See more.It is designed to identify viruses in plant metagenomic data but it can be used to assemble and annotate any sequences with the NCBI taxonomy." Sequence annotation, Sequence clustering, Sequence cluster visualisation Metagenomics, Virology, Microbial ecology To update https://github.com/marieBvr/virAnnot Metagenomics virannot iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/virAnnot https://github.com/galaxyproject/tools-iuc/tree/main/tools/virAnnot 1.0.0+galaxy0 biopython 1.70 (0/3) (0/3) (3/3) (3/3) +virheat virheat generates a heatmap of allele frequencies from vcf files virheat virheat Up-to-date https://github.com/jonas-fuchs/virHEAT Visualization, Variant Analysis virheat iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/virheat https://github.com/galaxyproject/tools-iuc/tree/main/tools/virheat 0.7 virheat 0.7 (0/1) (0/1) (0/1) (0/1) +virhunter 234.0 40.0 virhunter Deep Learning method for novel virus detection in sequencing data virhunter virhunter VirHunter VirHunter is a deep learning method that uses Convolutional Neural Networks (CNNs) and a Random Forest Classifier to identify viruses in sequencing datasets. More precisely, VirHunter classifies previously assembled contigs as viral, host, and bacterial (contamination). Sequence classification Virology To update https://github.com/cbib/virhunter Machine Learning virhunter iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/VirHunter https://github.com/galaxyproject/tools-iuc/tree/main/tools/virhunter 1.0.0 numpy (0/1) (0/1) (1/1) (0/1) +volcanoplot 30946.0 1749.0 volcanoplot Tool to create a Volcano Plot To update https://ggplot2.tidyverse.org/ Visualization, Transcriptomics, Statistics volcanoplot iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/volcanoplot https://github.com/galaxyproject/tools-iuc/tree/main/tools/volcanoplot 0.0.6 r-ggplot2 2.2.1 (1/1) (1/1) (1/1) (1/1) +vsearch 8507.0 182.0 vsearch_alignment, vsearch_chimera_detection, vsearch_clustering, vsearch_dereplication, vsearch_masking, vsearch_search, vsearch_shuffling, vsearch_sorting VSEARCH including searching, clustering, chimera detection, dereplication, sorting, masking and shuffling of sequences. vsearch vsearch VSEARCH High-throughput search and clustering sequence analysis tool. It supports de novo and reference based chimera detection, clustering, full-length and prefix dereplication, reverse complementation, masking, all-vs-all pairwise global alignment, exact and global alignment searching, shuffling, subsampling and sorting. It also supports FASTQ file analysis, filtering and conversion. DNA mapping, Chimera detection Metagenomics, Sequence analysis To update https://github.com/torognes/vsearch Sequence Analysis vsearch iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/vsearch https://github.com/galaxyproject/tools-iuc/tree/main/tools/vsearch 2.8.3 vsearch 2.28.1 (8/8) (8/8) (8/8) (8/8) +vsnp vsnp_add_zero_coverage, vsnp_build_tables, vsnp_determine_ref_from_data, vsnp_get_snps, vsnp_statistics The vSNP tools are critical components of several workflows that validate SNPs and produce annotatedSNP tables and corresponding phylogenetic trees. To update https://github.com/USDA-VS/vSNP Sequence Analysis vsnp iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/vsnp https://github.com/galaxyproject/tools-iuc/tree/main/tools/vsnp 3.0.6 pysam 0.22.1 (0/5) (0/5) (0/5) (0/5) +weather_app simple_weather provides simple weather in text format To update http://wttr.in/ Visualization, Web Services simpleweather iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/weather_app https://github.com/galaxyproject/tools-iuc/tree/main/tools/weather_app 0.1.2 curl (0/1) (0/1) (0/1) (0/1) +weblogo3 2370.0 74.0 rgweblogo3 Sequence Logo generator for fasta weblogo weblogo WebLogo Web-based application designed to make generate sequence logos. Sequence cluster visualisation, Sequence visualisation, Sequence motif recognition Nucleic acid sites, features and motifs, Sequence analysis To update Graphics weblogo3 devteam https://github.com/galaxyproject/tools-iuc/tree/master/tools/weblogo3 https://github.com/galaxyproject/tools-iuc/tree/main/tools/weblogo3 3.5.0 weblogo 3.7.9 (1/1) (1/1) (1/1) (1/1) +wigtobigwig ucsc_wigtobigwig converts bedGraph (wig) files into binary bigwig UCSC_Genome_Browser_Utilities UCSC_Genome_Browser_Utilities UCSC Genome Browser Utilities Utilities for handling sequences and assemblies from the UCSC Genome Browser project. Sequence analysis Up-to-date https://genome.ucsc.edu/goldenPath/help/bigWig.html Convert Formats ucsc_wigtobigwig iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/wigtobigwig https://github.com/galaxyproject/tools-iuc/tree/main/tools/ucsc_tools/wigtobigwig 447 ucsc-wigtobigwig 447 (1/1) (1/1) (1/1) (0/1) +windowmasker 85.0 windowmasker_mkcounts, windowmasker_ustat Identify repetitive regions using WindowMasker To update https://www.ncbi.nlm.nih.gov/IEB/ToolBox/CPP_DOC/lxr/source/src/app/winmasker/ Sequence Analysis windowmasker iuc https://github.com/galaxyproject/tools-iuc/tree/main/tools/windowmasker/ https://github.com/galaxyproject/tools-iuc/tree/main/tools/windowmasker 1.0 blast 2.15.0 (0/2) (2/2) (2/2) (0/2) +winnowmap 248.0 27.0 winnowmap A long-read mapping tool optimized for mapping ONT and PacBio reads to repetitive reference sequences. Up-to-date https://github.com/marbl/Winnowmap Next Gen Mappers winnowmap iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/winnowmap https://github.com/galaxyproject/tools-iuc/tree/main/tools/winnowmap 2.03 winnowmap 2.03 (0/1) (0/1) (1/1) (0/1) +xpath 234.0 3.0 xpath XPath XML querying tool To update http://search.cpan.org/dist/XML-XPath/ Text Manipulation xpath iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/xpath https://github.com/galaxyproject/tools-iuc/tree/main/tools/xpath perl-xml-xpath 1.47 (0/1) (0/1) (1/1) (0/1) +yahs 344.0 64.0 yahs Yet Another Hi-C scaffolding tool Up-to-date https://github.com/c-zhou/yahs Assembly yahs iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/yahs https://github.com/galaxyproject/tools-iuc/tree/main/tools/yahs 1.2a.2 yahs 1.2a.2 (1/1) (1/1) (1/1) (0/1) +zerone 90.0 2.0 zerone ChIP-seq discretization and quality control Up-to-date https://github.com/nanakiksc/zerone ChIP-seq zerone iuc https://github.com/galaxyproject/tools-iuc/tree/master/tools/zerone https://github.com/galaxyproject/tools-iuc/tree/main/tools/zerone 1.0 zerone 1.0 (0/1) (0/1) (1/1) (0/1)