---+ Bioinformatics Master List This page is a master list of bioinformatics software frequently used in the lab, and their purposes. It also includes additional notes about what are good/ bad use cases, caveats or known issues. Most of these tools are likely available from bioconda or bioconductor and we advise against downloading source code and compiling it yourself. Figuring out what software is best suited for the task can be hard. It can take some trial and error with a small datatset, but [[https://davetang.org/muse/2023/07/12/deciding-which-bioinformatics-tool-to-use/][these are also general good guidelines]]. ---++ Next-Generation Sequencing and Genomics * [[https://www.bioinformatics.org/sms2/][Online sequence manipulation]]: a wide variety of small tasks for protein and DNA sequences * [[https://github.com/OpenGene/fastp][fastp]]: trim adapters and perform quality control on short reads. * [[https://github.com/BenLangmead/bowtie2][bowtie2]]: align short reads to a reference sequence. * [[https://github.com/barricklab/breseq][breseq]]: call mutations from single end or paired end illumina reads against a given reference sequence of a haploid microbial genome. _breseq_ can be used with long-read data, but is not optimised for this purpose. * [[https://github.com/barricklab/seabreeze][seabreeze]]: call structural variants between bacterial genomes. Also annotates genomes and visualizes the structural variation. * [[https://github.com/lh3/minimap2][minimap2]]: align long reads against a reference sequence. * [[https://github.com/mummer4/mummer][mummer]]: generate whole genome alignments * [[https://github.com/tseemann/prokka][prokka]]: annotate features on prokaryotic genomes * [[https://github.com/xiezhq/ISEScan][ISEScan]]: find insertion sequences in bacterial genomes. * [[https://github.com/rrwick/Trycycler][Trycycler]]: generate de novo consensus genome assemblies from long-read sequencing. Trycycler combines the output of several individual assemblers. It also has a successor, [[https://github.com/rrwick/Autocycler][Autocycler]]. * [[https://github.com/dzerbino/velvet][velvet]]: de novo assembly of short reads. * [[https://github.com/samtools/samtools][samtools]]: Handling common NGS and alignment file formats (SAM, BAM). * [[https://github.com/ncbi/sra-tools][sratools]]: Download data from the NCBI SRA * [[https://subread.sourceforge.net/featureCounts.html][featureCounts]]: counts mapped reads for genomic features. Used in RNA-sequencing. Often used upstream of DESeq2. Requires an alignment file first. * [[https://bioconductor.org/packages/release/bioc/html/DESeq2.html][DESeq2]]: perform differential gene expression analysis. Often used downsteam of something like featureCounts. * [[http://etetoolkit.org/treeview/][treeview]]: View phylogenetic trees. Accepts trees in newick format. * [[https://github.com/rcedgar/muscle][Muscle]]: multiple sequence alignment. Usually used as a first step to constructing phylogenetic trees. * [[https://github.com/tseemann/any2fasta][any2fast]]: lightweight Perl scripts to covert between common DNA file formats ---++ Visualizations * [[https://ggplot2.tidyverse.org/][ggplot2]]: general purpose data visualization in R * [[https://matplotlib.org/][matplotlib]]: general purpose data visualization in Python * [[https://igv.org/][Integrated Genomics Viewer]]: a genome browser to view alignment files (BAM files) and annotation files (like BED files). * [[https://genome.ucsc.edu/][UCSC Genome Browser]]: general purpose online genome browser * [[https://circos.ca/software/download/circos/][circos]]: make circular genome plots. Also has a javascript version [[https://wlcb.oit.uci.edu/NG-Circos][NG-Circos]] ---++ Misc * [[https://snakemake.readthedocs.io/en/stable/][Snakemake]]: Python-based workflow manager. Integrates nicely with conda to manage software dependencies.
E
dit
|
A
ttach
|
Watch
|
P
rint version
|
H
istory
: r2
<
r1
|
B
acklinks
|
V
iew topic
|
M
ore topic actions
Barrick Lab
>
ReferenceList
>
ListofBioinformatics
Contributors to this topic
IraZibbu
Topic revision: r2 - 2025-04-17 - 21:59:52 - Main.IraZibbu
Barrick Lab
Contact
Research
Publications
Team
Protocols
Reference
Software
UT Austin
Mol Biosciences
ILS
Microbiology
EEB
CSSB
CBRS
The LTEE
iGEM team
SynBioCyc
SynBio course
NGS course
BEACON
Search
Log in
Copyright ©2025 Barrick Lab contributing authors. Ideas, requests, problems?
Send feedback