bioconductor v3.9.0 Biostrings
Memory efficient string containers, string matching
Link to this section Summary
Functions
AAString objects
The Single-Letter Amino Acid Code
AlignedXStringSet and QualityAlignedXStringSet objects
Biostrings internals
DNAString objects
The Standard Genetic Code and its known variants
Known HNF4alpha binding sequences
The IUPAC Extended Genetic Alphabet
InDel objects
MIndex objects
MaskedXString objects
MultipleAlignment objects
PDict objects
PairwiseAlignments, PairwiseAlignmentsSingleSubject, and PairwiseAlignmentsSingleSubjectSummary objects
Write a PairwiseAlignments object to a file
QualityScaledBStringSet, QualityScaledDNAStringSet, QualityScaledRNAStringSet and QualityScaledAAStringSet objects
RNAString objects
XStringPartialMatches objects
PhredQuality, SolexaQuality and IlluminaQuality objects
XStringSetList objects
XStringSet objects
Comparing and ordering the elements in one or more XStringSet objects
Read/write an XStringSet object from/to a file
The XStringViews class
BString objects
Utility functions related to sequence alignment
Replace letters in a sequence or set of sequences
Show (display) detailed object content
Pearson's chi-squared Test and G-tests for String Position Dependence
Searching a sequence for palindromes
getSeq
A replacement for R standard gregexpr function
Injecting a hard mask in a sequence
Subsetting a string
Calculate the frequency of letters in a biological sequence, or the consensus matrix of a set of sequences
Obtain the length of the longest substring containing only 'letter'
Low-level matching functions
Masking by content (or by position)
Find paired matches in a sequence
Matching a dictionary of patterns against a reference
Inexact matching with matchPDict()/countPDict()/whichPDict()
PWM creating, matching, and related utilities
String searching functions
Find "theoretical amplicons" mapped to a probe pair
Utility functions operating on the matches returned by a high-level matching function
A function to match a query sequence to the sequences of a set of probes.
Some miscellaneous stuff
(Deprecated) Needleman-Wunsch Global Alignment
Calculate the frequency of oligonucleotides in a DNA or RNA sequence (and other related functions)
Pad and clip strings
Optimal Pairwise Alignment
Versions of bacteriophage phiX174 complete genome and sample short reads
Percent Sequence Identity
Longest Common Prefix/Suffix/Substring searching functions
Extract/replace arbitrary substrings from/in a string or set of strings.
Replacing letters in a sequence (or set of sequences) at some specified locations
Sequence reversing and complementing
String Distance/Alignment Score Matrix
Scoring matrices
Turning a DNA sequence into a vector of complex numbers
Translating DNA/RNA sequences
Trim Flanking Patterns from Sequences
Concatenate sequences contained in XString, XStringSet and/or XStringViews objects
An annotation data file for CHR1 in the yeastSEQ package
Link to this section Functions
AAString_class()
AAString objects
Description
An AAString object allows efficient storage and manipulation of a long amino acid sequence.
Usage
AAString(x="", start=1, nchar=NA)
## Predefined constants:
AA_ALPHABET # full Amino Acid alphabet
AA_STANDARD # first 20 letters only
AA_PROTEINOGENIC # first 22 letters only
Arguments
Argument | Description |
---|---|
x | A single string. |
start, nchar | Where to start reading from in x and how many letters to read. |
Details
The AAString class is a direct XString subclass (with no additional slot). Therefore all functions and methods described in the XString man page also work with an AAString object (inheritance).
Unlike the BString container that allows storage of any single string (based on a single-byte character set) the AAString container can only store a string based on the Amino Acid alphabet (see below).
Seealso
AMINO_ACID_CODE
,
letter
,
XString-class ,
alphabetFrequency
Author
H. Pagès
Examples
AA_ALPHABET
a <- AAString("MARKSLEMSIR*")
length(a)
alphabet(a)
AMINO_ACID_CODE()
The Single-Letter Amino Acid Code
Description
Named character vector mapping single-letter amino acid representations to 3-letter amino acid representations.
Seealso
Examples
## See all the 3-letter codes
AMINO_ACID_CODE
## Convert an AAString object to a vector of 3-letter amino acid codes
aa <- AAString("LANDEECQW")
AMINO_ACID_CODE[strsplit(as.character(aa), NULL)[[1]]]
AlignedXStringSet_class()
AlignedXStringSet and QualityAlignedXStringSet objects
Description
The AlignedXStringSet
and QualityAlignedXStringSet
classes are
containers for storing an aligned XStringSet
.
Details
Before we define the notion of alignment, we introduce the notion of "filled-with-gaps subsequence". A "filled-with-gaps subsequence" of a string string1 is obtained by inserting 0 or any number of gaps in a subsequence of s1. For example L-A--ND and A--N-D are "filled-with-gaps subsequences" of LAND. An alignment between two strings string1 and string2 results in two strings (align1 and align2) that have the same length and are "filled-with-gaps subsequences" of string1 and string2.
For example, this is an alignment between LAND and LEAVES: list(" ", " L-A ", " LEA ", " ")
An alignment can be seen as a compact representation of one set of basic operations that transforms string1 into align1. There are 3 different kinds of basic operations: "insertions" (gaps in align1), "deletions" (gaps in align2), "replacements". The above alignment represents the following basic operations: list(" ", " insert E at pos 2 ", " insert V at pos 4 ", " insert E at pos 5 ", " replace by S at pos 6 (N is replaced by S) ", " delete at pos 7 (D is deleted) ", " ") Note that "insert X at pos i" means that all letters at a position >= i are moved 1 place to the right before X is actually inserted.
There are many possible alignments between two given strings string1 and string2 and a common problem is to find the one (or those ones) with the highest score, i.e. with the lower total cost in terms of basic operations.
Seealso
pairwiseAlignment
,
PairwiseAlignments-class
,
XStringSet-class
Author
P. Aboyoun
Examples
pattern <- AAString("LAND")
subject <- AAString("LEAVES")
pa1 <- pairwiseAlignment(pattern, subject, substitutionMatrix="BLOSUM50",
gapOpening=3, gapExtension=1)
alignedPattern <- pattern(pa1)
class(alignedPattern) # AlignedXStringSet object
unaligned(alignedPattern)
aligned(alignedPattern)
as.character(alignedPattern)
nchar(alignedPattern)
Biostrings_internals()
Biostrings internals
Description
Biostrings objects, classes and methods that are not intended to be used directly.
Author
H. Pagès
DNAString_class()
DNAString objects
Description
A DNAString object allows efficient storage and manipulation of a long DNA sequence.
Details
The DNAString class is a direct XString subclass (with no additional slot). Therefore all functions and methods described in the XString man page also work with a DNAString object (inheritance).
Unlike the BString container that allows storage of any single string (based on a single-byte character set) the DNAString container can only store a string based on the DNA alphabet (see below). In addition, the letters stored in a DNAString object are encoded in a way that optimizes fast search algorithms.
Seealso
IUPAC_CODE_MAP
,
letter
,
XString-class ,
RNAString-class ,
reverseComplement
,
alphabetFrequency
Author
H. Pagès
Examples
DNA_BASES
DNA_ALPHABET
d <- DNAString("TTGAAAA-CTC-N")
length(d)
alphabet(d) # DNA_ALPHABET
alphabet(d, baseOnly=TRUE) # DNA_BASES
GENETIC_CODE()
The Standard Genetic Code and its known variants
Description
Two predefined objects ( GENETIC_CODE
and RNA_GENETIC_CODE
)
that represent The Standard Genetic Code.
Other genetic codes are stored in predefined table GENETIC_CODE_TABLE
from which they can conveniently be extracted with getGeneticCode
.
Usage
## The Standard Genetic Code:
GENETIC_CODE
RNA_GENETIC_CODE
## All the known genetic codes:
GENETIC_CODE_TABLE
getGeneticCode(id_or_name2="1", full.search=FALSE, as.data.frame=FALSE)
Arguments
Argument | Description |
---|---|
id_or_name2 | A single string that uniquely identifies the genetic code to extract. Should be one of the values in the id or name2 columns of GENETIC_CODE_TABLE . |
full.search | By default, only the id and name2 columns of GENETIC_CODE_TABLE are searched for an exact match with id_or_name2 . If full.search is TRUE, then the search is extended to the name column of GENETIC_CODE_TABLE and id_or_name2 only needs to be a substring of one of the names in that column (also case is ignored). |
as.data.frame | Should the genetic code be returned as a data frame instead of a named character vector? |
Details
Formally, a genetic code is a mapping between the 64 tri-nucleotide sequences (called codons) and amino acids.
The Standard Genetic Code (a.k.a. The Canonical Genetic Code, or simply The Genetic Code) is the particular mapping that encodes the vast majority of genes in nature.
GENETIC_CODE
and RNA_GENETIC_CODE
are predefined named
character vectors that represent this mapping.
All the known genetic codes are summarized in GENETIC_CODE_TABLE
,
which is a predefined data frame with one row per known genetic code.
Use getGeneticCode
to extract one genetic code at a time from
this object.
Value
GENETIC_CODE
and RNA_GENETIC_CODE
are both named character
vectors of length 64 (the number of all possible tri-nucleotide sequences)
where each element is a single letter representing either an amino acid
or the stop codon "*"
(aka termination codon).
The names of the GENETIC_CODE
vector are the DNA codons i.e. the
tri-nucleotide sequences (directed 5' to 3') that are assumed to belong
to the "coding DNA strand" (aka "sense DNA strand" or "non-template DNA
strand") of the gene.
The names of the RNA_GENETIC_CODE
are the RNA codons i.e. the
tri-nucleotide sequences (directed 5' to 3') that are assumed to belong
to the mRNA of the gene.
Note that the values in the GENETIC_CODE
and RNA_GENETIC_CODE
vectors are the same, only their names are different. The names of the
latter are those of the former where all occurrences of T (thymine) have
been replaced by U (uracil).
Finally, both vectors have an alt_init_codons
attribute on them,
that lists the list("alternative initiation codons") . Note that codons that
always translate to M
(Methionine) (e.g. ATG in GENETIC_CODE
or AUG in RNA_GENETIC_CODE
) are omitted from the
alt_init_codons
attribute.
GENETIC_CODE_TABLE
is a data frame that contains all the known
genetic codes listed at ftp://ftp.ncbi.nih.gov/entrez/misc/data/gc.prt .
The data frame has one row per known genetic code and the 5 following
columns:
name
: The long and very descriptive name of the genetic code.name2
: The short name of the genetic code (not all genetic codes have one).id
: The id of the genetic code.AAs
: A 64-character string representing the genetic code itself in a compact form (i.e. one letter per codon, the codons are assumed to be ordered like inGENETIC_CODE
).Starts
: A 64-character string indicating the Initiation Codons.
By default (i.e. when as.data.frame
is set to FALSE),
getGeneticCode
returns a named character vector of length 64
similar to GENETIC_CODE
i.e. it contains 1-letter strings from
the Amino Acid alphabet (see ?
) and its names
are identical to names(GENETIC_CODE)
. In addition it has an attribute
on it, the alt_init_codons
attribute, that lists the list("alternative
", " initiation codons") . Note that codons that always translate to M
(Methionine) (e.g. ATG) are omitted from the alt_init_codons
attribute.
When as.data.frame
is set to TRUE, getGeneticCode
returns a
data frame with 64 rows (one per codon), rownames (3-letter strings
representing the codons), and the 2 following columns:
AA
: A 1-letter string from the Amino Acid alphabet (see?
) representing the amino acid mapped to the codon ("*"
is used to mark the stop codon).Start
: A 1-letter string indicating an alternative mapping for the codon i.e. what amino acid the codon is mapped to when it's the first tranlated codon.
The rownames of the data frame are identical tonames(GENETIC_CODE)
.
Seealso
AA_ALPHABET
andAMINO_ACID_CODE
.The
translate
andtrinucleotideFrequency
functions.
Author
H. Pagès
References
All the known genetic codes are described here:
http://www.ncbi.nlm.nih.gov/Taxonomy/Utils/wprintgc.cgi
The "official names" of the various codes ("Standard", "SGC0", "Vertebrate Mitochondrial", "SGC1", etc..) and their ids (1, 2, etc...) were taken from the print-form ASN.1 version of the above document (version 4.0 at the time of this writing):
ftp://ftp.ncbi.nih.gov/entrez/misc/data/gc.prt
Examples
## ---------------------------------------------------------------------
## THE STANDARD GENETIC CODE
## ---------------------------------------------------------------------
GENETIC_CODE
## Codon ATG is *always* translated to M (Methionine)
GENETIC_CODE[["ATG"]]
## Codons TTG and CTG are "normally" translated to L except when they are
## the first translated codon (a.k.a. start codon or initiation codon),
## in which case they are translated to M:
attr(GENETIC_CODE, "alt_init_codons")
GENETIC_CODE[["TTG"]]
GENETIC_CODE[["CTG"]]
sort(table(GENETIC_CODE)) # the same amino acid can be encoded by 1
# to 6 different codons
RNA_GENETIC_CODE
all(GENETIC_CODE == RNA_GENETIC_CODE) # TRUE
## ---------------------------------------------------------------------
## ALL THE KNOWN GENETIC CODES
## ---------------------------------------------------------------------
GENETIC_CODE_TABLE[1:3 , ]
getGeneticCode("SGC0") # The Standard Genetic Code, again
stopifnot(identical(getGeneticCode("SGC0"), GENETIC_CODE))
getGeneticCode("SGC1") # Vertebrate Mitochondrial
getGeneticCode("ascidian", full.search=TRUE) # Ascidian Mitochondrial
## ---------------------------------------------------------------------
## EXAMINE THE DIFFERENCES BETWEEN THE STANDARD CODE AND A NON-STANDARD
## ONE
## ---------------------------------------------------------------------
idx <- which(GENETIC_CODE != getGeneticCode("SGC1"))
rbind(Standard=GENETIC_CODE[idx], SGC1=getGeneticCode("SGC1")[idx])
HNF4alpha()
Known HNF4alpha binding sequences
Description
Seventy one known HNF4alpha binding sequences
Details
A DNAStringSet
containing 71 known binding sequences for HNF4alpha.
Author
P. Aboyoun
References
Ellrott, K., Yang, C., Sladek, F.M., Jiang, T. (2002) "Identifying transcription factor binding sites through Markov chain optimations", Bioinformatics, 18 (Suppl. 2), S100-S109.
Examples
data(HNF4alpha)
HNF4alpha
IUPAC_CODE_MAP()
The IUPAC Extended Genetic Alphabet
Description
The IUPAC_CODE_MAP
named character vector contains the mapping from
the IUPAC nucleotide ambiguity codes to their meaning.
The mergeIUPACLetters
function provides the reverse mapping.
Usage
IUPAC_CODE_MAP
mergeIUPACLetters(x)
Arguments
Argument | Description |
---|---|
x | A vector of non-empty character strings made of IUPAC letters. |
Details
IUPAC nucleotide ambiguity codes are used for representing sequences of nucleotides where the exact nucleotides that occur at some given positions are not known with certainty.
Value
IUPAC_CODE_MAP
is a named character vector where the names are
the IUPAC nucleotide ambiguity codes and the values are their corresponding
meanings. The meaning of each code is described by a string that enumarates
the base letters ( "A"
, "C"
, "G"
or "T"
)
associated with the code.
The value returned by mergeIUPACLetters
is an unnamed character
vector of the same length as its argument x
where each element
is an IUPAC nucleotide ambiguity code.
Seealso
Author
H. Pagès
References
http://www.chick.manchester.ac.uk/SiteSeer/IUPAC_codes.html
IUPAC-IUB SYMBOLS FOR NUCLEOTIDE NOMENCLATURE: Cornish-Bowden (1985) Nucl. Acids Res. 13: 3021-3030.
Examples
IUPAC_CODE_MAP
some_iupac_codes <- c("R", "M", "G", "N", "V")
IUPAC_CODE_MAP[some_iupac_codes]
mergeIUPACLetters(IUPAC_CODE_MAP[some_iupac_codes])
mergeIUPACLetters(c("Ca", "Acc", "aA", "MAAmC", "gM", "AB", "bS", "mk"))
InDel_class()
InDel objects
Description
The InDel
class is a container for storing insertion and deletion
information.
Details
This is a generic class that stores any insertion and deletion information.
Seealso
pairwiseAlignment
,
PairwiseAlignments-class
Author
P. Aboyoun
MIndex_class()
MIndex objects
Description
The MIndex class is the basic container for storing the matches of a set of patterns in a subject sequence.
Details
An MIndex object contains the matches (start/end locations) of a set of patterns found in an XString object called "the subject string" or "the subject sequence" or simply "the subject".
matchPDict
function returns an MIndex object.
Seealso
matchPDict
,
PDict-class ,
IRanges-class ,
XStringViews-class
Author
H. Pagès
Examples
## See ?matchPDict and ?`matchPDict-inexact` for some examples.
MaskedXString_class()
MaskedXString objects
Description
The MaskedBString, MaskedDNAString, MaskedRNAString and MaskedAAString classes are containers for storing masked sequences.
All those containers derive directly (and with no additional slots) from the MaskedXString virtual class.
Details
In Biostrings, a pile of masks can be put on top of a sequence. A pile of masks is represented by a MaskCollection object and the sequence by an XString object. A MaskedXString object is the result of bundling them together in a single object.
Note that, no matter what masks are put on top of it, the original sequence is always stored unmodified in a MaskedXString object. This allows the user to activate/deactivate masks without having to worry about losing the information stored in the masked/unmasked regions. Also this allows efficient memory management since the original sequence never needs to be copied (modifying it would require to make a copy of it first - sequences cannot and should never be modified in place in Biostrings), even when the set of active/inactive masks changes.
Seealso
Author
H. Pagès
Examples
## ---------------------------------------------------------------------
## A. MASKING BY POSITION
## ---------------------------------------------------------------------
mask0 <- Mask(mask.width=29, start=c(3, 10, 25), width=c(6, 8, 5))
x <- DNAString("ACACAACTAGATAGNACTNNGAGAGACGC")
length(x) # same as width(mask0)
nchar(x) # same as length(x)
masks(x) <- mask0
x
length(x) # has not changed
nchar(x) # has changed
gaps(x)
## Prepare a MaskCollection object of 3 masks ('mymasks') by running the
## examples in the man page for these objects:
example(MaskCollection, package="IRanges")
## Put it on 'x':
masks(x) <- mymasks
x
alphabetFrequency(x)
## Deactivate all masks:
active(masks(x)) <- FALSE
x
## Activate mask "C":
active(masks(x))["C"] <- TRUE
x
## Turn MaskedXString object into a Views object:
as(x, "Views")
## Drop the masks:
masks(x) <- NULL
x
alphabetFrequency(x)
## ---------------------------------------------------------------------
## B. MASKING BY CONTENT
## ---------------------------------------------------------------------
## See ?maskMotif for masking by content
MultipleAlignment_class()
MultipleAlignment objects
Description
The MultipleAlignment class is a container for storing multiple sequence alignments.
Usage
## Constructors:
DNAMultipleAlignment(x=character(), start=NA, end=NA, width=NA,
use.names=TRUE, rowmask=NULL, colmask=NULL)
RNAMultipleAlignment(x=character(), start=NA, end=NA, width=NA,
use.names=TRUE, rowmask=NULL, colmask=NULL)
AAMultipleAlignment(x=character(), start=NA, end=NA, width=NA,
use.names=TRUE, rowmask=NULL, colmask=NULL)
## Read functions:
readDNAMultipleAlignment(filepath, format)
readRNAMultipleAlignment(filepath, format)
readAAMultipleAlignment(filepath, format)
## Write funtions:
write.phylip(x, filepath)
## ... and more (see below)
Arguments
Argument | Description |
---|---|
x | Either a character vector (with no NAs), or an XString , XStringSet or XStringViews object containing strings with the same number of characters. If writing out a Phylip file, then x would be a MultipleAlignment object |
start,end,width | Either NA , a single integer, or an integer vector of the same length as x specifying how x should be "narrowed" (see ? in the IRanges package for the details). |
use.names | TRUE or FALSE . Should names be preserved? |
|filepath
| A character vector (of arbitrary length when reading, of length 1 when writing) containing the paths to the files to read or write. Note that special values like ""
or "|cmd"
(typically supported by other I/O functions in R) are not supported here. Also filepath
cannot be a connection. |
|format
| Either "fasta"
(the default), stockholm
, or "clustal"
. |
|rowmask
| a NormalIRanges object that will set masking for rows |
|colmask
| a NormalIRanges object that will set masking for columns |
Details
The MultipleAlignment class is designed to hold and represent multiple sequence alignments. The rows and columns within an alignment can be masked for ad hoc analyses.
Seealso
XStringSet-class , MaskedXString-class
Author
P. Aboyoun and M. Carlson
Examples
## create an object from file
origMAlign <-
readDNAMultipleAlignment(filepath =
system.file("extdata",
"msx2_mRNA.aln",
package="Biostrings"),
format="clustal")
## list the names of the sequences in the alignment
rownames(origMAlign)
## rename the sequences to be the underlying species for MSX2
rownames(origMAlign) <- c("Human","Chimp","Cow","Mouse","Rat",
"Dog","Chicken","Salmon")
origMAlign
## See a detailed pager view
if (interactive()) {
detail(origMAlign)
}
## operations to mask rows
## For columns, just use colmask() and do the same kinds of operations
rowMasked <- origMAlign
rowmask(rowMasked) <- IRanges(start=1,end=3)
rowMasked
## remove rowumn masks
rowmask(rowMasked) <- NULL
rowMasked
## "select" rows of interest
rowmask(rowMasked, invert=TRUE) <- IRanges(start=4,end=7)
rowMasked
## or mask the rows that intersect with masked rows
rowmask(rowMasked, append="intersect") <- IRanges(start=1,end=5)
rowMasked
## TATA-masked
tataMasked <- maskMotif(origMAlign, "TATA")
colmask(tataMasked)
## automatically mask rows based on consecutive gaps
autoMasked <- maskGaps(origMAlign, min.fraction=0.5, min.block.width=4)
colmask(autoMasked)
autoMasked
## calculate frequencies
alphabetFrequency(autoMasked)
consensusMatrix(autoMasked, baseOnly=TRUE)[, 84:90]
## get consensus values
consensusString(autoMasked)
consensusViews(autoMasked)
## cluster the masked alignments
sdist <- stringDist(as(autoMasked,"DNAStringSet"), method="hamming")
clust <- hclust(sdist, method = "single")
plot(clust)
fourgroups <- cutree(clust, 4)
fourgroups
## write out the alignement object (with current masks) to Phylip format
write.phylip(x = autoMasked, filepath = tempfile("foo.txt",tempdir()))
PDict_class()
PDict objects
Description
The PDict class is a container for storing a preprocessed dictionary of DNA
patterns that can later be passed to the matchPDict
function
for fast matching against a reference sequence (the subject).
PDict
is the constructor function for creating new PDict objects.
Usage
PDict(x, max.mismatch=NA, tb.start=NA, tb.end=NA, tb.width=NA,
algorithm="ACtree2", skip.invalid.patterns=FALSE)
Arguments
Argument | Description |
---|---|
x | A character vector, a DNAStringSet object or an XStringViews object with a DNAString subject. |
max.mismatch | A single non-negative integer or NA . See the "Allowing a small number of mismatching letters" section below. |
tb.start,tb.end,tb.width | A single integer or NA . See the "Trusted Band" section below. |
algorithm | "ACtree2" (the default) or "Twobit" . |
skip.invalid.patterns | This argument is not supported yet (and might in fact be replaced by the filter argument very soon). |
Details
THIS IS STILL WORK IN PROGRESS!
If the original dictionary x
is a character vector or
an XStringViews object with a DNAString subject,
then the PDict
constructor will first try to turn it
into a DNAStringSet object.
By default (i.e. if PDict
is called with max.mismatch=NA
,
tb.start=NA
, tb.end=NA
and tb.width=NA
)
the following limitations apply: (1) the original dictionary can only
contain base letters (i.e. only As, Cs, Gs and Ts), therefore IUPAC
ambiguity codes are not allowed; (2) all the
patterns in the dictionary must have the same length ("constant width"
dictionary); and (3) later matchPdict
can only be used with
max.mismatch=0
.
A Trusted Band can be used in order to relax these limitations (see the "Trusted Band" section below).
If you are planning to use the resulting PDict
object in order
to do inexact matching where valid hits are allowed to have a small
number of mismatching letters, then see the "Allowing a small number
of mismatching letters" section below.
Two preprocessing algorithms are currently supported:
algorithm="ACtree2"
(the default) and algorithm="Twobit"
.
With the "ACtree2"
algorithm, all the oligonucleotides in the
Trusted Band are stored in a 4-ary Aho-Corasick tree.
With the "Twobit"
algorithm, the 2-bit-per-letter
signatures of all the oligonucleotides in the Trusted Band are computed
and the mapping from these signatures to the 1-based position of the
corresponding oligonucleotide in the Trusted Band is stored in a way that
allows very fast lookup.
Only PDict objects preprocessed with the "ACtree2"
algo can then
be used with matchPdict
(and family) and with fixed="pattern"
(instead of fixed=TRUE
, the default), so that IUPAC ambiguity codes
in the subject are treated as ambiguities. PDict objects obtained with the
"Twobit"
algo don't allow this.
See ?`` for more information about support of IUPAC ambiguity codes in the subject. ## Seealso [
matchPDict](#matchpdict) , [
DNA_ALPHABET](#dnaalphabet) , [
IUPAC_CODE_MAP`](#iupaccodemap) ,
DNAStringSet-class ,
XStringViews-class
## Author
H. Pagès
## References
Aho, Alfred V.; Margaret J. Corasick (June 1975). "Efficient string
matching: An aid to bibliographic search".
Communications of the ACM 18 (6): 333-340.
## Examples
r ## --------------------------------------------------------------------- ## A. NO HEAD AND NO TAIL (THE DEFAULT) ## --------------------------------------------------------------------- library(drosophila2probe) dict0 <- DNAStringSet(drosophila2probe) dict0 # The original dictionary. length(dict0) # Hundreds of thousands of patterns. unique(nchar(dict0)) # Patterns are 25-mers. pdict0 <- PDict(dict0) # Store the original dictionary in # a PDict object (preprocessing). pdict0 class(pdict0) length(pdict0) # Same as length(dict0). tb.width(pdict0) # The width of the (implicit) # Trusted Band. sum(duplicated(pdict0)) table(patternFrequency(pdict0)) # 9 patterns are repeated 3 times. pdict0[[1]] pdict0[[5]] ## --------------------------------------------------------------------- ## B. NO HEAD AND A TAIL ## --------------------------------------------------------------------- dict1 <- c("ACNG", "GT", "CGT", "AC") pdict1 <- PDict(dict1, tb.end=2) pdict1 class(pdict1) length(pdict1) width(pdict1) head(pdict1) tb(pdict1) tb.width(pdict1) width(tb(pdict1)) tail(pdict1) pdict1[[3]]
PairwiseAlignments_class()
PairwiseAlignments, PairwiseAlignmentsSingleSubject, and PairwiseAlignmentsSingleSubjectSummary objects
Description
The PairwiseAlignments
class is a container for storing
a set of pairwise alignments.
The PairwiseAlignmentsSingleSubject
class is a container for storing
a set of pairwise alignments with a single subject.
The PairwiseAlignmentsSingleSubjectSummary
class is a container for storing
the summary of a set of pairwise alignments.
Usage
## Constructors:
## When subject is missing, pattern must be of length 2
list(list("PairwiseAlignments"), list("XString,XString"))(pattern, subject,
type = "global", substitutionMatrix = NULL, gapOpening = 0, gapExtension = 1)
list(list("PairwiseAlignments"), list("XStringSet,missing"))(pattern, subject,
type = "global", substitutionMatrix = NULL, gapOpening = 0, gapExtension = 1)
list(list("PairwiseAlignments"), list("character,character"))(pattern, subject,
type = "global", substitutionMatrix = NULL, gapOpening = 0, gapExtension = 1,
baseClass = "BString")
list(list("PairwiseAlignments"), list("character,missing"))(pattern, subject,
type = "global", substitutionMatrix = NULL, gapOpening = 0, gapExtension = 1,
baseClass = "BString")
Arguments
Argument | Description |
---|---|
pattern | a character vector of length 1 or 2, an XString , or an XStringSet object of length 1 or 2. |
subject | a character vector of length 1 or an XString object. |
type | type of alignment. One of "global" , "local" , "overlap" , "global-local" , and "local-global" where "global" = align whole strings with end gap penalties, "local" = align string fragments, "overlap" = align whole strings without end gap penalties, "global-local" = align whole strings in pattern with consecutive subsequence of subject , "local-global" = align consecutive subsequence of pattern with whole strings in subject . |
substitutionMatrix | substitution matrix for the alignment. If NULL, the diagonal values and off-diagonal values are set to 0 and 1 respectively. |
gapOpening | the cost for opening a gap in the alignment. |
gapExtension | the incremental cost incurred along the length of the gap in the alignment. |
baseClass | the base XString class to use in the alignment. |
Details
Before we define the notion of alignment, we introduce the notion of "filled-with-gaps subsequence". A "filled-with-gaps subsequence" of a string string1 is obtained by inserting 0 or any number of gaps in a subsequence of s1. For example L-A--ND and A--N-D are "filled-with-gaps subsequences" of LAND. An alignment between two strings string1 and string2 results in two strings (align1 and align2) that have the same length and are "filled-with-gaps subsequences" of string1 and string2.
For example, this is an alignment between LAND and LEAVES: list(" ", " L-A ", " LEA ", " ")
An alignment can be seen as a compact representation of one set of basic operations that transforms string1 into align1. There are 3 different kinds of basic operations: "insertions" (gaps in align1), "deletions" (gaps in align2), "replacements". The above alignment represents the following basic operations: list(" ", " insert E at pos 2 ", " insert V at pos 4 ", " insert E at pos 5 ", " replace by S at pos 6 (N is replaced by S) ", " delete at pos 7 (D is deleted) ", " ") Note that "insert X at pos i" means that all letters at a position >= i are moved 1 place to the right before X is actually inserted.
There are many possible alignments between two given strings string1 and string2 and a common problem is to find the one (or those ones) with the highest score, i.e. with the lower total cost in terms of basic operations.
Seealso
pairwiseAlignment
,
writePairwiseAlignments
,
AlignedXStringSet-class ,
XString-class ,
XStringViews-class ,
align-utils ,
pid
Author
P. Aboyoun
Examples
PairwiseAlignments("-PA--W-HEAE", "HEAGAWGHE-E")
pattern <- AAStringSet(c("HLDNLKGTF", "HVDDMPNAKLLL"))
subject <- AAString("SHLDTEKMSMKLL")
pa1 <- pairwiseAlignment(pattern, subject, substitutionMatrix="BLOSUM50",
gapOpening=3, gapExtension=1)
pa1
alignedPattern(pa1)
alignedSubject(pa1)
stopifnot(identical(width(alignedPattern(pa1)),
width(alignedSubject(pa1))))
as.character(pa1)
aligned(pa1)
as.matrix(pa1)
nchar(pa1)
score(pa1)
PairwiseAlignments_io()
Write a PairwiseAlignments object to a file
Description
The writePairwiseAlignments
function writes a
PairwiseAlignments object to a file.
Only the "pair" format is supported at the moment.
Usage
writePairwiseAlignments(x, file="", Matrix=NA, block.width=50)
Arguments
Argument | Description |
---|---|
x | A PairwiseAlignments object, typically returned by the pairwiseAlignment function. |
|file
| A connection, or a character string naming the file to print to. If ""
(the default), writePairwiseAlignments
prints to the standard output connection (aka the console) unless redirected by sink
. If it is "|cmd"
, the output is piped to the command given by cmd
, by opening a pipe connection. |
|Matrix
| A single string containing the name of the substitution matrix (e.g. "BLOSUM50"
) used for the alignment. See the substitutionMatrix
argument of the pairwiseAlignment
function for the details. See ?
for a list of predefined substitution matrices available in the Biostrings package. |
|block.width
| A single integer specifying the maximum number of sequence letters (including the "-" letter, which represents gaps) per line. |
Details
The "pair" format is one of the numerous pairwise sequence alignment formats supported by the EMBOSS software. See http://emboss.sourceforge.net/docs/themes/AlignFormats.html for a brief (and rather informal) description of this format.
Seealso
Note
This brief description of the "pair" format suggests that it is best suited for global pairwise alignments, because, in that case, the original pattern and subject sequences can be inferred (by just removing the gaps).
However, even though the "pair" format can also be used for non global
pairwise alignments (i.e. for global-local , local-global ,
and local pairwise alignments), in that case the original
pattern and subject sequences cannot be inferred. This is because
the alignment written to the file doesn't necessarily span the entire
pattern (if type(x)
is local-global
or local
)
or the entire subject (if type(x)
is global-local
or local
).
As a consequence, the writePairwiseAlignments
function can be
used on a PairwiseAlignments object x
containing non global
alignments (i.e. with type(x) != "global"
), but with the 2 following
caveats:
The type of the alignments (
type(x)
) is not written to the file.The original pattern and subject sequences cannot be inferred. Furthermore, there is no way to infer their lengths (because we don't know whether they were trimmed or not).
Also note that the pairwiseAlignment
function
interprets the gapOpening
and gapExtension
arguments
differently than most other alignment tools. As a consequence
the values of the Gap_penalty and Extend_penalty fields written to
the file are not the same as the values that were passed to the
gapOpening
and gapExtension
arguments. With the
following relationship:
Gap_penalty = gapOpening + gapExtension
Extend_penalty = gapExtension
Author
H. Pagès
References
http://emboss.sourceforge.net/docs/themes/AlignFormats.html
Examples
## ---------------------------------------------------------------------
## A. WITH ONE PAIR
## ---------------------------------------------------------------------
pattern <- DNAString("CGTACGTAACGTTCGT")
subject <- DNAString("CGTCGTCGTCCGTAA")
pa1 <- pairwiseAlignment(pattern, subject)
pa1
writePairwiseAlignments(pa1)
writePairwiseAlignments(pa1, block.width=10)
## The 2 bottom-right numbers (16 and 15) are the lengths of
## the original pattern and subject, respectively.
pa2 <- pairwiseAlignment(pattern, subject, type="global-local")
pa2 # score is different!
writePairwiseAlignments(pa2)
## By just looking at the file, we can't tell the length of the
## original subject! Could be 13, could be more...
pattern <- DNAString("TCAACTTAACTT")
subject <- DNAString("GGGCAACAACGGG")
pa3 <- pairwiseAlignment(pattern, subject, type="global-local",
gapOpening=-2, gapExtension=-1)
writePairwiseAlignments(pa3)
## ---------------------------------------------------------------------
## B. WITH MORE THAN ONE PAIR (AND NAMED PATTERNS)
## ---------------------------------------------------------------------
pattern <- DNAStringSet(c(myp1="ACCA", myp2="ACGCA", myp3="ACGGCA"))
pa4 <- pairwiseAlignment(pattern, subject)
pa4
writePairwiseAlignments(pa4)
## ---------------------------------------------------------------------
## C. REPRODUCING THE ALIGNMENT SHOWN AT
## http://emboss.sourceforge.net/docs/themes/alnformats/align.pair
## ---------------------------------------------------------------------
pattern <- c("TSPASIRPPAGPSSRPAMVSSRRTRPSPPGPRRPTGRPCCSAAPRRPQAT",
"GGWKTCSGTCTTSTSTRHRGRSGWSARTTTAACLRASRKSMRAACSRSAG",
"SRPNRFAPTLMSSCITSTTGPPAWAGDRSHE")
subject <- c("TSPASIRPPAGPSSRRPSPPGPRRPTGRPCCSAAPRRPQATGGWKTCSGT",
"CTTSTSTRHRGRSGWRASRKSMRAACSRSAGSRPNRFAPTLMSSCITSTT",
"GPPAWAGDRSHE")
pattern <- unlist(AAStringSet(pattern))
subject <- unlist(AAStringSet(subject))
pattern # original pattern
subject # original subject
data(BLOSUM62)
pa5 <- pairwiseAlignment(pattern, subject,
substitutionMatrix=BLOSUM62,
gapOpening=9.5, gapExtension=0.5)
pa5
writePairwiseAlignments(pa5, Matrix="BLOSUM62")
QualityScaledXStringSet_class()
QualityScaledBStringSet, QualityScaledDNAStringSet, QualityScaledRNAStringSet and QualityScaledAAStringSet objects
Description
The QualityScaledBStringSet class is a container for storing a
BStringSet
object with an XStringQuality
object.
Similarly, the QualityScaledDNAStringSet (or QualityScaledRNAStringSet, or
QualityScaledAAStringSet) class is a container for storing a
DNAStringSet
(or RNAStringSet
, or
AAStringSet
) objects with an XStringQuality
object.
Usage
## Constructors:
QualityScaledBStringSet(x, quality)
QualityScaledDNAStringSet(x, quality)
QualityScaledRNAStringSet(x, quality)
QualityScaledAAStringSet(x, quality)
## Read/write a QualityScaledXStringSet object from/to a FASTQ file:
readQualityScaledDNAStringSet(filepath,
quality.scoring=c("phred", "solexa", "illumina"),
nrec=-1L, skip=0L, seek.first.rec=FALSE,
use.names=TRUE)
writeQualityScaledXStringSet(x, filepath, append=FALSE,
compress=FALSE, compression_level=NA)
Arguments
Argument | Description |
---|---|
x | For the QualityScaled*StringSet constructors: Either a character vector, or an XString , XStringSet or XStringViews object. For writeQualityScaledXStringSet : A QualityScaledDNAStringSet object or other QualityScaledXStringSet derivative. |
quality | An XStringQuality derivative. |
filepath, nrec, skip, seek.first.rec, use.names, |
| See ?`` . | |
quality.scoring| Specify the quality scoring used in the FASTQ file. Must be one of
"phred"(the default),
"solexa", or
"illumina". If set to
"phred"(or
"solexa"or
"illumina"), the qualities will be stored in a [PhredQuality](#phredquality) (or [SolexaQuality](#solexaquality) or [IlluminaQuality](#illuminaquality) , respectively) object. | ## Details The
QualityScaledBStringSet,
QualityScaledDNAStringSet,
QualityScaledRNAStringSetand
QualityScaledAAStringSetfunctions are constructors that can be used to "naturally" turn
xinto an QualityScaledXStringSet object of the desired base type. ## Seealso * [BStringSet](#bstringset) , [DNAStringSet](#dnastringset) , [RNAStringSet](#rnastringset) , and [AAStringSet](#aastringset) objects. * [XStringQuality](#xstringquality) objects. * [
readDNAStringSet](#readdnastringset) and [
writeXStringSet`](#writexstringset) for reading/writing a DNAStringSet object (or other XStringSet derivative) from/to a FASTA or FASTQ file.
## Author
P. Aboyoun
## Examples
r ## --------------------------------------------------------------------- ## QualityScaled*StringSet() CONSTRUCTORS ## --------------------------------------------------------------------- x1 <- DNAStringSet(c("TTGA", "CTCN")) q1 <- PhredQuality(c("*+,-", "6789")) qdna1 <- QualityScaledDNAStringSet(x1, q1) qdna1 ## --------------------------------------------------------------------- ## READ/WRITE A QualityScaledDNAStringSet OBJECT FROM/TO A FASTQ FILE ## --------------------------------------------------------------------- filepath <- system.file("extdata", "s_1_sequence.txt", package="Biostrings") ## By default, readQualityScaledDNAStringSet() assumes that the FASTQ ## file contains "Phred quality scores" (this is the standard Sanger ## variant to assess reliability of a base call): qdna2 <- readQualityScaledDNAStringSet(filepath) qdna2 outfile2a <- tempfile() writeQualityScaledXStringSet(qdna2, outfile2a) outfile2b <- tempfile() writeQualityScaledXStringSet(qdna2, outfile2b, compress=TRUE) ## Use 'quality.scoring="solexa"' or 'quality.scoring="illumina"' if the ## quality scores are Solexa quality scores: qdna3 <- readQualityScaledDNAStringSet(filepath, quality.scoring="solexa") qdna3 outfile3a <- tempfile() writeQualityScaledXStringSet(qdna3, outfile3a) outfile3b <- tempfile() writeQualityScaledXStringSet(qdna3, outfile3b, compress=TRUE) ## Sanity checks: stopifnot(identical(readLines(outfile2a), readLines(filepath))) stopifnot(identical(readLines(outfile2a), readLines(outfile2b))) stopifnot(identical(readLines(outfile3a), readLines(filepath))) stopifnot(identical(readLines(outfile3a), readLines(outfile3b)))
RNAString_class()
RNAString objects
Description
An RNAString object allows efficient storage and manipulation of a long RNA sequence.
Details
The RNAString class is a direct XString subclass (with no additional slot). Therefore all functions and methods described in the XString man page also work with an RNAString object (inheritance).
Unlike the BString container that allows storage of any single string (based on a single-byte character set) the RNAString container can only store a string based on the RNA alphabet (see below). In addition, the letters stored in an RNAString object are encoded in a way that optimizes fast search algorithms.
Seealso
IUPAC_CODE_MAP
,
letter
,
XString-class ,
DNAString-class ,
reverseComplement
,
alphabetFrequency
Author
H. Pagès
Examples
RNA_BASES
RNA_ALPHABET
d <- DNAString("TTGAAAA-CTC-N")
r <- RNAString(d)
r
alphabet(r) # RNA_ALPHABET
alphabet(r, baseOnly=TRUE) # RNA_BASES
## When comparing an RNAString object with a DNAString object,
## U and T are considered equals:
r == d # TRUE
XStringPartialMatches_class()
XStringPartialMatches objects
Description
WARNING: This class is currently under development and might not work properly! Full documentation will come later.
Please DO NOT TRY TO USE it for now. Thanks for your comprehension!
Seealso
XStringViews-class ,
XString-class ,
letter
Author
H. Pagès
XStringQuality_class()
PhredQuality, SolexaQuality and IlluminaQuality objects
Description
Objects for storing string quality measures.
Usage
## Constructors:
PhredQuality(x)
SolexaQuality(x)
IlluminaQuality(x)
## alphabet and encoding
list(list("alphabet"), list("XStringQuality"))(x)
list(list("encoding"), list("XStringQuality"))(x)
Arguments
Argument | Description |
---|---|
x | Either a character vector, BString , BStringSet , integer vector, or number vector of error probabilities. |
Details
PhredQuality
objects store characters that are interpreted as
[0 - 99] quality measures by subtracting 33 from their ASCII decimal
representation (e.g. ! = 0, " = 1, # = 2, ...). Quality measures q
encode probabilities as -10 * log10(p)
.
SolexaQuality
objects store characters that are interpreted as
[-5 - 99] quality measures by subtracting 64 from their ASCII decimal
representation (e.g. ; = -5, < = -4, = = -3, ...). Quality measures q
encode probabilities as -10 * (log10(p) - log10(1 - p))
.
IlluminaQuality
objects store characters that are interpreted
as [0 - 99] quality measures by subtracting 64 from their ASCII
decimal representation (e.g. @ = 0, A = 1, B = 2, ...). Quality
measures q encode probabilities as -10 * log10(p)
Seealso
pairwiseAlignment
,
PairwiseAlignments-class ,
DNAString-class ,
BStringSet-class
Author
P. Aboyoun
Examples
PhredQuality(0:40)
SolexaQuality(0:40)
IlluminaQuality(0:40)
pq <- PhredQuality(c("*+,-./", "0123456789:;"))
qs <- as(pq, "IntegerList") # quality scores
qs
as(qs, "PhredQuality")
p <- as(pq, "NumericList") # probabilities
as(p, "PhredQuality")
PhredQuality(seq(1e-4,0.5,length=10))
SolexaQuality(seq(1e-4,0.5,length=10))
IlluminaQuality(seq(1e-4,0.5,length=10))
x <- SolexaQuality(BStringSet(c(a="@ABC", b="abcd")))
as(x, "IntegerList") # quality scores
as(x, "NumericList") # probabilities
as.matrix(x) # quality scores
XStringSetList_class()
XStringSetList objects
Description
The XStringSetList class is a virtual container for storing a list of XStringSet objects.
Usage
## Constructors:
BStringSetList(..., use.names=TRUE)
DNAStringSetList(..., use.names=TRUE)
RNAStringSetList(..., use.names=TRUE)
AAStringSetList(..., use.names=TRUE)
Arguments
Argument | Description |
---|---|
list() | Character vector(s) (with no NAs), or XStringSet object(s), or XStringViews object(s) to be concatenated into a XStringSetList . |
use.names | TRUE or FALSE . Should names be preserved? |
Details
Concrete flavors of the XStringSetList container are the BStringSetList, DNAStringSetList, RNAStringSetList and AAStringSetList containers for storing a list of BStringSet , DNAStringSet , RNAStringSet and AAStringSet objects, respectively. These four containers are direct subclasses of XStringSetList with no additional slots.
Currently DNAStringSetList()
and AAStringSetList()
are
the only XStringSetList constructors. The XStringSetList class itself
is virtual and has no constructor.
Seealso
Author
H. Pagès
Examples
## ------------------------------------------------------------------------
## A. THE XStringSetList CONSTRUCTORS
## ------------------------------------------------------------------------
## Currently DNAStringSetList() and AAStringSetList() are the only
## constructors. Others will be developed when the use case arises.
dna1 <- c("AAA", "AC", "", "T", "GGATA")
dna2 <- c("G", "TT", "C")
x <- DNAStringSetList(dna1, dna2)
x
DNAStringSetList(DNAStringSet(dna1), DNAStringSet(dna2))
DNAStringSetList(dna1, DNAStringSet(dna2))
DNAStringSetList(DNAStringSet(dna1), dna2)
DNAStringSetList(dna1, RNAStringSet(DNAStringSet(dna2)))
DNAStringSetList(list(dna1, dna2))
DNAStringSetList(CharacterList(dna1, dna2))
## Empty object (i.e. zero-length):
DNAStringSetList()
## Not empty (length is 1):
DNAStringSetList(character(0))
## ---------------------------------------------------------------------
## B. UNLISTING AN XStringSetList OBJECT
## ---------------------------------------------------------------------
length(x)
elementNROWS(x)
unlist(x)
x[[1]]
x[[2]]
as.list(x)
names(x) <- LETTERS[1:length(x)]
x[["A"]]
x[["B"]]
as.list(x) # named list
XStringSet_class()
XStringSet objects
Description
The BStringSet class is a container for storing a set of
BString
objects and for making its manipulation
easy and efficient.
Similarly, the DNAStringSet (or RNAStringSet, or AAStringSet) class is
a container for storing a set of DNAString
(or RNAString
, or AAString
) objects.
All those containers derive directly (and with no additional slots) from the XStringSet virtual class.
Usage
## Constructors:
BStringSet(x=character(), start=NA, end=NA, width=NA, use.names=TRUE)
DNAStringSet(x=character(), start=NA, end=NA, width=NA, use.names=TRUE)
RNAStringSet(x=character(), start=NA, end=NA, width=NA, use.names=TRUE)
AAStringSet(x=character(), start=NA, end=NA, width=NA, use.names=TRUE)
## Accessor-like methods:
list(list("width"), list("character"))(x)
list(list("nchar"), list("XStringSet"))(x, type="chars", allowNA=FALSE)
## ... and more (see below)
Arguments
Argument | Description |
---|---|
x | Either a character vector (with no NAs), or an XString , XStringSet or XStringViews object. |
start,end,width | Either NA , a single integer, or an integer vector of the same length as x specifying how x should be "narrowed" (see ? for the details). |
use.names | TRUE or FALSE . Should names be preserved? |
type,allowNA | Ignored. |
Details
The BStringSet
, DNAStringSet
, RNAStringSet
and
AAStringSet
functions are constructors that can be used to
turn input x
into an XStringSet object of the desired base type.
They also allow the user to "narrow" the sequences contained in x
via proper use of the start
, end
and/or width
arguments. In this context, "narrowing" means dropping a prefix or/and
a suffix of each sequence in x
.
The "narrowing" capabilities of these constructors can be illustrated
by the following property: if x
is a character vector
(with no NAs), or an XStringSet (or XStringViews ) object,
then the 3 following transformations are equivalent:
list("
", " ", list(list(), list("
", " ", list("BStringSet(x, start=mystart, end=myend, width=mywidth)"), "
", " ")), "
", " ", list(list(), list("
", " ", list("subseq(BStringSet(x), start=mystart, end=myend, width=mywidth)"), "
", " ")), "
", " ", list(list(), list("
", " ", list("BStringSet(subseq(x, start=mystart, end=myend, width=mywidth))"), "
", " ")), "
", " ")
Note that, besides being more convenient, the first form is also more
efficient on character vectors.
Seealso
readDNAStringSet
andwriteXStringSet
for reading/writing a DNAStringSet object (or other XStringSet derivative) from/to a FASTA or FASTQ file.XString objects.
XStringViews objects.
XStringSetList objects.
XVectorList objects.
Author
H. Pagès
Examples
## ---------------------------------------------------------------------
## A. USING THE XStringSet CONSTRUCTORS ON A CHARACTER VECTOR OR FACTOR
## ---------------------------------------------------------------------
## Note that there is no XStringSet() constructor, but an XStringSet
## family of constructors: BStringSet(), DNAStringSet(), RNAStringSet(),
## etc...
x0 <- c("#CTC-NACCAGTAT", "#TTGA", "TACCTAGAG")
width(x0)
x1 <- BStringSet(x0)
x1
## 3 equivalent ways to obtain the same BStringSet object:
BStringSet(x0, start=4, end=-3)
subseq(x1, start=4, end=-3)
BStringSet(subseq(x0, start=4, end=-3))
dna0 <- DNAStringSet(x0, start=4, end=-3)
dna0
names(dna0)
names(dna0)[2] <- "seqB"
dna0
## When the input vector contains a lot of duplicates, turning it into
## a factor first before passing it to the constructor will produce an
## XStringSet object that is more compact in memory:
library(hgu95av2probe)
x2 <- sample(hgu95av2probe$sequence, 999000, replace=TRUE)
dna2a <- DNAStringSet(x2)
dna2b <- DNAStringSet(factor(x2)) # slower but result is more compact
object.size(dna2a)
object.size(dna2b)
## ---------------------------------------------------------------------
## B. USING THE XStringSet CONSTRUCTORS ON A SINGLE SEQUENCE (XString
## OBJECT OR CHARACTER STRING)
## ---------------------------------------------------------------------
x3 <- "abcdefghij"
BStringSet(x3, start=2, end=6:2) # behaves like 'substring(x3, 2, 6:2)'
BStringSet(x3, start=-(1:6))
x4 <- BString(x3)
BStringSet(x4, end=-(1:6), width=3)
## Randomly extract 1 million 40-mers from C. elegans chrI:
extractRandomReads <- function(subject, nread, readlength)
{
if (!is.integer(readlength))
readlength <- as.integer(readlength)
start <- sample(length(subject) - readlength + 1L, nread,
replace=TRUE)
DNAStringSet(subject, start=start, width=readlength)
}
library(BSgenome.Celegans.UCSC.ce2)
rndreads <- extractRandomReads(Celegans$chrI, 1000000, 40)
## Notes:
## - This takes only 2 or 3 seconds versus several hours for a solution
## using substring() on a standard character string.
## - The short sequences in 'rndreads' can be seen as the result of a
## simulated high-throughput sequencing experiment. A non-realistic
## one though because:
## (a) It assumes that the underlying technology is perfect (the
## generated reads have no technology induced errors).
## (b) It assumes that the sequenced genome is exactly the same as the
## reference genome.
## (c) The simulated reads can contain IUPAC ambiguity letters only
## because the reference genome contains them. In a real
## high-throughput sequencing experiment, the sequenced genome
## of course doesn't contain those letters, but the sequencer
## can introduce them in the generated reads to indicate ambiguous
## base-calling.
## (d) The simulated reads come from the plus strand only of a single
## chromosome.
## - See the getSeq() function in the BSgenome package for how to
## circumvent (d) i.e. how to generate reads that come from the whole
## genome (plus and minus strands of all chromosomes).
## ---------------------------------------------------------------------
## C. USING THE XStringSet CONSTRUCTORS ON AN XStringSet OBJECT
## ---------------------------------------------------------------------
library(drosophila2probe)
probes <- DNAStringSet(drosophila2probe)
probes
RNAStringSet(probes, start=2, end=-5) # does NOT copy the sequence data!
## ---------------------------------------------------------------------
## D. USING THE XStringSet CONSTRUCTORS ON AN ORDINARY list OF XString
## OBJECTS
## ---------------------------------------------------------------------
probes10 <- head(probes, n=10)
set.seed(33)
shuffled_nucleotides <- lapply(probes10, sample)
shuffled_nucleotides
DNAStringSet(shuffled_nucleotides) # does NOT copy the sequence data!
## Note that the same result can be obtained in a more compact way with
## just:
set.seed(33)
endoapply(probes10, sample)
## ---------------------------------------------------------------------
## E. USING subseq() ON AN XStringSet OBJECT
## ---------------------------------------------------------------------
subseq(probes, start=2, end=-5)
subseq(probes, start=13, end=13) <- "N"
probes
## Add/remove a prefix:
subseq(probes, start=1, end=0) <- "--"
probes
subseq(probes, end=2) <- ""
probes
## Do more complicated things:
subseq(probes, start=4:7, end=7) <- c("YYYY", "YYY", "YY", "Y")
subseq(probes, start=4, end=6) <- subseq(probes, start=-2:-5)
probes
## ---------------------------------------------------------------------
## F. UNLISTING AN XStringSet OBJECT
## ---------------------------------------------------------------------
library(drosophila2probe)
probes <- DNAStringSet(drosophila2probe)
unlist(probes)
## ---------------------------------------------------------------------
## G. COMPACTING AN XStringSet OBJECT
## ---------------------------------------------------------------------
## As a particular type of XVectorList objects, XStringSet objects can
## optionally be compacted. Compacting is done typically before
## serialization. See ?compact for more information.
library(drosophila2probe)
probes <- DNAStringSet(drosophila2probe)
y <- subseq(probes[1:12], start=5)
probes@pool
y@pool
object.size(probes)
object.size(y)
y0 <- compact(y)
y0@pool
object.size(y0)
XStringSet_comparison()
Comparing and ordering the elements in one or more XStringSet objects
Description
Methods for comparing and ordering the elements in one or more XStringSet objects.
Details
Element-wise (aka "parallel") comparison of 2 XStringSet objects is based on the lexicographic order between 2 BString , DNAString , RNAString , or AAString objects.
For DNAStringSet and RNAStringSet objects, the letters in the respective alphabets (i.e. DNA_ALPHABET and RNA_ALPHABET ) are ordered based on a predefined code assigned to each letter. The code assigned to each letter can be retrieved with: list(" ", " dna_codes <- as.integer(DNAString(paste(DNA_ALPHABET, collapse=""))) ", " names(dna_codes) <- DNA_ALPHABET ", " ", " rna_codes <- as.integer(RNAString(paste(RNA_ALPHABET, collapse=""))) ", " names(rna_codes) <- RNA_ALPHABET ", " ") Note that this order does NOT depend on the locale in use. Also note that comparing DNA sequences with RNA sequences is supported and in that case T and U are considered to be the same letter.
For BStringSet and AAStringSet objects, the alphabetical order is defined by the C collation. Note that, at the moment, AAStringSet objects are treated like BStringSet objects i.e. the alphabetical order is NOT defined by the order of the letters in AA_ALPHABET . This might change at some point.
Seealso
XStringSet-class ,
==
,
is.unsorted
,
order
,
rank
,
sort
,
duplicated
,
unique
,
match
,
%in%
Author
H. Pagès
Examples
## ---------------------------------------------------------------------
## A. SIMPLE EXAMPLES
## ---------------------------------------------------------------------
dna <- DNAStringSet(c("AAA", "TC", "", "TC", "AAA", "CAAC", "G"))
match(c("", "G", "AA", "TC"), dna)
library(drosophila2probe)
fly_probes <- DNAStringSet(drosophila2probe)
sum(duplicated(fly_probes)) # 481 duplicated probes
is.unsorted(fly_probes) # TRUE
fly_probes <- sort(fly_probes)
is.unsorted(fly_probes) # FALSE
is.unsorted(fly_probes, strictly=TRUE) # TRUE, because of duplicates
is.unsorted(unique(fly_probes), strictly=TRUE) # FALSE
## Nb of probes that are the reverse complement of another probe:
nb1 <- sum(reverseComplement(fly_probes) %in% fly_probes)
stopifnot(identical(nb1, 455L)) # 455 probes
## Probes shared between drosophila2probe and hgu95av2probe:
library(hgu95av2probe)
human_probes <- DNAStringSet(hgu95av2probe)
m <- match(fly_probes, human_probes)
stopifnot(identical(sum(!is.na(m)), 493L)) # 493 shared probes
## ---------------------------------------------------------------------
## B. AN ADVANCED EXAMPLE
## ---------------------------------------------------------------------
## We want to compare the first 5 bases with the 5 last bases of each
## probe in drosophila2probe. More precisely, we want to compute the
## percentage of probes for which the first 5 bases are the reverse
## complement of the 5 last bases.
library(drosophila2probe)
probes <- DNAStringSet(drosophila2probe)
first5 <- narrow(probes, end=5)
last5 <- narrow(probes, start=-5)
nb2 <- sum(first5 == reverseComplement(last5))
stopifnot(identical(nb2, 17L))
## Percentage:
100 * nb2 / length(probes) # 0.0064 %
## If the probes were random DNA sequences, a probe would have 1 chance
## out of 4^5 to have this property so the percentage would be:
100 / 4^5 # 0.098 %
## With randomly generated probes:
set.seed(33)
random_dna <- sample(DNAString(paste(DNA_BASES, collapse="")),
sum(width(probes)), replace=TRUE)
random_probes <- successiveViews(random_dna, width(probes))
random_probes
random_probes <- as(random_probes, "XStringSet")
random_probes
random_first5 <- narrow(random_probes, end=5)
random_last5 <- narrow(random_probes, start=-5)
nb3 <- sum(random_first5 == reverseComplement(random_last5))
100 * nb3 / length(random_probes) # 0.099 %
XStringSet_io()
Read/write an XStringSet object from/to a file
Description
Functions to read/write an XStringSet object from/to a file.
Usage
## Read FASTA (or FASTQ) files in an XStringSet object:
readBStringSet(filepath, format="fasta",
nrec=-1L, skip=0L, seek.first.rec=FALSE,
use.names=TRUE, with.qualities=FALSE)
readDNAStringSet(filepath, format="fasta",
nrec=-1L, skip=0L, seek.first.rec=FALSE,
use.names=TRUE, with.qualities=FALSE)
readRNAStringSet(filepath, format="fasta",
nrec=-1L, skip=0L, seek.first.rec=FALSE,
use.names=TRUE, with.qualities=FALSE)
readAAStringSet(filepath, format="fasta",
nrec=-1L, skip=0L, seek.first.rec=FALSE,
use.names=TRUE, with.qualities=FALSE)
## Extract basic information about FASTA (or FASTQ) files
## without actually loading the sequence data:
fasta.seqlengths(filepath,
nrec=-1L, skip=0L, seek.first.rec=FALSE,
seqtype="B", use.names=TRUE)
fasta.index(filepath,
nrec=-1L, skip=0L, seek.first.rec=FALSE,
seqtype="B")
fastq.seqlengths(filepath,
nrec=-1L, skip=0L, seek.first.rec=FALSE)
fastq.geometry(filepath,
nrec=-1L, skip=0L, seek.first.rec=FALSE)
## Write an XStringSet object to a FASTA (or FASTQ) file:
writeXStringSet(x, filepath, append=FALSE,
compress=FALSE, compression_level=NA, format="fasta", ...)
## Serialize an XStringSet object:
saveXStringSet(x, objname, dirpath=".", save.dups=FALSE, verbose=TRUE)
Arguments
Argument | Description |
---|
|filepath
| A character vector (of arbitrary length when reading, of length 1 when writing) containing the path(s) to the file(s) to read or write. Reading files in gzip format (which usually have the '.gz' extension) is supported. Note that special values like ""
or "|cmd"
(typically supported by other I/O functions in R) are not supported here. Also filepath
cannot be a standard connection . However filepath
can be an object as returned by open_input_files
. This object can be used to read files by chunks. See "READ FILES BY CHUNK" in the examples section for the details. |
|format
| Either "fasta"
(the default) or "fastq"
. |
|nrec
| Single integer. The maximum of number of records to read in. Negative values are ignored. |
|skip
| Single non-negative integer. The number of records of the data file(s) to skip before beginning to read in records. |
|seek.first.rec
| TRUE
or FALSE
(the default). If TRUE
, then the reading function starts by setting the file position indicator at the beginning of the first line in the file that looks like the beginning of a FASTA (if format
is "fasta"
) or FASTQ (if format
is "fastq"
) record. More precisely this is the first line in the file that starts with a '>' (for FASTA) or a '@' (for FASTQ). An error is raised if no such line is found. Normal parsing then starts from there, and everything happens like if the file actually started there. In particular it will be an error if this first record is not a valid FASTA or FASTQ record. Using seek.first.rec=TRUE
is useful for example to parse GFF3 files with embedded FASTA data. |
|use.names
| TRUE
(the default) or FALSE
. If TRUE
, then the returned vector is named. For FASTA the names are taken from the record description lines. For FASTQ they are taken from the record sequence ids. Dropping the names with use.names=FALSE
can help reduce memory footprint e.g. for a FASTQ file containing millions of reads. |
|with.qualities
| TRUE
or FALSE
(the default). This argument is only supported when reading a FASTQ file. If TRUE
, then the quality strings are also read and returned in the qualities
metadata column of the returned DNAStringSet object. Note that by default the quality strings are ignored. This helps reduce memory footprint if the FASTQ file contains millions of reads. |
|seqtype
| A single string specifying the type of sequences contained in the FASTA file(s). Supported sequence types: |
"B"
for anything i.e. any letter is a valid one-letter sequence code."DNA"
for DNA sequences i.e. only letters inDNA_ALPHABET
(case ignored) are valid one-letter sequence codes."RNA"
for RNA sequences i.e. only letters inRNA_ALPHABET
(case ignored) are valid one-letter sequence codes."AA"
for Amino Acid sequences. Currently treated as"B"
but this will change in the near future i.e. only letters inAA_ALPHABET
(case ignored) will be valid one-letter sequence codes. Invalid one-letter sequence codes are ignored with a warning. |x
| ForwriteXStringSet
, the object to write tofile
. ForsaveXStringSet
, the object to serialize. | |append
|TRUE
orFALSE
. IfTRUE
output will be appended tofile
; otherwise, it will overwrite the contents offile
. See?
for the details. | |compress
| Like for thesave
function in base R, must beTRUE
orFALSE
(the default), or a single string specifying whether writing to the file is to use compression. The only type of compression supported at the moment is"gzip"
. PassingTRUE
is equivalent to passing"gzip"
. | |compression_level
| Not implemented yet. | |...
| Further format-specific arguments. Ifformat="fasta"
, thewidth
argument can be used to specify the maximum number of letters per line of sequence.width
must be a single integer. Ifformat="fastq"
, thequalities
argument can be used to specify the quality strings.qualities
must be a BStringSet object. If the argument is omitted, then the quality strings are taken from thequalities
metadata column ofx
(i.e. frommcols(x)$qualities
). Ifx
has noqualities
metadata column and thequalities
argument is omitted, then the fake quality ';' is assigned to each letter inx
and written to the FASTQ file. | |objname
| The name of the serialized object. | |dirpath
| The path to the directory where to save the serialized object. | |save.dups
|TRUE
orFALSE
. IfTRUE
then theDups
object describing how duplicated elements inx
are related to each other is saved too. For advanced users only. | |verbose
|TRUE
orFALSE
. |
Details
gzip compression is supported by reading and writing functions on all platforms.
readDNAStringSet
and family (i.e. readBStringSet
,
readDNAStringSet
, readRNAStringSet
and readAAStringSet
)
load sequences from an input file (or multiple input files) into an
XStringSet object. When multiple input files are specified,
all must have the same format (i.e. FASTA or FASTQ) and files with
different compression types can be mixed with non-compressed files.
The files are read in the order they were specified and the sequences
are stored in the returned object in the order they were read.
Only FASTA and FASTQ files are supported for now.
The fasta.seqlengths
utility returns an integer vector with one
element per FASTA record in the input files. Each element is the length
of the sequence found in the corresponding record, that is, the number of
valid one-letter sequence codes in the record. See description of the
seqtype
argument above for how to control the set of valid
one-letter sequence codes.
The fasta.index
utility returns a data frame with 1 row per
FASTA record in the input files and the following columns:
recno
: The rank of the record in the (virtually) concatenated input files.fileno
: The rank of the file where the record is located.offset
: The offset of the record relative to the start of the file where it's located. Measured in bytes.desc
: The description line (a.k.a. header) of the record.seqlength
: The length of the sequence in the record (not counting invalid letters).filepath
: The path to the file where the record is located. Always a local file, so if the user specified a remote file, this column will contain the path to the downloaded file.
A subset of this data frame can be passed toreadDNAStringSet
and family for direct access to an arbitrary subset of sequences. More precisely, iffai
is a FASTA index that was obtained withfasta.index(filepath, ..., seqtype="DNA")
, thenreadDNAStringSet(fai[i, ])
is equivalent toreadDNAStringSet(filepath, ...)[i]
for any valid subscripti
, except that the former only loads the requested sequences in memory and thus will be more memory efficient if only a small subset of sequences is requested.
The fastq.seqlengths
utility returns the read lengths in an integer
vector with one element per FASTQ record in the input files.
The fastq.geometry
utility is a convenience wrapper around
fastq.seqlengths
that returns an integer vector of length 2
describing the geometry of the FASTQ files. The first integer gives
the total number of FASTQ records in the files and the second element the
common length of the reads (this common length is set to NA
in case
of variable length reads or if no FASTQ record was found). This compact
representation of the geometry can be useful if the FASTQ files are known
to contain fixed length reads.
writeXStringSet
writes an XStringSet object to a file.
Like with readDNAStringSet
and family, only FASTA and FASTQ
files are supported for now.
WARNING: Please be aware that using writeXStringSet
on a
BStringSet object that contains the '
' (LF) or '
' (CR)
characters or the FASTA markup characters '>' or ';' is almost
guaranteed to produce a broken FASTA file!
Serializing an XStringSet object with saveXStringSet
is equivalent to using the standard save
mechanism. But it will
try to reduce the size of x
in memory first before calling
save
. Most of the times this leads to a much reduced size on disk.
Seealso
BStringSet , DNAStringSet , RNAStringSet , and AAStringSet objects.
readQualityScaledDNAStringSet
andwriteQualityScaledXStringSet
for reading/writing a QualityScaledDNAStringSet object (or other QualityScaledXStringSet derivative) from/to a FASTQ file.
References
http://en.wikipedia.org/wiki/FASTA_format
Examples
## ---------------------------------------------------------------------
## A. READ/WRITE FASTA FILES
## ---------------------------------------------------------------------
## Read a non-compressed FASTA files:
filepath1 <- system.file("extdata", "someORF.fa", package="Biostrings")
fasta.seqlengths(filepath1, seqtype="DNA")
x1 <- readDNAStringSet(filepath1)
x1
## Read a gzip-compressed FASTA file:
filepath2 <- system.file("extdata", "someORF.fa.gz", package="Biostrings")
fasta.seqlengths(filepath2, seqtype="DNA")
x2 <- readDNAStringSet(filepath2)
x2
## Sanity check:
stopifnot(identical(as.character(x1), as.character(x2)))
## Read 2 FASTA files at once:
filepath3 <- system.file("extdata", "fastaEx.fa", package="Biostrings")
fasta.seqlengths(c(filepath2, filepath3), seqtype="DNA")
x23 <- readDNAStringSet(c(filepath2, filepath3))
x23
## Sanity check:
x3 <- readDNAStringSet(filepath3)
stopifnot(identical(as.character(x23), as.character(c(x2, x3))))
## Use a FASTA index to load only an arbitrary subset of sequences:
filepath4 <- system.file("extdata", "dm3_upstream2000.fa.gz",
package="Biostrings")
fai <- fasta.index(filepath4, seqtype="DNA")
head(fai)
head(fai$desc)
i <- sample(nrow(fai), 10) # randomly pick up 10 sequences
x4 <- readDNAStringSet(fai[i, ])
## Sanity check:
stopifnot(identical(as.character(readDNAStringSet(filepath4)[i]),
as.character(x4)))
## Write FASTA files:
out23a <- tempfile()
writeXStringSet(x23, out23a)
out23b <- tempfile()
writeXStringSet(x23, out23b, compress=TRUE)
file.info(c(out23a, out23b))$size
## Sanity checks:
stopifnot(identical(as.character(readDNAStringSet(out23a)),
as.character(x23)))
stopifnot(identical(readLines(out23a), readLines(out23b)))
## ---------------------------------------------------------------------
## B. READ/WRITE FASTQ FILES
## ---------------------------------------------------------------------
filepath5 <- system.file("extdata", "s_1_sequence.txt",
package="Biostrings")
fastq.geometry(filepath5)
## The quality strings are ignored by default:
reads <- readDNAStringSet(filepath5, format="fastq")
reads
mcols(reads)
## Use 'with.qualities=TRUE' to load them:
reads <- readDNAStringSet(filepath5, format="fastq", with.qualities=TRUE)
reads
mcols(reads)
mcols(reads)$qualities
## Each quality string contains one letter per nucleotide in the
## corresponding read:
stopifnot(identical(width(mcols(reads)$qualities), width(reads)))
## Write the reads to a FASTQ file:
outfile <- tempfile()
writeXStringSet(reads, outfile, format="fastq")
outfile2 <- tempfile()
writeXStringSet(reads, outfile2, compress=TRUE, format="fastq")
## Sanity checks:
stopifnot(identical(readLines(outfile), readLines(filepath5)))
stopifnot(identical(readLines(outfile), readLines(outfile2)))
## ---------------------------------------------------------------------
## C. READ FILES BY CHUNK
## ---------------------------------------------------------------------
## readDNAStringSet() supports reading an arbitrary number of FASTA or
## FASTQ records at a time in a loop. This can be useful to process
## big FASTA or FASTQ files by chunk and thus avoids loading the entire
## file in memory. To achieve this the files to read from need to be
## opened with open_input_files() first. Note that open_input_files()
## accepts a vector of file paths and/or URLs.
## With FASTA files:
files <- open_input_files(filepath4)
i <- 0
while (TRUE) {
i <- i + 1
## Load 4000 records at a time. Each new call to readDNAStringSet()
## picks up where the previous call left.
dna <- readDNAStringSet(files, nrec=4000)
if (length(dna) == 0L)
break
cat("processing chunk", i, "...
")
## do something with 'dna' ...
}
## With FASTQ files:
files <- open_input_files(filepath5)
i <- 0
while (TRUE) {
i <- i + 1
## Load 75 records at a time.
reads <- readDNAStringSet(files, format="fastq", nrec=75)
if (length(reads) == 0L)
break
cat("processing chunk", i, "...
")
## do something with 'reads' ...
}
## IMPORTANT NOTE: Like connections, the object returned by
## open_input_files() can NOT be shared across workers in the
## context of parallelization!
## ---------------------------------------------------------------------
## D. READ A FASTQ FILE AS A QualityScaledDNAStringSet OBJECT
## ---------------------------------------------------------------------
## Use readQualityScaledDNAStringSet() if you want the object to be
## returned as a QualityScaledDNAStringSet instead of a DNAStringSet
## object. See ?readQualityScaledDNAStringSet for more information.
## Note that readQualityScaledDNAStringSet() is a simple wrapper to
## readDNAStringSet() that does the following if the file contains
## "Phred quality scores" (which is the standard Sanger variant to
## assess reliability of a base call):
reads <- readDNAStringSet(filepath5, format="fastq", with.qualities=TRUE)
quals <- PhredQuality(mcols(reads)$qualities)
QualityScaledDNAStringSet(reads, quals)
## The call to PhredQuality() is replaced with a call to SolexaQuality()
## or IlluminaQuality() if the quality scores are Solexa quality scores.
## ---------------------------------------------------------------------
## E. GENERATE FAKE READS AND WRITE THEM TO A FASTQ FILE
## ---------------------------------------------------------------------
library(BSgenome.Celegans.UCSC.ce2)
## Create a "sliding window" on chr I:
sw_start <- seq.int(1, length(Celegans$chrI)-50, by=50)
sw <- Views(Celegans$chrI, start=sw_start, width=10)
my_fake_reads <- as(sw, "XStringSet")
my_fake_ids <- sprintf("ID%06d", seq_len(length(my_fake_reads)))
names(my_fake_reads) <- my_fake_ids
my_fake_reads
## Fake quality ';' will be assigned to each base in 'my_fake_reads':
out2 <- tempfile()
writeXStringSet(my_fake_reads, out2, format="fastq")
## Passing qualities thru the 'qualities' argument:
my_fake_quals <- rep.int(BStringSet("DCBA@?>=<;"), length(my_fake_reads))
my_fake_quals
out3 <- tempfile()
writeXStringSet(my_fake_reads, out3, format="fastq",
qualities=my_fake_quals)
## ---------------------------------------------------------------------
## F. SERIALIZATION
## ---------------------------------------------------------------------
saveXStringSet(my_fake_reads, "my_fake_reads", dirpath=tempdir())
XStringViews_class()
The XStringViews class
Description
The XStringViews class is the basic container for storing a set of views (start/end locations) on the same sequence (an XString object).
Details
An XStringViews object contains a set of views (start/end locations) on the
same XString object called "the subject string"
or "the subject sequence" or simply "the subject".
Each view is defined by its start and end locations: both are
integers such that start <= end.
An XStringViews object is in fact a particular case of an
Views
object (the XStringViews class contains the
Views class) so it
can be manipulated in a similar manner: see
?
for
more information.
Note that two views can overlap and that a view can be "out of limits"
i.e. it can start before the first letter of the subject or/and end
after its last letter.
Seealso
Views-class ,
gaps
,
XString-class ,
XStringSet-class ,
letter
,
MIndex-class
Author
H. Pagès
Examples
## One standard way to create an XStringViews object is to use
## the Views() constructor.
## Views on a DNAString object:
s <- DNAString("-CTC-N")
v4 <- Views(s, start=3:0, end=5:8)
v4
subject(v4)
length(v4)
start(v4)
end(v4)
width(v4)
## Attach a comment to views #3 and #4:
names(v4)[3:4] <- "out of limits"
names(v4)
## A more programatical way to "tag" the "out of limits" views:
|names(v4)[start(v4) < 1 | nchar(subject(v4)) < end(v4)] <- "out of limits"|
## or just:
names(v4)[nchar(v4) < width(v4)] <- "out of limits"
## Two equivalent ways to extract a view as an XString object:
s2a <- v4[[2]]
s2b <- subseq(subject(v4), start=start(v4)[2], end=end(v4)[2])
identical(s2a, s2b) # TRUE
## It is an error to try to extract an "out of limits" view:
#v4[[3]] # Error!
v12 <- Views(DNAString("TAATAATG"), start=-2:9, end=0:11)
v12 == DNAString("TAA")
v12[v12 == v12[4]]
v12[v12 == v12[1]]
v12[3] == Views(RNAString("AU"), start=0, end=2)
## Here the first view doesn't even overlap with the subject:
Views(BString("aaa--b"), start=-3:4, end=-3:4 + c(3:6, 6:3))
## 'start' and 'end' are recycled:
subject <- "abcdefghij"
Views(subject, start=2:1, end=4)
Views(subject, start=5:7, end=nchar(subject))
Views(subject, start=1, end=5:7)
## Applying gaps() to an XStringViews object:
v2 <- Views("abCDefgHIJK", start=c(8, 3), end=c(14, 4))
gaps(v2)
## Coercion:
as(v12, "XStringSet") # same as 'as(v12, "DNAStringSet")'
rna <- as(v12, "RNAStringSet")
as(rna, "Views")
XString_class()
BString objects
Description
The BString class is a general container for storing a big string (a long sequence of characters) and for making its manipulation easy and efficient.
The DNAString , RNAString and AAString classes are similar containers but with the more biology-oriented purpose of storing a DNA sequence ( DNAString ), an RNA sequence ( RNAString ), or a sequence of amino acids ( AAString ).
All those containers derive directly (and with no additional slots) from the XString virtual class.
Details
The 2 main differences between an XString object and a standard character vector are: (1) the data stored in an XString object are not copied on object duplication and (2) an XString object can only store a single string (see the XStringSet container for an efficient way to store a big collection of strings in a single object).
Unlike the DNAString , RNAString and AAString containers that accept only a predefined set of letters (the alphabet), a BString object can be used for storing any single string based on a single-byte character set.
Seealso
subseq
,
letter
,
DNAString-class ,
RNAString-class ,
AAString-class ,
XStringSet-class ,
XStringViews-class ,
reverseComplement
,
compact
,
XVector-class
Author
H. Pagès
Examples
b <- BString("I am a BString object")
b
length(b)
## Extracting a linear subsequence:
subseq(b)
subseq(b, start=3)
subseq(b, start=-3)
subseq(b, end=-3)
subseq(b, end=-3, width=5)
## Subsetting:
b2 <- b[length(b):1] # better done with reverse(b)
as.character(b2)
b2 == b # FALSE
b2 == as.character(b2) # TRUE
## b[1:length(b)] is equal but not identical to b!
b == b[1:length(b)] # TRUE
identical(b, 1:length(b)) # FALSE
## This is because subsetting an XString object with [ makes a copy
## of part or all its sequence data. Hence, for the resulting object,
## the internal slot containing the memory address of the sequence
## data differs from the original. This is enough for identical() to
## see the 2 objects as different.
## Compacting. As a particular type of XVector objects, XString
## objects can optionally be compacted. Compacting is done typically
## before serialization. See ?compact for more information.
align_utils()
Utility functions related to sequence alignment
Description
A variety of different functions used to deal with sequence alignments.
Usage
nedit(x) # also nmatch and nmismatch
mismatchTable(x, shiftLeft=0L, shiftRight=0L, list())
mismatchSummary(x, list())
list(list("coverage"), list("AlignedXStringSet0"))(x, shift=0L, width=NULL, weight=1L)
list(list("coverage"), list("PairwiseAlignmentsSingleSubject"))(x, shift=0L, width=NULL, weight=1L)
compareStrings(pattern, subject)
list(list("consensusMatrix"), list("PairwiseAlignmentsSingleSubject"))(x,
as.prob=FALSE, shift=0L, width=NULL,
baseOnly=FALSE, gapCode="-", endgapCode="-")
Arguments
Argument | Description |
---|---|
x | A character vector or matrix, XStringSet , XStringViews , PairwiseAlignments , or list of FASTA records containing the equal-length strings. |
shiftLeft, shiftRight | Non-positive and non-negative integers respectively that specify how many preceding and succeeding characters to and from the mismatch position to include in the mismatch substrings. |
list() | Further arguments to be passed to or from other methods. |
shift, width | See ? . |
weight | An integer vector specifying how much each element in x counts. |
pattern, subject | The strings to compare. Can be of type character , XString , XStringSet , AlignedXStringSet , or, in the case of pattern , PairwiseAlignments . If pattern is a PairwiseAlignments object, then subject must be missing. |
as.prob | If TRUE then probabilities are reported, otherwise counts (the default). |
baseOnly | TRUE or FALSE . If TRUE , the returned vector only contains frequencies for the letters in the "base" alphabet i.e. "A", "C", "G", "T" if x is a "DNA input", and "A", "C", "G", "U" if x is "RNA input". When x is a BString object (or an XStringViews object with a BString subject, or a BStringSet object), then the baseOnly argument is ignored. |
gapCode, endgapCode | The codes in the appropriate alphabet to use for the internal and end gaps. |
Details
mismatchTable
: a data.frame containing the positions and substrings
of the mismatches for the AlignedXStringSet
or
PairwiseAlignments
object.
mismatchSummary
: a list of data.frame objects containing counts and
frequencies of the mismatches for the AlignedXStringSet
or
PairwiseAlignmentsSingleSubject
object.
compareStrings
combines two equal-length strings that are assumed to be
aligned into a single character string containing that replaces mismatches
with "?"
, insertions with "+"
, and deletions with "-"
.
Seealso
pairwiseAlignment
,
consensusMatrix
,
XString-class , XStringSet-class , XStringViews-class ,
AlignedXStringSet-class , PairwiseAlignments-class ,
match-utils
Examples
## Compare two globally aligned strings
string1 <- "ACTTCACCAGCTCCCTGGCGGTAAGTTGATC---AAAGG---AAACGCAAAGTTTTCAAG"
string2 <- "GTTTCACTACTTCCTTTCGGGTAAGTAAATATATAAATATATAAAAATATAATTTTCATC"
compareStrings(string1, string2)
## Create a consensus matrix
nw1 <-
pairwiseAlignment(AAStringSet(c("HLDNLKGTF", "HVDDMPNAL")), AAString("SMDDTEKMSMKL"),
substitutionMatrix = "BLOSUM50", gapOpening = 3, gapExtension = 1)
consensusMatrix(nw1)
## Examine the consensus between the bacteriophage phi X174 genomes
data(phiX174Phage)
phageConsmat <- consensusMatrix(phiX174Phage, baseOnly = TRUE)
phageDiffs <- which(apply(phageConsmat, 2, max) < length(phiX174Phage))
phageDiffs
phageConsmat[,phageDiffs]
chartr()
Replace letters in a sequence or set of sequences
Description
Replace letters in a sequence or set of sequences.
Usage
list(list("chartr"), list("ANY,ANY,XString"))(old, new, x)
replaceAmbiguities(x, new="N")
Arguments
Argument | Description |
---|---|
old | A character string specifying the characters to be replaced. |
new | A character string specifying the replacements. It must be a single letter for replaceAmbiguities . |
x | The sequence or set of sequences to translate. If x is an XString , XStringSet , XStringViews or MaskedXString object, then the appropriate chartr method is called, otherwise the standard chartr R function is called. |
Details
See ?
for the details.
Note that, unlike the standard chartr
R function,
the methods for XString , XStringSet , XStringViews
and MaskedXString objects do NOT support character ranges in the
specifications.
replaceAmbiguities()
is a simple wrapper around chartr()
that replaces all IUPAC ambiguities with N.
Value
An object of the same class and length as the original object.
Seealso
chartr
in the base package.The
replaceAt
function for extracting or replacing arbitrary subsequences from/in a sequence or set of sequences.The
replaceLetterAt
function for a DNA-specific single-letter replacement functions useful for SNP injections.IUPAC_CODE_MAP
for the mapping between IUPAC nucleotide ambiguity codes and their meaning.alphabetFrequency
(anduniqueLetters
) for tabulating letters in (and extracting the unique letters from) a sequence or set of sequences.The XString , XStringSet , XStringViews , and MaskedXString classes.
Examples
## ---------------------------------------------------------------------
## A BASIC chartr() EXAMPLE
## ---------------------------------------------------------------------
x <- BString("MiXeD cAsE 123")
chartr("iXs", "why", x)
## ---------------------------------------------------------------------
## TRANSFORMING DNA WITH BISULFITE (AND SEARCHING IT...)
## ---------------------------------------------------------------------
library(BSgenome.Celegans.UCSC.ce2)
chrII <- Celegans[["chrII"]]
alphabetFrequency(chrII)
pattern <- DNAString("TGGGTGTATTTA")
## Transforming and searching the + strand
plus_strand <- chartr("C", "T", chrII)
alphabetFrequency(plus_strand)
matchPattern(pattern, plus_strand)
matchPattern(pattern, chrII)
## Transforming and searching the - strand
minus_strand <- chartr("G", "A", chrII)
alphabetFrequency(minus_strand)
matchPattern(reverseComplement(pattern), minus_strand)
matchPattern(reverseComplement(pattern), chrII)
## ---------------------------------------------------------------------
## replaceAmbiguities()
## ---------------------------------------------------------------------
dna <- DNAStringSet(c("TTTKYTT-GR", "", "NAASACVT"))
dna
replaceAmbiguities(dna)
detail()
Show (display) detailed object content
Description
This is a variant of show
, offering a more detailed
display of object content.
Usage
detail(x, ...)
Arguments
Argument | Description |
---|---|
x | An object. The default simply invokes show . |
... | Additional arguments. The default definition makes no use of these arguments. |
Value
None; the function is invoked for its side effect (detailed display of object content).
Author
Martin Morgan
Examples
origMAlign <-
readDNAMultipleAlignment(filepath =
system.file("extdata",
"msx2_mRNA.aln",
package="Biostrings"),
format="clustal")
detail(origMAlign)
dinucleotideFrequencyTest()
Pearson's chi-squared Test and G-tests for String Position Dependence
Description
Performs Person's chi-squared test, G-test, or William's corrected G-test to determine dependence between two nucleotide positions.
Usage
dinucleotideFrequencyTest(x, i, j, test = c("chisq", "G", "adjG"),
simulate.p.value = FALSE, B = 2000)
Arguments
Argument | Description |
---|---|
x | A DNAStringSet or RNAStringSet object. |
i, j | Single integer values for positions to test for dependence. |
test | One of "chisq" (Person's chi-squared test), "G" (G-test), or "adjG" (William's corrected G-test). See Details section. |
simulate.p.value | a logical indicating whether to compute p-values by Monte Carlo simulation. |
B | an integer specifying the number of replicates used in the Monte Carlo test. |
Details
The null and alternative hypotheses for this function are: list(" ", " ", list(list("H0: "), list("positions ", list("i"), " and ", list("j"), " are independent")), " ", " ", list(list("H1: "), list("otherwise")), " ", " ")
Let O and E be the observed and expected probabilities for base pair
combinations at positions i
and j
respectively. Then the
test statistics are calculated as:
list("
", " ", list(list(list("test="chisq""), ": "), list("stat = sum(abs(O - E)^2/E)")), "
", " ", list(list(list("test="G""), ": "), list("stat = 2 sum(O log(O/E))")), "
", " ", list(list(list("test="adjG""), ": "), list("stat = 2 sum(O log(O/E))/q, where
", " q = 1 + ((df - 1)^2 - 1)/(6length(x)(df - 2))")), "
", " ")
Under the null hypothesis, these test statistics are approximately distributed
chi-squared(df = ((distinct bases at i) - 1) * ((distinct bases at j) - 1)).
Value
An htest object. See help(chisq.test) for more details.
Seealso
nucleotideFrequencyAt
,
XStringSet-class ,
chisq.test
Author
P. Aboyoun
References
Ellrott, K., Yang, C., Sladek, F.M., Jiang, T. (2002) "Identifying transcription factor binding sites through Markov chain optimations", Bioinformatics, 18 (Suppl. 2), S100-S109.
Sokal, R.R., Rohlf, F.J. (2003) "Biometry: The Principle and Practice of Statistics in Biological Research", W.H. Freeman and Company, New York.
Tomovic, A., Oakeley, E. (2007) "Position dependencies in transcription factor binding sites", Bioinformatics, 23, 933-941.
Williams, D.A. (1976) "Improved Likelihood ratio tests for complete contingency tables", Biometrika, 63, 33-37.
Examples
data(HNF4alpha)
dinucleotideFrequencyTest(HNF4alpha, 1, 2)
dinucleotideFrequencyTest(HNF4alpha, 1, 2, test = "G")
dinucleotideFrequencyTest(HNF4alpha, 1, 2, test = "adjG")
findPalindromes()
Searching a sequence for palindromes
Description
The findPalindromes
function can be used to find palindromic
regions in a sequence.
palindromeArmLength
, palindromeLeftArm
, and
palindromeRightArm
are utility functions for operating on
palindromic sequences.
Usage
findPalindromes(subject, min.armlength=4,
max.looplength=1, min.looplength=0, max.mismatch=0)
palindromeArmLength(x, max.mismatch=0, ...)
palindromeLeftArm(x, max.mismatch=0, ...)
palindromeRightArm(x, max.mismatch=0, ...)
Arguments
Argument | Description |
---|---|
subject | An XString object containing the subject string, or an XStringViews object. |
min.armlength | An integer giving the minimum length of the arms of the palindromes to search for. |
max.looplength | An integer giving the maximum length of "the loop" (i.e the sequence separating the 2 arms) of the palindromes to search for. Note that by default ( max.looplength=1 ), findPalindromes will search for strict palindromes only. |
min.looplength | An integer giving the minimum length of "the loop" of the palindromes to search for. |
max.mismatch | The maximum number of mismatching letters allowed between the 2 arms of the palindromes to search for. |
x | An XString object containing a 2-arm palindrome, or an XStringViews object containing a set of 2-arm palindromes. |
... | Additional arguments to be passed to or from methods. |
Details
The findPalindromes
function finds palindromic substrings in a subject
string. The palindromes that can be searched for are either strict
palindromes or 2-arm palindromes (the former being a particular case of
the latter) i.e. palindromes where the 2 arms are separated by an arbitrary
sequence called "the loop".
If the subject string is a nucleotide sequence (i.e. DNA or RNA), the 2 arms must contain sequences that are reverse complement from each other. Otherwise, they must contain sequences that are the same.
Value
findPalindromes
returns an XStringViews object containing all
palindromes found in subject
(one view per palindromic substring
found).
palindromeArmLength
returns the arm length (integer) of the 2-arm
palindrome x
. It will raise an error if x
has no arms. Note
that any sequence could be considered a 2-arm palindrome if we were OK with
arms of length 0 but we are not: x
must have arms of length greater
or equal to 1 in order to be considered a 2-arm palindrome.
When applied to an XStringViews object x
,
palindromeArmLength
behaves in a vectorized fashion by returning
an integer vector of the same length as x
.
palindromeLeftArm
returns an object of the same class as the original
object x
and containing the left arm of x
.
palindromeRightArm
does the same as palindromeLeftArm
but on
the right arm of x
.
Like palindromeArmLength
, both palindromeLeftArm
and
palindromeRightArm
will raise an error if x
has no arms.
Also, when applied to an XStringViews object x
, both behave
in a vectorized fashion by returning an XStringViews object of the
same length as x
.
Seealso
maskMotif
,
matchPattern
,
matchLRPatterns
,
matchProbePair
,
XStringViews-class ,
DNAString-class
Author
H. Pagès
Examples
x0 <- BString("abbbaabbcbbaccacabbbccbcaabbabacca")
pals0a <- findPalindromes(x0, min.armlength=3, max.looplength=5)
pals0a
palindromeArmLength(pals0a)
palindromeLeftArm(pals0a)
palindromeRightArm(pals0a)
pals0b <- findPalindromes(x0, min.armlength=9, max.looplength=5,
max.mismatch=3)
pals0b
palindromeArmLength(pals0b, max.mismatch=3)
palindromeLeftArm(pals0b, max.mismatch=3)
palindromeRightArm(pals0b, max.mismatch=3)
## Whitespaces matter:
x1 <- BString("Delia saw I was aileD")
palindromeArmLength(x1)
palindromeLeftArm(x1)
palindromeRightArm(x1)
x2 <- BString("was it a car or a cat I saw")
palindromeArmLength(x2)
palindromeLeftArm(x2)
palindromeRightArm(x2)
## On a DNA or RNA sequence:
x3 <- DNAString("CCGAAAACCATGATGGTTGCCAG")
findPalindromes(x3)
findPalindromes(RNAString(x3))
## Note that palindromes can be nested:
x4 <- DNAString("ACGTTNAACGTCCAAAATTTTCCACGTTNAACGT")
findPalindromes(x4, max.looplength=19)
## A real use case:
library(BSgenome.Dmelanogaster.UCSC.dm3)
chrX <- Dmelanogaster$chrX
chrX_pals0 <- findPalindromes(chrX, min.armlength=40, max.looplength=80)
chrX_pals0
palindromeArmLength(chrX_pals0) # 251 70 262
## Allowing up to 2 mismatches between the 2 arms:
chrX_pals2 <- findPalindromes(chrX, min.armlength=40, max.looplength=80,
max.mismatch=2)
chrX_pals2
palindromeArmLength(chrX_pals2, max.mismatch=2) # 254 77 44 48 40 264
getSeq()
getSeq
Description
A generic function for extracting a set of sequences (or subsequences) from a sequence container like a BSgenome object or other.
Usage
getSeq(x, ...)
Arguments
Argument | Description |
---|---|
x | A BSgenome object or any other supported object. Do showMethods("getSeq") to get the list of all supported types for x . |
... | Any additional arguments needed by the specialized methods. |
Value
An XString object or an XStringSet object or a character vector containing the extracted sequence(s).
See man pages of individual methods for the details e.g. with
`?`` to access the man page
of the method for BSgenome objects (make sure the
BSgenome package is loaded first).
## Seealso
getSeq,BSgenome-method ,
XString-class ,
XStringSet-class
## Examples
r ## Note that you need to load the package(s) defining the specialized ## methods to have showMethods() display them and to be able to access ## their man pages: library(BSgenome) showMethods("getSeq")
gregexpr2()
A replacement for R standard gregexpr function
Description
This is a replacement for the standard gregexpr function that does exact matching only. Standard gregexpr() misses matches when they are overlapping. The gregexpr2 function finds all matches but it only works in "fixed" mode i.e. for exact matching (regular expressions are not supported).
Usage
gregexpr2(pattern, text)
Arguments
Argument | Description |
---|---|
pattern | character string to be matched in the given character vector |
text | a character vector where matches are sought |
Value
A list of the same length as text
each element of
which is an integer vector as in gregexpr
,
except that the starting positions of all (even overlapping)
matches are given.
Note that, unlike gregexpr
, gregexpr2
doesn't attach a "match.length"
attribute to each element of the returned list because, since it only works
in "fixed" mode, then all the matches have the length of the pattern.
Another difference with gregexpr
is that with gregexpr2
,
the pattern
argument must be a single (non-NA, non-empty) string.
Seealso
Author
H. Pagès
Examples
gregexpr("aa", c("XaaaYaa", "a"), fixed=TRUE)
gregexpr2("aa", c("XaaaYaa", "a"))
injectHardMask()
Injecting a hard mask in a sequence
Description
injectHardMask
allows the user to "fill" the masked regions
of a sequence with an arbitrary letter (typically the "+"
letter).
Usage
injectHardMask(x, letter="+")
Arguments
Argument | Description |
---|---|
x | A MaskedXString or XStringViews object. |
letter | A single letter. |
Details
The name of the injectHardMask
function was chosen because of the
primary use that it is intended for: converting a pile of active "soft
masks" into a "hard mask".
Here the pile of active "soft masks" refers to the active masks that have
been put on top of a sequence. In Biostrings, the original sequence and the
masks defined on top of it are bundled together in one of the dedicated
containers for this: the MaskedBString , MaskedDNAString ,
MaskedRNAString and MaskedAAString containers (this is the
MaskedXString family of containers).
The original sequence is always stored unmodified in a MaskedXString
object so no information is lost. This allows the user to activate/deactivate
masks without having to worry about losing the letters that are in the
regions that are masked/unmasked. Also this allows better memory
management since the original sequence never needs to be copied, even when
the set of active/inactive masks changes.
However, there are situations where the user might want to list("really")
get rid of the letters that are in some particular regions by replacing
them with a junk letter (e.g. "+"
) that is guaranteed to not interfer
with the analysis that s/he is currently doing.
For example, it's very likely that a set of motifs or short reads will not
contain the "+"
letter (this could easily be checked) so they will
never hit the regions filled with "+"
.
In a way, it's like the regions filled with "+"
were masked but we
call this kind of masking "hard masking".
Some important differences between "soft" and "hard" masking: list(" ", " ", list(list(), list(" ", " ", list("injectHardMask"), " creates a (modified) copy of the original ", " sequence. Using "soft masking" does not. ", " ")), " ", " ", list(list(), list(" ", " A function that is "mask aware" like ", list("alphabetFrequency"), " or ", " ", list("matchPattern"), " will really skip the masked regions ", " when "soft masking" is used i.e. they will not walk thru the ", " regions that are under active masks. This might lead to some ",
" speed improvements when a high percentage of the original sequence
", " is masked. ", " With "hard masking", the entire sequence is walked thru. ", " ")), " ", " ", list(list(), list(" ", " Matches cannot span over masked regions with "soft masking". ", " With "hard masking" they can. ", " ")), " ", " ")
Value
An XString object of the same length as the orignal object x
if x
is a MaskedXString object, or of the same length
as subject(x)
if it's an XStringViews object.
Seealso
maskMotif
,
MaskedXString-class ,
replaceLetterAt
,
chartr
,
XString ,
XStringViews-class
Author
H. Pagès
Examples
## ---------------------------------------------------------------------
## A. WITH AN XStringViews OBJECT
## ---------------------------------------------------------------------
v2 <- Views("abCDefgHIJK", start=c(8, 3), end=c(14, 4))
injectHardMask(v2)
injectHardMask(v2, letter="=")
## ---------------------------------------------------------------------
## B. WITH A MaskedXString OBJECT
## ---------------------------------------------------------------------
mask0 <- Mask(mask.width=29, start=c(3, 10, 25), width=c(6, 8, 5))
x <- DNAString("ACACAACTAGATAGNACTNNGAGAGACGC")
masks(x) <- mask0
x
subject <- injectHardMask(x)
## Matches can span over masked regions with "hard masking":
matchPattern("ACggggggA", subject, max.mismatch=6)
## but not with "soft masking":
matchPattern("ACggggggA", x, max.mismatch=6)
letter()
Subsetting a string
Description
Extract a substring from a string by picking up individual letters by their position.
Usage
letter(x, i)
Arguments
Argument | Description |
---|---|
x | A character vector, or an XString , XStringViews or MaskedXString object. |
i | An integer vector with no NAs. |
Details
Unlike with the substr
or substring
functions,
i
must contain valid positions.
Value
A character vector of length 1 when x
is an XString
or MaskedXString object (the masks are ignored for the latter).
A character vector of the same length as x
when x
is a character vector or an XStringViews object.
Note that, because i
must contain valid positions,
all non-NA elements in the result are guaranteed to have exactly
length(i)
characters.
Seealso
subseq
,
XString-class ,
XStringViews-class ,
MaskedXString-class
Examples
x <- c("abcd", "ABC")
i <- c(3, 1, 1, 2, 1)
## With a character vector:
letter(x[1], 3:1)
letter(x, 3)
letter(x, i)
#letter(x, 4) # Error!
## With a BString object:
letter(BString(x[1]), i) # returns a character vector
BString(x[1])[i] # returns a BString object
## With an XStringViews object:
x2 <- as(BStringSet(x), "Views")
letter(x2, i)
letterFrequency()
Calculate the frequency of letters in a biological sequence, or the consensus matrix of a set of sequences
Description
Given a biological sequence (or a set of biological sequences),
the alphabetFrequency
function computes the frequency of
each letter of the relevant alphabet .
letterFrequency
is similar, but more compact if one is only
interested in certain letters.
It can also tabulate letters "in common".
letterFrequencyInSlidingView
is a more specialized version
of letterFrequency
for (non-masked) XString objects.
It tallys the requested letter frequencies for a fixed-width view,
or window, that is conceptually slid along the entire input sequence.
The consensusMatrix
function computes the consensus matrix
of a set of sequences, and the consensusString
function creates
the consensus sequence from the consensus matrix based upon specified
criteria.
In this man page we call "DNA input" (or "RNA input") an XString , XStringSet , XStringViews or MaskedXString object of base type DNA (or RNA).
Usage
alphabetFrequency(x, as.prob=FALSE, ...)
hasOnlyBaseLetters(x)
uniqueLetters(x)
|letterFrequency(x, letters, OR="|", as.prob=FALSE, ...)|
|letterFrequencyInSlidingView(x, view.width, letters, OR="|", as.prob=FALSE)|
consensusMatrix(x, as.prob=FALSE, shift=0L, width=NULL, ...)
list(list("consensusString"), list("matrix"))(x, ambiguityMap="?", threshold=0.5)
list(list("consensusString"), list("DNAStringSet"))(x, ambiguityMap=IUPAC_CODE_MAP,
threshold=0.25, shift=0L, width=NULL)
list(list("consensusString"), list("RNAStringSet"))(x,
ambiguityMap=
structure(as.character(RNAStringSet(DNAStringSet(IUPAC_CODE_MAP))),
names=
as.character(RNAStringSet(DNAStringSet(names(IUPAC_CODE_MAP))))),
threshold=0.25, shift=0L, width=NULL)
Arguments
Argument | Description |
---|---|
x | An XString , XStringSet , XStringViews or MaskedXString object for alphabetFrequency , letterFrequency , or uniqueLetters . DNA or RNA input for hasOnlyBaseLetters . An XString object for letterFrequencyInSlidingView . A character vector, or an XStringSet or XStringViews object for consensusMatrix . A consensus matrix (as returned by consensusMatrix ), or an XStringSet or XStringViews object for consensusString . |
as.prob | If TRUE then probabilities are reported, otherwise counts (the default). |
view.width | For letterFrequencyInSlidingView , the constant (e.g. 35, 48, 1000) size of the "window" to slide along x . The specified letters are tabulated in each window of length view.width . The rows of the result (see value) correspond to the various windows. |
letters | For letterFrequency or letterFrequencyInSlidingView , a character vector (e.g. "C", "CG", c ("C", "G")) giving the letters to tabulate. When x is DNA or RNA input, letters must come from alphabet . Except with OR=0 , multi-character elements of letters ('nchar' > 1) are taken as groupings of letters into subsets, to be tabulated in common ("or"'d), as if their alphabetFrequency's were added ( Arithmetic ). The columns of the result (see value) correspond to the individual and sets of letters which are counted separately. Unrelated (and, with some post-processing, related) counts may of course be obtained in separate calls. |
|OR
| For letterFrequency
or letterFrequencyInSlidingView
, the string (default |
) to use as a separator in forming names for the "grouped" columns, e.g. "C|G". The otherwise exceptional value 0
(zero) disables or'ing and is provided for convenience, allowing a single multi-character string (or several strings) of letters that should be counted separately. If some but not all letters are to be counted separately, they must reside in separate elements of letters (with 'nchar' 1 unless they are to be grouped with other letters), and OR
cannot be 0. |
|ambiguityMap
| Either a single character to use when agreement is not reached or a named character vector where the names are the ambiguity characters and the values are the combinations of letters that comprise the ambiguity (e.g. link{IUPAC_CODE_MAP}
). When ambiguityMap
is a named character vector, occurrences of ambiguous letters in x
are replaced with their base alphabet letters that have been equally weighted to sum to 1. (See Details for some examples.) |
|threshold
| The minimum probability threshold for an agreement to be declared. When ambiguityMap
is a single character, threshold
is a single number in (0, 1]. When ambiguityMap
is a named character vector (e.g. link{IUPAC_CODE_MAP}
), threshold
is a single number in (0, 1/sum(nchar(ambiguityMap) == 1)]. |
|...
| Further arguments to be passed to or from other methods. For the XStringViews and XStringSet methods, the collapse
argument is accepted. Except for letterFrequency
or letterFrequencyInSlidingView
, and with DNA or RNA input, the baseOnly
argument is accepted. If baseOnly
is TRUE
, the returned vector (or matrix) only contains the frequencies of the letters that belong to the "base" alphabet of x
i.e. to the alphabet returned by alphabet(x, baseOnly=TRUE)
. |
|shift
| An integer vector (recycled to the length of x
) specifying how each sequence in x
should be (horizontally) shifted with respect to the first column of the consensus matrix to be returned. By default ( shift=0
), each sequence in x
has its first letter aligned with the first column of the matrix. A positive shift
value means that the corresponding sequence must be shifted to the right, and a negative shift
value that it must be shifted to the left. For example, a shift of 5 means that it must be shifted 5 positions to the right (i.e. the first letter in the sequence must be aligned with the 6th column of the matrix), and a shift of -3 means that it must be shifted 3 positions to the left (i.e. the 4th letter in the sequence must be aligned with the first column of the matrix). |
|width
| The number of columns of the returned matrix for the consensusMatrix
method for XStringSet objects. When width=NULL
(the default), then this method returns a matrix that has just enough columns to have its last column aligned with the rightmost letter of all the sequences in x
after those sequences have been shifted (see the shift
argument above). This ensures that any wider consensus matrix would be a "padded with zeros" version of the matrix returned when width=NULL
. The length of the returned sequence for the consensusString
method for XStringSet objects. |
Details
alphabetFrequency
, letterFrequency
, and
letterFrequencyInSlidingView
are
generic functions defined in the Biostrings package.
letterFrequency
is similar to alphabetFrequency
but
specific to the letters of interest, hence more compact, especially
with OR
non-zero.
letterFrequencyInSlidingView
yields the same result, on the
sequence x
, that letterFrequency
would, if applied to the
hypothetical (and possibly huge) XStringViews
object
consisting of all the intervals of length view.width
on x
.
Taking advantage of the knowledge that successive "views" are nearly
identical, for letter counting purposes, it is both lighter and faster.
For letterFrequencyInSlidingView
, a masked ( MaskedXString )
object x
is only supported through a cast to an (ordinary)
XString such as unmasked
(which includes its masked
regions).
When consensusString
is executed with a named character
ambiguityMap
argument, it weights each input string equally and
assigns an equal probability to each of the base letters represented by
an ambiguity letter. So for DNA and a threshold
of 0.25,
a "G" and an "R" would result in an "R" since
1/2 "G" + 1/2 "R" = 3/4 "G" + 1/4 "A" => "R";
two "G"'s and one "R" would result in a "G" since
2/3 "G" + 1/3 "R" = 5/6 "G" + 1/6 "A" => "G"; and
one "A" and one "N" would result in an "N" since
1/2 "A" + 1/2 "N" = 5/8 "A" + 1/8 "C" + 1/8 "G" + 1/8 "T" => "N".
Value
alphabetFrequency
returns an integer vector when x
is an
XString or MaskedXString object. When x
is an
XStringSet or XStringViews object, then it returns
an integer matrix with length(x)
rows where the
i
-th row contains the frequencies for x[[i]]
.
If x
is a DNA or RNA input, then the returned vector is named
with the letters in the alphabet. If the baseOnly
argument is
TRUE
, then the returned vector has only 5 elements: 4 elements
corresponding to the 4 nucleotides + the 'other' element.
letterFrequency
returns, similarly, an integer vector or matrix,
but restricted and/or collated according to letters
and OR
.
letterFrequencyInSlidingView
returns, for an XString
object x
of length ( nchar
) L, an integer matrix
with L-view.width+1
rows, the i
-th of which holding the
letter frequencies of substring
.
hasOnlyBaseLetters
returns TRUE
or FALSE
indicating
whether or not x
contains only base letters (i.e. As, Cs, Gs and Ts
for DNA input and As, Cs, Gs and Us for RNA input).
uniqueLetters
returns a vector of 1-letter or empty strings. The empty
string is used to represent the nul character if x
happens to contain
any. Note that this can only happen if the base class of x
is BString .
An integer matrix with letters as row names for consensusMatrix
.
A standard character string for consensusString
.
Seealso
alphabet
,
coverage
,
oligonucleotideFrequency
,
countPDict
,
XString-class ,
XStringSet-class ,
XStringViews-class ,
MaskedXString-class ,
strsplit
Author
H. Pagès and P. Aboyoun; H. Jaffee for letterFrequency and letterFrequencyInSlidingView
Examples
## ---------------------------------------------------------------------
## alphabetFrequency()
## ---------------------------------------------------------------------
data(yeastSEQCHR1)
yeast1 <- DNAString(yeastSEQCHR1)
alphabetFrequency(yeast1)
alphabetFrequency(yeast1, baseOnly=TRUE)
hasOnlyBaseLetters(yeast1)
uniqueLetters(yeast1)
## With input made of multiple sequences:
library(drosophila2probe)
probes <- DNAStringSet(drosophila2probe)
alphabetFrequency(probes[1:50], baseOnly=TRUE)
alphabetFrequency(probes, baseOnly=TRUE, collapse=TRUE)
## ---------------------------------------------------------------------
## letterFrequency()
## ---------------------------------------------------------------------
letterFrequency(probes[[1]], letters="ACGT", OR=0)
base_letters <- alphabet(probes, baseOnly=TRUE)
base_letters
letterFrequency(probes[[1]], letters=base_letters, OR=0)
base_letter_freqs <- letterFrequency(probes, letters=base_letters, OR=0)
head(base_letter_freqs)
GC_content <- letterFrequency(probes, letters="CG")
head(GC_content)
letterFrequency(probes, letters="CG", collapse=TRUE)
## ---------------------------------------------------------------------
## letterFrequencyInSlidingView()
## ---------------------------------------------------------------------
data(yeastSEQCHR1)
x <- DNAString(yeastSEQCHR1)
view.width <- 48
letters <- c("A", "CG")
two_columns <- letterFrequencyInSlidingView(x, view.width, letters)
head(two_columns)
tail(two_columns)
three_columns <- letterFrequencyInSlidingView(x, view.width, letters, OR=0)
head(three_columns)
tail(three_columns)
|stopifnot(identical(two_columns[ , "C|G"],|
three_columns[ , "C"] + three_columns[ , "G"]))
## Note that, alternatively, 'three_columns' can also be obtained by
## creating the views on 'x' (as a Views object) and by calling
## alphabetFrequency() on it. But, of course, that is be *much* less
## efficient (both, in terms of memory and speed) than using
## letterFrequencyInSlidingView():
v <- Views(x, start=seq_len(length(x) - view.width + 1), width=view.width)
v
three_columns2 <- alphabetFrequency(v, baseOnly=TRUE)[ , c("A", "C", "G")]
stopifnot(identical(three_columns2, three_columns))
## Set the width of the view to length(x) to get the global frequencies:
letterFrequencyInSlidingView(x, letters="ACGTN", view.width=length(x), OR=0)
## ---------------------------------------------------------------------
## consensus*()
## ---------------------------------------------------------------------
## Read in ORF data:
file <- system.file("extdata", "someORF.fa", package="Biostrings")
orf <- readDNAStringSet(file)
## To illustrate, the following example assumes the ORF data
## to be aligned for the first 10 positions (patently false):
orf10 <- DNAStringSet(orf, end=10)
consensusMatrix(orf10, baseOnly=TRUE)
## The following example assumes the first 10 positions to be aligned
## after some incremental shifting to the right (patently false):
consensusMatrix(orf10, baseOnly=TRUE, shift=0:6)
consensusMatrix(orf10, baseOnly=TRUE, shift=0:6, width=10)
## For the character matrix containing the "exploded" representation
## of the strings, do:
as.matrix(orf10, use.names=FALSE)
## consensusMatrix() can be used to just compute the alphabet frequency
## for each position in the input sequences:
consensusMatrix(probes, baseOnly=TRUE)
## After sorting, the first 5 probes might look similar (at least on
## their first bases):
consensusString(sort(probes)[1:5])
consensusString(sort(probes)[1:5], ambiguityMap = "N", threshold = 0.5)
## Consensus involving ambiguity letters in the input strings
consensusString(DNAStringSet(c("NNNN","ACTG")))
consensusString(DNAStringSet(c("AANN","ACTG")))
consensusString(DNAStringSet(c("ACAG","ACAR")))
consensusString(DNAStringSet(c("ACAG","ACAR", "ACAG")))
## ---------------------------------------------------------------------
## C. RELATIONSHIP BETWEEN consensusMatrix() AND coverage()
## ---------------------------------------------------------------------
## Applying colSums() on a consensus matrix gives the coverage that
## would be obtained by piling up (after shifting) the input sequences
## on top of an (imaginary) reference sequence:
cm <- consensusMatrix(orf10, shift=0:6, width=10)
colSums(cm)
## Note that this coverage can also be obtained with:
as.integer(coverage(IRanges(rep(1, length(orf)), width(orf)), shift=0:6, width=10))
longestConsecutive()
Obtain the length of the longest substring containing only 'letter'
Description
This function accepts a character vector and computes the length of the
longest substring containing only letter
for each element of x
.
Usage
longestConsecutive(seq, letter)
Arguments
Argument | Description |
---|---|
seq | Character vector. |
letter | Character vector of length 1, containing one single character. |
Details
The elements of x
can be in upper case, lower case
or mixed. NAs are handled.
Value
An integer vector of the same length as x
.
Author
W. Huber
Examples
v = c("AAACTGTGFG", "GGGAATT", "CCAAAAAAAAAATT")
longestConsecutive(v, "A")
lowlevel_matching()
Low-level matching functions
Description
In this man page we define precisely and illustrate what a "match" of a pattern P in a subject S is in the context of the Biostrings package. This definition of a "match" is central to most pattern matching functions available in this package: unless specified otherwise, most of them will adhere to the definition provided here.
hasLetterAt
checks whether a sequence or set of sequences has the
specified letters at the specified positions.
neditAt
, isMatchingAt
and which.isMatchingAt
are
low-level matching functions that only look for matches at the specified
positions in the subject.
Usage
hasLetterAt(x, letter, at, fixed=TRUE)
## neditAt() and related utils:
neditAt(pattern, subject, at=1,
with.indels=FALSE, fixed=TRUE)
neditStartingAt(pattern, subject, starting.at=1,
with.indels=FALSE, fixed=TRUE)
neditEndingAt(pattern, subject, ending.at=1,
with.indels=FALSE, fixed=TRUE)
## isMatchingAt() and related utils:
isMatchingAt(pattern, subject, at=1,
max.mismatch=0, min.mismatch=0, with.indels=FALSE, fixed=TRUE)
isMatchingStartingAt(pattern, subject, starting.at=1,
max.mismatch=0, min.mismatch=0, with.indels=FALSE, fixed=TRUE)
isMatchingEndingAt(pattern, subject, ending.at=1,
max.mismatch=0, min.mismatch=0, with.indels=FALSE, fixed=TRUE)
## which.isMatchingAt() and related utils:
which.isMatchingAt(pattern, subject, at=1,
max.mismatch=0, min.mismatch=0, with.indels=FALSE, fixed=TRUE,
follow.index=FALSE, auto.reduce.pattern=FALSE)
which.isMatchingStartingAt(pattern, subject, starting.at=1,
max.mismatch=0, min.mismatch=0, with.indels=FALSE, fixed=TRUE,
follow.index=FALSE, auto.reduce.pattern=FALSE)
which.isMatchingEndingAt(pattern, subject, ending.at=1,
max.mismatch=0, min.mismatch=0, with.indels=FALSE, fixed=TRUE,
follow.index=FALSE, auto.reduce.pattern=FALSE)
Arguments
Argument | Description |
---|---|
x | A character vector, or an XString or XStringSet object. |
letter | A character string or an XString object containing the letters to check. |
at, starting.at, ending.at | An integer vector specifying the starting (for starting.at and at ) or ending (for ending.at ) positions of the pattern relatively to the subject. With auto.reduce.pattern (below), either a single integer or a constant vector of length nchar(pattern) (below), to which the former is immediately converted. For the hasLetterAt function, letter and at must have the same length. |
pattern | The pattern string (but see auto.reduce.pattern , below). |
subject | A character vector, or an XString or XStringSet object containing the subject sequence(s). |
max.mismatch, min.mismatch | Integer vectors of length >= 1 recycled to the length of the at (or starting.at , or ending.at ) argument. More details below. |
with.indels | See details below. |
fixed | Only with a DNAString or RNAString -based subject can a fixed value other than the default ( TRUE ) be used. If TRUE (the default), an IUPAC ambiguity code in the pattern can only match the same code in the subject, and vice versa. If FALSE , an IUPAC ambiguity code in the pattern can match any letter in the subject that is associated with the code, and vice versa. See IUPAC_CODE_MAP for more information about the IUPAC Extended Genetic Alphabet. fixed can also be a character vector, a subset of c("pattern", "subject") . fixed=c("pattern", "subject") is equivalent to fixed=TRUE (the default). An empty vector is equivalent to fixed=FALSE . With fixed="subject" , ambiguities in the pattern only are interpreted as wildcards. With fixed="pattern" , ambiguities in the subject only are interpreted as wildcards. |
follow.index | Whether the single integer returned by which.isMatchingAt (and related utils) should be the first value in at for which a match occurred, or its index in at (the default). |
auto.reduce.pattern | Whether pattern should be effectively shortened by 1 letter, from its beginning for which.isMatchingStartingAt and from its end for which.isMatchingEndingAt , for each successive (at, max.mismatch) "pair". |
Details
A "match" of pattern P in subject S is a substring S' of S that is considered similar enough to P according to some distance (or metric) specified by the user. 2 distances are supported by most pattern matching functions in the Biostrings package. The first (and simplest) one is the "number of mismatching letters". It is defined only when the 2 strings to compare have the same length, so when this distance is used, only matches that have the same number of letters as P are considered. The second one is the "edit distance" (aka Levenshtein distance): it's the minimum number of operations needed to transform P into S', where an operation is an insertion, deletion, or substitution of a single letter. When this metric is used, matches can have a different number of letters than P.
The neditAt
function implements these 2 distances.
If with.indels
is FALSE
(the default), then the first distance
is used i.e. neditAt
returns the "number of mismatching letters"
between the pattern P and the substring S' of S starting at the
positions specified in at
(note that neditAt
is vectorized
so a long vector of integers can be passed thru the at
argument).
If with.indels
is TRUE
, then the "edit distance" is
used: for each position specified in at
, P is compared to
all the substrings S' of S starting at this position and the smallest
distance is returned. Note that this distance is guaranteed to be reached
for a substring of length < 2*length(P) so, of course, in practice,
P only needs to be compared to a small number of substrings for every
starting position.
Value
hasLetterAt
: A logical matrix with one row per element in x
and one column per letter/position to check. When a specified position
is invalid with respect to an element in x
then the corresponding
matrix element is set to NA.
neditAt
: If subject
is an XString object, then
return an integer vector of the same length as at
.
If subject
is an XStringSet object, then return the
integer matrix with length(at)
rows and length(subject)
columns defined by:
list("
", " sapply(unname(subject),
", " function(x) neditAt(pattern, x, ...))
", " ")
neditStartingAt
is identical to neditAt
except
that the at
argument is now called starting.at
.
neditEndingAt
is similar to neditAt
except that
the at
argument is now called ending.at
and must contain
the ending positions of the pattern relatively to the subject.
isMatchingAt
: If subject
is an XString object,
then return the logical vector defined by:
list("
", " min.mismatch <= neditAt(...) <= max.mismatch
", " ")
If subject
is an XStringSet object, then return the
logical matrix with length(at)
rows and length(subject)
columns defined by:
list("
", " sapply(unname(subject),
", " function(x) isMatchingAt(pattern, x, ...))
", " ")
isMatchingStartingAt
is identical to isMatchingAt
except
that the at
argument is now called starting.at
.
isMatchingEndingAt
is similar to isMatchingAt
except that
the at
argument is now called ending.at
and must contain
the ending positions of the pattern relatively to the subject.
which.isMatchingAt
: The default behavior ( follow.index=FALSE
)
is as follow. If subject
is an XString object,
then return the single integer defined by:
list("
", " which(isMatchingAt(...))[1]
", " ")
If subject
is an XStringSet object, then return
the integer vector defined by:
list("
", " sapply(unname(subject),
", " function(x) which.isMatchingAt(pattern, x, ...))
", " ")
If follow.index=TRUE
, then the returned value is defined by:
list("
", " at[which.isMatchingAt(..., follow.index=FALSE)]
", " ")
which.isMatchingStartingAt
is identical to which.isMatchingAt
except that the at
argument is now called starting.at
.
which.isMatchingEndingAt
is similar to which.isMatchingAt
except that the at
argument is now called ending.at
and must
contain the ending positions of the pattern relatively to the subject.
Seealso
nucleotideFrequencyAt
,
matchPattern
,
matchPDict
,
matchLRPatterns
,
trimLRPatterns
,
IUPAC_CODE_MAP
,
XString-class ,
align-utils
Examples
## ---------------------------------------------------------------------
## hasLetterAt()
## ---------------------------------------------------------------------
x <- DNAStringSet(c("AAACGT", "AACGT", "ACGT", "TAGGA"))
hasLetterAt(x, "AAAAAA", 1:6)
## hasLetterAt() can be used to answer questions like: "which elements
## in 'x' have an A at position 2 and a G at position 4?"
q1 <- hasLetterAt(x, "AG", c(2, 4))
which(rowSums(q1) == 2)
## or "how many probes in the drosophila2 chip have T, G, T, A at
## position 2, 4, 13 and 20, respectively?"
library(drosophila2probe)
probes <- DNAStringSet(drosophila2probe)
q2 <- hasLetterAt(probes, "TGTA", c(2, 4, 13, 20))
sum(rowSums(q2) == 4)
## or "what's the probability to have an A at position 25 if there is
## one at position 13?"
q3 <- hasLetterAt(probes, "AACGT", c(13, 25, 25, 25, 25))
sum(q3[ , 1] & q3[ , 2]) / sum(q3[ , 1])
## Probabilities to have other bases at position 25 if there is an A
## at position 13:
sum(q3[ , 1] & q3[ , 3]) / sum(q3[ , 1]) # C
sum(q3[ , 1] & q3[ , 4]) / sum(q3[ , 1]) # G
sum(q3[ , 1] & q3[ , 5]) / sum(q3[ , 1]) # T
## See ?nucleotideFrequencyAt for another way to get those results.
## ---------------------------------------------------------------------
## neditAt() / isMatchingAt() / which.isMatchingAt()
## ---------------------------------------------------------------------
subject <- DNAString("GTATA")
## Pattern "AT" matches subject "GTATA" at position 3 (exact match)
neditAt("AT", subject, at=3)
isMatchingAt("AT", subject, at=3)
## ... but not at position 1
neditAt("AT", subject)
isMatchingAt("AT", subject)
## ... unless we allow 1 mismatching letter (inexact match)
isMatchingAt("AT", subject, max.mismatch=1)
## Here we look at 6 different starting positions and find 3 matches if
## we allow 1 mismatching letter
isMatchingAt("AT", subject, at=0:5, max.mismatch=1)
## No match
neditAt("NT", subject, at=1:4)
isMatchingAt("NT", subject, at=1:4)
## 2 matches if N is interpreted as an ambiguity (fixed=FALSE)
neditAt("NT", subject, at=1:4, fixed=FALSE)
isMatchingAt("NT", subject, at=1:4, fixed=FALSE)
## max.mismatch != 0 and fixed=FALSE can be used together
neditAt("NCA", subject, at=0:5, fixed=FALSE)
isMatchingAt("NCA", subject, at=0:5, max.mismatch=1, fixed=FALSE)
some_starts <- c(10:-10, NA, 6)
subject <- DNAString("ACGTGCA")
is_matching <- isMatchingAt("CAT", subject, at=some_starts, max.mismatch=1)
some_starts[is_matching]
which.isMatchingAt("CAT", subject, at=some_starts, max.mismatch=1)
which.isMatchingAt("CAT", subject, at=some_starts, max.mismatch=1,
follow.index=TRUE)
## ---------------------------------------------------------------------
## WITH INDELS
## ---------------------------------------------------------------------
subject <- BString("ABCDEFxxxCDEFxxxABBCDE")
neditAt("ABCDEF", subject, at=9)
neditAt("ABCDEF", subject, at=9, with.indels=TRUE)
isMatchingAt("ABCDEF", subject, at=9, max.mismatch=1, with.indels=TRUE)
isMatchingAt("ABCDEF", subject, at=9, max.mismatch=2, with.indels=TRUE)
neditAt("ABCDEF", subject, at=17)
neditAt("ABCDEF", subject, at=17, with.indels=TRUE)
neditEndingAt("ABCDEF", subject, ending.at=22)
neditEndingAt("ABCDEF", subject, ending.at=22, with.indels=TRUE)
maskMotif()
Masking by content (or by position)
Description
Functions for masking a sequence by content (or by position).
Usage
maskMotif(x, motif, min.block.width=1, ...)
mask(x, start=NA, end=NA, pattern)
Arguments
Argument | Description |
---|---|
x | The sequence to mask. |
motif | The motif to mask in the sequence. |
min.block.width | The minimum width of the blocks to mask. |
... | Additional arguments for matchPattern . |
start | An integer vector containing the starting positions of the regions to mask. |
end | An integer vector containing the ending positions of the regions to mask. |
pattern | The motif to mask in the sequence. |
Value
A MaskedXString object for maskMotif
and an XStringViews object for mask
.
Seealso
read.Mask
,
matchPattern
,
XString-class ,
MaskedXString-class ,
XStringViews-class ,
MaskCollection-class
Author
H. Pagès
Examples
## ---------------------------------------------------------------------
## EXAMPLE 1
## ---------------------------------------------------------------------
maskMotif(BString("AbcbbcbEEE"), "bcb")
maskMotif(BString("AbcbcbEEE"), "bcb")
## maskMotif() can be used in an incremental way to mask more than 1
## motif. Note that maskMotif() does not try to mask again what's
## already masked (i.e. the new mask will never overlaps with the
## previous masks) so the order in which the motifs are masked actually
## matters as it will affect the total set of masked positions.
x0 <- BString("AbcbEEEEEbcbbEEEcbbcbc")
x1 <- maskMotif(x0, "E")
x1
x2 <- maskMotif(x1, "bcb")
x2
x3 <- maskMotif(x2, "b")
x3
## Note that inverting the order in which "b" and "bcb" are masked would
## lead to a different final set of masked positions.
## Also note that the order doesn't matter if the motifs to mask don't
## overlap (we assume that the motifs are unique) i.e. if the prefix of
## each motif is not the suffix of any other motif. This is of course
## the case when all the motifs have only 1 letter.
## ---------------------------------------------------------------------
## EXAMPLE 2
## ---------------------------------------------------------------------
x <- DNAString("ACACAACTAGATAGNACTNNGAGAGACGC")
## Mask the N-blocks
x1 <- maskMotif(x, "N")
x1
as(x1, "Views")
gaps(x1)
as(gaps(x1), "Views")
## Mask the AC-blocks
x2 <- maskMotif(x1, "AC")
x2
gaps(x2)
## Mask the GA-blocks
x3 <- maskMotif(x2, "GA", min.block.width=5)
x3 # masks 2 and 3 overlap
gaps(x3)
## ---------------------------------------------------------------------
## EXAMPLE 3
## ---------------------------------------------------------------------
library(BSgenome.Dmelanogaster.UCSC.dm3)
chrU <- Dmelanogaster$chrU
chrU
alphabetFrequency(chrU)
chrU <- maskMotif(chrU, "N")
chrU
alphabetFrequency(chrU)
as(chrU, "Views")
as(gaps(chrU), "Views")
mask2 <- Mask(mask.width=length(chrU),
start=c(50000, 350000, 543900), width=25000)
names(mask2) <- "some ugly regions"
masks(chrU) <- append(masks(chrU), mask2)
chrU
as(chrU, "Views")
as(gaps(chrU), "Views")
## ---------------------------------------------------------------------
## EXAMPLE 4
## ---------------------------------------------------------------------
## Note that unlike maskMotif(), mask() returns an XStringViews object!
## masking "by position"
mask("AxyxyxBC", 2, 6)
## masking "by content"
mask("AxyxyxBC", "xyx")
noN_chrU <- mask(chrU, "N")
noN_chrU
alphabetFrequency(noN_chrU, collapse=TRUE)
matchLRPatterns()
Find paired matches in a sequence
Description
The matchLRPatterns
function finds paired matches in a sequence
i.e. matches specified by a left pattern, a right pattern and a maximum
distance between the left pattern and the right pattern.
Usage
matchLRPatterns(Lpattern, Rpattern, max.gaplength, subject,
max.Lmismatch=0, max.Rmismatch=0,
with.Lindels=FALSE, with.Rindels=FALSE,
Lfixed=TRUE, Rfixed=TRUE)
Arguments
Argument | Description |
---|---|
Lpattern | The left part of the pattern. |
Rpattern | The right part of the pattern. |
max.gaplength | The max length of the gap in the middle i.e the max distance between the left and right parts of the pattern. |
subject | An XString , XStringViews or MaskedXString object containing the target sequence. |
max.Lmismatch | The maximum number of mismatching letters allowed in the left part of the pattern. If non-zero, an inexact matching algorithm is used (see the matchPattern function for more information). |
max.Rmismatch | Same as max.Lmismatch but for the right part of the pattern. |
with.Lindels | If TRUE then indels are allowed in the left part of the pattern. In that case max.Lmismatch is interpreted as the maximum "edit distance" allowed in the left part of the pattern. See the with.indels argument of the matchPattern function for more information. |
with.Rindels | Same as with.Lindels but for the right part of the pattern. |
Lfixed | Only with a DNAString or RNAString subject can a Lfixed value other than the default ( TRUE ) be used. With Lfixed=FALSE , ambiguities (i.e. letters from the IUPAC Extended Genetic Alphabet (see IUPAC_CODE_MAP ) that are not from the base alphabet) in the left pattern and in the subject are interpreted as wildcards i.e. they match any letter that they stand for. Lfixed can also be a character vector, a subset of c("pattern", "subject") . Lfixed=c("pattern", "subject") is equivalent to Lfixed=TRUE (the default). An empty vector is equivalent to Lfixed=FALSE . With Lfixed="subject" , ambiguities in the pattern only are interpreted as wildcards. With Lfixed="pattern" , ambiguities in the subject only are interpreted as wildcards. |
Rfixed | Same as Lfixed but for the right part of the pattern. |
Value
An XStringViews object containing all the matches, even when they are overlapping (see the examples below), and where the matches are ordered from left to right (i.e. by ascending starting position).
Seealso
matchPattern
,
matchProbePair
,
trimLRPatterns
,
findPalindromes
,
reverseComplement
,
XString-class ,
XStringViews-class ,
MaskedXString-class
Author
H. Pagès
Examples
library(BSgenome.Dmelanogaster.UCSC.dm3)
subject <- Dmelanogaster$chr3R
Lpattern <- "AGCTCCGAG"
Rpattern <- "TTGTTCACA"
matchLRPatterns(Lpattern, Rpattern, 500, subject) # 1 match
## Note that matchLRPatterns() will return all matches, even when they are
## overlapping:
subject <- DNAString("AAATTAACCCTT")
matchLRPatterns("AA", "TT", 0, subject) # 1 match
matchLRPatterns("AA", "TT", 1, subject) # 2 matches
matchLRPatterns("AA", "TT", 3, subject) # 3 matches
matchLRPatterns("AA", "TT", 7, subject) # 4 matches
matchPDict_exact()
Matching a dictionary of patterns against a reference
Description
A set of functions for finding all the occurrences (aka "matches" or "hits") of a set of patterns (aka the dictionary) in a reference sequence or set of reference sequences (aka the subject)
The following functions differ in what they return: matchPDict
returns the "where" information i.e. the positions in the subject of all the
occurrences of every pattern; countPDict
returns the "how many
times" information i.e. the number of occurrences for each pattern;
and whichPDict
returns the "who" information i.e. which patterns
in the input dictionary have at least one match.
vcountPDict
and vwhichPDict
are vectorized versions
of countPDict
and whichPDict
, respectively, that is,
they work on a set of reference sequences in a vectorized fashion.
This man page shows how to use these functions (aka the *PDict
functions) for exact matching of a constant width dictionary i.e.
a dictionary where all the patterns have the same length (same number
of nucleotides).
See ?`` for how to use these functions for inexact matching or when the original dictionary has a variable width. ## Usage ```r matchPDict(pdict, subject, max.mismatch=0, min.mismatch=0, with.indels=FALSE, fixed=TRUE, algorithm="auto", verbose=FALSE) countPDict(pdict, subject, max.mismatch=0, min.mismatch=0, with.indels=FALSE, fixed=TRUE, algorithm="auto", verbose=FALSE) whichPDict(pdict, subject, max.mismatch=0, min.mismatch=0, with.indels=FALSE, fixed=TRUE, algorithm="auto", verbose=FALSE) vcountPDict(pdict, subject, max.mismatch=0, min.mismatch=0, with.indels=FALSE, fixed=TRUE, algorithm="auto", collapse=FALSE, weight=1L, verbose=FALSE, ...) vwhichPDict(pdict, subject, max.mismatch=0, min.mismatch=0, with.indels=FALSE, fixed=TRUE, algorithm="auto", verbose=FALSE) ``` ## Arguments |Argument |Description| |------------- |----------------| |
pdict| A [PDict](#pdict) object containing the preprocessed dictionary. All these functions also work with a dictionary that has not been preprocessed (in other words, the
pdictargument can receive an [XStringSet](#xstringset) object). Of course, it won't be as fast as with a preprocessed dictionary, but it will generally be slightly faster than using [
matchPattern](#matchpattern) / [
countPattern](#countpattern) or [
vmatchPattern](#vmatchpattern) / [
vcountPattern](#vcountpattern) in a "lapply/sapply loop", because, here, looping is done at the C-level. However, by using a non-preprocessed dictionary, many of the restrictions that apply to preprocessed dictionaries don't apply anymore. For example, the dictionary doesn't need to be rectangular or to be a [DNAStringSet](#dnastringset) object: it can be any type of [XStringSet](#xstringset) object and have a variable width. | |
subject| An [XString](#xstring) or [MaskedXString](#maskedxstring) object containing the subject sequence for
matchPDict,
countPDictand
whichPDict. An [XStringSet](#xstringset) object containing the subject sequences for
vcountPDictand
vwhichPDict. If
pdictis a [PDict](#pdict) object (i.e. a preprocessed dictionary), then
subjectmust be of base class [DNAString](#dnastring) . Otherwise,
subjectmust be of the same base class as
pdict. | |
max.mismatch, min.mismatch| The maximum and minimum number of mismatching letters allowed (see
?for the details). This man page focuses on exact matching of a constant width dictionary so
max.mismatch=0in the examples below. See
?for inexact matching. | |`with.indels` | Only supported by `countPDict` , `whichPDict` , `vcountPDict` and `vwhichPDict` at the moment, and only when the input dictionary is non-preprocessed (i.e. XStringSet). If `TRUE` then indels are allowed. In that case, `min.mismatch` must be `0` and `max.mismatch` is interpreted as the maximum "edit distance" allowed between any pattern and any of its matches. See `?
for more information. |
|fixed
| Whether IUPAC ambiguity codes should be interpreted literally or not (see ?
for more information). This man page focuses on exact matching of a constant width dictionary so fixed=TRUE
in the examples below. See ?`` for inexact matching. | |
algorithm| Ignored if
pdictis a preprocessed dictionary (i.e. a [PDict](#pdict) object). Otherwise, can be one of the following:
"auto",
"naive-exact",
"naive-inexact",
"boyer-moore"or
"shift-or". See
?for more information. Note that
"indels"is not supported for now. | |
verbose|
TRUEor
FALSE. | |
collapse, weight|
collapsemust be
FALSE,
1, or
2. If
collapse=FALSE(the default), then
weightis ignored and
vcountPDictreturns the full matrix of counts (
M0). If
collapse=1, then
M0is collapsed "horizontally" i.e. it is turned into a vector with
lengthequal to
length(pdict). If
weight=1L(the default), then this vector is defined by
rowSums(M0). If
collapse=2, then
M0is collapsed "vertically" i.e. it is turned into a vector with
lengthequal to
length(subject). If
weight=1L(the default), then this vector is defined by
colSums(M0). If
collapse=1or
collapse=2, then the elements in
subject(
collapse=1) or in
pdict(
collapse=2) can be weighted thru the
weightargument. In that case, the returned vector is defined by
M0 %% rep(weight, length.out=length(subject))and
rep(weight, length.out=length(pdict)) %% M0, respectively. | |
...| Additional arguments for methods. | ## Details In this man page, we assume that you know how to preprocess a dictionary of DNA patterns that can then be used with any of the
PDictfunctions described here. Please see
?if you don't. When using the
PDictfunctions for exact matching of a constant width dictionary, the standard way to preprocess the original dictionary is by calling the [
PDict](#pdict) constructor on it with no extra arguments. This returns the preprocessed dictionary in a [PDict](#pdict) object that can be used with any of the
PDictfunctions. ## Value If
Mdenotes the number of patterns in the
pdictargument (
M <- length(pdict)), then
matchPDictreturns an [MIndex](#mindex) object of length
M, and
countPDictan integer vector of length
M.
whichPDictreturns an integer vector made of the indices of the patterns in the
pdictargument that have at least one match. If
Ndenotes the number of sequences in the
subjectargument (
N <- length(subject)), then
vcountPDictreturns an integer matrix with
Mrows and
Ncolumns, unless the
collapseargument is used. In that case, depending on the type of
weight, an integer or numeric vector is returned (see above for the details).
vwhichPDictreturns a list of
Ninteger vectors. ## Seealso [PDict-class](#pdict-class) , [MIndex-class](#mindex-class) , [matchPDict-inexact](#matchpdict-inexact) , [
isMatchingAt](#ismatchingat) , [
coverage,MIndex-method](#coverage,mindex-method) , [
matchPattern](#matchpattern) , [
alphabetFrequency](#alphabetfrequency) , [DNAStringSet-class](#dnastringset-class) , [XStringViews-class](#xstringviews-class) , [MaskedDNAString-class](#maskeddnastring-class) ## Author H. Pagès ## References Aho, Alfred V.; Margaret J. Corasick (June 1975). "Efficient string matching: An aid to bibliographic search". Communications of the ACM 18 (6): 333-340. ## Examples ```r ## --------------------------------------------------------------------- ## A. A SIMPLE EXAMPLE OF EXACT MATCHING ## --------------------------------------------------------------------- ## Creating the pattern dictionary: library(drosophila2probe) dict0 <- DNAStringSet(drosophila2probe) dict0 # The original dictionary. length(dict0) # Hundreds of thousands of patterns. pdict0 <- PDict(dict0) # Store the original dictionary in # a PDict object (preprocessing). ## Using the pattern dictionary on chromosome 3R: library(BSgenome.Dmelanogaster.UCSC.dm3) chr3R <- Dmelanogaster$chr3R # Load chromosome 3R chr3R mi0 <- matchPDict(pdict0, chr3R) # Search... ## Looking at the matches: start_index <- startIndex(mi0) # Get the start index. length(start_index) # Same as the original dictionary. start_index[[8220]] # Starts of the 8220th pattern. end_index <- endIndex(mi0) # Get the end index. end_index[[8220]] # Ends of the 8220th pattern. nmatch_per_pat <- elementNROWS(mi0) # Get the number of matches per pattern. nmatch_per_pat[[8220]] mi0[[8220]] # Get the matches for the 8220th pattern. start(mi0[[8220]]) # Equivalent to startIndex(mi0)[[8220]]. sum(nmatch_per_pat) # Total number of matches. table(nmatch_per_pat) i0 <- which(nmatch_per_pat == max(nmatch_per_pat)) pdict0[[i0]] # The pattern with most occurrences. mi0[[i0]] # Its matches as an IRanges object. Views(chr3R, mi0[[i0]]) # And as an XStringViews object. ## Get the coverage of the original subject: cov3R <- as.integer(coverage(mi0, width=length(chr3R))) max(cov3R) mean(cov3R) sum(cov3R != 0) / length(cov3R) # Only 2.44% of chr3R is covered. if (interactive()) { plotCoverage <- function(cx, start, end) { plot.new() plot.window(c(start, end), c(0, 20)) axis(1) axis(2) axis(4) lines(start:end, cx[start:end], type="l") } plotCoverage(cov3R, 27600000, 27900000) } ## --------------------------------------------------------------------- ## B. NAMING THE PATTERNS ## --------------------------------------------------------------------- ## The names of the original patterns, if any, are propagated to the ## PDict and MIndex objects: names(dict0) <- mkAllStrings(letters, 4)[seq_len(length(dict0))] dict0 dict0[["abcd"]] pdict0n <- PDict(dict0) names(pdict0n)[1:30] pdict0n[["abcd"]] mi0n <- matchPDict(pdict0n, chr3R) names(mi0n)[1:30] mi0n[["abcd"]] ## This is particularly useful when unlisting an MIndex object: unlist(mi0)[1:10] unlist(mi0n)[1:10] # keep track of where the matches are coming from ## --------------------------------------------------------------------- ## C. PERFORMANCE ## --------------------------------------------------------------------- ## If getting the number of matches is what matters only (without ## regarding their positions), then countPDict() will be faster, ## especially when there is a high number of matches: nmatch_per_pat0 <- countPDict(pdict0, chr3R) stopifnot(identical(nmatch_per_pat0, nmatch_per_pat)) if (interactive()) { ## What's the impact of the dictionary width on performance? ## Below is some code that can be used to figure out (will take a long ## time to run). For different widths of the original dictionary, we ## look at: ## o pptime: preprocessing time (in sec.) i.e. time needed for ## building the PDict object from the truncated input ## sequences; ## o nnodes: nb of nodes in the resulting Aho-Corasick tree; ## o nupatt: nb of unique truncated input sequences; ## o matchtime: time (in sec.) needed to find all the matches; ## o totalcount: total number of matches. getPDictStats <- function(dict, subject) { ans_width <- width(dict[1]) ans_pptime <- system.time(pdict <- PDict(dict))[["elapsed"]] pptb <- pdict@threeparts@pptb ans_nnodes <- nnodes(pptb) ans_nupatt <- sum(!duplicated(pdict)) ans_matchtime <- system.time( mi0 <- matchPDict(pdict, subject) )[["elapsed"]] ans_totalcount <- sum(elementNROWS(mi0)) list( width=ans_width, pptime=ans_pptime, nnodes=ans_nnodes, nupatt=ans_nupatt, matchtime=ans_matchtime, totalcount=ans_totalcount ) } stats <- lapply(8:25, function(width) getPDictStats(DNAStringSet(dict0, end=width), chr3R)) stats <- data.frame(do.call(rbind, stats)) stats } ## --------------------------------------------------------------------- ## D. USING A NON-PREPROCESSED DICTIONARY ## --------------------------------------------------------------------- dict3 <- DNAStringSet(mkAllStrings(DNA_BASES, 3)) # all trinucleotides dict3 pdict3 <- PDict(dict3) ## The 3 following calls are equivalent (from faster to slower): res3a <- countPDict(pdict3, chr3R) res3b <- countPDict(dict3, chr3R) res3c <- sapply(dict3, function(pattern) countPattern(pattern, chr3R)) stopifnot(identical(res3a, res3b)) stopifnot(identical(res3a, res3c)) ## One reason for using a non-preprocessed dictionary is to get rid of ## all the constraints associated with preprocessing, e.g., when ## preprocessing with PDict(), the input dictionary must be DNA and a ## Trusted Band must be defined (explicitly or implicitly). ## See '?PDict' for more information about these constraints. ## In particular, using a non-preprocessed dictionary can be ## useful for the kind of inexact matching that can't be achieved ## with a PDict object (if performance is not an issue). ## See '?
matchPDict-inexact`' for more information about inexact
## matching.
dictD <- xscat(dict3, "N", reverseComplement(dict3))
## The 2 following calls are equivalent (from faster to slower):
resDa <- matchPDict(dictD, chr3R, fixed=FALSE)
resDb <- sapply(dictD,
function(pattern)
matchPattern(pattern, chr3R, fixed=FALSE))
stopifnot(all(sapply(seq_len(length(dictD)),
function(i)
identical(resDa[[i]], as(resDb[[i]], "IRanges")))))
## A non-preprocessed dictionary can be of any base class i.e. BString,
## RNAString, and AAString, in addition to DNAString:
matchPDict(AAStringSet(c("DARC", "EGH")), AAString("KMFPRNDEGHSTTWTEE"))
## ---------------------------------------------------------------------
## E. vcountPDict()
## ---------------------------------------------------------------------
## Load Fly upstream sequences (i.e. the sequences 2000 bases upstream of
## annotated transcription starts):
dm3_upstream_filepath <- system.file("extdata",
"dm3_upstream2000.fa.gz",
package="Biostrings")
dm3_upstream <- readDNAStringSet(dm3_upstream_filepath)
dm3_upstream
subject <- dm3_upstream[1:100]
mat1 <- vcountPDict(pdict0, subject)
dim(mat1) # length(pdict0) x length(subject)
nhit_per_probe <- rowSums(mat1)
table(nhit_per_probe)
## Without vcountPDict(), 'mat1' could have been computed with:
mat2 <- sapply(unname(subject), function(x) countPDict(pdict0, x))
stopifnot(identical(mat1, mat2))
## but using vcountPDict() is faster (10x or more, depending of the
## average length of the sequences in 'subject').
if (interactive()) {
## This will fail (with message "allocMatrix: too many elements
## specified") because, on most platforms, vectors and matrices in R
## are limited to 2^31 elements:
subject <- dm3_upstream
vcountPDict(pdict0, subject)
length(pdict0) length(dm3_upstream)
1 length(pdict0) length(dm3_upstream) # > 2^31
## But this will work:
nhit_per_seq <- vcountPDict(pdict0, subject, collapse=2)
sum(nhit_per_seq >= 1) # nb of subject sequences with at least 1 hit
table(nhit_per_seq) # max is 74
which.max(nhit_per_seq) # 1133
sum(countPDict(pdict0, subject[[1133]])) # 74
}
## ---------------------------------------------------------------------
## F. RELATIONSHIP BETWEEN vcountPDict(), countPDict() AND
## vcountPattern()
## ---------------------------------------------------------------------
subject <- dm3_upstream
## The 4 following calls are equivalent (from faster to slower):
mat3a <- vcountPDict(pdict3, subject)
mat3b <- vcountPDict(dict3, subject)
mat3c <- sapply(dict3,
function(pattern) vcountPattern(pattern, subject))
mat3d <- sapply(unname(subject),
function(x) countPDict(pdict3, x))
stopifnot(identical(mat3a, mat3b))
stopifnot(identical(mat3a, t(mat3c)))
stopifnot(identical(mat3a, mat3d))
## The 3 following calls are equivalent (from faster to slower):
nhitpp3a <- vcountPDict(pdict3, subject, collapse=1) # rowSums(mat3a)
nhitpp3b <- vcountPDict(dict3, subject, collapse=1)
nhitpp3c <- sapply(dict3,
function(pattern) sum(vcountPattern(pattern, subject)))
stopifnot(identical(nhitpp3a, nhitpp3b))
stopifnot(identical(nhitpp3a, nhitpp3c))
## The 3 following calls are equivalent (from faster to slower):
nhitps3a <- vcountPDict(pdict3, subject, collapse=2) # colSums(mat3a)
nhitps3b <- vcountPDict(dict3, subject, collapse=2)
nhitps3c <- sapply(unname(subject),
function(x) sum(countPDict(pdict3, x)))
stopifnot(identical(nhitps3a, nhitps3b))
stopifnot(identical(nhitps3a, nhitps3c))
## ---------------------------------------------------------------------
## G. vwhichPDict()
## ---------------------------------------------------------------------
subject <- dm3_upstream
## The 4 following calls are equivalent (from faster to slower):
vwp3a <- vwhichPDict(pdict3, subject)
vwp3b <- vwhichPDict(dict3, subject)
vwp3c <- lapply(seq_len(ncol(mat3a)), function(j) which(mat3a[ , j] != 0L))
vwp3d <- lapply(unname(subject), function(x) whichPDict(pdict3, x))
stopifnot(identical(vwp3a, vwp3b))
stopifnot(identical(vwp3a, vwp3c))
stopifnot(identical(vwp3a, vwp3d))
table(sapply(vwp3a, length))
which.min(sapply(vwp3a, length))
## Get the trinucleotides not represented in upstream sequence 21823:
dict3[-vwp3a[[21823]]] # 2 trinucleotides
## Sanity check:
tnf <- trinucleotideFrequency(subject[[21823]])
stopifnot(all(names(tnf)[tnf == 0] == dict3[-vwp3a[[21823]]]))
## ---------------------------------------------------------------------
## H. MAPPING PROBE SET IDS BETWEEN CHIPS WITH vwhichPDict()
## ---------------------------------------------------------------------
## Here we show a simple (and very naive) algorithm for mapping probe
## set IDs between the hgu95av2 and hgu133a chips (Affymetrix).
## 2 probe set IDs are considered mapped iff they share at least one
## probe.
## WARNING: This example takes about 10 minutes to run.
if (interactive()) {
library(hgu95av2probe)
library(hgu133aprobe)
probes1 <- DNAStringSet(hgu95av2probe)
probes2 <- DNAStringSet(hgu133aprobe)
pdict2 <- PDict(probes2)
## Get the mapping from probes1 to probes2 (based on exact matching):
map1to2 <- vwhichPDict(pdict2, probes1)
## The following helper function uses the probe level mapping to induce
## the mapping at the probe set IDs level (from hgu95av2 to hgu133a).
## To keep things simple, 2 probe set IDs are considered mapped iff
## each of them contains at least one probe mapped to one probe of
## the other:
mapProbeSetIDs1to2 <- function(psID)
unique(hgu133aprobe$Probe.Set.Name[unlist(
map1to2[hgu95av2probe$Probe.Set.Name == psID]
)])
## Use the helper function to build the complete mapping:
psIDs1 <- unique(hgu95av2probe$Probe.Set.Name)
mapPSIDs1to2 <- lapply(psIDs1, mapProbeSetIDs1to2) # about 3 min.
names(mapPSIDs1to2) <- psIDs1
## Do some basic stats:
table(sapply(mapPSIDs1to2, length))
## [ADVANCED USERS ONLY]
## An alternative that is slightly faster is to put all the probes
## (hgu95av2 + hgu133a) in a single PDict object and then query its
## 'dups0' slot directly. This slot is a Dups object containing the
## mapping between duplicated patterns.
## Note that we can do this only because all the probes have the
## same length (25) and because we are doing exact matching:
probes12 <- DNAStringSet(c(hgu95av2probe$sequence, hgu133aprobe$sequence))
pdict12 <- PDict(probes12)
dups0 <- pdict12@dups0
mapProbeSetIDs1to2alt <- function(psID)
{
ii1 <- unique(togroup(dups0, which(hgu95av2probe$Probe.Set.Name == psID)))
ii2 <- members(dups0, ii1) - length(probes1)
ii2 <- ii2[ii2 >= 1L]
unique(hgu133aprobe$Probe.Set.Name[ii2])
}
mapPSIDs1to2alt <- lapply(psIDs1, mapProbeSetIDs1to2alt) # about 5 min.
names(mapPSIDs1to2alt) <- psIDs1
## 'mapPSIDs1to2alt' and 'mapPSIDs1to2' contain the same mapping:
stopifnot(identical(lapply(mapPSIDs1to2alt, sort),
lapply(mapPSIDs1to2, sort)))
}
```
matchPDict_inexact()
Inexact matching with matchPDict()/countPDict()/whichPDict()
Description
The matchPDict
, countPDict
and whichPDict
functions
efficiently find the occurrences in a text (the subject) of all patterns
stored in a preprocessed dictionary.
This man page shows how to use these functions for inexact (or fuzzy) matching or when the original dictionary has a variable width.
See ?
for how to use these functions for exact
matching of a constant width dictionary i.e. a dictionary where all the
patterns have the same length (same number of nucleotides).
Details
In this man page, we assume that you know how to preprocess
a dictionary of DNA patterns that can then be used with
matchPDict
, countPDict
or whichPDict
.
Please see ?
if you don't.
matchPDict
and family support different kinds of inexact
matching but with some restrictions. Inexact matching is controlled
via the definition of a Trusted Band during the preprocessing step
and/or via the max.mismatch
, min.mismatch
and fixed
arguments.
Defining a Trusted Band is also required when the original dictionary
is not rectangular (variable width), even for exact matching.
See ?
for how to define a Trusted Band.
Here is how matchPDict
and family handle the Trusted Band
defined on pdict
:
(1) Find all the exact matches of all the elements in the Trusted Band.
(2) For each element in the Trusted Band that has at least one exact match, compare the head and the tail of this element with the flanking sequences of the matches found in (1).
Note that the number of exact matches found in (1) will decrease
exponentially with the width of the Trusted Band.
Here is a simple guideline in order to get reasonably good
performance: if TBW is the width of the Trusted Band
( TBW <- tb.width(pdict)
) and L the number of letters in the
subject ( L <- nchar(subject)
), then L / (4^TBW)
should
be kept as small as possible, typically < 10 or 20.
In addition, when a Trusted Band has been defined during preprocessing,
then matchPDict
and family can be called with fixed=FALSE
.
In this case, IUPAC ambiguity codes in the head or the tail of the
PDict object are treated as ambiguities.
Finally, fixed="pattern"
can be used to indicate that IUPAC
ambiguity codes in the subject should be treated as ambiguities.
It only works if the density of codes is not too high.
It works whether or not a Trusted Band has been defined on pdict
.
Seealso
PDict-class , MIndex-class , matchPDict
Author
H. Pagès
References
Aho, Alfred V.; Margaret J. Corasick (June 1975). "Efficient string matching: An aid to bibliographic search". Communications of the ACM 18 (6): 333-340.
Examples
## ---------------------------------------------------------------------
## A. USING AN EXPLICIT TRUSTED BAND
## ---------------------------------------------------------------------
library(drosophila2probe)
dict0 <- DNAStringSet(drosophila2probe)
dict0 # the original dictionary
## Preprocess the original dictionary by defining a Trusted Band that
## spans nucleotides 1 to 9 of each pattern.
pdict9 <- PDict(dict0, tb.end=9)
pdict9
tail(pdict9)
sum(duplicated(pdict9))
table(patternFrequency(pdict9))
library(BSgenome.Dmelanogaster.UCSC.dm3)
chr3R <- Dmelanogaster$chr3R
chr3R
table(countPDict(pdict9, chr3R, max.mismatch=1))
table(countPDict(pdict9, chr3R, max.mismatch=3))
table(countPDict(pdict9, chr3R, max.mismatch=5))
## ---------------------------------------------------------------------
## B. COMPARISON WITH EXACT MATCHING
## ---------------------------------------------------------------------
## When the original dictionary is of constant width, exact matching
## (i.e. 'max.mismatch=0' and 'fixed=TRUE) will be more efficient with
## a full-width Trusted Band (i.e. a Trusted Band that covers the entire
## dictionary) than with a Trusted Band of width < width(dict0).
pdict0 <- PDict(dict0)
count0 <- countPDict(pdict0, chr3R)
count0b <- countPDict(pdict9, chr3R, max.mismatch=0)
identical(count0b, count0) # TRUE
## ---------------------------------------------------------------------
## C. USING AN EXPLICIT TRUSTED BAND ON A VARIABLE WIDTH DICTIONARY
## ---------------------------------------------------------------------
## Here is a small variable width dictionary that contains IUPAC
## ambiguities (pattern 1 and 3 contain an N):
dict0 <- DNAStringSet(c("TACCNG", "TAGT", "CGGNT", "AGTAG", "TAGT"))
## (Note that pattern 2 and 5 are identical.)
## If we only want to do exact matching, then it is recommended to use
## the widest possible Trusted Band i.e. to set its width to
## 'min(width(dict0))' because this is what will give the best
## performance. However, when 'dict0' contains IUPAC ambiguities (like
## in our case), it could be that one of them is falling into the
## Trusted Band so we get an error (only base letters can go in the
## Trusted Band for now):
PDict(dict0, tb.end=min(width(dict0))) # Error!
## In our case, the Trusted Band cannot be wider than 3:
pdict <- PDict(dict0, tb.end=3)
tail(pdict)
subject <- DNAString("TAGTACCAGTTTCGGG")
m <- matchPDict(pdict, subject)
elementNROWS(m) # pattern 2 and 5 have 1 exact match
m[[2]]
## We can take advantage of the fact that our Trusted Band doesn't cover
## the entire dictionary to allow inexact matching on the uncovered parts
## (the tail in our case):
m <- matchPDict(pdict, subject, fixed=FALSE)
elementNROWS(m) # now pattern 1 has 1 match too
m[[1]]
m <- matchPDict(pdict, subject, max.mismatch=1)
elementNROWS(m) # now pattern 4 has 1 match too
m[[4]]
m <- matchPDict(pdict, subject, max.mismatch=1, fixed=FALSE)
elementNROWS(m) # now pattern 3 has 1 match too
m[[3]] # note that this match is "out of limit"
Views(subject, m[[3]])
m <- matchPDict(pdict, subject, max.mismatch=2)
elementNROWS(m) # pattern 4 gets 1 additional match
m[[4]]
## Unlist all matches:
unlist(m)
## ---------------------------------------------------------------------
## D. WITH IUPAC AMBIGUITY CODES IN THE PATTERNS
## ---------------------------------------------------------------------
## The Trusted Band cannot contain IUPAC ambiguity codes so patterns
## with ambiguity codes can only be preprocessed if we can define a
## Trusted Band with no ambiguity codes in it.
dict <- DNAStringSet(c("AAACAAKS", "GGGAAA", "TNCCGGG"))
pdict <- PDict(dict, tb.start=3, tb.width=4)
subject <- DNAString("AAACAATCCCGGGAAACAAGG")
matchPDict(pdict, subject)
matchPDict(pdict, subject, fixed="subject")
## Sanity checks:
res1 <- as.list(matchPDict(pdict, subject))
res2 <- as.list(matchPDict(dict, subject))
res3 <- lapply(dict,
function(pattern)
as(matchPattern(pattern, subject), "IRanges"))
stopifnot(identical(res1, res2))
stopifnot(identical(res1, res3))
res1 <- as.list(matchPDict(pdict, subject, fixed="subject"))
res2 <- as.list(matchPDict(dict, subject, fixed="subject"))
res3 <- lapply(dict,
function(pattern)
as(matchPattern(pattern, subject, fixed="subject"), "IRanges"))
stopifnot(identical(res1, res2))
stopifnot(identical(res1, res3))
## ---------------------------------------------------------------------
## E. WITH IUPAC AMBIGUITY CODES IN THE SUBJECT
## ---------------------------------------------------------------------
## 'fixed="pattern"' (or 'fixed=FALSE') can be used to indicate that
## IUPAC ambiguity codes in the subject should be treated as ambiguities.
pdict <- PDict(c("ACAC", "TCCG"))
matchPDict(pdict, DNAString("ACNCCGT"))
matchPDict(pdict, DNAString("ACNCCGT"), fixed="pattern")
matchPDict(pdict, DNAString("ACWCCGT"), fixed="pattern")
matchPDict(pdict, DNAString("ACRCCGT"), fixed="pattern")
matchPDict(pdict, DNAString("ACKCCGT"), fixed="pattern")
dict <- DNAStringSet(c("TTC", "CTT"))
pdict <- PDict(dict)
subject <- DNAString("CYTCACTTC")
mi1 <- matchPDict(pdict, subject, fixed="pattern")
mi2 <- matchPDict(dict, subject, fixed="pattern")
stopifnot(identical(as.list(mi1), as.list(mi2)))
matchPWM()
PWM creating, matching, and related utilities
Description
Position Weight Matrix (PWM) creating, matching, and related utilities for DNA data. (PWM for amino acid sequences are not supported.)
Usage
PWM(x, type = c("log2probratio", "prob"),
prior.params = c(A=0.25, C=0.25, G=0.25, T=0.25))
matchPWM(pwm, subject, min.score="80%", with.score=FALSE, ...)
countPWM(pwm, subject, min.score="80%", ...)
PWMscoreStartingAt(pwm, subject, starting.at=1)
## Utility functions for basic manipulation of the Position Weight Matrix
maxWeights(x)
minWeights(x)
maxScore(x)
minScore(x)
unitScale(x)
list(list("reverseComplement"), list("matrix"))(x, ...)
Arguments
Argument | Description |
---|---|
x | For PWM : a rectangular character vector or rectangular DNAStringSet object ("rectangular" means that all elements have the same number of characters) with no IUPAC ambiguity letters, or a Position Frequency Matrix represented as an integer matrix with row names containing at least A, C, G and T (typically the result of a call to consensusMatrix ). For maxWeights , minWeights , maxScore , minScore , unitScale and reverseComplement : a Position Weight Matrix represented as a numeric matrix with row names A, C, G and T. |
type | The type of Position Weight Matrix, either "log2probratio" or "prob". See Details section for more information. |
prior.params | A positive numeric vector, which represents the parameters of the Dirichlet conjugate prior, with names A, C, G, and T. See Details section for more information. |
pwm | A Position Weight Matrix represented as a numeric matrix with row names A, C, G and T. |
subject | Typically a DNAString object. A Views object on a DNAString subject, a MaskedDNAString object, or a single character string, are also supported. IUPAC ambiguity letters in subject are ignored (i.e. assigned weight 0) with a warning. |
min.score | The minimum score for counting a match. Can be given as a character string containing a percentage (e.g. "85%" ) of the highest possible score or as a single number. |
with.score | TRUE or FALSE . If TRUE , then the score of each hit is included in the returned object in a metadata column named score . Say the returned object is hits , this metadata column can then be accessed with mcols(hits)$score . |
starting.at | An integer vector specifying the starting positions of the Position Weight Matrix relatively to the subject. |
... | Additional arguments for methods. |
Details
The PWM
function uses a multinomial model with a Dirichlet conjugate
prior to calculate the estimated probability of base b at position i. As
mentioned in the Arguments section, prior.params
supplies the
parameters for the DNA bases A, C, G, and T in the Dirichlet prior. These
values result in a position independent initial estimate of the probabilities
for the bases to be
priorProbs = prior.params/sum(prior.params)
and the
posterior (data infused) estimate for the probabilities for the bases in each
of the positions to be
postProbs = (consensusMatrix(x) + prior.params)/(length(x) + sum(prior.params))
.
When type = "log2probratio"
, the PWM = unitScale(log2(postProbs/priorProbs))
.
When type = "prob"
, the PWM = unitScale(postProbs)
.
Value
A numeric matrix representing the Position Weight Matrix for PWM
.
A numeric vector containing the Position Weight Matrix-based scores
for PWMscoreStartingAt
.
An XStringViews object for matchPWM
.
A single integer for countPWM
.
A vector containing the max weight for each position in pwm
for maxWeights
.
A vector containing the min weight for each position in pwm
for minWeights
.
The highest possible score for a given Position Weight Matrix for
maxScore
.
The lowest possible score for a given Position Weight Matrix for
minScore
.
The modified numeric matrix given by
(x - minScore(x)/ncol(x))/(maxScore(x) - minScore(x))
for
unitScale
.
A PWM obtained by reverting the column order in PWM x
and by
reassigning each row to its complementary nucleotide
for reverseComplement
.
Seealso
consensusMatrix
,
matchPattern
,
reverseComplement
,
DNAString-class ,
XStringViews-class
Author
H. Pagès and P. Aboyoun
References
Wasserman, WW, Sandelin, A., (2004) Applied bioinformatics for the identification of regulatory elements, Nat Rev Genet., 5(4):276-87.
Examples
## Data setup:
data(HNF4alpha)
library(BSgenome.Dmelanogaster.UCSC.dm3)
chr3R <- Dmelanogaster$chr3R
chr3R
## Create a PWM from a PFM or directly from a rectangular
## DNAStringSet object:
pfm <- consensusMatrix(HNF4alpha)
pwm <- PWM(pfm) # same as 'PWM(HNF4alpha)'
## Perform some general routines on the PWM:
round(pwm, 2)
maxWeights(pwm)
maxScore(pwm)
reverseComplement(pwm)
## Score the first 5 positions:
PWMscoreStartingAt(pwm, chr3R, starting.at=1:5)
## Match the plus strand:
hits <- matchPWM(pwm, chr3R)
nhit <- countPWM(pwm, chr3R) # same as 'length(hits)'
## Use 'with.score=TRUE' to get the scores of the hits:
hits <- matchPWM(pwm, chr3R, with.score=TRUE)
head(mcols(hits)$score)
min(mcols(hits)$score / maxScore(pwm)) # should be >= 0.8
## The scores can also easily be post-calculated:
scores <- PWMscoreStartingAt(pwm, subject(hits), start(hits))
## Match the minus strand:
matchPWM(reverseComplement(pwm), chr3R)
matchPattern()
String searching functions
Description
A set of functions for finding all the occurrences (aka "matches" or "hits") of a given pattern (typically short) in a (typically long) reference sequence or set of reference sequences (aka the subject)
Usage
matchPattern(pattern, subject,
max.mismatch=0, min.mismatch=0,
with.indels=FALSE, fixed=TRUE,
algorithm="auto")
countPattern(pattern, subject,
max.mismatch=0, min.mismatch=0,
with.indels=FALSE, fixed=TRUE,
algorithm="auto")
vmatchPattern(pattern, subject,
max.mismatch=0, min.mismatch=0,
with.indels=FALSE, fixed=TRUE,
algorithm="auto", ...)
vcountPattern(pattern, subject,
max.mismatch=0, min.mismatch=0,
with.indels=FALSE, fixed=TRUE,
algorithm="auto", ...)
Arguments
Argument | Description |
---|---|
pattern | The pattern string. |
subject | An XString , XStringViews or MaskedXString object for matchPattern and countPattern . An XStringSet or XStringViews object for vmatchPattern and vcountPattern . |
max.mismatch, min.mismatch | The maximum and minimum number of mismatching letters allowed (see `?`` for the details). If non-zero, an algorithm that supports inexact matching is used. |
|with.indels
| If TRUE
then indels are allowed. In that case, min.mismatch
must be 0
and max.mismatch
is interpreted as the maximum "edit distance" allowed between the pattern and a match. Note that in order to avoid pollution by redundant matches, only the "best local matches" are returned. Roughly speaking, a "best local match" is a match that is locally both the closest (to the pattern P) and the shortest. More precisely, a substring S' of the subject S is a "best local match" iff: list("
", " (a) nedit(P, S') <= max.mismatch
", " (b) for every substring S1 of S':
", " nedit(P, S1) > nedit(P, S')
", " (c) for every substring S2 of S that contains S':
", " nedit(P, S2) >= nedit(P, S')
", " ") One nice property of "best local matches" is that their first and last letters are guaranteed to match the letters in P that they align with. |
|fixed
| If TRUE
(the default), an IUPAC ambiguity code in the pattern can only match the same code in the subject, and vice versa. If FALSE
, an IUPAC ambiguity code in the pattern can match any letter in the subject that is associated with the code, and vice versa. See ?`` for more information. | |
algorithm| One of the following:
"auto",
"naive-exact",
"naive-inexact",
"boyer-moore",
"shift-or"or
"indels". | |
...` | Additional arguments for methods. |
Details
Available algorithms are: naive exact'',
naive inexact'',
Boyer-Moore-like'',
shift-or'' and `indels''. Not all of them can be used in all situations: restrictions apply depending on the "search criteria" i.e. on the values of the
pattern,
subject,
max.mismatch,
min.mismatch,
with.indelsand
fixedarguments. It is important to note that the
algorithmargument is not part of the search criteria. This is because the supported algorithms are interchangeable, that is, if 2 different algorithms are compatible with a given search criteria, then choosing one or the other will not affect the result (but will most likely affect the performance). So there is no "wrong choice" of algorithm (strictly speaking). Using
algorithm="auto"(the default) is recommended because then the best suited algorithm will automatically be selected among the set of algorithms that are valid for the given search criteria. ## Value An [XStringViews](#xstringviews) object for
matchPattern. A single integer for
countPattern. An [MIndex](#mindex) object for
vmatchPattern. An integer vector for
vcountPattern, with each element in the vector corresponding to the number of matches in the corresponding element of
subject. ## Seealso [lowlevel-matching](#lowlevel-matching) , [
matchPDict](#matchpdict) , [
pairwiseAlignment](#pairwisealignment) , [
mismatch](#mismatch) , [
matchLRPatterns](#matchlrpatterns) , [
matchProbePair](#matchprobepair) , [
maskMotif](#maskmotif) , [
alphabetFrequency](#alphabetfrequency) , [XStringViews-class](#xstringviews-class) , [MIndex-class](#mindex-class) ## Note Use [
matchPDict](#matchpdict) if you need to match a (big) set of patterns against a reference sequence. Use [
pairwiseAlignment`](#pairwisealignment) if you need to solve a (Needleman-Wunsch)
global alignment, a (Smith-Waterman) local alignment, or an (ends-free)
overlap alignment problem.
## Examples
r ## --------------------------------------------------------------------- ## A. matchPattern()/countPattern() ## --------------------------------------------------------------------- ## A simple inexact matching example with a short subject: x <- DNAString("AAGCGCGATATG") m1 <- matchPattern("GCNNNAT", x) m1 m2 <- matchPattern("GCNNNAT", x, fixed=FALSE) m2 as.matrix(m2) ## With DNA sequence of yeast chromosome number 1: data(yeastSEQCHR1) yeast1 <- DNAString(yeastSEQCHR1) PpiI <- "GAACNNNNNCTC" # a restriction enzyme pattern match1.PpiI <- matchPattern(PpiI, yeast1, fixed=FALSE) match2.PpiI <- matchPattern(PpiI, yeast1, max.mismatch=1, fixed=FALSE) ## With a genome containing isolated Ns: library(BSgenome.Celegans.UCSC.ce2) chrII <- Celegans[["chrII"]] alphabetFrequency(chrII) matchPattern("N", chrII) matchPattern("TGGGTGTCTTT", chrII) # no match matchPattern("TGGGTGTCTTT", chrII, fixed=FALSE) # 1 match ## Using wildcards ("N") in the pattern on a genome containing N-blocks: library(BSgenome.Dmelanogaster.UCSC.dm3) chrX <- maskMotif(Dmelanogaster$chrX, "N") as(chrX, "Views") # 4 non masked regions matchPattern("TTTATGNTTGGTA", chrX, fixed=FALSE) ## Can also be achieved with no mask: masks(chrX) <- NULL matchPattern("TTTATGNTTGGTA", chrX, fixed="subject") ## --------------------------------------------------------------------- ## B. vmatchPattern()/vcountPattern() ## --------------------------------------------------------------------- ## Load Fly upstream sequences (i.e. the sequences 2000 bases upstream of ## annotated transcription starts): dm3_upstream_filepath <- system.file("extdata", "dm3_upstream2000.fa.gz", package="Biostrings") dm3_upstream <- readDNAStringSet(dm3_upstream_filepath) dm3_upstream Ebox <- DNAString("CANNTG") subject <- dm3_upstream mindex <- vmatchPattern(Ebox, subject, fixed="subject") nmatch_per_seq <- elementNROWS(mindex) # Get the number of matches per # subject element. sum(nmatch_per_seq) # Total number of matches. table(nmatch_per_seq) ## Let's have a closer look at one of the upstream sequences with most ## matches: i0 <- which.max(nmatch_per_seq) subject0 <- subject[[i0]] ir0 <- mindex[[i0]] # matches in 'subject0' as an IRanges object ir0 Views(subject0, ir0) # matches in 'subject0' as a Views object ## --------------------------------------------------------------------- ## C. WITH INDELS ## --------------------------------------------------------------------- library(BSgenome.Celegans.UCSC.ce2) subject <- Celegans$chrI pattern1 <- DNAString("ACGGACCTAATGTTATC") pattern2 <- DNAString("ACGGACCTVATGTTRTC") ## Allowing up to 2 mismatching letters doesn't give any match: m1a <- matchPattern(pattern1, subject, max.mismatch=2) ## But allowing up to 2 edit operations gives 3 matches: system.time(m1b <- matchPattern(pattern1, subject, max.mismatch=2, with.indels=TRUE)) m1b ## pairwiseAlignment() returns the (first) best match only: if (interactive()) { mat <- nucleotideSubstitutionMatrix(match=1, mismatch=0, baseOnly=TRUE) ## Note that this call to pairwiseAlignment() will need to ## allocate 733.5 Mb of memory (i.e. length(pattern) * length(subject) ## * 3 bytes). system.time(pwa <- pairwiseAlignment(pattern1, subject, type="local", substitutionMatrix=mat, gapOpening=0, gapExtension=1)) pwa } ## With IUPAC ambiguities in the pattern: m2a <- matchPattern(pattern2, subject, max.mismatch=2, fixed="subject") m2b <- matchPattern(pattern2, subject, max.mismatch=2, with.indels=TRUE, fixed="subject") ## All the matches in 'm1b' and 'm2a' should also appear in 'm2b': stopifnot(suppressWarnings(all(ranges(m1b) %in% ranges(m2b)))) stopifnot(suppressWarnings(all(ranges(m2a) %in% ranges(m2b)))) ## --------------------------------------------------------------------- ## D. WHEN 'with.indels=TRUE', ONLY "BEST LOCAL MATCHES" ARE REPORTED ## --------------------------------------------------------------------- ## With deletions in the subject: subject <- BString("ACDEFxxxCDEFxxxABCE") matchPattern("ABCDEF", subject, max.mismatch=2, with.indels=TRUE) matchPattern("ABCDEF", subject, max.mismatch=2) ## With insertions in the subject: subject <- BString("AiBCDiEFxxxABCDiiFxxxAiBCDEFxxxABCiDEF") matchPattern("ABCDEF", subject, max.mismatch=2, with.indels=TRUE) matchPattern("ABCDEF", subject, max.mismatch=2) ## With substitutions (note that the "best local matches" can introduce ## indels and therefore be shorter than 6): subject <- BString("AsCDEFxxxABDCEFxxxBACDEFxxxABCEDF") matchPattern("ABCDEF", subject, max.mismatch=2, with.indels=TRUE) matchPattern("ABCDEF", subject, max.mismatch=2)
matchProbePair()
Find "theoretical amplicons" mapped to a probe pair
Description
In the context of a computer-simulated PCR experiment, one wants to find
the amplicons mapped to a given primer pair.
The matchProbePair
function can be used for this: given a forward and a
reverse probe (i.e. the chromosome-specific sequences of the forward and
reverse primers used for the experiment) and a target sequence (generally a
chromosome sequence), the matchProbePair
function will return all
the "theoretical amplicons" mapped to this probe pair.
Usage
matchProbePair(Fprobe, Rprobe, subject, algorithm="auto", logfile=NULL, verbose=FALSE)
Arguments
Argument | Description |
---|---|
Fprobe | The forward probe. |
Rprobe | The reverse probe. |
subject | A DNAString object (or an XStringViews object with a DNAString subject) containing the target sequence. |
algorithm | One of the following: "auto" , "naive-exact" , "naive-inexact" , "boyer-moore" or "shift-or" . See matchPattern for more information. |
logfile | A file used for logging. |
verbose | TRUE or FALSE . |
Details
The matchProbePair
function does the following: (1) find all
the "plus hits" i.e. the Fprobe and Rprobe matches on the "plus" strand,
(2) find all the "minus hits" i.e. the Fprobe and Rprobe matches on the
"minus" strand and (3) from the set of all (plus_hit, minus_hit) pairs,
extract and return the subset of "reduced matches" i.e. the (plus_hit, minus_hit)
pairs such that (a) plus_hit <= minus_hit and (b) there are no hits (plus
or minus) between plus_hit and minus_hit.
This set of "reduced matches" is the set of "theoretical amplicons".
Value
An XStringViews object containing the set of "theoretical amplicons".
Seealso
matchPattern
,
matchLRPatterns
,
findPalindromes
,
reverseComplement
,
XStringViews-class
Author
H. Pagès
Examples
library(BSgenome.Dmelanogaster.UCSC.dm3)
subject <- Dmelanogaster$chr3R
## With 20-nucleotide forward and reverse probes:
Fprobe <- "AGCTCCGAGTTCCTGCAATA"
Rprobe <- "CGTTGTTCACAAATATGCGG"
matchProbePair(Fprobe, Rprobe, subject) # 1 "theoretical amplicon"
## With shorter forward and reverse probes, the risk of having multiple
## "theoretical amplicons" increases:
Fprobe <- "AGCTCCGAGTTCC"
Rprobe <- "CGTTGTTCACAA"
matchProbePair(Fprobe, Rprobe, subject) # 2 "theoretical amplicons"
Fprobe <- "AGCTCCGAGTT"
Rprobe <- "CGTTGTTCACA"
matchProbePair(Fprobe, Rprobe, subject) # 9 "theoretical amplicons"
match_utils()
Utility functions operating on the matches returned by a high-level matching function
Description
Miscellaneous utility functions operating on the matches returned by a
high-level matching function like matchPattern
,
matchPDict
, etc...
Usage
mismatch(pattern, x, fixed=TRUE)
nmatch(pattern, x, fixed=TRUE)
nmismatch(pattern, x, fixed=TRUE)
list(list("coverage"), list("MIndex"))(x, shift=0L, width=NULL, weight=1L)
list(list("coverage"), list("MaskedXString"))(x, shift=0L, width=NULL, weight=1L)
Arguments
Argument | Description |
---|---|
pattern | The pattern string. |
x | An XStringViews object for mismatch (typically, one returned by matchPattern(pattern, subject) ). An MIndex object for coverage , or any object for which a coverage method is defined. See ? . |
fixed | See `?`` . |
shift, width | See ? . |
weight | An integer vector specifying how much each element in x counts. |
Details
The mismatch
function gives the positions of the mismatching
letters of a given pattern relatively to its matches in a given subject.
The nmatch
and nmismatch
functions give the number of
matching and mismatching letters produced by the mismatch
function.
The coverage
function computes the "coverage" of a subject
by a given pattern or set of patterns.
Value
mismatch
: a list of integer vectors.
nmismatch
: an integer vector containing the length of the vectors
produced by mismatch
.
coverage
: an Rle object indicating
the coverage of x
.
See ?
for the details.
If x
is an MIndex object, the coverage of a given position
in the underlying sequence (typically the subject used during the search
that returned x
) is the number of matches (or hits) it belongs to.
Seealso
lowlevel-matching ,
matchPattern
,
matchPDict
,
XString-class ,
XStringViews-class ,
MIndex-class ,
coverage ,
align-utils
Examples
## ---------------------------------------------------------------------
## mismatch() / nmismatch()
## ---------------------------------------------------------------------
subject <- DNAString("ACGTGCA")
m <- matchPattern("NCA", subject, max.mismatch=1, fixed=FALSE)
mismatch("NCA", m)
nmismatch("NCA", m)
## ---------------------------------------------------------------------
## coverage()
## ---------------------------------------------------------------------
coverage(m)
## See ?matchPDict for examples of using coverage() on an MIndex object...
matchprobes()
A function to match a query sequence to the sequences of a set of probes.
Description
The query
sequence, a character string (probably representing
a transcript of interest), is scanned for the presence of exact
matches to the sequences in the character vector records
.
The indices of the set of matches are returned.
The function is inefficient: it works on R's character vectors, and
the actual matching algorithm is of time complexity length(query)
times length(records)
!
See matchPattern
, vmatchPattern
and
matchPDict
for more efficient sequence matching functions.
Usage
matchprobes(query, records, probepos=FALSE)
Arguments
Argument | Description |
---|---|
query | A character vector. For example, each element may represent a gene (transcript) of interest. See Details. |
records | A character vector. For example, each element may represent the probes on a DNA array. |
probepos | A logical value. If TRUE, return also the start positions of the matches in the query sequence. |
Details
toupper
is applied to the arguments query
and
records
before matching. The intention of this is to make
the matching case-insensitive.
The function is embarrassingly naive.
The matching is done using the C library function strstr
.
Value
A list. Its first element is a list of the same length as the input vector. Each element of the list is a numeric vector containing the indices of the probes that have a perfect match in the query sequence.
If probepos
is TRUE,
the returned list has a second element: it is of the same shape
as described above, and gives the respective positions of the
matches.
Seealso
matchPattern
, vmatchPattern
, matchPDict
Author
R. Gentleman, Laurent Gautier, Wolfgang Huber
Examples
if(require("hgu95av2probe")){
data("hgu95av2probe")
seq <- hgu95av2probe$sequence[1:20]
target <- paste(seq, collapse="")
matchprobes(target, seq, probepos=TRUE)
}
misc()
Some miscellaneous stuff
Description
Some miscellaneous stuff.
Usage
N50(csizes)
Arguments
Argument | Description |
---|---|
csizes | A vector containing the contig sizes. |
Value
N50
: The N50 value as an integer.
Seealso
Author
Nicolas Delhomme delhomme@embl.de
Examples
# Generate 10 random contigs of sizes comprised between 100 and 10000:
my.contig <- DNAStringSet(
sapply(
sample(c(100:10000), 10),
function(size)
paste(sample(DNA_BASES, size, replace=TRUE), collapse="")
)
)
# Get their sizes:
my.size <- width(my.contig)
# Calculate the N50 value of this set of contigs:
my.contig.N50 <- N50(my.size)
needwunsQS()
(Deprecated) Needleman-Wunsch Global Alignment
Description
Simple gap implementation of Needleman-Wunsch global alignment algorithm.
Usage
needwunsQS(s1, s2, substmat, gappen = 8)
Arguments
Argument | Description |
---|---|
s1, s2 | an R character vector of length 1 or an XString object. |
substmat | matrix of alignment score values. |
gappen | penalty for introducing a gap in the alignment. |
Details
Follows specification of Durbin, Eddy, Krogh, Mitchison (1998).
This function has been deprecated and is being replaced by
pairwiseAlignment
.
Value
An instance of class "PairwiseAlignments"
.
Seealso
pairwiseAlignment , PairwiseAlignments-class , substitution.matrices
Author
Vince Carey ( stvjc@channing.harvard.edu ) (original author) and H. Pagès (current maintainer).
References
R. Durbin, S. Eddy, A. Krogh, G. Mitchison, Biological Sequence Analysis, Cambridge UP 1998, sec 2.3.
Examples
## This function has been deprecated
## Use 'pairwiseAlignment' instead.
## nucleotide alignment
mat <- matrix(-5L, nrow = 4, ncol = 4)
for (i in seq_len(4)) mat[i, i] <- 0L
rownames(mat) <- colnames(mat) <- DNA_ALPHABET[1:4]
s1 <- DNAString(paste(sample(DNA_ALPHABET[1:4], 1000, replace=TRUE), collapse=""))
s2 <- DNAString(paste(sample(DNA_ALPHABET[1:4], 1000, replace=TRUE), collapse=""))
nw0 <- needwunsQS(s1, s2, mat, gappen = 0)
nw1 <- needwunsQS(s1, s2, mat, gappen = 1)
nw5 <- needwunsQS(s1, s2, mat, gappen = 5)
## amino acid alignment
needwunsQS("PAWHEAE", "HEAGAWGHEE", substmat = "BLOSUM50")
nucleotideFrequency()
Calculate the frequency of oligonucleotides in a DNA or RNA sequence (and other related functions)
Description
Given a DNA or RNA sequence (or a set of DNA or RNA sequences),
the oligonucleotideFrequency
function computes the frequency
of all possible oligonucleotides of a given length (called the "width"
in this particular context) in a sliding window that is shifted
step
nucleotides at a time.
The dinucleotideFrequency
and trinucleotideFrequency
functions are convenient wrappers for calling oligonucleotideFrequency
with width=2
and width=3
, respectively.
The nucleotideFrequencyAt
function computes the frequency
of the short sequences formed by extracting the nucleotides found
at some fixed positions from each sequence of a set of DNA or RNA
sequences.
In this man page we call "DNA input" (or "RNA input") an XString , XStringSet , XStringViews or MaskedXString object of base type DNA (or RNA).
Usage
oligonucleotideFrequency(x, width, step=1,
as.prob=FALSE, as.array=FALSE,
fast.moving.side="right", with.labels=TRUE, ...)
list(list("oligonucleotideFrequency"), list("XStringSet"))(x, width, step=1,
as.prob=FALSE, as.array=FALSE,
fast.moving.side="right", with.labels=TRUE,
simplify.as="matrix")
dinucleotideFrequency(x, step=1,
as.prob=FALSE, as.matrix=FALSE,
fast.moving.side="right", with.labels=TRUE, ...)
trinucleotideFrequency(x, step=1,
as.prob=FALSE, as.array=FALSE,
fast.moving.side="right", with.labels=TRUE, ...)
nucleotideFrequencyAt(x, at,
as.prob=FALSE, as.array=TRUE,
fast.moving.side="right", with.labels=TRUE, ...)
## Some related functions:
oligonucleotideTransitions(x, left=1, right=1, as.prob=FALSE)
mkAllStrings(alphabet, width, fast.moving.side="right")
Arguments
Argument | Description |
---|---|
x | Any DNA or RNA input for the *Frequency and oligonucleotideTransitions functions. An XStringSet or XStringViews object of base type DNA or RNA for nucleotideFrequencyAt . |
width | The number of nucleotides per oligonucleotide for oligonucleotideFrequency . The number of letters per string for mkAllStrings . |
step | How many nucleotides should the window be shifted before counting the next oligonucleotide (i.e. the sliding window step; default 1). If step is smaller than width , oligonucleotides will overlap; if the two arguments are equal, adjacent oligonucleotides will be counted (an efficient way to count codons in an ORF); and if step is larger than width , nucleotides will be sampled step nucleotides apart. |
at | An integer vector containing the positions to look at in each element of x . |
as.prob | If TRUE then probabilities are reported, otherwise counts (the default). |
as.array,as.matrix | Controls the "shape" of the returned object. If TRUE (the default for nucleotideFrequencyAt ) then it's a numeric matrix (or array), otherwise it's just a "flat" numeric vector i.e. a vector with no dim attribute (the default for the *Frequency functions). |
fast.moving.side | Which side of the strings should move fastest? Note that, when as.array is TRUE, then the supplied value is ignored and the effective value is "left" . |
with.labels | If TRUE then the returned object is named. |
... | Further arguments to be passed to or from other methods. |
simplify.as | Together with the as.array and as.matrix arguments, controls the "shape" of the returned object when the input x is an XStringSet or XStringViews object. Supported simplify.as values are "matrix" (the default), "list" and "collapsed" . If simplify.as is "matrix" , the returned object is a matrix with length(x) rows where the i -th row contains the frequencies for x[[i]] . If simplify.as is "list" , the returned object is a list of the same length as length(x) where the i -th element contains the frequencies for x[[i]] . If simplify.as is "collapsed" , then the the frequencies are computed for the entire object x as a whole (i.e. frequencies cumulated across all sequences in x ). |
left, right | The number of nucleotides per oligonucleotide for the rows and columns respectively in the transition matrix created by oligonucleotideTransitions . |
alphabet | The alphabet to use to make the strings. |
Value
If x
is an XString or MaskedXString object,
the *Frequency
functions return a numeric vector of length
4^width
. If as.array
(or as.matrix
) is TRUE
,
then this vector is formatted as an array (or matrix).
If x
is an XStringSet or XStringViews object,
the returned object has the shape specified by the simplify.as
argument.
Seealso
alphabetFrequency
,
alphabet
,
hasLetterAt
,
XString-class ,
XStringSet-class ,
XStringViews-class ,
MaskedXString-class ,
GENETIC_CODE
,
AMINO_ACID_CODE
,
reverseComplement
,
rev
Author
H. Pagès and P. Aboyoun; K. Vlahovicek for the step
argument
Examples
## ---------------------------------------------------------------------
## A. BASIC *Frequency() EXAMPLES
## ---------------------------------------------------------------------
data(yeastSEQCHR1)
yeast1 <- DNAString(yeastSEQCHR1)
dinucleotideFrequency(yeast1)
trinucleotideFrequency(yeast1)
oligonucleotideFrequency(yeast1, 4)
## Get the counts of tetranucleotides overlapping by one nucleotide:
oligonucleotideFrequency(yeast1, 4, step=3)
## Get the counts of adjacent tetranucleotides, starting from the first
## nucleotide:
oligonucleotideFrequency(yeast1, 4, step=4)
## Subset the sequence to change the starting nucleotide (here we start
## counting from third nucleotide):
yeast2 <- subseq(yeast1, start=3)
oligonucleotideFrequency(yeast2, 4, step=4)
## Get the less and most represented 6-mers:
f6 <- oligonucleotideFrequency(yeast1, 6)
f6[f6 == min(f6)]
f6[f6 == max(f6)]
## Get the result as an array:
tri <- trinucleotideFrequency(yeast1, as.array=TRUE)
tri["A", "A", "C"] # == trinucleotideFrequency(yeast1)["AAC"]
tri["T", , ] # frequencies of trinucleotides starting with a "T"
## With input made of multiple sequences:
library(drosophila2probe)
probes <- DNAStringSet(drosophila2probe)
dfmat <- dinucleotideFrequency(probes) # a big matrix
dinucleotideFrequency(probes, simplify.as="collapsed")
dinucleotideFrequency(probes, simplify.as="collapsed", as.matrix=TRUE)
## ---------------------------------------------------------------------
## B. OBSERVED DINUCLEOTIDE FREQUENCY VERSUS EXPECTED DINUCLEOTIDE
## FREQUENCY
## ---------------------------------------------------------------------
## The expected frequency of dinucleotide "ab" based on the frequencies
## of its individual letters "a" and "b" is:
## exp_Fab = Fa * Fb / N if the 2 letters are different (e.g. CG)
## exp_Faa = Fa * (Fa-1) / N if the 2 letters are the same (e.g. TT)
## where Fa and Fb are the frequencies of "a" and "b" (respectively) and
## N the length of the sequence.
## Here is a simple function that implements the above formula for a
## DNAString object 'x'. The expected frequencies are returned in a 4x4
## matrix where the rownames and colnames correspond to the 1st and 2nd
## base in the dinucleotide:
expectedDinucleotideFrequency <- function(x)
{
# Individual base frequencies.
bf <- alphabetFrequency(x, baseOnly=TRUE)[DNA_BASES]
(as.matrix(bf) %*% t(bf) - diag(bf)) / length(x)
}
## On Celegans chrI:
library(BSgenome.Celegans.UCSC.ce2)
chrI <- Celegans$chrI
obs_df <- dinucleotideFrequency(chrI, as.matrix=TRUE)
obs_df # CG has the lowest frequency
exp_df <- expectedDinucleotideFrequency(chrI)
## A sanity check:
stopifnot(as.integer(sum(exp_df)) == sum(obs_df))
## Ratio of observed frequency to expected frequency:
obs_df / exp_df # TA has the lowest ratio, not CG!
## ---------------------------------------------------------------------
## C. nucleotideFrequencyAt()
## ---------------------------------------------------------------------
nucleotideFrequencyAt(probes, 13)
nucleotideFrequencyAt(probes, c(13, 20))
nucleotideFrequencyAt(probes, c(13, 20), as.array=FALSE)
## nucleotideFrequencyAt() can be used to answer questions like: "how
## many probes in the drosophila2 chip have T, G, T, A at position
## 2, 4, 13 and 20, respectively?"
nucleotideFrequencyAt(probes, c(2, 4, 13, 20))["T", "G", "T", "A"]
## or "what's the probability to have an A at position 25 if there is
## one at position 13?"
nf <- nucleotideFrequencyAt(probes, c(13, 25))
sum(nf["A", "A"]) / sum(nf["A", ])
## Probabilities to have other bases at position 25 if there is an A
## at position 13:
sum(nf["A", "C"]) / sum(nf["A", ]) # C
sum(nf["A", "G"]) / sum(nf["A", ]) # G
sum(nf["A", "T"]) / sum(nf["A", ]) # T
## See ?hasLetterAt for another way to get those results.
## ---------------------------------------------------------------------
## D. oligonucleotideTransitions()
## ---------------------------------------------------------------------
## Get nucleotide transition matrices for yeast1
oligonucleotideTransitions(yeast1)
oligonucleotideTransitions(yeast1, 2, as.prob=TRUE)
## ---------------------------------------------------------------------
## E. ADVANCED *Frequency() EXAMPLES
## ---------------------------------------------------------------------
## Note that when dropping the dimensions of the 'tri' array, elements
## in the resulting vector are ordered as if they were obtained with
## 'fast.moving.side="left"':
triL <- trinucleotideFrequency(yeast1, fast.moving.side="left")
all(as.vector(tri) == triL) # TRUE
## Convert the trinucleotide frequency into the amino acid frequency
## based on translation:
tri1 <- trinucleotideFrequency(yeast1)
names(tri1) <- GENETIC_CODE[names(tri1)]
sapply(split(tri1, names(tri1)), sum) # 12512 occurrences of the stop codon
## When the returned vector is very long (e.g. width >= 10), using
## 'with.labels=FALSE' can improve performance significantly.
## Here for example, the observed speed up is between 25x and 500x:
f12 <- oligonucleotideFrequency(yeast1, 12, with.labels=FALSE) # very fast!
## With the use of 'step', trinucleotideFrequency() is a very fast way to
## calculate the codon usage table in an ORF (or a set of ORFs).
## Taking the same example as in '?codons':
file <- system.file("extdata", "someORF.fa", package="Biostrings")
my_ORFs <- readDNAStringSet(file)
## Strip flanking 1000 nucleotides around each ORF and remove first
## sequence as it contains an intron:
my_ORFs <- DNAStringSet(my_ORFs, start=1001, end=-1001)[-1]
## Codon usage for each ORF:
codon_usage <- trinucleotideFrequency(my_ORFs, step=3)
## Codon usage across all ORFs:
global_codon_usage <- trinucleotideFrequency(my_ORFs, step=3,
simplify.as="collapsed")
stopifnot(all(colSums(codon_usage) == global_codon_usage)) # sanity check
## Some related functions:
dict1 <- mkAllStrings(LETTERS[1:3], 4)
dict2 <- mkAllStrings(LETTERS[1:3], 4, fast.moving.side="left")
stopifnot(identical(reverse(dict1), dict2))
padAndClip()
Pad and clip strings
Description
padAndClip
first conceptually pads the supplied strings with an
infinite number of padding letters on both sides, then clip them.
stackStrings
is a convenience wrapper to padAndClip
that turns a variable-width set of strings into a rectangular
(i.e. constant-width) set, by padding and clipping the strings,
after conceptually shifting them horizontally.
Usage
padAndClip(x, views, Lpadding.letter=" ", Rpadding.letter=" ",
remove.out.of.view.strings=FALSE)
stackStrings(x, from, to, shift=0L,
Lpadding.letter=" ", Rpadding.letter=" ",
remove.out.of.view.strings=FALSE)
Arguments
Argument | Description |
---|---|
x | An XStringSet object containing the strings to pad and clip. |
views | A IntegerRanges object (recycled to the length of x if necessary) defining the region to keep for each string. Because the strings are first conceptually padded with an infinite number of padding letters on both sides, regions can go beyond string limits. |
Lpadding.letter, Rpadding.letter | A single letter to use for padding on the left, and another one to use for padding on the right. Note that the default letter ( " " ) does not work if, for example, x is a DNAStringSet object, because the space is not a valid DNA letter (see ? ). So the Lpadding.letter and Rpadding.letter arguments must be supplied if x is not a BStringSet object. For example, if x is a DNAStringSet object, a typical choice is to use "+" . |
remove.out.of.view.strings | TRUE or FALSE . Whether or not to remove the strings that are out of view in the returned object. |
from, to | Another way to specify the region to keep for each string, but with the restriction that from and to must be single integers. So only 1 region can be specified, and the same region is used for all the strings. |
shift | An integer vector (recycled to the length of x if necessary) specifying the amount of shifting (in number of letters) to apply to each string before doing pad and clip. Positive values shift to the right and negative values to the left. |
Value
For padAndClip
: An XStringSet object.
If remove.out.of.view.strings
is FALSE
, it has the same
length and names as x
, and its "shape", which is described by the
integer vector returned by width()
, is the same as the shape of the
views
argument after recycling.
The class of the returned object is the direct concrete subclass of
XStringSet that x
belongs to or derives from.
There are 4 direct concrete subclasses of the XStringSet virtual
class: BStringSet , DNAStringSet , RNAStringSet ,
and AAStringSet . If x
is an instance of one of
those classes, then the returned object has the same class as x
(i.e. in that case, padAndClip
acts as an endomorphism).
But if x
derives from one of those 4 classes, then the
returned object is downgraded to the class x
derives from.
In that case, padAndClip
does not act as an endomorphism.
For stackStrings
: Same as padAndClip
. In addition it is
guaranteed to have a rectangular shape i.e. to be a constant-width
XStringSet object.
Seealso
The
stackStringsFromBam
function in the GenomicAlignments package for stacking the read sequences (or their quality strings) stored in a BAM file on a region of interest.The XStringViews class to formally represent a set of views on a single string.
The
extractAt
andreplaceAt
functions for extracting/replacing arbitrary substrings from/in a string or set of strings.The XStringSet class.
The IntegerRanges class in the IRanges package.
Author
H. Pagès
Examples
x <- BStringSet(c(seq1="ABCD", seq2="abcdefghijk", seq3="", seq4="XYZ"))
padAndClip(x, IRanges(3, 8:5), Lpadding.letter=">", Rpadding.letter="<")
padAndClip(x, IRanges(1:-2, 7), Lpadding.letter=">", Rpadding.letter="<")
stackStrings(x, 2, 8)
stackStrings(x, -2, 8, shift=c(0, -11, 6, 7),
Lpadding.letter="#", Rpadding.letter=".")
stackStrings(x, -2, 8, shift=c(0, -14, 6, 7),
Lpadding.letter="#", Rpadding.letter=".")
stackStrings(x, -2, 8, shift=c(0, -14, 6, 7),
Lpadding.letter="#", Rpadding.letter=".",
remove.out.of.view.strings=TRUE)
library(hgu95av2probe)
probes <- DNAStringSet(hgu95av2probe)
probes
stackStrings(probes, 0, 26,
Lpadding.letter="+", Rpadding.letter="-")
options(showHeadLines=15)
stackStrings(probes, 3, 23, shift=6*c(1:5, -(1:5)),
Lpadding.letter="+", Rpadding.letter="N",
remove.out.of.view.strings=TRUE)
pairwiseAlignment()
Optimal Pairwise Alignment
Description
Solves (Needleman-Wunsch) global alignment, (Smith-Waterman) local alignment, and (ends-free) overlap alignment problems.
Usage
pairwiseAlignment(pattern, subject, list())
list(list("pairwiseAlignment"), list("ANY,ANY"))(pattern, subject,
patternQuality=PhredQuality(22L),
subjectQuality=PhredQuality(22L),
type="global",
substitutionMatrix=NULL, fuzzyMatrix=NULL,
gapOpening=10, gapExtension=4,
scoreOnly=FALSE)
list(list("pairwiseAlignment"), list("QualityScaledXStringSet,QualityScaledXStringSet"))(pattern, subject,
type="global",
substitutionMatrix=NULL, fuzzyMatrix=NULL,
gapOpening=10, gapExtension=4,
scoreOnly=FALSE)
Arguments
Argument | Description |
---|---|
pattern | a character vector of any length, an XString , or an XStringSet object. |
subject | a character vector of length 1, an XString , or an XStringSet object of length 1. |
patternQuality, subjectQuality | objects of class XStringQuality representing the respective quality scores for pattern and subject that are used in a quality-based method for generating a substitution matrix. These two arguments are ignored if !is.null(substitutionMatrix) or if its respective string set ( pattern , subject ) is of class QualityScaledXStringSet . |
type | type of alignment. One of "global" , "local" , "overlap" , "global-local" , and "local-global" where "global" = align whole strings with end gap penalties, "local" = align string fragments, "overlap" = align whole strings without end gap penalties, "global-local" = align whole strings in pattern with consecutive subsequence of subject , "local-global" = align consecutive subsequence of pattern with whole strings in subject . |
substitutionMatrix | substitution matrix representing the fixed substitution scores for an alignment. It cannot be used in conjunction with patternQuality and subjectQuality arguments. |
fuzzyMatrix | fuzzy match matrix for quality-based alignments. It takes values between 0 and 1; where 0 is an unambiguous mismatch, 1 is an unambiguous match, and values in between represent a fraction of "matchiness". (See details section below.) |
gapOpening | the cost for opening a gap in the alignment. |
gapExtension | the incremental cost incurred along the length of the gap in the alignment. |
scoreOnly | logical to denote whether or not to return just the scores of the optimal pairwise alignment. |
list() | optional arguments to generic function to support additional methods. |
Details
Quality-based alignments are based on the paper the Bioinformatics article by
Ketil Malde listed in the Reference section below. Let $psiloni$ be the
probability of an error in the base read. For "Phred"
quality measures
$Q$ in $[0, 99]$ , these error probabilities are given by
$psilon_i = 10^{-Q/10}$ . For "Solexa"
quality measures $Q$ in
$[-5, 99]$ , they are given by $psilon_i = 1 - 1/(1 + 10^{-Q/10})$ .
Assuming independence within and between base reads, the combined error
probability of a mismatch when the underlying bases do match is
$psilon_c = psilon_1 + psilon_2 - (n/(n-1)) psilon_1 psilon_2$ ,
where $n$ is the number of letters in the underlying alphabet (i.e.
$n = 4$ for DNA input, $n = 20$ for amino acid input, otherwise
$n$ is the number of distinct letters in the input).
Using $psilon_c$ , the substitution score is given by
$b * log_2(gamma{x,y} (1 - psilon_c) n + (1 - gamma{x,y}) psilon_c (n/(n-1)))$ ,
where $b$ is the bit-scaling for the scoring and $gamma{x,y}$ is the
probability that characters $x$ and $y$ represents the same underlying
information (e.g. using IUPAC, $gamma{A,A} = 1$ and $gamma{A,N} = 1/4$ .
In the arguments listed above fuzzyMatch
represents $gamma_{x,y}$
and patternQuality
and subjectQuality
represents $psilon_1$
and $psilon_2$ respectively.
If scoreOnly == FALSE
, a pairwise alignment with the maximum alignment
score is returned. If more than one pairwise alignment produces the maximum
alignment score, then the alignment with the smallest initial deletion whose
mismatches occur before its insertions and deletions is chosen. For example,
if pattern = "AGTA"
and subject = "AACTAACTA"
, then the alignment
pattern: [1] AG-TA; subject: [1] AACTA
is chosen over
pattern: [1] A-GTA; subject: [1] AACTA
or
pattern: [1] AG-TA; subject: [5] AACTA
if they all achieve the maximum
alignment score.
Value
If scoreOnly == FALSE
, an instance of class
PairwiseAlignments
or
PairwiseAlignmentsSingleSubject
is returned.
If scoreOnly == TRUE
, a numeric vector containing the scores for the
optimal pairwise alignments is returned.
Seealso
writePairwiseAlignments
,
stringDist
,
PairwiseAlignments-class ,
XStringQuality-class ,
substitution.matrices ,
matchPattern
Note
Use matchPattern
or vmatchPattern
if you need to
find all the occurrences (eventually with indels) of a given pattern in a
reference sequence or set of sequences.
Use matchPDict
if you need to match a (big) set of patterns
against a reference sequence.
Author
P. Aboyoun and H. Pagès
References
R. Durbin, S. Eddy, A. Krogh, G. Mitchison, Biological Sequence Analysis, Cambridge UP 1998, sec 2.3.
B. Haubold, T. Wiehe, Introduction to Computational Biology, Birkhauser Verlag 2006, Chapter 2.
K. Malde, The effect of sequence quality on sequence alignment, Bioinformatics 2008 24(7):897-900.
Examples
## Nucleotide global, local, and overlap alignments
s1 <-
DNAString("ACTTCACCAGCTCCCTGGCGGTAAGTTGATCAAAGGAAACGCAAAGTTTTCAAG")
s2 <-
DNAString("GTTTCACTACTTCCTTTCGGGTAAGTAAATATATAAATATATAAAAATATAATTTTCATC")
# First use a fixed substitution matrix
mat <- nucleotideSubstitutionMatrix(match = 1, mismatch = -3, baseOnly = TRUE)
globalAlign <-
pairwiseAlignment(s1, s2, substitutionMatrix = mat,
gapOpening = 5, gapExtension = 2)
localAlign <-
pairwiseAlignment(s1, s2, type = "local", substitutionMatrix = mat,
gapOpening = 5, gapExtension = 2)
overlapAlign <-
pairwiseAlignment(s1, s2, type = "overlap", substitutionMatrix = mat,
gapOpening = 5, gapExtension = 2)
# Then use quality-based method for generating a substitution matrix
pairwiseAlignment(s1, s2,
patternQuality = SolexaQuality(rep(c(22L, 12L), times = c(36, 18))),
subjectQuality = SolexaQuality(rep(c(22L, 12L), times = c(40, 20))),
scoreOnly = TRUE)
# Now assume can't distinguish between C/T and G/A
pairwiseAlignment(s1, s2,
patternQuality = SolexaQuality(rep(c(22L, 12L), times = c(36, 18))),
subjectQuality = SolexaQuality(rep(c(22L, 12L), times = c(40, 20))),
type = "local")
mapping <- diag(4)
dimnames(mapping) <- list(DNA_BASES, DNA_BASES)
mapping["C", "T"] <- mapping["T", "C"] <- 1
mapping["G", "A"] <- mapping["A", "G"] <- 1
pairwiseAlignment(s1, s2,
patternQuality = SolexaQuality(rep(c(22L, 12L), times = c(36, 18))),
subjectQuality = SolexaQuality(rep(c(22L, 12L), times = c(40, 20))),
fuzzyMatrix = mapping,
type = "local")
## Amino acid global alignment
pairwiseAlignment(AAString("PAWHEAE"), AAString("HEAGAWGHEE"),
substitutionMatrix = "BLOSUM50",
gapOpening = 0, gapExtension = 8)
phiX174Phage()
Versions of bacteriophage phiX174 complete genome and sample short reads
Description
Six versions of the complete genome for bacteriophage $phi$ X174 as well as a small number of Solexa short reads, qualities associated with those short reads, and counts for the number times those short reads occurred.
Details
The phiX174Phage
object is a DNAStringSet
containing the
following six naturally occurring versions of the bacteriophage $phi$ X174
genome cited in Smith et al.:
list(" ", " ", list(list("Genbank:"), list("The version of the genome from GenBank (NC_001422.1, GI:9626372).")), " ", " ", list(list("RF70s:"), list("A preparation of ", list(list("\phi")), " X double-stranded replicative form (RF) of DNA ", " by Clyde A. Hutchison III from the late 1970s.")), " ", " ", list(list("SS78:"), list("A preparation of ", list(list("\phi")), " X virion single-stranded DNA from 1978.")), " ", " ", list(list("Bull:"), list("The sequence of wild-type ", list(
list("\phi")), " X used by Bull et al.")), "
", " ", list(list("G'97:"), list("The ", list(list("\phi")), " X replicative form (RF) of DNA from Bull et al.")), "
", " ", list(list("NEB'03:"), list("A ", list(list("\phi")), " X replicative form (RF) of DNA from New England BioLabs (NEB).")), "
")
The srPhiX174
object is a DNAStringSet
containing short reads
from a Solexa machine.
The quPhiX174
object is a BStringSet
containing Solexa quality
scores associated with srPhiX174
.
The wtPhiX174
object is an integer vector containing counts associated
with srPhiX174
.
References
http://www.genome.jp/dbget-bin/www_bget?refseq+NC_001422
Bull, J. J., Badgett, M. R., Wichman, H. A., Huelsenbeck, Hillis, D. M., Gulati, A., Ho, C. & Molineux, J. (1997) Genetics 147, 1497-1507.
Smith, Hamilton O.; Clyde A. Hutchison, Cynthia Pfannkoch, J. Craig Venter (2003-12-23). "Generating a synthetic genome by whole genome assembly: {phi}X174 bacteriophage from synthetic oligonucleotides". Proceedings of the National Academy of Sciences 100 (26): 15440-15445. doi:10.1073/pnas.2237126100.
Examples
data(phiX174Phage)
nchar(phiX174Phage)
genBankPhage <- phiX174Phage[[1]]
genBankSubstring <- substring(genBankPhage, 2793-34, 2811+34)
data(srPhiX174)
srPhiX174
quPhiX174
summary(wtPhiX174)
alignPhiX174 <-
pairwiseAlignment(srPhiX174, genBankSubstring,
patternQuality = SolexaQuality(quPhiX174),
subjectQuality = SolexaQuality(99L),
type = "global-local")
summary(alignPhiX174, weight = wtPhiX174)
pid()
Percent Sequence Identity
Description
Calculates the percent sequence identity for a pairwise sequence alignment.
Usage
pid(x, type="PID1")
Arguments
Argument | Description |
---|---|
x | a PairwiseAlignments object. |
type | one of percent sequence identity. One of "PID1" , "PID2" , "PID3" , and "PID4" . See Details for more information. |
Details
Since there is no universal definition of percent sequence identity, the pid
function
calculates this statistic in the following types:
list("
", " ", list(list(list(""PID1""), ":"), list("
", " 100 (identical positions) / (aligned positions + internal gap positions)
", " ")), "
", " ", list(list(list(""PID2""), ":"), list("
", " 100 (identical positions) / (aligned positions)
", " ")), "
", " ", list(list(list(""PID3""), ":"), list("
", " 100 (identical positions) / (length shorter sequence)
", " ")), "
", " ", list(list(list(""PID4""), ":"), list("
", " 100 (identical positions) / (average length of the two sequences)
",
" ")), "
")
Value
A numeric vector containing the specified sequence identity measures.
Seealso
pairwiseAlignment , PairwiseAlignments-class , match-utils
Author
P. Aboyoun
References
A. May, Percent Sequence Identity: The Need to Be Explicit, Structure 2004, 12(5):737.
G. Raghava and G. Barton, Quantification of the variation in percentage identity for protein sequence alignments, BMC Bioinformatics 2006, 7:415.
Examples
s1 <- DNAString("AGTATAGATGATAGAT")
s2 <- DNAString("AGTAGATAGATGGATGATAGATA")
palign1 <- pairwiseAlignment(s1, s2)
palign1
pid(palign1)
palign2 <-
pairwiseAlignment(s1, s2,
substitutionMatrix =
nucleotideSubstitutionMatrix(match = 2, mismatch = 10, baseOnly = TRUE))
palign2
pid(palign2, type = "PID4")
pmatchPattern()
Longest Common Prefix/Suffix/Substring searching functions
Description
Functions for searching the Longest Common Prefix/Suffix/Substring of two strings.
WARNING: These functions are experimental and might not work properly! Full documentation will come later.
Please send questions/comments to hpages@fredhutch.org
Thanks for your comprehension!
Usage
lcprefix(s1, s2)
lcsuffix(s1, s2)
lcsubstr(s1, s2)
pmatchPattern(pattern, subject, maxlength.out=1L)
Arguments
Argument | Description |
---|---|
s1 | 1st string, a character string or an XString object. |
s2 | 2nd string, a character string or an XString object. |
pattern | The pattern string. |
subject | An XString object containing the subject string. |
maxlength.out | The maximum length of the output i.e. the maximum number of views in the returned object. |
Seealso
replaceAt()
Extract/replace arbitrary substrings from/in a string or set of strings.
Description
extractAt
extracts multiple subsequences from XString
object x
, or from the individual sequences of XStringSet
object x
, at the ranges of positions specified thru at
.
replaceAt
performs multiple subsequence replacements (a.k.a.
substitutions) in XString object x
, or in the individual
sequences of XStringSet object x
, at the ranges of positions
specified thru at
.
Usage
extractAt(x, at)
replaceAt(x, at, value="")
Arguments
Argument | Description |
---|---|
x | An XString or XStringSet object. |
at | Typically a IntegerRanges object if x is an XString object, and an IntegerRangesList object if x is an XStringSet object. Alternatively, the ranges can be specified with only 1 number per range (its start position), in which case they are considered to be empty ranges (a.k.a. zero-width ranges). So if at is a numeric vector, an IntegerList object, or a list of numeric vectors, each number in it is interpreted as the start position of a zero-width range. This is useful when using replaceAt to perform insertions. The following applies only if x is an XStringSet object: at is recycled to the length of x if necessary. If at is a IntegerRanges object (or a numeric vector), it is first turned into a IntegerRangesList object of length 1 and then this IntegerRangesList object is recycled to the length of x . This is useful for specifying the same ranges across all sequences in x . The effective shape of at is described by its length together with the lengths of its list elements after recycling. As a special case, extractAt accepts at and value to be both of length 0, in which case it just returns x unmodified (no-op). |
value | The replacement sequences. If x is an XString object, value is typically a character vector or an XStringSet object that is recycled to the length of at (if necessary). If x is an XStringSet object, value is typically a list of character vectors or a CharacterList or XStringSetList object. If necessary, it is recycled "vertically" first and then "horizontally" to bring it into the effective shape of at (see above). "Vertical recycling" is the usual recycling whereas "horizontal recycling" recycles the individual list elements . As a special case, extractAt accepts at and value to be both of length 0, in which case it just returns x unmodified (no-op). |
Value
For extractAt
: An XStringSet object of the same length as
at
if x
is an XString object.
An XStringSetList object of the same length as x
(and same effective shape as at
) if x
is an
XStringSet object.
For replaceAt
: An object of the same class as x
.
If x
is an XStringSet object, its length and names and
metadata columns are preserved.
Seealso
The
subseq
andsubseq<-
functions in the XVector package for simpler forms of subsequence extractions and replacements.The
extractList
andunstrsplit
functions defined and documented in the IRanges package.The
replaceLetterAt
function for a DNA-specific single-letter replacement functions useful for SNP injections.The
padAndClip
function for padding and clipping strings.The XString , XStringSet , and XStringSetList classes.
The IntegerRanges , IntegerRangesList , IntegerList , and CharacterList classes defined and documented in the IRanges package.
Note
Like subseq
(defined and documented in the
XVector package), extractAt
does not copy the sequence data!
extractAt
is equivalent to extractList
(defined and documented in the IRanges package) when x
is an
XString object and at
a IntegerRanges object.
Author
H. Pagès
Examples
## ---------------------------------------------------------------------
## (A) ON AN XString OBJECT
## ---------------------------------------------------------------------
x <- BString("abcdefghijklm")
at1 <- IRanges(5:1, width=3)
extractAt(x, at1)
names(at1) <- LETTERS[22:26]
extractAt(x, at1)
at2 <- IRanges(c(1, 5, 12), c(3, 4, 12), names=c("X", "Y", "Z"))
extractAt(x, at2)
extractAt(x, rev(at2))
value <- c("+", "-", "*")
replaceAt(x, at2, value=value)
replaceAt(x, rev(at2), value=rev(value))
at3 <- IRanges(c(14, 1, 1, 1, 1, 11), c(13, 0, 10, 0, 0, 10))
value <- 1:6
replaceAt(x, at3, value=value) # "24536klm1"
replaceAt(x, rev(at3), value=rev(value)) # "54236klm1"
## Deletions:
stopifnot(replaceAt(x, at2) == "defghijkm")
stopifnot(replaceAt(x, rev(at2)) == "defghijkm")
stopifnot(replaceAt(x, at3) == "klm")
stopifnot(replaceAt(x, rev(at3)) == "klm")
## Insertions:
at4 <- IRanges(c(6, 10, 2, 5), width=0)
stopifnot(replaceAt(x, at4, value="-") == "a-bcd-e-fghi-jklm")
stopifnot(replaceAt(x, start(at4), value="-") == "a-bcd-e-fghi-jklm")
at5 <- c(5, 1, 6, 5) # 2 insertions before position 5
replaceAt(x, at5, value=c("+", "-", "*", "/"))
## No-ops:
stopifnot(replaceAt(x, NULL, value=NULL) == x)
stopifnot(replaceAt(x, at2, value=extractAt(x, at2)) == x)
stopifnot(replaceAt(x, at3, value=extractAt(x, at3)) == x)
stopifnot(replaceAt(x, at4, value=extractAt(x, at4)) == x)
stopifnot(replaceAt(x, at5, value=extractAt(x, at5)) == x)
## The order of successive transformations matters:
## T1: insert "+" before position 1 and 4
## T2: insert "-" before position 3
## T1 followed by T2
x2a <- replaceAt(x, c(1, 4), value="+")
x3a <- replaceAt(x2a, 3, value="-")
## T2 followed by T1
x2b <- replaceAt(x, 3, value="-")
x3b <- replaceAt(x2b, c(1, 4), value="+")
## T1 and T2 simultaneously:
x3c <- replaceAt(x, c(1, 3, 4), value=c("+", "-", "+"))
## ==> 'x3a', 'x3b', and 'x3c' are all different!
## Append "**" to 'x3c':
replaceAt(x3c, length(x3c) + 1L, value="**")
## ---------------------------------------------------------------------
## (B) ON AN XStringSet OBJECT
## ---------------------------------------------------------------------
x <- BStringSet(c(seq1="ABCD", seq2="abcdefghijk", seq3="XYZ"))
at6 <- IRanges(c(1, 3), width=1)
extractAt(x, at=at6)
unstrsplit(extractAt(x, at=at6))
at7 <- IRangesList(IRanges(c(2, 1), c(3, 0)),
IRanges(c(7, 2, 12, 7), c(6, 5, 11, 8)),
IRanges(2, 2))
## Set inner names on 'at7'.
unlisted_at7 <- unlist(at7)
names(unlisted_at7) <-
paste0("rg", sprintf("%02d", seq_along(unlisted_at7)))
at7 <- relist(unlisted_at7, at7)
extractAt(x, at7) # same as 'as(mapply(extractAt, x, at7), "List")'
extractAt(x, at7[3]) # same as 'as(mapply(extractAt, x, at7[3]), "List")'
replaceAt(x, at7, value=extractAt(x, at7)) # no-op
replaceAt(x, at7) # deletions
at8 <- IRangesList(IRanges(1:5, width=0),
IRanges(c(6, 8, 10, 7, 2, 5),
width=c(0, 2, 0, 0, 0, 0)),
IRanges(c(1, 2, 1), width=c(0, 1, 0)))
replaceAt(x, at8, value="-")
value8 <- relist(paste0("[", seq_along(unlist(at8)), "]"), at8)
replaceAt(x, at8, value=value8)
replaceAt(x, at8, value=as(c("+", "-", "*"), "List"))
## Append "**" to all sequences:
replaceAt(x, as(width(x) + 1L, "List"), value="**")
## ---------------------------------------------------------------------
## (C) ADVANCED EXAMPLES
## ---------------------------------------------------------------------
library(hgu95av2probe)
probes <- DNAStringSet(hgu95av2probe)
## Split the probes in 5-mer chunks:
at <- successiveIRanges(rep(5, 5))
extractAt(probes, at)
## Replace base 13 by its complement:
at <- IRanges(13, width=1)
base13 <- extractAt(probes, at)
base13comp <- relist(complement(unlist(base13)), base13)
replaceAt(probes, at, value=base13comp)
## See ?xscat for a more efficient way to do this.
## Replace all the occurences of a given pattern with another pattern:
midx <- vmatchPattern("VCGTT", probes, fixed=FALSE)
matches <- extractAt(probes, midx)
unlist(matches)
unique(unlist(matches))
probes2 <- replaceAt(probes, midx, value="-++-")
## See strings with 2 or more susbtitutions:
probes2[elementNROWS(midx) >= 2]
## 2 sanity checks:
stopifnot(all(replaceAt(probes, midx, value=matches) == probes))
probes2b <- gsub("[ACG]CGTT", "-++-", as.character(probes))
stopifnot(identical(as.character(probes2), probes2b))
replaceLetterAt()
Replacing letters in a sequence (or set of sequences) at some specified locations
Description
replaceLetterAt
first makes a copy of a sequence (or set of
sequences) and then replaces some of the original letters by new
letters at the specified locations.
.inplaceReplaceLetterAt
is the IN PLACE version of
replaceLetterAt
: it will modify the original
sequence in place i.e. without copying it first.
Note that in place modification of a sequence is fundamentally
dangerous because it alters all objects defined in your session
that make reference to the modified sequence.
NEVER use .inplaceReplaceLetterAt
, unless you know what
you are doing!
Usage
replaceLetterAt(x, at, letter, if.not.extending="replace", verbose=FALSE)
## NEVER USE THIS FUNCTION!
.inplaceReplaceLetterAt(x, at, letter)
Arguments
Argument | Description |
---|---|
x | A DNAString or rectangular DNAStringSet object. |
at | The locations where the replacements must occur. If x is a DNAString object, then at is typically an integer vector with no NAs but a logical vector or Rle object is valid too. Locations can be repeated and in this case the last replacement to occur at a given location prevails. If x is a rectangular DNAStringSet object, then at must be a matrix of logicals with the same dimensions as x . |
letter | The new letters. If x is a DNAString object, then letter must be a DNAString object or a character vector (with no NAs) with a total number of letters ( sum(nchar(letter)) ) equal to the number of locations specified in at . If x is a rectangular DNAStringSet object, then letter must be a DNAStringSet object or a character vector of the same length as x . In addition, the number of letters in each element of letter must match the number of locations specified in the corresponding row of at ( all(width(letter) == rowSums(at)) ). |
if.not.extending | What to do if the new letter is not "extending" the old letter? The new letter "extends" the old letter if both are IUPAC letters and the new letter is as specific or less specific than the old one (e.g. M extends A, Y extends Y, but Y doesn't extend S). Possible values are "replace" (the default) for replacing in all cases, "skip" for not replacing when the new letter does not extend the old letter, "merge" for merging the new IUPAC letter with the old one, and "error" for raising an error. Note that the gap ( "-" ) and hard masking ( "+" ) letters are not extending or extended by any other letter. Also note that "merge" is the only value for the if.not.extending argument that guarantees the final result to be independent on the order the replacement is performed (although this is only relevant when at contains duplicated locations, otherwise the result is of course always independent on the order, whatever the value of if.not.extending is). |
verbose | When TRUE , a warning will report the number of skipped or merged letters. |
Details
.inplaceReplaceLetterAt
semantic is equivalent to calling
replaceLetterAt
with if.not.extending="merge"
and verbose=FALSE
.
Never use .inplaceReplaceLetterAt
!
It is used by the injectSNPs
function
in the BSgenome package, as part of the "lazy sequence loading"
mechanism, for altering the original sequences of a
BSgenome object at "sequence-load time".
This alteration consists in injecting the IUPAC ambiguity letters
representing the SNPs into the just loaded sequence, which is the
only time where in place modification of the external data of
an XString object is safe.
Value
A DNAString or DNAStringSet object of the same shape
(i.e. length and width) as the orignal object x
for replaceLetterAt
.
Seealso
The
replaceAt
function for extracting or replacing arbitrary subsequences from/in a sequence or set of sequences.IUPAC_CODE_MAP
for the mapping between IUPAC nucleotide ambiguity codes and their meaning.The
chartr
andinjectHardMask
functions.The DNAString and DNAStringSet class.
The
injectSNPs
function and the BSgenome class in the BSgenome package.
Author
H. Pagès
Examples
## Replace letters of a DNAString object:
replaceLetterAt(DNAString("AAMAA"), c(5, 1, 3, 1), "TYNC")
replaceLetterAt(DNAString("AAMAA"), c(5, 1, 3, 1), "TYNC", if.not.extending="merge")
## Replace letters of a DNAStringSet object (sorry for the totally
## artificial example with absolutely no biological meaning):
library(drosophila2probe)
probes <- DNAStringSet(drosophila2probe)
at <- matrix(c(TRUE, TRUE, FALSE, FALSE, FALSE, TRUE, FALSE, FALSE),
nrow=length(probes), ncol=width(probes)[1],
byrow=TRUE)
letter_subject <- DNAString(paste(rep.int("-", width(probes)[1]), collapse=""))
letter <- as(Views(letter_subject, start=1, end=rowSums(at)), "XStringSet")
replaceLetterAt(probes, at, letter)
reverseComplement()
Sequence reversing and complementing
Description
Use these functions for reversing sequences and/or complementing DNA or RNA sequences.
Usage
complement(x, list())
reverseComplement(x, list())
Arguments
Argument | Description |
---|---|
x | A DNAString , RNAString , DNAStringSet , RNAStringSet , XStringViews (with DNAString or RNAString subject), MaskedDNAString or MaskedRNAString object for complement and reverseComplement . |
list() | Additional arguments to be passed to or from methods. |
Details
See ?
for reversing an XString ,
XStringSet or XStringViews object.
If x
is a DNAString or RNAString object,
complement(x)
returns an object where each base in x
is "complemented" i.e. A, C, G, T in a DNAString object are replaced
by T, G, C, A respectively and A, C, G, U in a RNAString object
are replaced by U, G, C, A respectively.
Letters belonging to the IUPAC Extended Genetic Alphabet are also
replaced by their complement (M <-> K, R <-> Y, S <-> S, V <-> B,
W <-> W, H <-> D, N <-> N) and the gap ( "-"
) and hard masking
( "+"
) letters are unchanged.
reverseComplement(x)
is equivalent to reverse(complement(x))
but is faster and more memory efficient.
Value
An object of the same class and length as the original object.
Seealso
reverse ,
DNAString-class ,
RNAString-class ,
DNAStringSet-class ,
RNAStringSet-class ,
XStringViews-class ,
MaskedXString-class ,
chartr
,
findPalindromes
,
IUPAC_CODE_MAP
Examples
## ---------------------------------------------------------------------
## A. SOME SIMPLE EXAMPLES
## ---------------------------------------------------------------------
x <- DNAString("ACGT-YN-")
reverseComplement(x)
library(drosophila2probe)
probes <- DNAStringSet(drosophila2probe)
probes
alphabetFrequency(probes, collapse=TRUE)
rcprobes <- reverseComplement(probes)
rcprobes
alphabetFrequency(rcprobes, collapse=TRUE)
## ---------------------------------------------------------------------
## B. OBTAINING THE MISMATCH PROBES OF A CHIP
## ---------------------------------------------------------------------
pm2mm <- function(probes)
{
probes <- DNAStringSet(probes)
subseq(probes, start=13, end=13) <- complement(subseq(probes, start=13, end=13))
probes
}
mmprobes <- pm2mm(probes)
mmprobes
alphabetFrequency(mmprobes, collapse=TRUE)
## ---------------------------------------------------------------------
## C. SEARCHING THE MINUS STRAND OF A CHROMOSOME
## ---------------------------------------------------------------------
## Applying reverseComplement() to the pattern before calling
## matchPattern() is the recommended way of searching hits on the
## minus strand of a chromosome.
library(BSgenome.Dmelanogaster.UCSC.dm3)
chrX <- Dmelanogaster$chrX
pattern <- DNAString("ACCAACNNGGTTG")
matchPattern(pattern, chrX, fixed=FALSE) # 3 hits on strand +
rcpattern <- reverseComplement(pattern)
rcpattern
m0 <- matchPattern(rcpattern, chrX, fixed=FALSE)
m0 # 5 hits on strand -
## Applying reverseComplement() to the subject instead of the pattern is not
## a good idea for 2 reasons:
## (1) Chromosome sequences are generally big and sometimes very big
## so computing the reverse complement of the positive strand will
## take time and memory proportional to its length.
chrXminus <- reverseComplement(chrX) # needs to allocate 22M of memory!
chrXminus
## (2) Chromosome locations are generally given relatively to the positive
## strand, even for features located in the negative strand, so after
## doing this:
m1 <- matchPattern(pattern, chrXminus, fixed=FALSE)
## the start/end of the matches are now relative to the negative strand.
## You need to apply reverseComplement() again on the result if you want
## them to be relative to the positive strand:
m2 <- reverseComplement(m1) # allocates 22M of memory, again!
## and finally to apply rev() to sort the matches from left to right
## (5'3' direction) like in m0:
m3 <- rev(m2) # same as m0, finally!
## WARNING: Before you try the example below on human chromosome 1, be aware
## that it will require the allocation of about 500Mb of memory!
if (interactive()) {
library(BSgenome.Hsapiens.UCSC.hg18)
chr1 <- Hsapiens$chr1
matchPattern(pattern, reverseComplement(chr1)) # DON'T DO THIS!
matchPattern(reverseComplement(pattern), chr1) # DO THIS INSTEAD
}
stringDist()
String Distance/Alignment Score Matrix
Description
Computes the Levenshtein edit distance or pairwise alignment score matrix for a set of strings.
Usage
stringDist(x, method = "levenshtein", ignoreCase = FALSE, diag = FALSE, upper = FALSE, list())
list(list("stringDist"), list("XStringSet"))(x, method = "levenshtein", ignoreCase = FALSE, diag = FALSE,
upper = FALSE, type = "global", quality = PhredQuality(22L),
substitutionMatrix = NULL, fuzzyMatrix = NULL, gapOpening = 0,
gapExtension = 1)
list(list("stringDist"), list("QualityScaledXStringSet"))(x, method = "quality", ignoreCase = FALSE,
diag = FALSE, upper = FALSE, type = "global", substitutionMatrix = NULL,
fuzzyMatrix = NULL, gapOpening = 0, gapExtension = 1)
Arguments
Argument | Description |
---|---|
x | a character vector or an XStringSet object. |
method | calculation method. One of "levenshtein" , "hamming" , "quality" , or "substitutionMatrix" . |
ignoreCase | logical value indicating whether to ignore case during scoring. |
diag | logical value indicating whether the diagonal of the matrix should be printed by print.dist . |
upper | logical value indicating whether the upper triangle of the matrix should be printed by print.dist . |
type | (applicable when method = "quality" or method = "substitutionMatrix" ). type of alignment. One of "global" , "local" , and "overlap" , where "global" = align whole strings with end gap penalties, "local" = align string fragments, "overlap" = align whole strings without end gap penalties. |
quality | (applicable when method = "quality" ). object of class XStringQuality representing the quality scores for x that are used in a quality-based method for generating a substitution matrix. |
substitutionMatrix | (applicable when method = "substitutionMatrix" ). symmetric matrix representing the fixed substitution scores in the alignment. |
fuzzyMatrix | (applicable when method = "quality" ). fuzzy match matrix for quality-based alignments. It takes values between 0 and 1; where 0 is an unambiguous mismatch, 1 is an unambiguous match, and values in between represent a fraction of "matchiness". |
gapOpening | (applicable when method = "quality" or method = "substitutionMatrix" ). penalty for opening a gap in the alignment. |
gapExtension | (applicable when method = "quality" or method = "substitutionMatrix" ). penalty for extending a gap in the alignment |
list() | optional arguments to generic function to support additional methods. |
Details
When method = "hamming"
, uses the underlying neditStartingAt
code
to calculate the distances, where the Hamming distance is defined as the number
of substitutions between two strings of equal length. Otherwise, uses the
underlying pairwiseAlignment
code to compute the distance/alignment
score matrix.
Value
Returns an object of class "dist"
.
Seealso
dist , agrep , pairwiseAlignment , substitution.matrices
Author
P. Aboyoun
Examples
stringDist(c("lazy", "HaZy", "crAzY"))
stringDist(c("lazy", "HaZy", "crAzY"), ignoreCase = TRUE)
data(phiX174Phage)
plot(hclust(stringDist(phiX174Phage), method = "single"))
data(srPhiX174)
stringDist(srPhiX174[1:4])
stringDist(srPhiX174[1:4], method = "quality",
quality = SolexaQuality(quPhiX174[1:4]),
gapOpening = 10, gapExtension = 4)
substitution_matrices()
Scoring matrices
Description
Predefined substitution matrices for nucleotide and amino acid alignments.
Format
The BLOSUM and PAM matrices are square symmetric matrices with integer coefficients, whose row and column names are identical and unique: each name is a single letter representing a nucleotide or an amino acid.
nucleotideSubstitutionMatrix
produces a substitution matrix for all IUPAC
nucleic acid codes based upon match and mismatch parameters.
errorSubstitutionMatrices
produces a two element list of numeric
square symmetric matrices, one for matches and one for mismatches.
qualitySubstitutionMatrices
produces the substitution matrices
for Phred or Solexa quality-based reads.
Usage
data(BLOSUM45)
data(BLOSUM50)
data(BLOSUM62)
data(BLOSUM80)
data(BLOSUM100)
data(PAM30)
data(PAM40)
data(PAM70)
data(PAM120)
data(PAM250)
nucleotideSubstitutionMatrix(match = 1, mismatch = 0, baseOnly = FALSE, type = "DNA")
qualitySubstitutionMatrices(fuzzyMatch = c(0, 1), alphabetLength = 4L, qualityClass = "PhredQuality", bitScale = 1)
errorSubstitutionMatrices(errorProbability, fuzzyMatch = c(0, 1), alphabetLength = 4L, bitScale = 1)
Arguments
Argument | Description |
---|---|
match | the scoring for a nucleotide match. |
mismatch | the scoring for a nucleotide mismatch. |
baseOnly | TRUE or FALSE . If TRUE , only uses the letters in the "base" alphabet i.e. "A", "C", "G", "T". |
type | either "DNA" or "RNA". |
fuzzyMatch | a named or unnamed numeric vector representing the base match probability. |
errorProbability | a named or unnamed numeric vector representing the error probability. |
alphabetLength | an integer representing the number of letters in the underlying string alphabet. For DNA and RNA, this would be 4L. For Amino Acids, this could be 20L. |
qualityClass | a character string of "PhredQuality" , "SolexaQuality" , or "IlluminaQuality" . |
bitScale | a numeric value to scale the quality-based substitution matrices. By default, this is 1, representing bit-scale scoring. |
Details
The BLOSUM and PAM matrices are not unique. For example, the definition of the widely used BLOSUM62 matrix varies depending on the source, and even a given source can provide different versions of "BLOSUM62" without keeping track of the changes over time. NCBI provides many matrices here ftp://ftp.ncbi.nih.gov/blast/matrices/ but their definitions don't match those of the matrices bundled with their stand-alone BLAST software available here ftp://ftp.ncbi.nih.gov/blast/
The BLOSUM45, BLOSUM62, BLOSUM80, PAM30 and PAM70 matrices were taken from NCBI stand-alone BLAST software.
The BLOSUM50, BLOSUM100, PAM40, PAM120 and PAM250 matrices were taken from ftp://ftp.ncbi.nih.gov/blast/matrices/
The quality matrices computed in qualitySubstitutionMatrices
are
based on the paper by Ketil Malde. Let $psiloni$ be the probability
of an error in the base read. For "Phred"
quality measures $Q$
in $[0, 99]$ , these error probabilities are given by
$psilon_i = 10^{-Q/10}$ . For "Solexa"
quality measures
$Q$ in $[-5, 99]$ , they are given by
$psilon_i = 1 - 1/(1 + 10^{-Q/10})$ .
Assuming independence within and between base reads, the combined error
probability of a mismatch when the underlying bases do match is
$psilon_c = psilon_1 + psilon_2 - (n/(n-1)) psilon_1 psilon_2$ ,
where $n$ is the number of letters in the underlying alphabet. Using
$psilon_c$ , the substitution score is given by when two bases match is given by
$b * log_2(gamma{x,y} (1 - psilon_c) n + (1 - gamma{x,y}) psilon_c (n/(n-1)))$ ,
where $b$ is the bit-scaling for the scoring and $gamma{x,y}$ is the
probability that characters $x$ and $y$ represents the same underlying
information (e.g. using IUPAC, $gamma{A,A} = 1$ and $gamma{A,N} = 1/4$ .
In the arguments listed above fuzzyMatch
represents $gamma_{x,y}$
and errorProbability
represents $psilon_i$ .
Seealso
pairwiseAlignment
,
PairwiseAlignments-class ,
DNAString-class ,
AAString-class ,
PhredQuality-class ,
SolexaQuality-class ,
IlluminaQuality-class
Author
H. Pagès and P. Aboyoun
References
K. Malde, The effect of sequence quality on sequence alignment, Bioinformatics, Feb 23, 2008.
Examples
s1 <-
DNAString("ACTTCACCAGCTCCCTGGCGGTAAGTTGATCAAAGGAAACGCAAAGTTTTCAAG")
s2 <-
DNAString("GTTTCACTACTTCCTTTCGGGTAAGTAAATATATAAATATATAAAAATATAATTTTCATC")
## Fit a global pairwise alignment using edit distance scoring
pairwiseAlignment(s1, s2,
substitutionMatrix = nucleotideSubstitutionMatrix(0, -1, TRUE),
gapOpening = 0, gapExtension = 1)
## Examine quality-based match and mismatch bit scores for DNA/RNA
## strings in pairwiseAlignment.
## By default patternQuality and subjectQuality are PhredQuality(22L).
qualityMatrices <- qualitySubstitutionMatrices()
qualityMatrices["22", "22", "1"]
qualityMatrices["22", "22", "0"]
pairwiseAlignment(s1, s2)
## Get the substitution scores when the error probability is 0.1
subscores <- errorSubstitutionMatrices(errorProbability = 0.1)
submat <- matrix(subscores[,,"0"], 4, 4)
diag(submat) <- subscores[,,"1"]
dimnames(submat) <- list(DNA_ALPHABET[1:4], DNA_ALPHABET[1:4])
submat
pairwiseAlignment(s1, s2, substitutionMatrix = submat)
## Align two amino acid sequences with the BLOSUM62 matrix
aa1 <- AAString("HXBLVYMGCHFDCXVBEHIKQZ")
aa2 <- AAString("QRNYMYCFQCISGNEYKQN")
pairwiseAlignment(aa1, aa2, substitutionMatrix = "BLOSUM62", gapOpening = 3, gapExtension = 1)
## See how the gap penalty influences the alignment
pairwiseAlignment(aa1, aa2, substitutionMatrix = "BLOSUM62", gapOpening = 6, gapExtension = 2)
## See how the substitution matrix influences the alignment
pairwiseAlignment(aa1, aa2, substitutionMatrix = "BLOSUM50", gapOpening = 3, gapExtension = 1)
if (interactive()) {
## Compare our BLOSUM62 with BLOSUM62 from ftp://ftp.ncbi.nih.gov/blast/matrices/
data(BLOSUM62)
BLOSUM62["Q", "Z"]
file <- "ftp://ftp.ncbi.nih.gov/blast/matrices/BLOSUM62"
b62 <- as.matrix(read.table(file, check.names=FALSE))
b62["Q", "Z"]
}
toComplex()
Turning a DNA sequence into a vector of complex numbers
Description
The toComplex
utility function turns a DNAString object
into a complex vector.
Usage
toComplex(x, baseValues)
Arguments
Argument | Description |
---|---|
x | A DNAString object. |
baseValues | A named complex vector containing the values associated to each base e.g. c(A=1+0i, G=0+1i, T=-1+0i, C=0-1i) |
Value
A complex vector of the same length as x
.
Seealso
Author
H. Pagès
Examples
seq <- DNAString("accacctgaccattgtcct")
baseValues1 <- c(A=1+0i, G=0+1i, T=-1+0i, C=0-1i)
toComplex(seq, baseValues1)
## GC content:
baseValues2 <- c(A=0, C=1, G=1, T=0)
sum(as.integer(toComplex(seq, baseValues2)))
## Note that there are better ways to do this (see ?alphabetFrequency)
translate()
Translating DNA/RNA sequences
Description
Functions for translating DNA or RNA sequences into amino acid sequences.
Usage
## Translating DNA/RNA:
translate(x, genetic.code=GENETIC_CODE, no.init.codon=FALSE,
if.fuzzy.codon="error")
## Extracting codons without translating them:
codons(x)
Arguments
Argument | Description |
---|---|
x | A DNAStringSet , RNAStringSet , DNAString , RNAString , MaskedDNAString or MaskedRNAString object for translate . A DNAString , RNAString , MaskedDNAString or MaskedRNAString object for codons . |
genetic.code | The genetic code to use for the translation of codons into Amino Acid letters. It must be represented as a named character vector of length 64 similar to predefined constant GENETIC_CODE . More precisely: |
it must contain 1-letter strings in the Amino Acid alphabet;
its names must be identical to
names(GENETIC_CODE)
;it must have an
alt_init_codons
attribute on it, that lists the alternative initiation codons . The default value forgenetic.code
isGENETIC_CODE
, which represents The Standard Genetic Code. See?
for the Amino Acid alphabet, and?
for The Standard Genetic Code and its known variants. |no.init.codon
| By default,translate()
assumes that the first codon in a DNA or RNA sequence is the initiation codon. This means that thealt_init_codons
attribute on the suppliedgenetic.code
will be used to translate the alternative initiation codons . This can be changed by settingno.init.codon
to TRUE, in which case thealt_init_codons
attribute will be ignored. | |if.fuzzy.codon
| How fuzzy codons (i.e codon with IUPAC ambiguities) should be handled. Accepted values are: |"error"
: An error will be raised on the first occurence of a fuzzy codon. This is the default."solve"
: Fuzzy codons that can be translated non ambiguously to an amino acid or to * (stop codon) will be translated. Ambiguous fuzzy codons will be translated to X."error.if.X"
: Fuzzy codons that can be translated non ambiguously to an amino acid or to * (stop codon) will be translated. An error will be raised on the first occurence of an ambiguous fuzzy codon."X"
: All fuzzy codons (ambiguous and non-ambiguous) will be translated to X. Alternativelyif.fuzzy.codon
can be specified as a character vector of length 2 for more fine-grained control. The 1st string and 2nd strings specify how to handle non-ambiguous and ambiguous fuzzy codons, respectively. The accepted values for the 1st string are:"error"
: Any occurence of a non-ambiguous fuzzy codon will cause an error."solve"
: Non-ambiguous fuzzy codons will be translated to an amino acid or to *."X"
: Non-ambiguous fuzzy codons will be translated to X. The accepted values for the 2nd string are:"error"
: Any occurence of an ambiguous fuzzy codon will cause an error."X"
: Ambiguous fuzzy codons will be translated to X. All the 6 possible combinations of 1st and 2nd strings are supported. Note thatif.fuzzy.codon=c("error", "error")
is equivalent toif.fuzzy.codon="error"
,if.fuzzy.codon=c("solve", "X")
is equivalent toif.fuzzy.codon="solve"
,if.fuzzy.codon=c("solve", "error")
is equivalent toif.fuzzy.codon="error.if.X"
, andif.fuzzy.codon=c("X", "X")
is equivalent toif.fuzzy.codon="X"
.
Details
translate
reproduces the biological process of RNA
translation that occurs in the cell.
The input of the function can be either RNA or coding DNA.
By default The Standard Genetic Code (see ?
)
is used to translate codons into amino acids but the user can
supply a different genetic code via the genetic.code
argument.
codons
is a utility for extracting the codons involved
in this translation without translating them.
Value
For translate
: An AAString object when x
is a
DNAString , RNAString , MaskedDNAString , or
MaskedRNAString object.
An AAStringSet object parallel to x
(i.e. with 1
amino acid sequence per DNA or RNA sequence in x
) when x
is a DNAStringSet or RNAStringSet object. If x
has
names on it, they're propagated to the returned object.
For codons
: An XStringViews object with 1 view per codon.
When x
is a MaskedDNAString or MaskedRNAString object,
its masked parts are interpreted as introns and filled with the + letter
in the returned object. Therefore codons that span across masked regions
are represented by views that have a width > 3 and contain the + letter.
Note that each view is guaranteed to contain exactly 3 base letters.
Seealso
AA_ALPHABET
for the Amino Acid alphabet.GENETIC_CODE
for The Standard Genetic Code and its known variants.The examples for
extractTranscriptSeqs
in the GenomicFeatures package for computing the full proteome of a given organism.The
reverseComplement
function.The DNAStringSet and AAStringSet classes.
The XStringViews and MaskedXString classes.
Examples
## ---------------------------------------------------------------------
## 1. BASIC EXAMPLES
## ---------------------------------------------------------------------
dna1 <- DNAString("TTGATATGGCCCTTATAA")
translate(dna1)
## TTG is an alternative initiation codon in the Standard Genetic Code:
translate(dna1, no.init.codon=TRUE)
SGC1 <- getGeneticCode("SGC1") # Vertebrate Mitochondrial code
translate(dna1, genetic.code=SGC1)
## TTG is NOT an alternative initiation codon in the Vertebrate
## Mitochondrial code:
translate(dna1, genetic.code=SGC1, no.init.codon=TRUE)
## All 6 codons except 4th (CCC) are fuzzy:
dna2 <- DNAString("HTGATHTGRCCCYTRTRA")
translate(dna2) # error because of fuzzy codons
## Translate all fuzzy codons to X:
translate(dna2, if.fuzzy.codon="X")
## Or solve the non-ambiguous ones (3rd codon is ambiguous so cannot be
## solved):
translate(dna2, if.fuzzy.codon="solve")
## Fuzzy codons that are non-ambiguous with a given genetic code can
## become ambiguous with another genetic code, and vice versa:
translate(dna2, genetic.code=SGC1, if.fuzzy.codon="solve")
## ---------------------------------------------------------------------
## 2. TRANSLATING AN OPEN READING FRAME
## ---------------------------------------------------------------------
file <- system.file("extdata", "someORF.fa", package="Biostrings")
x <- readDNAStringSet(file)
x
## The first and last 1000 nucleotides are not part of the ORFs:
x <- DNAStringSet(x, start=1001, end=-1001)
## Before calling translate() on an ORF, we need to mask the introns
## if any. We can get this information fron the SGD database
## (http://www.yeastgenome.org/).
## According to SGD, the 1st ORF (YAL001C) has an intron at 71..160
## (see http://db.yeastgenome.org/cgi-bin/locus.pl?locus=YAL001C)
y1 <- x[[1]]
mask1 <- Mask(length(y1), start=71, end=160)
masks(y1) <- mask1
y1
translate(y1)
## Codons:
codons(y1)
which(width(codons(y1)) != 3)
codons(y1)[20:28]
## ---------------------------------------------------------------------
## 3. AN ADVANCED EXAMPLE
## ---------------------------------------------------------------------
## Translation on the '-' strand:
dna3 <- DNAStringSet(c("ATC", "GCTG", "CGACT"))
translate(reverseComplement(dna3))
## Translate sequences on both '+' and '-' strand across all
## possible reading frames (i.e., codon position 1, 2 or 3):
## First create a DNAStringSet of '+' and '-' strand sequences,
## removing the nucleotides prior to the reading frame start position.
dna3_subseqs <- lapply(1:3, function(pos)
subseq(c(dna3, reverseComplement(dna3)), start=pos))
## Translation of 'dna3_subseqs' produces a list of length 3, each with
## 6 elements (3 '+' strand results followed by 3 '-' strand results).
lapply(dna3_subseqs, translate)
## Note that translate() throws a warning when the length of the sequence
## is not divisible by 3. To avoid this warning wrap the function in
## suppressWarnings().
trimLRPatterns()
Trim Flanking Patterns from Sequences
Description
The trimLRPatterns
function trims left and/or right flanking patterns
from sequences.
Usage
trimLRPatterns(Lpattern = "", Rpattern = "", subject,
max.Lmismatch = 0, max.Rmismatch = 0,
with.Lindels = FALSE, with.Rindels = FALSE,
Lfixed = TRUE, Rfixed = TRUE, ranges = FALSE)
Arguments
Argument | Description |
---|---|
Lpattern | The left pattern. |
Rpattern | The right pattern. |
subject | An XString object, XStringSet object, or character vector containing the target sequence(s). |
max.Lmismatch | Either an integer vector of length nLp = nchar(Lpattern) representing an absolute number of mismatches (or edit distance if with.Lindels is TRUE ) or a single numeric value in the interval [0, 1) representing a mismatch rate when aligning terminal substrings (suffixes) of Lpattern with the beginning (prefix) of subject following the conventions set by neditStartingAt , isMatchingStartingAt , etc. When max.Lmismatch is 0L or a numeric value in the interval [0, 1) , it is taken as a "rate" and is converted to as.integer(1:nLp * max.Lmismatch) , analogous to agrep (which, however, employs ceiling ). Otherwise, max.Lmismatch is treated as an integer vector where negative numbers are used to prevent trimming at the i -th location. When an input integer vector is shorter than nLp , it is augmented with enough -1 s at the beginning to bring its length up to nLp . Elements of max.Lmismatch beyond the first nLp are ignored. Once the integer vector is constructed using the rules given above, when with.Lindels is FALSE , max.Lmismatch[i] is the number of acceptable mismatches (errors) between the suffix substring(Lpattern, nLp - i + 1, nLp) of Lpattern and the first i letters of subject . When with.Lindels is TRUE , max.Lmismatch[i] represents the allowed "edit distance" between that suffix of Lpattern and subject , starting at position 1 of subject (as in matchPattern and isMatchingStartingAt ). For a given element s of the subject , the initial segment (prefix) substring(s, 1, j) of s is trimmed if j is the largest i for which there is an acceptable match, if any. |
max.Rmismatch | Same as max.Lmismatch but with Rpattern , along with with.Rindels (below), and its initial segments (prefixes) substring(Rpattern, 1, i) . For a given element s of the subject, with nS = nchar(s) , the terminal segment (suffix) substring(s, nS - j + 1, nS) of s is trimmed if j is the largest i for which there is an acceptable match, if any. |
with.Lindels | If TRUE , indels are allowed in the alignments of the suffixes of Lpattern with the subject, at its beginning. See the with.indels arguments of the matchPattern and neditStartingAt functions for detailed information. |
with.Rindels | Same as with.Lindels but for alignments of the prefixes of Rpattern with the subject, at its end. See the with.indels arguments of the matchPattern and neditEndingAt functions for detailed information. |
Lfixed, Rfixed | Whether IUPAC extended letters in the left or right pattern should be interpreted as ambiguities (see `?`` for the details). |
ranges | If TRUE , then return the ranges to use to trim subject . If FALSE , then returned the trimmed subject . |
Value
A new XString object, XStringSet object, or character vector with the "longest" flanking matches removed, as described above.
Seealso
matchPattern
,
matchLRPatterns
,
lowlevel-matching ,
XString-class ,
XStringSet-class
Author
P. Aboyoun and H. Jaffee
Examples
Lpattern <- "TTCTGCTTG"
Rpattern <- "GATCGGAAG"
subject <- DNAString("TTCTGCTTGACGTGATCGGA")
subjectSet <- DNAStringSet(c("TGCTTGACGGCAGATCGG", "TTCTGCTTGGATCGGAAG"))
## Only allow for perfect matches on the flanks
trimLRPatterns(Lpattern = Lpattern, subject = subject)
trimLRPatterns(Rpattern = Rpattern, subject = subject)
trimLRPatterns(Lpattern = Lpattern, Rpattern = Rpattern, subject = subjectSet)
## Allow for perfect matches on the flanking overlaps
trimLRPatterns(Lpattern = Lpattern, Rpattern = Rpattern, subject = subjectSet,
max.Lmismatch = 0, max.Rmismatch = 0)
## Allow for mismatches on the flanks
trimLRPatterns(Lpattern = Lpattern, Rpattern = Rpattern, subject = subject,
max.Lmismatch = 0.2, max.Rmismatch = 0.2)
maxMismatches <- as.integer(0.2 * 1:9)
maxMismatches
trimLRPatterns(Lpattern = Lpattern, Rpattern = Rpattern, subject = subjectSet,
max.Lmismatch = maxMismatches, max.Rmismatch = maxMismatches)
## Produce ranges that can be an input into other functions
trimLRPatterns(Lpattern = Lpattern, Rpattern = Rpattern, subject = subjectSet,
max.Lmismatch = 0, max.Rmismatch = 0, ranges = TRUE)
trimLRPatterns(Lpattern = Lpattern, Rpattern = Rpattern, subject = subject,
max.Lmismatch = 0.2, max.Rmismatch = 0.2, ranges = TRUE)
xscat()
Concatenate sequences contained in XString, XStringSet and/or XStringViews objects
Description
This function mimics the semantic of paste(..., sep="")
but accepts XString , XStringSet or XStringViews
arguments and returns an XString or XStringSet object.
Usage
xscat(...)
Arguments
Argument | Description |
---|---|
list() | One or more character vectors (with no NAs), XString , XStringSet or XStringViews objects. |
Value
An XString object if all the arguments are either XString objects or character strings. An XStringSet object otherwise.
Seealso
XString-class ,
XStringSet-class ,
XStringViews-class ,
paste
Author
H. Pagès
Examples
## Return a BString object:
xscat(BString("abc"), BString("EF"))
xscat(BString("abc"), "EF")
xscat("abc", "EF")
## Return a BStringSet object:
xscat(BStringSet("abc"), "EF")
## Return a DNAStringSet object:
xscat(c("t", "a"), DNAString("N"))
## Arguments are recycled to the length of the longest argument:
res1a <- xscat("x", LETTERS, c("3", "44", "555"))
res1b <- paste0("x", LETTERS, c("3", "44", "555"))
stopifnot(identical(as.character(res1a), as.character(res1b)))
## Concatenating big XStringSet objects:
library(drosophila2probe)
probes <- DNAStringSet(drosophila2probe)
mm <- complement(narrow(probes, start=13, end=13))
left <- narrow(probes, end=12)
right <- narrow(probes, start=14)
xscat(left, mm, right)
## Collapsing an XStringSet (or XStringViews) object with a small
## number of elements:
probes1000 <- as.list(probes[1:1000])
y1 <- do.call(xscat, probes1000)
y2 <- do.call(c, probes1000) # slightly faster than the above
y1 == y2 # TRUE
## Note that this method won't be efficient when the number of
## elements to collapse is big (> 10000) so we need to provide a
## collapse() (or xscollapse()) function in Biostrings that will be
## efficient at doing this. Please request this on the Bioconductor
## mailing list (http://bioconductor.org/help/mailing-list/) if you
## need it.
yeastSEQCHR1()
An annotation data file for CHR1 in the yeastSEQ package
Description
This is a single character string containing DNA sequence of yeast chromosome number 1. The data were obtained from the Saccharomyces Genome Database ( ftp://genome-ftp.stanford.edu/pub/yeast/data_download/sequence/genomic_sequence/chromosomes/fasta/ ).
Details
Annotation based on data provided by Yeast Genome project.
Source data built:Yeast Genome data are built at various time intervals. Sources used were downloaded Fri Nov 21 14:00:47 2003 Package built: Fri Nov 21 14:00:47 2003
References
http://www.yeastgenome.org/DownloadContents.shtml
Examples
data(yeastSEQCHR1)
nchar(yeastSEQCHR1)