Contents

1 Introduction

Welcome to the ORFik package. ORFik is an R package for analysis of transcript and translation features through manipulation of sequence data and NGS data. This vignette will walk you through how to how to download annotation and align data with ORFik.

Here we will show a full example of aligning RNA-seq from yeast using the SacCer3 genome.

2 How ORFik organizes stored files

Working with NGS data and genome annotations, results ++, can be hassle to organize and to remember where everything is stored, ORFik tries to simplify this job for you by creating a fixed set of how files are organized. Using ORFiks organizing system is optional (you can specify all the paths manually if you want to), but using it will most likely make you code faster.

2.1 Specify output folders

Usually fastq files, processed data (bam files) and annotation (genome references) are stored in separate locations, for better clarity and re-usability of files.

Given a single parrent folder (for example “~/Bio_data/”), where all your Biological analysis is stored, ORFik uses a folder structure of separating these 3 types:

    1. fastq files (raw_data)
    1. bam files (processed_data)
    1. annotation reference files (references)

This is defined in the config() function, and only is needed to run once (config is stored for later experiments), so all other experiments will reuse the parent file structure. ORFik will try to automatically create suitable locations if the following function is not run;

  library(ORFik)                        # This package
  # Here the default values are shown:
  where_to_save_config <- "~/bio_data/ORFik_config.csv"
  
  parent_folder <- "~/bio_data/"
  fastq.dir <- file.path(parent_folder, "raw_data")
  bam.dir <- file.path(parent_folder, "processed_data")
  reference.dir <- file.path(parent_folder, "references")
  config.save(where_to_save_config,
              fastq.dir, bam.dir, reference.dir)

Either way if you made a custom config or let ORFik do it for you in next step, you can check what it is by now running config()

  config()

We have created the general folder structure, we must now create the folder structure for a specific experiment, like our yeast RNA-seq experiment from Chalmers et al.

  conf <- config.exper(experiment = "CHALMERS_Yeast", # short experiment info: here I used author + species
                     assembly = "Yeast_SacCer3", # Reference folder
                     type = c("RNA-seq")) # fastq and bam type
  conf

conf will show where the specific experiment will be stored.

3 Download RNA-seq NGS data

We will now download the NGS data, if you have in-lab data, you don’t need this step, since you already have access to the fastq files.

On the other hand, if you want to use published data, you need to download it. I here show what would work for the paired end RNA-seq experiment SRP012047.

ORFik comes with a read archive run downloader (Archives supported are: SRA, ERA, DRA or GSE). We will now show how to get metadata and data.

  1. Download using metadata table: The good thing here is that you can specify a project, and it will find all SRR numbers for you, in this vignette we will only download the 2 runs called SRR453566 and SRR453571. We will also only subset to download the 50000 first reads of the libraries, so you can replicate this faster. If you want to try full data it will take ~ 100 seconds to download on stable connection.
info <- download.SRA.metadata("SRP012047", outdir = conf["fastq RNA-seq"])
# Let's take 2 first runs in this experiment:
info <- info[1:2,]

Now let’s download the subset, using the metadata table (ORFik will automatically extract SRR numbers and download):

# Subset
# 18 MB, ~ 40 sec download time ->
download.SRA(info, conf["fastq RNA-seq"], subset = 50000) 

# Or you could do the full libraries
# 1.6 GB, ~ 100 sec download time 
# (Full size files have faster MB/s download speed than subsets) ->
# download.SRA(info, conf["fastq RNA-seq"]) 

We now have the RNA-seq run, separated into 2 files stored in the raw data fastq folder, there are 2 files since this is paired end data. We could for ease also just have specified the SRR number directly in download.SRA, but then we get no meta-data csv file, which is handy for auto-detection of paired end data, the organism name etc. This is shown below:

organism <- info$ScientificName[1]
is_paired_end <- all(info$LibraryLayout == "PAIRED")

4 Download genome and gtf files

To download the genome annotation we use the getGenomeAndAnnotation function. We need to decide 3 things:

The uncompressed toplevel file of human genome is > 70 GB, so for large genomes (like for human) you should usually set to primary_assembly (3 GB for human, no chromosome haplotypes). For small organisms like yeast, they don’t have a primary assembly, so use “toplevel”.

  annotation <- getGenomeAndAnnotation(
                      organism = organism, 
                      output.dir = conf["ref"],
                      assembly_type = "toplevel"
                      )

