Title: | Plotting data and annotation information along genomic coordinates |
---|---|
Description: | Genomic data analyses requires integrated visualization of known genomic information and new experimental data. Gviz uses the biomaRt and the rtracklayer packages to perform live annotation queries to Ensembl and UCSC and translates this to e.g. gene/transcript structures in viewports of the grid graphics package. This results in genomic information plotted together with your data. |
Authors: | Florian Hahne [aut], Steffen Durinck [aut], Robert Ivanek [aut, cre] , Arne Mueller [aut], Steve Lianoglou [aut], Ge Tan [aut], Lance Parsons [aut], Shraddha Pai [aut], Thomas McCarthy [ctb], Felix Ernst [ctb], Mike Smith [ctb] |
Maintainer: | Robert Ivanek <[email protected]> |
License: | Artistic-2.0 |
Version: | 1.51.0 |
Built: | 2024-10-30 07:29:23 UTC |
Source: | https://github.com/bioc/Gviz |
A class to represent short sequences that have been aligned to a reference genome as they are typically generated in next generation sequencing experiments.
## S4 method for signature 'AlignmentsTrack' initialize( .Object, stackRanges = GRanges(), stacks = numeric(), sequences = DNAStringSet(), referenceSequence = NULL, ... ) ## S4 method for signature 'ReferenceAlignmentsTrack' initialize( .Object, stream, reference, mapping = list(), args = list(), defaults = list(), stacks = numeric(), stackRanges = GRanges(), sequences = Biostrings::DNAStringSet(), referenceSequence = NULL, ... ) AlignmentsTrack( range = NULL, start = NULL, end = NULL, width = NULL, strand, chromosome, genome, stacking = "squish", id, cigar, mapq, flag = scanBamFlag(isUnmappedQuery = FALSE), isize, groupid, status, md, seqs, name = "AlignmentsTrack", isPaired = TRUE, importFunction, referenceSequence, ... ) ## S4 method for signature 'AlignmentsTrack' values(x) ## S4 replacement method for signature 'AlignmentsTrack' chromosome(GdObject) <- value ## S4 method for signature 'AlignmentsTrack' stacks(GdObject) ## S4 method for signature 'AlignmentsTrack' setStacks(GdObject, ...) ## S4 method for signature 'AlignmentsTrack' subset(x, from = NULL, to = NULL, stacks = FALSE, use.defaults = TRUE, ...) ## S4 method for signature 'ReferenceAlignmentsTrack' subset(x, from, to, chromosome, ...) ## S4 method for signature 'AlignmentsTrack' drawAxis(GdObject, ...) ## S4 method for signature 'AlignmentsTrack' drawGD(GdObject, minBase, maxBase, prepare = FALSE, subset = TRUE, ...) ## S4 method for signature 'AlignmentsTrack' show(object) ## S4 method for signature 'ReferenceAlignmentsTrack' show(object)
## S4 method for signature 'AlignmentsTrack' initialize( .Object, stackRanges = GRanges(), stacks = numeric(), sequences = DNAStringSet(), referenceSequence = NULL, ... ) ## S4 method for signature 'ReferenceAlignmentsTrack' initialize( .Object, stream, reference, mapping = list(), args = list(), defaults = list(), stacks = numeric(), stackRanges = GRanges(), sequences = Biostrings::DNAStringSet(), referenceSequence = NULL, ... ) AlignmentsTrack( range = NULL, start = NULL, end = NULL, width = NULL, strand, chromosome, genome, stacking = "squish", id, cigar, mapq, flag = scanBamFlag(isUnmappedQuery = FALSE), isize, groupid, status, md, seqs, name = "AlignmentsTrack", isPaired = TRUE, importFunction, referenceSequence, ... ) ## S4 method for signature 'AlignmentsTrack' values(x) ## S4 replacement method for signature 'AlignmentsTrack' chromosome(GdObject) <- value ## S4 method for signature 'AlignmentsTrack' stacks(GdObject) ## S4 method for signature 'AlignmentsTrack' setStacks(GdObject, ...) ## S4 method for signature 'AlignmentsTrack' subset(x, from = NULL, to = NULL, stacks = FALSE, use.defaults = TRUE, ...) ## S4 method for signature 'ReferenceAlignmentsTrack' subset(x, from, to, chromosome, ...) ## S4 method for signature 'AlignmentsTrack' drawAxis(GdObject, ...) ## S4 method for signature 'AlignmentsTrack' drawGD(GdObject, minBase, maxBase, prepare = FALSE, subset = TRUE, ...) ## S4 method for signature 'AlignmentsTrack' show(object) ## S4 method for signature 'ReferenceAlignmentsTrack' show(object)
.Object |
.Object |
stackRanges |
stackRanges |
stacks |
stacks |
sequences |
sequences |
referenceSequence |
An optional |
... |
Additional items which will all be interpreted as further
display parameters. See |
stream |
stream |
reference |
reference |
mapping |
mapping |
args |
args |
defaults |
defaults |
range |
An optional meta argument to handle the different input types.
If the The different input options for
|
start , end , width
|
Integer vectors, giving the start and the end coordinates for the individual track items, or their width. Two of the three need to be specified, and have to be of equal length or of length one, in which case this single value will be recycled. Otherwise, the usual R recycling rules for vectors do not apply here. |
strand |
Character vector, the strand information for the reads. It may
be provided in the form |
chromosome |
The chromosome on which the track's genomic ranges are
defined. A valid UCSC chromosome identifier if
|
genome |
The genome on which the track's ranges are defined. Usually
this is a valid UCSC genome identifier, however this is not being formally
checked at this point. If not provided here the constructor will try to
extract this information from the provided input, and eventually will fall
back to the default value of |
stacking |
The stacking type for overlapping items of the track. One in
|
id |
Character vector of read identifiers. Those identifiers have to be
unique, i.e., each range representing a read needs to have a unique
|
cigar |
A character vector of valid CIGAR strings describing details of the alignment. Typically those include alignment gaps or insertions and deletions, but also hard and soft clipped read regions. If missing, a fully mapped read without gaps or indels is assumed. Needs to be of equal length as the provided genomic coordinates, or of length 1. |
mapq |
A numeric vector of read mapping qualities. Needs to be of equal length as the provided genomic coordinates, or of length 1. |
flag |
A named integer vector of length 2, as is produced by Rsamtools::scanBamFlag(), used to filter out undesirable reads. If missing, all mapped reads will be included. |
isize |
A numeric vector of empirical insert sizes. This only applies if the reads are paired. Needs to be of equal length as the provided genomic coordinates, or of length 1. Currently not used. |
groupid |
A factor (or vector than can be coerced into one) defining
the read pairs. Reads with the same |
status |
A factor describing the mapping status of a read. Has to be
one in |
md |
A character vector describing the mapping details. This is effectively and alternative to the CIGAR encoding and it removes the dependency on a reference sequence to figure out read mismatches. Needs to be of equal length as the provided genomic coordinates, or of length 1. Currently not used. |
seqs |
|
name |
Character scalar of the track's name used in the title panel when plotting. |
isPaired |
A logical scalar to determine whether the reads are paired
or not. While this may be used to render paired-end data as single-end, the
oppsite will typically not have any effect because the appropriate
|
importFunction |
A user-defined function to be used to import the data
from a file. This only applies when the |
x |
x |
GdObject |
Object of |
value |
value |
from , to
|
from,to |
use.defaults |
|
minBase , maxBase
|
minBase,maxBase |
prepare |
|
subset |
|
object |
object |
The return value of the constructor function is a new object of class
AlignmentsTrack
or ReferenceAlignmentsTrack
.
initialize(AlignmentsTrack)
: Initialize.
ReferenceAlignmentsTrack-class
: The file-based version of the AlignmentsTrack-class
.
initialize(ReferenceAlignmentsTrack)
: Initialize.
AlignmentsTrack()
: Constructor for AlignmentsTrack-class
.
values(AlignmentsTrack)
: Return all additional annotation
information except for the genomic coordinates for the track items as
a data.frame
.
chromosome(AlignmentsTrack) <- value
: replace the value of the track's chromosome.
This has to be a valid UCSC chromosome identifier or an integer or character
scalar that can be reasonably coerced into one.
stacks(AlignmentsTrack)
: return the stack indices for each track item.
setStacks(AlignmentsTrack)
: recompute the stacks based on the available
space and on the object's track items and stacking settings.
subset(AlignmentsTrack)
: Subset a AlignmentsTrack
by coordinates
and sort if necessary.
subset(ReferenceAlignmentsTrack)
: Subset a ReferenceAlignmentsTrack
by coordinates
and sort if necessary.
drawAxis(AlignmentsTrack)
: add a y-axis to the title panel of a track.
drawGD(AlignmentsTrack)
: plot the object to a graphics device.
The return value of this method is the input object, potentially updated
during the plotting operation. Internally, there are two modes in which the
method can be called. Either in 'prepare' mode, in which case no plotting is
done but the object is preprocessed based on the available space, or in
'plotting' mode, in which case the actual graphical output is created.
Since subsetting of the object can be potentially costly, this can be
switched off in case subsetting has already been performed before or
is not necessary.
show(AlignmentsTrack)
: Show method.
show(ReferenceAlignmentsTrack)
: Show method.
Objects can be created using the constructor function
AlignmentsTrack
.
Florian Hahne
## Creating objects afrom <- 2960000 ato <- 3160000 alTrack <- AlignmentsTrack(system.file( package = "Gviz", "extdata", "gapped.bam" ), isPaired = TRUE) plotTracks(alTrack, from = afrom, to = ato, chromosome = "chr12") ## Omit the coverage or the pile-ups part plotTracks(alTrack, from = afrom, to = ato, chromosome = "chr12", type = "coverage" ) plotTracks(alTrack, from = afrom, to = ato, chromosome = "chr12", type = "pileup" ) ## Including sequence information with the constructor if (require(BSgenome.Hsapiens.UCSC.hg19)) { strack <- SequenceTrack(Hsapiens, chromosome = "chr21") afrom <- 44945200 ato <- 44947200 alTrack <- AlignmentsTrack(system.file( package = "Gviz", "extdata", "snps.bam" ), isPaired = TRUE, referenceSequence = strack) plotTracks(alTrack, chromosome = "chr21", from = afrom, to = ato) ## Including sequence information in the track list alTrack <- AlignmentsTrack(system.file( package = "Gviz", "extdata", "snps.bam" ), isPaired = TRUE) plotTracks(c(alTrack, strack), chromosome = "chr21", from = 44946590, to = 44946660 ) }
## Creating objects afrom <- 2960000 ato <- 3160000 alTrack <- AlignmentsTrack(system.file( package = "Gviz", "extdata", "gapped.bam" ), isPaired = TRUE) plotTracks(alTrack, from = afrom, to = ato, chromosome = "chr12") ## Omit the coverage or the pile-ups part plotTracks(alTrack, from = afrom, to = ato, chromosome = "chr12", type = "coverage" ) plotTracks(alTrack, from = afrom, to = ato, chromosome = "chr12", type = "pileup" ) ## Including sequence information with the constructor if (require(BSgenome.Hsapiens.UCSC.hg19)) { strack <- SequenceTrack(Hsapiens, chromosome = "chr21") afrom <- 44945200 ato <- 44947200 alTrack <- AlignmentsTrack(system.file( package = "Gviz", "extdata", "snps.bam" ), isPaired = TRUE, referenceSequence = strack) plotTracks(alTrack, chromosome = "chr21", from = afrom, to = ato) ## Including sequence information in the track list alTrack <- AlignmentsTrack(system.file( package = "Gviz", "extdata", "snps.bam" ), isPaired = TRUE) plotTracks(c(alTrack, strack), chromosome = "chr21", from = 44946590, to = 44946660 ) }
A class allow for on-demand streaming of data off the file system.
availableDefaultMapping(file, trackType) ## S4 method for signature 'ReferenceTrack' initialize( .Object, stream, reference, mapping = list(), args = list(), defaults = list() )
availableDefaultMapping(file, trackType) ## S4 method for signature 'ReferenceTrack' initialize( .Object, stream, reference, mapping = list(), args = list(), defaults = list() )
file |
A |
trackType |
A |
.Object |
.Object |
stream |
stream |
reference |
reference |
mapping |
mapping |
args |
ars |
defaults |
defaults |
The availableDefaultMappings
function can be used to find out whether
the package defines a mapping scheme between one of the many supported input
file types and the metadata columns of the tracks' GRanges
objects.
Constructor functions of AnnotationTrack
, DataTrack
, SequenceTrack
and AlignmentsTrack`` can create a special object of corresponding
Reference*Track' subclass with pointer to the referenced
file.
A virtual class: No objects may be created from it.
availableDefaultMapping()
: Function to find out whether the package
defines a mapping scheme between one of the many supported input file types
and the metadata columns of the tracks's GRanges
objects.
initialize(ReferenceTrack)
: Initialize.
stream
Object of class function. The import function to stream data
of the file system. Needs to be able to handle the two mandatory arguments
file
(a character
containing a valid file path) and selection
(a GRanges
object with the genomic region to plot).
reference
Object of class "character", the path to the file containing the data.
mapping
Object of class list
, a default mapping between the
metadata columns of the returned GRanges
object from the import function
and the elemenMetadata
columns that make up the final track object.
args
Object of class list
, the passed in constructor arguments
during object instantiation. Those will be needed when fetching the data
in order to fill all necessary slots.
defaults
Object of class list
, the relevant default values to be
used when neither mapping nor args provides the necessary information.
Florian Hahne
# This is a reference class, below example from AlignmentsTrack afrom <- 2960000 ato <- 3160000 alTrack <- AlignmentsTrack(system.file( package = "Gviz", "extdata", "gapped.bam" ), isPaired = TRUE) plotTracks(alTrack, from = afrom, to = ato, chromosome = "chr12")
# This is a reference class, below example from AlignmentsTrack afrom <- 2960000 ato <- 3160000 alTrack <- AlignmentsTrack(system.file( package = "Gviz", "extdata", "gapped.bam" ), isPaired = TRUE) plotTracks(alTrack, from = afrom, to = ato, chromosome = "chr12")
A class to hold gene model data for a genomic region fetched dynamically from EBI's Biomart Ensembl data source.
## S4 method for signature 'BiomartGeneRegionTrack' initialize( .Object, start = NULL, end = NULL, biomart, filter = list(), range, genome = NULL, chromosome = NULL, strand = NULL, featureMap = NULL, symbol = NULL, gene = NULL, transcript = NULL, entrez = NULL, ... ) BiomartGeneRegionTrack( start = NULL, end = NULL, biomart, chromosome = NULL, strand, genome = NULL, stacking = "squish", filters = list(), featureMap = NULL, name = "BiomartGeneRegionTrack", symbol = NULL, gene = NULL, entrez = NULL, transcript = NULL, ... ) ## S4 method for signature 'BiomartGeneRegionTrack' subset(x, from, to, chromosome, use.defaults = TRUE, ...)
## S4 method for signature 'BiomartGeneRegionTrack' initialize( .Object, start = NULL, end = NULL, biomart, filter = list(), range, genome = NULL, chromosome = NULL, strand = NULL, featureMap = NULL, symbol = NULL, gene = NULL, transcript = NULL, entrez = NULL, ... ) BiomartGeneRegionTrack( start = NULL, end = NULL, biomart, chromosome = NULL, strand, genome = NULL, stacking = "squish", filters = list(), featureMap = NULL, name = "BiomartGeneRegionTrack", symbol = NULL, gene = NULL, entrez = NULL, transcript = NULL, ... ) ## S4 method for signature 'BiomartGeneRegionTrack' subset(x, from, to, chromosome, use.defaults = TRUE, ...)
.Object |
.Object |
start |
An integer scalar with the genomic start coordinates for the gene model range. |
end |
An integer scalar with the genomic end coordinates for the gene model range. |
biomart |
An optional |
filter |
filter |
range |
range |
genome |
The genome on which the track's ranges are defined. Usually
this is a valid UCSC genome identifier, however this is not being formally
checked at this point. If no mapping from genome to Biomart Ensembl data
source is possible, the |
chromosome |
The chromosome on which the track's genomic ranges are
defined. A valid UCSC chromosome identifier. Please note that at this stage
only syntactic checking takes place, i.e., the argument value needs to be a
single integer, numeric character or a character of the form |
strand |
Character scalar, the strand for which to fetch gene
information from Biomart. One in |
featureMap |
Named character vector or list to map between the fields in the Biomart data base and the features as they are used to construct the track. If multiple values are provided in a single list item, the package will use the first one that is defined in the selected Biomart. |
symbol , transcript , gene , entrez
|
Character vector giving one or several gene symbols, Ensembl transcript identifiers, Ensembl gene identifiers, or ENTREZ gene identifiers, respectively. The genomic locus of their gene model will be fetch from Biomart instead of providing explicit start and end coordinates. |
... |
Additional items which will all be interpreted as further
display parameters. See |
stacking |
The stacking type for overlapping items of the track. One in
|
filters |
A list of additional filters to be applied in the Biomart
query. See |
name |
Character scalar of the track's name used in the title panel when plotting. |
x |
A valid track object class name, or the object itself, in which case the class is derived directly from it. |
from , to
|
from, to |
use.defaults |
|
A track containing all gene models in a particular region as fetched from
EBI's Biomart service. Usually the user does not have to take care of the
Biomart connection, which will be established automatically based on the
provided genome and chromosome information. However, for full flexibility a
valid Mart
object may be passed on to the constructor.
Please note that this assumes a connection to one of the Ensembl gene data
sources, mapping the available query data back to the internal object slots.
The return value of the constructor function is a new object of class
BiomartGeneRegionTrack
.
initialize(BiomartGeneRegionTrack)
: Initialize.
BiomartGeneRegionTrack()
: Constructor function for
BiomartGeneRegionTrack-class
.
subset(BiomartGeneRegionTrack)
: subset a BiomartGeneRegionTrack
by coordinates and sort if necessary.
Objects can be created using the constructor function
BiomartGeneRegionTrack
.
Florian Hahne
EBI Biomart webservice at http://www.biomart.org.
## Construct the object ## Not run: bmTrack <- BiomartGeneRegionTrack( start = 26682683, end = 26711643, chromosome = 7, genome = "mm9" ) ## End(Not run) ## Plotting plotTracks(bmTrack) ## Track names names(bmTrack) names(bmTrack) <- "foo" plotTracks(bmTrack) ## Subsetting and splitting subTrack <- subset(bmTrack, from = 26700000, to = 26705000) length(subTrack) subTrack <- bmTrack[transcript(bmTrack) == "ENSMUST00000144140"] split(bmTrack, transcript(bmTrack)) ## Accessors start(bmTrack) end(bmTrack) width(bmTrack) position(bmTrack) width(subTrack) <- width(subTrack) + 100 strand(bmTrack) strand(subTrack) <- "-" chromosome(bmTrack) chromosome(subTrack) <- "chrX" genome(bmTrack) genome(subTrack) <- "hg19" range(bmTrack) ranges(bmTrack) ## Annotation identifier(bmTrack) identifier(bmTrack, "lowest") identifier(subTrack) <- "bar" feature(bmTrack) feature(subTrack) <- "foo" exon(bmTrack) exon(subTrack) <- letters[1:2] gene(bmTrack) gene(subTrack) <- "bar" symbol(bmTrack) symbol(subTrack) <- "foo" transcript(bmTrack) transcript(subTrack) <- c("foo", "bar") chromosome(subTrack) <- "chr7" plotTracks(subTrack) values(bmTrack) ## Grouping group(bmTrack) group(subTrack) <- "Group 1" transcript(subTrack) plotTracks(subTrack) ## Stacking stacking(bmTrack) stacking(bmTrack) <- "dense" plotTracks(bmTrack) ## coercion as(bmTrack, "data.frame") as(bmTrack, "UCSCData") ## HTML image map coords(bmTrack) tags(bmTrack) bmTrack <- plotTracks(bmTrack)$foo coords(bmTrack) tags(bmTrack)
## Construct the object ## Not run: bmTrack <- BiomartGeneRegionTrack( start = 26682683, end = 26711643, chromosome = 7, genome = "mm9" ) ## End(Not run) ## Plotting plotTracks(bmTrack) ## Track names names(bmTrack) names(bmTrack) <- "foo" plotTracks(bmTrack) ## Subsetting and splitting subTrack <- subset(bmTrack, from = 26700000, to = 26705000) length(subTrack) subTrack <- bmTrack[transcript(bmTrack) == "ENSMUST00000144140"] split(bmTrack, transcript(bmTrack)) ## Accessors start(bmTrack) end(bmTrack) width(bmTrack) position(bmTrack) width(subTrack) <- width(subTrack) + 100 strand(bmTrack) strand(subTrack) <- "-" chromosome(bmTrack) chromosome(subTrack) <- "chrX" genome(bmTrack) genome(subTrack) <- "hg19" range(bmTrack) ranges(bmTrack) ## Annotation identifier(bmTrack) identifier(bmTrack, "lowest") identifier(subTrack) <- "bar" feature(bmTrack) feature(subTrack) <- "foo" exon(bmTrack) exon(subTrack) <- letters[1:2] gene(bmTrack) gene(subTrack) <- "bar" symbol(bmTrack) symbol(subTrack) <- "foo" transcript(bmTrack) transcript(subTrack) <- c("foo", "bar") chromosome(subTrack) <- "chr7" plotTracks(subTrack) values(bmTrack) ## Grouping group(bmTrack) group(subTrack) <- "Group 1" transcript(subTrack) plotTracks(subTrack) ## Stacking stacking(bmTrack) stacking(bmTrack) <- "dense" plotTracks(bmTrack) ## coercion as(bmTrack, "data.frame") as(bmTrack, "UCSCData") ## HTML image map coords(bmTrack) tags(bmTrack) bmTrack <- plotTracks(bmTrack)$foo coords(bmTrack) tags(bmTrack)
When plotting features linearly along genomic coordinates one frequently runs into the problem of too little resolution to adequately display all details. Most genome browsers try to reasonably reduce the amount of detail that is shown based on the current zoom level.
Most track classes in this package define an internal collapseTrack
method which tries to adjust the plotted content to the available
resolution, aims at reducing over-plotting and prevents rendering issues,
e.g. when lines are too thin to be plotted. This feature can be toggled on
or off using the collapse
display parameter (see
settings
for details on setting these parameters).
In the simplest case (for AnnotationTrack
objects) this
involves expanding all shown features to a minimum pixel width and height
(using display parameters min.width
and min.heigh
) and
collapsing overlapping annotation items (as defined by the parameter
min.distance
into one single item to prevent over-plotting.
For objects of class DataTrack
, the data values
underlying collapsed regions will be summarized based on the summary
display parameter. See the class' documentation for more details.
A fully customizable track object to be populated via a user-defined plotting function.
## S4 method for signature 'CustomTrack' initialize(.Object, plottingFunction, variables, ...) CustomTrack( plottingFunction = function(GdObject, prepare = FALSE, ...) { }, variables = list(), name = "CustomTrack", ... ) ## S4 method for signature 'CustomTrack' drawGD(GdObject, minBase, maxBase, prepare = FALSE, ...) ## S4 method for signature 'CustomTrack' show(object)
## S4 method for signature 'CustomTrack' initialize(.Object, plottingFunction, variables, ...) CustomTrack( plottingFunction = function(GdObject, prepare = FALSE, ...) { }, variables = list(), name = "CustomTrack", ... ) ## S4 method for signature 'CustomTrack' drawGD(GdObject, minBase, maxBase, prepare = FALSE, ...) ## S4 method for signature 'CustomTrack' show(object)
.Object |
.Object |
plottingFunction |
A user-defined function to be executed once the
track coordinates have been properly set up. The function needs to accept
two mandatory arguments: |
variables |
A list of additional variables for the user-defined plotting function. |
... |
Additional items which will all be interpreted as further
display parameters. See |
name |
Character scalar of the track's name. |
GdObject |
Object of |
minBase |
minBase |
maxBase |
maxBase |
prepare |
|
object |
object |
A track to allow for any sort of plotting, with the currently displayed
genomic location set. Essentially this acts as a simple callback into the
Gviz
plotting machinery after all the track panels and coordinates
have been set up. It is entirely up to the user what to plot in the track,
or even to use the predefined coordinate system. The only prerequisite is
that all plotting operations need to utilize Grid graphics.
The return value of the constructor function is a new object of class
CustomTrack
.
initialize(CustomTrack)
: Initialize.
CustomTrack()
: Objects can be created using the constructor function.
drawGD(CustomTrack)
: plot the object to a graphics device.
The return value of this method is the input object, potentially updated
during the plotting operation. Internally, there are two modes in which the
method can be called. Either in 'prepare' mode, in which case no plotting is
done but the object is preprocessed based on the available space, or in
'plotting' mode, in which case the actual graphical output is created.
Since subsetting of the object can be potentially costly, this can be
switched off in case subsetting has already been performed before or
is not necessary.
show(CustomTrack)
: Show method.
Florian Hahne
## Object construction: ## An empty object CustomTrack()
## Object construction: ## An empty object CustomTrack()
All tracks within this package are highly customizable. The
DisplayPars
class facilitates this and provides a unified API to the
customization parameters.
The individual parameters in a DisplayParameters
class are stored as
pointers in an environment. This has the upshot of not having to copy the
whole track object when changing parameters, and parameters can be updated
without the need to explicitly reassign the track to a symbol (i.e.,
updating of parameters happens in place). The downside is that upon copying
of track objects, the parameter environment needs to be re-instantiated.
Objects can be created using the constructor function DisplayPars
.
The default display parameters for a track object class can be queried using
the availableDisplayPars
function.
DisplayPars(...) getPar(x, name, ...) ## S4 method for signature 'DisplayPars,character' getPar(x, name, asIs = FALSE) ## S4 method for signature 'DisplayPars,missing' getPar(x, hideInternal = TRUE) displayPars(x, name, ...) ## S4 method for signature 'DisplayPars,missing' displayPars(x, hideInternal = TRUE) ## S4 method for signature 'DisplayPars,character' displayPars(x, name) ## S4 method for signature 'DisplayPars' as.list(x) setPar(x, value, ...) ## S4 method for signature 'DisplayPars,list' setPar(x, value, interactive = TRUE) ## S4 method for signature 'DisplayPars,character' setPar(x, name, value, interactive = TRUE) displayPars(x, recursive = FALSE) <- value ## S4 replacement method for signature 'DisplayPars,list' displayPars(x, recursive = FALSE) <- value ## S4 method for signature 'DisplayPars' show(object) ## S4 method for signature 'InferredDisplayPars' as.list(x) ## S4 method for signature 'InferredDisplayPars' show(object) availableDisplayPars(class)
DisplayPars(...) getPar(x, name, ...) ## S4 method for signature 'DisplayPars,character' getPar(x, name, asIs = FALSE) ## S4 method for signature 'DisplayPars,missing' getPar(x, hideInternal = TRUE) displayPars(x, name, ...) ## S4 method for signature 'DisplayPars,missing' displayPars(x, hideInternal = TRUE) ## S4 method for signature 'DisplayPars,character' displayPars(x, name) ## S4 method for signature 'DisplayPars' as.list(x) setPar(x, value, ...) ## S4 method for signature 'DisplayPars,list' setPar(x, value, interactive = TRUE) ## S4 method for signature 'DisplayPars,character' setPar(x, name, value, interactive = TRUE) displayPars(x, recursive = FALSE) <- value ## S4 replacement method for signature 'DisplayPars,list' displayPars(x, recursive = FALSE) <- value ## S4 method for signature 'DisplayPars' show(object) ## S4 method for signature 'InferredDisplayPars' as.list(x) ## S4 method for signature 'InferredDisplayPars' show(object) availableDisplayPars(class)
... |
All named arguments are stored in the object's environment as individual parameters, regardless of their type. |
x |
object to set the displayPar value on |
name |
Name of the retrieved parameter. |
asIs |
|
hideInternal |
|
value |
named value to be set |
interactive |
|
recursive |
|
object |
object |
class |
Either character scalar or object. Supported classes are:
|
The return value of the constructor function is a new object of class
DisplayPars
.
availableDisplayPars
returns a list of the default display
parameters.
DisplayPars()
: Constructor function.
getPar()
: Generics for getPar
.
getPar(x = DisplayPars, name = character)
: Alias for the displayPars
method.
getPar(x = DisplayPars, name = missing)
: Alias for the displayPars
method.
displayPars()
: Generics for displayPars
.
displayPars(x = DisplayPars, name = missing)
: Returns all available display parameters.
displayPars(x = DisplayPars, name = character)
: Returns the value of a subset of display parameters, as identified by name
.
as.list(DisplayPars)
: Converts DisplayPars
to list
.
setPar()
: Generics for SetPar
.
SetPar generic function
setPar(x = DisplayPars, value = list)
: Sets display parameters by the values of the
named list
in value. Note that display parameters in the DisplayPars-class
are pass-by-reference, so no re-assignment to the symbol obj
is necessary.
setPar(x = DisplayPars, value = character)
: set the single display parameter name to value.
Note that display parameters in the DisplayPars class are pass-by-reference,
so no re-assignment to the symbol obj
is necessary.
displayPars(x, recursive = FALSE) <- value
: Generics for displayPars<-
.
displayPars(x = DisplayPars) <- value
: Replaces or adds display parameters as provided by the named list
items.
show(DisplayPars)
: Show method.
as.list(InferredDisplayPars)
: Return InferredDisplayPars
as a list
.
show(InferredDisplayPars)
: Show method.
availableDisplayPars()
: Get default display parameters.
pars
an environment or a list containing parameter key value pairs.
Florian Hahne
## Construct object dp <- DisplayPars(col = "red", lwd = 2, transformation = log2) dp ## Query parameters displayPars(dp) displayPars(dp, "col") getPar(dp, c("col", "transformation")) ## Modify parameters displayPars(dp) <- list(lty = 1, fontsize = 3) setPar(dp, "pch", 20) dp ## Default parameters availableDisplayPars("GenomeAxisTrack")
## Construct object dp <- DisplayPars(col = "red", lwd = 2, transformation = log2) dp ## Query parameters displayPars(dp) displayPars(dp, "col") getPar(dp, c("col", "transformation")) ## Modify parameters displayPars(dp) <- list(lty = 1, fontsize = 3) setPar(dp, "pch", 20) dp ## Default parameters availableDisplayPars("GenomeAxisTrack")
This function is still a bit experimental. Write all tracks provided as a
list tracks
into a single BED file. So far only BED export is supported.
exportTracks(tracks, range, chromosome, file)
exportTracks(tracks, range, chromosome, file)
tracks |
A list of annotation track objects to be exported into a single BED file. |
range |
A numeric vector or length 2. The genomic range to display when opening the file in a browser. |
chromosome |
The chromosome to display when opening the file in a browser. |
file |
Character, the path to the file to write into. |
The function is called for its side effect of writing to a file.
Florian Hahne
## export AnnotationTrack to BED file at <- AnnotationTrack(start = seq(1, 10), width = 1, chromosome = "chr1") exportTracks(list(at), range = c(1, 10), chromosome = "chr1", file = paste0(tempfile(), ".bed") )
## export AnnotationTrack to BED file at <- AnnotationTrack(start = seq(1, 10), width = 1, chromosome = "chr1") exportTracks(list(at), range = c(1, 10), chromosome = "chr1", file = paste0(tempfile(), ".bed") )
A class to hold gene model data for a genomic region.
## S4 method for signature 'GeneRegionTrack' initialize(.Object, start, end, ...) ## S4 method for signature 'ReferenceGeneRegionTrack' initialize( .Object, stream, reference, mapping = list(), args = list(), defaults = list(), ... ) GeneRegionTrack( range = NULL, rstarts = NULL, rends = NULL, rwidths = NULL, strand, feature, exon, transcript, gene, symbol, chromosome, genome, stacking = "squish", name = "GeneRegionTrack", start = NULL, end = NULL, importFunction, stream = FALSE, ... ) ## S4 method for signature 'GeneRegionTrack' gene(GdObject) ## S4 replacement method for signature 'GeneRegionTrack,character' gene(GdObject) <- value ## S4 method for signature 'GeneRegionTrack' symbol(GdObject) ## S4 replacement method for signature 'GeneRegionTrack,character' symbol(GdObject) <- value ## S4 method for signature 'GeneRegionTrack' transcript(GdObject) ## S4 replacement method for signature 'GeneRegionTrack,character' transcript(GdObject) <- value ## S4 method for signature 'GeneRegionTrack' exon(GdObject) ## S4 replacement method for signature 'GeneRegionTrack,character' exon(GdObject) <- value ## S4 method for signature 'GeneRegionTrack' group(GdObject) ## S4 replacement method for signature 'GeneRegionTrack,character' group(GdObject) <- value ## S4 method for signature 'GeneRegionTrack' identifier( GdObject, type = .dpOrDefault(GdObject, "transcriptAnnotation", "symbol") ) ## S4 replacement method for signature 'GeneRegionTrack,character' identifier(GdObject) <- value ## S4 method for signature 'ReferenceGeneRegionTrack' subset(x, ...) ## S4 method for signature 'GeneRegionTrack' drawGD(GdObject, ...) ## S4 method for signature 'GeneRegionTrack' show(object) ## S4 method for signature 'ReferenceGeneRegionTrack' show(object)
## S4 method for signature 'GeneRegionTrack' initialize(.Object, start, end, ...) ## S4 method for signature 'ReferenceGeneRegionTrack' initialize( .Object, stream, reference, mapping = list(), args = list(), defaults = list(), ... ) GeneRegionTrack( range = NULL, rstarts = NULL, rends = NULL, rwidths = NULL, strand, feature, exon, transcript, gene, symbol, chromosome, genome, stacking = "squish", name = "GeneRegionTrack", start = NULL, end = NULL, importFunction, stream = FALSE, ... ) ## S4 method for signature 'GeneRegionTrack' gene(GdObject) ## S4 replacement method for signature 'GeneRegionTrack,character' gene(GdObject) <- value ## S4 method for signature 'GeneRegionTrack' symbol(GdObject) ## S4 replacement method for signature 'GeneRegionTrack,character' symbol(GdObject) <- value ## S4 method for signature 'GeneRegionTrack' transcript(GdObject) ## S4 replacement method for signature 'GeneRegionTrack,character' transcript(GdObject) <- value ## S4 method for signature 'GeneRegionTrack' exon(GdObject) ## S4 replacement method for signature 'GeneRegionTrack,character' exon(GdObject) <- value ## S4 method for signature 'GeneRegionTrack' group(GdObject) ## S4 replacement method for signature 'GeneRegionTrack,character' group(GdObject) <- value ## S4 method for signature 'GeneRegionTrack' identifier( GdObject, type = .dpOrDefault(GdObject, "transcriptAnnotation", "symbol") ) ## S4 replacement method for signature 'GeneRegionTrack,character' identifier(GdObject) <- value ## S4 method for signature 'ReferenceGeneRegionTrack' subset(x, ...) ## S4 method for signature 'GeneRegionTrack' drawGD(GdObject, ...) ## S4 method for signature 'GeneRegionTrack' show(object) ## S4 method for signature 'ReferenceGeneRegionTrack' show(object)
.Object |
.Object |
start , end
|
An integer scalar with the genomic start or end coordinate
for the gene model range. If those are missing, the default value will
automatically be the smallest (or largest) value, respectively in
|
... |
Additional items which will all be interpreted as further
display parameters. See |
stream |
A logical flag indicating that the user-provided import
function can deal with indexed files and knows how to process the additional
|
reference |
reference file |
mapping |
mapping |
args |
args |
defaults |
|
range |
An optional meta argument to handle the different input types. If the
The different input options for
|
rstarts |
An integer vector of the start coordinates for the actual
gene model items, i.e., for the individual exons. The relationship between
exons is handled via the |
rends |
An integer vector of the end coordinates for the actual gene
model items. Both |
rwidths |
An integer vector of widths for the actual gene model items.
This can be used instead of either |
strand |
Character vector, the strand information for the individual
track exons. It may be provided in the form |
feature |
Factor (or other vector that can be coerced into one), giving
the feature types for the individual track exons. When plotting the track
to the device, if a display parameter with the same name as the value of
|
exon |
Character vector of exon identifiers. It's values will be used
as the identifier tag when plotting to the device if the display parameter
|
transcript |
Factor (or other vector that can be coerced into one),
giving the transcript memberships for the individual track exons. All items
with the same transcript identifier will be visually connected when plotting
to the device. See |
gene |
Factor (or other vector that can be coerced into one), giving the gene memberships for the individual track exons. |
symbol |
A factor with human-readable gene name aliases which will be
used as labels when |
chromosome |
The chromosome on which the track's genomic ranges are
defined. A valid UCSC chromosome identifier if
|
genome |
The genome on which the track's ranges are defined. Usually
this is a valid UCSC genome identifier, however this is not being formally
checked at this point. If not provided here the constructor will try to
extract this information from the provided inputs, and eventually will fall
back to the default value of |
stacking |
The stacking type for overlapping items of the track. One in
|
name |
Character scalar of the track's name used in the title panel when plotting. |
importFunction |
A user-defined function to be used to import the data
from a file. This only applies when the |
GdObject |
Object of |
value |
Value to be set. |
type |
type |
x |
A valid track object class name, or the object itself, in which case the class is derived directly from it. |
object |
object |
A track containing all gene models in a particular region. The data are
usually fetched dynamially from an online data store, but it is also
possible to manully construct objects from local data. Connections to
particular online data sources should be implemented as sub-classes, and
GeneRegionTrack
is just the commone denominator that is being used
for plotting later on. There are several levels of data associated to a
GeneRegionTrack
:
identifiers are stored in the exon column of the
GRanges
object in the range
slot. Data may be
extracted using the exon
method.
identifiers are stored in the transcript column of
the GRanges
object. Data may be extracted using the
transcript
method.
identifiers are stored in the gene column of the
GRanges
object, more human-readable versions in the
symbol column. Data may be extracted using the gene
or the
symbol
methods.
information is stored in the feature column of
the GRanges
object. If a display parameter of the same
name is specified, the software will use its value for the coloring.
GeneRegionTrack
objects also know about coding regions and non-coding
regions (e.g., UTRs) in a transcript, and will indicate those by using
different shapes (wide boxes for all coding regions, thinner boxes for
non-coding regions). This is archived by setting the feature
values
of the object for non-coding elements to one of the options that are
provided in the thinBoxFeature
display parameters. All other elements
are considered to be coding elements.
The return value of the constructor function is a new object of class
GeneRegionTrack
.
initialize(GeneRegionTrack)
: Initialize.
ReferenceGeneRegionTrack-class
: The file-based version of the GeneRegionTrack-class
.
initialize(ReferenceGeneRegionTrack)
: Initialize.
GeneRegionTrack()
: Constructor function for GeneRegionTrack-class
.
gene(GeneRegionTrack)
: Extract the gene identifiers for all
gene models.
gene(GdObject = GeneRegionTrack) <- value
: Replace the gene identifiers for all
gene models.
The replacement value must be a character of appropriate length or another
vector that can be coerced into such.
symbol(GeneRegionTrack)
: Extract the human-readble gene symbol
for all gene models.
symbol(GdObject = GeneRegionTrack) <- value
: Replace the human-readable gene symbol
for all gene models.
The replacement value must be a character of appropriate length or another
vector that can be coerced into such.
transcript(GeneRegionTrack)
: Extract the transcript identifiers for all
transcripts in the gene models.
transcript(GdObject = GeneRegionTrack) <- value
: Replace the transcript identifiers for all
transcripts in the gene model. The replacement value must be a character of
appropriate length or another vector that can be coerced into such.
exon(GeneRegionTrack)
: Extract the exon identifiers for all exons
in the gene models.
exon(GdObject = GeneRegionTrack) <- value
: replace the exon identifiers for all exons
in the gene model. The replacement value must be a character of appropriate
length or another vector that can be coerced into such.
group(GeneRegionTrack)
: extract the group membership for all track items.
group(GdObject = GeneRegionTrack) <- value
: replace the grouping information for track items.
The replacement value must be a factor of appropriate length or another
vector that can be coerced into such.
identifier(GeneRegionTrack)
: return track item identifiers.
Depending on the setting of the optional argument lowest, these are either
the group identifiers or the individual item identifiers.
export
identifier(GdObject = GeneRegionTrack) <- value
: Set the track item identifiers.
The replacement value has to be a character vector of appropriate length.
This always replaces the group-level identifiers, so essentially it is
similar to groups<-
.
subset(ReferenceGeneRegionTrack)
: Subset a GeneRegionTrack by coordinates
and sort if necessary.
drawGD(GeneRegionTrack)
: plot the object to a graphics device.
The return value of this method is the input object, potentially updated
during the plotting operation. Internally, there are two modes in which the
method can be called. Either in 'prepare' mode, in which case no plotting is
done but the object is preprocessed based on the available space, or in
'plotting' mode, in which case the actual graphical output is created.
Since subsetting of the object can be potentially costly, this can be
switched off in case subsetting has already been performed before or
is not necessary.
show(GeneRegionTrack)
: Show method.
show(ReferenceGeneRegionTrack)
: Show method.
Objects can be created using the constructor function
GeneRegionTrack
.
Florian Hahne, Steve Lianoglou
## The empty object GeneRegionTrack() ## Load some sample data data(cyp2b10) ## Construct the object grTrack <- GeneRegionTrack( start = 26682683, end = 26711643, rstart = cyp2b10$start, rends = cyp2b10$end, chromosome = 7, genome = "mm9", transcript = cyp2b10$transcript, gene = cyp2b10$gene, symbol = cyp2b10$symbol, feature = cyp2b10$feature, exon = cyp2b10$exon, name = "Cyp2b10", strand = cyp2b10$strand ) ## Directly from the data.frame grTrack <- GeneRegionTrack(cyp2b10) ## From a TxDb object if (require(GenomicFeatures)) { samplefile <- system.file("extdata", "hg19_knownGene_sample.sqlite", package = "GenomicFeatures") txdb <- loadDb(samplefile) GeneRegionTrack(txdb) GeneRegionTrack(txdb, chromosome = "chr6", start = 35000000, end = 40000000) } ## Plotting plotTracks(grTrack) ## Track names names(grTrack) names(grTrack) <- "foo" plotTracks(grTrack) ## Subsetting and splitting subTrack <- subset(grTrack, from = 26700000, to = 26705000) length(subTrack) subTrack <- grTrack[transcript(grTrack) == "ENSMUST00000144140"] split(grTrack, transcript(grTrack)) ## Accessors start(grTrack) end(grTrack) width(grTrack) position(grTrack) width(subTrack) <- width(subTrack) + 100 strand(grTrack) strand(subTrack) <- "-" chromosome(grTrack) chromosome(subTrack) <- "chrX" genome(grTrack) genome(subTrack) <- "hg19" range(grTrack) ranges(grTrack) ## Annotation identifier(grTrack) identifier(grTrack, "lowest") identifier(subTrack) <- "bar" feature(grTrack) feature(subTrack) <- "foo" exon(grTrack) exon(subTrack) <- letters[1:2] gene(grTrack) gene(subTrack) <- "bar" symbol(grTrack) symbol(subTrack) <- "foo" transcript(grTrack) transcript(subTrack) <- c("foo", "bar") chromosome(subTrack) <- "chr7" plotTracks(subTrack) values(grTrack) ## Grouping group(grTrack) group(subTrack) <- "Group 1" transcript(subTrack) plotTracks(subTrack) ## Collapsing transcripts plotTracks(grTrack, collapseTranscripts = TRUE, showId = TRUE, extend.left = 10000, shape = "arrow" ) ## Stacking stacking(grTrack) stacking(grTrack) <- "dense" plotTracks(grTrack) ## coercion as(grTrack, "data.frame") as(grTrack, "UCSCData") ## HTML image map coords(grTrack) tags(grTrack) grTrack <- plotTracks(grTrack)$foo coords(grTrack) tags(grTrack)
## The empty object GeneRegionTrack() ## Load some sample data data(cyp2b10) ## Construct the object grTrack <- GeneRegionTrack( start = 26682683, end = 26711643, rstart = cyp2b10$start, rends = cyp2b10$end, chromosome = 7, genome = "mm9", transcript = cyp2b10$transcript, gene = cyp2b10$gene, symbol = cyp2b10$symbol, feature = cyp2b10$feature, exon = cyp2b10$exon, name = "Cyp2b10", strand = cyp2b10$strand ) ## Directly from the data.frame grTrack <- GeneRegionTrack(cyp2b10) ## From a TxDb object if (require(GenomicFeatures)) { samplefile <- system.file("extdata", "hg19_knownGene_sample.sqlite", package = "GenomicFeatures") txdb <- loadDb(samplefile) GeneRegionTrack(txdb) GeneRegionTrack(txdb, chromosome = "chr6", start = 35000000, end = 40000000) } ## Plotting plotTracks(grTrack) ## Track names names(grTrack) names(grTrack) <- "foo" plotTracks(grTrack) ## Subsetting and splitting subTrack <- subset(grTrack, from = 26700000, to = 26705000) length(subTrack) subTrack <- grTrack[transcript(grTrack) == "ENSMUST00000144140"] split(grTrack, transcript(grTrack)) ## Accessors start(grTrack) end(grTrack) width(grTrack) position(grTrack) width(subTrack) <- width(subTrack) + 100 strand(grTrack) strand(subTrack) <- "-" chromosome(grTrack) chromosome(subTrack) <- "chrX" genome(grTrack) genome(subTrack) <- "hg19" range(grTrack) ranges(grTrack) ## Annotation identifier(grTrack) identifier(grTrack, "lowest") identifier(subTrack) <- "bar" feature(grTrack) feature(subTrack) <- "foo" exon(grTrack) exon(subTrack) <- letters[1:2] gene(grTrack) gene(subTrack) <- "bar" symbol(grTrack) symbol(subTrack) <- "foo" transcript(grTrack) transcript(subTrack) <- c("foo", "bar") chromosome(subTrack) <- "chr7" plotTracks(subTrack) values(grTrack) ## Grouping group(grTrack) group(subTrack) <- "Group 1" transcript(subTrack) plotTracks(subTrack) ## Collapsing transcripts plotTracks(grTrack, collapseTranscripts = TRUE, showId = TRUE, extend.left = 10000, shape = "arrow" ) ## Stacking stacking(grTrack) stacking(grTrack) <- "dense" plotTracks(grTrack) ## coercion as(grTrack, "data.frame") as(grTrack, "UCSCData") ## HTML image map coords(grTrack) tags(grTrack) grTrack <- plotTracks(grTrack)$foo coords(grTrack) tags(grTrack)
Many annotation tracks are actually composed of a number of grouped sub-features, for instance exons in a gene model. This man page highlights the use of grouping information to build informative annotation plots.
All track objects that inherit from class
AnnotationTrack
support the grouping feature. The
information is usually passed on to the constructor function (for
AnnotationTrack
via the groups
argument and for
GeneRegionTrack
objects via the exon
argument)
or automatically downloaded from an online annotation repository
(BiomartGeneRegionTrack
). Group membership is specified
by a factor vector with as many items as there are annotation items in the
track (i.e., the value of length(track)
. Upon plotting, the grouped
annotation features are displayed together and will not be separated in the
stacking of track items.
Florian Hahne
Gviz
These functions are defunct and no longer available.
(none)
Gviz
These functions are provided for compatibility with older
versions of Gviz
only, and will be defunct at the next release.
(none)
A container for other track objects from the Gviz package that allows for the addition of a common highlighting area across tracks.
## S4 method for signature 'HighlightTrack' initialize(.Object, trackList, ...) HighlightTrack( trackList = list(), range = NULL, start = NULL, end = NULL, width = NULL, chromosome, genome, name = "HighlightTrack", ... ) ## S4 replacement method for signature 'HighlightTrack,list' displayPars(x, recursive = FALSE) <- value ## S4 method for signature 'HighlightTrack' length(x) ## S4 replacement method for signature 'HighlightTrack' chromosome(GdObject) <- value ## S4 method for signature 'HighlightTrack' setStacks(GdObject, ...) ## S4 method for signature 'HighlightTrack' consolidateTrack(GdObject, chromosome, ...) ## S4 method for signature 'HighlightTrack' subset(x, ...) ## S4 method for signature 'HighlightTrack' show(object)
## S4 method for signature 'HighlightTrack' initialize(.Object, trackList, ...) HighlightTrack( trackList = list(), range = NULL, start = NULL, end = NULL, width = NULL, chromosome, genome, name = "HighlightTrack", ... ) ## S4 replacement method for signature 'HighlightTrack,list' displayPars(x, recursive = FALSE) <- value ## S4 method for signature 'HighlightTrack' length(x) ## S4 replacement method for signature 'HighlightTrack' chromosome(GdObject) <- value ## S4 method for signature 'HighlightTrack' setStacks(GdObject, ...) ## S4 method for signature 'HighlightTrack' consolidateTrack(GdObject, chromosome, ...) ## S4 method for signature 'HighlightTrack' subset(x, ...) ## S4 method for signature 'HighlightTrack' show(object)
.Object |
.Object |
trackList |
A list of Gviz track objects that all have to inherit from
class |
... |
All additional parameters are ignored. |
range |
An optional meta argument to handle the different input types. If the
The different input options for
|
start , end
|
An integer scalar with the genomic start or end coordinates
for the highlighting range. Can also be supplied as part of the |
width |
An integer vector of widths for highlighting ranges. This can
be used instead of either |
chromosome |
The chromosome on which the track's genomic ranges are
defined. A valid UCSC chromosome identifier if
|
genome |
The genome on which the track's ranges are defined. Usually
this is a valid UCSC genome identifier, however this is not being formally
checked at this point. If not provided here the constructor will try to
extract this information from the provided inputs, and eventually will fall
back to the default value of |
name |
Character scalar of the track's name. This is not really used and only exists fro completeness. |
x |
A valid track object class name, or the object itself, in which case the class is derived directly from it. |
recursive |
|
value |
Value to be set. |
GdObject |
Object of |
object |
object |
A track to conceptionally group other Gviz track objects into a meta track
for the sole purpose of overlaying all the contained tracks with the same
highlighting region as defined by the objects genomic ranges. During
rendering the contained tracks will be treated as if they had been provided
to the plotTracks
function as individual objects.
The return value of the constructor function is a new object of class
HighlightTrack
.
initialize(HighlightTrack)
: Initialize.
HighlightTrack()
: Constructor function for
HighlightTrack-class
.
displayPars(x = HighlightTrack) <- value
: set display parameters using the values of
the named list in value. See settings
for details on display
parameters and customization.
length(HighlightTrack)
: return the number of subtracks.
chromosome(HighlightTrack) <- value
: replace the value of the track's chromosome.
This has to be a valid UCSC chromosome identifier or an integer or character
scalar that can be reasonably coerced into one.
setStacks(HighlightTrack)
: Rrecompute the stacks based on the available
space and on the object's track items and stacking settings.
This really just calls the setStacks
methods for the contained tracks and
only exists for dispatching reasons.
consolidateTrack(HighlightTrack)
: Consolidate
For a HighlightTrack
apply the method on each of the subtracks in
the trackList
slot
subset(HighlightTrack)
: subset all the contained tracks in an HighlightTrack by coordinates and sort if necessary.
show(HighlightTrack)
: Show method.
Objects can be created using the constructor function HighlightTrack
.
Florian Hahne
## Object construction: set.seed(123) dat <- runif(100, min = -2, max = 22) gt <- GenomeAxisTrack() dt <- DataTrack(data = dat, start = sort(sample(200, 100)), width = 1, genome = "hg19") ht <- HighlightTrack(trackList = list(gt, dt))
## Object construction: set.seed(123) dat <- runif(100, min = -2, max = 22) gt <- GenomeAxisTrack() dt <- DataTrack(data = dat, start = sort(sample(200, 100)), width = 1, genome = "hg19") ht <- HighlightTrack(trackList = list(gt, dt))
A class to represent the schematic display of a chromosome, also known as an ideogram. The respective information is typically directly fetched from UCSC.
chromosome |
The chromosome for which to create the ideogram. Has to be
a valid UCSC chromosome identifier of the form |
genome |
The genome on which to create the ideogram. This has to be a valid UCSC genome identifier if the ideogram data is to be fetched from the UCSC repository. |
name |
Character scalar of the track's name used in the title panel when plotting. Defaults to the selected chromosome. |
bands |
A |
... |
Additional items which will all be interpreted as further display parameters. |
Ideograms are schematic depictions of chromosomes, including chromosome band
information and centromere location. The relevant data for various species
is stored in the UCSC data base. The initializer method of the class will
automatically fetch the respective data for a given genome and chromosome
from UCSC and fill the appropriate object slots. When plotting
IdeogramTracks
, the current genomic location is indicated on the
chromosome by a colored box.
The Gviz.ucscUrl
option controls which URL is being used to connect
to UCSC. For instance, one could switch to the European UCSC mirror by
calling options(Gviz.ucscUrl="http://genome-euro.ucsc.edu/cgi-bin/"
.
The return value of the constructor function is a new object of class
IdeogramTrack
.
Objects can be created using the constructor function IdeogramTrack
.
When fetching ideogram data from UCSC the results are cached for faster
acces. See clearSessionCache
on details to delete these cached
items.
Florian Hahne
## Construct the object ## Not run: idTrack <- IdeogramTrack(chromosome = 7, genome = "mm9") ## End(Not run) ## Plotting plotTracks(idTrack, from = 5000000, to = 9000000) ## Track names names(idTrack) names(idTrack) <- "foo" plotTracks(idTrack, from = 5000000, to = 9000000) ## Accessors chromosome(idTrack) ## Not run: chromosome(idTrack) <- "chrX" ## End(Not run) genome(idTrack) ## Not run: genome(id) <- "hg19" ## End(Not run) range(idTrack) ranges(idTrack) ## Annotation values(idTrack) ## coercion as(idTrack, "data.frame")
## Construct the object ## Not run: idTrack <- IdeogramTrack(chromosome = 7, genome = "mm9") ## End(Not run) ## Plotting plotTracks(idTrack, from = 5000000, to = 9000000) ## Track names names(idTrack) names(idTrack) <- "foo" plotTracks(idTrack, from = 5000000, to = 9000000) ## Accessors chromosome(idTrack) ## Not run: chromosome(idTrack) <- "chrX" ## End(Not run) genome(idTrack) ## Not run: genome(id) <- "hg19" ## End(Not run) range(idTrack) ranges(idTrack) ## Annotation values(idTrack) ## coercion as(idTrack, "data.frame")
The virtual parent class for all track items in the Gviz package designed to contain numeric data. This class merely exists for dispatching purpose.
## S4 method for signature 'NumericTrack' drawAxis(GdObject, from, to, ...) ## S4 method for signature 'NumericTrack' drawGrid(GdObject, from, to)
## S4 method for signature 'NumericTrack' drawAxis(GdObject, from, to, ...) ## S4 method for signature 'NumericTrack' drawGrid(GdObject, from, to)
GdObject |
Object of |
from , to
|
Numeric scalar, giving the range of genomic coordinates to
limit the tracks in. Note that |
... |
Additional arguments. |
A virtual class: No objects may be created from it.
drawAxis(NumericTrack)
: add a y-axis to the title panel of a track.
drawGrid(NumericTrack)
: superpose a grid on top of a track.
dp
Object of DisplayPars-class
, the display settings controlling the
look and feel of a track. See settings for details on setting graphical
parameters for tracks.
name
Object of class character
, a human-readable name for the track
that will be used in the track's annotation panel if necessary.
imageMap
Object of ImageMap-class
, containing optional information
for an HTML image map. This will be created by the drawGD
methods when the
track is plotted to a device and is usually not set by the user.
range
Object of class GRanges
, the genomic ranges of the track items
as well as additional annotation information in its elementMetaData
slot.
Please not that the slot is actually implemented as a class union between
GRanges
and IRanges to increase efficiency, for instance for DataTrack
objects. This usually does not concern the user.
chromosome
Object of class character
, the chromosome on which the
track is defined. There can only be a single chromosome for one track. For
certain subclasses, the space of allowed chromosome names is limited (e.g.,
only those chromosomes that exist for a particular genome). Throughout the
package, chromosome name have to be entered either as a single integer scalar
or as a character scalar of the form chrXYZ, where XYZ may be an arbitrary
character string.
genome
Object of class character
, the genome for which the track is
defined. For most sub-classes this has to be valid UCSC genome identifier,
however this may not always be formally checked upon object instantiation.
Florian Hahne
plotTracks
is the main interface when plotting single track objects,
or lists of tracks linked together across the same genomic coordinates.
Essentially, the resulting plots are very similar to the graphical output of
the UCSC Genome Browser, except for all of the interactivity.
plotTracks( trackList, from = NULL, to = NULL, ..., sizes = NULL, panel.only = FALSE, extend.right = 0, extend.left = 0, title.width = NULL, add = FALSE, main, cex.main = 2, fontface.main = 2, col.main = "black", margin = 6, chromosome = NULL, innerMargin = 3 )
plotTracks( trackList, from = NULL, to = NULL, ..., sizes = NULL, panel.only = FALSE, extend.right = 0, extend.left = 0, title.width = NULL, add = FALSE, main, cex.main = 2, fontface.main = 2, col.main = "black", margin = 6, chromosome = NULL, innerMargin = 3 )
trackList |
A list of Gviz track objects, all inheriting from
class |
from , to
|
Character scalar, giving the range of genomic coordinates to
draw the tracks in. Note that |
... |
Additional arguments which are all interpreted as display parameters to tweak the appearance of the plot. These parameters are global, meaning that they will be used for all tracks in the list where they actually make sense, and they override the track-internal settings. See settings for details on display parameters. |
sizes |
A numeric vector of relative vertical sizes for the individual
tracks of length equal to the number of tracks in |
panel.only |
Logical flag, causing the tracks to be plotted as
lattice-like panel functions without resetting the plotting canvas and
omitting the title pane. This allows to embed tracks into a trellis layout.
Usually the function is called for a single track only when
|
extend.right , extend.left
|
Numeric scalar, extend the plotting range to
the right or to the left by a fixed number of bases. The final plotting
range is defined as |
title.width |
A expansion factor for the width of the title panels. This can be used to make more space, e.g. to accommodate for more detailed data axes. The default is to use as much space as needed to fit all the annotation text. |
add |
Logical flag, add the plot to an existing plotting canvas without re-initialising. |
main |
Character scalar, the plots main header. |
cex.main , fontface.main , col.main
|
The fontface, color and expansion factor settings for the main header. |
margin |
The margin width to add to the plot in pixels. |
chromosome |
Set the chromosome for all the tracks in the track list. |
innerMargin |
The inner margin width to add to the plot in pixels. |
Gviz tracks are plotted in a vertically stacked layout. Each track panel is split up into a title section containing the track name, as well as an optional axis for tracks containing numeric data, and a data section showing the actual data along genomic coordinates. In that sense, the output is very similar to the UCSC Genome Browser.
The layout of the individual tracks is highly customizable though so called
"display parameters". See settings
for details.
While plotting a track, the software automatically computes HTML image map
coordinates based on the current graphics device. These coordinates as well
as the associated annotation information can later be used to embed images
of the plots in semi-interactive HTML pages. See
ImageMap
for details.
A list of Gviz tracks, each one augmented by the computed image map
coordinates in the imageMap
slot, along with the additional ImageMap
object titles
containing information about the title panels.
Florian Hahne
## Create some tracks to plot st <- c(2000000, 2070000, 2100000, 2160000) ed <- c(2050000, 2130000, 2150000, 2170000) str <- c("-", "+", "-", "-") gr <- c("Group1", "Group2", "Group1", "Group3") annTrack <- AnnotationTrack( start = st, end = ed, strand = str, chromosome = 7, genome = "hg19", feature = "test", group = gr, id = paste("annTrack item", 1:4), name = "annotation track foo", stacking = "squish" ) ax <- GenomeAxisTrack() dt <- DataTrack( start = seq(min(st), max(ed), len = 10), width = 18000, data = matrix(runif(40), nrow = 4), genome = "hg19", chromosome = 7, type = "histogram", name = "data track bar" ) ## Now plot the tracks res <- plotTracks(list(ax, annTrack, dt)) ## Plot only a subrange res <- plotTracks(list(ax, annTrack, dt), from = 2080000, to = 2156000) ## Extend plotting ranges res <- plotTracks(list(ax, annTrack, dt), extend.left = 200000, extend.right = 200000) ## Add a header res <- plotTracks(list(ax, annTrack, dt), main = "A GenomGraphs plot", col.main = "darkgray" ) ## Change vertical size and title width res <- plotTracks(list(ax, annTrack, dt), sizes = c(1, 1, 5)) names(annTrack) <- "foo" res <- plotTracks(list(ax, annTrack), title.width = 0.6) ## Adding and lattice like plots library(grid) grid.newpage() pushViewport(viewport(height = 0.5, y = 1, just = "top")) grid.rect() plotTracks(annTrack, add = TRUE) popViewport(1) pushViewport(viewport(height = 0.5, y = 0, just = "bottom")) grid.rect() plotTracks(dt, add = TRUE) popViewport(1) ## Not run: library(lattice) myPanel <- function(x, ...) { plotTracks(annTrack, panel.only = TRUE, from = min(x), to = max(x), shape = "box" ) } a <- seq(1900000, 2250000, len = 40) xyplot(b ~ a | c, data.frame(a = a, b = 1, c = cut(a, 4)), panel = myPanel, scales = list(x = "free") ) ## End(Not run)
## Create some tracks to plot st <- c(2000000, 2070000, 2100000, 2160000) ed <- c(2050000, 2130000, 2150000, 2170000) str <- c("-", "+", "-", "-") gr <- c("Group1", "Group2", "Group1", "Group3") annTrack <- AnnotationTrack( start = st, end = ed, strand = str, chromosome = 7, genome = "hg19", feature = "test", group = gr, id = paste("annTrack item", 1:4), name = "annotation track foo", stacking = "squish" ) ax <- GenomeAxisTrack() dt <- DataTrack( start = seq(min(st), max(ed), len = 10), width = 18000, data = matrix(runif(40), nrow = 4), genome = "hg19", chromosome = 7, type = "histogram", name = "data track bar" ) ## Now plot the tracks res <- plotTracks(list(ax, annTrack, dt)) ## Plot only a subrange res <- plotTracks(list(ax, annTrack, dt), from = 2080000, to = 2156000) ## Extend plotting ranges res <- plotTracks(list(ax, annTrack, dt), extend.left = 200000, extend.right = 200000) ## Add a header res <- plotTracks(list(ax, annTrack, dt), main = "A GenomGraphs plot", col.main = "darkgray" ) ## Change vertical size and title width res <- plotTracks(list(ax, annTrack, dt), sizes = c(1, 1, 5)) names(annTrack) <- "foo" res <- plotTracks(list(ax, annTrack), title.width = 0.6) ## Adding and lattice like plots library(grid) grid.newpage() pushViewport(viewport(height = 0.5, y = 1, just = "top")) grid.rect() plotTracks(annTrack, add = TRUE) popViewport(1) pushViewport(viewport(height = 0.5, y = 0, just = "bottom")) grid.rect() plotTracks(dt, add = TRUE) popViewport(1) ## Not run: library(lattice) myPanel <- function(x, ...) { plotTracks(annTrack, panel.only = TRUE, from = min(x), to = max(x), shape = "box" ) } a <- seq(1900000, 2250000, len = 40) xyplot(b ~ a | c, data.frame(a = a, b = 1, c = cut(a, 4)), panel = myPanel, scales = list(x = "free") ) ## End(Not run)
The virtual parent class for all track items in the Gviz package that contain some form of genomic ranges (start, end, strand, chromosome and the associated genome.)
## S4 method for signature 'RangeTrack' initialize(.Object, range, chromosome, genome, ...) ## S4 method for signature 'RangeTrack' ranges(x) ## S4 method for signature 'RangeTrack' range(x) ## S4 method for signature 'RangeTrack' seqnames(x) ## S4 method for signature 'RangeTrack' seqlevels(x) ## S4 method for signature 'RangeTrack' seqinfo(x) ## S4 method for signature 'RangeTrack' genome(x) ## S4 replacement method for signature 'RangeTrack' genome(x) <- value ## S4 method for signature 'RangeTrack' chromosome(GdObject) ## S4 replacement method for signature 'RangeTrack' chromosome(GdObject) <- value ## S4 method for signature 'RangeTrack' start(x) ## S4 replacement method for signature 'RangeTrack' start(x) <- value ## S4 method for signature 'RangeTrack' end(x) ## S4 replacement method for signature 'RangeTrack' end(x) <- value ## S4 method for signature 'RangeTrack' width(x) ## S4 replacement method for signature 'RangeTrack' width(x) <- value ## S4 method for signature 'RangeTrack' min(x) ## S4 method for signature 'RangeTrack' max(x) ## S4 method for signature 'RangeTrack' length(x) ## S4 method for signature 'RangeTrack' strand(x) ## S4 replacement method for signature 'RangeTrack,ANY' strand(x) <- value ## S4 method for signature 'RangeTrack' position(GdObject, from = NULL, to = NULL, sort = FALSE, ...) ## S4 method for signature 'RangeTrack,ANY,ANY,ANY' x[i, j, ..., drop = TRUE] ## S4 method for signature 'RangeTrack' subset( x, from = NULL, to = NULL, sort = FALSE, drop = TRUE, use.defaults = TRUE, ... ) ## S4 method for signature 'RangeTrack,ANY' split(x, f, drop = FALSE, ...) ## S4 method for signature 'RangeTrack' values(x) ## S4 method for signature 'RangeTrack' feature(GdObject) ## S4 replacement method for signature 'RangeTrack,character' feature(GdObject) <- value ## S4 method for signature 'RangeTrack' consolidateTrack(GdObject, chromosome, ...)
## S4 method for signature 'RangeTrack' initialize(.Object, range, chromosome, genome, ...) ## S4 method for signature 'RangeTrack' ranges(x) ## S4 method for signature 'RangeTrack' range(x) ## S4 method for signature 'RangeTrack' seqnames(x) ## S4 method for signature 'RangeTrack' seqlevels(x) ## S4 method for signature 'RangeTrack' seqinfo(x) ## S4 method for signature 'RangeTrack' genome(x) ## S4 replacement method for signature 'RangeTrack' genome(x) <- value ## S4 method for signature 'RangeTrack' chromosome(GdObject) ## S4 replacement method for signature 'RangeTrack' chromosome(GdObject) <- value ## S4 method for signature 'RangeTrack' start(x) ## S4 replacement method for signature 'RangeTrack' start(x) <- value ## S4 method for signature 'RangeTrack' end(x) ## S4 replacement method for signature 'RangeTrack' end(x) <- value ## S4 method for signature 'RangeTrack' width(x) ## S4 replacement method for signature 'RangeTrack' width(x) <- value ## S4 method for signature 'RangeTrack' min(x) ## S4 method for signature 'RangeTrack' max(x) ## S4 method for signature 'RangeTrack' length(x) ## S4 method for signature 'RangeTrack' strand(x) ## S4 replacement method for signature 'RangeTrack,ANY' strand(x) <- value ## S4 method for signature 'RangeTrack' position(GdObject, from = NULL, to = NULL, sort = FALSE, ...) ## S4 method for signature 'RangeTrack,ANY,ANY,ANY' x[i, j, ..., drop = TRUE] ## S4 method for signature 'RangeTrack' subset( x, from = NULL, to = NULL, sort = FALSE, drop = TRUE, use.defaults = TRUE, ... ) ## S4 method for signature 'RangeTrack,ANY' split(x, f, drop = FALSE, ...) ## S4 method for signature 'RangeTrack' values(x) ## S4 method for signature 'RangeTrack' feature(GdObject) ## S4 replacement method for signature 'RangeTrack,character' feature(GdObject) <- value ## S4 method for signature 'RangeTrack' consolidateTrack(GdObject, chromosome, ...)
.Object |
.Object |
range |
range |
chromosome |
the currently active chromosome which may have to be set
for a |
genome |
genome |
... |
Additional arguments. |
x |
A valid track object class name, or the object itself, in which case the class is derived directly from it. |
value |
Value to be set. |
GdObject |
the input track object |
from , to
|
Numeric scalar, giving the range of genomic coordinates to
limit the tracks in. Note that |
sort |
|
i |
Numeric scalar, index to subset. |
j |
Numeric scalar, index to subset. Ignored. |
drop |
|
use.defaults |
|
f |
|
A virtual class: No objects may be created from it.
initialize(RangeTrack)
: Initialize.
ranges(RangeTrack)
: return the genomic coordinates for the track
along with all additional annotation information as an object of
class GRanges.
range(RangeTrack)
: return the genomic coordinates for the
track as an object of class IRanges.
seqnames(RangeTrack)
: return the track's seqnames.
seqlevels(RangeTrack)
: return the track's seqlevels.
seqinfo(RangeTrack)
: return the track's seqinfo.
genome(RangeTrack)
: return the track's genome.
genome(RangeTrack) <- value
: set the track's genome. Usually this has to
be a valid UCSC identifier, however this is not formally enforced here.
chromosome(RangeTrack)
: return the chromosome for which the track is defined.
chromosome(RangeTrack) <- value
: replace the value of the track's chromosome.
This has to be a valid UCSC chromosome identifier or an integer or character
scalar that can be reasonably coerced into one.
start(RangeTrack)
: the start of the track items in genomic
coordinates.
start(RangeTrack) <- value
: replace the start of the track items in
genomic coordinates.
end(RangeTrack)
: the end of the track items in genomic
coordinates.
end(RangeTrack) <- value
: replace the end of the track items in
genomic coordinates.
width(RangeTrack)
: the width of the track items in genomic
coordinates.
width(RangeTrack) <- value
: replace the width of the track items in genomic
coordinates.
min(RangeTrack)
: return the start position for the leftmost range item.
max(RangeTrack)
: return the end position for the rightmost range item.
length(RangeTrack)
: return the number of items in the track.
strand(RangeTrack)
: return a vector of strand specifiers for all
track items, in the form '+' for the Watson strand, '-' for the Crick
strand or '*' for either of the two.
strand(x = RangeTrack) <- value
: replace the strand information for the track
items. The replacement value needs to be an appropriate scalar or vector
of strand values.
position(RangeTrack)
: the arithmetic mean of the track item's
coordionates, i.e., (end(obj)-start(obj))/2
.
x[i
: subset the items in the RangeTrack
object.
This is essentially similar to subsetting of the GRanges
object in the
range
slot. For most applications, the subset method may be more appropriate.
subset(RangeTrack)
: subset a RangeTrack
by coordinates and
sort if necessary.
split(x = RangeTrack, f = ANY)
: split a RangeTrack
object by an appropriate
factor vector (or another vector that can be coerced into one). The output
of this operation is a list of objects of the same class as the input
object, all inheriting from class RangeTrack.
values(RangeTrack)
: return all additional annotation information
except for the genomic coordinates for the track items as a data.frame
.
feature(RangeTrack)
: return the grouping information for track
items. For certain sub-classes, groups may be indicated by different colour
schemes when plotting. See grouping or AnnotationTrack
and
GeneRegionTrack
for details.
@export
feature(GdObject = RangeTrack) <- value
: set the grouping information for track items.
This has to be a factor vector (or another type of vector that can be
coerced into one) of the same length as the number of items in the
RangeTrack.
See grouping or AnnotationTrack
and GeneRegionTrack
for
details.
@export
consolidateTrack(RangeTrack)
: Consolidate.
dp
Object of DisplayPars-class
, the display settings controlling the
look and feel of a track. See settings for details on setting graphical
parameters for tracks.
name
Object of class character
, a human-readable name for the track
that will be used in the track's annotation panel if necessary.
imageMap
Object of ImageMap-class
, containing optional information
for an HTML image map. This will be created by the drawGD
methods when the
track is plotted to a device and is usually not set by the user.
range
Object of class GRanges
, the genomic ranges of the track items
as well as additional annotation information in its elementMetaData
slot.
Please not that the slot is actually implemented as a class union between
GRanges
and IRanges to increase efficiency, for instance for DataTrack
objects. This usually does not concern the user.
chromosome
Object of class character
, the chromosome on which the
track is defined. There can only be a single chromosome for one track. For
certain subclasses, the space of allowed chromosome names is limited (e.g.,
only those chromosomes that exist for a particular genome). Throughout the
package, chromosome name have to be entered either as a single integer scalar
or as a character scalar of the form chrXYZ, where XYZ may be an arbitrary
character string.
genome
Object of class character
, the genome for which the track is
defined. For most sub-classes this has to be valid UCSC genome identifier,
however this may not always be formally checked upon object instantiation.
Florian Hahne
## This is a reference class therefore we show below ## an example from AnnotationTrack ## An empty object AnnotationTrack() ## Construct from individual arguments st <- c(2000000, 2070000, 2100000, 2160000) ed <- c(2050000, 2130000, 2150000, 2170000) str <- c("-", "+", "-", "-") gr <- c("Group1", "Group2", "Group1", "Group3") annTrack <- AnnotationTrack( start = st, end = ed, strand = str, chromosome = 7, genome = "hg19", feature = "test", group = gr, id = paste("annTrack item", 1:4), name = "generic annotation", stacking = "squish" ) ## Plotting plotTracks(annTrack)
## This is a reference class therefore we show below ## an example from AnnotationTrack ## An empty object AnnotationTrack() ## Construct from individual arguments st <- c(2000000, 2070000, 2100000, 2160000) ed <- c(2050000, 2130000, 2150000, 2170000) str <- c("-", "+", "-", "-") gr <- c("Group1", "Group2", "Group1", "Group3") annTrack <- AnnotationTrack( start = st, end = ed, strand = str, chromosome = 7, genome = "hg19", feature = "test", group = gr, id = paste("annTrack item", 1:4), name = "generic annotation", stacking = "squish" ) ## Plotting plotTracks(annTrack)
A track class to represent genomic sequences. The three child classes
SequenceDNAStringSetTrack
, SequenceRNAStringSetTrack
and
SequenceBSgenomeTrack
do most of the work, however in practise they
are of no particular relevance to the user.
## S4 method for signature 'SequenceTrack' initialize(.Object, chromosome, genome, ...) SequenceTrack( sequence, chromosome, genome, name = "SequenceTrack", importFunction, stream = FALSE, ... ) RNASequenceTrack( sequence, chromosome, genome, name = "SequenceTrack", importFunction, stream = FALSE, ... ) ## S4 method for signature 'SequenceDNAStringSetTrack' initialize(.Object, sequence, ...) ## S4 method for signature 'SequenceRNAStringSetTrack' initialize(.Object, sequence, ...) ## S4 method for signature 'SequenceBSgenomeTrack' initialize(.Object, sequence = NULL, ...) ## S4 method for signature 'ReferenceSequenceTrack' initialize(.Object, stream, reference, ...) ## S4 method for signature 'SequenceTrack' seqnames(x) ## S4 method for signature 'SequenceBSgenomeTrack' seqnames(x) ## S4 method for signature 'SequenceTrack' seqlevels(x) ## S4 method for signature 'SequenceBSgenomeTrack' seqlevels(x) ## S4 method for signature 'SequenceTrack' start(x) ## S4 method for signature 'SequenceTrack' end(x) ## S4 method for signature 'SequenceTrack' width(x) ## S4 method for signature 'SequenceTrack' length(x) ## S4 method for signature 'SequenceTrack' chromosome(GdObject) ## S4 replacement method for signature 'SequenceTrack' chromosome(GdObject) <- value ## S4 method for signature 'SequenceTrack' genome(x) ## S4 method for signature 'SequenceTrack' consolidateTrack(GdObject, chromosome, ...) ## S4 method for signature 'SequenceTrack' drawGD(GdObject, minBase, maxBase, prepare = FALSE, ...) ## S4 method for signature 'SequenceBSgenomeTrack' show(object) ## S4 method for signature 'SequenceDNAStringSetTrack' show(object) ## S4 method for signature 'SequenceRNAStringSetTrack' show(object) ## S4 method for signature 'ReferenceSequenceTrack' show(object)
## S4 method for signature 'SequenceTrack' initialize(.Object, chromosome, genome, ...) SequenceTrack( sequence, chromosome, genome, name = "SequenceTrack", importFunction, stream = FALSE, ... ) RNASequenceTrack( sequence, chromosome, genome, name = "SequenceTrack", importFunction, stream = FALSE, ... ) ## S4 method for signature 'SequenceDNAStringSetTrack' initialize(.Object, sequence, ...) ## S4 method for signature 'SequenceRNAStringSetTrack' initialize(.Object, sequence, ...) ## S4 method for signature 'SequenceBSgenomeTrack' initialize(.Object, sequence = NULL, ...) ## S4 method for signature 'ReferenceSequenceTrack' initialize(.Object, stream, reference, ...) ## S4 method for signature 'SequenceTrack' seqnames(x) ## S4 method for signature 'SequenceBSgenomeTrack' seqnames(x) ## S4 method for signature 'SequenceTrack' seqlevels(x) ## S4 method for signature 'SequenceBSgenomeTrack' seqlevels(x) ## S4 method for signature 'SequenceTrack' start(x) ## S4 method for signature 'SequenceTrack' end(x) ## S4 method for signature 'SequenceTrack' width(x) ## S4 method for signature 'SequenceTrack' length(x) ## S4 method for signature 'SequenceTrack' chromosome(GdObject) ## S4 replacement method for signature 'SequenceTrack' chromosome(GdObject) <- value ## S4 method for signature 'SequenceTrack' genome(x) ## S4 method for signature 'SequenceTrack' consolidateTrack(GdObject, chromosome, ...) ## S4 method for signature 'SequenceTrack' drawGD(GdObject, minBase, maxBase, prepare = FALSE, ...) ## S4 method for signature 'SequenceBSgenomeTrack' show(object) ## S4 method for signature 'SequenceDNAStringSetTrack' show(object) ## S4 method for signature 'SequenceRNAStringSetTrack' show(object) ## S4 method for signature 'ReferenceSequenceTrack' show(object)
.Object |
.Object |
chromosome |
the currently active chromosome which may have to be set
for a |
genome |
The genome on which the track's ranges are defined. Usually
this is a valid UCSC genome identifier, however this is not being formally
checked at this point. For a |
... |
Additional items which will all be interpreted as further
display parameters. See |
sequence |
A meta argument to handle the different input types, making the construction
of a The different input options for
|
name |
Character scalar of the track's name used in the title panel when plotting. |
importFunction |
A user-defined function to be used to import the
sequence data from a file. This only applies when the Both file types support indexing by genomic coordinates, and it makes sense
to only load the part of the file that is needed for plotting. To this end,
the |
stream |
A logical flag indicating that the user-provided import
function can deal with indexed files and knows how to process the additional
|
reference |
Name of the file (for streatming). |
x |
A valid track object class name, or the object itself, in which case the class is derived directly from it. |
GdObject |
the input track object |
value |
Value to be set. |
minBase |
Start of the sequence. |
maxBase |
End of the sequence. |
prepare |
|
object |
object |
The return value of the constructor function is a new object of class
SequenceDNAStringSetTrack
, SequenceBSgenomeTrack
ore
ReferenceSequenceTrack
, depending on the constructor arguments.
Typically the user will not have to be troubled with this distinction and
can rely on the constructor to make the right choice.
initialize(SequenceTrack)
: Initialize.
SequenceTrack()
: Constructor
RNASequenceTrack()
: Constructor
SequenceDNAStringSetTrack-class
: The DNAStringSet
-based version of the SequenceTrack-class
.
initialize(SequenceDNAStringSetTrack)
: Initialize.
SequenceRNAStringSetTrack-class
: The RNAStringSet
-based version of the SequenceTrack-class
.
initialize(SequenceRNAStringSetTrack)
: Initialize RNAStringSet
-based version of the SequenceTrack-class
.
SequenceBSgenomeTrack-class
: The BSgenome
-based version of the SequenceTrack-class
.
initialize(SequenceBSgenomeTrack)
: Initialize.
ReferenceSequenceTrack-class
: The file-based version of the SequenceTrack-class
.
initialize(ReferenceSequenceTrack)
: Initialize.
seqnames(SequenceTrack)
: return the names (i.e., the chromosome)
of the sequences contained in the object.
seqnames(SequenceBSgenomeTrack)
: return the names (i.e., the chromosome)
of the sequences contained in the object.
seqlevels(SequenceTrack)
: return the names (i.e., the chromosome)
of the sequences contained in the object. Only those with length > 0.
seqlevels(SequenceBSgenomeTrack)
: return the names (i.e., the chromosome)
of the sequences contained in the object. Only those with length > 0.
start(SequenceTrack)
: return the start coordinates of the track
items.
end(SequenceTrack)
: return the end coordinates of the track
items.
width(SequenceTrack)
: return the with of the track items in
genomic coordinates.
length(SequenceTrack)
: return the length of the sequence for
active chromosome.
chromosome(SequenceTrack)
: return the chromosome for which the track
is defined.
chromosome(SequenceTrack) <- value
: replace the value of the track's chromosome.
This has to be a valid UCSC chromosome identifier or an integer or character
scalar that can be reasonably coerced into one.
genome(SequenceTrack)
: Set the track's genome.
Usually this has to be a valid UCSC identifier, however this is not
formally enforced here.
consolidateTrack(SequenceTrack)
: Consolidate/
Determine whether there is chromosome
settings or not, and add this information.
drawGD(SequenceTrack)
: plot the object to a graphics device.
The return value of this method is the input object, potentially updated
during the plotting operation. Internally, there are two modes in which the
method can be called. Either in 'prepare' mode, in which case no plotting is
done but the object is preprocessed based on the available space, or in
'plotting' mode, in which case the actual graphical output is created.
Since subsetting of the object can be potentially costly, this can be
switched off in case subsetting has already been performed before or
is not necessary.
show(SequenceBSgenomeTrack)
: Show method.
show(SequenceDNAStringSetTrack)
: Show method.
show(SequenceRNAStringSetTrack)
: Show method.
show(ReferenceSequenceTrack)
: Show method.
Objects can be created using the constructor function SequenceTrack
.
Florian Hahne
## An empty object SequenceTrack() ## Construct from DNAStringSet library(Biostrings) letters <- c("A", "C", "T", "G", "N") set.seed(999) seqs <- DNAStringSet(c(chr1 = paste(sample(letters, 100000, TRUE), collapse = "" ), chr2 = paste(sample(letters, 200000, TRUE), collapse = ""))) sTrack <- SequenceTrack(seqs, genome = "hg19") sTrack ## Construct from BSGenome object if (require(BSgenome.Hsapiens.UCSC.hg19)) { sTrack <- SequenceTrack(Hsapiens) sTrack } ## Set active chromosome chromosome(sTrack) chromosome(sTrack) <- "chr2" head(seqnames(sTrack)) ## Plotting ## Sequences plotTracks(sTrack, from = 199970, to = 200000) ## Boxes plotTracks(sTrack, from = 199800, to = 200000) ## Line plotTracks(sTrack, from = 1, to = 200000) ## Force boxes plotTracks(sTrack, from = 199970, to = 200000, noLetters = TRUE) ## Direction indicator plotTracks(sTrack, from = 199970, to = 200000, add53 = TRUE) ## Sequence complement plotTracks(sTrack, from = 199970, to = 200000, add53 = TRUE, complement = TRUE) ## Colors plotTracks(sTrack, from = 199970, to = 200000, add53 = TRUE, fontcolor = c( A = 1, C = 1, G = 1, T = 1, N = 1 )) ## Track names names(sTrack) names(sTrack) <- "foo" ## Accessors genome(sTrack) genome(sTrack) <- "mm9" length(sTrack) ## Sequence extraction subseq(sTrack, start = 100000, width = 20) ## beyond the stored sequence range subseq(sTrack, start = length(sTrack), width = 20)
## An empty object SequenceTrack() ## Construct from DNAStringSet library(Biostrings) letters <- c("A", "C", "T", "G", "N") set.seed(999) seqs <- DNAStringSet(c(chr1 = paste(sample(letters, 100000, TRUE), collapse = "" ), chr2 = paste(sample(letters, 200000, TRUE), collapse = ""))) sTrack <- SequenceTrack(seqs, genome = "hg19") sTrack ## Construct from BSGenome object if (require(BSgenome.Hsapiens.UCSC.hg19)) { sTrack <- SequenceTrack(Hsapiens) sTrack } ## Set active chromosome chromosome(sTrack) chromosome(sTrack) <- "chr2" head(seqnames(sTrack)) ## Plotting ## Sequences plotTracks(sTrack, from = 199970, to = 200000) ## Boxes plotTracks(sTrack, from = 199800, to = 200000) ## Line plotTracks(sTrack, from = 1, to = 200000) ## Force boxes plotTracks(sTrack, from = 199970, to = 200000, noLetters = TRUE) ## Direction indicator plotTracks(sTrack, from = 199970, to = 200000, add53 = TRUE) ## Sequence complement plotTracks(sTrack, from = 199970, to = 200000, add53 = TRUE, complement = TRUE) ## Colors plotTracks(sTrack, from = 199970, to = 200000, add53 = TRUE, fontcolor = c( A = 1, C = 1, G = 1, T = 1, N = 1 )) ## Track names names(sTrack) names(sTrack) <- "foo" ## Accessors genome(sTrack) genome(sTrack) <- "mm9" length(sTrack) ## Sequence extraction subseq(sTrack, start = 100000, width = 20) ## beyond the stored sequence range subseq(sTrack, start = length(sTrack), width = 20)
The genome track plots in this package are all highly customizable by means of so called 'display parameters'. This page highlights the use of these parameters and list all available settings for the different track classes.
scheme |
A named nested list of display parameters, where the first level of nesting represents Gviz track object classes, and the second level of nesting represents parameters. |
name |
A character scalar with the scheme name. |
All of the package's track objects inherit the dp
slot from the
GdObject
parent class, which is the main container to
store an object's display parameters. Internally, the content of this slot
has to be an object of class DisplayPars
, but the user
is usually not exposed to this low level implementation. Instead, there are
two main interaction points, namely the individual object constructor
functions and the final plotTracks
function. In both cases,
all additional arguments that are not caught by any of the formally defined
function parameters are being interpreted as additional display parameters
and are automatically added to the aforementioned slot. The main difference
here is that display parameters that are passed on to the constructor
function are specific for an individual track object, whereas those supplied
to the plotTracks
function will be applied to all the objects in the
plotting list. Not all display parameters have an effect on the plotting of
all track classes, and those will be silently ignored.
One can query the available display parameters for a given class as well as
their default values by calling the availableDisplayPars
function, or by inspecting the man pages of the individual track classes.
The structure of the classes defined in this package is hierarchical, and so
are the available display parameters, i.e., all objects inherit the
parameters defined in the commom GdObject
parent class, and so on.
Once a track object has been created, the display parameters are still open
for modification. To this end, the DisplayPars
replacement
method is available for all objects inheriting from class GdObject
.
The method takes a named list of parameters as input, e.g.:
displayPars(foo) <- list(col="red", lwd=2)
In the same spirit, the currently set display parameters for the object
foo
can be inferred using the displayPars
method directly,
e.g.:
displayPars(foo)
For track objects inheriting from class
AnnotationTrack
, display parameters that are not
formally defined in the class definition or in any of the parent classes are
considered to be valid R color identifiers that are used to distinguish
between different types of annotation features. For instance, the parameter
'miRNA' will be used to color all annotation features of class miRNA. The
annotation types can be set in the constructor function of the track object
via the feature
argument. For most of the tracks that have been
inferred from one of the online repositories, this classification will
usually be downloaded along with the actual annotation data.
Users might find themselves changing the same parameters over and over
again, and it would make sense to register these modifications in a central
location once and for all. To this end the Gviz package supports display
parameter schemes. A scheme is essentially just a bunch of nested named
lists, where the names on the first level of nesting should correspond to
track class names, and the names on the second level to the display
parameters to set. The currently active schmeme can be changed by setting
the global option Gviz.scheme
, and a new scheme can be registered by
using the addScheme
function, providing both the list and the name
for the new scheme. The getScheme
function is useful to get the
current scheme as a list structure, for instance to use as a skeleton for
your own custom scheme.
In order to make these settings persitant across R sessions one can create
one or several schemes in the global environment in the special object
.GvizSchemes
, for instance by putting the necessary code in the
.Rprofile
file. This object needs to be a named list of schemes, and
it will be collected when the Givz package loads. Its content is then
automatically added to the collection of available schemes.
Please note that because display parameters are stored with the track objects, a scheme change only has an effect on those objects that are created after the change has taken place.
The getScheme
function returns current scheme as a list structure.
add35=FALSE
:Logical scalar. Add 3' to 5' direction indicators.
add53=FALSE
:Logical scalar. Add 5' to 3' direction indicators.
background.title="transparent"
:Character scalar. The background color for the title panel. Defaults to omit the background.
cex.id=0.7
:Numeric scalar. The text size for the optional range annotation.
cex=0.8
:Numeric scalar. The overall font expansion factor for the axis annotation text.
col.border.title="transparent"
:Integer or character scalar. The border color for the title panels.
lwd.border.title=1
:Integer scalar. The border width for the title panels.
col.id="white"
:Character scalar. The text color for the optional range annotation.
col.range="cornsilk4"
:Character scalar. The border color for highlighted regions on the axis.
distFromAxis=1
:Numeric scalar. Control the distance of the axis annotation from the tick marks.
exponent=NULL
:Numeric scalar. The exponent for the axis coordinates, e.g., 3 means mb, 6 means gb, etc. The default is to automatically determine the optimal exponent.
fill.range="cornsilk3"
:Character scalar. The fill color for highlighted regions on the axis.
fontcolor="#808080"
:Character scalar. The font color for the axis annotation text.
fontsize=10
:Numeric scalar. Font size for the axis annotation text in points.
labelPos="alternating"
: Character vector, one in
"alternating", "revAlternating", "above" or "below". The vertical
positioning of the axis labels. If scale
is not NULL
, the
possible values are "above", "below" and "beside".
littleTicks=FALSE
:Logical scalar. Add more fine-grained tick marks.
lwd=2
:Numeric scalar. The line width for the axis elementes.
scale=NULL
: Numeric scalar. If not NULL
a small scale
is drawn instead of the full axis, if the value is between 0 and 1 it is
interpreted as a fraction of the current plotting region, otherwise as an
absolute length value in genomic coordinates.
showId=FALSE
:Logical scalar. Show the optional range highlighting annotation.
showTitle=FALSE
:Logical scalar. Plot a title panel. Defaults to omit the title panel.
ticksAt=NULL
:Numeric scalar. The exact x-position for tickmarks (in base-pairs).
size=NULL
: Numeric scalar. The relative size of the track.
Can be overridden in the plotTracks
function. Defaults to the
ideal size based on the other track settings.
col="darkgray"
:Character scalar. The color for the axis lines and tickmarks.
Inherited from class GdObject:
alpha=1
:Numeric scalar. The transparency for all track items.
alpha.title=NULL
:Numeric scalar. The transparency for the title panel.
background.panel="transparent"
:Integer or character scalar. The background color of the content panel.
background.legend="transparent"
:Integer or character scalar. The background color for the legend.
cex.axis=NULL
: Numeric scalar. The expansion factor for the
axis annotation. Defaults to NULL
, in which case it is automatically
determined based on the available space.
cex.title=NULL
: Numeric scalar. The expansion factor for the
title panel. This effects the fontsize of both the title and the axis, if
any. Defaults to NULL
, which means that the text size is
automatically adjusted to the available space.
col.axis="white"
:Integer or character scalar. The font and line color for the y axis, if any.
col.frame="lightgray"
: Integer or character scalar. The line
color used for the panel frame, if frame==TRUE
col.grid="#808080"
: Integer or character scalar. Default
line color for grid lines, both when type=="g"
in
DataTrack
s and when display parameter grid==TRUE
.
col.line=NULL
: Integer or character scalar. Default colors
for plot lines. Usually the same as the global col
parameter.
col.symbol=NULL
: Integer or character scalar. Default colors
for plot symbols. Usually the same as the global col
parameter.
col.title="white"
:Integer or character scalar. The border color for the title panels
collapse=TRUE
: Boolean controlling whether to collapse the
content of the track to accomodate the minimum current device resolution.
See collapsing
for details.
fill="lightgray"
:Integer or character scalar. Default fill color setting for all plotting elements, unless there is a more specific control defined elsewhere.
fontface.title=2
:Integer or character scalar. The font face for the title panels.
fontface=1
:Integer or character scalar. The font face for all text, unless a more specific definition exists.
fontfamily.title="sans"
:Integer or character scalar. The font family for the title panels.
fontfamily="sans"
:Integer or character scalar. The font family for all text, unless a more specific definition exists.
frame=FALSE
:Boolean. Draw a frame around the track when plotting.
grid=FALSE
:Boolean, switching on/off the plotting of a grid.
h=-1
: Integer scalar. Parameter controlling the number of
horizontal grid lines, see panel.grid
for details.
lineheight=1
:Numeric scalar. The font line height for all text, unless a more specific definition exists.
lty.grid="solid"
: Integer or character scalar. Default line
type for grid lines, both when type=="g"
in DataTrack
s
and when display parameter grid==TRUE
.
lty="solid"
:Numeric scalar. Default line type setting for all plotting elements, unless there is a more specific control defined elsewhere.
lwd.title=1
:Integer scalar. The border width for the title panels
lwd.grid=1
: Numeric scalar. Default line width for grid
lines, both when type=="g"
in DataTrack
s and when
display parameter grid==TRUE
.
min.distance=1
: Numeric scalar. The minimum pixel distance
before collapsing range items, only if collapse==TRUE
. See
collapsing
for details.
min.height=3
: Numeric scalar. The minimum range height in
pixels to display. All ranges are expanded to this size in order to avoid
rendering issues. See collapsing
for details.
min.width=1
: Numeric scalar. The minimum range width in
pixels to display. All ranges are expanded to this size in order to avoid
rendering issues. See collapsing
for details.
reverseStrand=FALSE
: Logical scalar. Set up the plotting
coordinates in 3' -> 5' direction if TRUE
. This will effectively
mirror the plot on the vertical axis.
rotation.title=90
:The rotation angle for the text in the title panel. Even though this can be adjusted, the automatic resizing of the title panel will currently not work, so use at own risk.
rotation=0
:The rotation angle for all text unless a more specific definiton exists.
showAxis=TRUE
:Boolean controlling whether to plot a y axis (only applies to track types where axes are implemented).
v=-1
: Integer scalar. Parameter controlling the number of
vertical grid lines, see panel.grid
for details.
aggregateGroups=FALSE
: Logical scalar. Aggregate the values
within a sample group using the aggregation funnction specified in the
aggregation
parameter.
aggregation="mean"
: Function or character scalar. Used to
aggregate values in windows or for collapsing overlapping items. The
function has to accept a numeric vector as a single input parameter and has
to return a numeric scalar with the aggregated value. Alternatively, one of
the predefined options mean
, median
sum
, min
,
max
or extreme
can be supplied as a character scalar. Defaults
to mean
.
missingAsZero=TRUE
: Logical scalar. Defines how the missing
values are treated in the aggregation procedure with running window. Setting
it to TRUE
fills empty positions with zeros, which is default.
FALSE
fills empty positions with NA
.
alpha.confint=0.3
:Numeric scalar. The transparency for the confidence intervalls in confint-type plots.
amount=NULL
: Numeric scalar. Amount of jittering in xy-type
plots. See panel.xyplot
for details.
baseline=NULL
: Numeric scalar. Y-axis position of an optional
baseline. This parameter has a special meaning for mountain-type and
polygon-type plots, see the 'Details' section in
DataTrack
for more information.
box.legend=FALSE
:Logical scalar. Draw a box around a legend.
box.ratio=1
: Numeric scalar. Parameter controlling the
boxplot appearance. See panel.bwplot
for details.
box.width=NULL
: Numeric scalar. Parameter controlling the
boxplot appearance. See panel.bwplot
for details.
grid=FALSE
:Logical vector. Draw a line grid under the track content.
cex.legend=0.8
:Numeric scalar. The size factor for the legend text.
cex.sampleNames=NULL
:Numeric scalar. The size factor for the sample names text in heatmap or horizon plots. Defaults to an automatic setting.
cex=0.7
:Numeric scalar. The default pixel size for plotting symbols.
coef=1.5
: Numeric scalar. Parameter controlling the boxplot
appearance. See panel.bwplot
for details.
col.baseline=NULL
: Character scalar. Color for the optional
baseline, defaults to the setting of col
.
col.confint=NA
:Character vector. Border colors for the confidence intervals for confint-type plots.
col.boxplotFrame="#808080"
:Character scalar. Line color of the frame around grouped boxplots.
col.histogram="#808080"
:Character scalar. Line color in histogram-type plots.
col.horizon=NA
: The line color for the segments in the
horizon
-type plot. See horizonplot
for details.
col.mountain=NULL
: Character scalar. Line color in
mountain-type and polygon-type plots, defaults to the setting of
col
.
col.sampleNames="white"
:Character or integer scalar. The color used for the sample names in heatmap plots.
col=c("#0080ff", "#ff00ff", "darkgreen", "#ff0000", "orange",
"#00ff00", "brown")
: Character or integer vector. The color used for all
line and symbol elements, unless there is a more specific control defined
elsewhere. Unless groups
are specified, only the first color in the
vector is usually regarded.
collapse=FALSE
:Logical scalar. Collapse overlapping ranges and aggregate the underlying data.
degree=1
: Numeric scalar. Parameter controlling the loess
calculation for smooth and mountain-type plots. See
panel.loess
for details.
do.out=TRUE
: Logical scalar. Parameter controlling the
boxplot appearance. See panel.bwplot
for details.
evaluation=50
: Numeric scalar. Parameter controlling the
loess calculation for smooth and mountain-type plots. See
panel.loess
for details.
factor=0.5
: Numeric scalar. Factor to control amount of
jittering in xy-type plots. See panel.xyplot
for details.
family="symmetric"
: Character scalar. Parameter controlling
the loess calculation for smooth and mountain-type plots. See
panel.loess
for details.
fill.confint=NULL
:Character vector. Fill colors for the confidence intervals for confint-type plots.
fill.histogram=NULL
: Character scalar. Fill color in
histogram-type plots, defaults to the setting of fill
.
fill.horizon=c("#B41414", "#E03231", "#F7A99C", "#9FC8DC",
"#468CC8", "#0165B3")
: The fill colors for the segments in the
horizon
-type plot. This should be a vector of length six, where the
first three entries are the colors for positive changes, and the latter
three entries are the colors for negative changes. Defaults to a red-blue
color scheme. See horizonplot
for details.
fill.mountain=c("#CCFFFF", "#FFCCFF")
:Character vector of length 2. Fill color in mountain-type and polygon-type plots.
fontface.legend=NULL
:Integer or character scalar. The font face for the legend text.
fontfamily.legend=NULL
:Integer or character scalar. The font family for the legend text.
fontsize.legend=NULL
:Numeric scalar. The pixel size for the legend text.
fontcolor.legend="#808080"
:Integer or character scalar. The font color for the legend text.
gradient=c("#F7FBFF", "#DEEBF7", "#C6DBEF", "#9ECAE1",
"#6BAED6", "#4292C6", "#2171B5", "#08519C", "#08306B")
: Character vector.
The base colors for the gradient
plotting type or the heatmap
type with a single group. When plotting heatmaps with more than one group,
the col
parameter can be used to control the group color scheme,
however the gradient will always be from white to 'col' and thus does not
offer as much flexibility as this gradient
parameter.
groups=NULL
: Vector coercable to a factor. Optional sample
grouping. See 'Details' section in DataTrack
for
further information.
horizon.origin=0
: The baseline relative to which changes are
indicated on the horizon
-type plot. See horizonplot
for
details.
horizon.scale=NULL
: The scale for each of the segments in the
horizon
-type plot. Defaults to 1/3 of the absolute data range. See
horizonplot
for details.
jitter.x=FALSE
: Logical scalar. Toggle on jittering on the x
axis in xy-type plots. See panel.xyplot
for details.
jitter.y=FALSE
: Logical scalar. Toggle off jittering on the y
axis in xy-type plots. See panel.xyplot
for details.
levels.fos=NULL
: Numeric scalar. Parameter controlling the
boxplot appearance. See panel.bwplot
for details.
legend=TRUE
:Boolean triggering the addition of a legend to the track to indicate groups. This only has an effect if at least two groups are present.
lineheight.legend=NULL
:Numeric scalar. The line height for the legend text.
lty.baseline=NULL
: Character or numeric scalar. Line type of
the optional baseline, defaults to the setting of lty
.
lty.mountain=NULL
: Character or numeric scalar. Line type in
mountain-type and polygon-type plots, defaults to the setting of
lty
.
lwd.baseline=NULL
: Numeric scalar. Line width of the optional
baseline, defaults to the setting of lwd
.
lwd.mountain=NULL
: Numeric scalar. Line width in
mountain-type and polygon-type plots, defaults to the setting of
lwd
.
min.distance=0
:Numeric scalar. The mimimum distance in pixel below which to collapse ranges.
na.rm=FALSE
:Boolean controlling whether to discard all NA values when plotting or to keep empty spaces for NAs
ncolor=100
:Integer scalar. The number of colors for the 'gradient' plotting type
notch.frac=0.5
: Numeric scalar. Parameter controlling the
boxplot appearance. See panel.bwplot
for details.
notch=FALSE
: Logical scalar. Parameter controlling the
boxplot appearance. See panel.bwplot
for details.
pch=20
:Integer scalar. The type of glyph used for plotting symbols.
separator=0
:Numeric scalar. Number of pixels used to separate individual samples in heatmap- and horizon-type plots.
showColorBar=TRUE
:Boolean. Indicate the data range color mapping in the axis for 'heatmap' or 'gradient' types.
showSampleNames=FALSE
:Boolean. Display the names of the individual samples in a heatmap or a horizon plot.
size=NULL
: Numeric scalar. The relative size of the track.
Can be overridden in the plotTracks
function. By default the
size will be set automatically based on the selected plotting type.
span=0.2
: Numeric scalar. Parameter controlling the loess
calculation for smooth and mountain-type plots. See
panel.loess
for details.
stackedBars=TRUE
:Logical scalar. When there are several data groups, draw the histogram-type plots as stacked barplots or grouped side by side.
stats=X[[i]]
: Function. Parameter controlling the boxplot
appearance. See panel.bwplot
for details.
transformation=NULL
: Function. Applied to the data matrix
prior to plotting or when calling the score
method. The function
should accept exactly one input argument and its return value needs to be a
numeric vector which can be coerced back into a data matrix of identical
dimensionality as the input data.
type="p"
: Character vector. The plot type, one or several in
p
,l
, b
, a
, a_confint
, s
, g
,
r
, S
, confint
, smooth
, histogram
,
mountain
, polygon
, h
, boxplot
, gradient
,
heatmap
, horizon
. See 'Details' section in
DataTrack
for more information on the individual
plotting types.
varwidth=FALSE
: Logical scalar. Parameter controlling the
boxplot appearance. See panel.bwplot
for details.
window=NULL
: Numeric or character scalar. Aggregate the rows
values of the data matrix to window
equally sized slices on the data
range using the method defined in aggregation
. If negative, apply a
running window of size windowSize
using the same aggregation method.
Alternatively, the special value auto
causes the function to
determine the optimal window size to avoid overplotting, and fixed
uses fixed-size windows of size windowSize
.
windowSize=NULL
: Numeric scalar. The size of the running
window when the value of window
is negative.
ylim=NULL
:Numeric vector of length 2. The range of the y-axis scale.
yTicksAt=NULL
: Numeric vector. The points at which y-axis
tick-marks are to be drawn. By default, when NULL
, tickmark locations
are computed.
Inherited from class GdObject:
alpha=1
:Numeric scalar. The transparency for all track items.
alpha.title=NULL
:Numeric scalar. The transparency for the title panel.
background.panel="transparent"
:Integer or character scalar. The background color of the content panel.
background.title="lightgray"
:Integer or character scalar. The background color for the title panel.
background.legend="transparent"
:Integer or character scalar. The background color for the legend.
cex.axis=NULL
: Numeric scalar. The expansion factor for the
axis annotation. Defaults to NULL
, in which case it is automatically
determined based on the available space.
cex.title=NULL
: Numeric scalar. The expansion factor for the
title panel. This effects the fontsize of both the title and the axis, if
any. Defaults to NULL
, which means that the text size is
automatically adjusted to the available space.
col.axis="white"
:Integer or character scalar. The font and line color for the y axis, if any.
col.border.title="white"
:Integer or character scalar. The border color for the title panels.
col.frame="lightgray"
: Integer or character scalar. The line
color used for the panel frame, if frame==TRUE
col.grid="#808080"
: Integer or character scalar. Default
line color for grid lines, both when type=="g"
in
DataTrack
s and when display parameter grid==TRUE
.
col.line=NULL
: Integer or character scalar. Default colors
for plot lines. Usually the same as the global col
parameter.
col.symbol=NULL
: Integer or character scalar. Default colors
for plot symbols. Usually the same as the global col
parameter.
col.title="white"
:Integer or character scalar. The border color for the title panels
fill="lightgray"
:Integer or character scalar. Default fill color setting for all plotting elements, unless there is a more specific control defined elsewhere.
fontcolor="black"
:Integer or character scalar. The font color for all text, unless a more specific definition exists.
fontface.title=2
:Integer or character scalar. The font face for the title panels.
fontface=1
:Integer or character scalar. The font face for all text, unless a more specific definition exists.
fontfamily.title="sans"
:Integer or character scalar. The font family for the title panels.
fontfamily="sans"
:Integer or character scalar. The font family for all text, unless a more specific definition exists.
fontsize=12
:Numeric scalar. The font size for all text, unless a more specific definition exists.
frame=FALSE
:Boolean. Draw a frame around the track when plotting.
h=-1
: Integer scalar. Parameter controlling the number of
horizontal grid lines, see panel.grid
for details.
lineheight=1
:Numeric scalar. The font line height for all text, unless a more specific definition exists.
lty.grid="solid"
: Integer or character scalar. Default line
type for grid lines, both when type=="g"
in DataTrack
s
and when display parameter grid==TRUE
.
lty="solid"
:Numeric scalar. Default line type setting for all plotting elements, unless there is a more specific control defined elsewhere.
lwd.border.title=1
:Integer scalar. The border width for the title panels.
lwd.title=1
:Integer scalar. The border width for the title panels
lwd.grid=1
: Numeric scalar. Default line width for grid
lines, both when type=="g"
in DataTrack
s and when
display parameter grid==TRUE
.
lwd=1
:Numeric scalar. Default line width setting for all plotting elements, unless there is a more specific control defined elsewhere.
min.height=3
: Numeric scalar. The minimum range height in
pixels to display. All ranges are expanded to this size in order to avoid
rendering issues. See collapsing
for details.
min.width=1
: Numeric scalar. The minimum range width in
pixels to display. All ranges are expanded to this size in order to avoid
rendering issues. See collapsing
for details.
reverseStrand=FALSE
: Logical scalar. Set up the plotting
coordinates in 3' -> 5' direction if TRUE
. This will effectively
mirror the plot on the vertical axis.
rotation.title=90
:The rotation angle for the text in the title panel. Even though this can be adjusted, the automatic resizing of the title panel will currently not work, so use at own risk.
rotation=0
:The rotation angle for all text unless a more specific definiton exists.
showAxis=TRUE
:Boolean controlling whether to plot a y axis (only applies to track types where axes are implemented).
showTitle=TRUE
: Boolean controlling whether to plot a title
panel. Although this can be set individually for each track, in multi-track
plots as created by plotTracks
there will still be an empty
placeholder in case any of the other tracks include a title. The same holds
true for axes. Note that the the title panel background color could be set
to transparent in order to completely hide it.
v=-1
: Integer scalar. Parameter controlling the number of
vertical grid lines, see panel.grid
for details.
background.title="transparent"
:Character scalar. The background color for the title panel. Defaults to omit the background.
bevel=0.45
:Numeric scalar, between 0 and 1. The level of smoothness for the two ends of the ideogram.
centromereShape="triangle"
:Character scalar. The shape of the centromere. Only "triangle" or "circle" is accepted. Default to "triangle"
cex.bands=0.7
:Numeric scalar. The font expansion factor for the chromosome band identifier text.
cex=0.8
:Numeric scalar. The overall font expansion factor for the chromosome name text.
col="red"
:Character scalar. The border color used for the highlighting of the currently displayed genomic region.
col.border.title="transparent"
:Integer or character scalar. The border color for the title panels.
lwd.border.title=1
:Integer scalar. The border width for the title panels.
fill="#FFE3E6"
:Character scalar. The fill color used for the highlighting of the currently displayed genomic region.
fontface=1
:Character scalar. The font face for the chromosome name text.
fontfamily="sans"
:Character scalar. The font family for the chromosome name text.
fontcolor="#808080"
:Character scalar. The font color for the chromosome name text.
fontsize=10
:Numeric scalar. The font size for the chromosome name text.
outline=FALSE
:Logical scalar. Add borders to the individual chromosome staining bands.
showBandId=FALSE
:Logical scalar. Show the identifier for the chromosome bands if there is space for it.
lty=1
:Character or integer scalar. The line type used for the highlighting of the currently displayed genomic region.
lwd=1
:Numeric scalar. The line width used for the highlighting of the currently displayed genomic region.
showId=TRUE
:Logical scalar. Indicate the chromosome name next to the ideogram.
showTitle=FALSE
:Logical scalar. Plot a title panel. Defaults to omit the title panel.
size=NULL
: Numeric scalar. The relative size of the track.
Defaults to automatic size setting. Can also be overridden in the
plotTracks
function.
Inherited from class GdObject:
alpha=1
:Numeric scalar. The transparency for all track items.
alpha.title=NULL
:Numeric scalar. The transparency for the title panel.
background.panel="transparent"
:Integer or character scalar. The background color of the content panel.
background.legend="transparent"
:Integer or character scalar. The background color for the legend.
cex.axis=NULL
: Numeric scalar. The expansion factor for the
axis annotation. Defaults to NULL
, in which case it is automatically
determined based on the available space.
cex.title=NULL
: Numeric scalar. The expansion factor for the
title panel. This effects the fontsize of both the title and the axis, if
any. Defaults to NULL
, which means that the text size is
automatically adjusted to the available space.
col.axis="white"
:Integer or character scalar. The font and line color for the y axis, if any.
col.frame="lightgray"
: Integer or character scalar. The line
color used for the panel frame, if frame==TRUE
col.grid="#808080"
: Integer or character scalar. Default
line color for grid lines, both when type=="g"
in
DataTrack
s and when display parameter grid==TRUE
.
col.line=NULL
: Integer or character scalar. Default colors
for plot lines. Usually the same as the global col
parameter.
col.symbol=NULL
: Integer or character scalar. Default colors
for plot symbols. Usually the same as the global col
parameter.
col.title="white"
:Integer or character scalar. The border color for the title panels
collapse=TRUE
: Boolean controlling whether to collapse the
content of the track to accomodate the minimum current device resolution.
See collapsing
for details.
fontface.title=2
:Integer or character scalar. The font face for the title panels.
fontfamily.title="sans"
:Integer or character scalar. The font family for the title panels.
frame=FALSE
:Boolean. Draw a frame around the track when plotting.
grid=FALSE
:Boolean, switching on/off the plotting of a grid.
h=-1
: Integer scalar. Parameter controlling the number of
horizontal grid lines, see panel.grid
for details.
lineheight=1
:Numeric scalar. The font line height for all text, unless a more specific definition exists.
lty.grid="solid"
: Integer or character scalar. Default line
type for grid lines, both when type=="g"
in DataTrack
s
and when display parameter grid==TRUE
.
lwd.title=1
:Integer scalar. The border width for the title panels
lwd.grid=1
: Numeric scalar. Default line width for grid
lines, both when type=="g"
in DataTrack
s and when
display parameter grid==TRUE
.
min.distance=1
: Numeric scalar. The minimum pixel distance
before collapsing range items, only if collapse==TRUE
. See
collapsing
for details.
min.height=3
: Numeric scalar. The minimum range height in
pixels to display. All ranges are expanded to this size in order to avoid
rendering issues. See collapsing
for details.
min.width=1
: Numeric scalar. The minimum range width in
pixels to display. All ranges are expanded to this size in order to avoid
rendering issues. See collapsing
for details.
reverseStrand=FALSE
: Logical scalar. Set up the plotting
coordinates in 3' -> 5' direction if TRUE
. This will effectively
mirror the plot on the vertical axis.
rotation.title=90
:The rotation angle for the text in the title panel. Even though this can be adjusted, the automatic resizing of the title panel will currently not work, so use at own risk.
rotation=0
:The rotation angle for all text unless a more specific definiton exists.
showAxis=TRUE
:Boolean controlling whether to plot a y axis (only applies to track types where axes are implemented).
v=-1
: Integer scalar. Parameter controlling the number of
vertical grid lines, see panel.grid
for details.
arrowHeadWidth=30
: Numeric scalar. The width of the arrow
head in pixels if shape
is fixedArrow
.
arrowHeadMaxWidth=40
: Numeric scalar. The maximum width of
the arrow head in pixels if shape
is arrow
.
cex.group=0.6
:Numeric scalar. The font expansion factor for the group-level annotation.
cex=1
:Numeric scalar. The font expansion factor for item identifiers.
col.line="darkgray"
: Character scalar. The color used for
connecting lines between grouped items. Defaults to a light gray, but if set
to NULL
the same color as for the first item in the group is used.
col="transparent"
:Character or integer scalar. The border color for all track items.
featureAnnotation=NULL
: Character scalar. Add annotation
information to the individual track elements. This can be a value in
id
, group
or feature
. Defaults to id
. Only
works if showFeatureId
is not FALSE
.
fill="lightblue"
: Character or integer scalar. The fill
color for untyped items. This is also used to connect grouped items. See
grouping
for details.
fontfamily.group="sans"
:Character scalar. The font family for the group-level annotation.
fontcolor.group="#808080"
:Character or integer scalar. The font color for the group-level annotation.
fontcolor.item="white"
:Character or integer scalar. The font color for item identifiers.
fontface.group=2
:Numeric scalar. The font face for the group-level annotation.
fontsize.group=12
:Numeric scalar. The font size for the group-level annotation.
groupAnnotation=NULL
: Character scalar. Add annotation
information as group labels. This can be a value in id
, group
or feature
. Defaults to group
. Only works if showId
is
not FALSE
.
just.group="left"
: Character scalar. the justification of
group labels. Either left
, right
, above
or
below
.
lex=1
: Numeric scalar. The line expansion factor for all
track items. This is also used to connect grouped items. See
grouping
for details.
lineheight=1
:Numeric scalar. The font line height for item identifiers.
lty="solid"
: Character or integer scalar. The line type for
all track items. This is also used to connect grouped items. See
grouping
for details.
lwd=1
: Integer scalar. The line width for all track items.
This is also used to connect grouped items. See grouping
for
details.
mergeGroups=FALSE
: Logical scalar. Merge fully overlapping
groups if collapse==TRUE
.
min.height=3
: Numeric scalar. The minimum range height in
pixels to display. All ranges are expanded to this size in order to avoid
rendering issues. See collapsing
for details. For feathered
bars indicating the strandedness of grouped items this also controls the
height of the arrow feathers.
min.width=1
: Numeric scalar. The minimum range width in
pixels to display. All ranges are expanded to this size in order to avoid
rendering issues. See collapsing
for details.
rotation=0
:Numeric scalar. The degree of text rotation for item identifiers.
rotation.group=0
:Numeric scalar. The degree of text rotation for group labels.
rotation.item=0
:Numeric scalar. The degree of text rotation for item identifiers.
shape="arrow"
: Character scalar. The shape in which to
display the track items. Currently only box
, arrow
,
fixedArrow
, ellipse
, and smallArrow
are implemented.
showFeatureId=FALSE
:Logical scalar. Control whether to plot the individual track item identifiers.
showId=FALSE
:Logical scalar. Control whether to annotate individual groups.
showOverplotting=FALSE
: Logical scalar. Use a color gradient
to show the amount of overplotting for collapsed items. This implies that
collapse==TRUE
size=1
: Numeric scalar. The relative size of the track. Can
be overridden in the plotTracks
function.
Inherited from class StackedTrack:
stackHeight=0.75
:Numeric between 0 and 1. Controls the vertical size and spacing between stacked elements. The number defines the proportion of the total available space for the stack that is used to draw the glyphs. E.g., a value of 0.5 means that half of the available vertical drawing space (for each stacking line) is used for the glyphs, and thus one quarter of the available space each is used for spacing above and below the glyph. Defaults to 0.75.
reverseStacking=FALSE
:Logical flag. Reverse the y-ordering of stacked items. I.e., features that are plotted on the bottom-most stacks will be moved to the top-most stack and vice versa.
Inherited from class GdObject:
alpha=1
:Numeric scalar. The transparency for all track items.
alpha.title=NULL
:Numeric scalar. The transparency for the title panel.
background.panel="transparent"
:Integer or character scalar. The background color of the content panel.
background.title="lightgray"
:Integer or character scalar. The background color for the title panel.
background.legend="transparent"
:Integer or character scalar. The background color for the legend.
cex.axis=NULL
: Numeric scalar. The expansion factor for the
axis annotation. Defaults to NULL
, in which case it is automatically
determined based on the available space.
cex.title=NULL
: Numeric scalar. The expansion factor for the
title panel. This effects the fontsize of both the title and the axis, if
any. Defaults to NULL
, which means that the text size is
automatically adjusted to the available space.
col.axis="white"
:Integer or character scalar. The font and line color for the y axis, if any.
col.border.title="white"
:Integer or character scalar. The border color for the title panels.
col.frame="lightgray"
: Integer or character scalar. The line
color used for the panel frame, if frame==TRUE
col.grid="#808080"
: Integer or character scalar. Default
line color for grid lines, both when type=="g"
in
DataTrack
s and when display parameter grid==TRUE
.
col.symbol=NULL
: Integer or character scalar. Default colors
for plot symbols. Usually the same as the global col
parameter.
col.title="white"
:Integer or character scalar. The border color for the title panels
collapse=TRUE
: Boolean controlling whether to collapse the
content of the track to accomodate the minimum current device resolution.
See collapsing
for details.
fontcolor="black"
:Integer or character scalar. The font color for all text, unless a more specific definition exists.
fontface.title=2
:Integer or character scalar. The font face for the title panels.
fontface=1
:Integer or character scalar. The font face for all text, unless a more specific definition exists.
fontfamily.title="sans"
:Integer or character scalar. The font family for the title panels.
fontfamily="sans"
:Integer or character scalar. The font family for all text, unless a more specific definition exists.
fontsize=12
:Numeric scalar. The font size for all text, unless a more specific definition exists.
frame=FALSE
:Boolean. Draw a frame around the track when plotting.
grid=FALSE
:Boolean, switching on/off the plotting of a grid.
h=-1
: Integer scalar. Parameter controlling the number of
horizontal grid lines, see panel.grid
for details.
lty.grid="solid"
: Integer or character scalar. Default line
type for grid lines, both when type=="g"
in DataTrack
s
and when display parameter grid==TRUE
.
lwd.border.title=1
:Integer scalar. The border width for the title panels.
lwd.title=1
:Integer scalar. The border width for the title panels
lwd.grid=1
: Numeric scalar. Default line width for grid
lines, both when type=="g"
in DataTrack
s and when
display parameter grid==TRUE
.
min.distance=1
: Numeric scalar. The minimum pixel distance
before collapsing range items, only if collapse==TRUE
. See
collapsing
for details.
reverseStrand=FALSE
: Logical scalar. Set up the plotting
coordinates in 3' -> 5' direction if TRUE
. This will effectively
mirror the plot on the vertical axis.
rotation.title=90
:The rotation angle for the text in the title panel. Even though this can be adjusted, the automatic resizing of the title panel will currently not work, so use at own risk.
showAxis=TRUE
:Boolean controlling whether to plot a y axis (only applies to track types where axes are implemented).
showTitle=TRUE
: Boolean controlling whether to plot a title
panel. Although this can be set individually for each track, in multi-track
plots as created by plotTracks
there will still be an empty
placeholder in case any of the other tracks include a title. The same holds
true for axes. Note that the the title panel background color could be set
to transparent in order to completely hide it.
v=-1
: Integer scalar. Parameter controlling the number of
vertical grid lines, see panel.grid
for details.
arrowHeadWidth=10
: Numeric scalar. The width of the arrow
head in pixels if shape
is fixedArrow
.
arrowHeadMaxWidth=20
: Numeric scalar. The maximum width of
the arrow head in pixels if shape
is arrow
.
col=NULL
: Character or integer scalar. The border color for
all track items. Defaults to using the same color as in fill
, also
taking into account different track features
.
collapseTranscripts=FALSE
: Logical or character scalar. Can
be one in gene
, longest
, shortest
or meta
. Merge
all transcripts of the same gene into one single gene model. In the case of
gene
(or TRUE
), this will only keep the start location of the
first exon and the end location of the last exon from all transcripts of the
gene. For shortest
and longest
, only the longest or shortest
transcript model is retained. For meta
, a meta-transcript containing
the union of all exons is formed (essentially identical to the operation
reduce(geneModel)
).
exonAnnotation=NULL
: Character scalar. Add annotation
information to the individual exon models. This can be a value in
symbol
, gene
, transcript
, exon
or
feature
. Defaults to exon
. Only works if showExonId
is
not FALSE
.
fill="orange"
: Character or integer scalar. The fill color
for untyped items. This is also used to connect grouped items. See
grouping
for details.
min.distance=0
: Numeric scalar. The minimum pixel distance
before collapsing range items, only if collapse==TRUE
. See
collapsing
for details. Note that a value larger than 0 may
lead to UTR regions being merged to CDS regions, which in most cases is not
particularly useful.
shape=c("smallArrow", "box")
: Character scalar. The shape in
which to display the track items. Currently only box
, arrow
,
ellipse
, and smallArrow
are implemented.
showExonId=NULL
:Logical scalar. Control whether to plot the individual exon identifiers.
thinBoxFeature=c("utr", "ncRNA", "utr3", "utr5", "3UTR",
"5UTR", "miRNA", "lincRNA", "three_prime_UTR", "five_prime_UTR")
:Character vector. A listing of feature types that should be drawn with thin boxes. Typically those are non-coding elements.
transcriptAnnotation=NULL
: Character scalar. Add annotation
information as transcript labels. This can be a value in symbol
,
gene
, transcript
, exon
or feature
. Defaults to
symbol
. Only works if showId
is not FALSE
.
Inherited from class AnnotationTrack:
cex.group=0.6
:Numeric scalar. The font expansion factor for the group-level annotation.
cex=1
:Numeric scalar. The font expansion factor for item identifiers.
col.line="darkgray"
: Character scalar. The color used for
connecting lines between grouped items. Defaults to a light gray, but if set
to NULL
the same color as for the first item in the group is used.
featureAnnotation=NULL
: Character scalar. Add annotation
information to the individual track elements. This can be a value in
id
, group
or feature
. Defaults to id
. Only
works if showFeatureId
is not FALSE
.
fontfamily.group="sans"
:Character scalar. The font family for the group-level annotation.
fontcolor.group="#808080"
:Character or integer scalar. The font color for the group-level annotation.
fontcolor.item="white"
:Character or integer scalar. The font color for item identifiers.
fontface.group=2
:Numeric scalar. The font face for the group-level annotation.
fontsize.group=12
:Numeric scalar. The font size for the group-level annotation.
groupAnnotation=NULL
: Character scalar. Add annotation
information as group labels. This can be a value in id
, group
or feature
. Defaults to group
. Only works if showId
is
not FALSE
.
just.group="left"
: Character scalar. the justification of
group labels. Either left
, right
, above
or
below
.
lex=1
: Numeric scalar. The line expansion factor for all
track items. This is also used to connect grouped items. See
grouping
for details.
lineheight=1
:Numeric scalar. The font line height for item identifiers.
lty="solid"
: Character or integer scalar. The line type for
all track items. This is also used to connect grouped items. See
grouping
for details.
lwd=1
: Integer scalar. The line width for all track items.
This is also used to connect grouped items. See grouping
for
details.
mergeGroups=FALSE
: Logical scalar. Merge fully overlapping
groups if collapse==TRUE
.
min.height=3
: Numeric scalar. The minimum range height in
pixels to display. All ranges are expanded to this size in order to avoid
rendering issues. See collapsing
for details. For feathered
bars indicating the strandedness of grouped items this also controls the
height of the arrow feathers.
min.width=1
: Numeric scalar. The minimum range width in
pixels to display. All ranges are expanded to this size in order to avoid
rendering issues. See collapsing
for details.
rotation=0
:Numeric scalar. The degree of text rotation for item identifiers.
rotation.group=0
:Numeric scalar. The degree of text rotation for group labels.
rotation.item=0
:Numeric scalar. The degree of text rotation for item identifiers.
showFeatureId=FALSE
:Logical scalar. Control whether to plot the individual track item identifiers.
showId=FALSE
:Logical scalar. Control whether to annotate individual groups.
showOverplotting=FALSE
: Logical scalar. Use a color gradient
to show the amount of overplotting for collapsed items. This implies that
collapse==TRUE
size=1
: Numeric scalar. The relative size of the track. Can
be overridden in the plotTracks
function.
Inherited from class StackedTrack:
stackHeight=0.75
:Numeric between 0 and 1. Controls the vertical size and spacing between stacked elements. The number defines the proportion of the total available space for the stack that is used to draw the glyphs. E.g., a value of 0.5 means that half of the available vertical drawing space (for each stacking line) is used for the glyphs, and thus one quarter of the available space each is used for spacing above and below the glyph. Defaults to 0.75.
reverseStacking=FALSE
:Logical flag. Reverse the y-ordering of stacked items. I.e., features that are plotted on the bottom-most stacks will be moved to the top-most stack and vice versa.
Inherited from class GdObject:
alpha=1
:Numeric scalar. The transparency for all track items.
alpha.title=NULL
:Numeric scalar. The transparency for the title panel.
background.panel="transparent"
:Integer or character scalar. The background color of the content panel.
background.title="lightgray"
:Integer or character scalar. The background color for the title panel.
background.legend="transparent"
:Integer or character scalar. The background color for the legend.
cex.axis=NULL
: Numeric scalar. The expansion factor for the
axis annotation. Defaults to NULL
, in which case it is automatically
determined based on the available space.
cex.title=NULL
: Numeric scalar. The expansion factor for the
title panel. This effects the fontsize of both the title and the axis, if
any. Defaults to NULL
, which means that the text size is
automatically adjusted to the available space.
col.axis="white"
:Integer or character scalar. The font and line color for the y axis, if any.
col.border.title="white"
:Integer or character scalar. The border color for the title panels.
col.frame="lightgray"
: Integer or character scalar. The line
color used for the panel frame, if frame==TRUE
col.grid="#808080"
: Integer or character scalar. Default
line color for grid lines, both when type=="g"
in
DataTrack
s and when display parameter grid==TRUE
.
col.symbol=NULL
: Integer or character scalar. Default colors
for plot symbols. Usually the same as the global col
parameter.
col.title="white"
:Integer or character scalar. The border color for the title panels
collapse=TRUE
: Boolean controlling whether to collapse the
content of the track to accomodate the minimum current device resolution.
See collapsing
for details.
fontcolor="black"
:Integer or character scalar. The font color for all text, unless a more specific definition exists.
fontface.title=2
:Integer or character scalar. The font face for the title panels.
fontface=1
:Integer or character scalar. The font face for all text, unless a more specific definition exists.
fontfamily.title="sans"
:Integer or character scalar. The font family for the title panels.
fontfamily="sans"
:Integer or character scalar. The font family for all text, unless a more specific definition exists.
fontsize=12
:Numeric scalar. The font size for all text, unless a more specific definition exists.
frame=FALSE
:Boolean. Draw a frame around the track when plotting.
grid=FALSE
:Boolean, switching on/off the plotting of a grid.
h=-1
: Integer scalar. Parameter controlling the number of
horizontal grid lines, see panel.grid
for details.
lty.grid="solid"
: Integer or character scalar. Default line
type for grid lines, both when type=="g"
in DataTrack
s
and when display parameter grid==TRUE
.
lwd.border.title=1
:Integer scalar. The border width for the title panels.
lwd.title=1
:Integer scalar. The border width for the title panels
lwd.grid=1
: Numeric scalar. Default line width for grid
lines, both when type=="g"
in DataTrack
s and when
display parameter grid==TRUE
.
reverseStrand=FALSE
: Logical scalar. Set up the plotting
coordinates in 3' -> 5' direction if TRUE
. This will effectively
mirror the plot on the vertical axis.
rotation.title=90
:The rotation angle for the text in the title panel. Even though this can be adjusted, the automatic resizing of the title panel will currently not work, so use at own risk.
showAxis=TRUE
:Boolean controlling whether to plot a y axis (only applies to track types where axes are implemented).
showTitle=TRUE
: Boolean controlling whether to plot a title
panel. Although this can be set individually for each track, in multi-track
plots as created by plotTracks
there will still be an empty
placeholder in case any of the other tracks include a title. The same holds
true for axes. Note that the the title panel background color could be set
to transparent in order to completely hide it.
v=-1
: Integer scalar. Parameter controlling the number of
vertical grid lines, see panel.grid
for details.
C_segment="burlywood4"
:Character or integer scalar. Fill color for annotation objects of type 'C_segment'.
D_segment="lightblue"
:Character or integer scalar. Fill color for annotation objects of type 'C_segment'.
J_segment="dodgerblue2"
:Character or integer scalar. Fill color for annotation objects of type 'C_segment'.
Mt_rRNA="yellow"
:Character or integer scalar. Fill color for annotation objects of type 'Mt_rRNA'.
Mt_tRNA="darkgoldenrod"
:Character or integer scalar. Fill color for annotation objects of type 'Mt_tRNA'.
Mt_tRNA_pseudogene="darkgoldenrod1"
:Character or integer scalar. Fill color for annotation objects of type 'Mt_tRNA_pseudogene'.
V_segment="aquamarine"
:Character or integer scalar. Fill color for annotation objects of type 'V_segment'.
miRNA="cornflowerblue"
:Character or integer scalar. Fill color for annotation objects of type 'L_segment'.
miRNA_pseudogene="cornsilk"
:Character or integer scalar. Fill color for annotation objects of type 'miRNA_pseudogene'.
misc_RNA="cornsilk3"
:Character or integer scalar. Fill color for annotation objects of type 'misc_RNA'.
misc_RNA_pseudogene="cornsilk4"
:Character or integer scalar. Fill color for annotation objects of type 'misc_RNA_pseudogene'.
protein_coding="#FFD58A"
:Character or integer scalar. Fill color for annotation objects of type 'protein_coding'.
pseudogene="brown1"
:Character or integer scalar. Fill color for annotation objects of type 'pseudogene'.
rRNA="darkolivegreen1"
:Character or integer scalar. Fill color for annotation objects of type 'rRNA'.
rRNA_pseudogene="darkolivegreen"
:Character or integer scalar. Fill color for annotation objects of type 'rRNA_pseudogene'.
retrotransposed="blueviolet"
:Character or integer scalar. Fill color for annotation objects of type 'retrotransposed'.
scRNA="gold4"
:Character or integer scalar. Fill color for annotation objects of type 'scRNA'.
scRNA_pseudogene="darkorange2"
:Character or integer scalar. Fill color for annotation objects of type 'scRNA_pseudogene'.
snRNA="coral"
:Character or integer scalar. Fill color for annotation objects of type 'snRNA'.
snRNA_pseudogene="coral3"
:Character or integer scalar. Fill color for annotation objects of type 'snRNA_pseudogene'.
snoRNA="cyan"
:Character or integer scalar. Fill color for annotation objects of type 'snoRNA'.
snoRNA_pseudogene="cyan2"
:Character or integer scalar. Fill color for annotation objects of type 'snoRNA_pseudogene'.
tRNA_pseudogene="antiquewhite3"
:Character or integer scalar. Fill color for annotation objects of type 'tRNA_pseudogene'.
utr3="#FFD58A"
:Character or integer scalar. Fill color for annotation objects of type 'utr3'.
utr5="#FFD58A"
:Character or integer scalar. Fill color for annotation objects of type 'utr5'.
verbose=FALSE
:Logical scalar. Report data loading events from Bioamart or retrieval from cache.
Inherited from class GeneRegionTrack:
arrowHeadWidth=10
: Numeric scalar. The width of the arrow
head in pixels if shape
is fixedArrow
.
arrowHeadMaxWidth=20
: Numeric scalar. The maximum width of
the arrow head in pixels if shape
is arrow
.
col=NULL
: Character or integer scalar. The border color for
all track items. Defaults to using the same color as in fill
, also
taking into account different track features
.
collapseTranscripts=FALSE
: Logical or character scalar. Can
be one in gene
, longest
, shortest
or meta
. Merge
all transcripts of the same gene into one single gene model. In the case of
gene
(or TRUE
), this will only keep the start location of the
first exon and the end location of the last exon from all transcripts of the
gene. For shortest
and longest
, only the longest or shortest
transcript model is retained. For meta
, a meta-transcript containing
the union of all exons is formed (essentially identical to the operation
reduce(geneModel)
).
exonAnnotation=NULL
: Character scalar. Add annotation
information to the individual exon models. This can be a value in
symbol
, gene
, transcript
, exon
or
feature
. Defaults to exon
. Only works if showExonId
is
not FALSE
.
fill="orange"
: Character or integer scalar. The fill color
for untyped items. This is also used to connect grouped items. See
grouping
for details.
min.distance=0
: Numeric scalar. The minimum pixel distance
before collapsing range items, only if collapse==TRUE
. See
collapsing
for details. Note that a value larger than 0 may
lead to UTR regions being merged to CDS regions, which in most cases is not
particularly useful.
shape=c("smallArrow", "box")
: Character scalar. The shape in
which to display the track items. Currently only box
, arrow
,
ellipse
, and smallArrow
are implemented.
showExonId=NULL
:Logical scalar. Control whether to plot the individual exon identifiers.
thinBoxFeature=c("utr", "ncRNA", "utr3", "utr5", "3UTR",
"5UTR", "miRNA", "lincRNA", "three_prime_UTR", "five_prime_UTR")
:Character vector. A listing of feature types that should be drawn with thin boxes. Typically those are non-coding elements.
transcriptAnnotation=NULL
: Character scalar. Add annotation
information as transcript labels. This can be a value in symbol
,
gene
, transcript
, exon
or feature
. Defaults to
symbol
. Only works if showId
is not FALSE
.
Inherited from class AnnotationTrack:
cex.group=0.6
:Numeric scalar. The font expansion factor for the group-level annotation.
cex=1
:Numeric scalar. The font expansion factor for item identifiers.
col.line="darkgray"
: Character scalar. The color used for
connecting lines between grouped items. Defaults to a light gray, but if set
to NULL
the same color as for the first item in the group is used.
featureAnnotation=NULL
: Character scalar. Add annotation
information to the individual track elements. This can be a value in
id
, group
or feature
. Defaults to id
. Only
works if showFeatureId
is not FALSE
.
fontfamily.group="sans"
:Character scalar. The font family for the group-level annotation.
fontcolor.group="#808080"
:Character or integer scalar. The font color for the group-level annotation.
fontcolor.item="white"
:Character or integer scalar. The font color for item identifiers.
fontface.group=2
:Numeric scalar. The font face for the group-level annotation.
fontsize.group=12
:Numeric scalar. The font size for the group-level annotation.
groupAnnotation=NULL
: Character scalar. Add annotation
information as group labels. This can be a value in id
, group
or feature
. Defaults to group
. Only works if showId
is
not FALSE
.
just.group="left"
: Character scalar. the justification of
group labels. Either left
, right
, above
or
below
.
lex=1
: Numeric scalar. The line expansion factor for all
track items. This is also used to connect grouped items. See
grouping
for details.
lineheight=1
:Numeric scalar. The font line height for item identifiers.
lty="solid"
: Character or integer scalar. The line type for
all track items. This is also used to connect grouped items. See
grouping
for details.
lwd=1
: Integer scalar. The line width for all track items.
This is also used to connect grouped items. See grouping
for
details.
mergeGroups=FALSE
: Logical scalar. Merge fully overlapping
groups if collapse==TRUE
.
min.height=3
: Numeric scalar. The minimum range height in
pixels to display. All ranges are expanded to this size in order to avoid
rendering issues. See collapsing
for details. For feathered
bars indicating the strandedness of grouped items this also controls the
height of the arrow feathers.
min.width=1
: Numeric scalar. The minimum range width in
pixels to display. All ranges are expanded to this size in order to avoid
rendering issues. See collapsing
for details.
rotation=0
:Numeric scalar. The degree of text rotation for item identifiers.
rotation.group=0
:Numeric scalar. The degree of text rotation for group labels.
rotation.item=0
:Numeric scalar. The degree of text rotation for item identifiers.
showFeatureId=FALSE
:Logical scalar. Control whether to plot the individual track item identifiers.
showId=FALSE
:Logical scalar. Control whether to annotate individual groups.
showOverplotting=FALSE
: Logical scalar. Use a color gradient
to show the amount of overplotting for collapsed items. This implies that
collapse==TRUE
size=1
: Numeric scalar. The relative size of the track. Can
be overridden in the plotTracks
function.
Inherited from class StackedTrack:
stackHeight=0.75
:Numeric between 0 and 1. Controls the vertical size and spacing between stacked elements. The number defines the proportion of the total available space for the stack that is used to draw the glyphs. E.g., a value of 0.5 means that half of the available vertical drawing space (for each stacking line) is used for the glyphs, and thus one quarter of the available space each is used for spacing above and below the glyph. Defaults to 0.75.
reverseStacking=FALSE
:Logical flag. Reverse the y-ordering of stacked items. I.e., features that are plotted on the bottom-most stacks will be moved to the top-most stack and vice versa.
Inherited from class GdObject:
alpha=1
:Numeric scalar. The transparency for all track items.
alpha.title=NULL
:Numeric scalar. The transparency for the title panel.
background.panel="transparent"
:Integer or character scalar. The background color of the content panel.
background.title="lightgray"
:Integer or character scalar. The background color for the title panel.
background.legend="transparent"
:Integer or character scalar. The background color for the legend.
cex.axis=NULL
: Numeric scalar. The expansion factor for the
axis annotation. Defaults to NULL
, in which case it is automatically
determined based on the available space.
cex.title=NULL
: Numeric scalar. The expansion factor for the
title panel. This effects the fontsize of both the title and the axis, if
any. Defaults to NULL
, which means that the text size is
automatically adjusted to the available space.
col.axis="white"
:Integer or character scalar. The font and line color for the y axis, if any.
col.border.title="white"
:Integer or character scalar. The border color for the title panels.
col.frame="lightgray"
: Integer or character scalar. The line
color used for the panel frame, if frame==TRUE
col.grid="#808080"
: Integer or character scalar. Default
line color for grid lines, both when type=="g"
in
DataTrack
s and when display parameter grid==TRUE
.
col.symbol=NULL
: Integer or character scalar. Default colors
for plot symbols. Usually the same as the global col
parameter.
col.title="white"
:Integer or character scalar. The border color for the title panels
collapse=TRUE
: Boolean controlling whether to collapse the
content of the track to accomodate the minimum current device resolution.
See collapsing
for details.
fontcolor="black"
:Integer or character scalar. The font color for all text, unless a more specific definition exists.
fontface.title=2
:Integer or character scalar. The font face for the title panels.
fontface=1
:Integer or character scalar. The font face for all text, unless a more specific definition exists.
fontfamily.title="sans"
:Integer or character scalar. The font family for the title panels.
fontfamily="sans"
:Integer or character scalar. The font family for all text, unless a more specific definition exists.
fontsize=12
:Numeric scalar. The font size for all text, unless a more specific definition exists.
frame=FALSE
:Boolean. Draw a frame around the track when plotting.
grid=FALSE
:Boolean, switching on/off the plotting of a grid.
h=-1
: Integer scalar. Parameter controlling the number of
horizontal grid lines, see panel.grid
for details.
lty.grid="solid"
: Integer or character scalar. Default line
type for grid lines, both when type=="g"
in DataTrack
s
and when display parameter grid==TRUE
.
lwd.border.title=1
:Integer scalar. The border width for the title panels.
lwd.title=1
:Integer scalar. The border width for the title panels
lwd.grid=1
: Numeric scalar. Default line width for grid
lines, both when type=="g"
in DataTrack
s and when
display parameter grid==TRUE
.
reverseStrand=FALSE
: Logical scalar. Set up the plotting
coordinates in 3' -> 5' direction if TRUE
. This will effectively
mirror the plot on the vertical axis.
rotation.title=90
:The rotation angle for the text in the title panel. Even though this can be adjusted, the automatic resizing of the title panel will currently not work, so use at own risk.
showAxis=TRUE
:Boolean controlling whether to plot a y axis (only applies to track types where axes are implemented).
showTitle=TRUE
: Boolean controlling whether to plot a title
panel. Although this can be set individually for each track, in multi-track
plots as created by plotTracks
there will still be an empty
placeholder in case any of the other tracks include a title. The same holds
true for axes. Note that the the title panel background color could be set
to transparent in order to completely hide it.
v=-1
: Integer scalar. Parameter controlling the number of
vertical grid lines, see panel.grid
for details.
alpha.reads=0.5
:Numeric scalar between 0 and 1. The transparency of the individual read icons. Can be used to indicate overlapping regions in read pairs. Only on supported devices.
alpha.mismatch=1
:Numeric scalar between 0 and 1. The transparency of the mismatch base information.
cex=0.7
:Numeric Scalar. The global character expansion factor.
cex.mismatch=NULL
:Numeric Scalar. The character expansion factor for the mismatch base letters.
col.coverage=NULL
:Integer or character scalar. The line color for the coverage profile.
col.gap="#808080"
:Integer or character scalar. The color of the line that is bridging the gap regions in gapped alignments.
col.mates="#E0E0E0"
:Integer or character scalar. The color of the line that is connecting two paired reads.
col.deletion="#000000"
:Integer or character scalar. The color of the line that is bridging the deleted regions in alignments.
col.insertion="#984EA3"
:Integer or character scalar. The color of the line that highlighting insertions in alignments.
col.mismatch="#808080"
:Integer or character scalar. The box color around mismatch bases.
col.reads=NULL
:Integer or character scalar. The box color around reads.
col.sashimi=NULL
:Integer or character scalar. The line color for sashimi plots.
col="#808080"
:Integer or character scalar. The default color of all line elements.
collapse=FALSE
:Logical scalar. Do not perform any collapsing of overlapping elements. Currently not supported.
coverageHeight=0.1
:Numeric scalar. The height of the coverage region of the track. Can either be a value between 0 and 1 in which case it is taken as a relative height, or a positive value greater 1 in which case it is interpreted as pixels.
fill.coverage=NULL
:Integer or character scalar. The fill color for the coverage profile.
fill.reads=NULL
:Integer or character scalar. The fill color for the read icons.
fill="#BABABA"
:Integer or character scalar. The default fill color of all plot elements.
fontface.mismatch=2
:Integer scalar. The font face for mismatch bases.
lty.coverage=NULL
:Integer or character scalar. The line type of the coverage profile.
lty.gap=NULL
:Integer or character scalar. The type of the line that is bridging the gap regions in gapped alignments.
lty.mates=NULL
:Integer or character scalar. The type of the line that is connecting two paired reads.
lty.deletion=NULL
:Integer or character scalar. The type of the line that is bridging the deleted regions in alignments.
lty.insertion=NULL
:Integer or character scalar. The type of the line that highlighting insertions in alignments.
lty.mismatch=NULL
:Integer or character scalar. The box line type around mismatch bases.
lty.reads=NULL
:Integer or character scalar. The box line type around mismatch reads.
lty=1
:Integer or character scalar. The default type of all line elements.
lwd.coverage=NULL
:Integer or character scalar. The line width of the coverage profile.
lwd.gap=NULL
:Integer scalar. The width of the line that is bridging the gap regions in gapped alignments.
lwd.mates=NULL
:Integer scalar. The width of the line that is connecting two paired reads.
lwd.deletion=NULL
:Integer scalar. The width of the line that is bridging the deleted regions in alignments.
lwd.insertion=NULL
:Integer scalar. The width of the line that highlighting insertions in alignments.
lwd.mismatch=NULL
:Integer scalar. The box line width around mismatch bases.
lwd.reads=NULL
:Integer scalar. The box line width around reads.
lwd.sashimiMax=10
:Integer scalar. The maximal width of the line in sashimi plots.
lwd=1
:Integer scalar. The default width of all line elements.
max.height=10
: Integer scalar. The maximum height of an
individual read in pixels. Can be used in combination with min.height
to control the read and stacking appearance.
min.height=5
: Integer scalar. The minimum height of an
individual read in pixels. Can be used in combination with max.height
to control the read and stacking appearance.
minCoverageHeight=50
: Integer scalar. The minimum height of
the coverage section. Uselful in combination with a relative setting of
coverageHeight
.
minSashimiHeight=50
: Integer scalar. The minimum height of
the sashimi section. Uselful in combination with a relative setting of
sashimiHeight
.
noLetters=FALSE
:Logical scalar. Always plot colored boxes for mismatch bases regardles of the available space.
sashimiFilter=NULL
: GRanges object. Only junctions which
overlap equally with sashimiFilter
GRanges are shown. Default
NULL
, no filtering.
sashimiFilterTolerance=0
: Integer scalar. Only used in
combination with sashimiFilter
. It allows to include junctions whose
starts/ends are within specified distance from sashimiFilter
GRanges.
This is useful for cases where the aligner did not place the junction reads
precisely. Default 0L
, no tolerance.
sashimiHeight=0.1
:Integer scalar. The height of the sashimi part of the track. Can either be a value between 0 and 1 in which case it is taken as a relative height, or a positive value greater 1 in which case it is interpreted as pixels.
sashimiScore=1
:Integer scalar. The minimum number of reads supporting the junction.
sashimiStrand="*"
:Integer scalar. Only reads which have the specified strand are considered to count the junctions.
sashimiTransformation=NULL
:Function. Applied to the junction score vector prior to plotting. The function should accept exactly one input argument and its return value needs to be a numeric vector of identical length as the input data.
showIndels=FALSE
: Logical scalar. Consider insertions and
deletions in coverage and pile-up. Default is FALSE
. If set to
TRUE
the deletions defined in CIGAR string are not considered in
coverage plot. The deletions are displayed as bridging lines in pile-up
track. Insertions are shown as vertical bars.
showMismatches=TRUE
:Logical scalar. Add mismatch information, either as individual base letters or using color coded bars. This implies that the reference sequence has been provided, either to the class constructor or as part of the track list.
size=NULL
:Numeric scalar. The size of the track. Defaults to automatic sizing.
transformation=NULL
:Function. Applied to the coverage vector prior to plotting. The function should accept exactly one input argument and its return value needs to be a numeric Rle of identical length as the input data.
type=c("coverage", "pileup")
: Character vactor. The type of
information to plot. For coverage
a coverage plot, potentially
augmented by base mismatch information, for sashimi
a sashimi plot,
showing the juctions, and for pileup
the pileups of the individual
reads. These three can be combined.
Inherited from class StackedTrack:
stackHeight=0.75
:Numeric between 0 and 1. Controls the vertical size and spacing between stacked elements. The number defines the proportion of the total available space for the stack that is used to draw the glyphs. E.g., a value of 0.5 means that half of the available vertical drawing space (for each stacking line) is used for the glyphs, and thus one quarter of the available space each is used for spacing above and below the glyph. Defaults to 0.75.
reverseStacking=FALSE
:Logical flag. Reverse the y-ordering of stacked items. I.e., features that are plotted on the bottom-most stacks will be moved to the top-most stack and vice versa.
Inherited from class GdObject:
alpha=1
:Numeric scalar. The transparency for all track items.
alpha.title=NULL
:Numeric scalar. The transparency for the title panel.
background.panel="transparent"
:Integer or character scalar. The background color of the content panel.
background.title="lightgray"
:Integer or character scalar. The background color for the title panel.
background.legend="transparent"
:Integer or character scalar. The background color for the legend.
cex.axis=NULL
: Numeric scalar. The expansion factor for the
axis annotation. Defaults to NULL
, in which case it is automatically
determined based on the available space.
cex.title=NULL
: Numeric scalar. The expansion factor for the
title panel. This effects the fontsize of both the title and the axis, if
any. Defaults to NULL
, which means that the text size is
automatically adjusted to the available space.
col.axis="white"
:Integer or character scalar. The font and line color for the y axis, if any.
col.border.title="white"
:Integer or character scalar. The border color for the title panels.
col.frame="lightgray"
: Integer or character scalar. The line
color used for the panel frame, if frame==TRUE
col.grid="#808080"
: Integer or character scalar. Default
line color for grid lines, both when type=="g"
in
DataTrack
s and when display parameter grid==TRUE
.
col.line=NULL
: Integer or character scalar. Default colors
for plot lines. Usually the same as the global col
parameter.
col.symbol=NULL
: Integer or character scalar. Default colors
for plot symbols. Usually the same as the global col
parameter.
col.title="white"
:Integer or character scalar. The border color for the title panels
fontcolor="black"
:Integer or character scalar. The font color for all text, unless a more specific definition exists.
fontface.title=2
:Integer or character scalar. The font face for the title panels.
fontface=1
:Integer or character scalar. The font face for all text, unless a more specific definition exists.
fontfamily.title="sans"
:Integer or character scalar. The font family for the title panels.
fontfamily="sans"
:Integer or character scalar. The font family for all text, unless a more specific definition exists.
fontsize=12
:Numeric scalar. The font size for all text, unless a more specific definition exists.
frame=FALSE
:Boolean. Draw a frame around the track when plotting.
grid=FALSE
:Boolean, switching on/off the plotting of a grid.
h=-1
: Integer scalar. Parameter controlling the number of
horizontal grid lines, see panel.grid
for details.
lineheight=1
:Numeric scalar. The font line height for all text, unless a more specific definition exists.
lty.grid="solid"
: Integer or character scalar. Default line
type for grid lines, both when type=="g"
in DataTrack
s
and when display parameter grid==TRUE
.
lwd.border.title=1
:Integer scalar. The border width for the title panels.
lwd.title=1
:Integer scalar. The border width for the title panels
lwd.grid=1
: Numeric scalar. Default line width for grid
lines, both when type=="g"
in DataTrack
s and when
display parameter grid==TRUE
.
min.distance=1
: Numeric scalar. The minimum pixel distance
before collapsing range items, only if collapse==TRUE
. See
collapsing
for details.
min.width=1
: Numeric scalar. The minimum range width in
pixels to display. All ranges are expanded to this size in order to avoid
rendering issues. See collapsing
for details.
reverseStrand=FALSE
: Logical scalar. Set up the plotting
coordinates in 3' -> 5' direction if TRUE
. This will effectively
mirror the plot on the vertical axis.
rotation.title=90
:The rotation angle for the text in the title panel. Even though this can be adjusted, the automatic resizing of the title panel will currently not work, so use at own risk.
rotation=0
:The rotation angle for all text unless a more specific definiton exists.
showAxis=TRUE
:Boolean controlling whether to plot a y axis (only applies to track types where axes are implemented).
showTitle=TRUE
: Boolean controlling whether to plot a title
panel. Although this can be set individually for each track, in multi-track
plots as created by plotTracks
there will still be an empty
placeholder in case any of the other tracks include a title. The same holds
true for axes. Note that the the title panel background color could be set
to transparent in order to completely hide it.
v=-1
: Integer scalar. Parameter controlling the number of
vertical grid lines, see panel.grid
for details.
Florian Hahne
## Which scheme is used? getOption("Gviz.scheme") ## Change default settings for GeneRegionTrack scheme <- getScheme() scheme$GeneRegionTrack$fill <- "salmon" scheme$GeneRegionTrack$col <- NULL scheme$GeneRegionTrack$transcriptAnnotation <- "transcript" ## replace default scheme with myScheme addScheme(scheme, "myScheme") options(Gviz.scheme = "myScheme") getOption("Gviz.scheme") data(geneModels) grtrack <- GeneRegionTrack(geneModels, genome = "hg19", chromosome = "chr7", name = "Gene Model") plotTracks(grtrack)
## Which scheme is used? getOption("Gviz.scheme") ## Change default settings for GeneRegionTrack scheme <- getScheme() scheme$GeneRegionTrack$fill <- "salmon" scheme$GeneRegionTrack$col <- NULL scheme$GeneRegionTrack$transcriptAnnotation <- "transcript" ## replace default scheme with myScheme addScheme(scheme, "myScheme") options(Gviz.scheme = "myScheme") getOption("Gviz.scheme") data(geneModels) grtrack <- GeneRegionTrack(geneModels, genome = "hg19", chromosome = "chr7", name = "Gene Model") plotTracks(grtrack)
The virtual parent class for all track types in the Gviz package which contain potentially overlapping annotation items that have to be stacked when plotted.
## S4 method for signature 'StackedTrack' initialize(.Object, stacking, ...) ## S4 method for signature 'StackedTrack' stacking(GdObject) ## S4 replacement method for signature 'StackedTrack,character' stacking(GdObject) <- value ## S4 method for signature 'StackedTrack' stacks(GdObject) ## S4 method for signature 'StackedTrack' setStacks(GdObject, ...) ## S4 method for signature 'StackedTrack' consolidateTrack(GdObject, ...) ## S4 method for signature 'StackedTrack,ANY,ANY,ANY' x[i, j, ..., drop = TRUE] ## S4 method for signature 'StackedTrack' subset(x, from = NULL, to = NULL, sort = FALSE, stacks = FALSE, ...) ## S4 method for signature 'StackedTrack' drawGD(GdObject, ...)
## S4 method for signature 'StackedTrack' initialize(.Object, stacking, ...) ## S4 method for signature 'StackedTrack' stacking(GdObject) ## S4 replacement method for signature 'StackedTrack,character' stacking(GdObject) <- value ## S4 method for signature 'StackedTrack' stacks(GdObject) ## S4 method for signature 'StackedTrack' setStacks(GdObject, ...) ## S4 method for signature 'StackedTrack' consolidateTrack(GdObject, ...) ## S4 method for signature 'StackedTrack,ANY,ANY,ANY' x[i, j, ..., drop = TRUE] ## S4 method for signature 'StackedTrack' subset(x, from = NULL, to = NULL, sort = FALSE, stacks = FALSE, ...) ## S4 method for signature 'StackedTrack' drawGD(GdObject, ...)
.Object |
.Object |
stacking |
stacking |
... |
Additional arguments. |
GdObject |
Object of |
value |
Value to be set. |
x |
A valid track object class name, or the object itself, in which case the class is derived directly from it. |
i |
Numeric scalar, index to subset. |
j |
Numeric scalar, index to subset. Ignored. |
drop |
|
from , to
|
Numeric scalar, giving the range of genomic coordinates to
limit the tracks in. Note that |
sort |
|
stacks |
|
A virtual Class: No objects may be created from it.
initialize(StackedTrack)
: Initialize.
stacking(StackedTrack)
: return the current stacking type.
stacking(GdObject = StackedTrack) <- value
: set the object's stacking type to one in
c(hide, dense, squish, pack,full)
.
stacks(StackedTrack)
: return the stack indices for each track item.
setStacks(StackedTrack)
: recompute the stacks based on the available
space and on the object's track items and stacking settings.
consolidateTrack(StackedTrack)
: Consolidate.
a display parameter)
x[i
: subset the items in the StackedTrack
object.
This is essentially similar to subsetting of the GRanges
object in the
range slot. For most applications, the subset method may be more appropriate.
subset(StackedTrack)
: subset a StackedTrack
by coordinates and sort if necessary.
drawGD(StackedTrack)
: plot the object to a graphics device.
The return value of this method is the input object, potentially updated
during the plotting operation. Internally, there are two modes in which
the method can be called. Either in 'prepare' mode, in which case no
plotting is done but the stacking information is updated based on the
available space, or in 'plotting' mode, in which case the actual graphical
output is created. Note that the method for this particular subclass is
usually called through inheritance and not particularly useful on its own.
dp
Object of DisplayPars-class
, the display settings controlling the
look and feel of a track. See settings for details on setting graphical
parameters for tracks.
name
Object of class character
, a human-readable name for the track
that will be used in the track's annotation panel if necessary.
imageMap
Object of ImageMap-class
, containing optional information
for an HTML image map. This will be created by the drawGD
methods when the
track is plotted to a device and is usually not set by the user.
range
Object of class GRanges
, the genomic ranges of the track items
as well as additional annotation information in its elementMetaData
slot.
Please not that the slot is actually implemented as a class union between
GRanges
and IRanges to increase efficiency, for instance for DataTrack
objects. This usually does not concern the user.
chromosome
Object of class character
, the chromosome on which the
track is defined. There can only be a single chromosome for one track. For
certain subclasses, the space of allowed chromosome names is limited (e.g.,
only those chromosomes that exist for a particular genome). Throughout the
package, chromosome name have to be entered either as a single integer scalar
or as a character scalar of the form chrXYZ, where XYZ may be an arbitrary
character string.
genome
Object of class character
, the genome for which the track is
defined. For most sub-classes this has to be valid UCSC genome identifier,
however this may not always be formally checked upon object instantiation.
stacking
Object of class character
, the stacking type of overlapping
items on the final plot. One in c(hide, dense, squish, pack,full)
.
Currently, only hide
(do not show the track items at all), squish
(make
best use of the available space) and dense
(no stacking at all) are
implemented.
stacks
Object of class numeric
, holding the stack indices for each
track item. This slot is usually populated by calling the setStacks
method
upon plotting, since the correct stacking is a function of the available
plotting space.
Florian Hahne
## This is a reference class therefore we show below ## an example from AnnotationTrack ## An empty object AnnotationTrack() ## Construct from individual arguments st <- c(2000000, 2070000, 2100000, 2160000) ed <- c(2050000, 2130000, 2150000, 2170000) str <- c("-", "+", "-", "-") gr <- c("Group1", "Group2", "Group1", "Group3") annTrack <- AnnotationTrack( start = st, end = ed, strand = str, chromosome = 7, genome = "hg19", feature = "test", group = gr, id = paste("annTrack item", 1:4), name = "generic annotation", stacking = "squish" ) ## Plotting plotTracks(annTrack) ## Stacking stacking(annTrack) stacking(annTrack) <- "dense" plotTracks(annTrack)
## This is a reference class therefore we show below ## an example from AnnotationTrack ## An empty object AnnotationTrack() ## Construct from individual arguments st <- c(2000000, 2070000, 2100000, 2160000) ed <- c(2050000, 2130000, 2150000, 2170000) str <- c("-", "+", "-", "-") gr <- c("Group1", "Group2", "Group1", "Group3") annTrack <- AnnotationTrack( start = st, end = ed, strand = str, chromosome = 7, genome = "hg19", feature = "test", group = gr, id = paste("annTrack item", 1:4), name = "generic annotation", stacking = "squish" ) ## Plotting plotTracks(annTrack) ## Stacking stacking(annTrack) stacking(annTrack) <- "dense" plotTracks(annTrack)
The UCSC data base provides a wealth of annotation information. This
function can be used to access UCSC, to retrieve the data available there
and to return it as an annotation track object amenable to plotting with
plotTracks
.
UcscTrack( track, table = NULL, trackType = c("AnnotationTrack", "GeneRegionTrack", "DataTrack", "GenomeAxisTrack"), genome, chromosome, name = NULL, from, to, ... )
UcscTrack( track, table = NULL, trackType = c("AnnotationTrack", "GeneRegionTrack", "DataTrack", "GenomeAxisTrack"), genome, chromosome, name = NULL, from, to, ... )
track |
Character, the name of the track to fetch from UCSC. To find out about available tracks please consult the online table browser at http://genome.ucsc.edu/cgi-bin/hgTables?command=start. |
table |
Character, the name of the table to fetch from UCSC, or
|
trackType |
Character, one in |
genome |
Character, a valid USCS genome identifier for which to fetch the data. |
chromosome |
Character, a valid USCS character identifier for which to fetch the data. |
name |
Character, the name to use for the resulting track object. |
from , to
|
A range of genomic locations for which to fetch data. |
... |
All additional named arguments are expected to be either
display parameters for the resulting objects, or character scalars of column
names in the downloaded UCSC data tables that are matched by name to
available arguments in the respective constructor functions as defined by
the |
clearSessionCache
is can be called to remove all cached items from
the session which are generated when connecting with the UCSC data base.
The data stored at the UCSC data bases can be of different formats: gene or
transcript model data, simple annotation features like CpG Island locations
or SNPs, or numeric data like conservation or mapability. This function
presents a unified API to download all kinds of data and to map them back to
one of the annotation track objects defined in this package. The type of
object to hold the data has to be given in the trackType
argument,
and subsequently the function passes all data on to the respective object
constructor. All additional named arguments are considered to be relevant
for the constructor of choice, and single character scalars are replaced by
the respective data columns in the downloaded UCSC tables if available. For
instance, assuming the table for track 'foo' contains the columns 'id',
'type', 'fromLoc' and 'toLoc', giving the feature identifier, type, start
end end location. In order to create an AnnotationTrack
object from that data, we have to pass the additional named arguments
id="id"
, feature="type"
, start="fromLoc"
and
codeend="toLoc" to the UcscTrack
function. The complete function call
could look like this:
UcscTrack(track="foo", genome="mm9", chromosome=3, from=1000,
to=10000, trackType="AnnotationTrack", id="id", feature="type",
start="from", end="to")
To reduce the bandwidth, some caching of the UCSC connection takes place. In
order to remove these cached session items, call clearSessionCache
.
The Gviz.ucscUrl
option controls which URL is being used to connect
to UCSC. For instance, one could switch to the European UCSC mirror by
calling options(Gviz.ucscUrl="http://genome-euro.ucsc.edu/cgi-bin/"
.
An annotation track object as determined by trackType
.
Florian Hahne
## Not run: ## Create UcscTrack for Known Genes from mm9 genome from <- 65921878 to <- 65980988 knownGenes <- UcscTrack( genome = "mm9", chromosome = "chrX", track = "knownGene", from = from, to = to, trackType = "GeneRegionTrack", rstarts = "exonStarts", rends = "exonEnds", gene = "name", symbol = "name", transcript = "name", strand = "strand", fill = "#8282d2", name = "UCSC Genes" ) ## End(Not run) ## if the UCSC is not accessible load prepared object data(ucscItems) ## knownGenes is essentially GeneRegionTrack knownGenes ## plotting plotTracks(knownGenes, chromosome = "chrX", from = 65920688, to = 65960068)
## Not run: ## Create UcscTrack for Known Genes from mm9 genome from <- 65921878 to <- 65980988 knownGenes <- UcscTrack( genome = "mm9", chromosome = "chrX", track = "knownGene", from = from, to = to, trackType = "GeneRegionTrack", rstarts = "exonStarts", rends = "exonEnds", gene = "name", symbol = "name", transcript = "name", strand = "strand", fill = "#8282d2", name = "UCSC Genes" ) ## End(Not run) ## if the UCSC is not accessible load prepared object data(ucscItems) ## knownGenes is essentially GeneRegionTrack knownGenes ## plotting plotTracks(knownGenes, chromosome = "chrX", from = 65920688, to = 65960068)