QIIME 2 plugin for sequence alignment using minimap2.
Installation¶
We provide two options for installing q2-minimap2 via conda environment files, depending on your preferred QIIME2 distribution:
1: Amplicon distribution¶
Use the environment file q2-minimap2-qiime2-amplicon-2025.10.yml to create a new conda environment.
conda env create -f q2-minimap2-qiime2-amplicon-2025.10.yml
conda activate q2-minimap2-amplicon2: Moshpit distribution¶
Use the environment file q2-minimap2-qiime2-moshpit-2025.10.yml to create a new conda environment based on the MOSHPIT distro.
conda env create -f q2-minimap2-qiime2-moshpit-2025.10.yml
conda activate q2-minimap2-moshpitProvided Actions¶
build-index
Build a Minimap2 index database from reference sequences.
minimap2-search
Search for top hits in a reference database using alignment between the query sequences and reference database sequences using Minimap2. Returns a report of the top M hits for each query (where M=maxaccepts).
filter-reads
This method aligns long-read sequencing data (from a FASTQ file) to a set of reference sequences, identifying sequences that match or do not match the reference within a specified identity percentage. The alignment is performed using Minimap2, and the results are processed using Samtools.
extract-reads
This method aligns long-read sequencing data (from a FASTA file) to a set of reference sequences, identifying sequences that match or do not match the reference within a specified identity percentage. The alignment is performed using Minimap2, and the results are processed using Samtools.
classify-consensus-minimap2
Assign taxonomy to query sequences using Minimap2. Performs alignment between query and reference reads, then assigns consensus taxonomy to each query sequence.
Examples¶
- build-index
- Build Minimap2 index database
qiime minimap2 build-index --i-reference reference.qza --o-index index.qza --verbose
minimap2-search
- Generate both hits and no hits for each query. Keep a maximum of one hit per query (primary).
qiime minimap2 minimap2-search --i-query fasta_reads.qza --i-index index.qza --o-search-results paf.qza --verbose- Generate only hits for each query. Keep a maximum of one hit per query (primary mappings).
qiime minimap2 minimap2-search --i-query fasta_reads.qza --i-index index.qza --o-search-results paf_only_hits.qza --p-output-no-hits false --verbose- Generate only hits for each query, limiting the number of hits to a maximum of 3 per query. Ensure that each hit has a minimum similarity percentage of 90% to be considered valid.
qiime minimap2 minimap2-search --i-query fasta_reads.qza --i-index index.qza --o-search-results paf_only_hits_ma3.qza --p-maxaccepts 3 --p-output-no-hits false --verbose
filter-reads
- Keep mapped (single-end reads)
qiime minimap2 filter-reads --i-query single-end-reads.qza --i-index index.qza --o-filtered-query mapped_se.qza --verbose- Keep unmapped (single-end reads)
qiime minimap2 filter-reads --i-query single-end-reads.qza --i-index index.qza --p-keep unmapped --o-filtered-query unmapped_se.qza --verbose- Keep mapped (paired-end reads)
qiime minimap2 filter-reads --i-query paired-end-reads.qza --i-index index.qza --o-filtered-query mapped_pe.qza --verbose- Keep mapped reads with mapping percentage >= 98% (paired-end reads)
qiime minimap2 filter-reads --i-query paired-end-reads.qza --i-index index.qza --p-min-per-identity 0.98 --o-filtered-query mapped_pe_over_98p_id.qza --verbose
- extract-reads
- Extract mapped
qiime minimap2 extract-reads --i-sequences fasta_reads.qza --i-index index.qza --o-extracted-reads mapped_fasta.qza --verbose- Extract unmapped
qiime minimap2 extract-reads --i-sequences fasta_reads.qza --i-index index.qza --p-extract unmapped --o-extracted-reads unmapped_fasta.qza --verbose- Extract mapped reads with mapping percentage >= 87%
qiime minimap2 extract-reads --i-sequences fasta_reads.qza --i-index index.qza --p-min-per-identity 0.87 --o-extracted-reads mapped_fasta_ido_ver_87.qza --verbose
- classify-consensus-minimap2
- Assign taxonomy to query sequences using Minimap2
qiime minimap2 classify-consensus-minimap2 --i-query n1K_initial_reads_SILVA132.fna.qza --i-index ccm_index.qza --i-reference-taxonomy raw_taxonomy.qza --p-n-threads 8 --output-dir classification_output --verbose
- Links
- Documentation
- Source Code
- Stars
- 2
- Last Commit
- f4d2835
- Available Distros
- 2025.10
- 2025.10/amplicon
- 2025.10/moshpit