Title: | Mapping, quantification and variant analysis of sequencing data |
---|---|
Description: | Alignment, quantification and analysis of RNA sequencing data (including both bulk RNA-seq and scRNA-seq) and DNA sequenicng data (including ATAC-seq, ChIP-seq, WGS, WES etc). Includes functionality for read mapping, read counting, SNP calling, structural variant detection and gene fusion discovery. Can be applied to all major sequencing techologies and to both short and long sequence reads. |
Authors: | Wei Shi, Yang Liao and Gordon K Smyth with contributions from Jenny Dai |
Maintainer: | Wei Shi <[email protected]>, Yang Liao <[email protected]> and Gordon K Smyth <[email protected]> |
License: | GPL (>=3) |
Version: | 2.21.1 |
Built: | 2024-11-01 03:39:56 UTC |
Source: | https://github.com/bioc/Rsubread |
The align
function can align both DNA and RNA sequencing reads. Subjunc
is an RNA-seq aligner and it reports full alignment of each read (align
reports partial alignment for exon spanning reads).
align( # index for reference sequences index, # input reads and output readfile1, readfile2 = NULL, type = "rna", input_format = "gzFASTQ", output_format = "BAM", output_file = paste(readfile1,"subread",output_format,sep="."), # offset value added to Phred quality scores of read bases phredOffset = 33, # thresholds for mapping nsubreads = 10, TH1 = 3, TH2 = 1, maxMismatches = 3, # unique mapping and multi-mapping unique = FALSE, nBestLocations = 1, # indel detection indels = 5, complexIndels = FALSE, # read trimming nTrim5 = 0, nTrim3 = 0, # distance and orientation of paired end reads minFragLength = 50, maxFragLength = 600, PE_orientation = "fr", # number of CPU threads nthreads = 1, # read group readGroupID = NULL, readGroup = NULL, # read order keepReadOrder = FALSE, sortReadsByCoordinates = FALSE, # color space reads color2base = FALSE, # dynamic programming DP_GapOpenPenalty = -1, DP_GapExtPenalty = 0, DP_MismatchPenalty = 0, DP_MatchScore = 2, # detect structural variants detectSV = FALSE, # gene annotation useAnnotation = FALSE, annot.inbuilt = "mm39", annot.ext = NULL, isGTF = FALSE, GTF.featureType = "exon", GTF.attrType = "gene_id", chrAliases = NULL) subjunc( # index for reference sequences index, # input reads and output readfile1, readfile2 = NULL, input_format = "gzFASTQ", output_format = "BAM", output_file = paste(readfile1,"subjunc",output_format,sep = "."), # offset value added to Phred quality scores of read bases phredOffset = 33, # thresholds for mapping nsubreads = 14, TH1 = 1, TH2 = 1, maxMismatches = 3, # unique mapping and multi-mapping unique = FALSE, nBestLocations = 1, # indel detection indels = 5, complexIndels = FALSE, # read trimming nTrim5 = 0, nTrim3 = 0, # distance and orientation of paired end reads minFragLength = 50, maxFragLength = 600, PE_orientation = "fr", # number of CPU threads nthreads = 1, # read group readGroupID = NULL, readGroup = NULL, # read order keepReadOrder = FALSE, sortReadsByCoordinates = FALSE, # color space reads color2base = FALSE, # dynamic programming DP_GapOpenPenalty = -1, DP_GapExtPenalty = 0, DP_MismatchPenalty = 0, DP_MatchScore = 2, # detect all junctions including gene fusions reportAllJunctions = FALSE, # gene annotation useAnnotation = FALSE, annot.inbuilt = "mm39", annot.ext = NULL, isGTF = FALSE, GTF.featureType = "exon", GTF.attrType = "gene_id", chrAliases = NULL)
align( # index for reference sequences index, # input reads and output readfile1, readfile2 = NULL, type = "rna", input_format = "gzFASTQ", output_format = "BAM", output_file = paste(readfile1,"subread",output_format,sep="."), # offset value added to Phred quality scores of read bases phredOffset = 33, # thresholds for mapping nsubreads = 10, TH1 = 3, TH2 = 1, maxMismatches = 3, # unique mapping and multi-mapping unique = FALSE, nBestLocations = 1, # indel detection indels = 5, complexIndels = FALSE, # read trimming nTrim5 = 0, nTrim3 = 0, # distance and orientation of paired end reads minFragLength = 50, maxFragLength = 600, PE_orientation = "fr", # number of CPU threads nthreads = 1, # read group readGroupID = NULL, readGroup = NULL, # read order keepReadOrder = FALSE, sortReadsByCoordinates = FALSE, # color space reads color2base = FALSE, # dynamic programming DP_GapOpenPenalty = -1, DP_GapExtPenalty = 0, DP_MismatchPenalty = 0, DP_MatchScore = 2, # detect structural variants detectSV = FALSE, # gene annotation useAnnotation = FALSE, annot.inbuilt = "mm39", annot.ext = NULL, isGTF = FALSE, GTF.featureType = "exon", GTF.attrType = "gene_id", chrAliases = NULL) subjunc( # index for reference sequences index, # input reads and output readfile1, readfile2 = NULL, input_format = "gzFASTQ", output_format = "BAM", output_file = paste(readfile1,"subjunc",output_format,sep = "."), # offset value added to Phred quality scores of read bases phredOffset = 33, # thresholds for mapping nsubreads = 14, TH1 = 1, TH2 = 1, maxMismatches = 3, # unique mapping and multi-mapping unique = FALSE, nBestLocations = 1, # indel detection indels = 5, complexIndels = FALSE, # read trimming nTrim5 = 0, nTrim3 = 0, # distance and orientation of paired end reads minFragLength = 50, maxFragLength = 600, PE_orientation = "fr", # number of CPU threads nthreads = 1, # read group readGroupID = NULL, readGroup = NULL, # read order keepReadOrder = FALSE, sortReadsByCoordinates = FALSE, # color space reads color2base = FALSE, # dynamic programming DP_GapOpenPenalty = -1, DP_GapExtPenalty = 0, DP_MismatchPenalty = 0, DP_MatchScore = 2, # detect all junctions including gene fusions reportAllJunctions = FALSE, # gene annotation useAnnotation = FALSE, annot.inbuilt = "mm39", annot.ext = NULL, isGTF = FALSE, GTF.featureType = "exon", GTF.attrType = "gene_id", chrAliases = NULL)
index |
character string giving the basename of index file. Index files should be located in the current directory. |
readfile1 |
a character vector including names of files that include sequence reads to be aligned. For paired-end reads, this gives the list of files including first reads in each library. File format is FASTQ/FASTA by default. See |
readfile2 |
a character vector giving names of files that include second reads in paired-end read data. Files included in |
type |
a character string or an integer giving the type of sequencing data. Possible values include |
input_format |
character string specifying format of read input files. |
output_format |
character string specifying format of output file. |
output_file |
a character vector specifying names of output files. By default, names of output files are set as the file names provided in |
phredOffset |
numeric value added to base-calling Phred scores to make quality scores (represented as ASCII letters). Possible values include |
nsubreads |
numeric value giving the number of subreads extracted from each read. |
TH1 |
numeric value giving the consensus threshold for reporting a hit. This is the threshold for the first reads if paired-end read data are provided. |
TH2 |
numeric value giving the consensus threhold for the second reads in paired-end data. |
maxMismatches |
numeric value giving the maximum number of mis-matched bases allowed in the alignment. |
unique |
logical indicating if only uniquely mapped reads should be reported. A uniquely mapped read has one single mapping location that has less mis-matched bases than any other candidate locations. By default, multi-mapping reads will be reported in addition to uniquely mapped reads. Number of alignments reported for each multi-mapping read is determined by the |
nBestLocations |
numeric value specifying the maximal number of equally-best mapping locations that will be reported for a multi-mapping read. 1 by default. The allowed value is between 1 to 16 (inclusive). In the mapping output, ‘NH’ tag is used to indicate how many alignments are reported for the read and ‘HI’ tag is used for numbering the alignments reported for the same read. This argument is only applicable when |
indels |
numeric value giving the maximum number of insertions/deletions allowed during the mapping. |
complexIndels |
logical indicating if complex indels will be detected. If |
nTrim5 |
numeric value giving the number of bases trimmed off from 5' end of each read. |
nTrim3 |
numeric value giving the number of bases trimmed off from 3' end of each read. |
minFragLength |
numeric value giving the minimum fragment length. 50 by default. |
maxFragLength |
numeric value giving the maximum fragment length. 600 by default. |
PE_orientation |
character string giving the orientation of the two reads from the same pair. It has three possible values including |
nthreads |
numeric value giving the number of threads used for mapping. |
readGroupID |
a character string giving the read group ID. The specified string is added to the read group header field and also be added to each read in the mapping output. |
readGroup |
a character string in the format of |
keepReadOrder |
logical indicating if the order of reads in the BAM output is kept the same as that in the input file. (Reads from the same pair are always placed next to each other regardless of this option). |
sortReadsByCoordinates |
logical indicating if reads will be sorted by their mapping locations in the mapping output. This option is applicable for BAM output only. A BAI index file will also be generated for each BAM file so the generated BAM files can be directly loaded into a genome browser such as IGB or IGV. |
color2base |
logical. If |
DP_GapOpenPenalty |
a numeric value giving the penalty for opening a gap when using the Smith-Waterman dynamic programming algorithm to detect insertions and deletions. The Smith-Waterman algorithm is only applied for those reads which are found to contain insertions or deletions. |
DP_GapExtPenalty |
a numeric value giving the penalty for extending the gap, used by the Smith-Waterman algorithm. |
DP_MismatchPenalty |
a numeric value giving the penalty for mismatches, used by the Smith-Waterman algorithm. |
DP_MatchScore |
a numeric value giving the score for matches used by the Smith-Waterman algorithm. |
detectSV |
logical indicating if structural variants (SVs) will be detected during read mapping. See below for more details. |
reportAllJunctions |
logical indicating if all discovered junctions will be reported. This includes exon-exon junctions and also gene fusions. Presence of donor/receptor sites is not required when |
useAnnotation |
logical indicating if gene annotation information will be used in the mapping. |
annot.inbuilt |
a character string specifying an inbuilt annotation used for read summarization. It has five possible values |
annot.ext |
A character string giving name of a user-provided annotation file or a data frame including user-provided annotation data. If the annotation is in GTF format, it can only be provided as a file. If it is in SAF format, it can be provided as a file or a data frame. The provided annotation file can be a uncompressed or gzip compressed file. If an annotation is provided via |
isGTF |
logical indicating if the annotation provided via the |
GTF.featureType |
a character string denoting the type of features that will be extracted from a GTF annotation. |
GTF.attrType |
a character string denoting the type of attributes in a GTF annotation that will be used to group features. |
chrAliases |
a character string providing the name of a comma-delimited text file that includes aliases of chromosome names. This file should contain two columns. First column contains names of chromosomes included in the SAF or GTF annotation and second column contains corresponding names of chromosomes in the reference genome. No column headers should be provided. Also note that chromosome names are case sensitive. This file can be used to match chromosome names between the annotation and the reference genome. |
align
and subjunc
are R versions of programs in the Subread suite of programs (http://subread.sourceforge.net) that implement fast, accurate sequence read alignment based on the "seed-and-vote" mapping paradigm (Liao et al. 2013; Liao et al. 2019).
align
is the R version of the command-line program subread-align
and subjunc
is the R version of the command-line program subjunc
.
align
is a general-purpose aligner that can be used to align both genomic DNA-seq reads and RNA-seq reads.
subjunc
is designed for mapping RNA-seq reads only.
The main difference between subjunc
and align
for RNA-seq alignment is that subjunc
reports discovered exon-exon junctions and it also performs full alignments for every read including exon-spanning reads.
align
instead reports the largest mappable regions for each read and soft-clips the remainder of the read.
subjunc
requires the presence of donor and receptor sites when calling exon-exon junctions.
It can detect up to four junction locations in a junction read.
align
and subjunc
can be run with either a full index or a gapped index (see buildindex
for more details).
Maximum mapping speed is achieved when the full index is used.
With a full index built for human/mouse genome, align
maps ~14 million reads per minute with 10 threads.
subjunc
is slightly slower than align
.
Both align
and subjunc
require 17.8GB of memory for mapping.
With a gapped index built for human/mouse genome, align
maps ~9 million reads per minute with 10 threads.
align
requires 8.2GB of memory for mapping and subjunc
requires 8.8GB of memory.
The detectSV
argument of align
can be used to detect structural variants (SVs) in genomic DNA sequencing data.
The reportAllJunctions
argument of subjunc
function can be used for the detection of SVs in RNA-seq data, as well as the detection of non-canonical junctions that do not have the canonical donor/receptor sites.
For each library, breakpoints detected from SV events are saved to a file with suffix name ‘.breakpoints.txt’, which includes chromosomal coordinates of SV breakpoints and numbers of supporting reads.
The BAM/SAM output includes extra fields to describe the complete alignments of breakpoint-containing reads.
For a breakpoint-containing read, mapping of its major sequence segment is described in the main fields of BAM/SAM output whereas mapping of its minor sequence segment, which does not map along with the major segment due to the presence of a breakpoint, is described in the extra fields including 'CC'(Chr), 'CP'(Position),'CG'(CIGAR) and 'CT'(strand).
Note that each breakpoint-containing read occupies only one row in the BAM/SAM output.
For each library, mapping results including both aligned and unaligned reads are saved to a file.
Indels discovered during mapping are saved to a VCF format file (.indel.vcf
).
subjunc
also outputs a BED format file that contains list of discovered exon-exon junctions (.junction.bed
).
If detectSV
or reportAllJunctions
options are set to TRUE
, structural variants discovered during read mapping will be reported and saved to a file (.breakpoints.txt
), which includes chromosomal coordinates of breakpoints and number of supporting reads for each breakpoint.
Other than outputting data to files, align
and subjunc
also return a data.frame
that includes mapping statistics for each library, such as total number of reads, number of mapped reads, number of uniquely mapped reads, number of indels and number of junctions (subjunc
only).
Wei Shi and Yang Liao
Yang Liao, Gordon K Smyth and Wei Shi (2019). The R package Rsubread is easier, faster, cheaper and better for alignment and quantification of RNA sequencing reads. Nucleic Acids Research, 47(8):e47. http://www.ncbi.nlm.nih.gov/pubmed/30783653
Yang Liao, Gordon K Smyth and Wei Shi (2013). The Subread aligner: fast, accurate and scalable read mapping by seed-and-vote. Nucleic Acids Research, 41(10):e108. http://www.ncbi.nlm.nih.gov/pubmed/23558742
# Build an index for the artificial sequence included in file 'reference.fa'. ref <- system.file("extdata","reference.fa",package="Rsubread") buildindex(basename="./reference_index",reference=ref) # align a sample read dataset ('reads.txt') to the sample reference reads <- system.file("extdata","reads.txt.gz",package="Rsubread") align.stat <- align(index = "./reference_index", readfile1 = reads, output_file = "./Rsubread_alignment.BAM", phredOffset = 64) align.stat
# Build an index for the artificial sequence included in file 'reference.fa'. ref <- system.file("extdata","reference.fa",package="Rsubread") buildindex(basename="./reference_index",reference=ref) # align a sample read dataset ('reads.txt') to the sample reference reads <- system.file("extdata","reads.txt.gz",package="Rsubread") align.stat <- align(index = "./reference_index", readfile1 = reads, output_file = "./Rsubread_alignment.BAM", phredOffset = 64) align.stat
Calculate percentages of nucleotides A, T, G and C in the input FASTQ or FASTQ file.
atgcContent( filename, basewise = FALSE)
atgcContent( filename, basewise = FALSE)
filename |
a character string giving the name of input FASTQ/FASTA file |
basewise |
logical specifying how the percentages are calculated. If |
Sequencing reads could contain letter "N" besides "A", "T", "G" and "C". Percentage of "N" in the read dataset is calcuated as well.
The basewise
calculation is useful for examining the GC bias towards the base position in the read.
By default, the percentages of nucleotides in the entire dataset will be reported.
A named vector containing percentages for each nucleotide type if basewise
is FALSE
.
Otherwise, a data matrix containing nucleotide percentages for each base position of the reads.
Zhiyin Dai and Wei Shi
An index needs to be built before read mapping can be performed. This function creates a hash table index for the reference genome, which can then be used by Subread and Subjunc aligners for read alignment.
buildindex( # basic input/output options basename, reference, # options for the details of the index gappedIndex = FALSE, indexSplit = FALSE, memory = 8000, TH_subread = 100, colorspace = FALSE)
buildindex( # basic input/output options basename, reference, # options for the details of the index gappedIndex = FALSE, indexSplit = FALSE, memory = 8000, TH_subread = 100, colorspace = FALSE)
basename |
a character string giving the basename of created index files. |
reference |
a character string giving the name of a FASTA or gzipped FASTA file containing the sequences of all chromosomes and contigs. |
gappedIndex |
logical indicating whether a gapped index or a full index should be built. A gapped index contains 16mers (subreads) that are extracted every three bases from a reference genome, whereas a full index contains subreads extracted from every chromosomal location of a genome. The index provides a hash table mapping the sequences of all subreads to their corresponding chromosomal locations. Default value is |
indexSplit |
logical indicating whether the index can be split into multiple blocks. The block size is determined by the value of |
memory |
a numeric value specifying the amount of memory (in megabytes) used for storing the index during read mapping. 8000 MB by default. Note that this option is ignored when |
TH_subread |
a numeric value specifying the threshold for removing highly repetitive subreads (16bp mers). 100 by default. Subreads will be excluded from the index if they occur more than threshold number of times in the genome. |
colorspace |
logical specifying the mode of the index. If |
This function generates a hash-table index for a reference genome, in which keys are subreads (16mers) and values are their chromosomal locations in the reference genome.
The built index can then be used by Subread (align
) and subjunc
aligners to map reads (Liao et al. 2019; Liao et al. 2013).
Index building is an one-off operation.
Highly repetitive subreads (or uninformative subreads) are excluded from the hash table so as to reduce mapping ambiguity.
TH_subread
specifies the maximal number of times a subread is allowed to occur in the reference genome to be included in hash table.
Maximum mapping speed can be achieved by building a full index for the reference genome.
By default buildindex
builds a full index.
Building a gapped index will significantly reduce the memory use, at a modest cost to read mapping time.
It is recommended to use a gapped index on a personal computer due to the limited amount of computer memory available.
Memory use can be further reduced by splitting an index to multiple blocks.
The amount of memory to be used in read mapping is determined at the index building stage.
To build a full index for human/mouse genome, buildindex
function requires 15GB memory.
When using a full index to map reads to human/mouse genome, align
and subjunc
requires 17.8GB memory.
To build a gapped index for human/mouse genome, buildindex
function only requires 5.7GB memory.
When using a gapped index to map reads to human/mouse genome, align
requires 8.2GB memory and subjunc
requires 8.8GB memory.
Sequences of reference genomes can be downloaded from public databases. For instance, primary assembly of human genome GRCh38/hg38 or mouse genome GRCm38/mm10 can be downloaded from the GENCODE database via the following links:
No value is produced but index files are written to the current working directory.
Wei Shi and Yang Liao
Yang Liao, Gordon K Smyth and Wei Shi (2019). The R package Rsubread is easier, faster, cheaper and better for alignment and quantification of RNA sequencing reads. Nucleic Acids Research, 47(8):e47. http://www.ncbi.nlm.nih.gov/pubmed/30783653
Yang Liao, Gordon K Smyth and Wei Shi (2013). The Subread aligner: fast, accurate and scalable read mapping by seed-and-vote. Nucleic Acids Research, 41(10):e108. http://www.ncbi.nlm.nih.gov/pubmed/23558742
# Build an index for the artifical sequence included in file 'reference.fa' ref <- system.file("extdata","reference.fa",package="Rsubread") buildindex(basename="./reference_index",reference=ref)
# Build an index for the artifical sequence included in file 'reference.fa' ref <- system.file("extdata","reference.fa",package="Rsubread") buildindex(basename="./reference_index",reference=ref)
Process raw 10X scRNA-seq data and generate UMI counts for each gene in each cell.
cellCounts( # input data index, sample, input.mode = "BCL", cell.barcode = NULL, # parameters used for mapping reads nsubreads = 15, minVotes = 1, maxMismatches = 10, minMappedLength = 1, # parameters used for assigning and counting UMIs annot.inbuilt = "mm39", annot.ext = NULL, isGTFAnnotationFile = FALSE, GTF.featureType = "exon", GTF.attrType = "gene_id", useMetaFeatures = TRUE, # user provided UMI cutoff for cell calling umi.cutoff = NULL, # number of threads nthreads = 10, # parameters for alignment of multi-mapping reads nBestLocations = 1, uniqueMapping = FALSE, # report UMI counts for cell barcodes that were filtered out reportExcludedBarcodes = FALSE )
cellCounts( # input data index, sample, input.mode = "BCL", cell.barcode = NULL, # parameters used for mapping reads nsubreads = 15, minVotes = 1, maxMismatches = 10, minMappedLength = 1, # parameters used for assigning and counting UMIs annot.inbuilt = "mm39", annot.ext = NULL, isGTFAnnotationFile = FALSE, GTF.featureType = "exon", GTF.attrType = "gene_id", useMetaFeatures = TRUE, # user provided UMI cutoff for cell calling umi.cutoff = NULL, # number of threads nthreads = 10, # parameters for alignment of multi-mapping reads nBestLocations = 1, uniqueMapping = FALSE, # report UMI counts for cell barcodes that were filtered out reportExcludedBarcodes = FALSE )
index |
A character string providing the base name of index files that were created for a reference genome by using |
sample |
A data frame or a character string providing sample-related information. The value provided to this parameter depends on the |
input.mode |
A character string specifying the input mode. The supported input modes include |
cell.barcode |
A character string giving the name of a text file (can be gzipped) that contains the set of cell barcodes used in sample preparation. If |
nsubreads |
A numeric value giving the number of subreads (seeds) extracted from each read. |
minVotes |
A numeric value giving the minimum number of votes required for reporting a hit. |
maxMismatches |
A numeric value giving the maximum number of mis-matched bases allowed in the mapping of a read. |
minMappedLength |
A numeric value giving the minimum number of mapped bases in a read required for reporting a hit. |
annot.inbuilt |
Specify an inbuilt annotation for UMI counting. See |
annot.ext |
Specify an external annotation for UMI counting. See |
isGTFAnnotationFile |
See |
GTF.featureType |
See |
GTF.attrType |
See |
useMetaFeatures |
Specify if UMI counting should be carried out at the meta-feature level (eg. gene level). See |
umi.cutoff |
Specify a UMI count cutoff for cell calling. All the cells with a total UMI count greater than this cutoff will be called. If |
nthreads |
A numeric value giving the number of threads used for read mapping and counting. |
nBestLocations |
A numeric value giving the maximum number of reported alignments for each multi-mapping read. |
uniqueMapping |
A logical value specifying if the multi-mapping reads should not be reported as mapped (i.e. reporting uniquely mapped reads only). |
reportExcludedBarcodes |
If |
The cellCounts
function takes as input scRNA-seq reads generated by the 10X platform, maps them to the reference genome and then produces UMI (Unique Molecular Identifier) counts for each gene in each cell.
It also performs sample demultiplexing, cell barcode demultiplexing and read deduplication, before generating UMI counts.
It can process multiple datasets at the same time.
The sample information can be provided to cellCounts
via the sample
parameter.
If the input format is BCL
or CBCL
, the provided sample information should include the location where the read data are stored, flowcell lanes used for sequencing, sample names and names of index sets used for indexing samples.
If a sample was sequenced in all lanes, then its lane number can be set as *
.
Alternatively, all the lane numbers can be listed for this sample.
The sample information should be saved to a data.frame
object and then provided to the sample
parameter.
Below shows an example of this data frame:
InputDirectory Lane SampleName IndexSetName /path/to/dataset1 1 Sample1 SI-GA-E1 /path/to/dataset1 1 Sample2 SI-GA-E2 /path/to/dataset1 2 Sample1 SI-GA-E1 /path/to/dataset1 2 Sample2 SI-GA-E2 /path/to/dataset2 1 Sample3 SI-GA-E3 /path/to/dataset2 1 Sample4 SI-GA-E4 /path/to/dataset2 2 Sample3 SI-GA-E3 /path/to/dataset2 2 Sample4 SI-GA-E4 ...
It is compulsory to have the four column headers shown in the example above when generating this data frame for a 10X dataset.
If more than one datasets are provided for analysis, the InputDirectory
column should include more than one distinct directory.
Note that this data frame is different from the Sample Sheet generated by the Illumina sequencer.
The cellCounts
function uses the index set names included in this data frame to generate an Illumina Sample Sheet and then uses it to demultiplex all the samples.
If the input format is FASTQ
, a data.frame
object containing the following three columns, BarcodeUMIFile
, ReadFile
and SampleName
, should be provided to the sample
parameter.
Each row in the data frame represents a sample.
The BarcodeUMIFile
column should include names of FASTQ files containing cell barcode and UMI sequences for each read, and the ReadFile
column should include names of FASTQ files containing genomic sequences for corresponding reads.
If the input format is FASTQ-dir
, a character string, which includes the path to the directory where the FASTQ-format read data are stored, should be provided to the sample
parameter.
The data in this directory are expected to be generated by the bcl2fastq
program (developed by Illumina), or by the cellranger mkfastq
command (developed by 10x), or by the bamtofastq
program (developed by 10x).
Finally, if the input format is BAM
, a data.frame
object containing the following two columns, BAMFile
and SampleName
, should be provided to the sample
parameter.
Each row in the data frame represents a sample.
The BAMFile
column should include names of BAM files containing genomic sequences of reads with associated cell barcode and UMI sequences.
The cell barcode and UMI sequences should be provided in the "CR" and "UR" tags included in the BAM files.
The Phred-encoded quality strings of the cell barcode and UMI sequences should be provided in the "CY" and "UY" tags.
These tags were originally defined in CellRanger BAM files.
The cellCounts
function returns a List
object to R.
It also outputs one BAM file for each sample. The BAM file includes location-sorted read mapping results.
If the input mode is neither FASTQ
nor FASTQ-dir
, it also outputs three or four gzipped FASTQ files, which include cell barcode and UMI sequences (R1), sample index sequences (I1, and optionally I2 for dual-indexed samples) and the actual genomic sequences of the reads (R2), respectively.
The returned List
object contains the following components:
counts |
a |
annotation |
a |
sample.info |
a |
cell.confidence |
a |
counts.excluded.barcodes |
a |
Yang Liao and Wei Shi
buildindex
, align
, featureCounts
# Data used in this example (71MB) can be downloaded from https://shilab-bioinformatics.github.io/cellCounts-Example/cellCounts-Example.zip ## Not run: library(Rsubread) buildindex("chr1", "hg38_chr1.fa.gz") sample.sheet <- data.frame(BarcodeUMIFile="reads_R1.fastq.gz", ReadFile="reads_R2.fastq.gz", SampleName="Example") counts <- cellCounts("chr1", sample.sheet, input.mode="FASTQ", annot.inbuilt="hg38") ## End(Not run)
# Data used in this example (71MB) can be downloaded from https://shilab-bioinformatics.github.io/cellCounts-Example/cellCounts-Example.zip ## Not run: library(Rsubread) buildindex("chr1", "hg38_chr1.fa.gz") sample.sheet <- data.frame(BarcodeUMIFile="reads_R1.fastq.gz", ReadFile="reads_R2.fastq.gz", SampleName="Example") counts <- cellCounts("chr1", sample.sheet, input.mode="FASTQ", annot.inbuilt="hg38") ## End(Not run)
Use GC content adjusted background read counts to determine the detection p values for each gene
detectionCall( dataset, species = "hg", plot = FALSE)
detectionCall( dataset, species = "hg", plot = FALSE)
dataset |
a character string giving the filename of a SAM format file, which is the output of read alignment. |
species |
a character string specifing the species. Options are |
plot |
logical indicating whether a density plot of detection p values will be generated. |
A data frame which includes detection p values and annotation information for each gene.
Zhiyin Dai and Wei Shi
This is for internal use only. This function generates the annotation files for calculating p values in the detectionCall
function.
detectionCallAnnotation( species = "hg", binsize = 2000)
detectionCallAnnotation( species = "hg", binsize = 2000)
species |
a character string specifying the species to analyase |
binsize |
an integer value specifying the bin-size of integenic region |
This is an internal function and should not be called by users directly.
It takes as input the annotation files produced by processExons
function, calculates GC percentages for each exon of genes and also for intergenic regions and add GC info into the annotations.
The new annotation data are then saved to files which can be used by detectionCall
function for calling absolutely expressed genes.
Two annotation files, which contain GC content for exons of genes and for intergenic regions respectively, are written to the current working directory. This function returns a NULL
object.
Zhiyin Dai and Wei Shi
Measure background noises and perform Fisher's Exact tests to detect SNPs.
exactSNP( # basic input/output options readFile, isBAM = FALSE, refGenomeFile, SNPAnnotationFile = NULL, outputFile = paste0(readFile, ".exactSNP.VCF"), # fine tuning parameters qvalueCutoff = 12, minAllelicFraction = 0, minAllelicBases = 1, minReads = 1, maxReads = 1000000, minBaseQuality = 13, nTrimmedBases = 3, nthreads = 1)
exactSNP( # basic input/output options readFile, isBAM = FALSE, refGenomeFile, SNPAnnotationFile = NULL, outputFile = paste0(readFile, ".exactSNP.VCF"), # fine tuning parameters qvalueCutoff = 12, minAllelicFraction = 0, minAllelicBases = 1, minReads = 1, maxReads = 1000000, minBaseQuality = 13, nTrimmedBases = 3, nthreads = 1)
readFile |
a character string giving the name of a file including read mapping results. This function takes as input a SAM file by default. If a BAM file is provided, the |
isBAM |
logical indicating if the file provided via |
refGenomeFile |
a character string giving the name of a file that includes reference sequences (FASTA format). |
SNPAnnotationFile |
a character string giving the name of a VCF-format file that includes annotated SNPs (the file can be uncompressed or gzip compressed). Such annotation can be downloaded from public databases such as dbSNP. Incorporating known SNPs into SNP calling has been found to be helpful. However note that the annotated SNPs may or may not be called for the sample being analyzed. |
outputFile |
a character string giving the name of the output file to be generated by this function. The output file includes all the reported SNPs (in VCF format). It includes discovered indels as well. |
qvalueCutoff |
a numeric value giving the q-value cutoff for SNP calling at sequencing depth of 50X. |
minAllelicFraction |
a numeric value giving the minimum fraction of allelic bases out of all read bases included at a chromosomal location required for SNP calling. Its value must be within |
minAllelicBases |
an integer giving the minimum number of allelic (mis-matched) bases a SNP must have at a chromosomal location. |
minReads |
an integer giving the minimum number of mapped reads a SNP-containing location must have (ie. the minimum coverage). |
maxReads |
an integer specifying the maximum depth a SNP-containing location is allowed to have. |
minBaseQuality |
a numeric value giving the minimum base quality score (Phred score) read bases should satisfy before being used for SNP calling. |
nTrimmedBases |
a numeric value giving the number of bases trimmed off from each end of the read. |
nthreads |
a numeric value giving the number of threads/CPUs used. |
This function takes as input a SAM/BAM format file, measures local background noise for each chromosomal location and then performs Fisher's exact tests to find statistically significant SNPs .
This function implements a novel algorithm for discovering SNPs. This algorithm is comparable with or better than existing SNP callers, but it is fast more efficient. It can be used to call SNPs for individual samples (ie. no control samples are required). Detail of the algorithm is described in a manuscript which is currently under preparation.
No value is produced but but a VCF format file is written to the current working directory. This file contains detailed information for discovered SNPs including chromosomal locations, reference bases, alternative bases, read coverages, allele frequencies and p values.
Yang Liao and Wei Shi
Assign mapped sequencing reads to specified genomic features.
featureCounts(files, # annotation annot.inbuilt = "mm39", annot.ext = NULL, isGTFAnnotationFile = FALSE, GTF.featureType = "exon", GTF.attrType = "gene_id", GTF.attrType.extra = NULL, chrAliases = NULL, # level of summarization useMetaFeatures = TRUE, # overlap between reads and features allowMultiOverlap = FALSE, minOverlap = 1, fracOverlap = 0, fracOverlapFeature = 0, largestOverlap = FALSE, nonOverlap = NULL, nonOverlapFeature = NULL, # Read shift, extension and reduction readShiftType = "upstream", readShiftSize = 0, readExtension5 = 0, readExtension3 = 0, read2pos = NULL, # multi-mapping reads countMultiMappingReads = TRUE, # fractional counting fraction = FALSE, # long reads isLongRead = FALSE, # read filtering minMQS = 0, splitOnly = FALSE, nonSplitOnly = FALSE, primaryOnly = FALSE, ignoreDup = FALSE, # strandness strandSpecific = 0, # exon-exon junctions juncCounts = FALSE, genome = NULL, # parameters specific to paired end reads isPairedEnd = FALSE, countReadPairs = TRUE, requireBothEndsMapped = FALSE, checkFragLength = FALSE, minFragLength = 50, maxFragLength = 600, countChimericFragments = TRUE, autosort = TRUE, # number of CPU threads nthreads = 1, # read group byReadGroup = FALSE, # report assignment result for each read reportReads = NULL, reportReadsPath = NULL, # miscellaneous tmpDir = ".", verbose = FALSE)
featureCounts(files, # annotation annot.inbuilt = "mm39", annot.ext = NULL, isGTFAnnotationFile = FALSE, GTF.featureType = "exon", GTF.attrType = "gene_id", GTF.attrType.extra = NULL, chrAliases = NULL, # level of summarization useMetaFeatures = TRUE, # overlap between reads and features allowMultiOverlap = FALSE, minOverlap = 1, fracOverlap = 0, fracOverlapFeature = 0, largestOverlap = FALSE, nonOverlap = NULL, nonOverlapFeature = NULL, # Read shift, extension and reduction readShiftType = "upstream", readShiftSize = 0, readExtension5 = 0, readExtension3 = 0, read2pos = NULL, # multi-mapping reads countMultiMappingReads = TRUE, # fractional counting fraction = FALSE, # long reads isLongRead = FALSE, # read filtering minMQS = 0, splitOnly = FALSE, nonSplitOnly = FALSE, primaryOnly = FALSE, ignoreDup = FALSE, # strandness strandSpecific = 0, # exon-exon junctions juncCounts = FALSE, genome = NULL, # parameters specific to paired end reads isPairedEnd = FALSE, countReadPairs = TRUE, requireBothEndsMapped = FALSE, checkFragLength = FALSE, minFragLength = 50, maxFragLength = 600, countChimericFragments = TRUE, autosort = TRUE, # number of CPU threads nthreads = 1, # read group byReadGroup = FALSE, # report assignment result for each read reportReads = NULL, reportReadsPath = NULL, # miscellaneous tmpDir = ".", verbose = FALSE)
files |
a character vector giving names of input files containing read mapping results. The files can be in either SAM format or BAM format. The file format is automatically detected by the function. |
annot.inbuilt |
a character string specifying an inbuilt gene annotation used for read summarization. It has five possible values |
annot.ext |
A character string giving name of a user-provided annotation file or a data frame including user-provided annotation data. If the annotation is in GTF format, it can only be provided as a file. If it is in SAF format, it can be provided as a file or a data frame. See below for more details about SAF format annotation. If an annotation file is provided, it can be uncompressed or gzip compressed. Note that |
isGTFAnnotationFile |
logical indicating whether the annotation provided via the |
GTF.featureType |
a character string or a vector of character strings giving the feature type or types used to select rows in the GTF annotation which will be used for read summarization. |
GTF.attrType |
a character string giving the attribute type in the GTF annotation which will be used to group features (eg. exons) into meta-features (eg. genes). |
GTF.attrType.extra |
a character vector specifying extra GTF attribute types that will also be included in the counting output. These attribute types will not be used to group features. |
chrAliases |
a character string giving the name of a chromosome name alias file. This should be a two-column comma-delimited text file. Chromosome name aliases included in this file are used to match chr names in annotation with those in the reads. First column in the file should include chr names in the annotation and second column should include chr names in the reads. Chr names are case sensitive. No column header should be included in the file. |
useMetaFeatures |
logical indicating whether the read summarization should be performed at the feature level (eg. exons) or meta-feature level (eg. genes). If |
allowMultiOverlap |
logical indicating if a read is allowed to be assigned to more than one feature (or meta-feature) if it is found to overlap with more than one feature (or meta-feature). |
minOverlap |
|
fracOverlap |
|
fracOverlapFeature |
|
largestOverlap |
If |
nonOverlap |
|
nonOverlapFeature |
|
readShiftType |
a character string indicating how reads should be shifted. It has four possible values including |
readShiftSize |
|
readExtension5 |
|
readExtension3 |
|
read2pos |
Specifying whether each read should be reduced to its 5' most base or 3' most base. It has three possible values: |
countMultiMappingReads |
logical indicating if multi-mapping reads/fragments should be counted, |
fraction |
logical indicating if fractional counts are produced for multi-mapping reads and/or multi-overlapping reads. |
isLongRead |
logical indicating if input data contain long reads. This option should be set to |
minMQS |
|
splitOnly |
logical indicating whether only split alignments (their CIGAR strings contain letter 'N') should be included for summarization. |
nonSplitOnly |
logical indicating whether only non-split alignments (their CIGAR strings do not contain letter 'N') should be included for summarization. |
primaryOnly |
logical indicating if only primary alignments should be counted. Primary and secondary alignments are identified using bit 0x100 in the Flag field of SAM/BAM files. If |
ignoreDup |
logical indicating whether reads marked as duplicates should be ignored. |
strandSpecific |
an integer vector indicating if strand-specific read counting should be performed. Length of the vector should be either |
juncCounts |
logical indicating if number of reads supporting each exon-exon junction will be reported. Junctions will be identified from all the exon-spanning reads included in the input data. |
genome |
a character string giving the name of a FASTA-format file that includes the reference sequences used in read mapping that produced the provided SAM/BAM files. |
isPairedEnd |
A logical scalar or a logical vector, indicating whether libraries contain paired-end reads or not. |
countReadPairs |
A logical scalar or a logical vector, indicating if read pairs, instead of reads, should be counted for paired-end read data. |
requireBothEndsMapped |
logical indicating if both ends from the same fragment are required to be successfully aligned before the fragment can be assigned to a feature or meta-feature. This parameter is only appliable when |
checkFragLength |
logical indicating if the two ends from the same fragment are required to satisify the fragment length criteria before the fragment can be assigned to a feature or meta-feature. This parameter is only appliable when |
minFragLength |
|
maxFragLength |
|
countChimericFragments |
logical indicating whether a chimeric fragment, which has its two reads mapped to different chromosomes, should be counted or not. |
autosort |
logical specifying if the automatic read sorting is enabled. This option is only applicable for paired-end reads. If |
nthreads |
|
byReadGroup |
logical indicating if read counting will be performed for each individual read group. |
reportReads |
output detailed read assignment results for each read (or fragment if paired end). The detailed assignment results can be saved in three different formats including |
reportReadsPath |
a character string specifying the directory where files including detailed assignment results are saved. If |
tmpDir |
a character string specifying the directory under which intermediate files are saved (later removed). By default, current working directory is used. |
verbose |
logical indicating if verbose information for debugging will be generated. This may include information such as unmatched chromosomes/contigs between reads and annotation. |
featureCounts
is a general-purpose read summarization function that can assign mapped reads from genomic DNA and RNA sequencing to genomic features or meta-features.
The function takes as input a set of SAM or BAM files containing read mapping results.
The files might be generated by align
or subjunc
or any suitable aligner.
featureCounts
accepts two annotation formats to specify the genomic features: SAF (Simplified Annotation Format) or GTF/GFF.
The GTF/GFF format is specified at https://genome.ucsc.edu/FAQ/FAQformat.html.
SAF is a Simplified Annotation Format with five columns.
It can be either a data.frame or a tab-delimited text file in the following style:
GeneID Chr Start End Strand 497097 chr1 3204563 3207049 - 497097 chr1 3411783 3411982 - 497097 chr1 3660633 3661579 - 100503874 chr1 3637390 3640590 - 100503874 chr1 3648928 3648985 - 100038431 chr1 3670236 3671869 - ...
SAF annotation includes the following five required columns: GeneID
, Chr
, Start
, End
and Strand
.
The GeneID
column includes identifiers of features.
These identifiers can be integer or character string.
The Chr
column includes chromosome names of features and these names should match the chromosome names includes in the provided SAM/BAM files.
The Start
and End
columns include start and end coordinates of features, respectively.
Both start and end coordinates are inclusive.
The Strand
column indicates the strand of features ("+"
or "-"
).
Column names in a SAF annotation should be the same as those shown in the above example (case insensitive).
Columns can be in any order.
Extra columns are allowed to be added into the annotation.
Inbuilt annotations, which were generated based on NCBI RefSeq gene annotations, are provided to faciliate convenient read summarization.
We provide inbuilt annotations for the following genomes: "hg38"
, "hg19"
, "mm39"
, "mm10"
and "mm9"
.
The content of inbuilt annotations can be accessed via the getInBuiltAnnotation
function.
These annotations have a SAF format.
The inbuilt annotations are a modified version of NCBI RefSeq gene annotations.
For inbuilt annotations "hg38"
, "hg19"
, "mm10"
and "mm9"
, their original RefSeq annotations were downloaded from NCBI RefSeq MapView.
We then used these downloaded annotations to create inbuilt annotations.
For each gene, we used its CDS and UTR regions provided in the original annotation to construct a list of exons, by merging and concatenating all CDSs and UTRs belonging to the same gene.
Exons within each gene include all chromosomal bases included in the original CDS and UTR regions, but they include each base only once.
Also, exons within the same gene in the inbuilt annotation do not overlap with each other.
For the inbuilt annotation "mm39"
, its original RefSeq annotation was downloaded from https://ftp.ncbi.nlm.nih.gov/genomes/all/annotation_releases/10090/GCF_000001635.27-RS_2023_04/GCF_000001635.27_GRCm39_genomic.gtf.gz.
This is a GTF-format annotation.
We changed the format of chromosome names in this annotation from "NC_xxxxxx"
to "chr"
followed by a number.
For example, "NC_000067.7"
was changed to "chr1"
.
The flattenGTF
function was then used to merge overlapping exons within the same gene to generate the inbuilt annotation.
Entrez gene identifiers were used in this annotation.
Users may provide an external annotation to featureCounts
for read summarization via the annot.ext
parameter.
If the provided external annotation is in SAF format, it can be provided as either a data.frame
or a tab-delimited text file with proper column names included.
If it is in GTF/GFF format, it should be provided as a file only (and isGTFAnnotationFile
should be set to TRUE
).
featureCounts
function uses the GTF.attrType
attribute in a GTF/GFF annotation to group features to form meta-features when performing read summarization at meta-feature level.
The argument useMetaFeatures
specifies whether read summarization should be performed at feature level or at meta-feature level.
A feature represents a continuous genomic region and a meta-feature is a group of features.
For instance, an exon is a feature and a gene comprising one or more exons is a meta-feature.
To assign reads to meta-features, featureCounts
firstly groups into meta-features the features that have the same gene identifiers.
featureCounts
looks for gene identifiers in GeneID
column of a SAF annotation or by using GTF.attrType
attribute in a GTF/GFF annotation.
Then for each read featureCounts
searches for meta-features that have at least one feature that overlaps with the read.
A read might be found to overlap with more than one feature within the same meta-feature (eg. an exon-spanning read overlaps with more than one exon from the same gene), however this read will still be counted only once for the meta-feature.
RNA-seq reads are often summarized to meta-features to produce read counts for genes. Further downstream analysis can then be carried out to discover differentially expressed genes. Feature-level summarization of RNA-seq data often yields exon-level read counts, which is useful for investigating alternative splicing of genes.
featureCounts
provides multiple options to count multi-mapping reads (reads mapping to more than one location in the reference genome).
Users can choose to ignore such reads by setting countMultiMappingReads
to FALSE
, or fully count every alignment reported for a multi-mapping read by setting countMultiMappingReads
to TRUE
(each alignment carries 1
count), or count each alignment fractionally by setting both countMultiMappingReads
and fraction
to TRUE
(each alignment carries 1/x
count where x
is the total number of alignments reported for the read).
featureCounts
also provides multiple options to count multi-overlapping reads (reads overlapping with more than one meta-feature when conducting meta-feature-level summarization or overlapping with more than one feature when conducting feature-level summarization).
Users can choose to ignore such reads by setting allowMultiOverlap
to FALSE
, or fully count them for each overlapping meta-feature/feature by setting allowMultiOverlap
to TRUE
(each overlapping meta-feature/feature receives a count of 1 from a read), or assign a fractional count to each overlapping meta-feature/feature by setting both allowMultiOverlap
and fraction
to TRUE
(each overlapping meta-feature/feature receives a count of 1/y
from a read where y
is the total number of meta-features/features overlapping with the read).
If a read is both multi-mapping and multi-overlapping, then each overlapping meta-feature/feature will receive a fractional count of 1/(x*y)
if countMultiMappingReads
, allowMultiOverlap
and fraction
are all set to TRUE
.
When isPairedEnd
is TRUE
, fragments (pairs of reads) instead of reads will be counted.
featureCounts
function checks if reads from the same pair are adjacent to each other (this could happen when reads were for example sorted by their mapping locations), and it automatically reorders those reads that belong to the same pair but are not adjacent to each other in the input read file.
A list with the following components:
counts |
a data matrix containing read counts for each feature or meta-feature for each library. |
counts_junction (optional) |
a data frame including primary and secondary genes overlapping an exon junction, position information for the left splice site (‘Site1’) and the right splice site (‘Site2’) of a junction (including chromosome name, coordinate and strand) and number of supporting reads for each junction in each library. Both primary and secondary genes overlap at least one of the two splice sites of a junction. Secondary genes do not overlap more splice sites than the primary gene. When the primary and secondary genes overlap same number of splice sites, the gene with the smallest leftmost base position is selected as the primary gene. For each junction, no more than one primary gene is reported but there might be more than one secondary genes reported. If a junction does not overlap any genes, it has a missing value in the fields of primary gene and secondary gene. Note that this data frame is only generated when |
annotation |
a data frame with six columns including |
targets |
a character vector giving sample information. |
stat |
a data frame giving number of successfully assigned reads in each library and also number of unassigned reads falling in each filtering category (unmapped, read type, singleton, mapping quality, chimera, fragment length, duplicate, multi-mapping, secondary alignment, split alignment, no features, overlapping length and assignment ambiguity). See Users Guide for more details. |
Wei Shi and Yang Liao
Yang Liao, Gordon K Smyth and Wei Shi (2019). The R package Rsubread is easier, faster, cheaper and better for alignment and quantification of RNA sequencing reads. Nucleic Acids Research, 47(8):e47. http://www.ncbi.nlm.nih.gov/pubmed/30783653
Yang Liao, Gordon K Smyth and Wei Shi (2014). featureCounts: an efficient general-purpose program for assigning sequence reads to genomic features. Bioinformatics, 30(7):923-30. http://www.ncbi.nlm.nih.gov/pubmed/24227677
## Not run: # Summarize SAM format single-end reads using built-in RefSeq annotation for mouse genome mm39: featureCounts(files="mapping_results_SE.sam",annot.inbuilt="mm39") # Summarize single-end reads using a user-provided GTF annotation file: featureCounts(files="mapping_results_SE.sam",annot.ext="annotation.gtf", isGTFAnnotationFile=TRUE,GTF.featureType="exon",GTF.attrType="gene_id") # Summarize single-end reads using 5 threads: featureCounts(files="mapping_results_SE.sam",nthreads=5) # Summarize BAM format single-end read data: featureCounts(files="mapping_results_SE.bam") # Perform strand-specific read counting (strandSpecific=2 if reversely stranded): featureCounts(files="mapping_results_SE.bam",strandSpecific=1) # Summarize paired-end reads and counting fragments (instead of reads): featureCounts(files="mapping_results_PE.bam",isPairedEnd=TRUE) # Count fragments satisfying the fragment length criteria, eg. [50bp, 600bp]: featureCounts(files="mapping_results_PE.bam",isPairedEnd=TRUE, checkFragLength=TRUE,minFragLength=50,maxFragLength=600) # Count fragments that have both ends successfully aligned without checking the fragment length: featureCounts(files="mapping_results_PE.bam",isPairedEnd=TRUE,requireBothEndsMapped=TRUE) # Exclude chimeric fragments from fragment counting: featureCounts(files="mapping_results_PE.bam",isPairedEnd=TRUE,countChimericFragments=FALSE) ## End(Not run)
## Not run: # Summarize SAM format single-end reads using built-in RefSeq annotation for mouse genome mm39: featureCounts(files="mapping_results_SE.sam",annot.inbuilt="mm39") # Summarize single-end reads using a user-provided GTF annotation file: featureCounts(files="mapping_results_SE.sam",annot.ext="annotation.gtf", isGTFAnnotationFile=TRUE,GTF.featureType="exon",GTF.attrType="gene_id") # Summarize single-end reads using 5 threads: featureCounts(files="mapping_results_SE.sam",nthreads=5) # Summarize BAM format single-end read data: featureCounts(files="mapping_results_SE.bam") # Perform strand-specific read counting (strandSpecific=2 if reversely stranded): featureCounts(files="mapping_results_SE.bam",strandSpecific=1) # Summarize paired-end reads and counting fragments (instead of reads): featureCounts(files="mapping_results_PE.bam",isPairedEnd=TRUE) # Count fragments satisfying the fragment length criteria, eg. [50bp, 600bp]: featureCounts(files="mapping_results_PE.bam",isPairedEnd=TRUE, checkFragLength=TRUE,minFragLength=50,maxFragLength=600) # Count fragments that have both ends successfully aligned without checking the fragment length: featureCounts(files="mapping_results_PE.bam",isPairedEnd=TRUE,requireBothEndsMapped=TRUE) # Exclude chimeric fragments from fragment counting: featureCounts(files="mapping_results_PE.bam",isPairedEnd=TRUE,countChimericFragments=FALSE) ## End(Not run)
The common variants (inc. SNPs and indels) among all the input files are found. A data frame containing these common variants is returned. The data frame has a similar format as VCF files.
findCommonVariants(VCF_files)
findCommonVariants(VCF_files)
VCF_files |
a character vector giving the names of VCF format files. |
This function loads all variants (SNPs and indels) from the input VCF files, and find the common variants that are reported in all the VCF files. If a variant record in a input VCF file has multiple alternative sequences (split by ‘,’), each alternative sequence is treated as a single variant. Two variants in two VCF files are the same only if their genomic locations, their reference sequences, their alternative sequences and their variant types are identical.
This function currently does not support other types of variants other than SNPs and indels.
There are eight columns in the returned data frame: chromosome name, position, identity, reference sequence, alternative sequence, quality, filter and extra information. The input may have more columns; these columns are not included in the data frame. If the identity, the quality, the filter and the extra information for the same variant are different among the input VCF files, those information associated with the lowest quality value of this variant among the VCF files is reported in the resulted data frame. For example, if an SNP on chrX:12345 (A=>G) is reported in all the three input VCF files, and the quality scores in the three VCF files are 100, 10, 50 respectively, the identity, the quality, the filter and the extra information in the second VCF file are reported in the resulted data frame for this SNP.
A data frame containing the common variants among all the input VCF files is returned. The first eight columns are: chromosome name, position, identity, reference sequence, alternative sequence, quality, filter and extra information.
If there are not any common variants, this function returns an NA value.
Yang Liao and Wei Shi
## Not run: # finding the common variants between to input VCF files: a.vcf and b.vcf library(Rsubread) findCommonVariants(c('a.vcf','b.vcf')) ## End(Not run)
## Not run: # finding the common variants between to input VCF files: a.vcf and b.vcf library(Rsubread) findCommonVariants(c('a.vcf','b.vcf')) ## End(Not run)
Convert a GTF/GFF annotation to SAF format and flatten overlapping features.
flattenGTF( # basic input/output options GTFfile, GTF.featureType = "exon", GTF.attrType = "gene_id", # the option specifying the merging algorithm method = "merge")
flattenGTF( # basic input/output options GTFfile, GTF.featureType = "exon", GTF.attrType = "gene_id", # the option specifying the merging algorithm method = "merge")
GTFfile |
a character string giving the name of a GTF file as input. |
GTF.featureType |
a character string giving the feature type used to select rows in a GTF annotation. |
GTF.attrType |
a character string giving the attribute type in a GTF annotation which will be used to group features. |
method |
a character string specifying the method for how to flatten the GTF file. The method can be either |
This function locates features in a GTF annotation via GTF.featureType
and then groups them into meta-features via GTF.attrType
.
When method="merge"
, the overlapping features found in a meta-feature will be merged to form a single continuous feature encompassing all the overlapping features.
If method="chop"
, overlapping features will be chopped into multiple non-overlapping bins.
Here is an example to illustrate the differences between the two methods.
Say there are three exons belonging to the same gene and the coordinates of these exons are [100, 200], [150, 500] and [250, 400].
When running on "merge"
mode, a single exon will be returned for this gene and the coordinates of this exon are [100, 500], representing the union of the three original exons.
When running on "chop"
mode, five non-overlapping bins will be returned, including [100, 149], [150, 200], [201, 249], [250, 400] and [401, 500].
Intervals of these bins are determined by start and end coordinates of the three original exons (100, 150, 200, 250, 400 and 500).
Output of this function is a SAF format annotation which can be fed to featureCounts
function for read counting.
Description to SAF format annotation can also be found in featureCounts
.
A data.frame
including a SAF format annotation in which features included in each meta-feature are all distinct.
Yang Liao and Wei Shi
Retrieve an inbuilt gene annotation and save it to a data frame.
getInBuiltAnnotation(annotation = "mm39")
getInBuiltAnnotation(annotation = "mm39")
annotation |
a character string specifying the inbuilt gene annotation to be retrieved. It has five possible values including |
The inbuilt gene annotations included in the Rsubread package were generated based on the NCBI RefSeq gene annotations.
The inbuilt annotations are much simpler than the original RefSeq annotations in that they only contain essential data required for the processing of sequencing data such as RNA-seq data.
Also in each inbuilt annotation, duplicate exons within the same gene are removed and overlapping exons within the same gene are merged.
For more information about the inbuilt annotations, please refer to the help page for featureCounts
function.
A data frame with five columns including GeneID
, Chr
, Start
, End
and Strand
.
Wei Shi
x <- getInBuiltAnnotation("hg38") head(x)
x <- getInBuiltAnnotation("hg38") head(x)
This is for internal use. It converts the NCBI exon annotations into data files for use in the detectionCall
function.
processExons( filename = "human_seq_gene.md", species = "hg")
processExons( filename = "human_seq_gene.md", species = "hg")
filename |
a character string giving the name of input .md file (NCBI annotation file) |
species |
a character string specifying the species |
This is an internal function and should not be called by users directly.
It processes annotation of genes in human genome GRCh37/hg19 or mouse genome GRCm37/mm9. The annotation is available for download from the following links (these annotations include chromosomal coordinates of UTR and CDS regions of genes):
ftp://ftp.ncbi.nlm.nih.gov/genomes/H_sapiens/ARCHIVE/BUILD.37.2/mapview/seq_gene.md.gz
ftp://ftp.ncbi.nlm.nih.gov/genomes/M_musculus/ARCHIVE/BUILD.37.2/mapview/seq_gene.md.gz
This function finds the chromosomal coordinates of intergenic regions (regions between neighbouring genes) and then outputs them to a file.
It also outputs to a file chromosomal coordinates of exons of genes by concatenating UTRs with CDSs and merging overlapping CDSs within each gene.
The generated annotation files will then be used by detectionCallAnnotation
function to produce annotation data required by detectionCall
function.
Two annotation files are written to the current working directory. This function returns a NULL
object.
Zhiyin Dai and Wei Shi
Create a SAF data-frame of genewise promoter regions.
promoterRegions( annotation = "mm39", upstream = 3000L, downstream = 2000L)
promoterRegions( annotation = "mm39", upstream = 3000L, downstream = 2000L)
annotation |
a data.frame containing gene annotation in SAF format or a character string giving the name of a genome with built-in annotation. If using built-in annotation, the character string should be one of the following: |
upstream |
an integer giving the number of upstream bases that will be inclued in the promoter region generated for each gene. These bases are taken immediately upstream (5' end) from transcriptional start site of each gene. |
downstream |
an integer giving the number of downstream bases that will be inclued in the promoter region generated for each gene. These bases are taken immediately downstream (3' end) from transcriptional start site of each gene. |
This function takes as input a SAF format gene annotation and produces a SAF format data.frame containing the chromosomal coordinates of the specified promoter region for each gene.
See featureCounts
for definition of the SAF format.
Regardless of the upstream
or downstream
values, the downstream end of the region never extends past the end of the gene and the upstream end never extends outside the relevant chromosome.
Setting downstream
to an infinite or large value will cause the body of each gene to be included.
A SAF format data.frame
with columns GeneID
, Chr
, Start
, End
and Strand
.
Gordon K Smyth
featureCounts
, getInBuiltAnnotation
# To get whole gene bodies (from TSS to TES) for the latest mouse genome: x <- promoterRegions("mm39", upstream = 0, downstream = Inf) head(x)
# To get whole gene bodies (from TSS to TES) for the latest mouse genome: x <- promoterRegions("mm39", upstream = 0, downstream = Inf) head(x)
Number of mapped reads/fragments will be counted and fraction of such reads/fragments will be calculated.
propmapped( files, countFragments = TRUE, properlyPaired = FALSE, verbose = FALSE)
propmapped( files, countFragments = TRUE, properlyPaired = FALSE, verbose = FALSE)
files |
a character vector giving the names of SAM/BAM format files. Format of input files is automatically determined by the function. |
countFragments |
logical indicating whether reads or fragments (read pairs) should be counted. If |
properlyPaired |
logical indicating if only properly paired reads will be counted. This is only applicable for paired end data. |
verbose |
logical indicating if verbose information should be displayed. |
This function uses the FLAG
field in the SAM/BAM to look for mapped reads and count them.
Reads/fragments, which have more than one reported location, will be reported only once.
When counting single end reads, counting reads has the same meaning as counting fragments (the results are identical).
Note that align
and subjunc
return the same mapping statistics as propmapped
as a by-product of the alignment process, so saving the output from align
or subjunc
will be faster and more informative than running propmapped
separately.
A data frame containing the total number of reads, number of mapped reads and proportion of mapped reads for each library.
Wei Shi and Yang Liao
# build an index using the sample reference sequence provided in the package # and save it to the current directory ref <- system.file("extdata","reference.fa",package="Rsubread") buildindex(basename="./reference_index",reference=ref) # align the sample read data provided in this package to the sample reference # and save the mapping results to the current directory reads <- system.file("extdata","reads.txt.gz",package="Rsubread") stat <- align(index="./reference_index",readfile1=reads,output_file="./Rsubread_alignment.BAM") stat # get the percentage of successfully mapped reads propmapped("./Rsubread_alignment.BAM")
# build an index using the sample reference sequence provided in the package # and save it to the current directory ref <- system.file("extdata","reference.fa",package="Rsubread") buildindex(basename="./reference_index",reference=ref) # align the sample read data provided in this package to the sample reference # and save the mapping results to the current directory reads <- system.file("extdata","reads.txt.gz",package="Rsubread") stat <- align(index="./reference_index",readfile1=reads,output_file="./Rsubread_alignment.BAM") stat # get the percentage of successfully mapped reads propmapped("./Rsubread_alignment.BAM")
Extract quality strings and convert them to Phred scores for generating boxplots.
qualityScores( # basic input/output options filename, input_format = "gzFASTQ", offset = 33, nreads = 10000)
qualityScores( # basic input/output options filename, input_format = "gzFASTQ", offset = 33, nreads = 10000)
filename |
a character string giving the name of an input file containing sequence reads. |
input_format |
a character string specifying format of the input file. |
offset |
a numeric value giving the offset added to the base-calling Phred scores. Possible values include |
nreads |
a numeric value giving the number of reads from which quality scores are extracted. |
Quality scores of read bases are represented by ASCII characters in next-gen sequencing data.
This function extracts the quality characters from each base in each read and then converts them to Phred scores using the provided offset value (offset
).
If the total number of reads in a dataset is n
, then every n
/nreads
read is extracted from the input data.
A data matrix containing Phred scores for read bases. Rows in the matrix are reads and columns are base positions in each read.
Wei Shi, Yang Liao and Zhiyin Dai
reads <- system.file("extdata","reads.txt.gz",package="Rsubread") x <- qualityScores(filename=reads,offset=64,nreads=1000) x[1:10,1:10]
reads <- system.file("extdata","reads.txt.gz",package="Rsubread") x <- qualityScores(filename=reads,offset=64,nreads=1000) x[1:10,1:10]
Remove reads which are mapped to identical locations, using mapping location of the first base of each read.
removeDupReads( # basic input/output options inputFile, threshold = 50, outputFile, outputFormat = "BAM")
removeDupReads( # basic input/output options inputFile, threshold = 50, outputFile, outputFormat = "BAM")
inputFile |
a character string giving the name of a SAM or BAM format input file. |
threshold |
a numeric value giving the threshold for removing duplicated reads, 50 by default. Reads will be removed if they are found to be duplicated equal to or more than |
outputFile |
a character string giving the base name of output files. |
outputFormat |
a character string giving the format of the output file. |
This function uses the mapping location of first base of each read to find duplicated reads.
Reads are removed if they are duplicated more than threshold
number of times.
This function generates a BAM or SAM file including the remaining reads after duplicate removal.
Yang Liao and Wei Shi
Fast re-ordering of paired-end reads using read names and mapping locations.
repair( inFiles, inFormat = "BAM", outFiles = paste(inFiles,"repair",sep="."), addDummy = TRUE, fullData = TRUE, compress = FALSE, nthreads = 8)
repair( inFiles, inFormat = "BAM", outFiles = paste(inFiles,"repair",sep="."), addDummy = TRUE, fullData = TRUE, compress = FALSE, nthreads = 8)
inFiles |
a character vector giving names of input files. These files are typically location-sorted BAM files. |
inFormat |
a character string specifying format of input files. Supported formats include |
outFiles |
a character string giving names of output files. Re-ordered reads are saved to BAM-format files. |
addDummy |
logical indicating if a dummy read will be added to each singleton read which has a missing pair in the input. |
fullData |
logical indicating if sequences and base-calling quality scores of reads will be included in the output. |
compress |
logical indicating if compression should be turned on when generating BAM output. |
nthreads |
a numeric value giving number of CPU threads. 8 by default. |
This function takes as input paired-end BAM or SAM files, re-orders reads to make reads from the same pair be adjacent to each other and outputs the re-ordered reads into new BAM files.
The function makes use of both read names and mapping information of reads (eg. mapping coordinates) to identify reads belonging to the same pair. This makes sure that all paired-end reads are correctly re-ordered, especially those multi-mapping read pairs that include more than one reported alignment in the input.
The BAM files produced by this function are compatible with featureCounts
, meaning that no further re-ordering needs to be performed by featureCounts
.
No value is produced but BAM files with re-ordered reads are written to the current working directory.
Wei Shi and Yang Liao
Users Guide for Rsubread and Subread
RsubreadUsersGuide()
RsubreadUsersGuide()
The Subread/Rsubread Users Guide provides detailed description to the functions and programs included in the Subread and Rsubread software packages. It also includes case studies for analyzing next-gen sequencing data.
The Subread package is written in C and it can be downloaded from http://subread.sourceforge.net. The Rsubread package provides R wrappers functions for many of the programs included in Subread package.
Character string giving the file location.
Wei Shi
This function performs SAM to BED conversion. Each read in the SAM input is converted into an interval in the BED file.
sam2bed( samfile, bedfile, readlen)
sam2bed( samfile, bedfile, readlen)
samfile |
a character string giving the name of input file. Input format should be in SAM format. |
bedfile |
a character string giving the name of output file. Output file is in BED format. |
readlen |
a numeric value giving the length of reads included in the input file. |
This function converts a SAM format file to a BED format file, which can then be displayed in a genome browser like UCSC genome browser, IGB, IGV. This function does not find the read length from the SAM file, but requires the user to specify the read length.
No value is produced but a BED format file is written to the current working directory. This file contains six columns including chromosomal name, start position, end position, name(‘.’), mapping quality score and strandness.
Wei Shi
The simReads
function generates simulated reads from a given set of transcripts with specified expression levels.
simReads( # the transcript sequences and relative expression levels transcript.file, expression.levels, # the name of the output files output.prefix, # options on the output library.size = 1e5, read.length = 75, truth.in.read.names = FALSE, # simulating sequencing errors simulate.sequencing.error = TRUE, quality.reference = NULL, # distribution of fragment lengths paired.end = FALSE, fragment.length.min = 100, fragment.length.max = 500, fragment.length.mean = 180, fragment.length.sd = 40, # manipulating transcript names simplify.transcript.names = FALSE) scanFasta( # the file containing the transcript database transcript.file, # manipulating transcript names simplify.transcript.names = FALSE, # miscellaneous options quiet = FALSE)
simReads( # the transcript sequences and relative expression levels transcript.file, expression.levels, # the name of the output files output.prefix, # options on the output library.size = 1e5, read.length = 75, truth.in.read.names = FALSE, # simulating sequencing errors simulate.sequencing.error = TRUE, quality.reference = NULL, # distribution of fragment lengths paired.end = FALSE, fragment.length.min = 100, fragment.length.max = 500, fragment.length.mean = 180, fragment.length.sd = 40, # manipulating transcript names simplify.transcript.names = FALSE) scanFasta( # the file containing the transcript database transcript.file, # manipulating transcript names simplify.transcript.names = FALSE, # miscellaneous options quiet = FALSE)
transcript.file |
a character string giving the name of a file that contains the transcript names and sequences. The format can be FASTA or gzipped-FASTA. All transcript names must be unique and any duplicate sequences (two or more transcripts with the same sequence) will trigger warning messages. |
expression.levels |
a numeric vector giving the relative expression levels of the transcripts, in the order of transcripts in |
output.prefix |
a character string giving the basename of all the output files. |
library.size |
a numeric value giving the number of reads or read-pairs to be generated. One million by default. |
read.length |
a anumeric value giving the length of each read in the output. Maximum length is 250bp. Transcripts that are shorter than the read length will not be used for generating simulated reads. 75 by default. |
truth.in.read.names |
logical indicating if the true mapping location of reads or read-pairs should be encoded into the read names. |
simulate.sequencing.error |
logical indicating if sequencing errors should be simulated in the output reads. If |
quality.reference |
a character string giving the name of a file that contains one or multiple sequencing quality strings in the Phred+33 format. The file should have Unix rather than Windows line ends and the sequencing quality strings must have the same length as |
paired.end |
logical indicating if paired-end reads should be generated. |
fragment.length.min |
a numeric value giving the minimum fragment length. The minimum fragment length must be equal to or greater than the output read length. 100 by default. |
fragment.length.max |
a numeric value giving the maximum fragment length. 500 by default. |
fragment.length.mean |
a numeric value giving the mean of fragment lengths. 180 by default. |
fragment.length.sd |
a numeric value giving the standard deviation of fragment lengths. The fragment lengths are drawn from a truncated gamma distribution that is defined by |
simplify.transcript.names |
logical indicating if transcript names should be simplified. If |
quiet |
logical indicating if the warning message for repeated sequences should be suppressed in the |
simReads
generates simulated reads from a set of transcript sequences at specified abundances. The input includes a transcript file in FASTA format and a numeric vector specifying the relative expression levels the transcripts. The output consists of one or two gzipped FASTQ files that contain the simulated reads or read-pairs.
The number of fragments for each transcript are drawn from a multinomial distribution, summing to the specified library.size.
The RNA fragment lengths are drawn from a truncated gamma distribution with mean and standard deviation specified by fragment.length.mean
and fragment.length.sd
respectively and lower and upper limits specified by fragment.length.min
and fragment.length.max
.
The sequence reads are then taken from one or both ends of the simulated fragments to simulate short-read sequencing.
To have reads generated from it, a transcript must have length equal to or greater than the minimum fragment length.
Substitution sequencing errors can be simulated in the reads by emulating the sequencing quality of a real High-Throughput Sequencing sample. When simulate.sequencing.error = TRUE
and a set of Phred+33 encoded quality strings are provided to simReads
, a quality string is randomly chosen for each output read and read bases are substituted with random base values according to the probabilities described in the quality string. Inbuilt quality strings are provided for generating 100-bp and 75-bp long reads, hence the quality.reference
can be optionally omitted when read.length
is 100 or 75.
The scanFasta
function checks and processes the FASTA or gzipped-FASTA file. It scans through the file that defines the transcript sequences and returns a data.frame of transcript names and sequence lengths. It additionally checks the transcript sequences for uniqueness.
Baldoni et al (2024) uses simReads
to generate realistic RNA-seq data with specified levels of biological and technical variation.
simReads
writes a FASTQ file, or a pair of FASTQ files if paired.end
, containing the simulated reads.
It also returns a data.frame
with three columns:
TranscriptID |
character | transcript name |
Length |
integer | length of transcript sequence |
Count |
integer | simulated read count |
scanFasta
returns a data.frame
with six columns:
TranscriptID |
character | transcript name |
Length |
integer | length of transcript sequence |
MD5 |
character | MD5 digest of the transcript sequence |
Unique |
logical | is this transcript's sequence unique in the FASTA file? |
Occurrence |
integer | number of times this transcript's sequence was observed |
Duplicate |
logical | this transcript's sequence is a duplicate of a previous sequence. |
Note that selecting transcripts with Duplicate == FALSE
will ensure unique sequences, i.e., any sequence that was observed multiple times in the FASTQ file will be only included only once in the selection.
Yang Liao, Gordon K Smyth and Wei Shi
Baldoni PL, Chen Y, Hediyeh-zadeh S, Liao Y, Dong X, Ritchie ME, Shi W, Smyth GK (2024). Dividing out quantification uncertainty allows efficient assessment of differential transcript expression with edgeR. Nucleic Acids Research 52(3), e13. doi:10.1093/nar/gkad1167.
## Not run: # Scan through the fasta file to get transcript names and lengths transcripts <- scanFasta("GENCODE-Human-transcripts.fa.gz") nsequences <- nrow(transcripts) - sum(transcripts$Duplicate) # Assign a random TPM value to each non-duplicated transcript sequence TPMs <- rep(0, nrow(transcripts)) TPMs[!transcripts$Duplicate] <- rexp(nsequences) # Generate actual reads. # The output read file is my-simulated-sample_R1.fastq.gz # The true read counts are returned. true.counts <- simReads("GENCODE-Human-transcripts.fa.gz", TPMs, "my-simulated-sample") print(true.counts[1:10,]) ## End(Not run)
## Not run: # Scan through the fasta file to get transcript names and lengths transcripts <- scanFasta("GENCODE-Human-transcripts.fa.gz") nsequences <- nrow(transcripts) - sum(transcripts$Duplicate) # Assign a random TPM value to each non-duplicated transcript sequence TPMs <- rep(0, nrow(transcripts)) TPMs[!transcripts$Duplicate] <- rexp(nsequences) # Generate actual reads. # The output read file is my-simulated-sample_R1.fastq.gz # The true read counts are returned. true.counts <- simReads("GENCODE-Human-transcripts.fa.gz", TPMs, "my-simulated-sample") print(true.counts[1:10,]) ## End(Not run)
This function aligns DNA-seq reads, generated by long-read sequencing technologies such as Nanopore and PacBio sequencers, to a reference genome.
sublong( # basic input/output options index, readFiles, outputFiles, outputFormat = "BAM", nthreads = 1)
sublong( # basic input/output options index, readFiles, outputFiles, outputFormat = "BAM", nthreads = 1)
index |
a character vector giving the basename of index files. Index files should be located in the current directory. The provided index should be a full index and also it should have only one block. See |
readFiles |
a character vector giving the names of input files that contain long sequence reads. FASTQ and gzipped FASTQ formats are both accepted. |
outputFiles |
a character vector specifying the names of output files that contain read mapping results. |
outputFormat |
a character string specifying the format of output files. |
nthreads |
an integer giving the number of threads used for mapping. |
sublong
is designed for the mapping of long reads.
It performs full alignment of reads by performing seed-and-vote mapping followed by a bounded dynamic programming procedure.
sublong
is able to map reads as long as millions of bases.
sublong
is extremely fast.
It takes less than 10 minutes to complete the mapping of more than 100,000 long reads generated from Nanopore MinION ultra-long sequencing protocol.
The number of CIGAR operations (eg. insertion and deletion) reported for a long read may exceed the limit on the total number of operations allowed in a CIGAR string (up to 65,535 operations in a CIGAR string in BAM output and up to 99,900 operations in a CIGAR string in SAM output). If this limited is exceeded, the read will be soft clipped.
Yang Liao and Wei Shi
ref <- system.file("extdata","reference.fa",package="Rsubread") buildindex(basename="./full_index",reference=ref,gappedIndex=FALSE, indexSplit=FALSE) reads <- system.file("extdata","longreads.txt.gz",package="Rsubread") sublong("./full_index",reads,"./Long_alignment.BAM",nthreads=4)
ref <- system.file("extdata","reference.fa",package="Rsubread") buildindex(basename="./full_index",reference=ref,gappedIndex=FALSE, indexSplit=FALSE) reads <- system.file("extdata","longreads.txt.gz",package="Rsubread") sublong("./full_index",reads,"./Long_alignment.BAM",nthreads=4)
For each transcript, number of unique bases and total number of bases will be reported.
txUnique( # basic input/output options GTF_Annotation_File, Feature_Type = "exon", Gene_ID_Attribute = "gene_id", Transcript_ID_Attribute = "transcript_id")
txUnique( # basic input/output options GTF_Annotation_File, Feature_Type = "exon", Gene_ID_Attribute = "gene_id", Transcript_ID_Attribute = "transcript_id")
GTF_Annotation_File |
a character string giving the name of a GTF file containing the transcript-level annotations. |
Feature_Type |
a character string specifying the type of annotations. Only the annotations of the given type will be loaded from the GTF file. |
Gene_ID_Attribute |
a character string specifying the attribute name in the 9-th column in the GTF file for the gene identifier. |
Transcript_ID_Attribute |
a character string specifying the attribute name in the 9-th column in the GTF file for the transcript identifier. |
This function compares the transcripts belonging to the same gene and then counts the number of bases unique to each transcript. It also reports the total number of bases for each transcript. When a transcript is found to contain overlapping exons, the overlapping exons will be merged and each overlapping base will be counted only once.
A data matrix in which each row represents a transcript. The matrix includes four columns: gene identifier, transcript identifier, number of bases unique to each transcript and total number of bases each transcript has.
Yang Liao and Wei Shi