The function will also create a txdb object to speed up loading of gtf annotation, and index your genome to a .fai file (fasta index), for faster access to genomic regions.

If you rerun this function after is has completed, it will not re-download, only output the correct object paths, this makes it easy to rerun the script (for other experiments of same species), when you have some steps already completed before.

4.1 Contaminants

If you you want to remove contaminants: phix, non coding RNAs, ribosomal RNAs, or tRNAs, also specify these in the function. By default it will download phix from refseq and the other contaminants are usually defined within the genome annotation of the species, so they are extracted from the .gtf file.

  annotation <- getGenomeAndAnnotation(
                      organism = organism, 
                      genome = TRUE, GTF = TRUE,
                      phix = TRUE, ncRNA = TRUE, tRNA = TRUE, rRNA = TRUE,
                      output.dir = conf["ref"],
                      assembly_type = "toplevel"
                      )

Note that some species does not have well annotated rRNAs, tRNAs etc in their gtf files. For this ORFik contains some clever tricks:

  • rRNA: You can set rRNA = “silva” to download the Silva database (~ 2GB file)
  • ncRNA: If the gtf does not have Non-coding RNAs, they can be extracted by setting ncRNA = “auto”, it will then check if the organism exists in the NONCODE database and automatically download them for you if they exists.
  • tRNA: Genomes without defined tRNAs are rare, and no web API to access tRNAs for all common experimental organisms exists. So in that rare case, you must manually download and add the sequences from tRNAs using tRNA scan or similar databases (then add this file to the getGenomeAndAnnotation call using argument tRNA = “path/to/downloaded/tRNAs.fasta”)

5 RNA-seq alignment

ORFik uses the STAR aligner, which is splice aware and fast and shown to usually map the highest amount of reads. The sad thing is that it only works on unix systems (Linux or Mac).

For windows users: installing and running ORFik on Windows subsystem for Linux (WSL) will work, if you want to align data with ORFik.

To align the data we need two steps, the indexing of the genome step and the alignment to the genome step.

5.1 Indexing

To index the genome just give it the annotation output from previous step. This will also make an index for each of the depletion steps like phix, if you specified them in the earlier step.

index <- STAR.index(annotation)

If you run this function again after index exists in current file location, it will not re-index, but just output the correct object paths. Do remake = TRUE if you want to re-index.

5.2 Aligning the data

ORFik uses the fastp for trimming reads, this also only works on unix (Linux or Mac OS). If you are on windows, or you want to trim the reads yourself, just run the trimming and give the folder with the trimmed reads as input in next step. Also if you are unsure of what the 3’ adapter was, run first FASTQC to which adapters are detected. The great thing with fastp is that it has auto detection and removal of adapters, if you check out the resulting files you will see fastp has auto removed the Illumina adapters.

Now let’s see what we need as inputs for the alignment pipeline: We need usually 9 arguments (more are possible if you need them):

  • input.dir.rna: directory with fastq files (or trimmed files on mac)
  • output.dir.rna: output directory for bam files
  • index: the STAR index from previous step
  • paired.end: “yes” in this case, or “no” if single end.
  • steps: steps of depletion and alignment wanted: (a string: which steps to do? (default: “tr-ge”, write “all” to get all: “tr-co-ge”) tr: trimming (only for unix), co: deplete contaminants included, ph: phix depletion, rR: rrna depletion, nc: ncrna depletion, tR: trna depletion, ge: genome alignment) Write your wanted steps, seperated by “-”. Order does not matter. To just do trim and alignment to genome write “tr-ge”
  • adapter.sequence “auto”, or if you know add it, usually more secure with manual. Presets are “illumina”, “small_RNA” and “nextera”.
  • max.cpus How many cpus maximum to use
  • trim.front How many bases to trim front. Only if you believe there are low quality reads in front.
  • min.length minimum length of reads that pass to the bam file.
alignment <- 
  STAR.align.folder(conf["fastq RNA-seq"], conf["bam RNA-seq"], index,
                    paired.end = is_paired_end,
                    steps = "tr-ge", # (trim needed: adapters found, then genome)
                    adapter.sequence = "auto",
                    max.cpus = 30, trim.front = 3, min.length = 20)

