rnb.options(...)
rnb.getOption(x)
character
s, or new option values given in the form name = value
.character
vector of length 1.rnb.getOption
, the current value for x
. For rnb.options()
, a list of all
RnBeads options and their current values. If option names are given, a list of all requested options
and their values. If option values are set, rnb.options
returns the previous values of the modified
options, invisibly.
analysis.name
= NULL
character
vector storing a short title of the analysis. If specified, this name appears at
the page title of every report.logging
= TRUE
email
= NULL
assembly
= "hg19"
rnb.get.assemblies
.analyze.sites
= TRUE
region.types
= NULL
character
vector. NULL
(default value)
signifies that all available region annotations (as returned by rnb.region.types
) are summarized
upon loading and normalization, and the other modules analyze all regions summarized in the dataset. If this
option is set to an empty vector, analysis on the region level is skipped.region.aggregation
= "mean"
"min"
, "max"
,
"mean"
(default), "median"
, "sum"
, "coverage.weighted"
. The last method is
applicable only for sequencing-based methylation datasets. It computes the weighted average of the values of
the associated CpGs, whereby weights are calculated based on the coverages of the respective sites.region.subsegments
= 0
region.types
option into subsegments containing on average region.subsegments
sites per
subsegment. This is done by clustering the sites within each regions according to their genomic coordinates.
These subsegments are then used for subsequent analysis.
Use cautiously as this will significantly increase the runtime of the pipeline.region.subsegments.types
= NULL
region.types
when set to
NULL
.identifiers.column
= NULL
NULL
, it points to a non-existing column or a column that does not list IDs, the default
identifiers are used. These are the row names of the sample phenotype table (and the column names of the beta
value matrix).colors.category
= c("#1B9E77","#D95F02",...)
character
vector of length 2 or more giving the color scheme for displaying categorical trait values in
plots. RnBeads denotes missing values (NA
) by grey, therefore, it is not recommended to include shades
of grey in this vector. The default value of this option is the result of the "Dark2"
palette of
RColorBrewer with 8 values.colors.gradient
= c("#132B43","#56B1F7")
character
vector of length 2 or more giving the color scheme for displaying continuous (gradient) trait
values in plots. RnBeads interpolates between the color values.min.group.size
= 2
integer
.max.group.count
= NULL
integer
of value 2
or
more. As a special case, a value of NULL
(default) indicates that the maximum number of subgroups is
the number of samples in an analysis minus 1
, i.e. traits with all unique values will be ignored.replicate.id.column
= NULL
NULL
(default), replicate handling is disabled.gz.large.files
= FALSE
.gz
format).import
= TRUE
FALSE
only when
the provided data source is an object of type RnBSet, i.e. the data has been previously loaded
by RnBeads.import.default.data.type
= "infinium.idat.dir"
bs.bed.dir
and save the options.
See rnb.execute.import
for further details.import.table.separator
= ","
rnb.execute.import
for details.import.bed.style
= "BisSNP"
"BisSNP", "Encode","EPP", "bismarkCytosine", "bismarkCov"
are currently
supported. See the RnBeads vignette and the FAQ section on the website for more details.import.bed.columns
integer
vector, in which the names are: "chr"
, "start"
,
"end"
, "strand"
, "meth"
, "coverage"
, "c"
and "t"
. These names
correspond the columns for chromosome, start position, end position, strand, methylation degree, read
coverage, number of reads with C and number of reads with T, respectively. Methylation degree and/or read
coverage, if not specified, are inferred from the values in the columns "c"
and "t"
.
Further details and examples of BED files can be found in Section 4.1 of the RnBeads vignette.import.bed.frame.shift
= 1
integer
specifying the frame shift between
the coordinates in the input BED file and the corresponding genomic reference. This (integer
) value
is added to the coordinates from the BED file before matching the methylation sites to the annotated ones.import.bed.test
= TRUE
import.bed.test.only
= FALSE
import.skip.object.check
= FALSE
import.gender.prediction
= TRUE
preprocessing
= TRUE
normalization
= NULL
NULL
(default) enables this step for analysis on Infinium datasets, but disables it in case of
sequencing-based datasets. Note that normalization is never applied in sequencing datasets; if this flag is
enabled, it will lead to a warning message.normalization.method
= "swan"
"none"
. Multiple normalization methods are supported:
"illumina"
-
methylumi-implemented
Illumina scaling normalization; "swan"
(default) - SWAN-normalization by Gordon et al., as implemented
in minfi; "bmiq"
-
beta-mixture quantile normalization method by Teschendorff et al; as well as "wm.dasen"
,
"wm.nasen"
, "wm.betaqn"
, "wm.naten"
, "wm.nanet"
, "wm.nanes"
,
"wm.danes"
, "wm.danet"
, "wm.danen"
, "wm.daten1"
, "wm.daten2"
,
"wm.tost"
, "wm.fuks"
and "wm.swan"
- all normalization methods implemented in the
wateRmelon package. When
setting this option to a specific algorithm, make sure its dedicated package is installed.normalization.background.method
= "methylumi.noob"
"none"
, "methylumi.noob"
,
"methylumi.goob"
and "methylumi.lumi"
.normalization.plot.shifts
= TRUE
qc
= TRUE
qc.boxplots
= TRUE
qc.barplots
= TRUE
qc.negative.boxplot
= TRUE
qc.snp.distances
= TRUE
qc.snp.boxplot
= FALSE
qc.snp.barplot
= FALSE
qc.sample.batch.size
= 50
qc.coverage.plots
= FALSE
qc.coverage.threshold.plot
= 1:10
integer
vector of positive values. Setting this to an empty vector disables the coverage thresholds plot.qc.coverage.histograms
= FALSE
qc.coverage.violins
= FALSE
filtering.whitelist
= NULL
chr2:48607772
. Unknown identifiers are silently ignored.filtering.blacklist
= NULL
chr2:48607772
.
Unknown identifiers are silently ignored.filtering.context.removal
= c("CC","CAG",...)
character
vector giving the list of probe context types to be removed as a filtering step. Possible
context values are "CC"
, "CG"
, "CAG"
, "CAH"
, "CTG"
, "CTH"
and
"Other"
. Probes in the second context measure CpG methylation; the last context denotes probes
dedicated to SNP detection. Setting this option to NULL
or an empty vector effectively disables the
step of context-specific probe removal.filtering.snp
= "3"
"no"
"3"
"5"
"any"
or "yes"
"3"
and
"5"
are treated as "yes"
.filtering.cross.reactive
= FALSE
filtering.greedycut
= TRUE
filtering.greedycut.pvalue.threshold
= 0.05
filtering.greedycut
is TRUE
.filtering.greedycut.rc.ties
= "row"
"row"
, "column"
or "any"
; the
last one indicating random choice. This option has effect only when filtering.greedycut
is
TRUE
.filtering.sex.chromosomes.removal
= FALSE
filtering.missing.value.quantile
= 1
NA
s in a larger fraction of samples than this threshold. Setting
this option to 1 (default) retains all sites, and thus effectively disables the missing value filtering step
in the preprocessing module. If this is set to 0, all sites that contain missing values are filtered out.filtering.coverage.threshold
= 5
filtering.low.coverage.masking
= FALSE
filtering.missing.value.quantile
this can lead to the removal of sites.filtering.high.coverage.outliers
= FALSE
filtering.deviation.threshold
= 0
NA
s),
are retained. Setting this option to 0 (default) disables filtering based on methylation variability.inference
= FALSE
inference.targets.sva
= character()
inference.reference.methylome.column
= character()
NA
values in this column.inference.max.cell.type.markers
= 10000
inference.top.cell.type.markers
= 500
inference.sva.num.method
= "leek"
sva
function for details.exploratory
= TRUE
exploratory.columns
= NULL
NULL
- indicates that columns should be
automatically selected; see rnb.sample.groups
for how this is done.exploratory.top.dimensions
= 0
exploratory.principal.components
= 8
integer
value between 0
and 10
. Setting this
option to 0
disables such tests.exploratory.correlation.pvalue.threshold
= 0.01
exploratory.correlation.permutations
= 10000
integer
.
Setting this option to 0
disables permutation tests.exploratory.correlation.qc
= TRUE
exploratory.principal.components
is non-zero.exploratory.beta.distribution
= TRUE
exploratory.intersample
= TRUE
exploratory.deviation.plots
= NULL
NULL
(default) enables deviation plots on Infinium datasets, but
disables them in case of sequencing-based datasets, because their generation can be very computationally
intensive. This option has effect only when exploratory.intersample
is TRUE
.exploratory.clustering
= "all"
"all"
(default), clustering is performed using all sites; a value of "top"
indicates that only
the most variable sites are used (see the option exploratory.clustering.top.sites
); and "none"
disables clustering.exploratory.clustering.top.sites
= 1000
integer
vector
containing positive values. This option is ignored when exploratory.clustering
is "none"
.exploratory.clustering.heatmaps.pdf
= FALSE
exploratory.clustering.top.sites
(more than 200), because heatmaps might generate very large PDF files.exploratory.region.profiles
= NULL
NULL
(default), regional methylation
profiles are created only for the region types that are available for the targeted assembly and summarized in
the dataset of interest. Setting this option to an empty vector disables the region profiles step in the
exploratory analysis module.exploratory.gene.symbols
= NULL
exploratory.custom.loci.bed
= NULL
differential
= TRUE
differential.site.test.method
= "limma"
limma
package for differential expression
in microarrays.differential.permutations
= 0
integer
. Setting this option to 0
(default)
disables permutation tests for rank permutations. Note that p-values for differential methylation are
computed and also considered for the ranking in any case.differential.comparison.columns
= NULL
NULL
- indicates that columns should be
automatically selected. Seernb.sample.groups
for how this is done. By default,
the comparisons are done in a one vs. all manner if there are multiple
groups defined in a column. differential.comparison.columns.all.pairwise
= NULL
NULL
(default) indicates that no column is selected for all pairwise comparisons explicitely.
If specified, the selected columns must be a subset of the columns that will be selected according to the
differential.comparison.columns
option.covariate.adjustment.columns
= NULL
differential.site.test.method=="limma"
.
columns.pairing
= NULL
rnb.sample.groups
differential.adjustment.sva
= TRUE
TRUE
, RnBeads looks for overlaps between the differential.comparison.columns
and
inference.targets.sva
options and include the surrogate variables as confounding factors only for these
columns. In other words, it will only have an effect if the corresponding inference option
(see inference.targets.sva
option for details) is enabled.
Currently this is only supported for differential.site.test.method=="limma"
.differential.adjustment.celltype
= TRUE
inference.reference.methylome.column
option for details). Currently this is only supported for differential.site.test.method=="limma"
.
differential.enrichment
= FALSE
differential.report.sites
= TRUE
analyze.sites
option.export.to.bed
= TRUE
export.to.trackhub
= c("bigBed","bigWig")
character
vector specifying which data types should be exported to
Track hub directories. Possible values
in the vector are "bigBed"
and "bigWig"
. When this options is set to NULL
, track hub
export is disabled. Note that if "bigBed"
is contained in this option, bed files are created
automatically.export.to.csv
= FALSE
export.to.ewasher
= FALSE
export.types
= "sites"
character
vector of sites and region names to be exported. If NULL
, no region methylation values
are exported.disk.dump.big.matrices
= FALSE
logging.exit.on.error
= FALSE
distribution.subsample
= 1000000
0
disables subsampling. More information
is presented the Details section of rnb.step.betadistribution
enforce.memory.management
= FALSE
enforce.destroy.disk.dumps
= FALSE
disk.dump.big.matrices
option) should actively
be deleted when RnBSets are modified. You should switch it to TRUE
when disk.dump.big.matrices
is TRUE
and the amount of hard drive space is also limited.rnb.options()
with no arguments returns a list with the current values of the options. To access the
value of a single option, one should use, e.g., rnb.getOption("filtering.greedycut")
, rather than
rnb.options("filtering.greedycut")
which is a list of length one. Also, only a limited set of options
is available (see below). Attempting to get or set the value of a non-existing option results in an error.
str(rnb.options())
rnb.getOption("filtering.greedycut")
Run the code above in your browser using DataLab