Table of Contents

Overview and Objectives

Once raw sequence files are generated (in FASTQ format) and quality-checked, the next step in most NGS pipelines is mapping to a reference genome. For individual sequences of interest, it is common to use a tool like BLAST to identify genes or species of origin. However, a typical example will have millions of reads, and a reference space that is frequently billions of bases, which BLAST and similar tools are not really designed to handle.

Thus, a large set of computational tools have been developed to quickly, and with sufficient (but NOT absolute) accuracy align each read to its best location, if any, in a reference. Even though many mapping tools exist, a few individual programs have a dominant "market share" of the NGS world. These programs vary widely in their design, inputs, outputs, and applications. In this section, we will primarily focus on two of the most versatile mappers: BWA and Bowtie2, the latter being part of the Tuxedo suite (e.g. Tophat2).

Sample Datasets

You have already worked with a paired-end yeast ChIP-seq dataset, which we will continue to use here.  The paired end data should be located at:

$SCRATCH/YEAST_FASTQ_AFTER_DAY_2

We will also use two additional RNA-seq datasets, which are located at:

/corral-repl/utexas/BioITeam/core_ngs_tools/human_stuff

Set up a new directory in your scratch area called 'fastq_align', and populate it with copies the following files, derived from the locations given above:

File NameDescriptionSample
Sample_Yeast_L005_R1.cat.fastq.gzPaired-end Illumina, First of pair, FASTQYeast ChIP-seq
Sample_Yeast_L005_R2.cat.fastq.gzPaired-end Illumina, Second of pair, FASTQYeast ChIP-seq
human_rnaseq.fastq.gzPaired-end Illumina, First of pair only, FASTQHuman RNA-seq
human_mirnaseq.fastq.gzSingle-end Illumina, FASTQHuman microRNA-seq
cds
mkdir fastq_align
cd fastq_align
cp $SCRATCH/YEAST_FASTQ_AFTER_DAY_2 /corral-repl/utexas/BioITeam/core_ngs_tools/human_stuff/*rnaseq.fastq.gz .


Do a fast quality check on the two new data files like you did earlier on the yeast files, and move all files and directories that are produced from the fastQC commands into a new subdirectory called 'fastqc_out'.

cd $SCRATCH/fastq_align
mkdir fastqc_out
module load fastqc
fastqc human_rnaseq.fastq.gz
fastqc human_mirnaseq.fastq.gz
mv *fastqc* fastqc_out

Reference Genomes

Before we get to alignment, we need a genome to align to.  We will use three different references here:  the human genome (hg19), the yeast genome (sacCer3), and mirbase (v20).  Mirbase is a collection of all known microRNAs in all species, and we will use the human subset of that database as our alignment reference.  This has the advantage of being significantly smaller than the human genome, while containing all the sequences we are actually interested in.

Due to natural variation, sequencing errors, and processing issues, variation between reference sequence and sample sequence is always possible. Alignment to the human genome allows a putative "microRNA" read the opportunity to find a better alignment in a region of the genome that is not an annotated microRNA relative to the microRNA reference sequence. If this occurs, we might think that a read represents a microRNA (since it aligned in the mirbase alignment), when it is actually more likely to have come from a non-miRNA area of the genome.

These are the three reference genomes we will be using today, with some information about them (and here is information about many more genomes):

ReferenceSpeciesBase LengthContig NumberSourceDownload
Hg19Human3.1 Gbp25 (really 93)UCSCUCSC GoldenPath
SacCer3Yeast12.2 Mbp17UCSCUCSC GoldenPath
MirbaseV20Human160 Kbp1908MirbaseMirbase Downloads

Searching genomes, however, is hard work and takes a long time if done on an un-indexed, linear genomic sequence.  So, most aligners require that references be indexed for quick access  The aligners we are using each require a different index, but use the same method (the Burrows-Wheeler Transform) to get the job done.  This requires taking a FASTA file as input, with each chromosome (or contig) as a separate entry, and producing some aligner-specific set of files as output.  Then, those output files are used by the aligner when executing a given alignment command. Hg19 is way too big for us to index here, so we're not going to do it, and it's not included in the core_ngs_tools directory at Corral that we've been copying from.  Instead, all hg19 index files are located at:

/scratch/01063/abattenh/ref_genome/bwa/bwtsw/hg19

Now, we're going to grab the other two references, and we will build each index right before we use it in each set of exercise below.  These two references are located at:

/corral-repl/utexas/BioITeam/core_ngs_tools/references/sacCer3.fa
/corral-repl/utexas/BioITeam/core_ngs_tools/references/hairpin_cDNA_hsa.fa

Now, stage the yeast and mirbase reference fasta files in your scratch area in a directory called 'references'.

cp -r /corral-repl/utexas/BioITeam/core_ngs_tools/references/*.fa $SCRATCH/

With that, we're ready to get started on the first exercise.

Exercise #1: BWA - Yeast ChIP-seq

Like other tools you've worked with so far, you first need to load bwa using the module system.  So, go ahead and do that now, and then enter 'bwa' with no arguments to view the help page.

module load bwa
bwa

As you can see, there are several commands one can use with bwa to do different things.  To test out one of them, we're going to index the genome with the 'index' command.  If you enter 'bwa index' with no arguments, you will see a list of the required arguments.  Here, we only need to specify two things: whether to use 'bwtsw' or 'is' indexing, and the name of the fasta file.  We will specify 'bwtsw' as the indexing option, and the name of the FASTA file is, obviously, sacCer3.fa.  The output of this command, importantly, is a group of files that are all required together as the index.  So, within the references directory, we will create another directory called "yeast", move the yeast FASTA file into that directory, and run the index commands from there:

cd $SCRATCH/references/
mkdir yeast
mv sacCer3.fa yeast
cd yeast
bwa index -a bwtsw sacCer3.fa

This command should produce a set of output files that look like this:

sacCer3.fa
sacCer3.fa.amb
sacCer3.fa.ann
sacCer3.fa.bwt
sacCer3.fa.pac
sacCer3.fa.sa

Now, we're ready to execute the actual alignment, with the goal of producing a SAM/BAM file from the input FASTQ files and reference.  We will first generate SAI files from each of the FASTQ files with the reference individually using the 'aln' command, then combine them (with the reference) into one SAM/BAM output file using the 'sampe' command.   We need a directory to put the alignments when they are finished, as well as any intermediate files, so create a directory called 'alignments'.  The command flow, all together, is as follows. Notice how each file is in its proper directory, which requires us to specify the whole file path in the alignment commands.

cds
mkdir alignments
bwa aln references/yeast/sacCer3.fa fastq_align/Sample_Yeast_L005_R1.cat.fastq.gz > alignments/yeast_R1.sai
bwa aln references/yeast/sacCer3.fa fastq_align/Sample_Yeast_L005_R2.cat.fastq.gz > alignments/yeast_R2.sai
bwa sampe references/yeast/sacCer3.fa alignments/yeast_R1.sai alignments/yeast_R2.sai fastq_align/Sample_Yeast_L005_R1.cat.fastq.gz fastq_align/Sample_Yeast_L005_R2.cat.fastq.gz > alignments/yeast_pairedend.sam

You did it!  In the alignments directory, there should exist the two intermediate files (the SAI files), along with the SAM file that contains the alignments.  It's just a text file, so take a look with head, more, less, tail, or whatever you feel like.  In the next section, with samtools, you'll learn some additional ways to analyze the data. BWA, however, is a lot more complex than the above commands let on.  If you look at the help pages for 'bwa aln' in particluar, there are numerous options that can increase the alignment rate (as well as decrease it), and all sorts of other things.  There are lots of options, but here is a summary of the most important ones.

OptionEffect
-kControls the number of mismatches allowable in the seed of each alignment (default = 2)
-nControls the number of mismatches (or fraction of bases in a given alignment that can be mismatches) in the entire alignment (including the seed) (default = 0.04)
-lControls the length of the seed (default = 32)
-tControls the number of threads

The rest of the options control the details of how much a mismatch or gap is penalized, limits on the number of acceptable hits per read, and so on.  Much more information can be accessed at the BWA manual page.

Exercise #2: Bowtie2 and Local Alignment - Human microRNA-seq

Now we're going to switch over to a different aligner that was originally designed for very short reads, and is frequently used for RNA-seq data.  Accordingly, we have prepared a test microRNA-seq dataset for you to experiment with.  This data is derived from a human H1 embryonic stem cell (H1-hESC) small RNA dataset generated by the ENCODE Consortium (its about a half million reads).  However, there is a problem!  We don't know (or, well, you don't know) what the adapter structure or sequences were.  So, you have a bunch of 36 base pair reads, but many of those reads will include extra sequence that will impede alignment!  We need an aligner that can find subsections of the read that align, and discard (or "soft-clip") the rest away.  Bowtie2 is just such an aligner.  Go ahead and load it up so we can examine some help pages and options.  To do that, you must first load the "perl" module, and then the bowtie2 module designated "bowtie/2.2.0". 

module load perl
module load bowtie/2.2.0
bowtie2

Now that it's loaded, 

Exercise #3: BWA-MEM (and Tophat2) - Human mRNA-seq

 

Future Directions