layout | title | nav_order | description | permalink |
---|---|---|---|---|
default |
Home |
1 |
Quick start guides for bioinformatics programs, with video demonstrations and scripts. |
/ |
This project provides introductions to various bioinformatics tools with short guides, video demonstrations, and scripts that tie these tools together. The documents in this project can be read locally in a plain-text editor, or viewed online at https://rnnh.github.io/bioinfo-notebook/. If you are not familiar with using programs from the command line, begin with the page "Introduction to the command line". If you have any questions, or spot any mistakes, please submit an issue on GitHub.
These bioinformatics pipelines can be carried out using scripts and tools described in this project. Input files for some of these scripts can be specified in the command line; other scripts will need to be altered to fit the given input data.
- FASTQ reads from whole genome sequencing (WGS) can be assembled using SPAdes.
- Sequencing reads can be aligned to this assembled genome using bowtie2.
- The script snp_calling.sh aligns sequencing reads to an assembled genome and detects single nucleotide polymorphisms (SNPs). This will produce a Variant Call Format (VCF) file.
- The proteins in the assembled reference genome- the genome to which the reads are aligned- can be annotated using genome_annotation_SwissProt_CDS.sh.
- The genome annotation GFF file can be cross-referenced with the VCF file using annotating_snps.R. This will produce an annotated SNP format file.
- Annotated SNP format files can be cross-referenced using annotated_snps_filter.R. For two annotated SNP files, this script will produce a file with annotated SNPs unique to the first file, and a file with annotated SNPs unique to the second file.
- fastq-dump_to_featureCounts.sh can be used to download RNA-seq reads from NCBI's Sequence Read Archive (SRA) and align them to a reference genome. This script uses fastq-dump or fasterq-dump to download the sequencing reads as FASTQ, and featureCounts to align them to a reference FASTA nucleotide file.
- Running fastq-dump_to_featureCounts.sh will produce feature count tables. These feature count tables can be combined using combining_featCount_tables.py.
- These combined feature count tables can be used for differential expression (DE) analysis. An example DE analysis script is included in this project: DE_analysis_edgeR_script.R. This script uses the R programming language with the edgeR library.
- Augustus can be used to predict genes from FASTA nucleotide files.
- Once the FASTA amino acid sequences have been extracted from the Augustus annotations, you can search for orthologs using OrthoFinder.
- To find a specific gene of interest, search the amino acid sequences of the predicted genes using BLAST.
- Introduction to the command line
- Windows Subsystem for Linux
- Using Ubuntu through a Virtual Machine
- File formats used in bioinformatics
- Augustus
- Bcftools
- BLAST
- Bowtie
- Bowtie2
- Conda
- Fasterq-dump
- Fastq-dump
- FeatureCounts
- Htseq-count
- OrthoFinder
- SAMtools
- sgRNAcas9
- SPAdes
- Annotated SNPs filter
- Annotating SNPs
- Combining featCount tables.py
- DE_analysis_edgeR_script.R
- Fastq-dump to featureCounts
- Genome annotation script
- Linux setup script
- SNP calling script
- UniProt downloader
After following these instructions, there will be a copy of the bioinfo-notebook GitHub repo on your system in the ~/bioinfo-notebook/
directory.
This means there will be a copy of all the documents and scripts in this project on your computer.
If you are using Linux and run the Linux setup script, the bioinfo-notebook
virtual environment- which includes the majority of the command line programs covered in this project- will also be installed using conda.
1. This project is written to be used through a UNIX (Linux or Mac with macOS Mojave or later) operating system. If you are using a Windows operating system, begin with these pages on setting up Ubuntu (a Linux operating system):
Once you have an Ubuntu system set up, run the following command to update the lists of available software:
$ sudo apt-get update # Updates lists of software that can be installed
2. Run the following command in your home directory (~
) to download this project:
$ git clone https://github.com/rnnh/bioinfo-notebook.git
3. If you are using Linux, run the Linux setup script with this command after downloading the project:
$ bash ~/bioinfo-notebook/scripts/linux_setup.sh
bioinfo-notebook/
βββ assets/
βΒ Β βββ bioinfo-notebook_logo.svg
βββ data/
βΒ Β βββ blastx_SwissProt_example_nucleotide_sequence.fasta.tsv
βΒ Β βββ blastx_SwissProt_S_cere.tsv
βΒ Β βββ design_table.csv
βΒ Β βββ example_genome_annotation.gtf
βΒ Β βββ example_nucleotide_sequence.fasta
βΒ Β βββ featCounts_S_cere_20200331.csv
βββ docs/
βΒ Β βββ annotated_snps_filter.md
βΒ Β βββ annotating_snps.md
βΒ Β βββ augustus.md
βΒ Β βββ blast.md
βΒ Β βββ bowtie2.md
βΒ Β βββ bowtie.md
βΒ Β βββ cl_intro.md
βΒ Β βββ cl_solutions.md
βΒ Β βββ combining_featCount_tables.md
βΒ Β βββ conda.md
βΒ Β βββ DE_analysis_edgeR_script.md
βΒ Β βββ DE_analysis_edgeR_script.pdf
βΒ Β βββ fasterq-dump.md
βΒ Β βββ fastq-dump.md
βΒ Β βββ fastq-dump_to_featureCounts.md
βΒ Β βββ featureCounts.md
βΒ Β βββ file_formats.md
βΒ Β βββ genome_annotation_SwissProt_CDS.md
βΒ Β βββ htseq-count.md
βΒ Β βββ linux_setup.md
βΒ Β βββ orthofinder.md
βΒ Β βββ part1.md # Navigation page for website
βΒ Β βββ part2.md # Navigation page for website
βΒ Β βββ part3.md # Navigation page for website
βΒ Β βββ report_an_issue.md
βΒ Β βββ samtools.md
βΒ Β βββ sgRNAcas9.md
βΒ Β βββ snp_calling.md
βΒ Β βββ SPAdes.md
βΒ Β βββ ubuntu_virtualbox.md
βΒ Β βββ UniProt_downloader.md
βΒ Β βββ wsl.md
βββ envs/ # conda environment files
βΒ Β βββ augustus.yml # environment for Augustus
βΒ Β βββ bioinfo-notebook.txt
βΒ Β βββ bioinfo-notebook.yml
βΒ Β βββ orthofinder.yml # environment for OrthoFinder
βΒ Β βββ sgRNAcas9.yml # environment for sgRNAcas9
βββ scripts/
βΒ Β βββ annotated_snps_filter.R
βΒ Β βββ annotating_snps.R
βΒ Β βββ combining_featCount_tables.py
βΒ Β βββ DE_analysis_edgeR_script.R
βΒ Β βββ fastq-dump_to_featureCounts.sh
βΒ Β βββ genome_annotation_SwissProt_CDS.sh
βΒ Β βββ linux_setup.sh
βΒ Β βββ snp_calling.sh
βΒ Β βββ UniProt_downloader.sh
βββ _config.yml # Configures github.io project website
βββ .gitignore
βββ LICENSE
βββ README.md
βββ .travis.yml # Configures Travis CI testing for GitHub repo