From ad10f0c9f2735fd223e923c52da991c2c2ef54b8 Mon Sep 17 00:00:00 2001 From: =?UTF-8?q?B=C3=A9r=C3=A9nice=20Batut?= Date: Wed, 18 Dec 2024 13:12:34 +0100 Subject: [PATCH] Add microGalaxy lab (#263) MIME-Version: 1.0 Content-Type: text/plain; charset=UTF-8 Content-Transfer-Encoding: 8bit * Add 1st draft for the microgalaxy lab * tool list * tool list * add link * multiple tools * multiple tools * multiple tools * multiple tools * multiple tools * multiple tools * multiple tools * multiple tools * multiple tools * remote tools * test * test * test * bla * bla * All tools * changing to the new structure of excalidraw, content still need to be filled * changing base and usegalaxy servers yml files * correcting file name * solving linting errors * changing 2 links to microGalaxy * updating with microGalaxy logo * changing news and events source link * correcting links * removing github microGalaxy link * Apply suggestions from code review applying comments Co-authored-by: Bérénice Batut * updating links * adding help links to the lab in the community section as a third tab * changing from links to buttons * commenting the news and events section for now and commenting the bottom helping links since we have them aready in the community section * correcting the bottons shaps * updating bottons shapes * Delete communities/microgalaxy/resources/.~lock.curated_tools.tsv# * Update communities/microgalaxy/lab/base.yml Co-authored-by: Bérénice Batut --------- Co-authored-by: paulzierep Co-authored-by: EngyNasr --- communities/all/labs/microgalaxy | 1 + communities/microgalaxy/lab/CONTRIBUTORS | 4 + communities/microgalaxy/lab/README.md | 2 + communities/microgalaxy/lab/base.yml | 68 ++ .../1_data_import_and_preparation.yml | 110 ++ .../lab/sections/2_microbial_isolates.yml | 38 + .../microgalaxy/lab/sections/3_microbiome.yml | 38 + .../microgalaxy/lab/sections/4_tools.yml | 744 ++++++++++++++ .../microgalaxy/lab/sections/5_workflows.yml | 81 ++ .../lab/sections/6_support_and_help.yml | 51 + .../microgalaxy/lab/sections/7_community.yml | 74 ++ communities/microgalaxy/lab/static/custom.css | 0 .../lab/static/microgalaxy-logo.png | Bin 0 -> 21073 bytes .../microgalaxy/lab/templates/conclusion.html | 45 + .../microgalaxy/lab/templates/footer.html | 0 .../microgalaxy/lab/templates/intro.html | 45 + .../microgalaxy/lab/tool_panel/hca-scanpy.yml | 16 + .../lab/tool_panel/hca-scanpy.yml.lock | 47 + .../lab/tool_panel/hicexplorer.yml | 120 +++ .../lab/tool_panel/hicexplorer.yml.lock | 359 +++++++ .../microgalaxy/lab/tool_panel/import.yml | 8 + .../lab/tool_panel/import.yml.lock | 23 + .../microgalaxy/lab/tool_panel/multiomics.yml | 4 + .../lab/tool_panel/multiomics.yml.lock | 11 + .../microgalaxy/lab/tool_panel/sccaf.yml | 10 + .../microgalaxy/lab/tool_panel/sccaf.yml.lock | 29 + .../microgalaxy/lab/tool_panel/seurat.yml | 28 + .../lab/tool_panel/seurat.yml.lock | 83 ++ .../lab/tool_panel/single_cell.yml | 136 +++ .../lab/tool_panel/single_cell.yml.lock | 568 +++++++++++ .../microgalaxy/lab/tool_panel/spatial.yml | 14 + .../lab/tool_panel/spatial.yml.lock | 41 + .../lab/tool_panel/tool_panel_view.yml | 438 ++++++++ .../lab/tool_panel/usegalaxy.org.au.yml | 964 ++++++++++++++++++ communities/microgalaxy/lab/usegalaxy.eu.yml | 53 + .../lab/usegalaxy.eu/static/custom.css | 10 + .../lab/usegalaxy.eu/templates/footer.html | 70 ++ .../microgalaxy/lab/usegalaxy.org.au.yml | 41 + .../usegalaxy.org.au/templates/footer.html | 119 +++ communities/microgalaxy/lab/usegalaxy.org.yml | 33 + sources/bin/populate_labs.py | 70 ++ 41 files changed, 4596 insertions(+) create mode 120000 communities/all/labs/microgalaxy create mode 100644 communities/microgalaxy/lab/CONTRIBUTORS create mode 100644 communities/microgalaxy/lab/README.md create mode 100644 communities/microgalaxy/lab/base.yml create mode 100644 communities/microgalaxy/lab/sections/1_data_import_and_preparation.yml create mode 100644 communities/microgalaxy/lab/sections/2_microbial_isolates.yml create mode 100644 communities/microgalaxy/lab/sections/3_microbiome.yml create mode 100644 communities/microgalaxy/lab/sections/4_tools.yml create mode 100644 communities/microgalaxy/lab/sections/5_workflows.yml create mode 100644 communities/microgalaxy/lab/sections/6_support_and_help.yml create mode 100644 communities/microgalaxy/lab/sections/7_community.yml create mode 100644 communities/microgalaxy/lab/static/custom.css create mode 100644 communities/microgalaxy/lab/static/microgalaxy-logo.png create mode 100644 communities/microgalaxy/lab/templates/conclusion.html create mode 100644 communities/microgalaxy/lab/templates/footer.html create mode 100644 communities/microgalaxy/lab/templates/intro.html create mode 100644 communities/microgalaxy/lab/tool_panel/hca-scanpy.yml create mode 100644 communities/microgalaxy/lab/tool_panel/hca-scanpy.yml.lock create mode 100644 communities/microgalaxy/lab/tool_panel/hicexplorer.yml create mode 100644 communities/microgalaxy/lab/tool_panel/hicexplorer.yml.lock create mode 100644 communities/microgalaxy/lab/tool_panel/import.yml create mode 100644 communities/microgalaxy/lab/tool_panel/import.yml.lock create mode 100644 communities/microgalaxy/lab/tool_panel/multiomics.yml create mode 100644 communities/microgalaxy/lab/tool_panel/multiomics.yml.lock create mode 100644 communities/microgalaxy/lab/tool_panel/sccaf.yml create mode 100644 communities/microgalaxy/lab/tool_panel/sccaf.yml.lock create mode 100644 communities/microgalaxy/lab/tool_panel/seurat.yml create mode 100644 communities/microgalaxy/lab/tool_panel/seurat.yml.lock create mode 100644 communities/microgalaxy/lab/tool_panel/single_cell.yml create mode 100644 communities/microgalaxy/lab/tool_panel/single_cell.yml.lock create mode 100644 communities/microgalaxy/lab/tool_panel/spatial.yml create mode 100644 communities/microgalaxy/lab/tool_panel/spatial.yml.lock create mode 100644 communities/microgalaxy/lab/tool_panel/tool_panel_view.yml create mode 100644 communities/microgalaxy/lab/tool_panel/usegalaxy.org.au.yml create mode 100644 communities/microgalaxy/lab/usegalaxy.eu.yml create mode 100644 communities/microgalaxy/lab/usegalaxy.eu/static/custom.css create mode 100644 communities/microgalaxy/lab/usegalaxy.eu/templates/footer.html create mode 100644 communities/microgalaxy/lab/usegalaxy.org.au.yml create mode 100644 communities/microgalaxy/lab/usegalaxy.org.au/templates/footer.html create mode 100644 communities/microgalaxy/lab/usegalaxy.org.yml create mode 100644 sources/bin/populate_labs.py diff --git a/communities/all/labs/microgalaxy b/communities/all/labs/microgalaxy new file mode 120000 index 00000000..db96afd0 --- /dev/null +++ b/communities/all/labs/microgalaxy @@ -0,0 +1 @@ +../../microgalaxy/lab \ No newline at end of file diff --git a/communities/microgalaxy/lab/CONTRIBUTORS b/communities/microgalaxy/lab/CONTRIBUTORS new file mode 100644 index 00000000..f26526af --- /dev/null +++ b/communities/microgalaxy/lab/CONTRIBUTORS @@ -0,0 +1,4 @@ +# If GitHub username, name and avatar will be fetched and displayed +bebatut +zierep +EngyNasr \ No newline at end of file diff --git a/communities/microgalaxy/lab/README.md b/communities/microgalaxy/lab/README.md new file mode 100644 index 00000000..0105b125 --- /dev/null +++ b/communities/microgalaxy/lab/README.md @@ -0,0 +1,2 @@ +# microGalaxy subdomain/Lab + diff --git a/communities/microgalaxy/lab/base.yml b/communities/microgalaxy/lab/base.yml new file mode 100644 index 00000000..c6a15c65 --- /dev/null +++ b/communities/microgalaxy/lab/base.yml @@ -0,0 +1,68 @@ +# Request this as a webpage with: +# https://site.usegalaxy.org.au/lab/export?content_root=https://raw.githubusercontent.com/galaxyproject/galaxy_codex/tree/main/communities/microgalaxy/base.yml + +# ----------------------------------------------------------------------------- +# Use these variables in HTML templates like: +# "Welcome to the Galaxy {{ site_name }} {{ lab_name }}" +# To make the content more generic and reusable across sites + +# These will be rendered like "Welcome to the Galaxy {{ site_name }} {{ lab_name }}!" +site_name: European +lab_name: microGalaxy Lab +analysis_name: microGalaxy +nationality: European + +# Used for rendering tool/workflow links. Trailing '/' will be removed. +galaxy_base_url: https://microgalaxy.usegalaxy.eu +subdomain: microGalaxy +root_domain: usegalaxy.eu + +# This will enable a feedback form on the webpage: +# feedback_email: help@mygalaxy.org + +support_url: https://help.galaxyproject.org +quota_request_url: https://help.galaxyproject.org +data_policy_url: https://usegalaxy.org/static/terms.html +terms_url: https://usegalaxy.org/static/terms.html + +help_links: + - title: General Galaxy support + url: https://galaxyproject.org/support/ + - title: General Galaxy help forum + url: https://help.galaxyproject.org + - title: Galaxy Training Network Slack workspace + url: https://join.slack.com/t/gtnsmrgsbord/shared_invite/zt-2llyx6p8j-LmpEIsJu0t4MQkBctkN8qg + - title: microGalaxy user community chat room (Same channel but using Matrix/Element) + url: https://matrix.to/#/#galaxyproject_microGalaxy:gitter.im + - title: Galaxy Training Community chat + url: https://matrix.to/#/#Galaxy-Training-Network_Lobby:gitter.im + - title: Usegalaxy.org chat + url: https://matrix.to/#/#galaxyproject_Lobby:gitter.im + +intro_extra_md: "" +conclusion_extra_md: "" + +# ----------------------------------------------------------------------------- +# Custom content relative to this file URL + +header_logo: static/microgalaxy-logo.png +custom_css: static/custom.css +intro_md: templates/intro.html +conclusion_md: templates/conclusion.html +footer_md: templates/footer.html + + +# Data (Tools, Workflows etc.) to be rendered into sections/tabs/accordion elements. +# Either: +# 1. Relative to this file URL +# 2. Full URL to fetch globally centralized content +sections: + - sections/1_data_import_and_preparation.yml + - sections/2_microbial_isolates.yml + - sections/3_microbiome.yml + - sections/4_tools.yml + - sections/5_workflows.yml + - sections/6_support_and_help.yml + - sections/7_community.yml + +# ----------------------------------------------------------------------------- diff --git a/communities/microgalaxy/lab/sections/1_data_import_and_preparation.yml b/communities/microgalaxy/lab/sections/1_data_import_and_preparation.yml new file mode 100644 index 00000000..0c892cde --- /dev/null +++ b/communities/microgalaxy/lab/sections/1_data_import_and_preparation.yml @@ -0,0 +1,110 @@ +id: data +title: Data import and preparation +tabs: + - id: tools + title: Tools + heading_md: > + Common tools are listed here, or search for more in the full tool panel to the left. + content: + - title_md: Import data to Galaxy + description_md: > + Standard upload of data to Galaxy, from your computer or from the web. + button_link: "{{ galaxy_base_url }}/tool_runner?tool_id=upload1" + - title_md: FastQC - sequence quality reports + description_md: > +

+ Before using your sequencing data, it's important to ensure that + the data quality is sufficient for your analysis. +

+ inputs: + - datatypes: + - fastq + - bam + - sam + button_link: "{{ galaxy_base_url }}/tool_runner?tool_id=toolshed.g2.bx.psu.edu%2Frepos%2Fdevteam%2Ffastqc%2Ffastqc" + - title_md: FastP - sequence quality reports, trimming & filtering + description_md: > +

+ Faster run than FastQC, this tool can also trim reads and filter by quality. +

+ inputs: + - datatypes: + - fastq + button_link: "{{ galaxy_base_url }}/tool_runner?tool_id=toolshed.g2.bx.psu.edu%2Frepos%2Fiuc%2Ffastp%2Ffastp" + - title_md: NanoPlot - visualize Oxford Nanopore data + description_md: > +

+ A plotting suite for Oxford Nanopore sequencing data and alignments. +

+ inputs: + - datatypes: + - fastq + - fasta + - vcf_bgzip + button_link: "{{ galaxy_base_url }}/tool_runner?tool_id=toolshed.g2.bx.psu.edu%2Frepos%2Fiuc%2Fnanoplot%2Fnanoplot" + - title_md: GenomeScope - estimate genome size + description_md: > +

+ A set of metrics and graphs to visualize genome size and complexity prior to assembly. +

+ inputs: + - datatypes: + - tabular + label: Output from Meryl or Jellyfish histo + button_link: "{{ galaxy_base_url }}/tool_runner?tool_id=toolshed.g2.bx.psu.edu%2Frepos%2Fiuc%2Fgenomescope%2Fgenomescope" + - title_md: Meryl - count kmers + description_md: > +

+ Prepare kmer count histogram for input to GenomeScope. +

+ inputs: + - datatypes: + - fastq + - fasta + button_link: "{{ galaxy_base_url }}/tool_runner?tool_id=toolshed.g2.bx.psu.edu%2Frepos%2Fiuc%2Fmeryl%2Fmeryl" + + - id: workflows + title: Workflows + heading_md: > + A workflow is a series of Galaxy tools that have been linked together to perform a specific analysis. You can use and customize the example workflows below. + Learn more. + content: + - title_md: Data QC + description_md: > +

+ Report statistics from sequencing reads.

Tools: nanoplot fastqc multiqc +

+ button_link: "{{ galaxy_base_url }}/workflows/trs_import?trs_server=workflowhub.eu&run_form=true&trs_id=222" + view_link: https://workflowhub.eu/workflows/222 + view_tip: View in WorkflowHub + button_tip: Import to Galaxy AU + - title_md: Kmer counting to estimate genome size + description_md: > +

+ Estimates genome size and heterozygosity based on counts of kmers.

Tools: meryl genomescope +

+ button_link: "{{ galaxy_base_url }}/workflows/trs_import?trs_server=workflowhub.eu&run_form=true&trs_id=223" + view_link: https://workflowhub.eu/workflows/223 + view_tip: View in WorkflowHub + button_tip: Import to Galaxy AU + - title_md: Trim and filter reads + description_md: > +

+ Trims and filters raw sequence reads according to specified settings.

Tools: fastp +

+ button_link: "{{ galaxy_base_url }}/workflows/trs_import?trs_server=workflowhub.eu&run_form=true&trs_id=224" + view_link: https://workflowhub.eu/workflows/224 + view_tip: View in WorkflowHub + button_tip: Import to Galaxy AU + + - id: tutorials + title: Tutorials + heading_md: > + + content: [] + + - id: faq + title: FAQ + heading_md: > + + content: [] \ No newline at end of file diff --git a/communities/microgalaxy/lab/sections/2_microbial_isolates.yml b/communities/microgalaxy/lab/sections/2_microbial_isolates.yml new file mode 100644 index 00000000..f6cc84cd --- /dev/null +++ b/communities/microgalaxy/lab/sections/2_microbial_isolates.yml @@ -0,0 +1,38 @@ +id: isolates +title: Microbial isolates +tabs: + - id: workflows + title: Workflows + heading_md: > + + content: [] + + - id: tutorials + title: Tutorials + heading_md: > + + content: [] + + - id: pathways + title: Learning pathways + heading_md: > + Connected tutorials to train you to perform microbial data analysis fast!. + content: + - title_md: Introduction to Galaxy and Sequence analysis + description_md: > + New to Galaxy and/or the field of genomics? In this learing pathway, you will learn how to use Galaxy for analysis, and will be guided through the most common first steps of any genome analysis; quality control and a mapping or assembly of your genomic sequences. + button_link: + - title_md: Genome annotation for prokaryotes + description_md: > + + button_link: + - title_md: Detection of AMR genes in bacterial genomes + description_md: > + + button_link: + + - id: faq + title: FAQ + heading_md: > + + content: [] \ No newline at end of file diff --git a/communities/microgalaxy/lab/sections/3_microbiome.yml b/communities/microgalaxy/lab/sections/3_microbiome.yml new file mode 100644 index 00000000..5e339542 --- /dev/null +++ b/communities/microgalaxy/lab/sections/3_microbiome.yml @@ -0,0 +1,38 @@ +id: microbiome +title: Microbiome +tabs: + - id: workflows + title: Workflows + heading_md: > + + content: [] + + - id: tutorials + title: Tutorials + heading_md: > + + content: [] + + - id: pathways + title: Learning pathways + heading_md: > + Connected tutorials to train you to perform microbial data analysis fast!. + content: + - title_md: Introduction to Galaxy and Sequence analysis + description_md: > + New to Galaxy and/or the field of genomics? In this learing pathway, you will learn how to use Galaxy for analysis, and will be guided through the most common first steps of any genome analysis; quality control and a mapping or assembly of your genomic sequences. + button_link: + - title_md: Metagenomics data processing and analysis for microbiome + description_md: > + + button_link: + - title_md: Clinical metaproteomics workflows within Galaxy + description_md: > + + button_link: + + - id: faq + title: FAQ + heading_md: > + + content: [] \ No newline at end of file diff --git a/communities/microgalaxy/lab/sections/4_tools.yml b/communities/microgalaxy/lab/sections/4_tools.yml new file mode 100644 index 00000000..3318efec --- /dev/null +++ b/communities/microgalaxy/lab/sections/4_tools.yml @@ -0,0 +1,744 @@ +id: tools +title: Community Tools +tabs: +- id: tool_list + title: List of community curated tools available for microGalaxy + content: + - title_md: PAMPA + description_md: Tools to compute and analyse biodiversity metrics + - title_md: TreeBest + description_md: TreeBeST best + - title_md: abacas + description_md: Order and Orientate Contigs + - title_md: abricate + description_md: Mass screening of contigs for antiobiotic resistance genes + - title_md: abritamr + description_md: A pipeline for running AMRfinderPlus and collating results into + functional classes + - title_md: abyss + description_md: Assembly By Short Sequences - a de novo, parallel, paired-end + sequence assembler + - title_md: aldex2 + description_md: Performs analysis Of differential abundance taking sample variation + into account + - title_md: amplican + description_md: AmpliCan is an analysis tool for genome editing. + - title_md: amrfinderplus + description_md: '"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.' + - title_md: ancombc + description_md: Performs analysis of compositions of microbiomes with bias correction. + - title_md: antismash + description_md: Antismash allows the genome-wide identification, annotation and + analysis of secondary metabolite biosynthesis gene clusters + - title_md: artic + description_md: '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' + - title_md: assemblystats + description_md: Summarise an assembly (e.g. N50 metrics) + - title_md: bakta + description_md: '"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."' + - title_md: bamtools + description_md: Operate on and transform BAM datasets in various ways using bamtools + - title_md: bandage + description_md: Bandage - A Bioinformatics Application for Navigating De novo + Assembly Graphs Easily + - title_md: bayescan + description_md: Detecting natural selection from population-based genetic data + - title_md: bbtools + description_md: 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. + - title_md: bigscape + description_md: Construct sequence similarity networks of BGCs and groups them + into GCF + - title_md: binning_refiner + description_md: Reconciles the outputs of different binning programs with the + aim to improve the quality of genome bins,especially with respect to contamination + levels. + - title_md: biohansel + description_md: Heidelberg and Enteritidis SNP Elucidation + - title_md: biom_format + description_md: The biom-format package provides a command line interface and + Python API for working with BIOM files. + - title_md: biotradis + description_md: Bio-Tradis is a tool suite dedicated to essentiality analyses + with TraDis data. + - title_md: blast2go + description_md: Maps BLAST results to GO annotation terms + - title_md: blast_rbh + description_md: BLAST Reciprocal Best Hits (RBH) from two FASTA files + - title_md: blastxml_to_top_descr + description_md: Make table of top BLAST match descriptions + - title_md: bracken + description_md: Bayesian Reestimation of Abundance with KrakEN + - title_md: busco + description_md: BUSCO assess genome and annotation completeness + - title_md: cat + description_md: Contig Annotation Tool (CAT) + - title_md: cd_hit_dup + description_md: simple tool for removing duplicates from sequencing reads + - title_md: cdhit + description_md: Cluster or compare biological sequence datasets + - title_md: cemitool + description_md: Gene co-expression network analysis tool + - title_md: checkm + description_md: Assess the quality of microbial genomes recovered from isolates, + single cells, and metagenomes + - title_md: clair3 + description_md: Symphonizing pileup and full-alignment for high-performance long-read + variant calling + - title_md: clinod + description_md: 'NoD: a Nucleolar localization sequence detector for eukaryotic + and viral proteins' + - title_md: clustalw + description_md: ClustalW multiple sequence alignment program for DNA or proteins + - title_md: cmsearch_deoverlap + description_md: removes lower scoring overlaps from cmsearch results. + - title_md: codeml + description_md: Detects positive selection + - title_md: cojac + description_md: co-occurrence of mutations on amplicons + - title_md: combine_assembly_stats + description_md: Combine multiple Assemblystats datasets into a single tabular + report + - title_md: combine_metaphlan_humann + description_md: Combine MetaPhlAn2 and HUMAnN2 outputs to relate genus/species + abundances and gene families/pathways abundances + - title_md: compare_humann2_output + description_md: Compare outputs of HUMAnN2 for several samples and extract similar + and specific information + - title_md: compleasm + description_md: 'Compleasm: a faster and more accurate reimplementation of BUSCO' + - title_md: concoct + description_md: 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. + - title_md: coverm + description_md: CoverM genome and contig wrappers + - title_md: cryptogenotyper + description_md: CryptoGenotyper is a standalone tool to *in-silico* determine + species and subtype based on SSU rRNA and gp60 markers. + - title_md: cutadapt + description_md: Flexible tool to remove adapter sequences (and quality trim) high + throughput sequencing reads (fasta/fastq). + - title_md: dada2 + description_md: DADA2 wrappers + - title_md: das_tool + description_md: DAS Tool for genome resolved metagenomics + - title_md: deseq2 + description_md: Differential gene expression analysis based on the negative binomial + distribution + - title_md: diamond + description_md: DIAMOND is a new alignment tool for aligning short DNA sequencing + reads to a protein reference database such as NCBI-NR. + - title_md: disco + description_md: DISCO is a overlap-layout-consensus (OLC) metagenome assembler + - title_md: dram + description_md: DRAM for distilling microbial metabolism to automate the curation + of microbiome function + - title_md: drep + description_md: dRep compares and dereplicates genome sets + - title_md: ectyper + description_md: EC-Typer - in silico serotyping of Escherichia coli species + - title_md: effectiveT3 + description_md: Find bacterial type III effectors in protein sequences + - title_md: eggnog_mapper + description_md: eggnog-mapper fast functional annotation of novel sequences + - title_md: emboss_5 + description_md: Galaxy wrappers for EMBOSS version 5.0.0 tools + - title_md: ete + description_md: Analyse phylogenetic trees using the ETE Toolkit + - title_md: export2graphlan + description_md: export2graphlan is a conversion software tool for producing both + annotation and tree file for GraPhlAn + - title_md: ez_histograms + description_md: ggplot2 histograms and density plots + - title_md: fargene + description_md: fARGene (Fragmented Antibiotic Resistance Gene iENntifiEr ) + - title_md: fastani + description_md: Fast alignment-free computation of whole-genome Average Nucleotide + Identity + - title_md: fastk + description_md: 'FastK: A K-mer counter (for HQ assembly data sets)' + - title_md: fastp + description_md: Fast all-in-one preprocessing for FASTQ files + - title_md: fastqe + description_md: FASTQE + - title_md: fasttree + description_md: FastTree infers approximately-maximum-likelihood phylogenetic + trees from alignments of nucleotide or protein sequences - GVL + - title_md: featurecounts + description_md: featureCounts counts the number of reads aligned to defined masked + regions in a reference genome + - title_md: filter_spades_repeats + description_md: Remove short and repeat contigs/scaffolds + - title_md: filtlong + description_md: Filtlong - Filtering long reads by quality + - title_md: flashlfq + description_md: FlashLFQ mass-spectrometry proteomics label-free quantification + - title_md: flye + description_md: Assembly of long and error-prone reads. + - title_md: format_metaphlan2_output + description_md: Format MetaPhlAn2 output to extract abundance at different taxonomic + levels + - title_md: fraggenescan + description_md: Tool for finding (fragmented) genes in short read + - title_md: freyja + description_md: lineage abundances estimation + - title_md: frogs + description_md: Suite for metabarcoding analysis + - title_md: funannotate + description_md: Funannotate is a genome prediction, annotation, and comparison + software package. + - title_md: getmlst + description_md: Download MLST datasets by species from pubmlst.org + - title_md: ggplot2 + description_md: 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. + - title_md: gi2taxonomy + description_md: Fetch taxonomic representation + - title_md: glimmer + description_md: Glimmer makes gene predictions. + - title_md: glimmer_hmm + description_md: GlimmerHMM is a new gene finder based on a Generalized Hidden + Markov Model (GHMM) + - title_md: goenrichment + description_md: Performs GO Enrichment analysis. + - title_md: goseq + description_md: goseq does selection-unbiased testing for category enrichment + amongst differentially expressed (DE) genes for RNA-seq data + - title_md: graphlan + description_md: GraPhlAn is a software tool for producing high-quality circular + representations of taxonomic and phylogenetic trees + - title_md: graphmap + description_md: Mapper for long, error-prone reads. + - title_md: gtdbtk + description_md: '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. ' + - title_md: gubbins + description_md: Gubbins - bacterial recombination detection + - title_md: hamronization + description_md: Convert AMR gene detection tool output to hAMRonization specification + format. + - title_md: hansel + description_md: Heidelberg and Enteritidis SNP Elucidation + - title_md: hifiasm_meta + description_md: A hifiasm fork for metagenome assembly using Hifi reads. + - title_md: hivtrace + description_md: An application that identifies potential transmission clusters + within a supplied FASTA file with an option to find potential links against + the Los Alamos HIV Sequence Database. + - title_md: hmmer3 + description_md: 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). + - title_md: humann + description_md: HUMAnN for functionally profiling metagenomes and metatranscriptomes + at species-level resolution + - title_md: hyphy + description_md: Hypothesis Testing using Phylogenies + - title_md: hypo + description_md: Super Fast & Accurate Polisher for Long Read Genome Assemblies + - title_md: icescreen + description_md: ICEscreen identifies Integrative Conjugative Elements (ICEs) and + Integrative Mobilizable Elements (IMEs) in Bacillota genomes. + - title_md: idba_ud + description_md: Wrappers for the idba assembler variants. + - title_md: infernal + description_md: Infernal ("INFERence of RNA ALignment") is for searching DNA sequence + databases for RNA structure and sequence similarities. + - title_md: instrain + description_md: InStrain is a tool for analysis of co-occurring genome populations + from metagenomes + - title_md: integron_finder + description_md: '"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"' + - title_md: interproscan + description_md: Interproscan queries the interpro database and provides annotations. + - title_md: iprscan5 + description_md: Interproscan queries the interpro database and provides annotations. + - title_md: iqtree + description_md: Efficient phylogenomic software by maximum likelihood + - title_md: isescan + description_md: '"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."' + - title_md: itsx + description_md: ITSx is an open source software utility to extract the highly + variable ITS1 and ITS2 subregions from ITS sequences. + - title_md: ivar + description_md: iVar is a computational package that contains functions broadly + useful for viral amplicon-based sequencing + - title_md: jbrowse + description_md: JBrowse Genome Browser integrated as a Galaxy Tool + - title_md: jellyfish + description_md: Jellyfish is a tool for fast, memory-efficient counting of k-mers + in DNA + - title_md: kat_filter + description_md: Filtering kmers or reads from a database of kmers hashes + - title_md: kc-align + description_md: Kc-Align custom tool + - title_md: khmer + description_md: In-memory nucleotide sequence k-mer counting, filtering, graph + traversal and more + - title_md: kleborate + description_md: Screen genome assemblies of Klebsiella pneumoniae and the Klebsiella + pneumoniae species complex (KpSC) + - title_md: kofamscan + description_md: Gene function annotation tool based on KEGG Orthology and hidden + Markov model + - title_md: kraken + description_md: 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. + - title_md: kraken2 + description_md: Kraken2 for taxonomic designation. + - title_md: kraken2tax + description_md: Convert Kraken output to Galaxy taxonomy data. + - title_md: kraken_biom + description_md: Create BIOM-format tables (http://biom-format.org) from Kraken + output (http://ccb.jhu.edu/software/kraken/) + - title_md: kraken_taxonomy_report + description_md: Kraken taxonomy report + - title_md: krakentools + description_md: KrakenTools is a suite of scripts to be used alongside the Kraken + - title_md: krocus + description_md: Predict MLST directly from uncorrected long reads + - title_md: lca_wrapper + description_md: Find lowest diagnostic rank + - title_md: legsta + description_md: Performs in silico Legionella pneumophila sequence based typing. + - title_md: lighter + description_md: Lighter is a kmer-based error correction method for whole genome + sequencing data + - title_md: limma_voom + description_md: Perform RNA-Seq differential expression analysis using limma voom + pipeline + - title_md: lineagespot + description_md: Identification of SARS-CoV-2 related metagenomic mutations based + on a single (or a list of) variant(s) file(s) + - title_md: lorikeet + description_md: Tools for M. tuberculosis DNA fingerprinting (spoligotyping) + - title_md: lotus2 + description_md: LotuS2 OTU processing pipeline + - title_md: m6anet + description_md: m6anet to detect m6A RNA modifications from nanopore data + - title_md: maaslin2 + description_md: MaAsLin2 is comprehensive R package for efficiently determining + multivariable association between microbial meta'omic features and clinical + metadata. + - title_md: mafft + description_md: Multiple alignment program for amino acid or nucleotide sequences + - title_md: make_nr + description_md: Make a FASTA file non-redundant + - title_md: maker + description_md: 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. + - title_md: mapseq + description_md: fast and accurate sequence read classification tool designed to + assign taxonomy and OTU classifications to ribosomal RNA sequences. + - title_md: mash + description_md: Fast genome and metagenome distance estimation using MinHash + - title_md: maxbin2 + description_md: clusters metagenomic contigs into bins + - title_md: maxquant + description_md: wrapper for MaxQuant + - title_md: mcl + description_md: The Markov Cluster Algorithm, a cluster algorithm for graphs + - title_md: medaka + description_md: Sequence correction provided by ONT Research + - title_md: megahit + description_md: An ultra-fast single-node solution for large and complex metagenomics + assembly via succinct de Bruijn graph. + - title_md: megahit_contig2fastg + description_md: A subprogram within the Megahit toolkit for converting contigs + to assembly graphs (fastg) + - title_md: megan + description_md: 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). + - title_md: meningotype + description_md: Assign sequence type to N. meningitidis genome assemblies + - title_md: merqury + description_md: Merqury is a tool for evaluating genomes assemblies based of k-mer + operations. + - title_md: meryl + description_md: Meryl a k-mer counter. + - title_md: metabat2 + description_md: 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. + - title_md: metaeuk + description_md: '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. ' + - title_md: metagene_annotator + description_md: MetaGeneAnnotator gene-finding program for prokaryote and phage + - title_md: metagenomeseq + description_md: metagenomeSeq Normalization + - title_md: metanovo + description_md: Produce targeted databases for mass spectrometry analysis. + - title_md: metaphlan + description_md: MetaPhlAn for Metagenomic Phylogenetic Analysis + - title_md: metaquantome + description_md: quantitative analysis of microbiome taxonomy and function + - title_md: metawrapmg + description_md: A flexible pipeline for genome-resolved metagenomic data analysis + - title_md: minia + description_md: Short-read assembler based on a de Bruijn graph + - title_md: miniasm + description_md: Miniasm - Ultrafast de novo assembly for long noisy reads (though + having no consensus step) + - title_md: minipolish + description_md: Polishing miniasm assemblies + - title_md: miniprot + description_md: Align a protein sequence against a genome with affine gap penalty, + splicing and frameshift. + - title_md: mitos + description_md: de-novo annotation of metazoan mitochondrial genomes + - title_md: mlst + description_md: Scan contig files against PubMLST typing schemes + - title_md: mob_suite + description_md: MOB-suite is a set of software tools for clustering, reconstruction + and typing of plasmids from draft assemblies + - title_md: mothur + description_md: Mothur wrappers + - title_md: mrbayes + description_md: A program for the Bayesian estimation of phylogeny. + - title_md: msconvert + description_md: msconvert Convert and/or filter mass spectrometry files (including + vendor formats) using the official Docker container + - title_md: msstatstmt + description_md: MSstatsTMT protein significance analysis in shotgun mass spectrometry-based + proteomic experiments with tandem mass tag (TMT) labeling + - title_md: multigsea + description_md: GSEA-based pathway enrichment analysis for multi-omics data + - title_md: multiqc + description_md: MultiQC aggregates results from bioinformatics analyses across + many samples into a single report + - title_md: mykrobe + description_md: Antibiotic resistance predictions + - title_md: mykrobe_parser + description_md: RScript to parse the results of mykrobe predictor. + - title_md: mz_to_sqlite + description_md: Creates a SQLite database for proteomics data + - title_md: nanocompore + description_md: 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. + - title_md: nanoplot + description_md: Plotting tool for long read sequencing data and alignments + - title_md: nanopolishcomp + description_md: 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. + - title_md: ncbi_blast_plus + description_md: NCBI BLAST+ + - title_md: ncbi_fcs_gx + description_md: FCS-GX detects contamination from foreign organisms in genome + sequences using the genome cross-species aligner (GX). + - title_md: newick_utils + description_md: Perform operations on Newick trees + - title_md: nextclade + description_md: Identify differences between your sequences and a reference sequence + used by Nextstrain + - title_md: nextdenovo + description_md: String graph-based de novo assembler for long reads + - title_md: nonpareil + description_md: Estimate average coverage in metagenomic datasets + - title_md: nucleosome_prediction + description_md: Prediction of Nucleosomes Positions on the Genome + - title_md: nugen_nudup + description_md: Marks/removes PCR introduced duplicate molecules based on the + molecular tagging technology used in NuGEN products. + - title_md: obisindicators + description_md: Compute biodiveristy indicators for marine data from obis + - title_md: obitools + description_md: OBITools is a set of programs developed to simplify the manipulation + of sequence files + - title_md: omark + description_md: Proteome quality assessment software + - title_md: orfipy + description_md: Galaxy wrapper for ORFIPY + - title_md: orthofinder + description_md: Accurate inference of orthologous gene groups made easy + - title_md: peptideshaker + description_md: PeptideShaker and SearchGUI + - title_md: pfamscan + description_md: Search a FASTA sequence against a library of Pfam HMM. + - title_md: pharokka + description_md: rapid standardised annotation tool for bacteriophage genomes and + metagenomes + - title_md: phyloseq + description_md: Handling and analysis of high-throughput microbiome census data + - title_md: phyml + description_md: PhyML is a phylogeny software based on the maximum-likelihood + principle. + - title_md: picrust + description_md: PICRUSt wrappers + - title_md: picrust2 + description_md: 'PICRUSt2: Phylogenetic Investigation of Communities by Reconstruction + of Unobserved States' + - title_md: plasflow + description_md: PlasFlow - Prediction of plasmid sequences in metagenomic contigs. + - title_md: plasmidfinder + description_md: '"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"' + - title_md: plasmidspades + description_md: Genome assembler for assemblying plasmid + - title_md: polypolish + description_md: '"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."' + - title_md: prodigal + description_md: A protein-coding gene prediction software tool for bacterial and + archaeal genomes + - title_md: prokka + description_md: Rapid annotation of prokaryotic genomes + - title_md: promer + description_md: Aligns two sets of contigs and reports amino acid substitutions + between them + - title_md: proteinortho + description_md: Proteinortho is a tool to detect orthologous proteins/genes within + different species. + - title_md: pycoqc + description_md: QC metrics for ONT Basecalling + - title_md: pygenometracks + description_md: 'pyGenomeTracks: Standalone program and library to plot beautiful + genome browser tracks.' + - title_md: qiime_add_on + description_md: QIIME to perform microbial community analysis + - title_md: qiime_core + description_md: QIIME to perform microbial community analysis + - title_md: qualimap + description_md: Qualimap 2 is a platform-independent application written in Java + andR that facilitates the quality control of alignment sequencing data and itsderivatives + like feature counts. + - title_md: quast + description_md: Quast (Quality ASsessment Tool) evaluates genome assemblies. + - title_md: quickmerge + description_md: Merge long-read and hybrid assemblies to increase contiguity + - title_md: rRNA + description_md: Identification of ribosomal RNA genes in metagenomic fragments. + - title_md: racon + description_md: Consensus module for raw de novo DNA assembly of long uncorrected + reads. + - title_md: rasusa + description_md: Randomly subsample sequencing reads to a specified coverage + - title_md: raxml + description_md: RAxML - A Maximum Likelihood based phylogenetic inference + - title_md: read_it_and_keep + description_md: Rapid decontamination of SARS-CoV-2 sequencing reads + - title_md: reago + description_md: Reago is tool to assembly 16S ribosomal RNA recovery from metagenomic + data. + - title_md: recentrifuge + description_md: '"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."' + - title_md: repeatexplorer2 + description_md: Tool for annotation of repeats from unassembled shotgun reads. + - title_md: roary + description_md: Roary the pangenome pipeline + - title_md: rseqc + description_md: an RNA-seq quality control package + - title_md: salmon + description_md: Salmon is a wicked-fast program to produce a highly-accurate, + transcript-level quantification estimates from RNA-seq and single-cell data. + - title_md: sarscov2formatter + description_md: sarscov2formatter custom script + - title_md: sarscov2summary + description_md: sarscov2summary custom script + - title_md: scoary + description_md: Scoary calculates the assocations between all genes in the accessory + genome and the traits. + - title_md: semibin + description_md: 'SemiBin: Semi-supervised Metagenomic Binning Using Siamese Neural + Networks' + - title_md: seqkit + description_md: A cross-platform and ultrafast toolkit for FASTA/Q file manipulation + - title_md: seqprep + description_md: Tool for merging paired-end Illumina reads and trimming adapters. + - title_md: seqsero2 + description_md: Salmonella serotype prediction from genome sequencing data + - title_md: shorah + description_md: Reconstruct haplotypes using ShoRAH in amplicon mode + - title_md: shovill + description_md: Faster de novo assembly pipeline based around Spades + - title_md: sistr_cmd + description_md: SISTR in silico serotyping tool + - title_md: smallgenomeutilities + description_md: Set of utilities for manipulating small viral genome data. + - title_md: smalt + description_md: SMALT aligns DNA sequencing reads with a reference genome. + - title_md: snap + description_md: SNAP is a general purpose gene finding program suitable for both + eukaryotic and prokaryotic genomes. + - title_md: snippy + description_md: Contains the snippy tool for characterising microbial snps + - title_md: sonneityping + description_md: Scripts for parsing Mykrobe predict results for Shigella sonnei. + - title_md: sortmerna + description_md: SortMeRNA is a software designed to rapidly filter ribosomal RNA + fragments from metatransriptomic data produced by next-generation sequencers. + - title_md: spades + description_md: '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.' + - title_md: spotyping + description_md: SpoTyping allows fast and accurate in silico Mycobacterium spoligotyping + from sequence reads + - title_md: sr_bowtie + description_md: bowtie wrapper tool to align small RNA sequencing reads + - title_md: srst2 + description_md: Short Read Sequence Typing for Bacterial Pathogens + - title_md: srst2 + description_md: SRST2 Short Read Sequence Typing for Bacterial Pathogens + - title_md: staramr + description_md: Scan genome contigs against the ResFinder, PlasmidFinder, and + PointFinder antimicrobial resistance databases. + - title_md: stringmlst + description_md: Rapid and accurate identification of the sequence type (ST) + - title_md: structure + description_md: for using multi-locus genotype data to investigate population + structure. + - title_md: suite_qiime2__alignment + description_md: .nan + - title_md: suite_qiime2__composition + description_md: .nan + - title_md: suite_qiime2__cutadapt + description_md: .nan + - title_md: suite_qiime2__dada2 + description_md: .nan + - title_md: suite_qiime2__deblur + description_md: .nan + - title_md: suite_qiime2__demux + description_md: .nan + - title_md: suite_qiime2__diversity + description_md: .nan + - title_md: suite_qiime2__diversity_lib + description_md: .nan + - title_md: suite_qiime2__emperor + description_md: .nan + - title_md: suite_qiime2__feature_classifier + description_md: .nan + - title_md: suite_qiime2__feature_table + description_md: .nan + - title_md: suite_qiime2__fragment_insertion + description_md: .nan + - title_md: suite_qiime2__longitudinal + description_md: .nan + - title_md: suite_qiime2__metadata + description_md: .nan + - title_md: suite_qiime2__phylogeny + description_md: .nan + - title_md: suite_qiime2__quality_control + description_md: .nan + - title_md: suite_qiime2__quality_filter + description_md: .nan + - title_md: suite_qiime2__rescript + description_md: .nan + - title_md: suite_qiime2__sample_classifier + description_md: .nan + - title_md: suite_qiime2__taxa + description_md: .nan + - title_md: suite_qiime2__vsearch + description_md: .nan + - title_md: suite_qiime2_core + description_md: .nan + - title_md: suite_qiime2_core__tools + description_md: .nan + - title_md: t2ps + description_md: Draw phylogeny + - title_md: t2t_report + description_md: Summarize taxonomy + - title_md: t_coffee + description_md: T-Coffee + - title_md: taxonomy_krona_chart + description_md: Krona pie chart from taxonomic profile + - title_md: tb-profiler + description_md: Processes M. tuberculosis sequence data to infer strain type and + identify known drug resistance markers. + - title_md: tooldistillator + description_md: ToolDistillator extract and aggregate information from different + tool outputs to JSON parsable files + - title_md: transit + description_md: TRANSIT + - title_md: transtermhp + description_md: Finds rho-independent transcription terminators in bacterial genomes + - title_md: trim_galore + description_md: Trim Galore adaptive quality and adapter trimmer + - title_md: trycycler + description_md: Trycycler toolkit wrappers + - title_md: unicycler + description_md: Unicycler is a hybrid assembly pipeline for bacterial genomes. + - title_md: unipept + description_md: Unipept retrieves metaproteomics information + - title_md: uniprotxml_downloader + description_md: Download UniProt proteome in XML or fasta format + - title_md: usher + description_md: UShER toolkit wrappers + - title_md: valet + description_md: A pipeline for detecting mis-assemblies in metagenomic assemblies. + - title_md: vapor + description_md: Classify Influenza samples from raw short read sequence data + - title_md: varvamp + description_md: Variable VirusAMPlicons (varVAMP) is a tool to design primers + for highly diverse viruses + - title_md: vegan + description_md: an R package fo community ecologist + - title_md: velvet + description_md: de novo genomic assembler specially designed for short read sequencing + technologies + - title_md: velvet_optimiser + description_md: Automatically optimize Velvet assemblies + - title_md: virAnnot + description_md: virAnnot wrappers + - title_md: vsearch + description_md: VSEARCH including searching, clustering, chimera detection, dereplication, + sorting, masking and shuffling of sequences. + - title_md: wtdbg + description_md: WTDBG is a fuzzy Bruijn graph (FBG) approach to long noisy reads + assembly. diff --git a/communities/microgalaxy/lab/sections/5_workflows.yml b/communities/microgalaxy/lab/sections/5_workflows.yml new file mode 100644 index 00000000..b13d1053 --- /dev/null +++ b/communities/microgalaxy/lab/sections/5_workflows.yml @@ -0,0 +1,81 @@ +id: workflows +title: Workflows +tabs: + - id: workflows1 + title: Workflow Best Practices + heading_md: > +
+

+ Workflows are chains of of tools that can be run together at the click of a button. + The above tabs contain both peer reviewed and community submitted workflows. +

+

+ Tag your workflows + with #microgalaxy and share publicly with other users! +

+ Additional common workflow tags for our community are: +
    +
  • training (for workflows that correspond to the Galaxy Training Network's tutorials)
  • +
  • data interoperability
  • +
  • bacteria
  • +
  • prokaryote
  • +
  • microbiome
  • +
  • micro-organism
  • +
  • pathogen
  • +
+
+ + content: + - title_md: How to tag a workflow + description_md: > + + - title_md: WorkflowHub + description_md: > + WorkflowHub hosts high quality workflows. You can explore microGalaxy workflows from WorkflowHub. + button_link: "https://workflowhub.eu/search?q=microgalaxy+galaxy" + button_md: 🔗 + button_tip: Visit WorkflowHub + + - id: workflows3 + title: Community workflows + heading_md: > + Anyone on Galaxy can share their workflow publicly - if your workflow is running well, share it with others! +

You can search these community workflows below.

+ content: + - title_md: Community Workflows + description_md: > + Search through community workflows tagged with #microgalaxy. + + + - title_md: Advanced workflow search + description_md: > + The GTN's + {gtn modal}[Pan-Galactic Workflow Search](https://training.galaxyproject.org/training-material/workflows/list.html) + allows you to search for workflows across all of Galaxy! + + button_link: "https://training.galaxyproject.org/training-material/workflows/list.html" + button_md: 🔗 + button_tip: Visit WorkflowHub + + - title_md: How to share your workflow + description_md: > + Learn how to {gtn modal}[publish your workflow](https://training.galaxyproject.org/training-material/faqs/galaxy/workflows_publish.html) + to share your work with the Galaxy community. diff --git a/communities/microgalaxy/lab/sections/6_support_and_help.yml b/communities/microgalaxy/lab/sections/6_support_and_help.yml new file mode 100644 index 00000000..cce7e489 --- /dev/null +++ b/communities/microgalaxy/lab/sections/6_support_and_help.yml @@ -0,0 +1,51 @@ +id: support +title: Support & Help +tabs: + - id: help + title: Help + heading_md: > + You can browse through workflows before that have been reviewed by scientists. + content: + - title_md: Troubleshooting errors + description_md: > + Find specific advice for + {gtn modal}[troubleshooting Galaxy errors](https://training.galaxyproject.org/training-material/faqs/galaxy/analysis_troubleshooting.html) + on the GTN. + - title_md: Galaxy [American/Australia/EU/France/..] Support + description_md: > + Any user of Galaxy [American/Australia/EU/France/..] can request support online! + button_md: Request support + button_link: "{{ support_url }}" + - title_md: microGalaxy support + description_md: > + Users of microGalaxy can submit any kind of bug report via the microGalaxy webserver + button_link: "{{ galaxy_base_url }}" + button_md: microGalaxy support + - title_md: microGalaxy chat room + description_md: > + Of course! Check out the microGalaxy Matrix channel + button_link: "{{ microgalaxy_matrix }}" + button_md: Matrix channel + - title_md: Can I upload sensitive data? + description_md: > + No, please do not upload personal or sensitive, such as human health or clinical data. Please see our + [Privacy Policy]({{ data_policy_url }}) + page for definitions of sensitive and health-related information. + + Please also make sure you have read our + [Terms of Service]({{ terms_url }}), + which covers hosting and analysis of research data. + - title_md: Is my data private? + description_md: > + Please read our + [Privacy Policy]({{ data_policy_url }}) + for information on your personal data and any data that you upload. + + - id: request + title: Request + content: + - title_md: How can I increase my storage quota? + description_md: > + Please submit a quota request if your Galaxy account reaches its data storage limit. Requests are usually provisioned quickly if you provide a reasonable use case for your request. + button_md: Request + button_link: "{{ quota_request_url }}" diff --git a/communities/microgalaxy/lab/sections/7_community.yml b/communities/microgalaxy/lab/sections/7_community.yml new file mode 100644 index 00000000..ed3cc8ca --- /dev/null +++ b/communities/microgalaxy/lab/sections/7_community.yml @@ -0,0 +1,74 @@ +id: community +title: Community +tabs: + - id: participate + title: Participate + content: + - title_md: Chat with other users + description_md: > + Of course! Check out the microGalaxy Matrix channel + - title_md: Join our community! + description_md: > + + This Galaxy space is the result of hard, collaborative work by many contributors . + + It is maintained by the microGalaxy Community of Practice. + + This group unites scientists like yourself with software developers and bioinformaticians to create, share, and test resources to make microvial data analysis easier. + + Check out our site and join our community via [microGalaxy mailing list](https://lists.galaxyproject.org/lists/microgalaxy@lists.galaxyproject.org)! + + button_link: "{{ microgalaxy_matrix }}" + button_md: + button_tip: Visit microGalaxy + + - id: governance + title: How is the Galaxy Community organised? + heading_md: > + Learn about the + {gtn modal}[governance structure of Galaxy communities](https://training.galaxyproject.org/training-material/topics/community/faqs/governance_structure.html) on the GTN. + content: [] + + - id: links + title: Galaxy Community support links + content: + - title_md: General support + description_md: > + General Galaxy support + button_link: "{{ support_url }}" + button_md: Request support + - title_md: General help forum + description_md: > + General Galaxy help forum + button_link: "{{ galaxy_help_url }}" + button_md: Help forum + - title_md: Galaxy Training Network Slack workspace + description_md: > + GTN Slack channel + button_link: "{{ gtn_slack_url }}" + button_md: Slack channel + - title_md: Galaxy Training Network Community chat + description_md: > + GTN Matrix channel + button_link: "{{ gtn_matrix_channel }}" + button_md: Matrix channel + - title_md: microGalaxy user community chat room (Same channel but using Matrix/Element) + description_md: > + microGalaxy Matrix channel + button_link: "{{ microgalaxy_matrix }}" + button_md: Matrix channel + - title_md: American Galaxy Sever chat + description_md: > + Usegalaxy.org Matrix chat + button_link: "{{ american_server }}" + button_md: Matrix channel + - title_md: Australian Galaxy Server chat + description_md: > + Usegalaxy.org.au chat + button_link: "{{ australian_server }}" + button_md: Request form + - title_md: European Galaxy server chat + description_md: > + Usegalaxy.eu Matrix chat + button_link: "{{ european_server }}" + button_md: Matrix channel \ No newline at end of file diff --git a/communities/microgalaxy/lab/static/custom.css b/communities/microgalaxy/lab/static/custom.css new file mode 100644 index 00000000..e69de29b diff --git a/communities/microgalaxy/lab/static/microgalaxy-logo.png b/communities/microgalaxy/lab/static/microgalaxy-logo.png new file mode 100644 index 0000000000000000000000000000000000000000..ea12683deefd15fe8a251855292cafedac1439db GIT binary patch literal 21073 zcmbTeWmKC@)HaH{6^eT)(Bke|3X}pxiWD!!-7OF#v{0aUaR{M!ad$6PEV#P`f)ofA z?BsdRIzP_(zF+TJxmU7gvS;?#mTT|1qqIM$5);r7prN4=tG#=xi-v{{Ks`=)IH;0! zt~ZsaFMRiRMqX%WByIma=z}*iVrXbAXlid2_57EPb8v(7^sfem)oeLF&2_a^y7moXsH^{%2+?Wkj%wry*TVx_gib(2WO?F*&Hr6xpmHSn;l%JQ2^zhsLiWF zxEJ5oezShK4}Mxd_tft1@8@gflO3{!`rKw#PG})6{16w*O!24Yxf4x>eCBC?S`ztF z$U$omc&oKMzpLeS+7e+-Rb=<0(mDJEP_?@Yqk|CSJn5i5QShOS6?-&T{CuHk590`5 z*SueyvV#xPE3X48+7fwWSmX5K;k~a(C4wCgv$(wdS~hGgSnCSVaTm^)!242d3jMwR zp17z=&UNWgM9=}gH#lq7oEjjplCb+hky>YnbAg{Je&)4Fm0IzKoR#-@Wi_#pPlJeC z0ZEm>P%&+(j=D)l%c9Un&fEz#{Z<_*JnpHeDE8ICg$F|NPw3?&^|x zT_?yDWB*Au5?zsD$kXR^?cu2e-F14wgZ65|_P}IZ(6}m!JZt=~zidE7+F=Xd;@+(A zPAO@*z6WvRq-ZnRPFVR#vmp%2SVX!b;K@v?N?kd%^P!_;zZH6&J5k$|6)$QUDT-Q; zJCIyL3ZzS)8G27&C*mypjuVzui)ht5Z0Gw}3(ND%ii7_HiC&KcvT#0k|IOV2T=}HC zB_Gcu#Hi58klZ=ICBC3(1Te#aUzk25@?bv@<;3;W^R!aM_?Sk{+Qu3Fse|pb5FZy{ z+(lZ$CCFzuph0PiqTburch@gTcX-ZKq7U|Ch8`VOv*J!kzPc_EIS?ztR6gXb=K(v{6@9`J5xbO}gsj53z7?K27>6nqN zyl*mM89kme;wL!&>>qsh5sE^e?Xkn75sUUC#EPOQmZI!@rk6 zoc80H-&o5y9cwZ!+g!29$Z@e!mmhP25p~@geI6yF`x8++=*!&Te0Upl`)qa0oM@13 zkxhvEiiY35s1lPly=WJj9=|f>FfMwEUc$#Q=0;1^ze5OP;+gdy>zp;wPipjN`y2Rt zs!qN#sdTrZj(s*o);<3;OepT6t})7LfC|7?3_q2^9lj;rj%TS-{^CD?n;}uO+fu!$mhpj!A#;T53CoZLF2~z3;bZfcR7vRlvnQY?R;}?nNXMX>3HT79+lX z$UE@!h@9k`!#^;53}5(=Nmzmbt5Lz!^aowfi=H^CTqc4LF$onp73^07w6u1O7e}T` zkEYyK8ytUrFW2heF!XtPkk0uvjB8KArDW$+H9SWj%f*5Q;xh3`hSva!r`LC+7~jUO zcdj7=H+k`W9UB+8#QtaoQKxkXjhy{u z2n8Zv(;I6|=RnfJe#*mnO887LZ7%&?RtalY(HY0(2UUsg?K3}NsC0*FvFcOHFrl#ubN275jjrEl z-tGR>NRHd&k;SZ$QG51M%m|=FjRQy|nG929x)&61o>d&_<+N=#s|NqFqH(- z0Z27^j5hzp zmaASp61$dMJD8339(m%u=i1hK(XvG)MjsjX%h=-V%RX|Q>mC>XgumR+A}IbKsB6-{ zlaLqIXMy+T(kFTA;-d)QqKby{S*Y%M!S!W;U1uAyb2TwYvMGXO<<&l&El zeM9#dPhI1xzm`rNxMFg?Jn;HN`Gv6cVxr)XSEq)_lR#H$jIPzY9e=Q3-!q*%6^+3* z@OqMhg_Dvvp$~}&uRwLr2g-$g1FtWekMuL(whVSM%N<`Wp zs-J1LH2$3zdRMV-JdVuyShBFdBeDVE7v8v~*RVlafyGUcaH$jjXKvjEpKdJleYf~| z+f^^HE7kL7T_OiL^#GnRL?kT_EY<77136Wv=+b=NTi0n<4PWFGrLQ-PQZ_TG6<0;R zJH^9rJD!Nc>0;km7Nl?hO2&ML8+Gm+KZIPk(k+df9}@gf<2PZ<68r5k5Oyg4!DhXA z{THq)e-AvQCGjqn+K_^tS^KIhUC9;VO819*46pJi81r54aIH*IGYd^>xO-qC%EoTVT!x<1S@t;0+EEea^r&irBM4wHech4GalMn8VS1f9X1hj;wfb$<=%au6^Zyn#1eEV=OtaW}BX=tPOLs5QR%D zRmZ=@dE}7+|8Wvij}`v>@6nK8rTBZz-A}5Lj8`_3K$_S7GW-r*6H{zwXEJ;(EWlr; zfs=$IY4LUb#LAi>UtpaYRF@vpo2@wq%B3oUe z5ZMWhiD@Gnyj4K@-9HB&6m4hJpwu+@Zn7 z_{+6vnuU6zY(966?KcUVsA>L58cTunsG2+CY-k?F`Tn!CV3E&VBZ>jaDAOS1NAb%% z#oo^X)6R8+Y-UMPMsE)bynfkjed-xxxxb>VZ~FBNRm=T3*BM)yox^PdOJn=Jv7P@_ zY*k&f!vtysMe_!Y;LnB6(*oCEz}Fe_Ehocij1@(m%qV_npX)}|^L*-adR6vGM_oUt zv%K7SKAZXL?%{WPZvh$}&8wt&lcjHRhUtPHG3~e92?n%PpCbow!h5DnrF#Ayd%i-Z zW=96KcV`IZFQNLfElx<76h#W703v(2O68gA;D^ z9rx+uisU6zI_75TRLI$@T0?Vt6F?Ys`<$*`ZYNxIJFMq3tx&bp@KH+HQ4*sULr;Kf z(m@A9S!+Vxgt`mBAgMy<%K4<_51A5_S&V}wB`fUJk9^$^xAvx z0CIBgvlRH`O45yN-NSi>QR* z7X-J*e^hZFlIRk-8|>-+r;RvJ@aMQt^HyAO2AuF+d)QuLHX0CRfvlaMUSb#gk-e!8;XYM zdrGK-6^B*qoACddsE@6nc*k-q_(V7f`7A)wE4IjZ%Kr~g=msr8QFdq$_;(bVN%^gATg2m_s)V{b*|YX8)U?jt>c$WH z;ZERhiB=!fF>6(Cy~7?_Yczafp(8^rSJE4M=0KS#c9y&GOK;!ZVSM|Ss1;L>&U<*D z3skr^*h<2;XF-*Wc%HR|ok-752T;ahqPALM1skWY78F=a7WZ6vJGAGsk#&dSHKUOG zds0^DglZqEglcz06(|>yGaO!b3277Zh@Sol1Kod*zzy%=sr|H}E|}<)5sfUvZ4mR8vnWcR^F0;nz)~kzV^9chlH3D%6*pB2uX1 z#JXc~vepr(lZ4mj`lpcd#}|r@*FlLN-S=Ccp(Lg@SaD!>6T0zVixe4ifil5Wuc~Cg zQxq`iSezq2$I7pE;|5e*i(he23{9ck9_&~%m0R9JmDiae8lh9oZWay(m~u=PN# z5A{&fhW~k=A{)57yZZst$@B8#ZNlQ4NOzS~(nh+b8^4w0>ztfsAd^Pky4j$XhKM5# z(cD%~V8`0W(a*-~oxlr+J1cBvk*x1pW_5Ju_s>NIln?C8(O8smCSH46;!a|23XAyC z@D$75_S>p*$uK=t{Ap@Xi?gg8{D|a#{_3N6f=7NPFi^%umEzyJa(HA zi<->-0hs@TPBl5yPS;`XaajUPFbRJX@}yN3r|zss=a8Uw$CM{zU7bxmS#!AboLXI# zfXO7}A})-YI7#d~$$Q6D()n)P-kv_}Wmr^+_-A5RBn=vpeV9Yko0cCl-mqbEmTZt@1$HqDB4A-kMAgm-E#L$WHz;T(7ofM+)hG1p0V7kxrJQ$ z-zRN!x?+B-Kz|UHV(l9HK|}4c#;-3j+Os#tO-84lZrk6nHBQZp`>a#E$;89-?A!LY zlj%C&0Jhyb$JsAag@uK88PAY}5E2ktqAM4Ksca{hF z!lk@}Cu zqT6^0_4xvlTBC01Y@5mDc{8rl2|8}6 z#FuKgcuW&yY}fF!cRAj+z)xG6T!n9^4kx)W3mhvoQ_$~%l$?L?M&c+>!)Na-=5LVn zc~#OHXiH?of`)w^tTsT?#1A#yzwSh)<7(_lR`DCt=81!sTRABRK6x-w^#uCVsgZ8U ze<%IpI>B3f)zzeYZHM;CS%*mHm|GxlGCR}ZO}L7{Ux2&x`?!+1dt$P9GWCGCOFSpN%ln`--#D9Y6FM9_0} z_Z>fP5wjt}b}?hSh0plf%yi|Lf9sB0mg0HiJDDjkfbo-L?D+GEe6Rg;v*x|8adCGo zJuGK2Ct2-#Pr_%N_a8Z-7<-`6>jaodTF?BhL{1b|)h8^Z`LBj~O?NWa$=kV$>bOGfyS0Tns&kSAv@S8>@9hGiv)rO?gU`Xh@edtQuq`#`x^B*hD zfC=9DV7P=2Gd)O5TIF3`+F|;Qu|&cA(Ts&ALf1vG;~i@8?}C-xhCc)EsN3Y<>(l@h zHV|PUq;*#9_<|jTm!P%nGX~3*vm4GutEtpAvTsk~!d?Rbz1h)*h&UW++%)^IK`Hvc z?;ZM+TyY%rIpUXm+r?f_lw4D0%orYC3TGfYWT@f!l1zBrLOsbJI#GC5qoA(l8)bNdW!_Ox;DV;bkF}=? zox$GM4vw~Yx{;r(*L+^fYS`HUm)qU5J~`T8SaYVk(~vCrGLr}r96iZ;zIt@Etn>Xo zi|#0R8ipf{FY6QxGB57wt zR0@cu!%uKxNi*V`gCy~9nVm9m_K@ZSW3b=(H)JI+OR|0!i`6W@++g#Ec{_phWI zPPYBAQmpIg*AV9cis!|{HO+h}e`{yXJw19$^4Dj{a7WQO5-}jsxIQ9cPA`m8zU!ms zaJRZ>;%e7r;aSo@q}*DX)A`%#anSRp$`Gqyy+3)H?()v#%`cp_hp~k;U8g~@|FSzbXg-MgV(N3v(<%Lwm$etLzMfTED*cE*Hp=r@2aw#Uw?$~o7 zd2rxd}%CqsuQ)xxkwT9q4s}c&Wzy0g_V{Mk6MX3 zlWX+xr|3D55P5ZEQrsv{fF%v?cdU#TXHp1h#m8b(IvMgRrLGI|NCVtUaNux1j!FqMSiJp3mG|I$*6v6dedOT#X<<1CFa&8`$V`znkHBdJb*8iMKSc|K;2 zghtWKUot}ymue{&{d1Z(a)-9A z+AFJ#ysTMXmHHR47}ou$dj2vt4@WXO2CNf#&#y#cXfM5RlQ(#|S=!fGIrE}x{q#CF zJ1sxl@vK#C>WiY*qw0BZo9)FV>i*tZfEJkU<>7t_x0_WAvxWJayfkYN^fr40P#hUF1w=GG z3`f)i$aLD>t|M;Ip5(hWh29>gjt>v^DHLD$$HZOV`BwG}-24(Ov;(;&U<8=Us)7qJ z-gVbnhZ?kk=Nk$qY7nRFSRKStjZLxTMj0ZX#wnVo&_fDy&qufT^~M!xCPWd6QvMg= zXt*>QD>prgR69G^7*DrYkE^5SYxw`Dr-O^mejQ20Nop)FQP+oy$CD6+JBWj->qFOG zfcHMNn3s5tF)!I#)K4 zPbC|MN8Nb;NwI@>pyS+!;3u&2jy>a0msM5H(##lBdYSSPFzk-Hz9%AnvD%ElHN;;vO1 z=cBX85AkC(O;04DZZ6@--0yJgkyjV~f8%f-JP8oz1XuR=E?*rYNF+F3Z%`aRwoUZ= zgxe%gY;$8jc)m5Y0=pvP?Qf)gKno)i59&1M&Tc;>J_TcTUxwR6sGhdbVU1=eezGtW zLFOFS;7({`-%_jV)wY zZ;frnmy&^6^F#q+;CJ8Pcy&!`6pCFd(G%Co`RkJd?Lp}z&{Jyo+VS7)c2^r4c26m; zrG#VN(F|XRg=<(a1KlHusKS?N3wZ@$m}-~%+c}GTr^?P3SN}Tf25~OsS+9^#C997X z(gLW?uZFFsEuPemDs)2PJA`gv3)2rDVpoB8*a)cidWH;j31+ORjV?l<3JwBIj(w=mo)l#nF*+^yr_g~GyH(zX4Id1O%M_{=OL#LPAP z@ofk3;hOYB%682!#%yj`bGM6mKi=>fQ!du!&u8}(Pht%Jq6TX2v)q~`RyT?GnA;^f z-M=#o+^>|^c2g}%#SdP$|0kTkhFkYjKbu=C0U!ANUNJK9+jyP-L>GA6-)B`tB&mxN zIQ!M$>1oNrs%c3AyXN%4t`vhxp5~^4Ba3CiirDszTup_k&6vrW0rrlP3{!~sxp(~G zOlfjkMet;c*DYUrCl~sKc_ph>EUc~P%BAET-x_vS3kgXb+*v~M4`&`66?1PKZE6+`%jdtHJmlcG>5NW zd)JNcQebQ-n6FjImJt3`WIBIV-{CZ*GASlsKipxga%Jz~ali_p{YivKno}7NoMTiH z!tHl$uT*af30cqCAK)5rj^8v)PJ24s$af)>mP@m)-j;a$7@y5GSX0Mq?RCdXZHyBj z#sm{()w~+}&r{Ew^^;IeOv8W4j}%<8Adb}FX%;Ulo#^b3$+>%Y3;}&kupiKDnNtx* z+**B^ol&#vtg&z&Rgc8)2$o;C>yq9v5xzN=Y56X!1P(lUDcRmVIN~O7bRd5LdtC#T ztsGhklNnEJB1f!n-0xX)^IrQ0X(g(LG-Iz0_uR3PQBTV;LxAx*ZOyw&?|EJu&DD3;lG=#(*N?kn(%-+FMcN_Ums`Oawh1n!CC zpf2=6f>cXSIPe$Q;NEniDhgn@eql~J_g}0PKJtedXE`?R*c16c`ya%hmh^}wq^J`9 zXkNzJTgOhJ_%wuR$4WVF>pOj!!;3Ae)m!`TzLOn3R@%>k_LDm=%cML4PpjxX)&r(r z4rcQbRHe)Rs|}><0OvSLW=ETi+AH)4eRjX>F=Kg&~qRe!at z(mEA-d2RpU0g?SF!}Dx%GW5T?P<1A5X-d+C59;Z%BjMR4z6+1#Gv3U79Xk%3Bw%`% z_RbUiD>coB*f0y-7Z14Bp|w0J{AOQl?6$(@f8*cXuT2gTKX5|UY&&w27AQz_U1O|T z8s?Ry3#aHT`*4`7IER`VTV64u*~FFz=DOJ6ZXJG`#jmrDB$mMW>}F@nrzKFQnR%dZ zH~o-^N*+7?v4w-o&SmjI&R^yc59li%*!X(l&*j|%?%6Vy-3Bx`a5DIAav!hu zAiIb*w}723PUFr0mkR(aE^umGxHhka=b^$* z^5??}=iK$$ikXQhEo^{P{^ivb;wk2`HLvdQG}A%0)h|}|5qfZ*mA-@+&YNJQhXV(1 zX(fApR9@rMs>$d?<>XIIO+6$PI(SMIqI_*K@A&+tJwpF4FBU7#vi%)iDFzTMGT1~M zs|f#eve0i}x0x>1dZ zYx_HJctRm5oVY^fh+hMviD_A7@U|6&2xI>lIUdd8uWEN95Med6wcT>bAY}({Z3-X643D`G?0-YOo|zH;7h; z5Jrz=2o1n$!9-dbi1L|Rc;8u<0<9hdxW%siLh}940)@(QTkVdPcq(f!)eY@c0ktU2 zk56ZN8Cre?5O;LxrrL4(C5+Qk14<%l4`B{QedgC>A)iR23Chqon%|dyDqSv zZ?P;ke&8Jy6GO54R|0sDVIa;?88{7KT%_H;PU|CYUl0q=j7}WLjP0U58};6P;{^F)09x~NHcqQ*%d0b8O)`Ygi6fv35*U&p zag2aZ&NGCn11dyP9Af{5Lqacxf3AYxli|+dCz4ApK;NcBusRSBw>#3{N>*%W zl{I8uEA&m`Li0BcaouuR*R$A_rNfk_6@QPrS?;^#CV)**`XC$eUZa_*>AfmSV~6Ta zGtP6|zU{1pSW>CKHo2#y3k1Z<2H^nt(mce544!Q~wR_R00iaJ~gO?7|Ss}P7yqmLq zJjRxehv}Feyof5YUCp_6}^{H{QT@v+k@+22OJWsyeK49Ow)c~2Y0Fi`uckF*1EuU{Bq~;bp_UYv7pVPflrC4H@l)w$r~dBQzvz$ap1;B|PCaBU zewN3hGL=SR5-y~w+7X{?ckz=M;LHvt{DD5@&s7I6aolisMr0*R&}YzSsx=ThV{w8M z&;8gYkf+gpz%Rc%GCe&!7Ui3Fs#0oP*TiMNzu{6cse}1Xpq+SrInXNXtkd3+;@~f@a+YeW2Hzl5@Pu^!LtYd8J!L{=N3(5? z3VLMtzS3rrS!3P?bprh(nCK@;*rW?~*9Fq4xVgEP>17H3FHY$H>6ZR4OI{I2_n$LZ zkK5$6|58o~X!{BiZhSQ{+%-5GCZrovf*uK9@e_?$Vf%bl;|`UTA@?LDj$GlNp5ULH z;7=fq!deYKSP!RzuV5Z@$}*Sw$x)L?<`PGmPP{!d(^7s@`Kakr`M4Phj~al$&)h5E zHARpziwQvjB$zPQHS{--(Dt|8 z&hC8@nWF@E7IglrcZUZ2ost|+&cYl|{>8fA)#o!#kt!w;?^f=?M4huOB{sDoWvf#G zr;&=wPsK7-RdF&?g$6LrAsX+rA7w-A)HLq{?{kJ^<^{cvRHtj0&s>!z<=3)W;GOD9 z0d1GZS!tvog{v#$lEes1WjkFvdM(E7!1UG8OU6ZUYYWvwQ;Vs6q1p+&om}X?sx|Y} z>3Z>mEy(_B@cP>g$CoA=T_*3k0@LL7r`Ow+y20uRU?tLMGW7a5Ij4hlQLH8-tf}8c z34u7k55*yd(9`0nYmVvb^#T{om)#wT^6|yF7R3{Sh>(2z(W2^bM&qdHd%kzUA!o^>4SY1@HR|oIVd5NU)~wEeoeM>`l2nl(@Pq7 zJ!ju>XS;Nw8H;dt*uqt>F3DzkC7T6OmVLo$cRdh#@w-UM&gkVv(v9L9QXW$Iw|HxY zVzX_07Qba=jF}kDmGZ}d=(0b?O^gRgV_pD0Jy(fg-UG3k^4P z6tPaq-G)HGjrw8qqgZ5Umpx4=>7v4z;(k|24=&o|3YKhG%bGJZQWOMMQcVr*>|uba z(n~SiSdQ`C@s}XCnaM^Xr}p|sYUWwOG0CuDs||@fxUz$fvmm)&6bR;7pPP|8FW<$} z)$Ws!XwAReXaOuEB26#c{0`r3qm7SZ0pD`N!uP^EYsO_?Fhb&s&=E54+9+V~B^+7O zInN_71)~DXkTxrPCo0t8I1Ih|R^e7!EVQ!)s~c&@5B_%<|<6?7dE0NM^P&m zy-bmr3adlLh?^2dFGPqKc@yw-y}8o9niz{o%i;LL5G@I(=dI|#| z1?B@NGHYTZ{dB{@N~ISZyFO@nEUU(33qH(;UzyR9j4+TJzR+plLoWeTRU{PLcgsfA-~a5KhuS=lWWRoYdkO{-WLF>$rIQ9p+3D*T2kG@HuPf_` zH4Uh$4@gc%+RbogAWS4m7OQ327Jui(*#vWmRV5_X@ay6sY+aHBfLz@-0Ldj0AnMGj zD1NN7Rfnv~%%0g;M_XkGz_^KUWCO0oX2+M=>ashi45iy5_nTWYu>qCdiyW~1s4%eA zWl0cz=^VLZGc8_S3Ra@%n9um7rs%h4*iRXLI8U?X=7nb1u;4@97&jud1h_z{MslJ? z74GvUyyf~JRQjo(V`n?>Evw*iOX2Gc)2dKrh&Vc85&~~{r~H^yn9RuCo6IP`K#AB4 zy~w<_lWhCe(oGxISu+Rp(1lLukRnS+poaRpEzim#zxKzlE{I`KyeRXlV08n=9OVcv z;2-`Dtt5Zci3qXjJi4Sv7Zd4c7CSr9~sJoun~zyd?EEq zJ}r|Fl-79qC=L^hA|Suo3$Ijlrm=bolj$O!!5_A=tCC%pY32-ihN&k>Wf*r((}^R{#_`RwCXPql`&m}74;!wX9;npx(P$)TZ@Eth;f0+p3tsq+nzrWlX02d?*_A%p2bOu zvN8DdOvXjGY!jNB{4>~O`B3v59Y_&yseZVUGm7z090ehb3TN7+e^uD5vxKcNBWdu~ zDJN?&JYJ&?f5U`+@WL)JlG(d*{2erM3sRgb-$;j;Jh-(4-AI)wtV z82N4P9`xxliA^Rj-AZxHT@|=Nsp?~2zg;0|bv`&sKL`%Clz#>l$62LT{uuV?;-n~# zkLoq0WK-6fa0oYtJHL)_J3QYPD+r!I5^y~eHE$ygV*^3b)QyTU9-a^S8H5F&{RF)h zj+E#uVSs)50C{>r38U^Xy3r`8t=8g#^8fa+a2AI~z6tooLi@8ff8W%e-g?@dXKhr` zAUsy-ed58+qL-s>B}lG>9N{*c(1e9(=wsY0#XL7CLkC*fZ1yD{_DUy(1$%S@@pDd} zMsXf=Lz#q#&SyTCU=NrtK`!h#GnfD_#V~>TmL2*K(jV?39H35PGK9KQQlzWDK&s+8jeBk` zIf50g5buen-4>0rs#Q#@B0t2AUye7MFvhS&77-Mq-vzr-W-)i0{seS{Qv8swCP1`z z%Y-4ztWl%JL#P)$*WloP6c&Y$PP__&1T+fKnA8cw*cvL;cM*Sm71ql!5f@6zA-FJB zuQ%d8m1+l-`fT%gHE4)a&7t)os&n4Po3S19j_lXZyAKhEX81w z9kmYcd;YWe?0bJ0?Vu`hRLS&Hxc7A3GIbJL!HvikC6a{;1qu-e6RQHL0~!$dksGrz_Ke`?ULSaxa~AY?tP_{3Tj1at>v<+@GS}LKgV;2Hkm9aP z>w@H9fRw9Su8zqLij1wBxd=#CoMEQW7B@E|-mkK!i+shspIi4MeQ)s~)cO;WrB79qK44$eS@Bc;N$L z^KC)rnKi8QDF-OwIhqD()` zhD#6@x4Z}`%W+z9Z!UVhvBFTQ#lMqvm@WUdSta=U+V?|Kdi+mWY;^=p-z1+KP+F+e z1gP}P+1os(+SbBGL1UADL1UX49&D!pAE%x7k?$%3v4KzO5g}Gk$~jErcXUXx3yEvF z7ij^I1aH12w=jhCyMeUolw@qoILmh}{&Y3%Dhiy3AD}!Zec5OFkCOb3hXb zy|?cChacuoxLV_Eh>*6iD0Rkr_zDY&gW`YU^HK4Y2_LlOz4=|k8*>h*d3WyK!kixa ze1Vo7*Y10aX@L28f+bUI7q&~X*R6>~l|!vd(bKv{ZWhdo0{Hl@QBX=W7q>@zNM6fp z=*blf?h0#cNo?$h=##-}!2|NW6NepKYpEVaBd4#y5EnU>^kXJVYd?M>!Y=%WE87{DPZ zD1YgqO-KVI9vz`g4xMP)U#cEIrKh#k$3B}aoWctVSP5mJ+pGQ4Fs`{N!o&S4GV%?g zQMfFj!^=ieIZyEG3?!GUFIW~>8S}@5_aSSv2HaRv8Q{BVyvT~zLWLJDM}rIe*nOG0 z2;p>>d$$}C`gke_U^~zZ2^0tJ^C3?d>&KRtFl7S}^VTA;eRM>E0IcQXl6YtNSB^QA zg}yZO{b~}Vsb(^+Ng4h>^!WjAy^^2vzlkM6cC4WFG%-}rk%S2gCHbnn^$Oek$knBy z3~V?|DrlL;y@Q(oS>1zLY`Ic=1nVV)v<&MZX;Ik@)dz2X4wu!O{B8mXW?IM6ALZUy zjIMS@RfZCx>!seYSf9!UhvE2r;9QH?kWXmQ!Kd&2Xi#yjF$+qYtkkZgI2+C8+Rwb` zezaly*0@krp=Su4`p7;xBtL?n7L0u+)*Mf z99wP6BoJu?2v1pdSqNzcF0!cgSJ^Z^@;Vkv_V070W7}2j@UeH$Cejc-rEdL~^P(Qd zw85Bo5+T-3TeQuJ^Eh!2BLR1c^K^$B+yOG(DtW(Wvjwdd-kaEl1v@^H-h270^kmvs z+v~JJNa;wC1EFw_GQ}>DXNb$=@XpsWn?LHqmLvm|F0LOlfO?| zg7vVab_=KeF=6p^(tLjz!}08>_$99F;`Ok<4TBWF>l?}AZ-Q* zA`CC)c{9_yIAj`JpwnGlZm972qF!H}OTPm1BnA?Sa;5h34={i)v0?OZ0xfDBV7MS8 zSLAgS+RN~yKm_acw@{bNk>{gArFvcjP+W`Qb&>M;?fp$s$zZyN?^Y%z5Ka5*XVr?z+cs6l*AF;id`q(@xNg$93^bq)D|4IujS<~2LD`1Th=G*_g- z;%|{s4KH$Nm#kFCbVA!jaKJ&ZAhhcO@R+Hbd~W!yxSklWwEhXG(1%oHpkrMVSH}WgH)+Ubkbec;t4wRH*s0{r<24$)H${=kQ^ZAWG zOTofhaFKqP0U__VCfS@ZqoV9)JvO-%#ARv4-)k}_zn82hMm{5z3ZBD2UcC_?OTp&G zFA1|o*;<2zn22ZSP;qS2LSNL8dkNWR06b~s%NcDo-WJ!yKJoHALE!M~gH?~xe)gNENmeC%fhYKx)y2sWrZ{18 zhT;=kpERMSy_Yby;lIzDFagM*F%n38Jvv}1b-of}A@bUdl&JenL=>mx0`Ri5eBuwj zRLDkyWgj5zqX-6qp>y-RUmx2E|HyRO_QMFlM}ttgObi6#RIXKlS%ef3V<)X8LWFo% z{Po9Nps?R+niP~=VIC*o>JoqC^#}cy>|ZKSRU4@EoHF-CK*dr+EPBA|LIBnT@r)Oe+a?Sv`+dFwA-9f3=`E#FOd#IEQjuxz@9Ns@FF_fKOwB&dnysm* zr73P81%U1V0gCRAW;Q($u=3u^N#l7>40GWg080{|F0Nq62Y*eU^YJ z<)23@unp;n&Pl}Qe?XusIQ3CBfW{j%QL3)CX+r%4`F)Bf!Saj0wNYbdh0mKrw7i^+ zj5k?egRwnYYsh$%FDgIf7xH7=)7Abruc_KKfVQV3!&#?b{1V(=^4$nRT8aylz*N+_ zhWYbCLhP2ihQHvNaG>7(`> z8<)aFSy$d4bnBMRAZfRW>J>}$nNgwnCakh5{4W-h6Bba}`|RL7|GPn~q4*mYO_XJf zihJJq_s5~|I9h~-%GCnJqNw)LpZqY6xU6h$u&xlAQ!U3YRf+7lB zygIAWLv0khw1?DhWWU3lUj#Sou;U5Va9t~`(|C)cfCWTAm5Tzi1__dsLgDH0m)X^J zEe;EzwYoA2Qyj{Pky4_75I~!7k?yGTB&JF(X%a4SnouIq8!t?Cc|qW+5T9 z`QeXlb;#nT%^B2`!t1#0C*b5F7oMpg-o)-y^m>Qn86JGdk#G z_a<>AkidPWms^~h%cdZ&v<}Q{Y!Ggz-+5!R3?H3uJ4w!og20*1gHPX^-bnwAiJob3 zb0unV`-KaQMLf-`f|Pd|%zubIzx*EFULuX2p`~6N<SgI_Aegue<-KOe&yZG zsBV}aih)qrZzM}7Q?0gHD`Fw%WYW0~ofN7>ra)S#xZ39TB;P7eSOJnzAXUsDM8*%x zsec)3e&6^tC~;!nt(yECO%_Wrp@9^ZCeoX^zOjb76jpH6z*^gqTxJO-${OUdo0q{`@8 zA#GtBM}<{V^+)j^#ZY6fd;dXJfz+lcIwt0t7nRYNHYx+I&G$QbHB~y3VEzvP)Re(Y zl=^Foy#Fe-@$x+L{zV;Wz;7vFv9ya70gx}oO$iw%&G-;V1f=pBH84?47}xYLf0_+E z{_p(>Fo_XK(yVdmck+?Lod%WI6Myf2j`P0F?He*VHZnB@q!0PtW`A6#IG7PT*>%OL zDoa`X_5TDG5b5t9CES-~Wc^fn*Zah`bK&zBCu#T?ZH}w1W>F4?J zw&J@^@9~=f`flC2{fUn4Y&zEK>E1t2$NHA?_VbxCNliH)|F>ixDCatg-;(J3Pg48P z<#H9N+BqAY>;9tK-heL0I{eGOlan9p@to;3>0t59o zsJ%bREbdgt5wIob*$bh6f3M=k|H9ru;{G~z>{uB00#r31j@y=}8}#wF7+=(gERW)1 z=}03$AAj)pUlr&q<5PL3agS8@x&6%Epqe)^rCo_`|NiubOr#zrWc_@l*1Izb^z>l9 z%!Kp#p8CoqqHhr*4j;cY30#wl#b!c#4o&#Z-vykSc^VweJ_3ERhwVU5PpAXv=N~lO z^k3;Fbyjxgpnp%$*m!>98<{T969jKHa)zc+pr;NsR4}IfMiQ^?IKj6oHMWQ!9)kC( zui!RUq`M%QNuXEWRQy+D3Fs9k&);3}Ttoo9o*9(HgZ=|QFa^BxUTxgd>QwCEHy@Rt zPc;u@OH263HlUBkeC2qY<|jO#l-N@)sV(c=xqKI^K~I1Cu+bgC2++sJH-z^&p`DI? ztP*!Op|eZx(|!M=KpT8VYZ(mx1l8tCQD-`03ohJs#xyQA%&Cg@0w5ZKp zof+?eZS9*gzTyM?N%#G^=wP#w!kg+mF1I7-ZDi5{t3Y2|TzW`L`ke;bW-{p2Ubl&D z-21UwLJS&ao%Tusn!^RRvtD#SE)AgnH9iwt&USji=aZhK&)yu8;%pqHX3s{^>m^c2 z(`3;97SFWtO;J4M{>u40tV~9$N;Ls(M=R|pc5O>L3dGBoCl2;1GpRomXoKC7UkCY~ zr8Y-zK2vP&+H^x)${MXRMxk?!b{6$Mma3$5OrxJn~BRW}zQ{t=uy^{7R z3bVCzJszVDcuGqa1$zqdu?@*X+ZxTU<`#gSvtPbeyrZoNZ&Z_7#pO>Fz22NUN*%sa z%gRmM(Kv@)Nf{J5rd91_8I_dy|0j41wRtvB0_eFPjN{jSk*pc+*qpr~27KS}G=P4y zk{az1i5{_~>EqG#{G@ps(WGTn>fo7#5L% z(2s0LtNT7)>;dL`zP(pgI-d>G|}I#6v@JA2YfdRdi2k!7(9Ph>l+cj z>6qW=xF%2Xdz$J&VyBt0BJ*n4V^+~WPEOT-m2k~s0jKaX6)f}!Y_BB6HYTRn#@A^H zL5hPuxkn}HA*PzRBM8_5W`kaELd?3-($f8mz9(uxPuJ@ywcC%+HcY*3QO|>p;a-sk zd|MM~;_JQ&o$G_y0(y}Q5uVwdDWH#sEY%O9rnrZX>K~W#jaJw1id_QBR8}Sn&v9vv z6yJX)T`@<$V7TP$6gTE^F)&G;QoP!Vcz7et1U`slpSYUR|m@cxvE2 zEg2+6f?jlhkOyAV3wmvN<$^0WO;EYb&$Q$si>0Eed#G9k`gkEW-}$^?xl+Pmi-B2E z*IEtw_|lDX=F1=@EV9X{^Wir)we3_XBd}G&{(ejKM%4Z_C_PMIP_~`%rsR_sIV_#d zECRp4Kw2dAlhEHwq|S@LYi%bZM)CE4p8l^)WO5689q9zU=wy^O&QHWsdRS#UnjzrP z57l_BRlSCr4SJ>CQBQ%~YaI)r`0ln4^bYF35_`esrA2FYN_wlmcG6&-V<`1%$D8== zS73Je{k8@@XLJa}>8=t<(-Q#wCFuseQtlvS(KfU0i6H2IX-Rj~(2&0nc!*r5ZkxVW zwA?qvgB0n&^Xvfn_zZ8~91G@*+;0Wwm4W#xv(JaK&9sKY#Ai;&GnPbW&nM~sl0g4B zsuj0RP4$++VKAG6J~dc5rl@BMbHYWw!Ui6FKdo6L7J~kJ?Sp422aLEOm#W<6KrP@= z;`>770YtN#2rBm}b3Izy7CoTn)H(~-vNav_NcT&f9IbMw+EwPlKRf_{R)cDmXC^nC@wS&eB1{U(C=7}UM288H@XJ5SgGW;AM~`ZS%Mw;<#d5wsg5W*IJrhChcJNav$ruZ zYj(OpuVl4|)=FB>vr85D-PQVhM9N!h1--HlwRN=y>Ic2=D1r3j^AZMdQ_Vrz3!t~1 zM=w_BO>2zY2B2Rg&@mrVxy>4ZL9!QhjETt02kKeLN)PDcX@p`kiBo5m`JYQS=tbvJ za4K`EYc5iiRtxAkrY#a?Y^(N=5wlNIjSbMTy(TtbEX~MEw*dM!kKr66i#6F0^pyf0 z{Zy5MvEK+>vp(%W>+hoFCfa*gm<@U*#;?1kin6Uy=?1-0s4Ug_gz^L`Hu9T`(V*wB z2=SspPf2qFmbXk*27IHk9O}FjVH+PnZ$r>4<$FcIGb$57uMAeE3_pktesbL&!F14b zlH9M^f*trbuFqmU=ta^;{g(gk6{M$)=e zX|O437i~1_%^#r8Go%DUSS*)bY{74PdGy}X1;KooV5bx)@#^1}ETqBf0;{Q@nruB{ zlRWx&1-^T-;Jy7N-Jlm47vYJ60{wL_o=|Bd=oQByRfg0mvA0O^Rq5JEGDuafBE@k^ zWAp4FfWF=Di>@lQNbM^kdw$&E(*=5EAa1?LM7dPe`jjOmHwxVQ27v)xHLvPi@4vUY zwP|&E^b3r5FtV3vhpZcc<@1ErH09bYMrPe8<&PH$Y_m*o3Bu(ftDLppSLF(sIwrm) zFZlw{rycb2a$uq>Yc1ij#scSdIA2R6*NoK>e|%YRM&q09rK@piTV?8h%!n|6(y6wo zt!cvLH@P){l)Gn3S9_W>I1cavg zw?0>n(JB=le^qfTrh;B@oQCa%)-mRIl}7pd!mEvmfL^4wJ!j!0z75C6(^8kBNL3^* z1(SMeY>z|o>>_|ZX^3NA!CLESSsYyNy;o6lUuWGGf3b?ga%f!Q&=6}M^m6es(e12O zW}J>uLL^$2qck~2FF&kRJV538FJtIl&J+pzsRg~VB;Znkwsb=q4w=Z}-Yc~(uEHyb zX-V_svIqcu27q4aP#0@lD$(|!k5BcMyU>gxUSw_ozp1rXI$L1D4}M5Y*Ac!Mrt+G6nkTrJI6!X$&@0#IT9vQe83Fo) z`1KbifwNxCU}+m*ec3Lc7wsz|uoB5Tx1t1slIirD&U0Eq5Pw7u=u1lcX9@JL%^r{E z(Dt^$HR46yzIo|NjhSlyR(W0e<=II9y>OhatHxP+wg!C*>{Se^iiT^Z>a8NETz6kQ zmCp3=QX`MAq?$XRB5S5C`#53UU|UqL6wR7xuilH2v~a&x(0A$5V|S5~93u7X;|tcO z4nrl&cuR4umWV&lcU}`4pw9r%#{pdS55eq6e31$cD+$*1*~#-I3hl3AVAm4R$5+MjJ+I+>KA<;(gOt9e8T54hhl`{z zi)OEIg(NT26IcD4gOdnk0l_e^FYQ+VyR zomAUsYoThjil>>$b#Z#fQ!#y0lO787!_E_R6gQXos%ct^yQ>x?FTgOAh)8jhe zeC&K~@xf7f!3{pQdiwWU^!XB3`lOC{g4F|09FyfdZhpA%>QhPyg@p;%zJ?r&Nj!)a zPjB^INDt7z7W%9~+yKTJ*avU(s0f*>1+XS}DHwX0{`2ZA67N~4rSfE0t(zTvo15ClOs z7Z0RzMi!e=gzhe7AUf4#tY0NbItEt|f*{D|;u7N8(sreZxOxx-LD>uXO + {% if help_links %} +

microGalaxy community support

+ + {% endif %} + + +
+

News and Events

+ +
+
+ +
+
+ +
+
+
--> + +{% if feedback_email %} +
+

What do you think of the {{ lab_name }}?

+ +
+{% endif %} + + +
+ {{ conclusion_extra_md|safe }} +
diff --git a/communities/microgalaxy/lab/templates/footer.html b/communities/microgalaxy/lab/templates/footer.html new file mode 100644 index 00000000..e69de29b diff --git a/communities/microgalaxy/lab/templates/intro.html b/communities/microgalaxy/lab/templates/intro.html new file mode 100644 index 00000000..625c1d4d --- /dev/null +++ b/communities/microgalaxy/lab/templates/intro.html @@ -0,0 +1,45 @@ +
+

+ Welcome to the Galaxy {{ site_name }} {{ lab_name }}! +

+ +

+ Whether you are analysing microbiome samples or bacterial isolates, long reads or short, shotgun or 16S, genomics, transcriptomics, proteomics or metabolomics, multiomics or integrative analysis this is the place to be! +

+

+ + How does this page relate to Galaxy {{ site_name }}? + +

+ + {{ intro_extra_md }} + + +
diff --git a/communities/microgalaxy/lab/tool_panel/hca-scanpy.yml b/communities/microgalaxy/lab/tool_panel/hca-scanpy.yml new file mode 100644 index 00000000..30e12240 --- /dev/null +++ b/communities/microgalaxy/lab/tool_panel/hca-scanpy.yml @@ -0,0 +1,16 @@ +tool_panel_section_label: HCA-Scanpy +tools: +- name: seurat_plot + owner: ebi-gxa +- name: scanpy_integrate_bbknn + owner: ebi-gxa +- name: scanpy_integrate_combat + owner: ebi-gxa +- name: scanpy_integrate_mnn + owner: ebi-gxa +- name: scanpy_plot_scrublet + owner: ebi-gxa +- name: scanpy_multiplet_scrublet + owner: ebi-gxa +- name: seurat_run_umap + owner: ebi-gxa diff --git a/communities/microgalaxy/lab/tool_panel/hca-scanpy.yml.lock b/communities/microgalaxy/lab/tool_panel/hca-scanpy.yml.lock new file mode 100644 index 00000000..62bc2659 --- /dev/null +++ b/communities/microgalaxy/lab/tool_panel/hca-scanpy.yml.lock @@ -0,0 +1,47 @@ +install_repository_dependencies: true +install_resolver_dependencies: false +install_tool_dependencies: false +tool_panel_section_label: HCA-Scanpy +tools: +- name: seurat_plot + owner: ebi-gxa + revisions: + - 95d79f1134f0 + tool_panel_section_id: hca_scanpy + tool_panel_section_label: HCA-Scanpy +- name: scanpy_integrate_bbknn + owner: ebi-gxa + revisions: + - c9da9192eee5 + tool_panel_section_id: hca_scanpy + tool_panel_section_label: HCA-Scanpy +- name: scanpy_integrate_combat + owner: ebi-gxa + revisions: + - 3c47bc560688 + tool_panel_section_id: hca_scanpy + tool_panel_section_label: HCA-Scanpy +- name: scanpy_integrate_mnn + owner: ebi-gxa + revisions: + - ff6decc0f432 + tool_panel_section_id: hca_scanpy + tool_panel_section_label: HCA-Scanpy +- name: scanpy_plot_scrublet + owner: ebi-gxa + revisions: + - 6f5509cf3176 + tool_panel_section_id: hca_scanpy + tool_panel_section_label: HCA-Scanpy +- name: scanpy_multiplet_scrublet + owner: ebi-gxa + revisions: + - 53ce0e336840 + tool_panel_section_id: hca_scanpy + tool_panel_section_label: HCA-Scanpy +- name: seurat_run_umap + owner: ebi-gxa + revisions: + - b9424c715a0d + tool_panel_section_id: hca_scanpy + tool_panel_section_label: HCA-Scanpy diff --git a/communities/microgalaxy/lab/tool_panel/hicexplorer.yml b/communities/microgalaxy/lab/tool_panel/hicexplorer.yml new file mode 100644 index 00000000..7c94a0de --- /dev/null +++ b/communities/microgalaxy/lab/tool_panel/hicexplorer.yml @@ -0,0 +1,120 @@ +tool_panel_section_label: HiCExplorer +tools: +- name: hicexplorer_chicaggregatestatistic + owner: bgruening +- name: hicexplorer_chicdifferentialtest + owner: bgruening +- name: hicexplorer_chicexportdata + owner: bgruening +- name: hicexplorer_chicplotviewpoint + owner: bgruening +- name: hicexplorer_chicqualitycontrol + owner: bgruening +- name: hicexplorer_chicsignificantinteractions + owner: bgruening +- name: hicexplorer_chicviewpoint + owner: bgruening +- name: hicexplorer_chicqualitycontrol + owner: bgruening +- name: hicexplorer_chicsignificantinteractions + owner: bgruening +- name: hicexplorer_chicviewpoint + owner: bgruening +- name: hicexplorer_chicviewpointbackgroundmodel + owner: bgruening +- name: hicexplorer_hicadjustmatrix + owner: bgruening +- name: hicexplorer_hicaggregatecontacts + owner: bgruening +- name: hicexplorer_hicaverageregions + owner: bgruening +- name: hicexplorer_hicbuildmatrix + owner: bgruening +- name: hicexplorer_hiccomparematrices + owner: bgruening +- name: hicexplorer_hiccompartmentspolarization + owner: bgruening +- name: hicexplorer_hicconvertformat + owner: bgruening +- name: hicexplorer_hiccorrectmatrix + owner: bgruening +- name: hicexplorer_hiccorrelate + owner: bgruening +- name: hicexplorer_hicdetectloops + owner: bgruening +- name: hicexplorer_hicdifferentialtad + owner: bgruening +- name: hicexplorer_hicfindrestrictionsites + owner: bgruening +- name: hicexplorer_hicfindtads + owner: bgruening +- name: hicexplorer_hichyperoptdetectloops + owner: bgruening +- name: hicexplorer_hicinfo + owner: bgruening +- name: hicexplorer_hicinterintratad + owner: bgruening +- name: hicexplorer_hicmergedomains + owner: bgruening +- name: hicexplorer_hicmergeloops + owner: bgruening +- name: hicexplorer_hicmergematrixbins + owner: bgruening +- name: hicexplorer_hicnormalize + owner: bgruening +- name: hicexplorer_hicpca + owner: bgruening +- name: hicexplorer_hicplotaverageregions + owner: bgruening +- name: hicexplorer_hicplotdistvscounts + owner: bgruening +- name: hicexplorer_hicplotmatrix + owner: bgruening +- name: hicexplorer_hicplotsvl + owner: bgruening +- name: hicexplorer_hicplotviewpoint + owner: bgruening +- name: hicexplorer_hicquickqc + owner: bgruening +- name: hicexplorer_hicsummatrices + owner: bgruening +- name: hicexplorer_hictadclassifier + owner: bgruening +- name: hicexplorer_hictraintadclassifier + owner: bgruening +- name: hicexplorer_hictransform + owner: bgruening +- name: hicexplorer_hicvalidatelocations + owner: bgruening +- name: schicexplorer_schicadjustmatrix + owner: iuc +- name: schicexplorer_schiccluster + owner: iuc +- name: schicexplorer_schicclustercompartments + owner: iuc +- name: schicexplorer_schicclusterminhash + owner: iuc +- name: schicexplorer_schicclustersvl + owner: iuc +- name: schicexplorer_schicconsensusmatrices + owner: iuc +- name: schicexplorer_schiccorrectmatrices + owner: iuc +- name: schicexplorer_schiccreatebulkmatrix + owner: iuc +- name: schicexplorer_schicdemultiplex + owner: iuc +- name: schicexplorer_schicinfo + owner: iuc +- name: schicexplorer_schicmergematrixbins + owner: iuc +- name: schicexplorer_schicmergetoscool + owner: iuc +- name: schicexplorer_schicnormalize + owner: iuc +- name: schicexplorer_schicplotclusterprofiles + owner: iuc +- name: schicexplorer_schicplotconsensusmatrices + owner: iuc +- name: schicexplorer_schicqualitycontrol + owner: iuc diff --git a/communities/microgalaxy/lab/tool_panel/hicexplorer.yml.lock b/communities/microgalaxy/lab/tool_panel/hicexplorer.yml.lock new file mode 100644 index 00000000..a86a55c1 --- /dev/null +++ b/communities/microgalaxy/lab/tool_panel/hicexplorer.yml.lock @@ -0,0 +1,359 @@ +install_repository_dependencies: true +install_resolver_dependencies: false +install_tool_dependencies: false +tool_panel_section_label: HiCExplorer +tools: +- name: hicexplorer_chicaggregatestatistic + owner: bgruening + revisions: + - 01c37e54e86e + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: hicexplorer_chicdifferentialtest + owner: bgruening + revisions: + - 9d42a6133690 + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: hicexplorer_chicexportdata + owner: bgruening + revisions: + - 23b8d6b8960c + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: hicexplorer_chicplotviewpoint + owner: bgruening + revisions: + - 013e53ccc7ac + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: hicexplorer_chicqualitycontrol + owner: bgruening + revisions: + - b892fa1fcaec + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: hicexplorer_chicsignificantinteractions + owner: bgruening + revisions: + - 640e0e45518a + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: hicexplorer_chicviewpoint + owner: bgruening + revisions: + - f881c94fb3b3 + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: hicexplorer_chicqualitycontrol + owner: bgruening + revisions: + - b892fa1fcaec + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: hicexplorer_chicsignificantinteractions + owner: bgruening + revisions: + - 640e0e45518a + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: hicexplorer_chicviewpoint + owner: bgruening + revisions: + - f881c94fb3b3 + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: hicexplorer_chicviewpointbackgroundmodel + owner: bgruening + revisions: + - 9d02f1819e81 + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: hicexplorer_hicadjustmatrix + owner: bgruening + revisions: + - 2dccb6bb0add + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: hicexplorer_hicaggregatecontacts + owner: bgruening + revisions: + - f0216498a666 + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: hicexplorer_hicaverageregions + owner: bgruening + revisions: + - c72fa6cb8817 + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: hicexplorer_hicbuildmatrix + owner: bgruening + revisions: + - ed2cca6b5de4 + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: hicexplorer_hiccomparematrices + owner: bgruening + revisions: + - 3ee5332bf57c + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: hicexplorer_hiccompartmentspolarization + owner: bgruening + revisions: + - 3a6a5381db36 + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: hicexplorer_hicconvertformat + owner: bgruening + revisions: + - c0737631eea1 + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: hicexplorer_hiccorrectmatrix + owner: bgruening + revisions: + - ea19190ce5e0 + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: hicexplorer_hiccorrelate + owner: bgruening + revisions: + - 2b4d6a8dab36 + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: hicexplorer_hicdetectloops + owner: bgruening + revisions: + - 0410b6aada45 + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: hicexplorer_hicdifferentialtad + owner: bgruening + revisions: + - 77d8e0fd162a + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: hicexplorer_hicfindrestrictionsites + owner: bgruening + revisions: + - 6c5097f6d41e + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: hicexplorer_hicfindtads + owner: bgruening + revisions: + - ec4b948dc6f0 + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: hicexplorer_hichyperoptdetectloops + owner: bgruening + revisions: + - 7f7c6ead2d0d + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: hicexplorer_hicinfo + owner: bgruening + revisions: + - e4f8fceab96a + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: hicexplorer_hicinterintratad + owner: bgruening + revisions: + - 55b013e59018 + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: hicexplorer_hicmergedomains + owner: bgruening + revisions: + - b376ef118807 + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: hicexplorer_hicmergeloops + owner: bgruening + revisions: + - 1511a8ebe906 + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: hicexplorer_hicmergematrixbins + owner: bgruening + revisions: + - 977dc15add20 + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: hicexplorer_hicnormalize + owner: bgruening + revisions: + - 6d042c96aceb + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: hicexplorer_hicpca + owner: bgruening + revisions: + - 77919cc3618e + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: hicexplorer_hicplotaverageregions + owner: bgruening + revisions: + - ea5d67ec94ab + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: hicexplorer_hicplotdistvscounts + owner: bgruening + revisions: + - 6326cd29c1c3 + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: hicexplorer_hicplotmatrix + owner: bgruening + revisions: + - b63363075c2e + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: hicexplorer_hicplotsvl + owner: bgruening + revisions: + - b4e780e93c91 + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: hicexplorer_hicplotviewpoint + owner: bgruening + revisions: + - 58de3c7c8e89 + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: hicexplorer_hicquickqc + owner: bgruening + revisions: + - 21d859ad4502 + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: hicexplorer_hicsummatrices + owner: bgruening + revisions: + - 36dfa2825a59 + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: hicexplorer_hictadclassifier + owner: bgruening + revisions: + - 887d203233e5 + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: hicexplorer_hictraintadclassifier + owner: bgruening + revisions: + - 1ff19476c5a5 + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: hicexplorer_hictransform + owner: bgruening + revisions: + - f36828ebdc54 + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: hicexplorer_hicvalidatelocations + owner: bgruening + revisions: + - 1d201e8378b3 + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: schicexplorer_schicadjustmatrix + owner: iuc + revisions: + - 2e773e00ceb0 + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: schicexplorer_schiccluster + owner: iuc + revisions: + - baa3ae7ac42c + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: schicexplorer_schicclustercompartments + owner: iuc + revisions: + - 54b6cef88a7f + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: schicexplorer_schicclusterminhash + owner: iuc + revisions: + - 3048283ee054 + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: schicexplorer_schicclustersvl + owner: iuc + revisions: + - e6ec3914a076 + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: schicexplorer_schicconsensusmatrices + owner: iuc + revisions: + - 33b1c99cc709 + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: schicexplorer_schiccorrectmatrices + owner: iuc + revisions: + - 295558e266d0 + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: schicexplorer_schiccreatebulkmatrix + owner: iuc + revisions: + - acb3ed49109e + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: schicexplorer_schicdemultiplex + owner: iuc + revisions: + - f224fc9af1d3 + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: schicexplorer_schicinfo + owner: iuc + revisions: + - 41b415c410e3 + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: schicexplorer_schicmergematrixbins + owner: iuc + revisions: + - 47ef02546fe9 + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: schicexplorer_schicmergetoscool + owner: iuc + revisions: + - 70a13d0a950f + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: schicexplorer_schicnormalize + owner: iuc + revisions: + - 66e96c3d3c5d + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: schicexplorer_schicplotclusterprofiles + owner: iuc + revisions: + - 65f2f5d29947 + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: schicexplorer_schicplotconsensusmatrices + owner: iuc + revisions: + - 95b1216e1e70 + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer +- name: schicexplorer_schicqualitycontrol + owner: iuc + revisions: + - 4a841ab67e3b + tool_panel_section_id: hicexplorer + tool_panel_section_label: HiCExplorer diff --git a/communities/microgalaxy/lab/tool_panel/import.yml b/communities/microgalaxy/lab/tool_panel/import.yml new file mode 100644 index 00000000..f87138d9 --- /dev/null +++ b/communities/microgalaxy/lab/tool_panel/import.yml @@ -0,0 +1,8 @@ +tool_panel_section_label: Import/manipulate sc data +tools: +- name: 10x_bamtofastq + owner: bgruening +- name: scater_read_10x_results + owner: ebi-gxa +- name: gsc_scran_normalize + owner: artbio diff --git a/communities/microgalaxy/lab/tool_panel/import.yml.lock b/communities/microgalaxy/lab/tool_panel/import.yml.lock new file mode 100644 index 00000000..8b5f8cd3 --- /dev/null +++ b/communities/microgalaxy/lab/tool_panel/import.yml.lock @@ -0,0 +1,23 @@ +install_repository_dependencies: true +install_resolver_dependencies: false +install_tool_dependencies: false +tool_panel_section_label: Import/manipulate sc data +tools: +- name: 10x_bamtofastq + owner: bgruening + revisions: + - f71fd828c126 + tool_panel_section_id: import_manipulate_sc_data + tool_panel_section_label: Import/manipulate sc data +- name: scater_read_10x_results + owner: ebi-gxa + revisions: + - da3f394039b5 + tool_panel_section_id: import_manipulate_sc_data + tool_panel_section_label: Import/manipulate sc data +- name: gsc_scran_normalize + owner: artbio + revisions: + - 6864acb21714 + tool_panel_section_id: import_manipulate_sc_data + tool_panel_section_label: Import/manipulate sc data diff --git a/communities/microgalaxy/lab/tool_panel/multiomics.yml b/communities/microgalaxy/lab/tool_panel/multiomics.yml new file mode 100644 index 00000000..e305aae5 --- /dev/null +++ b/communities/microgalaxy/lab/tool_panel/multiomics.yml @@ -0,0 +1,4 @@ +tool_panel_section_label: Multiomics +tools: +- name: episcanpy_cluster_embed + owner: iuc diff --git a/communities/microgalaxy/lab/tool_panel/multiomics.yml.lock b/communities/microgalaxy/lab/tool_panel/multiomics.yml.lock new file mode 100644 index 00000000..467ea6c6 --- /dev/null +++ b/communities/microgalaxy/lab/tool_panel/multiomics.yml.lock @@ -0,0 +1,11 @@ +install_repository_dependencies: true +install_resolver_dependencies: false +install_tool_dependencies: false +tool_panel_section_label: Multiomics +tools: +- name: episcanpy_cluster_embed + owner: iuc + revisions: + - f4713992f23a + tool_panel_section_id: multiomics + tool_panel_section_label: Multiomics diff --git a/communities/microgalaxy/lab/tool_panel/sccaf.yml b/communities/microgalaxy/lab/tool_panel/sccaf.yml new file mode 100644 index 00000000..45909169 --- /dev/null +++ b/communities/microgalaxy/lab/tool_panel/sccaf.yml @@ -0,0 +1,10 @@ +tool_panel_section_label: SCCAF +tools: +- name: run_sccaf + owner: ebi-gxa +- name: sccaf_asses + owner: ebi-gxa +- name: sccaf_asses_merger + owner: ebi-gxa +- name: sccaf_regress_out + owner: ebi-gxa diff --git a/communities/microgalaxy/lab/tool_panel/sccaf.yml.lock b/communities/microgalaxy/lab/tool_panel/sccaf.yml.lock new file mode 100644 index 00000000..49c80525 --- /dev/null +++ b/communities/microgalaxy/lab/tool_panel/sccaf.yml.lock @@ -0,0 +1,29 @@ +install_repository_dependencies: true +install_resolver_dependencies: false +install_tool_dependencies: false +tool_panel_section_label: SCCAF +tools: +- name: run_sccaf + owner: ebi-gxa + revisions: + - 647d34f125bc + tool_panel_section_id: sccaf + tool_panel_section_label: SCCAF +- name: sccaf_asses + owner: ebi-gxa + revisions: + - 37a4c22f600b + tool_panel_section_id: sccaf + tool_panel_section_label: SCCAF +- name: sccaf_asses_merger + owner: ebi-gxa + revisions: + - 99d15ded4d5f + tool_panel_section_id: sccaf + tool_panel_section_label: SCCAF +- name: sccaf_regress_out + owner: ebi-gxa + revisions: + - 5ef0610e9f50 + tool_panel_section_id: sccaf + tool_panel_section_label: SCCAF diff --git a/communities/microgalaxy/lab/tool_panel/seurat.yml b/communities/microgalaxy/lab/tool_panel/seurat.yml new file mode 100644 index 00000000..0b95e939 --- /dev/null +++ b/communities/microgalaxy/lab/tool_panel/seurat.yml @@ -0,0 +1,28 @@ +tool_panel_section_label: Seurat +tools: +- name: seurat_create_seurat_object + owner: ebi-gxa +- name: seurat_export_cellbrowser + owner: ebi-gxa +- name: seurat_filter_cells + owner: ebi-gxa +- name: seurat_find_clusters + owner: ebi-gxa +- name: seurat_find_markers + owner: ebi-gxa +- name: seurat_find_neighbours + owner: ebi-gxa +- name: seurat_find_variable_genes + owner: ebi-gxa +- name: seurat_normalise_data + owner: ebi-gxa +- name: seurat_dim_plot + owner: ebi-gxa +- name: seurat_read10x + owner: ebi-gxa +- name: seurat_run_pca + owner: ebi-gxa +- name: seurat_run_tsne + owner: ebi-gxa +- name: seurat_scale_data + owner: ebi-gxa diff --git a/communities/microgalaxy/lab/tool_panel/seurat.yml.lock b/communities/microgalaxy/lab/tool_panel/seurat.yml.lock new file mode 100644 index 00000000..cf910f55 --- /dev/null +++ b/communities/microgalaxy/lab/tool_panel/seurat.yml.lock @@ -0,0 +1,83 @@ +install_repository_dependencies: true +install_resolver_dependencies: false +install_tool_dependencies: false +tool_panel_section_label: Seurat +tools: +- name: seurat_create_seurat_object + owner: ebi-gxa + revisions: + - f8865ae30723 + tool_panel_section_id: seurat + tool_panel_section_label: Seurat +- name: seurat_export_cellbrowser + owner: ebi-gxa + revisions: + - 36221da750e8 + tool_panel_section_id: seurat + tool_panel_section_label: Seurat +- name: seurat_filter_cells + owner: ebi-gxa + revisions: + - cd9f564bd63f + tool_panel_section_id: seurat + tool_panel_section_label: Seurat +- name: seurat_find_clusters + owner: ebi-gxa + revisions: + - d541e9e62beb + tool_panel_section_id: seurat + tool_panel_section_label: Seurat +- name: seurat_find_markers + owner: ebi-gxa + revisions: + - 07fc9f4841b3 + tool_panel_section_id: seurat + tool_panel_section_label: Seurat +- name: seurat_find_neighbours + owner: ebi-gxa + revisions: + - ba897c57bdd9 + tool_panel_section_id: seurat + tool_panel_section_label: Seurat +- name: seurat_find_variable_genes + owner: ebi-gxa + revisions: + - 948fc0276b4f + tool_panel_section_id: seurat + tool_panel_section_label: Seurat +- name: seurat_normalise_data + owner: ebi-gxa + revisions: + - 3f49bc9c9213 + tool_panel_section_id: seurat + tool_panel_section_label: Seurat +- name: seurat_dim_plot + owner: ebi-gxa + revisions: + - 64174ac50d78 + tool_panel_section_id: seurat + tool_panel_section_label: Seurat +- name: seurat_read10x + owner: ebi-gxa + revisions: + - f5db0e853f57 + tool_panel_section_id: seurat + tool_panel_section_label: Seurat +- name: seurat_run_pca + owner: ebi-gxa + revisions: + - 8ded486b0014 + tool_panel_section_id: seurat + tool_panel_section_label: Seurat +- name: seurat_run_tsne + owner: ebi-gxa + revisions: + - 0db997e4a81d + tool_panel_section_id: seurat + tool_panel_section_label: Seurat +- name: seurat_scale_data + owner: ebi-gxa + revisions: + - 5e9ba303f9e1 + tool_panel_section_id: seurat + tool_panel_section_label: Seurat diff --git a/communities/microgalaxy/lab/tool_panel/single_cell.yml b/communities/microgalaxy/lab/tool_panel/single_cell.yml new file mode 100644 index 00000000..a8a11fed --- /dev/null +++ b/communities/microgalaxy/lab/tool_panel/single_cell.yml @@ -0,0 +1,136 @@ +tool_panel_section_label: Single-cell +tools: +- name: scanpy_plot + owner: iuc +- name: scanpy_inspect + owner: iuc +- name: scanpy_filter + owner: iuc +- name: scanpy_normalize + owner: iuc +- name: scanpy_cluster_reduce_dimension + owner: iuc +- name: scanpy_remove_confounders + owner: iuc +- name: anndata_export + owner: iuc +- name: anndata_import + owner: iuc +- name: anndata_inspect + owner: iuc +- name: anndata_manipulate + owner: iuc +- name: modify_loom + owner: iuc +- name: dropletutils + owner: iuc +- name: raceid_clustering + owner: iuc +- name: raceid_filtnormconf + owner: iuc +- name: raceid_inspectclusters + owner: iuc +- name: raceid_inspecttrajectory + owner: iuc +- name: raceid_trajectory + owner: iuc +- name: scanpy_filter_cells + owner: ebi-gxa +- name: scanpy_filter_genes + owner: ebi-gxa +- name: scanpy_normalise_data + owner: ebi-gxa +- name: scanpy_find_variable_genes + owner: ebi-gxa +- name: scanpy_scale_data + owner: ebi-gxa +- name: scanpy_run_pca + owner: ebi-gxa +- name: scanpy_compute_graph + owner: ebi-gxa +- name: scanpy_run_tsne + owner: ebi-gxa +- name: scanpy_run_umap + owner: ebi-gxa +- name: scanpy_find_cluster + owner: ebi-gxa +- name: scanpy_find_markers + owner: ebi-gxa +- name: scanpy_plot_embed + owner: ebi-gxa +- name: anndata_ops + owner: ebi-gxa +- name: scanpy_parameter_iterator + owner: ebi-gxa +- name: scanpy_read_10x + owner: ebi-gxa +- name: scanpy_integrate_harmony + owner: ebi-gxa +- name: gtf2gene_list + owner: ebi-gxa +- name: scanpy_run_fdg + owner: ebi-gxa +- name: scanpy_run_diffmap + owner: ebi-gxa +- name: scanpy_run_paga + owner: ebi-gxa +- name: scanpy_run_dpt + owner: ebi-gxa +- name: scanpy_plot_trajectory + owner: ebi-gxa +- name: alevin + owner: bgruening +- name: droplet_barcode_plot + owner: ebi-gxa +- name: salmon_kallisto_mtx_to_10x + owner: ebi-gxa +- name: dropletutils_read_10x + owner: ebi-gxa +- name: dropletutils_empty_drops + owner: ebi-gxa +- name: sceasy_convert + owner: ebi-gxa +- name: retrieve_scxa + owner: ebi-gxa +- name: scanpy_regress_variable + owner: ebi-gxa +- name: music_construct_eset + owner: bgruening +- name: music_inspect_eset + owner: bgruening +- name: music_manipulate_eset + owner: bgruening +- name: music_deconvolution + owner: bgruening +- name: music_compare + owner: bgruening +- name: episcanpy_build_matrix + owner: iuc +- name: episcanpy_preprocess + owner: iuc +- name: sinto_barcode + owner: iuc +- name: sinto_fragments + owner: iuc +- name: baredsc_1d + owner: iuc +- name: baredsc_2d + owner: iuc +- name: baredsc_combine_1d + owner: iuc +- name: baredsc_combine_2d + owner: iuc +- name: cite_seq_count + owner: iuc +- name: velocyto_cli + owner: iuc +- name: gsc_scran_normalize + owner: artbio +- name: snapatac2_clustering + owner: iuc +- name: snapatac2_peaks_and_motif + owner: iuc +- name: snapatac2_plotting + owner: iuc +- name: snapatac2_preprocessing + owner: iuc diff --git a/communities/microgalaxy/lab/tool_panel/single_cell.yml.lock b/communities/microgalaxy/lab/tool_panel/single_cell.yml.lock new file mode 100644 index 00000000..7e805143 --- /dev/null +++ b/communities/microgalaxy/lab/tool_panel/single_cell.yml.lock @@ -0,0 +1,568 @@ +install_repository_dependencies: true +install_resolver_dependencies: false +install_tool_dependencies: false +tool_panel_section_label: Single-cell +tools: +- name: scanpy_plot + owner: iuc + revisions: + - 6adf98e782f3 + - 6f5349dd5c49 + - 7647e5cd1b8b + - 95777145cb92 + - 9a169729c9f9 + - 9b0cdb8cf6be + - aa0c474463c2 + - f7446fd8d5e7 + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: scanpy_inspect + owner: iuc + revisions: + - 3081ff5c84a3 + - 5c3ebe2adc77 + - 6bd82ed14acd + - 6c145a6868cc + - 9d33775ec67d + - c5d3684f7c4c + - e4c99c83dfbf + - f54f0f0598ad + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: scanpy_filter + owner: iuc + revisions: + - 277313130da5 + - 2d02d9702d3a + - 3c86f71498bc + - 5511647110ff + - a03ff8633507 + - b409c2486353 + - d636ce5cde16 + - f87ed6503715 + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: scanpy_normalize + owner: iuc + revisions: + - 51d945eab1e1 + - 5342ce58cd1e + - 7b9fafe32c86 + - 94c19fb1281c + - a407e7f8bdc1 + - ab55fe8030b6 + - c9cb76cf8d6c + - d844935c906c + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: scanpy_cluster_reduce_dimension + owner: iuc + revisions: + - 35bc2eb568ed + - 3e4e1cf73d98 + - 4d8f983cd751 + - 6acb08931836 + - 6f83f8fd381f + - aaa5da8e73a9 + - b2df381a6004 + - edec35114f72 + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: scanpy_remove_confounders + owner: iuc + revisions: + - 215733a383f2 + - 458e8f43a775 + - 73ab2ac53d06 + - 80d4e2cac903 + - bf2017df9837 + - c2ef03559dc6 + - c65fce500915 + - d18e7a6e5cd4 + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: anndata_export + owner: iuc + revisions: + - 0cb889db0910 + - 32c5c85cbc12 + - c0b037b12765 + - c5ac926c838f + - e1c3c2f2a834 + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: anndata_import + owner: iuc + revisions: + - 00712416fdaa + - '499059586799' + - 93dd15e13e6a + - ae1e5d9d8972 + - cfc3f5a57dc6 + - fb9e030ffae4 + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: anndata_inspect + owner: iuc + revisions: + - 038e32885fec + - 383dcb0500f9 + - 39e945f0b2c1 + - 6f0d0c784f09 + - ee98d611afc6 + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: anndata_manipulate + owner: iuc + revisions: + - 3d748954434b + - 43cb7b5a6fe7 + - 8db95f488f0f + - ed4996a16f7f + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: modify_loom + owner: iuc + revisions: + - 4b0adaa31c95 + - 59be31ac9dc3 + - 7784821452ac + - e98619de2776 + - eeab712b0b99 + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: dropletutils + owner: iuc + revisions: + - 2c1200fba922 + - a9caad671439 + - cdf4443d5625 + - cfe1e6c28d95 + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: raceid_clustering + owner: iuc + revisions: + - 0bff0ee0683a + - 7e014059a88d + - a4b734cd253b + - c4f39bf4a068 + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: raceid_filtnormconf + owner: iuc + revisions: + - 43c146e25a43 + - 7608d5faee41 + - b83fbc90161e + - d45f092caf24 + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: raceid_inspectclusters + owner: iuc + revisions: + - 37a47c4fd84d + - 41f34e925bd5 + - be4646256624 + - f3eb2291da05 + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: raceid_inspecttrajectory + owner: iuc + revisions: + - 3478133d0f6f + - 69018f285aa3 + - a6821f856a1e + - c8434a623268 + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: raceid_trajectory + owner: iuc + revisions: + - 2af7c5086a96 + - 44b935f2271b + - 72979cac22b2 + - e93b008c637a + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: scanpy_filter_cells + owner: ebi-gxa + revisions: + - 7fd39eb52f38 + - 8ed4e80e8799 + - ba64b91ed2b9 + - bf1e0bdec1db + - e9283529cba1 + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: scanpy_filter_genes + owner: ebi-gxa + revisions: + - 474a69c47184 + - 7143938df06e + - a1698b43abeb + - cc64914b0cf4 + - d82d999fa716 + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: scanpy_normalise_data + owner: ebi-gxa + revisions: + - 1e9616772e16 + - 3027cb62adbd + - 3a4564b9d685 + - 6b97ffba31da + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: scanpy_find_variable_genes + owner: ebi-gxa + revisions: + - 2861ca3bfe4d + - 5c62f39aab8f + - 64dd8bb151e1 + - 82bd7bf93454 + - ae467daae2f7 + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: scanpy_scale_data + owner: ebi-gxa + revisions: + - 22f2957da902 + - 2b6913c840bf + - 4cc9362782b4 + - f86b2c3bc459 + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: scanpy_run_pca + owner: ebi-gxa + revisions: + - 04bdc69f00d7 + - 4428dba93375 + - 59028945c857 + - 988edd5fa902 + - c4f7fb2b1f70 + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: scanpy_compute_graph + owner: ebi-gxa + revisions: + - 22bd5861706d + - 3cf0177ed87e + - 5ec3b715809c + - 6417cccad133 + - fcaa9048cdaf + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: scanpy_run_tsne + owner: ebi-gxa + revisions: + - 181d61d2f3cd + - 384cacc40611 + - a147dce191e9 + - abdb61e4afa3 + - fe727a9496ea + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: scanpy_run_umap + owner: ebi-gxa + revisions: + - abae3d11d920 + - ad70b3552c99 + - bd4a244faeb8 + - e31937baa330 + - ea91cfd0444e + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: scanpy_find_cluster + owner: ebi-gxa + revisions: + - 15e8a4c60418 + - 2ccd9f9e2cd0 + - 36735850e461 + - 621d7d7a605f + - 8dc3d8941217 + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: scanpy_find_markers + owner: ebi-gxa + revisions: + - 615a46c220f0 + - 7042ce140caa + - 81c34e67f262 + - a57c0538e56b + - d8f5224005bb + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: scanpy_plot_embed + owner: ebi-gxa + revisions: + - 35f6611fb8c3 + - 7d5c97823f8b + - 9fafbfcdee0d + - a71086d2e55f + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: anndata_ops + owner: ebi-gxa + revisions: + - 31e5e6d606ef + - 53a251c6d991 + - 825dfd66e3fb + - a4774b7b2e85 + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: scanpy_parameter_iterator + owner: ebi-gxa + revisions: + - 4e4420ed5292 + - 73d43034c860 + - a8c73996ac50 + - b9dd12ab0550 + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: scanpy_read_10x + owner: ebi-gxa + revisions: + - 078aa23c9374 + - 4d13979de6ee + - 9afcfcd1d215 + - c8391a25dee3 + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: scanpy_integrate_harmony + owner: ebi-gxa + revisions: + - 2cef3539f420 + - 3111bcf039dd + - 5bea4f3c4edf + - c354af93f567 + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: gtf2gene_list + owner: ebi-gxa + revisions: + - 14b3f2a4523b + - 1a642de6db01 + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: scanpy_run_fdg + owner: ebi-gxa + revisions: + - be019b069e31 + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: scanpy_run_diffmap + owner: ebi-gxa + revisions: + - 79cc06a557b0 + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: scanpy_run_paga + owner: ebi-gxa + revisions: + - b2768cae00a1 + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: scanpy_run_dpt + owner: ebi-gxa + revisions: + - 03921aa8b29c + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: scanpy_plot_trajectory + owner: ebi-gxa + revisions: + - cb1992d1804b + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: alevin + owner: bgruening + revisions: + - 04b494623f8e + - c9944a2600f1 + - e32b215b7c04 + - e4c01dcece8b + - f2000bc73102 + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: droplet_barcode_plot + owner: ebi-gxa + revisions: + - 8f605643ccfd + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: salmon_kallisto_mtx_to_10x + owner: ebi-gxa + revisions: + - 88f5a0a6a818 + - e42c217a450f + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: dropletutils_read_10x + owner: ebi-gxa + revisions: + - ca62f52e0d7f + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: dropletutils_empty_drops + owner: ebi-gxa + revisions: + - fa662ca7ae7f + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: sceasy_convert + owner: ebi-gxa + revisions: + - f62bc418173f + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: retrieve_scxa + owner: ebi-gxa + revisions: + - 72b6e1747e37 + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: scanpy_regress_variable + owner: ebi-gxa + revisions: + - 0bab2ae44e7a + - 1200b55768ce + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: music_construct_eset + owner: bgruening + revisions: + - 282819d09a4f + - 2cfd0db49bbc + - 7ffaa0968da3 + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: music_inspect_eset + owner: bgruening + revisions: + - 7705cc75ac18 + - 8c64a2da3869 + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: music_manipulate_eset + owner: bgruening + revisions: + - 22232092be53 + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: music_deconvolution + owner: bgruening + revisions: + - 2ba99a52bd44 + - 56371b5a2da9 + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: music_compare + owner: bgruening + revisions: + - 4447ed460308 + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: episcanpy_build_matrix + owner: iuc + revisions: + - 31a21ba2c5ea + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: episcanpy_preprocess + owner: iuc + revisions: + - 29f5f25b9935 + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: sinto_barcode + owner: iuc + revisions: + - d1b34ac42b8f + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: sinto_fragments + owner: iuc + revisions: + - 29e6bfb2cf49 + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: baredsc_1d + owner: iuc + revisions: + - 02b1fe7aed76 + - 0e70b2dfe4be + - 4fff5a293013 + - 769d815e4b0d + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: baredsc_2d + owner: iuc + revisions: + - 344c2af50552 + - a90f8efe08b4 + - aa4a6f0916b4 + - c29e7bb492bf + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: baredsc_combine_1d + owner: iuc + revisions: + - 050cf43887d3 + - 5b7c81b35b89 + - b13d3e4c48e1 + - c32347702e12 + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: baredsc_combine_2d + owner: iuc + revisions: + - 02fc39c8610d + - 1d77986f9ddc + - 239193b96d72 + - ae969fdb8442 + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: cite_seq_count + owner: iuc + revisions: + - 3df3d1b51110 + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: velocyto_cli + owner: iuc + revisions: + - 883c33ef3372 + - 90e95e9ee190 + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: gsc_scran_normalize + owner: artbio + revisions: + - 6864acb21714 + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: snapatac2_clustering + owner: iuc + revisions: + - 8f8bef61fd0b + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: snapatac2_peaks_and_motif + owner: iuc + revisions: + - 588c811fdd48 + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: snapatac2_plotting + owner: iuc + revisions: + - fecf9664c885 + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell +- name: snapatac2_preprocessing + owner: iuc + revisions: + - cec3e76eaf05 + tool_panel_section_id: single_cell + tool_panel_section_label: Single-cell diff --git a/communities/microgalaxy/lab/tool_panel/spatial.yml b/communities/microgalaxy/lab/tool_panel/spatial.yml new file mode 100644 index 00000000..85d64f88 --- /dev/null +++ b/communities/microgalaxy/lab/tool_panel/spatial.yml @@ -0,0 +1,14 @@ +tool_panel_section_label: Spatial +tools: +- name: quantification + owner: perssond +- name: cell_intensity_processing + owner: goeckslab +- name: s3segmenter + owner: perssond +- name: slice_image + owner: imgteam +- name: squidpy + owner: goeckslab +- name: vitessce_spatial + owner: goeckslab diff --git a/communities/microgalaxy/lab/tool_panel/spatial.yml.lock b/communities/microgalaxy/lab/tool_panel/spatial.yml.lock new file mode 100644 index 00000000..415c67d3 --- /dev/null +++ b/communities/microgalaxy/lab/tool_panel/spatial.yml.lock @@ -0,0 +1,41 @@ +install_repository_dependencies: true +install_resolver_dependencies: false +install_tool_dependencies: false +tool_panel_section_label: Spatial +tools: +- name: quantification + owner: perssond + revisions: + - 3a916c4e9f5f + tool_panel_section_id: spatial + tool_panel_section_label: Spatial +- name: cell_intensity_processing + owner: goeckslab + revisions: + - 5d541df02496 + tool_panel_section_id: spatial + tool_panel_section_label: Spatial +- name: s3segmenter + owner: perssond + revisions: + - 96d0d969ebc9 + tool_panel_section_id: spatial + tool_panel_section_label: Spatial +- name: slice_image + owner: imgteam + revisions: + - a72590196440 + tool_panel_section_id: spatial + tool_panel_section_label: Spatial +- name: squidpy + owner: goeckslab + revisions: + - d30ef0613122 + tool_panel_section_id: spatial + tool_panel_section_label: Spatial +- name: vitessce_spatial + owner: goeckslab + revisions: + - 7cc457aa78b1 + tool_panel_section_id: spatial + tool_panel_section_label: Spatial diff --git a/communities/microgalaxy/lab/tool_panel/tool_panel_view.yml b/communities/microgalaxy/lab/tool_panel/tool_panel_view.yml new file mode 100644 index 00000000..992f462b --- /dev/null +++ b/communities/microgalaxy/lab/tool_panel/tool_panel_view.yml @@ -0,0 +1,438 @@ +name: Single Cell +type: generic +id: singlecell +items: +- id: general_section + text: General Tools + type: label +- sections: + # These will be named differently on each server: + - getext # "Get Data" + - send # "Send Data" + - collection_operations + - plots + - textutil + - filter + - group +- id: sc_tools + text: Single Cell Tools + type: label +- id: importSC + name: Import/manipulate SC data + type: section + items: + - type: tool + id: toolshed.g2.bx.psu.edu/repos/bgruening/alevin/alevin + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/anndata_ops/anndata_ops + - type: tool + id: toolshed.g2.bx.psu.edu/repos/bgruening/music_construct_eset/music_construct_eset + - type: tool + id: toolshed.g2.bx.psu.edu/repos/bgruening/10x_bamtofastq/10x_bamtofastq + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/droplet_barcode_plot/_dropletBarcodePlot + - type: tool + id: toolshed.g2.bx.psu.edu/repos/iuc/dropletutils/dropletutils + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/dropletutils_empty_drops/dropletutils_empty_drops + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/dropletutils_read_10x/dropletutils_read_10x + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/retrieve_scxa/retrieve_scxa + - type: tool + id: toolshed.g2.bx.psu.edu/repos/iuc/anndata_export/anndata_export + - type: tool + id: toolshed.g2.bx.psu.edu/repos/iuc/anndata_inspect/anndata_inspect + - type: tool + id: toolshed.g2.bx.psu.edu/repos/bgruening/music_inspect_eset/music_inspect_eset + - type: tool + id: toolshed.g2.bx.psu.edu/repos/iuc/anndata_manipulate/anndata_manipulate + - type: tool + id: toolshed.g2.bx.psu.edu/repos/iuc/modify_loom/modify_loom + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/monocle3_create/monocle3_create + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/salmon_kallisto_mtx_to_10x/_salmon_kallisto_mtx_to_10x + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/scater_read_10x_results/scater_read_10x_results + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/sceasy_convert/sceasy_convert + - type: tool + id: toolshed.g2.bx.psu.edu/repos/iuc/scpipe/scpipe + - type: tool + id: toolshed.g2.bx.psu.edu/repos/artbio/gsc_scran_normalize/scran_normalize + - type: tool + id: toolshed.g2.bx.psu.edu/repos/iuc/umi_tools_count/umi_tools_count + - type: tool + id: toolshed.g2.bx.psu.edu/repos/iuc/umi_tools_dedup/umi_tools_dedup + - type: tool + id: toolshed.g2.bx.psu.edu/repos/iuc/umi_tools_extract/umi_tools_extract + - type: tool + id: toolshed.g2.bx.psu.edu/repos/iuc/umi_tools_group/umi_tools_group + - type: tool + id: toolshed.g2.bx.psu.edu/repos/iuc/umi_tools_whitelist/umi_tools_whitelist +- id: scanpy + type: section + name: Scanpy + items: + - type: tool + id: toolshed.g2.bx.psu.edu/repos/iuc/scanpy_cluster_reduce_dimension/scanpy_cluster_reduce_dimension + - type: tool + id: toolshed.g2.bx.psu.edu/repos/iuc/scanpy_filter/scanpy_filter + - type: tool + id: toolshed.g2.bx.psu.edu/repos/iuc/scanpy_inspect/scanpy_inspect + - type: tool + id: toolshed.g2.bx.psu.edu/repos/iuc/scanpy_normalize/scanpy_normalize + - type: tool + id: toolshed.g2.bx.psu.edu/repos/iuc/scanpy_plot/scanpy_plot + - type: tool + id: toolshed.g2.bx.psu.edu/repos/iuc/scanpy_remove_confounders/scanpy_remove_confounders +- id: monocle3 + type: section + name: Monocle3 + items: + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/monocle3_create/monocle3_create + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/monocle3_diffexp/monocle3_diffExp + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/monocle3_learngraph/monocle3_learnGraph + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/monocle3_ordercells/monocle3_orderCells + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/monocle3_partition/monocle3_partition + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/monocle3_plotcells/monocle3_plotCells + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/monocle3_preprocess/monocle3_preprocess + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/monocle3_reducedim/monocle3_reduceDim + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/monocle3_topmarkers/monocle3_topmarkers +- id: seurat + type: section + name: Seurat + items: + - type: tool + id: toolshed.g2.bx.psu.edu/repos/iuc/seurat/seurat + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/seurat_create_seurat_object/seurat_create_seurat_object + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/seurat_export_cellbrowser/seurat_export_cellbrowser + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/seurat_filter_cells/seurat_filter_cells + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/seurat_find_clusters/seurat_find_clusters + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/seurat_find_markers/seurat_find_markers + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/seurat_find_neighbours/seurat_find_neighbours + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/seurat_find_variable_genes/seurat_find_variable_genes + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/seurat_normalise_data/seurat_normalise_data + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/seurat_dim_plot/seurat_dim_plot + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/seurat_read10x/seurat_read10x + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/seurat_run_pca/seurat_run_pca + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/seurat_run_tsne/seurat_run_tsne + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/seurat_scale_data/seurat_scale_data +- id: inference + type: section + name: Inference + items: + - type: tool + id: toolshed.g2.bx.psu.edu/repos/bgruening/music_deconvolution/music_deconvolution + - type: tool + id: toolshed.g2.bx.psu.edu/repos/bgruening/music_compare/music_compare + - type: tool + id: toolshed.g2.bx.psu.edu/repos/iuc/velocyto_cli/velocyto_cli +- id: spatial + type: section + name: Spatial + items: + - type: tool + id: toolshed.g2.bx.psu.edu/repos/perssond/quantification/quantification + - type: tool + id: toolshed.g2.bx.psu.edu/repos/goeckslab/cell_intensity_processing/cell_intensity_processing + - type: tool + id: toolshed.g2.bx.psu.edu/repos/perssond/s3segmenter/s3segmenter + - type: tool + id: toolshed.g2.bx.psu.edu/repos/imgteam/slice_image/ip_slice_image + - type: tool + id: toolshed.g2.bx.psu.edu/repos/goeckslab/squidpy/squidpy_spatial + - type: tool + id: toolshed.g2.bx.psu.edu/repos/goeckslab/vitessce_spatial/vitessce_spatial +- id: multiomics + type: section + name: Multiomics + items: + - type: tool + id: toolshed.g2.bx.psu.edu/repos/iuc/episcanpy_build_matrix/episcanpy_build_matrix + - type: tool + id: toolshed.g2.bx.psu.edu/repos/iuc/cite_seq_count/cite_seq_count + - type: tool + id: toolshed.g2.bx.psu.edu/repos/iuc/episcanpy_cluster_embed/episcanpy_cluster_embed + - type: tool + id: toolshed.g2.bx.psu.edu/repos/iuc/episcanpy_preprocess/episcanpy_preprocess + - type: tool + id: toolshed.g2.bx.psu.edu/repos/iuc/sinto_barcode/sinto_barcode + - type: tool + id: toolshed.g2.bx.psu.edu/repos/iuc/sinto_fragments/sinto_fragments +- id: hca-scanpy + type: section + name: HCA-Scanpy + items: + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/anndata_ops/anndata_ops + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/seurat_plot/seurat_plot + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/scanpy_integrate_bbknn/scanpy_integrate_bbknn + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/scanpy_integrate_combat/scanpy_integrate_combat + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/scanpy_compute_graph/scanpy_compute_graph + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/scanpy_run_diffmap/scanpy_run_diffmap + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/scanpy_run_dpt/scanpy_run_dpt + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/scanpy_filter_cells/scanpy_filter_cells + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/scanpy_filter_genes/scanpy_filter_genes + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/scanpy_find_cluster/scanpy_find_cluster + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/scanpy_find_markers/scanpy_find_markers + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/scanpy_find_variable_genes/scanpy_find_variable_genes + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/scanpy_integrate_harmony/scanpy_integrate_harmony + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/scanpy_integrate_mnn/scanpy_integrate_mnn + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/scanpy_normalise_data/scanpy_normalise_data + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/scanpy_run_paga/scanpy_run_paga + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/scanpy_parameter_iterator/scanpy_parameter_iterator + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/scanpy_plot_scrublet/scanpy_plot_scrublet + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/scanpy_plot_embed/scanpy_plot_embed + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/scanpy_plot_trajectory/scanpy_plot_trajectory + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/scanpy_read_10x/scanpy_read_10x + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/scanpy_regress_variable/scanpy_regress_variable + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/scanpy_run_fdg/scanpy_run_fdg + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/scanpy_run_pca/scanpy_run_pca + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/scanpy_run_tsne/scanpy_run_tsne + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/scanpy_run_umap/scanpy_run_umap + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/scanpy_scale_data/scanpy_scale_data + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/scanpy_multiplet_scrublet/scanpy_multiplet_scrublet + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/seurat_run_umap/seurat_run_umap +- id: raceid + type: section + name: RaceID + items: + - type: tool + id: toolshed.g2.bx.psu.edu/repos/iuc/raceid_inspectclusters/raceid_inspectclusters + - type: tool + id: toolshed.g2.bx.psu.edu/repos/iuc/raceid_clustering/raceid_clustering + - type: tool + id: toolshed.g2.bx.psu.edu/repos/iuc/raceid_filtnormconf/raceid_filtnormconf + - type: tool + id: toolshed.g2.bx.psu.edu/repos/iuc/raceid_inspecttrajectory/raceid_inspecttrajectory + - type: tool + id: toolshed.g2.bx.psu.edu/repos/iuc/raceid_trajectory/raceid_trajectory +- id: hicexplorer + type: section + name: HiCExplorer + items: + - type: tool + id: toolshed.g2.bx.psu.edu/repos/bgruening/hicexplorer_chicaggregatestatistic/hicexplorer_chicaggregatestatistic + - type: tool + id: toolshed.g2.bx.psu.edu/repos/bgruening/hicexplorer_chicdifferentialtest/hicexplorer_chicdifferentialtest + - type: tool + id: toolshed.g2.bx.psu.edu/repos/bgruening/hicexplorer_chicexportdata/hicexplorer_chicexportdata + - type: tool + id: toolshed.g2.bx.psu.edu/repos/bgruening/hicexplorer_chicplotviewpoint/hicexplorer_chicplotviewpoint + - type: tool + id: toolshed.g2.bx.psu.edu/repos/bgruening/hicexplorer_chicqualitycontrol/hicexplorer_chicqualitycontrol + - type: tool + id: toolshed.g2.bx.psu.edu/repos/bgruening/hicexplorer_chicsignificantinteractions/hicexplorer_chicsignificantinteractions + - type: tool + id: toolshed.g2.bx.psu.edu/repos/bgruening/hicexplorer_chicviewpoint/hicexplorer_chicviewpoint + - type: tool + id: toolshed.g2.bx.psu.edu/repos/bgruening/hicexplorer_chicqualitycontrol/hicexplorer_chicqualitycontrol + - type: tool + id: toolshed.g2.bx.psu.edu/repos/bgruening/hicexplorer_chicsignificantinteractions/hicexplorer_chicsignificantinteractions + - type: tool + id: toolshed.g2.bx.psu.edu/repos/bgruening/hicexplorer_chicviewpoint/hicexplorer_chicviewpoint + - type: tool + id: toolshed.g2.bx.psu.edu/repos/bgruening/hicexplorer_chicviewpointbackgroundmodel/hicexplorer_chicviewpointbackgroundmodel + - type: tool + id: toolshed.g2.bx.psu.edu/repos/bgruening/hicexplorer_hicadjustmatrix/hicexplorer_hicadjustmatrix + - type: tool + id: toolshed.g2.bx.psu.edu/repos/bgruening/hicexplorer_hicaggregatecontacts/hicexplorer_hicaggregatecontacts + - type: tool + id: toolshed.g2.bx.psu.edu/repos/bgruening/hicexplorer_hicaverageregions/hicexplorer_hicaverageregions + - type: tool + id: toolshed.g2.bx.psu.edu/repos/bgruening/hicexplorer_hicbuildmatrix/hicexplorer_hicbuildmatrix + - type: tool + id: toolshed.g2.bx.psu.edu/repos/bgruening/hicexplorer_hiccomparematrices/hicexplorer_hiccomparematrices + - type: tool + id: toolshed.g2.bx.psu.edu/repos/bgruening/hicexplorer_hiccompartmentspolarization/hicexplorer_hiccompartmentspolarization + - type: tool + id: toolshed.g2.bx.psu.edu/repos/bgruening/hicexplorer_hicconvertformat/hicexplorer_hicconvertformat + - type: tool + id: toolshed.g2.bx.psu.edu/repos/bgruening/hicexplorer_hiccorrectmatrix/hicexplorer_hiccorrectmatrix + - type: tool + id: toolshed.g2.bx.psu.edu/repos/bgruening/hicexplorer_hiccorrelate/hicexplorer_hiccorrelate + - type: tool + id: toolshed.g2.bx.psu.edu/repos/bgruening/hicexplorer_hicdetectloops/hicexplorer_hicdetectloops + - type: tool + id: toolshed.g2.bx.psu.edu/repos/bgruening/hicexplorer_hicdifferentialtad/hicexplorer_hicdifferentialtad + - type: tool + id: toolshed.g2.bx.psu.edu/repos/bgruening/hicexplorer_hicfindrestrictionsites/hicexplorer_hicfindrestrictionsites + - type: tool + id: toolshed.g2.bx.psu.edu/repos/bgruening/hicexplorer_hicfindtads/hicexplorer_hicfindtads + - type: tool + id: toolshed.g2.bx.psu.edu/repos/bgruening/hicexplorer_hichyperoptdetectloops/hicexplorer_hichyperoptDetectLoops + - type: tool + id: toolshed.g2.bx.psu.edu/repos/bgruening/hicexplorer_hicinfo/hicexplorer_hicinfo + - type: tool + id: toolshed.g2.bx.psu.edu/repos/bgruening/hicexplorer_hicinterintratad/hicexplorer_hicinterintratad + - type: tool + id: toolshed.g2.bx.psu.edu/repos/bgruening/hicexplorer_hicmergedomains/hicexplorer_hicmergedomains + - type: tool + id: toolshed.g2.bx.psu.edu/repos/bgruening/hicexplorer_hicmergeloops/hicexplorer_hicmergeloops + - type: tool + id: toolshed.g2.bx.psu.edu/repos/bgruening/hicexplorer_hicmergematrixbins/hicexplorer_hicmergematrixbins + - type: tool + id: toolshed.g2.bx.psu.edu/repos/bgruening/hicexplorer_hicnormalize/hicexplorer_hicnormalize + - type: tool + id: toolshed.g2.bx.psu.edu/repos/bgruening/hicexplorer_hicpca/hicexplorer_hicpca + - type: tool + id: toolshed.g2.bx.psu.edu/repos/bgruening/hicexplorer_hicplotaverageregions/hicexplorer_hicplotaverageregions + - type: tool + id: toolshed.g2.bx.psu.edu/repos/bgruening/hicexplorer_hicplotdistvscounts/hicexplorer_hicplotdistvscounts + - type: tool + id: toolshed.g2.bx.psu.edu/repos/bgruening/hicexplorer_hicplotmatrix/hicexplorer_hicplotmatrix + - type: tool + id: toolshed.g2.bx.psu.edu/repos/bgruening/hicexplorer_hicplotsvl/hicexplorer_hicplotsvl + - type: tool + id: toolshed.g2.bx.psu.edu/repos/bgruening/hicexplorer_hicplottads/hicexplorer_hicplottads + - type: tool + id: toolshed.g2.bx.psu.edu/repos/bgruening/hicexplorer_hicplotviewpoint/hicexplorer_hicplotviewpoint+galaxy0 + - type: tool + id: toolshed.g2.bx.psu.edu/repos/bgruening/hicexplorer_hicquickqc/hicexplorer_hicquickqc + - type: tool + id: toolshed.g2.bx.psu.edu/repos/bgruening/hicexplorer_hicsummatrices/hicexplorer_hicsummatrices + - type: tool + id: toolshed.g2.bx.psu.edu/repos/bgruening/hicexplorer_hictadclassifier/hicexplorer_hictadclassifier + - type: tool + id: toolshed.g2.bx.psu.edu/repos/bgruening/hicexplorer_hictraintadclassifier/hicexplorer_hictraintadclassifier + - type: tool + id: toolshed.g2.bx.psu.edu/repos/bgruening/hicexplorer_hictransform/hicexplorer_hictransform + - type: tool + id: toolshed.g2.bx.psu.edu/repos/bgruening/hicexplorer_hicvalidatelocations/hicexplorer_hicvalidatelocations + - type: tool + id: toolshed.g2.bx.psu.edu/repos/iuc/schicexplorer_schicadjustmatrix/schicexplorer_schicadjustmatrix + - type: tool + id: toolshed.g2.bx.psu.edu/repos/iuc/schicexplorer_schiccluster/schicexplorer_schiccluster + - type: tool + id: toolshed.g2.bx.psu.edu/repos/iuc/schicexplorer_schicclustercompartments/schicexplorer_schicclustercompartments + - type: tool + id: toolshed.g2.bx.psu.edu/repos/iuc/schicexplorer_schicclusterminhash/schicexplorer_schicclusterminhash + - type: tool + id: toolshed.g2.bx.psu.edu/repos/iuc/schicexplorer_schicclustersvl/schicexplorer_schicclustersvl + - type: tool + id: toolshed.g2.bx.psu.edu/repos/iuc/schicexplorer_schicconsensusmatrices/schicexplorer_schicconsensusmatrices + - type: tool + id: toolshed.g2.bx.psu.edu/repos/iuc/schicexplorer_schiccorrectmatrices/schicexplorer_schiccorrectmatrices + - type: tool + id: toolshed.g2.bx.psu.edu/repos/iuc/schicexplorer_schiccreatebulkmatrix/schicexplorer_schiccreatebulkmatrix + - type: tool + id: toolshed.g2.bx.psu.edu/repos/iuc/schicexplorer_schicdemultiplex/schicexplorer_schicdemultiplex + - type: tool + id: toolshed.g2.bx.psu.edu/repos/iuc/schicexplorer_schicinfo/schicexplorer_schicinfo + - type: tool + id: toolshed.g2.bx.psu.edu/repos/iuc/schicexplorer_schicmergematrixbins/schicexplorer_schicmergematrixbins + - type: tool + id: toolshed.g2.bx.psu.edu/repos/iuc/schicexplorer_schicmergetoscool/schicexplorer_schicmergetoscool + - type: tool + id: toolshed.g2.bx.psu.edu/repos/iuc/schicexplorer_schicnormalize/schicexplorer_schicnormalize + - type: tool + id: toolshed.g2.bx.psu.edu/repos/iuc/schicexplorer_schicplotclusterprofiles/schicexplorer_schicplotclusterprofiles + - type: tool + id: toolshed.g2.bx.psu.edu/repos/iuc/schicexplorer_schicplotconsensusmatrices/schicexplorer_schicplotconsensusmatrices + - type: tool + id: toolshed.g2.bx.psu.edu/repos/iuc/schicexplorer_schicqualitycontrol/schicexplorer_schicqualitycontrol +- id: sccaf + type: section + name: SCCAF + items: + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/run_sccaf/run_sccaf + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/sccaf_asses/sccaf_asses + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/sccaf_asses_merger/sccaf_asses_merger + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/sccaf_regress_out/sccaf_regress_out +- id: others-sc + type: section + name: Other Single Cell Tools + items: + - type: tool + id: toolshed.g2.bx.psu.edu/repos/iuc/baredsc_1d/baredsc_1d + - type: tool + id: toolshed.g2.bx.psu.edu/repos/iuc/baredsc_2d/baredsc_2d + - type: tool + id: toolshed.g2.bx.psu.edu/repos/iuc/baredsc_combine_1d/baredsc_combine_1d + - type: tool + id: toolshed.g2.bx.psu.edu/repos/iuc/baredsc_combine_2d/baredsc_combine_2d + - type: tool + id: toolshed.g2.bx.psu.edu/repos/iuc/anndata_import/anndata_import + - type: tool + id: toolshed.g2.bx.psu.edu/repos/artbio/gsc_scran_normalize/scran_normalize + - type: tool + id: toolshed.g2.bx.psu.edu/repos/iuc/snapatac2_clustering/snapatac2_clustering + - type: tool + id: toolshed.g2.bx.psu.edu/repos/iuc/snapatac2_peaks_and_motif/snapatac2_peaks_and_motif + - type: tool + id: toolshed.g2.bx.psu.edu/repos/iuc/snapatac2_plotting/snapatac2_plotting + - type: tool + id: toolshed.g2.bx.psu.edu/repos/iuc/snapatac2_preprocessing/snapatac2_preprocessing +- id: interactive_tools + text: Interactive tools + type: label +- id: it + type: section + name: Interactive Tools + items: + - type: tool + id: interactive_tool_cellxgene + - type: tool + id: interactive_tool_jupyter_notebook + - type: tool + id: interactive_tool_isee + - type: tool + id: interactive_tool_rstudio + - type: tool + id: toolshed.g2.bx.psu.edu/repos/ebi-gxa/ucsc_cell_browser/ucsc_cell_browser diff --git a/communities/microgalaxy/lab/tool_panel/usegalaxy.org.au.yml b/communities/microgalaxy/lab/tool_panel/usegalaxy.org.au.yml new file mode 100644 index 00000000..fd7d9bd5 --- /dev/null +++ b/communities/microgalaxy/lab/tool_panel/usegalaxy.org.au.yml @@ -0,0 +1,964 @@ +install_resolver_dependencies: false +install_tool_dependencies: false +tools: +- name: scanpy_plot + owner: iuc + revisions: + - 6adf98e782f3 + - 6f5349dd5c49 + - 7647e5cd1b8b + - 95777145cb92 + - 9a169729c9f9 + - 9b0cdb8cf6be + - aa0c474463c2 + - f7446fd8d5e7 + tool_panel_section_label: Single-Cell +- name: scanpy_inspect + owner: iuc + revisions: + - 3081ff5c84a3 + - 5c3ebe2adc77 + - 6bd82ed14acd + - 6c145a6868cc + - 9d33775ec67d + - c5d3684f7c4c + - e4c99c83dfbf + - f54f0f0598ad + tool_panel_section_label: Single-Cell +- name: scanpy_filter + owner: iuc + revisions: + - 277313130da5 + - 2d02d9702d3a + - 3c86f71498bc + - 5511647110ff + - a03ff8633507 + - b409c2486353 + - d636ce5cde16 + - f87ed6503715 + tool_panel_section_label: Single-Cell +- name: scanpy_normalize + owner: iuc + revisions: + - 51d945eab1e1 + - 5342ce58cd1e + - 7b9fafe32c86 + - 94c19fb1281c + - a407e7f8bdc1 + - ab55fe8030b6 + - c9cb76cf8d6c + - d844935c906c + tool_panel_section_label: Single-Cell +- name: scanpy_cluster_reduce_dimension + owner: iuc + revisions: + - 35bc2eb568ed + - 3e4e1cf73d98 + - 4d8f983cd751 + - 6acb08931836 + - 6f83f8fd381f + - aaa5da8e73a9 + - b2df381a6004 + - edec35114f72 + tool_panel_section_label: Single-Cell +- name: scanpy_remove_confounders + owner: iuc + revisions: + - 215733a383f2 + - 458e8f43a775 + - 73ab2ac53d06 + - 80d4e2cac903 + - bf2017df9837 + - c2ef03559dc6 + - c65fce500915 + - d18e7a6e5cd4 + tool_panel_section_label: Single-Cell +- name: anndata_export + owner: iuc + revisions: + - 0cb889db0910 + - 32c5c85cbc12 + - c0b037b12765 + - c5ac926c838f + - e1c3c2f2a834 + tool_panel_section_label: Single-Cell +- name: anndata_import + owner: iuc + revisions: + - 00712416fdaa + - '499059586799' + - 93dd15e13e6a + - ae1e5d9d8972 + - cfc3f5a57dc6 + - fb9e030ffae4 + tool_panel_section_label: Single-Cell +- name: anndata_inspect + owner: iuc + revisions: + - 038e32885fec + - 383dcb0500f9 + - 39e945f0b2c1 + - 6f0d0c784f09 + - ee98d611afc6 + tool_panel_section_label: Single-Cell +- name: anndata_manipulate + owner: iuc + revisions: + - 3d748954434b + - 43cb7b5a6fe7 + - 8db95f488f0f + - ed4996a16f7f + tool_panel_section_label: Single-Cell +- name: modify_loom + owner: iuc + revisions: + - 4b0adaa31c95 + - 59be31ac9dc3 + - 7784821452ac + - e98619de2776 + - eeab712b0b99 + tool_panel_section_label: Single-Cell +- name: dropletutils + owner: iuc + revisions: + - 2c1200fba922 + - a9caad671439 + - cdf4443d5625 + - cfe1e6c28d95 + tool_panel_section_label: Single-Cell +- name: raceid_clustering + owner: iuc + revisions: + - 0bff0ee0683a + - 7e014059a88d + - a4b734cd253b + - c4f39bf4a068 + tool_panel_section_label: Single-Cell +- name: raceid_filtnormconf + owner: iuc + revisions: + - 43c146e25a43 + - 7608d5faee41 + - b83fbc90161e + - d45f092caf24 + tool_panel_section_label: Single-Cell +- name: raceid_inspectclusters + owner: iuc + revisions: + - 37a47c4fd84d + - 41f34e925bd5 + - be4646256624 + - f3eb2291da05 + tool_panel_section_label: Single-Cell +- name: raceid_inspecttrajectory + owner: iuc + revisions: + - 3478133d0f6f + - 69018f285aa3 + - a6821f856a1e + - c8434a623268 + tool_panel_section_label: Single-Cell +- name: raceid_trajectory + owner: iuc + revisions: + - 2af7c5086a96 + - 44b935f2271b + - 72979cac22b2 + - e93b008c637a + tool_panel_section_label: Single-Cell +- name: scanpy_filter_cells + owner: ebi-gxa + revisions: + - 7fd39eb52f38 + - 8ed4e80e8799 + - ba64b91ed2b9 + - bf1e0bdec1db + - e9283529cba1 + tool_panel_section_label: Single-Cell +- name: scanpy_filter_genes + owner: ebi-gxa + revisions: + - 474a69c47184 + - 7143938df06e + - a1698b43abeb + - cc64914b0cf4 + - d82d999fa716 + tool_panel_section_label: Single-Cell +- name: scanpy_normalise_data + owner: ebi-gxa + revisions: + - 1e9616772e16 + - 3027cb62adbd + - 3a4564b9d685 + - 6b97ffba31da + tool_panel_section_label: Single-Cell +- name: scanpy_find_variable_genes + owner: ebi-gxa + revisions: + - 2861ca3bfe4d + - 5c62f39aab8f + - 64dd8bb151e1 + - 82bd7bf93454 + - ae467daae2f7 + tool_panel_section_label: Single-Cell +- name: scanpy_scale_data + owner: ebi-gxa + revisions: + - 22f2957da902 + - 2b6913c840bf + - 4cc9362782b4 + - f86b2c3bc459 + tool_panel_section_label: Single-Cell +- name: scanpy_run_pca + owner: ebi-gxa + revisions: + - 04bdc69f00d7 + - 4428dba93375 + - 59028945c857 + - 988edd5fa902 + - c4f7fb2b1f70 + tool_panel_section_label: Single-Cell +- name: scanpy_compute_graph + owner: ebi-gxa + revisions: + - 22bd5861706d + - 3cf0177ed87e + - 5ec3b715809c + - 6417cccad133 + - fcaa9048cdaf + tool_panel_section_label: Single-Cell +- name: scanpy_run_tsne + owner: ebi-gxa + revisions: + - 181d61d2f3cd + - 384cacc40611 + - a147dce191e9 + - abdb61e4afa3 + - fe727a9496ea + tool_panel_section_label: Single-Cell +- name: scanpy_run_umap + owner: ebi-gxa + revisions: + - abae3d11d920 + - ad70b3552c99 + - bd4a244faeb8 + - e31937baa330 + - ea91cfd0444e + tool_panel_section_label: Single-Cell +- name: scanpy_find_cluster + owner: ebi-gxa + revisions: + - 15e8a4c60418 + - 2ccd9f9e2cd0 + - 36735850e461 + - 621d7d7a605f + - 8dc3d8941217 + tool_panel_section_label: Single-Cell +- name: scanpy_find_markers + owner: ebi-gxa + revisions: + - 615a46c220f0 + - 7042ce140caa + - 81c34e67f262 + - a57c0538e56b + - d8f5224005bb + tool_panel_section_label: Single-Cell +- name: scanpy_plot_embed + owner: ebi-gxa + revisions: + - 35f6611fb8c3 + - 7d5c97823f8b + - 9fafbfcdee0d + - a71086d2e55f + tool_panel_section_label: Single-Cell +- name: anndata_ops + owner: ebi-gxa + revisions: + - 31e5e6d606ef + - 53a251c6d991 + - 825dfd66e3fb + - a4774b7b2e85 + tool_panel_section_label: Single-Cell +- name: scanpy_parameter_iterator + owner: ebi-gxa + revisions: + - 4e4420ed5292 + - 73d43034c860 + - a8c73996ac50 + - b9dd12ab0550 + tool_panel_section_label: Single-Cell +- name: scanpy_read_10x + owner: ebi-gxa + revisions: + - 078aa23c9374 + - 4d13979de6ee + - 9afcfcd1d215 + - c8391a25dee3 + tool_panel_section_label: Single-Cell +- name: scanpy_integrate_harmony + owner: ebi-gxa + revisions: + - 2cef3539f420 + - 3111bcf039dd + - 5bea4f3c4edf + - c354af93f567 + tool_panel_section_label: Single-Cell +- name: gtf2gene_list + owner: ebi-gxa + revisions: + - 14b3f2a4523b + - 1a642de6db01 + tool_panel_section_label: Single-Cell +- name: scanpy_run_fdg + owner: ebi-gxa + revisions: + - be019b069e31 + tool_panel_section_label: Single-Cell +- name: scanpy_run_diffmap + owner: ebi-gxa + revisions: + - 79cc06a557b0 + tool_panel_section_label: Single-Cell +- name: scanpy_run_paga + owner: ebi-gxa + revisions: + - b2768cae00a1 + tool_panel_section_label: Single-Cell +- name: scanpy_run_dpt + owner: ebi-gxa + revisions: + - 03921aa8b29c + tool_panel_section_label: Single-Cell +- name: scanpy_plot_trajectory + owner: ebi-gxa + revisions: + - cb1992d1804b + tool_panel_section_label: Single-Cell +- name: alevin + owner: bgruening + revisions: + - 04b494623f8e + - c9944a2600f1 + - e32b215b7c04 + - e4c01dcece8b + - f2000bc73102 + tool_panel_section_label: Single-Cell +- name: droplet_barcode_plot + owner: ebi-gxa + revisions: + - 8f605643ccfd + tool_panel_section_label: Single-Cell +- name: salmon_kallisto_mtx_to_10x + owner: ebi-gxa + revisions: + - 88f5a0a6a818 + - e42c217a450f + tool_panel_section_label: Single-Cell +- name: dropletutils_read_10x + owner: ebi-gxa + revisions: + - ca62f52e0d7f + tool_panel_section_label: Single-Cell +- name: dropletutils_empty_drops + owner: ebi-gxa + revisions: + - fa662ca7ae7f + tool_panel_section_label: Single-Cell +- name: sceasy_convert + owner: ebi-gxa + revisions: + - f62bc418173f + tool_panel_section_label: Single-Cell +- name: retrieve_scxa + owner: ebi-gxa + revisions: + - 72b6e1747e37 + tool_panel_section_label: Single-Cell +- name: scanpy_regress_variable + owner: ebi-gxa + revisions: + - 0bab2ae44e7a + - 1200b55768ce + tool_panel_section_label: Single-Cell +- name: music_construct_eset + owner: bgruening + revisions: + - 282819d09a4f + - 2cfd0db49bbc + - 7ffaa0968da3 + tool_panel_section_label: Single-Cell +- name: music_inspect_eset + owner: bgruening + revisions: + - 7705cc75ac18 + - 8c64a2da3869 + tool_panel_section_label: Single-Cell +- name: music_manipulate_eset + owner: bgruening + revisions: + - 22232092be53 + tool_panel_section_label: Single-Cell +- name: music_deconvolution + owner: bgruening + revisions: + - 2ba99a52bd44 + - 56371b5a2da9 + tool_panel_section_label: Single-Cell +- name: music_compare + owner: bgruening + revisions: + - 4447ed460308 + tool_panel_section_label: Single-Cell +- name: episcanpy_build_matrix + owner: iuc + revisions: + - 31a21ba2c5ea + tool_panel_section_label: Single-Cell +- name: episcanpy_preprocess + owner: iuc + revisions: + - 29f5f25b9935 + tool_panel_section_label: Single-Cell +- name: sinto_barcode + owner: iuc + revisions: + - d1b34ac42b8f + tool_panel_section_label: Single-Cell +- name: sinto_fragments + owner: iuc + revisions: + - 29e6bfb2cf49 + tool_panel_section_label: Single-Cell +- name: baredsc_1d + owner: iuc + revisions: + - 02b1fe7aed76 + - 0e70b2dfe4be + - 4fff5a293013 + - 769d815e4b0d + tool_panel_section_label: Single-Cell +- name: baredsc_2d + owner: iuc + revisions: + - 344c2af50552 + - a90f8efe08b4 + - aa4a6f0916b4 + - c29e7bb492bf + tool_panel_section_label: Single-Cell +- name: baredsc_combine_1d + owner: iuc + revisions: + - 050cf43887d3 + - 5b7c81b35b89 + - b13d3e4c48e1 + - c32347702e12 + tool_panel_section_label: Single-Cell +- name: baredsc_combine_2d + owner: iuc + revisions: + - 02fc39c8610d + - 1d77986f9ddc + - 239193b96d72 + - ae969fdb8442 + tool_panel_section_label: Single-Cell +- name: cite_seq_count + owner: iuc + revisions: + - 3df3d1b51110 + tool_panel_section_label: Single-Cell +- name: velocyto_cli + owner: iuc + revisions: + - 883c33ef3372 + - 90e95e9ee190 + tool_panel_section_label: Single-Cell +- name: gsc_scran_normalize + owner: artbio + revisions: + - 6864acb21714 + tool_panel_section_label: Single-Cell +- name: snapatac2_clustering + owner: iuc + revisions: + - 8f8bef61fd0b + tool_panel_section_label: Single-Cell +- name: snapatac2_peaks_and_motif + owner: iuc + revisions: + - 588c811fdd48 + tool_panel_section_label: Single-Cell +- name: snapatac2_plotting + owner: iuc + revisions: + - fecf9664c885 + tool_panel_section_label: Single-Cell +- name: snapatac2_preprocessing + owner: iuc + revisions: + - cec3e76eaf05 + tool_panel_section_label: Single-Cell +- name: seurat_plot + owner: ebi-gxa + revisions: + - 95d79f1134f0 + tool_panel_section_label: Single-Cell +- name: scanpy_integrate_bbknn + owner: ebi-gxa + revisions: + - c9da9192eee5 + tool_panel_section_label: Single-Cell +- name: scanpy_integrate_combat + owner: ebi-gxa + revisions: + - 3c47bc560688 + tool_panel_section_label: Single-Cell +- name: scanpy_integrate_mnn + owner: ebi-gxa + revisions: + - ff6decc0f432 + tool_panel_section_label: Single-Cell +- name: scanpy_plot_scrublet + owner: ebi-gxa + revisions: + - 6f5509cf3176 + tool_panel_section_label: Single-Cell +- name: scanpy_multiplet_scrublet + owner: ebi-gxa + revisions: + - 53ce0e336840 + tool_panel_section_label: Single-Cell +- name: seurat_run_umap + owner: ebi-gxa + revisions: + - b9424c715a0d + tool_panel_section_label: Single-Cell +- name: hicexplorer_chicaggregatestatistic + owner: bgruening + revisions: + - 01c37e54e86e + tool_panel_section_label: Single-Cell +- name: hicexplorer_chicdifferentialtest + owner: bgruening + revisions: + - 9d42a6133690 + tool_panel_section_label: Single-Cell +- name: hicexplorer_chicexportdata + owner: bgruening + revisions: + - 23b8d6b8960c + tool_panel_section_label: Single-Cell +- name: hicexplorer_chicplotviewpoint + owner: bgruening + revisions: + - 013e53ccc7ac + tool_panel_section_label: Single-Cell +- name: hicexplorer_chicqualitycontrol + owner: bgruening + revisions: + - b892fa1fcaec + tool_panel_section_label: Single-Cell +- name: hicexplorer_chicsignificantinteractions + owner: bgruening + revisions: + - 640e0e45518a + tool_panel_section_label: Single-Cell +- name: hicexplorer_chicviewpoint + owner: bgruening + revisions: + - f881c94fb3b3 + tool_panel_section_label: Single-Cell +- name: hicexplorer_chicqualitycontrol + owner: bgruening + revisions: + - b892fa1fcaec + tool_panel_section_label: Single-Cell +- name: hicexplorer_chicsignificantinteractions + owner: bgruening + revisions: + - 640e0e45518a + tool_panel_section_label: Single-Cell +- name: hicexplorer_chicviewpoint + owner: bgruening + revisions: + - f881c94fb3b3 + tool_panel_section_label: Single-Cell +- name: hicexplorer_chicviewpointbackgroundmodel + owner: bgruening + revisions: + - 9d02f1819e81 + tool_panel_section_label: Single-Cell +- name: hicexplorer_hicadjustmatrix + owner: bgruening + revisions: + - 2dccb6bb0add + tool_panel_section_label: Single-Cell +- name: hicexplorer_hicaggregatecontacts + owner: bgruening + revisions: + - f0216498a666 + tool_panel_section_label: Single-Cell +- name: hicexplorer_hicaverageregions + owner: bgruening + revisions: + - c72fa6cb8817 + tool_panel_section_label: Single-Cell +- name: hicexplorer_hicbuildmatrix + owner: bgruening + revisions: + - ed2cca6b5de4 + tool_panel_section_label: Single-Cell +- name: hicexplorer_hiccomparematrices + owner: bgruening + revisions: + - 3ee5332bf57c + tool_panel_section_label: Single-Cell +- name: hicexplorer_hiccompartmentspolarization + owner: bgruening + revisions: + - 3a6a5381db36 + tool_panel_section_label: Single-Cell +- name: hicexplorer_hicconvertformat + owner: bgruening + revisions: + - c0737631eea1 + tool_panel_section_label: Single-Cell +- name: hicexplorer_hiccorrectmatrix + owner: bgruening + revisions: + - ea19190ce5e0 + tool_panel_section_label: Single-Cell +- name: hicexplorer_hiccorrelate + owner: bgruening + revisions: + - 2b4d6a8dab36 + tool_panel_section_label: Single-Cell +- name: hicexplorer_hicdetectloops + owner: bgruening + revisions: + - 0410b6aada45 + tool_panel_section_label: Single-Cell +- name: hicexplorer_hicdifferentialtad + owner: bgruening + revisions: + - 77d8e0fd162a + tool_panel_section_label: Single-Cell +- name: hicexplorer_hicfindrestrictionsites + owner: bgruening + revisions: + - 6c5097f6d41e + tool_panel_section_label: Single-Cell +- name: hicexplorer_hicfindtads + owner: bgruening + revisions: + - ec4b948dc6f0 + tool_panel_section_label: Single-Cell +- name: hicexplorer_hichyperoptdetectloops + owner: bgruening + revisions: + - 7f7c6ead2d0d + tool_panel_section_label: Single-Cell +- name: hicexplorer_hicinfo + owner: bgruening + revisions: + - e4f8fceab96a + tool_panel_section_label: Single-Cell +- name: hicexplorer_hicinterintratad + owner: bgruening + revisions: + - 55b013e59018 + tool_panel_section_label: Single-Cell +- name: hicexplorer_hicmergedomains + owner: bgruening + revisions: + - b376ef118807 + tool_panel_section_label: Single-Cell +- name: hicexplorer_hicmergeloops + owner: bgruening + revisions: + - 1511a8ebe906 + tool_panel_section_label: Single-Cell +- name: hicexplorer_hicmergematrixbins + owner: bgruening + revisions: + - 977dc15add20 + tool_panel_section_label: Single-Cell +- name: hicexplorer_hicnormalize + owner: bgruening + revisions: + - 6d042c96aceb + tool_panel_section_label: Single-Cell +- name: hicexplorer_hicpca + owner: bgruening + revisions: + - 77919cc3618e + tool_panel_section_label: Single-Cell +- name: hicexplorer_hicplotaverageregions + owner: bgruening + revisions: + - ea5d67ec94ab + tool_panel_section_label: Single-Cell +- name: hicexplorer_hicplotdistvscounts + owner: bgruening + revisions: + - 6326cd29c1c3 + tool_panel_section_label: Single-Cell +- name: hicexplorer_hicplotmatrix + owner: bgruening + revisions: + - b63363075c2e + tool_panel_section_label: Single-Cell +- name: hicexplorer_hicplotsvl + owner: bgruening + revisions: + - b4e780e93c91 + tool_panel_section_label: Single-Cell +- name: hicexplorer_hicplotviewpoint + owner: bgruening + revisions: + - 58de3c7c8e89 + tool_panel_section_label: Single-Cell +- name: hicexplorer_hicquickqc + owner: bgruening + revisions: + - 21d859ad4502 + tool_panel_section_label: Single-Cell +- name: hicexplorer_hicsummatrices + owner: bgruening + revisions: + - 36dfa2825a59 + tool_panel_section_label: Single-Cell +- name: hicexplorer_hictadclassifier + owner: bgruening + revisions: + - 887d203233e5 + tool_panel_section_label: Single-Cell +- name: hicexplorer_hictraintadclassifier + owner: bgruening + revisions: + - 1ff19476c5a5 + tool_panel_section_label: Single-Cell +- name: hicexplorer_hictransform + owner: bgruening + revisions: + - f36828ebdc54 + tool_panel_section_label: Single-Cell +- name: hicexplorer_hicvalidatelocations + owner: bgruening + revisions: + - 1d201e8378b3 + tool_panel_section_label: Single-Cell +- name: schicexplorer_schicadjustmatrix + owner: iuc + revisions: + - 2e773e00ceb0 + tool_panel_section_label: Single-Cell +- name: schicexplorer_schiccluster + owner: iuc + revisions: + - baa3ae7ac42c + tool_panel_section_label: Single-Cell +- name: schicexplorer_schicclustercompartments + owner: iuc + revisions: + - 54b6cef88a7f + tool_panel_section_label: Single-Cell +- name: schicexplorer_schicclusterminhash + owner: iuc + revisions: + - 3048283ee054 + tool_panel_section_label: Single-Cell +- name: schicexplorer_schicclustersvl + owner: iuc + revisions: + - e6ec3914a076 + tool_panel_section_label: Single-Cell +- name: schicexplorer_schicconsensusmatrices + owner: iuc + revisions: + - 33b1c99cc709 + tool_panel_section_label: Single-Cell +- name: schicexplorer_schiccorrectmatrices + owner: iuc + revisions: + - 295558e266d0 + tool_panel_section_label: Single-Cell +- name: schicexplorer_schiccreatebulkmatrix + owner: iuc + revisions: + - acb3ed49109e + tool_panel_section_label: Single-Cell +- name: schicexplorer_schicdemultiplex + owner: iuc + revisions: + - f224fc9af1d3 + tool_panel_section_label: Single-Cell +- name: schicexplorer_schicinfo + owner: iuc + revisions: + - 41b415c410e3 + tool_panel_section_label: Single-Cell +- name: schicexplorer_schicmergematrixbins + owner: iuc + revisions: + - 47ef02546fe9 + tool_panel_section_label: Single-Cell +- name: schicexplorer_schicmergetoscool + owner: iuc + revisions: + - 70a13d0a950f + tool_panel_section_label: Single-Cell +- name: schicexplorer_schicnormalize + owner: iuc + revisions: + - 66e96c3d3c5d + tool_panel_section_label: Single-Cell +- name: schicexplorer_schicplotclusterprofiles + owner: iuc + revisions: + - 65f2f5d29947 + tool_panel_section_label: Single-Cell +- name: schicexplorer_schicplotconsensusmatrices + owner: iuc + revisions: + - 95b1216e1e70 + tool_panel_section_label: Single-Cell +- name: schicexplorer_schicqualitycontrol + owner: iuc + revisions: + - 4a841ab67e3b + tool_panel_section_label: Single-Cell +- name: quantification + owner: perssond + revisions: + - 3a916c4e9f5f + tool_panel_section_label: Single-Cell +- name: cell_intensity_processing + owner: goeckslab + revisions: + - 5d541df02496 + tool_panel_section_label: Single-Cell +- name: s3segmenter + owner: perssond + revisions: + - 96d0d969ebc9 + tool_panel_section_label: Single-Cell +- name: slice_image + owner: imgteam + revisions: + - a72590196440 + tool_panel_section_label: Single-Cell +- name: squidpy + owner: goeckslab + revisions: + - d30ef0613122 + tool_panel_section_label: Single-Cell +- name: vitessce_spatial + owner: goeckslab + revisions: + - 7cc457aa78b1 + tool_panel_section_label: Single-Cell +- name: run_sccaf + owner: ebi-gxa + revisions: + - 647d34f125bc + tool_panel_section_label: Single-Cell +- name: sccaf_asses + owner: ebi-gxa + revisions: + - 37a4c22f600b + tool_panel_section_label: Single-Cell +- name: sccaf_asses_merger + owner: ebi-gxa + revisions: + - 99d15ded4d5f + tool_panel_section_label: Single-Cell +- name: sccaf_regress_out + owner: ebi-gxa + revisions: + - 5ef0610e9f50 + tool_panel_section_label: Single-Cell +- name: episcanpy_cluster_embed + owner: iuc + revisions: + - f4713992f23a + tool_panel_section_label: Single-Cell +- name: 10x_bamtofastq + owner: bgruening + revisions: + - f71fd828c126 + tool_panel_section_label: Single-Cell +- name: scater_read_10x_results + owner: ebi-gxa + revisions: + - da3f394039b5 + tool_panel_section_label: Single-Cell +- name: gsc_scran_normalize + owner: artbio + revisions: + - 6864acb21714 + tool_panel_section_label: Single-Cell +- name: seurat_create_seurat_object + owner: ebi-gxa + revisions: + - f8865ae30723 + tool_panel_section_label: Single-Cell +- name: seurat_export_cellbrowser + owner: ebi-gxa + revisions: + - 36221da750e8 + tool_panel_section_label: Single-Cell +- name: seurat_filter_cells + owner: ebi-gxa + revisions: + - cd9f564bd63f + tool_panel_section_label: Single-Cell +- name: seurat_find_clusters + owner: ebi-gxa + revisions: + - d541e9e62beb + tool_panel_section_label: Single-Cell +- name: seurat_find_markers + owner: ebi-gxa + revisions: + - 07fc9f4841b3 + tool_panel_section_label: Single-Cell +- name: seurat_find_neighbours + owner: ebi-gxa + revisions: + - ba897c57bdd9 + tool_panel_section_label: Single-Cell +- name: seurat_find_variable_genes + owner: ebi-gxa + revisions: + - 948fc0276b4f + tool_panel_section_label: Single-Cell +- name: seurat_normalise_data + owner: ebi-gxa + revisions: + - 3f49bc9c9213 + tool_panel_section_label: Single-Cell +- name: seurat_dim_plot + owner: ebi-gxa + revisions: + - 64174ac50d78 + tool_panel_section_label: Single-Cell +- name: seurat_read10x + owner: ebi-gxa + revisions: + - f5db0e853f57 + tool_panel_section_label: Single-Cell +- name: seurat_run_pca + owner: ebi-gxa + revisions: + - 8ded486b0014 + tool_panel_section_label: Single-Cell +- name: seurat_run_tsne + owner: ebi-gxa + revisions: + - 0db997e4a81d + tool_panel_section_label: Single-Cell +- name: seurat_scale_data + owner: ebi-gxa + revisions: + - 5e9ba303f9e1 + tool_panel_section_label: Single-Cell diff --git a/communities/microgalaxy/lab/usegalaxy.eu.yml b/communities/microgalaxy/lab/usegalaxy.eu.yml new file mode 100644 index 00000000..8343e551 --- /dev/null +++ b/communities/microgalaxy/lab/usegalaxy.eu.yml @@ -0,0 +1,53 @@ +# This content extends base.yml + +# Request this as a webpage with: +# https://site.usegalaxy.org.au/lab/export?content_root=https://raw.githubusercontent.com/nomadscientist/galaxy_codex/tree/main/communities/microgalaxy/usegalaxy.eu.yml + +# ----------------------------------------------------------------------------- +# Use these variables in HTML templates like: +# "Welcome to the Galaxy {{ site_name }} {{ lab_name }}" +# To make the content more generic and reusable across sites + +# These will be rendered like "Welcome to the Galaxy {{ site_name }} {{ lab_name }}!" +site_name: Europe +nationality: European + +# Used for rendering tool/workflow links. Trailing '/' will be removed. +galaxy_base_url: https://microgalaxy.usegalaxy.eu +subdomain: microGalaxy +root_domain: usegalaxy.eu + +# This will enable a feedback form on the webpage: +# feedback_email: help@mygalaxy.org + +quota_request_url: https://docs.google.com/forms/d/e/1FAIpQLSf9w2MOS6KOlu9XdhRSDqWnCDkzoVBqHJ3zH_My4p8D8ZgkIQ/viewform +data_policy_url: "#data-policy" +terms_url: https://usegalaxy-eu.github.io/gdpr/tos.html + +help_links: + - title: General Galaxy support + url: https://galaxyproject.org/support/ + - title: Galaxy EU help forum + url: https://help.galaxyproject.org/c/usegalaxy-eu-support/6 + - title: microGalaxy Galaxy user community chat room + url: https://matrix.to/#/#galaxyproject_microGalaxy:gitter.im + - title: Galaxy Training Community chat + url: https://matrix.to/#/#Galaxy-Training-Network_Lobby:gitter.im + - title: Usegalaxy.eu chat + url: https://matrix.to/#/#usegalaxy-eu_Lobby:gitter.im + - title: Usegalaxy.org chat + url: https://matrix.to/#/#galaxyproject_Lobby:gitter.im + +conclusion_extra_md: > +
+ {% markdown_from_url 'https://raw.githubusercontent.com/galaxyproject/galaxy-hub/master/content/eu/common/data-policy.md' %} +
+
+ +
+ +# ----------------------------------------------------------------------------- +# Custom content relative to this file URL + +custom_css: usegalaxy.eu/static/custom.css +footer_md: usegalaxy.eu/templates/footer.html diff --git a/communities/microgalaxy/lab/usegalaxy.eu/static/custom.css b/communities/microgalaxy/lab/usegalaxy.eu/static/custom.css new file mode 100644 index 00000000..a579d07b --- /dev/null +++ b/communities/microgalaxy/lab/usegalaxy.eu/static/custom.css @@ -0,0 +1,10 @@ +#conclusionExtra h1 { + font-size: 1.5rem; + margin-bottom: 1rem; +} +#conclusionExtra { + font-size: 90%; +} +#conclusionExtra td { + font-size: 90%; +} \ No newline at end of file diff --git a/communities/microgalaxy/lab/usegalaxy.eu/templates/footer.html b/communities/microgalaxy/lab/usegalaxy.eu/templates/footer.html new file mode 100644 index 00000000..f87a847b --- /dev/null +++ b/communities/microgalaxy/lab/usegalaxy.eu/templates/footer.html @@ -0,0 +1,70 @@ +
+ + + +
diff --git a/communities/microgalaxy/lab/usegalaxy.org.au.yml b/communities/microgalaxy/lab/usegalaxy.org.au.yml new file mode 100644 index 00000000..fa7ccd02 --- /dev/null +++ b/communities/microgalaxy/lab/usegalaxy.org.au.yml @@ -0,0 +1,41 @@ +# This content extends base.yml + +# Request this as a webpage with: +# https://site.usegalaxy.org.au/lab/export?content_root=https://raw.githubusercontent.com/nomadscientist/galaxy_codex/tree/main/communities/microgalaxy/usegalaxy.org.au.yml + +# ----------------------------------------------------------------------------- +# Use these variables in MD/HTML templates like: +# "Welcome to the Galaxy {{ site_name }} {{ lab_name }}" +# To make the content more generic and reusable across sites + +# These will be rendered like "Welcome to the Galaxy {{ site_name }} {{ lab_name }}!" +site_name: Australia +nationality: Australian + +# Used for rendering tool/workflow links. Trailing '/' will be removed. +galaxy_base_url: https://microgalaxy.usegalaxy.org.au +subdomain: microGalaxy +root_domain: usegalaxy.org.au + +# This will enable a feedback form on the webpage: +feedback_email: help@genome.edu.au + +# More variables for MD/HTML templating +support_url: https://site.usegalaxy.org.au/request +quota_request_url: https://site.usegalaxy.org.au/request/quota +data_policy_url: https://site.usegalaxy.org.au/about#data-privacy +terms_url: https://site.usegalaxy.org.au/about#terms-of-service + +help_links: + - title: Galaxy Australia Support + url: https://site.usegalaxy.org.au/request + - title: General Galaxy support + url: https://galaxyproject.org/support/ + - title: General Galaxy help forum + url: https://help.galaxyproject.org + - title: microGalaxy Galaxy user community chat room + url: https://matrix.to/#/#galaxyproject_microGalaxy:gitter.im + - title: Galaxy Training Community chat + url: https://matrix.to/#/#Galaxy-Training-Network_Lobby:gitter.im + - title: Usegalaxy.org chat + url: https://matrix.to/#/#galaxyproject_Lobby:gitter.im diff --git a/communities/microgalaxy/lab/usegalaxy.org.au/templates/footer.html b/communities/microgalaxy/lab/usegalaxy.org.au/templates/footer.html new file mode 100644 index 00000000..1935fba9 --- /dev/null +++ b/communities/microgalaxy/lab/usegalaxy.org.au/templates/footer.html @@ -0,0 +1,119 @@ + \ No newline at end of file diff --git a/communities/microgalaxy/lab/usegalaxy.org.yml b/communities/microgalaxy/lab/usegalaxy.org.yml new file mode 100644 index 00000000..7ec421c2 --- /dev/null +++ b/communities/microgalaxy/lab/usegalaxy.org.yml @@ -0,0 +1,33 @@ +# This content extends base.yml + +# Request this as a webpage with: +# https://site.usegalaxy.org.au/lab/export?content_root=https://raw.githubusercontent.com/nomadscientist/galaxy_codex/tree/main/communities/microgalaxy/usegalaxy.org.yml + +# ----------------------------------------------------------------------------- +# Use these variables in HTML templates like: +# "Welcome to the Galaxy {{ site_name }} {{ lab_name }}" +# To make the content more generic and reusable across sites + +# These will be rendered like "Welcome to the Galaxy {{ site_name }} {{ lab_name }}!" +site_name: "" # ? +nationality: "" + +# Used for rendering tool/workflow links. Trailing '/' will be removed. +galaxy_base_url: https://microgalaxy.usegalaxy.org +subdomain: microGalaxy +root_domain: usegalaxy.org + +# This will enable a feedback form on the webpage: +# feedback_email: help@mygalaxy.org + +help_links: + - title: General Galaxy support + url: https://galaxyproject.org/support/ + - title: General Galaxy help forum + url: https://help.galaxyproject.org + - title: microGalaxy Galaxy user community chat room + url: https://matrix.to/#/#galaxyproject_microGalaxy:gitter.im + - title: Galaxy Training Community chat + url: https://matrix.to/#/#Galaxy-Training-Network_Lobby:gitter.im + - title: Usegalaxy.org chat + url: https://matrix.to/#/#galaxyproject_Lobby:gitter.im diff --git a/sources/bin/populate_labs.py b/sources/bin/populate_labs.py new file mode 100644 index 00000000..6e28ce12 --- /dev/null +++ b/sources/bin/populate_labs.py @@ -0,0 +1,70 @@ +import argparse +import os +from typing import List + +import oyaml as yaml +import pandas as pd + +# import yaml + + +def main() -> None: + parser = argparse.ArgumentParser(description="Create community tools.yml from tool.tsv.") + + # Adding positional arguments with short options + parser.add_argument( + "-c", "--tool_tsv", type=str, required=True, help="Path to the TSV file (e.g., curated_tools.tsv)" + ) + parser.add_argument( + "-y", "--tool_yml", type=str, required=True, help="Path to the output YAML file (e.g., tools.yml)" + ) + + args = parser.parse_args() + + # Check if the tool TSV file exists + if not os.path.exists(args.tool_tsv): + print(f"Error: The file '{args.tool_tsv}' does not exist.") + return + + try: + # Read the TSV file with pandas (use tab delimiter) + data = pd.read_csv(args.tool_tsv, sep="\t") + + # Construct the YAML data structure + yaml_data = { + "id": "tools", + "title": "Community Tools", + "tabs": [ + {"id": "tool_list", "title": "List of community curated tools available for microGalaxy", "content": []} + ], + } + + # Populate the content section with each row from the TSV + for _, row in data.iterrows(): + # Use the first column (assumed to be the tool title) as the title_md + title_md = row[data.columns[0]] # Get the first column's value as title_md + + # Start the unordered list
    and construct each
  • for every other column in the row + description = row["Description"] + # for column in data.columns[1:]: # Skip the first column (since it's title_md) + # description += f"
  • {column}: {row[column]}
  • \n" + # description += "
" + + # Create the tool entry with the formatted HTML list + tool_entry = { + "title_md": title_md, + "description_md": description, # Directly insert the HTML string without escape sequences + } + yaml_data["tabs"][0]["content"].append(tool_entry) + + # Write the YAML data to the output file + with open(args.tool_yml, "w") as yaml_file: + yaml.dump(yaml_data, yaml_file, default_flow_style=False, allow_unicode=True, indent=2) + print(f"Data successfully written to '{args.tool_yml}'") + + except Exception as e: + print(f"An error occurred: {e}") + + +if __name__ == "__main__": + main()