If you used the fastp (tr step), you will get a pre-alignment QC report. Just like FastQC in html format. You will also get a MultiQC report from STAR runs made by ORFik for you.

5.3 Solving errors when aligning:

Running STAR is a heavy job for most machines, so you may experience an error if your machine is not good enough or you have a non-default OS config (Aligning human genome on 32GB memory computer will make it useless for any other task until alignment is done, so if you have access to a multi-core server with more memory, you should use it).

We will now go through some possible problems and how to fix them.

5.3.1 RAM usage warnings

STAR is very memory hungry, therefor if you want to index and align large genomes like human (3 GB usually), you might need to adjust 2 parameters. If you have less than 40 GB free memory (32 GB might work), adjust this during indexing:

  • 20 GB max ram usage during genome generation
  • 2 SA sparse (suffix array should be sparse, this will give slower mapping)
index <- STAR.index(annotation, max.ram = 20, SAsparse = 2)

5.3.2 Systems with that restricts max open files

STAR can use a lot of threads, each threads makes many several files open. Some systems have a restriction on how many files you can have open. This is found by doing “ulimit -Hn” in the terminal. If STAR crashes from this error, you need either increase amount of open files allowed (requires root access) or decrease the amount of cores used by STAR (does not require root access):

STAR.align.folder(conf["fastq RNA-seq"], conf["bam RNA-seq"], index,
                    max.cpus = 4) # Reduce cores to 4 usually works for most systems

6 Create an ORFik experiment of the Yeast data

The next step is to make an ORFik experiment (check out the ORFik experiment vignette if you are unfamiliar with this class).

If you renamed the files during the fastq step properly, this will make the ORFik experiment able to guess correctly what the data is. If there are replicates etc. If you did not, you can still rename the bam files now.

We can now easily make an ORFik experiment from the data we have:

txdb_file <- paste0(annotation["gtf"], ".db") # Get txdb file, not raw gtf
fa <- annotation["genome"]
create.experiment(exper = "yeast_exp_RNA",
                  dir = paste0(conf["bam RNA-seq"], "/aligned/"),
                  txdb = txdb_file, 
                  fa = fa, 
                  organism = organism,
                  viewTemplate = FALSE, 
                  pairedEndBam = is_paired_end # True/False per bam file
                  )

The files is now saved to default directory which is: saveDir = “~/Bio_data/ORFik_experiments/”

df <- read.experiment("yeast_exp_RNA")

If you are not happy with the libtype, stage, replicates and so on for the file, you can edit the ORFik experiment in R (recreate experiment, wanted slots) or edit in Libre Office, Excel or another spreadsheet viewer.

6.1 Post alignment QC report

See ?QCreport for details of what you will get as output

  QCreport(df)

6.2 Convert libraries to new formats

Now you have an experiment, but bam files are big and slow to load. Let’s convert to some faster formats.

If you want optimzed format identical to bam file (contains cigar information), use .ofst. (Fastest, not readable in IGV) (ofst files are made when running ORFikQC)

  remove.experiments(df) # Remove loaded libraries
  convertLibs(df, type = "ofst")

If you want peaks only, use wig files (Fast, readable in IGV)

  remove.experiments(df)
  convertLibs(df, type = "wig")

As an example of how to load the data to R in the optimized format .ofst.

6.3 Outputting libraries to R

This will output the libraries to the environment specified, default .GlobalEnv (the default R environment). The files are named from the experiment table RNA_1_WT, RNA_1_treated etc.

  remove.experiments(df)
  outputLibs(df, type = "ofst")

6.4 FPKM values (normalized counts)

After you have run QCreport you will have count tables of peaks over the mrna’s, 5’ UTRs, CDS and 3’ UTRs.

Let’s do an example to find the ratio between fpkm of between the CDS and mRNAs transcript regions.

  mrna <- countTable(df, region = "mrna", type = "fpkm")
  cds <- countTable(df, region = "cds", type = "fpkm")
  ratio <- cds / mrna

We now have a ratio of fpkm values between CDS and mrna.

You can now continue to the Ribo-seq pipeline to see a more advanced example.