gptomics/bioskills

a set of SKILLS.md for doing bioinformatics with agents like claude code

129 stars23 forksUpdated Jan 25, 2026
npx skills add gptomics/bioskills

README

bioSkills

A collection of skills that guide AI coding agents (Claude Code, Codex, Gemini) through common bioinformatics tasks.

Project Goal

This repository provides AI agents with expert knowledge for bioinformatics workflows. Each skill contains code patterns, best practices, and examples that help agents generate correct, idiomatic code for common tasks.

Target users range from undergrads learning computational biology to PhD researchers processing large-scale data. The skills cover the full spectrum from basic sequence manipulation to advanced analyses like single-cell RNA-seq and population genetics.

Requirements

Python

  • Python 3.9+
  • biopython, pysam, cyvcf2, pybedtools, pyBigWig, scikit-allel, anndata
pip install biopython pysam cyvcf2 pybedtools pyBigWig scikit-allel anndata mygene

R/Bioconductor

Required for differential expression, single-cell, pathway analysis, and methylation skills.

if (!require('BiocManager', quietly = TRUE))
    install.packages('BiocManager')
BiocManager::install(c('DESeq2', 'edgeR', 'Seurat', 'clusterProfiler', 'methylKit'))

CLI Tools

# macOS
brew install samtools bcftools blast minimap2 bedtools

# Ubuntu/Debian
sudo apt install samtools bcftools ncbi-blast+ minimap2 bedtools

# conda
conda install -c bioconda samtools bcftools blast minimap2 bedtools \
    fastp kraken2 metaphlan sra-tools bwa-mem2 bowtie2 star hisat2 \
    manta delly cnvkit macs3 tobias

Installation

Claude Code

git clone https://github.com/your-username/bioSkills.git
cd bioSkills
./install-claude.sh                              # Install globally
./install-claude.sh --project /path/to/project   # Or install to specific project
./install-claude.sh --list                       # List available skills
./install-claude.sh --validate                   # Validate all skills
./install-claude.sh --update                     # Only update changed skills
./install-claude.sh --uninstall                  # Remove all bio-* skills

Codex CLI

./install-codex.sh                               # Install globally
./install-codex.sh --project /path/to/project    # Or install to specific project
./install-codex.sh --validate                    # Validate all skills
./install-codex.sh --update                      # Only update changed skills
./install-codex.sh --uninstall                   # Remove all bio-* skills

Gemini CLI

./install-gemini.sh                              # Install globally
./install-gemini.sh --project /path/to/project   # Or install to specific project
./install-gemini.sh --validate                   # Validate all skills
./install-gemini.sh --update                     # Only update changed skills
./install-gemini.sh --uninstall                  # Remove all bio-* skills

Codex and Gemini installers convert to the Agent Skills standard (examples/ -> scripts/, usage-guide.md -> references/).

Skill Categories

CategorySkillsPrimary ToolsDescription
sequence-io9Bio.SeqIORead, write, convert FASTA/FASTQ/GenBank and 40+ formats
sequence-manipulation7Bio.Seq, Bio.SeqUtilsTranscription, translation, motif search, sequence properties
database-access10Bio.Entrez, BLAST+, SRA toolkit, UniProt APINCBI/UniProt queries, SRA downloads, BLAST, homology searches
alignment-files9samtools, pysamSAM/BAM/CRAM viewing, sorting, filtering, statistics, validation
variant-calling13bcftools, cyvcf2, Manta, Delly, VEP, SnpEffVCF/BCF calling, SVs, filtering, annotation, clinical interpretation
alignment4Bio.Align, Bio.AlignIOPairwise and multiple sequence alignment, MSA statistics, alignment I/O
phylogenetics5Bio.Phylo, IQ-TREE2, RAxML-ngTree I/O, visualization, ML inference with model selection, ultrafast bootstrap
differential-expression6DESeq2, edgeR, ggplot2, pheatmapRNA-seq differential expression, visualization, batch correction
structural-biology6Bio.PDB, ESMFold, Chai-1PDB/mmCIF parsing, SMCRA navigation, geometric analysis, ML structure prediction
single-cell13Seurat, Scanpy, Pertpy, CassiopeiascRNA-seq QC, clustering, trajectory, communication, annotation, perturb-seq, lineage tracing
pathway-analysis6clusterProfiler, ReactomePA, rWikiPathways, enrichplotGO, KEGG, Reactome, WikiPathways enrichment
restriction-analysis4Bio.RestrictionRestriction sites, mapping, enzyme selection
methylation-analysis4Bismark, methylKit, bsseqBisulfite alignment, methylation calling, DMRs
chip-seq7MACS3, ChIPseeker, DiffBindPeak calling, annotation, differential binding, motifs, QC, super-enhancers
metagenomics7Kraken2, MetaPhlAn, Bracken, HUMAnNTaxonomic classification, abundance estimation, func

...

Read full README

Publisher

gptomicsgptomics

Statistics

Stars129
Forks23
Open Issues0
LicenseMIT License
CreatedJan 15, 2026