Minor changes:
[
) method, where drop
argument must appear at the end.bcbioRNASeq
generator unit test that imports GFF file to longtests,
as this can be slow to download from Ensembl FTP server.Minor changes:
EnsemblToNcbi
step, which no longer supports format
argument.Major changes:
Minor changes:
bcb
object.plotGeneSaturation
to plotFeatureSaturation
in QC template.plotGenesDetected
to plotFeaturesDetected
in QC template.plotMeanSD
to plotMeanSd
in QC template.plotPCA
to plotPca
in QC template.plotRRNAMappingRate
to plotRrnaMappingRate
in QC template.plotMA
to plotMa
in DE template.plotDEGPCA
to plotDegPca
in DE template.plotDEGHeatmap
to plotDegHeatmap
in DE template.Ensembl2Ncbi
to EnsemblToNcbi
in FA template.Minor changes:
isTximport
assert check
from the goalie package.Major changes:
bcbioRNASeq
object will now fail validity checks with validObject
if
entrezId
is defined in rowData instead of now preferred ncbiGeneId
. This
breaking change can be resolved using updateObject
.ncbiGeneId
instead of legacy entrezId
metadata in GRanges
returned by AcidGenomes package.Minor changes:
bcb
object using Bioconductor 3.17 dependencies.DFrame
and GRanges
instead of DataFrame
and
GenomicRanges
virtual classes internally.Minor changes:
tximport
call for
kallisto aligned against GENCODE reference. Refer to related Bioconductor
issue
for details.Minor changes:
requireNamespaces
import from AcidBase to goalie.Major changes:
Minor changes:
Map
instead of mapply
, where applicable.sessioninfo
as a dependency, switching back to using utils
sessionInfo
internally instead.Major changes:
Minor changes:
DataFrame
return from metrics
by default. Hardened calls to
ggplot
using as.data.frame
coercion.Major changes:
Minor changes:
DESCRIPTION
file.Starting a new release series for 2022.
Major changes:
Minor changes:
formalsList
parameters defined in basejump,
which will be removed in a pending release update.Minor changes:
bcbioRNASeq
object
(e.g. "bcb.rds"
), which has been moved back to data
instead of nested
inside of rds
by date (e.g. YYYY-MM-DD).Minor changes:
infReps
slot in list does not return named rows when txOut
is TRUE
for
Bioconductor 3.14 release.Minor changes:
plotVolcano
call as expected.Minor changes:
bcbioRNASeq
importer now supports a very minimal dataset with a
single sample, which isn't common.Maintenance release, incorporating useful changes from the basejump v0.14 release series.
Minor changes:
makeGRangesFromEnsembl
)
need to have ignoreVersion = TRUE
defined, since this argument changed
by default in AcidGenomes.Minor changes:
assays
slot)
in a tryCatch
call, to more gracefully avoid errors on minimal data sets,
such as the bcbio-nextgen unit test data.Minor changes:
Minor changes:
fast = TRUE
.show
: Added display of fast: TRUE
when applicable.Minor changes:
Minor changes:
Minor changes:
plotPCACovariates
, which causing CI checks to error due
to a dplyr bug in DEGreport. Will reenable when this gets fixed and is updated
on Bioconductor.Minor changes:
bcbioRNASeq
generator now has improved message support for selected samples.
Internally, this is managed by the cli package.updateObject
: Now supporting verbose
argument, which defaults to FALSE
.Minor changes:
bcbioRNASeq
: Removed now defunct spikeNames
argument. Refer to
makeSummarizedExperiment
documentation and release notes in basejump
package for details.Minor changes:
dataVersions
and programsVersions
in
metadata
slot, for compatibility with updateObject
upgrade path from
v0.2.9 objects, which are currently generated by bcbio-nextgen. Thanks
@sjmonkley for catching this. See issue #146.Major changes:
bcbioRNASeq
to DGEList
coercion, for handoff
to edgeR and limma-voom. Now the code handles countsFromAbundance
settings
more intelligently and informs the user whether downstream edgeR and/or
limma-voom handoff is appropriate.as.DESeqDataSet
, as.DESeqTransform
, and as.DGEList
S4
generic methods, which support arguments. Note that quick coercion using
only as
(see coerce
documentation from Bioconductor) does not support
arguments.Minor changes:
Minor changes:
DataFrame
validity checks to also check for DFrame
class,
which has changed in latest S4Vectors 0.23 release.Minor changes:
Minor changes:
bcbioRNASeq
: Internal generator now calls importSampleData
using
pipeline = "bcbio"
argument, so we don't run into breaking changes when
handling user metadata in a future basejump update.Minor changes:
Major changes:
[
) operations.updateObject
: Improved rowRanges
handling.Minor changes:
bcbioRNASeq
generator now captures call using standardizeCall
instead of
match.call
, and automatically expands all default arguments.plotPCACovariates
: Reworked internal code to not depend on dplyr.Minor changes:
bcbioRNASeq
, [
, and updateObject
.Major changes:
updateObject
: Worked internal approach to be compatible with upcoming
Bioconductor 3.10 release. Has to rethink the strategy to handling assays
internally, which can no longer be easily coerced from assays slot in the
bcbioRNASeq
object, due to changes in ShallowSimpleListAssays
handling.
This should return an object in exactly the same manner as previous releases.Major changes:
bcbioRNASeq
: Now supporting fast
argument, which enables the user to skip
any internal DESeq2 calculations. This will skip generation of normalized
,
vst
, and fpkm
matrices. Note that automatic rlog
matrix generation is
no longer supported, since it's often too slow, especially for large datasets.
If you want to generate rlog counts, simply coerce the bcbioRNASeq object
to a DESeqDataSet, then run the rlog
function.counts
assay. These values
are saved in an aligned
matrix.New functions:
pseudoVsAligned
: Visually inspect the correlation of pseudoaligned counts
to the aligned counts. Note that default bcbio genomes use legacy UCSC builds,
where as the pseudoaligners generate values from newer Ensembl transcript
annotations.Minor changes:
Major changes:
bcbioRNASeq
to DGEList
(edgeR) object coercion.relativeLogExpression
: Improved internal code, using edgeR
calcNormFactors
approach.Minor changes:
Minor changes:
counts
call.plotMeanSD
: Improved default colors. Improved internal non-zero count
handling. Reworked plot headers.Major changes:
Minor changes:
Minor changes:
Minor changes:
flip = TRUE
. This is more human readable.bcbiornaseq_file
as main input param..normalizedTrans
function required for some
quality control plots.Minor changes:
rnaseq
Docker image.Minor changes:
travis-render.sh
script into kebab
case, rather than snake case.inheritParams
).Moved forked development repository to Acid Genomics.
Major changes:
Minor changes:
counts
for example.basejump
prefix to acid
, where applicable.Minor changes:
bcbioRNASeq
validity method.bcbioRNASeq
object input. This is likely not necessary and will be removed
in a future update.bcbioRNASeq
to DESeqDataSet
coercion.perMillion
argument code handling inside plotting
functions: plotMappedReads
, plotTotalReads
.reexports.R
. No longer reexporting Gene2Symbol
or magrittr pipe.Major changes:
sampleData
: Moved method support to basejump package.Minor changes:
DataFrame
.Minor changes:
plotGene
to plotCounts
, to match consistency in basejump and
DESeqAnalysis package updates.Minor changes:
Minor changes:
interestingGroups
handling in plotting functions. Needed
to add back an interestingGroups<-
assignment call to slot the object.sanitizeRowData
and sanitizeSampleData
from imports.Minor changes:
.tximport
: Use makeNames
to check for valid names internally.Major changes:
bcbioRNASeq
. Improved check steps using ok
method, similar to approach in goalie.plotPCACovariates
method support.Minor changes:
alphaSummary
, contrastName
,
export
, markdown
, sampleData
, topTables
nullOK
mode where applicable.
This is particularly use for formals that use NULL
by default. See
bcbioRNASeq
generator changes, for example.prepareRNASeqTemplate
example is causing build checks to fail, so disable.This is the first release that switched over to using goalie for assert checks instead of assertive.
Major changes:
bcbioRNASeq
generator has been overhauled to use assert
for assert checks.Minor changes:
validate
in place of validate_that
in validity checks.match.arg
internally to check validity of countsFromAbundance
argument passthrough to tximport
.Major changes:
params$object_file
. This convention will be used across all other bcbio R
packages. Reworked and simplified plotCountsPerGene
section of QC template.Minor changes:
plotCountsPerBiotype
: Ensure normalized
argument uses "tpm" first.plotDispEsts
: Switch to using hasUniqueCols
internally instead of
areSamplesUnique
.Major changes:
relevelRowRanges
and relevelColData
utilities from
basejump.Minor changes:
sampleData<-
reexport.bcbioRNASeq
generator function.bcbioRNASeq
generator function..new.bcbioRNASeq
call.plot5Prime3PrimeBias
now uses color
argument instead of fill
.plotDispEsts
now checks for duplicate samples and early returns.plotTotalReads
: Bumped recommended default to 20 million from 10 million.Minor changes:
_setup.R
: rmarkdown, basejump, DESeq2.plotGene
: Updated working example.sampleData<-
generic.Major changes:
DESeqAnalysis
S4 class to a separate package.Deprecated functions and methods:
NAMESPACE
: magrittr pipe (%>%
), DESeqAnalysis
,
DESeqResultsTables
, alphaSummary
, contrastName
, export
, markdown
,
plotDEGHeatmap
, plotDEGPCA
, plotMA
, plotMeanAverage
, plotVolcano
,
topTables
.alphaSummary
: Migrated DESeqDataSet
method to DESeqAnalysis package.Example data:
deseq
example, which has migrated to DESeqAnalysis package.Minor changes:
getOption
) via formalsList
global variable.Major changes:
bcbioRNASeq
S4 class.extract
([
) method: Improved internal handling of rowRanges
and
colData
. Now using I
internally for complex S4 columns in mcols
for
rowRanges
.Minor changes:
bcb
dataset.Rle
global variable. May want to avoid this approach because
Rle
is a defined function in S4Vectors, however.getOption
in formals.Development fork of hbc/bcbioRNASeq
. Code development will proceed here on the
fork until a stable release is ready to merge back at official HBC repo, to
avoid any disruption for active RNA-seq experiments.
New S4 classes:
DESeqAnalysis
S4 class, which helps containerize up a DESeq2
analysis, often requiring corresponding DESeqDataSet
, DESeqTransform
, and
DESeqResults
objects. Note that this class may be defined in a separate
package in a future update.Code migration to basejump:
aggregateReplicates
has moved to basejump, and now works primarily on
SummarizedExperiment
method, instead of bcbioRNASeq
.alphaSummary
, contrastName
,
plot5Prime3PrimeBias
, plotCountDensity
, plotCountsPerGene
,
plotDEGHeatmap
, plotDEGPCA
, plotExonicMappingRate
, plotGenderMarkers
,
plotGeneSaturation
, plotGenesDetected
, plotIntronicMappingRate
.metrics
method, which returns a tbl_df
of colData
, has been moved to
basejump.plotCorrelationHeatmap
code is now primarily defined in basejump as a
SummarizedExperiment
method. bcbioRNASeq now calls this method internally
but keeps support for normalized
counts argument.tpm
method support, which is now handled by SummarizedExperiment
method support in basejump.S4 method reworks:
counts.bcbioRNASeq
). This step is recommended by Bioconductor, and
can make troubleshooting easier.export
: Reworked S4 methods for DESeqResults
and DESeqResultsTables
S4
classes.extract
(i.e. [
) method: Switched transform
formal to recalculate
.
Added additional assert checks. Operation no longer changes the saved
version
of bcbioRNASeq, slotted into metadata
.interestingGroups
formal is now set NULL
instead of missing for plotting
functions.markdown
: Initial support of new S4 generic, which returns a markdown table
of sample metadata.plot5Prime3PrimeBias
: Added an addition grep matching step to handle
differential variations on the x5x3Bias
column in colData
.plotCountDensity
S4 method has been removed. Use plotGeneSaturation
generic with geom = "density"
argument instead.plotCountsPerBiotype
: New S4 method support, which calls basejump
SummarizedExperiment
method.plotDEGHeatmap
: Draft update of DESeqResults
method.plotDEGPCA
: Draft update of DESeqResults
method.plotDispEsts
: Split out and reworked internal method definition.plotGenesDetected
: This code has been moved to basejump and is now defined
against SummarizedExperiment
.plotMA
: Reworked internal DESeqResults
method code. Added draft support
for new DESeqAnalysis
S4 class. Keeping plotMeanAverage
reexported, since
this function is used in the F1000 workflow paper.plotMappingRate
: Set the default limit back down to 0.7.plotMeanSD
: Reworked internal DESeqDataSet
code. Added additional assert
checks and changed the default handling of vst
and rlog
internal formals.plotPCA
: Draft update of SummarizedExperiment
. Will offload this code to
basejump in a future update. Switched return
argument to support tibble
and S4 DataFrame
-- note change from previous support for data.frame
.plotPCACovariates
method, since DEGreport is failing. Will add back
support for this generic in a future update.plotQC
: Initial method support for bcbioRNASeq
.plotTotalReads
: Reworked and tightened up internal ggplot2 code.plotVolcano
: Draft update to DESeqResults
method. Will rework this code
with a DESeqAnalysis
approach in a future update.relativeLogExpression
: Added S4 method support.resultsTables
: Removed this approach to subsetting DESeqResults
. This will
be a rework in the upcoming DESeqAnalysis package.sampleData
: Simplified internal code, which takes advantage of updates to
SummarizedExperiment
defined in basejump.updateObject
: Reworked internal metadata handling.Example data reorganization:
bcb
(bcbioRNASeq
) and deseq
(DESeqDataSet
) examples.bcb_small
, dds_small
, gender_markers
, and res_small
have been removed.data-raw/
scripts.extdata/bcbio/
example datasets. Testing out both
2017-05-23_rnaseq
and 2018-03-18_GSE67267-merged
data.R Markdown templates:
quality_control
). Differential
expression and functional analysis templates have been temporarily removed
but will be re-added in the future.Minor changes:
AllClasses.R
.
Previously, this code was split out per S4 (e.g. bcbioRNASeq-validity.R
).coerce-methods.R
to as-methods.R
.assert-internal.R
.DESeq2-internal.R
.globals.R
..meltCounts
code.params.R
.bcbio
prefix has been renamed to basejump
, where applicable. Refer to
global function params defined with getOption
, and internal ggplot2 utility
functions, such as basejump_geom_abline
.countsFromAbundance
selection in internal tximport
call.
This is useful for some transcript-level analyses.Deprecations:
download
function.plotCountDensity
, plotPCACovariates
, resultsTables
.Minor changes:
Major changes:
tximport-internal.R
file)
where sample names can get associated with the wrong samples in experiments,
causing samples with numbers roll over from 1 -> 10. Thanks to Richard from
AstraZeneca for catching this.NA
in ribosomal RNA calculations.Minor changes:
as
coercion method support. Need to ensure
exportMethods(coerce)
is included in NAMESPACE
file, otherwise
bcbioRNASeq
to DESeqDataSet
coercion using as(bcb, "DESeqDataSet")
won't
work when called from an Rscript without the package library loaded. Thanks
@roryk for noticing this.Major changes:
transform = TRUE
argument to [
extraction method, allowing the
user to skip automatic DESeq2 transformations, which can be CPU intensive
for large datasets.plotMA
instead of plotMeanAverage
. An MA-plot
by definition is not a "Mean Average" plot, so this function name is
misleading. We will keep the plotMeanAverage
working but it is now
soft deprecated.plotGeneSaturation
now supports label
argument, similar to plotPCA
.Minor changes:
tximport
call to handle transcript
version mismatch with tx2gene data.frame. This can result if the bcbio
pipeline is using an old genome build.genomeBuild
is detected from AnnotationHub rowRangesMetadata
if
applicable, and not left NULL
in the metadata.aes
instead of aes_string
, which uses
tidyeval and quasiquotation.plotGene
: reduced the number of return
options to simply "facet" and
"wide". Previously, this also supported "grid", "list", and "markdown", but
these were removed because they are not frequently used.plotGene
: Switched back to internal lapply
call instead of using
BiocParallel::bplapply
. This doesn't always work perfect in an HPC
environment (e.g. HMS O2 cluster).plotMeanAverage
in favor of plotMA
.Minor changes:
bcbioRNASeq
constructor
to work with minimal bcbio test data.aes_
in favor of consistent usage of
aes_string
. This will make the transition to ggplot2 v2.3.0 easier
in a future update.Major changes:
aggregateReplicates
support has been added back. This function returns
a RangedSummarizedExperiment
instead of a bcbioRNASeq
object, containing
only an aggregate raw counts matrix in the counts
slot of assays
.dds_file
and organism
as new parameter arguments. We've reduced the number
of parameters required here to run clusterProfiler.alphaSummary
defunct for bcbioRNASeq
object, in favor of
DESeqDataSet
only. This function is only useful when a proper design formula
has been defined.Minor changes:
metrics
now contains an informative error for datasets that were analyzed
using the fast-rnaseq
bcbio pipeline.DESeqDataSet
coercion from bcbioRNASeq
object doesn't attempt to run
DESeq
command any more, which was unnecessary and improves speed.bcbioSingleCell
constructor now supports censorSamples
parameter. This
is useful for removing known poor quality samples upon loading.NULL
in the quality control
functions. This behavior doesn't change the appearance of the plot colors,
which will still default to ggplot2::scale_colour_hue
or
ggplot2::scale_fill_hue
. The upcoming ggplot2 v2.3.0 update supports
global options for color and fill palettes, so these parameters may be
deprecated in a future release.topTables
.Infrastructure changes:
libudunits2-dev
(Linux).Major changes:
vst
) over rlog
counts by default in plots, where applicable.Minor changes:
plotDEGPCA
to default differential expression R Markdown
template.colData
factors are correctly releveled upon object subset with [
. This
helps avoid unwanted downstream errors when creating a DESeqDataSet
and
running differential expression with DESeq2.facet
return method by default for plotGene
. Updated the
working example to reflect this.metrics
now returns interestingGroups
column.sample
label has been removed from axis title for QC plot functions.bcbio_geom_abline
, bcbio_geom_label
, and bcbio_geom_label_repel
.
These are also used by bcbioSingleCell for improved graphical consistency.Minor changes:
plotPCA
functions to match
plotMeanAverage
and plotVolcano
.plotDEGPCA
, matching the other DEG
functions. Also added directionality to plotDEGPCA
.DESeqDataSet
method support to plotCorrelationHeatmap
, using the
normalized counts.reusltsTables
now writes local files to tempdir
when Dropbox mode
is enabled using dropboxDir
.Last set of code fixes before F1000v2 resubmission.
Major changes:
rle
return support for counts
, which are calculated on the fly.transgeneNames
and spikeNames
support to loadRNASeq
function.loadRNASeq
now supports organism = NULL
again, for datasets with poorly
annotated genomes.assay
containing raw counts is now named counts
instead of
raw
, for consistency with other SummarizedExperiment
objects (e.g.
DESeqDataSet
) and the bcbioSingleCell S4 class definition.plotGene
and plotGenderMarkers
.Minor changes:
updateObject
method.assays
, even when rlog
and vst transformations are skipped.[[<-
, assays<-
, colData<-
, interestingGroups<-
, and
metadata<-
assignment methods, to avoid unwanted coercion to
SummarizedExperiment
. Objects extending RangedSummarizedExperiment
shouldn't be doing this, so we may need to file a bug report with Bioconductor
or check our class definition in the package.stop
, warning
and message
rather than the
alternate [rlang][] functions abort
, warn
, and inform
.Major changes:
bcbioRNASeq
S4 class object is now extending RangedSummarizedExperiment
instead of SummarizedExperiment
. Consequently, the row annotations are now
stored in the rowRanges
slot as GRanges
class, instead of in the
rowData
slot as a DataFrame
. The rowData
accessor still works and
returns a data frame of gene/transcript annotations, but these are now
coerced from the internally stored GRanges
. The GRanges
object is
acquired automatically from Ensembl using basejump::ensembl
. By
default, GRanges
are acquired from Ensembl using AnnotationHub and
ensembldb. Legacy GRCh37 genome build is supported using the
EnsDb.Hsapiens.v75 package.assays
now only slot matrices. We've moved the tximport data from
the now defunct bcbio
slot to assays. This includes the lengths
matrix
from tximport. Additionally, we are optionally slotting DESeq2
variance-stabilized counts ("rlog
", "vst"
). DESeq2 normalized counts
and edgeR TMM counts are calculated on the fly and no longer stored
inside the bcbioRNASeq
object.colData
now defaults to returning as data.frame
instead of
DataFrame
, for easy piping to tidyverse functions.bcbio
slot is now defunct.isSpike
argument during the loadRNASeq
data import step.plotCountsPerGene
and
plotCountDensity
. Note that we are subsetting the nonzero genes as
defined by the raw counts here.tximport
code to no longer attempt to strip
transcript versions. This is required for working with C. elegans
transcripts.as(object, "DESeqDataSet")
coercion method support for
bcbioRNASeq
class. This helps us set up the differential expression
analysis easily.counts
function now returns DESeq2 normalized counts (normalized = TRUE
)
and edgeR TMM counts (normalized = "tmm"
) on the fly, as suggested by the
F1000 reviewers.bcbioRNASeq
object, since
we're not stashing a DESeqDataSet
any more.Minor changes:
validObject
is now required for all plotting functions. This check is
also called in the R Markdown template. Legacy objects can be updated using
updateObject
.metrics
now returns columns sorted alphabetically.contrastName
as a generic function.plotDEGHeatmap
and plotDEGPCA
generics no longer have counts
defined in the signature. The counts
argument is now only defined in the
methods.prepareRNASeqTemplate
has been converted from a generic to a standard
function.metadata
validity checks.plotCorrelationHeatmap
matrix method has been moved to basejump
package, for improved consistency with the other heatmap code.plotGenderMarkers
internal code has been reworked to match
plotGene
.plotMA
appearance has changed, providing a line at the 0
y-intercept, similar to DESeqDataSet
method.bcb_small
instead of
bcb
).BiocCheck
..sampleDirs
code is now exported in bcbioBase as a
generic.gene2symbol
and interestingGroups
method support are now defined
for SummarizedExperiment
in the bcbioBase package.Updating legacy objects (pre v0.2.0):
updateObject
in combination with the rowRanges
argument, which
requires a GRanges
object. GRanges
can be obtained from Ensembl using
the basejump::ensembl
function or the ensembldb package.Deprecations:
bcbio
slot is now defunct, since we have moved all data into the
SummarizedExperiment
container.plot5x3Bias
in favor of plot5Prime3PrimeBias
. This is
less confusing as to what this function plots.flatFiles
has been deprecated in favor of as(object, "list")
coercion
method. See bcbioBase package for SummarizedExperiment
method
support.design
, download
, meltLog10
, txi
.bcbioRNADataSet
method support has been removed.gene2symbol
argument not renaming rows in plotDEGHeatmap
.[
subset method dropping metrics in metadata.resultsTables
.plotDEGHeatmap
.plotDEGPCA
.resultsTables
, for use with
the Stem Cell Commons database.plotGene
and plotGenderMarkers
to run
faster.selectSamples
.organism
and genomeBuild
parameters are now user-definable in the main
loadRNASeq
import function.intersect
in the featureCounts matrix.aggregateReplicates
code. This needs to be reworked
and added back in a future release.if
statements to be more class specific.plotCorrelationHeatmap
transform
argument to normalized
,
for consistency with the counts
generic.title
support to plots, where applicable.plotDEGHeatmap
.plotGenderMarkers
.resulsTables
function now defaults to summary = TRUE
.bcb
, dds
, res
, etc.) into a single examples
object. This helps avoid accidental use of example bcb
in an analysis.internal-ggplot.R
to above each function.maxSamples
parameter in loadRNASeq
to transformationLimit
.
If there are more samples than this limit, then the DESeq2 transformations
will be skipped. In this case, rlog
and vst
will not be slotted into
assays
.loadRNASeq
to ensure rows are in
the same order as the columns in the counts matrix. Otherwise, DESeq will
report an error at the DESeqDataSetFromTximport
step. We're also ensuring
the factor levels get updated here.glimpse
instead of str
in examples, where applicable.colData<-
assignment method support. This requires a DataFrame
class object. Upon assignment, the internal colData at
bcbio(object, "DESeqDataSet")
, assays(object)[["rlog"]]
and
assays(object)[["vst"]]
are also updated to match.design
, which will update the internal
DESeqDataSet.gene2symbol
generic, which will now return a 2
column data.frame
with ensgene
and symbol
columns. This is helpful for
downstream gene to symbol mapping operations.interestingGroups<-
in the documentation.internal-meltLog10.R
for example.viridis::scale_fill_viridis(discrete = TRUE)
. This makes it clearer to the
user in the documentation where these palettes are located.plotGene
.plotHeatmap
now uses internal gene2symbol
mappings from stashed
annotable, instead of always querying Ensembl. The user can define custom
mappings with the gene2symbol
argument, if desired.plotPCA
now supports custom color palettes. The shapes
parameter has
been removed because it doesn't work well and is limited to datasets with few
samples. This behavior matches the PCA functionality in DESeq2.plotVolcano
. Added support for gene2symbol
argument, like in plotHeatmap
. If left missing, the function will query
Ensembl for the gene2symbol mappings. We're now using data
instead of
stats
as the main data source.dependencies
argument, which allows for automatic install of suggested
packages along with imports.interestingGroups<-
.plotGeneHeatmap
to simply plotHeatmap
.f1000v1
branch containing the reproducible code used to generate
the figures in our workflow.plotMA
to support vertical or horizontal layout return. Also
added an argument to remove the color legend, which is typically not that
informative.bcbioRNADataSet
(< 0.1.0) to bcbioRNASeq
class object is
now possible using as
coercion method.bcbioRNASeq
object.
Legacy bcbioRNADataSet
objects must be upgraded to bcbioRNASeq
class.bcbioRNASeq
S4 object
using flatFiles
function.bcbioRNASeq
method support for annotable
generic.bcbioRNADataSet
S4 class to bcbioRNASeq
. This matches the
naming conventions in the bcbioSingleCell package.loadRNASeqRun
to simply loadRNASeq
.loadRNASeq
from using S4 dispatch to a standard function.loadRNASeq
that enables request of a
specific Ensembl release version for gene annotations.interestingGroup
argument in quality control functions to
interestingGroups
for better consistency.plotPCACovariates
.bcbioRNADataSet
object.bcbioRNADataSet
in differential expression
R Markdown template.bcbioRNADataSet
or a metrics data.frame
and manual interesting_group
declaration for visualization.snake_case
to camelCase
.setup.R
to use *_dir
instead of
*_out
.DESeqDataSet
using design = formula(~1)
for quality control. This
enables automatic generation of rlog
and vst
transformed counts.bcbioRnaDataSet
to bcbioRNADataSet
(case sensitive).bcbioRnaDataSet
S4 definition updates.plot_pca
and gene-level heatmaps.bcbioRnaDataSet
.load_run
that saves to S4 object instead of list.pkgdown::build_site
.project-summary.yaml
saved in the final run directory.import_*
functions to read_*
.Add the following code to your website.
For more information on customizing the embed code, read Embedding Snippets.