Major changes:
Major changes:
Minor changes:
Minor changes:
mapToDataFrame
from NAMESPACE, which will be made defunct in a
pending update to AcidPlyr and AcidGenerics packages. We recommend using
rbindToDataFrame
instead.Minor changes:
requireNamespaces
from reexports, as this function will be migrated
from AcidBase to goalie in a pending update.Minor changes:
minorVersion
has been removed in favor of majorMinorVersion
.euclidean
and zscore
as reexports from AcidGenerics.
Methods for these are primarily defined in AcidBase.Minor changes:
Major changes:
Minor changes:
droplevels2
, to avoid method collisions with changes in
DataFrame
class handling introduced in Bioconductor 3.15.Major changes:
CellCycleMarkers
,
CellTypeMarkers
, importCellCycleMarkers
, importCellTypeMarkers
.CellCycleMarkers
, CellTypeMarkers
, KnownMarkers
.Minor changes:
compressExtPattern
, extPattern
(removed from AcideBase; refer to goalie), and localOrRemoteFile
(removed
from pipette).GenomicRanges
, GenomicRangesList
, IntegerRanges
virtual classes, instead of GRanges
, GRangesList
, IRanges
, respectively.
Downstream S4 methods should be declared against these virtual classes, and
never against DFrame
directly (use DataFrame
virtual class), for example.as
from pipette package.Minor changes:
aggregate
and aggregateCols
, following update
in AcidSingleCell that improves the consistency of aggregate
methods.New functions:
abort
, inform
, warn
.Removed functions:
matchArgsToDoCall
,
matchEnsemblReleaseToURL
, matchHumanOrthologs
, matchesInterestingGroups
,
metadataBlacklist
, multiassignAsEnvir
, readSampleData
, readTx2Gene
,
sortUnique
, toStringUnique
, and unlistToDataFrame
.as
, formalArgs
, is
, new
, and
validObject
.Minor changes:
Minor changes:
mapEnsemblBuildToUCSC
and mapUCSCBuildToEnsembl
, which are no
longer exported in the AcidGenomes package.Minor changes:
simpleClass
reexport from AcidBase package update.Minor changes:
median
and quantile
reexports to import from AcidGenerics instead
of AcidBase. This now refers to median
and quantile
generics defined in
IRanges package, which is useful for handling of NumericList
objects.Minor changes:
Minor changes:
Minor changes:
Minor changes:
metadataBlacklist
in favor of metadataDenylist
.Minor changes:
EntrezGeneInfo
.Minor changes:
seqnames
in reexports, which is used in bcbioRNASeq.Minor changes:
getListElement
from S4Vectors via AcidGenerics, which is used
in bcbioRNASeq.Minor changes:
URLencode
from utils via AcidBase as a reexport, which is used
in the Cellosaurus package.Minor changes:
mapToDataFrame
and rbindToDataFrame
from AcidPlyr.
Note that unlistToDataFrame
is now deprecated, in favor of mapToDataFrame
,
and will be removed in a future release.Minor changes:
formula
and untar
, which are used in WormBase package.Minor changes:
Minor changes:
Minor changes:
end
, start
, and width
from AcidGenerics.Minor changes:
Minor changes:
CharacterList
, FactorList
, IntegerList
, LogicalList
, NumericList
,
and RleList
.New functions:
capture.output
,
cbind
, getS3method
, model.matrix
, rbind
, and relevel
.New functions:
Minor changes:
Reworked package to simply inherit and reexport functions from other Acid Genomics packages, rather than defining any code directly here.
Major changes:
camelCase
and upperCamelCase
now default to strict = TRUE
, reflecting
change implemented in syntactic v0.4.4 release.Minor changes:
mapUCSCBuildToEnsembl
, defined in AcidGenomes.Minor changes:
AsIs
method support for sem
, which is required for dplyr mutate
calculations on numeric classes. Note that the numeric
method is defined
in the AcidBase package.Minor changes:
sem
function from AcidBase.Minor changes:
transmit
to pipette package. Still reexporting here.Minor changes:
makeSummarizedExperiment
and makeSingleCellExperiment
generators
to generate empty objects without requiring any assays to be defined.Migrated some functions to AcidBase, AcidGenomes, AcidPlyr, and pipette packages.
Major changes:
Ensembl2Entrez
: Improved internal matching engine, to allow reverse matching
of Entrez identifiers to Ensembl identifiers.Entrez2Ensembl
, which works like Entrez2Ensembl
.Entrez2Ensembl
, which inherits Ensembl2Entrez
structure.Minor changes:
makeSummarizedExperiment
: No longer requiring primary assay
defined to
be named "counts". This isn't appropriate for SummarizedExperiment
objects
defined in the new DepMapAnalysis package.makeGRangesFromEnsembl
: Include geneSynonyms
column for supported
organisms, including Homo sapiens.matchEnsemblReleaseToURL
in favor of mapEnsemblReleaseToURL
.Minor changes:
makeProtein2GeneFromEnsembl
: Improved error message on match failure. Now
returns the protein IDs that failed to match more clearly.New classes:
Protein2Gene
: DataFrame
with proteinID
, geneID
, and geneName
columns. Use corresponding makeProtein2GeneFromEnsembl
to generate object
simplify using Ensembl protein IDs as input.New functions:
getEnsDb
: Now exporting function that was used internally to obtain EnsDb
object from AnnotationHub.makeProtein2GeneFromEnsembl
: New utility function that takes Ensembl protein
identifiers as input, and returns corresponding gene identifiers and gene
names (i.e. HUGO gene symbols).Minor changes:
makeGRangesFromEnesmbl
to enable export of
new getEnsDb
function.makeGRangesFromEnsembl
/ getEnsDb
: Improved sorting of Ensembl releases
so that current release greater than 99 returns as expected. Since Ensembl is
now at 101, we need to convert to integers internally instead of attempting
to sort on strings.New functions:
splitByLevel
: Easily split a data frame into a list using a defined factor
column (f
argument). Can easily include the reference level with
ref = TRUE
, which is useful for statistical calculations on pairwise
contrasts.Minor changes:
New methods:
intersectAll
: Defined list
method.intersectionMatrix
: Defined list
method.Minor changes:
requireNamespaces
from acidbase package.Minor changes:
alphaThreshold
and lfcThreshold
methods to DESeqAnalysis package.
These are not used in other packages and may not be generally applicable to
SummarizedExperiment
class, so rethinking here.Minor changes:
Minor changes:
autopadZeros
: Migrated character method support to syntactic package, since
this is useful for low-level code run inside koopa.Minor changes:
aggregate
, aggregateCols
, aggregateRows
: Relaxed assert checks on
validity of dimnames, so we can use internally in acidgsea package, which
needs to handle gene symbols containing syntactically invalid hyphens.Minor changes:
convertGenesToSymbols
: Added method support for GRanges
class objects.
Automatically sets names as unique gene symbols.HGNC2Ensembl
: Enforce TSV handling internally in import
call.MGI2Ensembl
: Fix for column name handling.Minor changes:
importSampleData
: The pipeline = "cpi"
option is now defunct.
Use pipeline = "none', sheet = 2L
for CPI samples.importSampleData
: Added optional autopadZeros
argument for easy handling
of sample identifiers, which are often input by users without correct padding.
This helps easily convert sample_1, sample_2, ... sample_10 to expected
sample_01, sample_02, ... sample_10 sorting. Currently disabled by default.importTx2Gene
: Added ignoreGeneVersion
option, now enabled by default.
This helps process gene identifiers by default in a manner suitable for
downstream tximport-DESeq2 workflow.headtail
: Removed Unicode support in favor of simple ASCII return, to avoid
build warnings in latest R 4.0 release version.DataFrame
class and
NCBI server updates.camelCase
, dottedCase
, organism
, snakeCase
, upperCamelCase
: S4
methods for DataFrame
are now defined directly against DataFrame
, instead
of attempting to inherit from DataTable
virtual class. This will break
otherwise on bioc-devel 3.12, which seems to have changed inheritance.Minor changes:
matchEnsemblReleaseToURL
, matchHumanOrthologs
: update unit tests to
reflect Ensembl server migration, which has rendered Ensembl archives
inaccessible via biomaRt until March 24th. Unit tests now check against
current release instead of a pinned archive release.Minor changes:
makeSingleCellExperiment
, makeSummarizedExperiment
: Removed spikeNames
support due to a breaking change in SingleCellExperiment, which has removed
isSpike
in favor of altExps
. Refer to the SingleCellExperiment
documentation for updated current best practice for handling spike-in
transcripts, which now requires slotting a separate SummarizedExperiment
object containing things like ERCCs inside the main SingleCellExperiment.Minor changes:
pseudobulk
methods to pointillism package. Rethinking the approach
used here to work better with per-cluster aggregation operations. Will be
updated in the next pointillism release.Major changes:
aggregate
, aggregateCols
, aggregateRows
support to reflect
internal migration away from Matrix.utils dependency.Minor changes:
aggregate
: Now defining matrix method.aggregate*
generics now consistently use "x" instead of "object".Major changes:
New functions:
integerCounts
: Simple method support for returning a rounded integer counts
matrix. Intended primarily for downstream handoff to bulk RNA-seq differential
expression callers, such as DESeq2.Minor changes:
mutateAll
functionality.Minor changes:
formalsList
global slightly. Using the synesthesia
color palette
for heatmap.color
argument doesn't always perform well enough, so I'm
switching to a blue/black/yellow palette defined by blueYellow
in acidplots
instead for heatmap.color
. The synesthesia
palette performs really well
for correlation heatmaps, and is now recommended by default via the
acid.heatmap.correlation.color
global now instead.filterCells
: Improved internal sampleName / sampleID handling.New functions:
correlation
: Added S4 method support that mimics base cor
methods, but
is more flexible, supporting additional arguments via ...
in generic. This
way we can provide intelligent and quick correlation calculations for nested
assays inside a SummarizedExperiment
and for DESeqResults
(see DESeqAnalysis package).Major changes:
Bug fixes:
filterCells
requires an internal decode
step to handle Rle
evaluation,
which worked previously in Bioconductor 3.9 release.SingleCellExperiment
example object resave
in acidtest 0.2.7 update, which changed the numbers.New reexports:
metadata2
and metadata2<-
functions from transformer.
These will be used internally in the pending DESeqAnalysis update.New functions:
ensemblVersion
, gencodeVersion
, refseqVersion
,
flybaseVersion
, wormbaseVersion
. Similar shell variants are available in
the koopa package.Minor changes:
Minor changes:
importSampleData
: Pipeline now defaulting to "none" instead of "bcbio",
since this flag is now properly hard coded in bcbio R packages.
Added new Constellation (CPI) pipeline option.makeSampleData
: Now checks for all NA columns and rows, similar to approach
in importSampleData
. This helps improve return consistency. Automatic
rowname setting has been tweaked a bit to no longer attempt to remove original
ID column.Minor changes:
makeSampleData
: Made function slightly more flexible. Now allowing automatic
rowname coercion from columns ("sampleID", "rowname", "rn"), similar to
approach employed by data.table and tibble packages.stripGeneVersions
alias, which uses the same code internally
as stripTranscriptVersions
.Disabled methods:
calculateMetrics
,
estimateSizeFactors
, and nonzeroRowsAndCols
until is_pristine
bug in
DelayedArray v0.11.8 is fixed on Bioconductor Devel (3.10). This is causing
unit tests to fail otherwise.
See related issueMinor changes:
Major changes:
melt
: Updated min
and minMethod
defaults for matrix
method. The min
argument now defaults to -Inf
, and the minMethod
now defaults to
"absolute"
, instead of "perRow"
, since this behavior is more intuitive to
the user.Minor changes:
nonzeroRowsAndCols
: Added assay
argument, switching from internal counts
usage, to make the SummarizedExperiment
method more flexible.Minor changes:
mcolnames
: Moved S4 methods previously defined in syntactic here.Major changes:
autopadZeros
: Added improved support for detection and automatic handling
of zeros in need of padding on the left side of a character vector. This
addition is necessary for handling of Genewiz processed FASTQ file names.makeTx2Gene
functions now support ignoreTxVersion
argument, similar to
conventions defined in tximport package.Minor changes:
importSampleData
: Updated to tentatively support a general pipeline via the
"none" argument. In this case, only a sampleID
column is required in
metadata. This is been developed in conjunction with my new Genewiz to
kallisto Nextflow processing pipeline being implemented at CPI.Minor changes:
melt
: Added method support for contingency table
class.set_*
reexports from magrittr packages.Updated R dependency to 3.6.
New functions:
melt
: Added S4 methods for melting data into long format. Provides support
for matrix
, Matrix
, DataFrame
, SummarizedExperiment
, and
SingleCellExperiment
currently.nonzeroRowsAndCols
: Quickly remove non-zero rows and columns from a matrix
or SummarizedExperiment
.Major changes:
EggNOG
and PANTHER
S4 classes to separate packages.Minor changes:
calculateMetrics
: Now calls nonzeroRowsAndCols
internally first when
prefilter = FALSE
, speeding up calculations significantly for very large
SingleCellExperiment
objects. This was added to improve loading of example
unfiltered 10X Genomics Chromium data.Deprecations:
readSampleData
and readTx2Gene
in favor of importSampleData
and importTx2Gene
, respectively.Minor changes:
makeSummarizedExperiment
: Now automatically handles non-Ensembl gene symbols
present in assays that aren't defined in rowRanges
. This applies primarily
to 10X Cell Ranger v3 output, which includes some non-Ensembl gene symbols:
CD11b, CD4, CD8a, HLA-DR, IgG1, PD-1, etc. The function still intentionally
errors on unannotated Ensembl features, which often indicates an accidental
release version mismatch.Minor changes:
meltCounts
: Added initial method support for SingleCellExperiment
.
Currently requires deparsing of the count matrix to call reshape2::melt
.
Returns columns with S4 run-length encoding (Rle) applied.mapGenes
: Converted warning to message when strict = FALSE
.New functions:
readSampleData
and readTx2Gene
from bcbioBase.readSampleData
internal code, but still supporting bcbio pipeline
conventions (i.e. "description" column for samples) as the default. I've
reworked this approach so we can also call readSampleData
inside the
Chromium package (for 10X Genomics single-cell RNA-seq data) without having
to depend on the bcbio R packages.DataFrame
:
inner_join
, left_join
, right_join
, full_join
, anti_join
;
mutate_all
, mutate_at
, mutate_if
;
select_all
, select_at
, select_if
.Major changes:
aggregateCols
: Sped up return by calling SingleCellExperiment
rather than
makeSingleCellExperiment
. Note that this now doesn't return session
information in the object.cell2sample
: Renamed return from tibble
to tbl_df
, for consistency.assert*
functions that have been reworked using a goalie approach.estimateSizeFactors
: Removed option to calculate "deseq2-median-ratio"
using DESeq2. We may revisit this idea in a future release.makeSampleData
: Improved internal code for DataFrame
method.Minor changes:
select
from AnnotationDbi, now that we're no longer depending
on dplyr.droplevels
instead of relevel
on S4 objects internally,
where applicable. This is better supported by S4Vectors package.Minor changes:
filterCells
: Improved downstream handling of nCells
argument.
Ensure double filtering is still allowed.Minor changes:
appendToBody
and methodFormals
calls to have better backward
compatibility with R 3.5.calculateMetrics
: Bug fix for getting rowData
via mcols
without
use.names = TRUE
. This improves Bioconductor backward compatibility.
Also updated internal code to call hasMetrics
from goalie.separatorBar
defunct. Use separator
function instead.New functions:
calculateMetrics
: Migrated code here from bcbioSingleCell. Improved method
to support DelayedArray
class for large matrices.Minor changes:
Major changes:
makeSampleData
: Switched to S4 method that works on data.frame
and
DataFrame
class objects. Enforcing lower camel case for column names.makeSummarizedExperiment
and makeSingleCellExperiment
: Switched to S4
method approach that currently requires SimpleList
input for assays.
Previously, we allowed list
input for assays, but we're tightening this up
to simply the package code base and improve consistency.aggregate
methods now consistently return the primary assay named as
counts
. This follows the recommended conventions defined in
SingleCellExperiment. Aggregation functions will now intentionally fail for
SummarizedExperiment
objects that don't contain an assay named counts
.Minor changes:
params.Rd
file to new
acidroxygen package. This will be linked in the other Acid Genomics packages.100th release!
Minor changes:
mapCellsToSamples
: Relaxed grep matching on cells
input to support legacy
bcbioSingleCell objects. This change was needed to improve updateObject
method in the upcoming bcbioSingleCell update.Minor changes:
makeLabel
, makeTitle
, makeWords
.Minor changes:
Start of new release series. Version bump reflects changes in dependency packages. See the acidtest, bioverbs, freerange, syntactic, and transformer release notes for more details.
Minor changes:
combine
method on SummarizedExperiment. Needed to ensure row
names are assigned on rowData to provide backward compatibility for Bioc 3.7.mapGenesToRownames
: Improved matching for SummarizedExperiment
objects
that don't contain gene-to-symbol mappings defined in rowData
.meltCounts
: Improved factor handling. Also added matrix
method support.
Added advanced option to disable minCounts
filtering, by setting as NULL
.Deprecations:
Minor changes:
theme_midnight
and theme_paperwhite
defunct, in favor if variants in
new acidplots package.New functions:
matchEnsemblReleaseToURL
: Takes an Ensembl release version (e.g. 96
) as
input and returns the corresponding archive URL.matchHumanOrthologs
: Convenience function that wraps biomaRt package to
map model system gene identifiers to HGNC IDs and symbols. This is
particularly useful for running orthologus GSEA with our pfgsea package.Major changes:
combine
method for SummarizedExperiment
now includes all matrices defined
in assays
slot. Also improved support for colData
handling on subsets
where NA
values have been removed.Minor changes:
Gene2Symbol
: Modified format
formal to use "unmodified" instead of "long",
which is more intuitive.makeGene2Symbol
: Added support for format
argument, similar to
Gene2Symbol
generator function.Minor changes:
readFileByExtension
,
readYAML
, fixNA
.theme_midnight
and theme_paperwhite
are deprecated but
exported with support, by suggesting acidplots package.assertHasRownames
, tx2geneFromGFF
.Major changes:
New functions:
alphaThreshold
and lfcThreshold
against
Annotated
class. These values get stored in the metadata
slot of the
object.New functions:
showHeader
: Utility function for show
methods defined in other packages.Minor changes:
DESCRIPTION
for details).Minor changes:
sampleData
is erroring.Major changes:
meltCounts
: Switched from using nonzeroGenes
formal approach to
minCounts
and minCountsMethod
, which is more flexible.Minor changes:
formalsList
.Minor changes:
emptyRanges
format has been renamed
from mcolsNames
to mcolnames
.Major changes:
aggregateRows
, aggregateCols
, aggregateCellsToSamples
: Improved internal
code for SummarizedExperiment metadata handling. Applies primarily to colData
and rowData juggling for these methods.interestingGroups
: Reworked to define method against Annotated
class.
SummarizedExperiment
inherits from this class, supporting metadata
.mapCellsToSamples
: Tightened up match assert checks.mcolnames
now uses S4 methods, primarily against Vector
class.organism
: Reworked S4 methods. Added support for Annotated
and
DataTable
classes from S4Vectors.Minor changes:
aggregateCols
.detectLanes
: Renamed primary argument from object
to path
. Improved
pattern
formal to evaluate lanePattern
global.basejump.test
to acid.test
.sampleData
: Improved error message when sampleName
factor column is
missing.zeroVsDepth
now returns depth
column as integer
instead of numeric
.New functions:
rankedMatrix
: New utility function for quickly performing ranked matrix
calculations. Particularly useful for differential expression comparison
across studies using log2 fold change or Wald test statistic.Minor changes:
Major changes:
annotable
,
convertUCSCBuildToEnsembl
, detectOrganism
, emptyRanges
,
makeGRangesFromEnsDb
, makeGRangesFromEnsembl
, makeGRangesFromGFF
,
makeGRangesFromGTF
.plotHeatmap
, plotCorrelationHeatmap
, and plotQuantileHeatmap
.Minor changes:
removeNA
and sanitizeNA
code to brio package, so these
functions can be imported in thew new freerange package.organism_mappings
internal dataset to freerange package.Minor changes:
convertSampleIDsToNames
: Removed code to assign sampleName
column to
NULL
. This step doesn't work consistently for DataFrame
across
Bioconductor installations, and has been found to error on R 3.4 and the
current bioc-devel on AppVeyor.makeGRangesFromGFF
: Compressed Ensembl GTF file example was erroring out
on AppVeyor CI, due to Windows' poor handling of temp files on non-admin
accounts. Switched to a non-gzipped example file to avoid this issue. Also
removed tabular table from documentation, which currently doesn't render
correctly via pkgdown.Minor changes:
Minor changes:
sampleData
and blacklisted metadata handling.Minor changes:
Major changes:
makeGRangesFromGFF
: Reworked internal code, making it more modular. Added
initial support for RefSeq GFF3 files. Also improved sanitization and special
handling of files from FlyBase and WormBase.Minor changes:
plotHeatmap
family: Bug fix needed for internal is.na
call on
annotationCol
, which should be wrapped with any
to return boolean. This
errors (as it should) on R 3.6, but I missed it on R 3.5..makeGRanges
, which is run
for both GFF file and ensembldb import. We've improved the Rle encoding steps
here to work with complex GFF3 files (e.g. GENCODE).Minor changes:
Minor changes:
goalie::bapply
and additional useful pipes from magrittr
package.plotGene
generic reexported, while encouring
users to update their code to use plotCounts
instead.interestingGroups
: Simplified internal assert checks, removing
matchesInterestingGroups
, which can become circular.Minor changes:
unname
to some assert checks for expected logical(1)
return,
which only happens in R 3.4 but not R 3.5.uniteInterestingGroups
: Improved internal assert checks and name handling.Minor changes:
plotGene
in favor of plotCounts
. This change will be reflected
in future updates of packages that depend on basejump, including the bcbio
R packages.assert
from goalie package.Minor changes:
decode
and encode
are properly reexported from brio.Minor changes:
decode
call internally for some plotting functions, to ensure
that run-length encoded (Rle) rowData gets handled correctly.interestingGroups
handling in plot functions.Offloaded to brio:
decode
, encode
. These are useful for data sanitization. Still re-exported
here in basejump.Offloaded to goalie:
printString
. This is a low-level function that is useful for setting the
cause attribute in error messages. Still reexported here in basejump.Deprecations:
sanitizeRowData
has been deprecated in favor of atomize
.sanitizeAnnotable
deprecation has been updated to point to atomize
.Minor changes:
decode
call internally for some plotting functions, to ensure
that run-length encoded (Rle) rowData gets handled correctly.interestingGroups
handling in plot functions.Offloaded to brio:
decode
, encode
. These are useful for data sanitization. Still re-exported
here in basejump.Offloaded to goalie:
printString
. This is a low-level function that is useful for setting the
cause attribute in error messages. Still reexported here in basejump.Deprecations:
sanitizeRowData
has been deprecated in favor of atomize
.sanitizeAnnotable
deprecation has been updated to point to atomize
.Minor changes:
reexports.R
file.Minor changes:
DESCRIPTION
file to make them more human readable.
Note that basejump sub-packages are imported first, then Bioconductor
packages, followed by CRAN packages, and required default packages.imports.R
file.This release defines the initial point where basejump becomes even more modular, offloading some functions to new brio, syntactic, and S4Transformer packages.
Note that all offloaded functions will continue to be reexported in basejump. If you notice a function that is missing and not correctly re-exported, please file an issue.
Note that S4Transformer has since been renamed to transformer.
Offloaded to S4Transformer:
as
coercion methods moved to S4Transformer package. This methods define our
useful interconversions between Bioconductor and tidyverse data classes,
including DataFrame
and tbl_df
(tibble).coerceS4ToList
/ flatFiles
.Offloaded to bb8:
cleanSystemLibrary
. This doesn't scale well to all installations and is
really only intended for personal use, so bb8 package is more appropriate.parseRd
, RdTags
, saveRdExamples
, and
tabular
are outside the scope of basejump.Offloaded to brio:
basenameSansExt
.dots
.export
.import
.initDir
.loadData
.localOrRemoteFile
.pasteURL
.realpath
.sanitizeColData
.sanitizeRowData
.sanitizeSampleData
.saveData
.transmit
.writeCounts
.Offloaded to goalie:
matchArgsToDoCall
.MethodDefinition
.standardizeCall
.Minor changes:
nullOK
support to goalie assert checks, where applicable.This release defines the initial point where basejump begins to import bioverbs.
Major changes:
Minor changes:
aggregateCellsToSamples
: Split out S4 method to a separate file. Previously
was defined in aggregate-methods.R
.collapse-methods.R
, which is now split out to collaseToString-methods.R
.matchesGene2Symbol
, matchesInterestingGroups
: Reworked internal code and
moved to separate files. No longer relies upon makeTestFunction
from
checkmate package.Documentation:
I bumped the release series from v0.8 to v0.9 because this represents a significant change to the internal codebase, where I have now switched to using my new goalie assert check engine from assertive.
New functions:
decode
: Decode S4 run-length encoding (Rle).encode
: Apply S4 run-length encoding (Rle).geneNames
: Convenience function that returns gene names (symbols) mapped to
the stable, but not human-friendly gene identifiers.matchesGene2Symbol
, matchesInterestingGroups
: New functions designed to
match corresponding Gene2Symbol
objects or interestingGroups
.pasteURL
: Convenience function that generates URL strings.sanitizeColData
: rework of previous sanitizeSampleData
approach.Major changes:
goalie::assert
function is more flexible in many cases.
Similarly, goalie::validate
is now being used in place of
assertthat::validate_that
.plotHeatmap
now calculates the z-score normalization internally, rather than
relying upon the codebase inside pheatmap.export
: Improved SummarizedExperiment
method to also write Gene2Symbol
and Ensembl2Entrez
mappings to disk, when defined. The human-friendly output
formal has been renamed from human
to humanize
, to reflect an action
(verb). This corresponds better to our humanize
generic function. Also
reworked some internal code that handles output of colData and rowData to
disk.makeGRangesFromEnsembl
: Switched to using S4 run-length encoding (Rle) in
our metadata column (mcols) return. This functionality matches the conventions
used by GenomicRanges in the GRanges
return, and reduces the memory
footprint of very large annotation objects.Minor changes:
has_length
aren't quite strict enough.
Switch to using length(x) > 0L
or improved hasLength
assert check defined
in the goalie package.geneSynonyms
: Switched to using new pasteURL
function internally instead
of using paste
with /
separator.HGNC2Ensembl
generator: switch to using pasteURL
internally.loadData
, and other related load family functions: simplified internal code
using our new goalie asserts.Deprecations:
assertFormalGene2symbol
from deprecations.Documentation:
string
to character(1)
, and boolean
to
logical(1)
. This better matches the actual data structure in R. Some other
packages like checkmate also use this convention, which I think is more
readable than my previous approach.New functions:
deg
: Utility function to quickly obtain differentially expressed gene
(DEG) identifiers as a character vector.Major changes:
plotHeatmap
: Now defining row scaling internally, rather than relying on the
functionality defined in pheatmap
.New functions:
humanize
. New generic that enables easy conversion to human-friendly column
and/or row names. Useful for CSV file export in particular.Minor changes:
export
: Added humanize
argument support.makeNames
functions
(e.g. .sanitizeAcronyms
).sampleData
: Improved blacklist pattern matching against Seurat
objects
for SingleCellExperiment
method.Minor changes:
hasUniqueCols
from goalie. Switched from previous approach
using areSamplesUnique
.genomeBuild
, used in makeGRanges
functions.New functions:
relevelRowRanges
, relevelColData
.Deprecations:
markdownPlotlist
. Renamed to markdownPlots
.Minor changes:
autopadZeros
: Improved internal code to keep track of names for character
method. Also added method support for SummarizedExperiment
, which works on
the column names (e.g. sample names) only by default.Ensembl2Entrez
: Simplify validity check to require integer
in entrezID
column. Also reworked and improved internal code that supports run-length
encoding (Rle) using decode
.export
: Improved documentation for name
argument.makeGRangesFromEnsembl
: Improved messages to user.plotCountsPerBiotype
: Improved error messages for when the biotype isn't
defined.plotPCA
: Add support for unique sample detection with areSamplesUnique
,
similar to the approach used in the bcbioRNASeq quality control R Markdown.sampleNames
: Simplified sampleName
extraction, using [[
internally.sanitizeRowData
.New functions:
autopadZeros
. Useful for padding zeros inside of a character vector.basenameSansExt
. Quickly get the basename without the file extension for
desired file path(s). Surprisingly, this isn't defined in the tools package
so I wrote my own.cleanSystemLibrary
. I ran into some shared library configuration issues
on the Azure infrastructure, so this utility function is useful for checking
wheter an R installation has a clean library.plotGenderMarkers
: Migrated the SummarizedExperiment
method from
bcbioRNASeq package.Minor changes:
calls.R
into separate R files.
Refer to dots
, for example.environment.R
into separate R files. See detectHPC
for example.Minor changes:
assertthat::validate_that
in S4 class validity checks.
Removed former approach using internal .valid
function.deprecated.R
file.interestingGroups
doesn't attempt validity check using validObject
by
default, which can be enabled instead using check = TRUE
.sampleData
: Tightened up internal assert checks.PANTHER
: Minor tweaks to internal variable names inside .splitTerms
.transmit
: Improved messages. Temporarily disabled working example, since it
consistently fails on Travis CI.Major changes:
Migrating some additional base code that can be dispatched on either
SummarizedExperiment
or SingleCellExperiment
from the bcbio R packages.
We're going to split out some of the single-cell RNA-seq functionality into
separate packages, since a lot of my work moving forward deals with the 10X
Genomics Cell Ranger platform, rather than the bcbio-supported inDrops platform.
In particular:
barcodeRanksPerSample
.filterCells
.plotBarcodeRanks
.plotCellCounts
.plotGenesPerCell
.plotMitoRatio
.plotMitoVsCoding
.plotNovelty
.plotReadsPerCell
.plotUMIsPerCell
.plotUMIsVsGenes
.Minor changes:
plotHeatmap
and plotPCA
code from bcbio R packages.formalsList
global variable, which stashes getOption
defaults
used in some functions, namely the save/load functions and some plotting
functions.formalsList
along with formals
declaration internally
to make the parameters more consistent across functions.removeNA
).Major changes:
The split-out sub-package approach isn't working quite right, so the code base has been consolidated back into a single basejump package. Development toward splitting the package will continue, but a conceptual re-imagining of how to organize the functions is needed.
Major changes:
This release is the beginning of an attempt to rework the basejump codebase a bit and make the package easier to unit test on Travis CI. bcbio R packages will be pinned to v0.7.2 during this development period.
Here we are working to split out the functionality of basejump into several, smaller sub-packages:
New functions:
assertAllAreURL
.assertAllAreValidNames
.validNames
.Major changes:
gene2symbol
, makeGene2symbolFromEnsembl
, and
makeGene2symbolFromGFF
functions now support the unique
argument, which
returns sanitized values in the geneName
column, ensuring there are no
duplicates. This is enabled by default (recommended) but can be disabled using
unique = FALSE
. This functionality was added to ensure consistent gene name
handling in single-cell RNA-seq analyses.saveData
now supports basejump.save.ext
and basejump.save.compress
global options, so the desired file type (e.g. RDS instead of RDA) and
compression (e.g. xz instead of gzip) can be easily specified for an entire
project.Minor changes:
sampleNames
now supports assignment for SummarizedExperiment
method.lanePattern
regular expression pattern as a global, which was
previously defined in the bcbioBase package.as
coercion method support. Need to ensure
exportMethods(coerce)
is included in NAMESPACE
file, otherwise
tibble
coercion using as(x, "tbl_df")
won't work when called from an
Rscript without the package library loaded. Thanks @roryk for noticing this.gene2symbol
generic to use ...
, since we've added the
unique = TRUE
argument in this release.annotable
: Moved to makeGRanges.R
file, and improved the internal code
to export supported formals also used in makeGRangesFromEnsembl
. The
function should work exactly the same as previous releases, but now with
clearer supported arguments in the documentation.cleanSystemLibrary
, since Travis CI
installs packages into the system library, and causes this check to return
FALSE
.as(from, "tbl_df")
for internal tibble coercion in all
functions.geneSynonyms
and panther
: organism
argument matching no longer suggests
a default.
The current list of supported organisms is in the documentation, and described
in the internal match.arg
call.SummarizedExperiment
methods use validObject
validity checks, where
applicable.makeGRanges
, makeGene2symbol
, and
makeTx2gene
functions.annotationCol
and annotationColors
automatically.sampleData
: Made validity check stricter, requiring sampleName
column
to be defined, otherwise the function will intentionally error.formals
internall to keep ggplot2 theme formals consistent.CONTRIBUTING.md
file.New functions:
cleanSystemLibrary
: Utility function to check whether a user has installed
packages into the R system library. Refer to .libPaths
documentation
for more information on library paths.Major changes:
build
instead of genomeBuild
for Ensembl annotation
functions. The genomeBuild
argument still works but now will inform the user
about the change.Minor changes:
prepareTemplate
from bcbioBase package. Simplifed this
function to copy all files inside extdata/rmarkdown/shared
within a
specified package. Currently in use for bcbioRNASeq, bcbioSingleCell,
and the new pointillism clustering package.In this release, we are migrating some of the S4 generics previously exported in the bcbioBase package. We are consolidating these functions here for simplicity and stability.
New functions:
makeSummarizedExperiment
: Renamed prepareSummarizedExperiment
,
previously exported in the bcbioBase package. We are using the make
prefix here for consistency (see other gene annotation functions).flatFiles
,
metrics
, plotCorrleationHeatmap
, plotGene
, plotHeatmap
,
plotQC
, and plotQuantileHeatmap
.Major changes:
curl::has_internet
internally to check for Internet connection.
This applies to the annotation functions that query web databases.SummarizedExperiment
to
an unstructured list
. This is the method used internally for flatFiles
.New functions:
matchInterestingGroups
: New developer function to automatically handle
interestingGroups
argument used across various plotting functions and in the
bcbio infrastructure packges.Minor changes:
separatorBar
and updateMessage
global export from bcbioBase.
Improved separatorBar
appeareance to automatically scale to current session
width, using getOption("width")
.New functions:
convertSymbolsToGenes
: provides SummarizedExperiment
method support for
converting objects containing gene symbols ("geneName") as rownames back to
gene identifiers ("geneID").eggnog
: quickly download current annotations from EggNOG database.
Useful for annotating gene-to-protein matches; currently in use with the
brightworm RNAi screening package, which contains WormBase gene ID and
EggNOG ID annotations.Major changes:
broadClass
now supports GRanges
and SummarizedExperiment
. Support for
data.frame
and/or DataFrame
class objects has been removed.Minor changes:
convertGenesToSymbols
and convertTranscriptsToGenes
now have
organism
and gene2symbol
arguments set NULL
by default.dplyr::pull
to reexported functions.foldChangeToLogRatio
and logRatioToFoldChange
constructors into
numeric
method declarations.gene2symbol
SummarizedExperiment
method.toStringUnique
now uses x
instead of atomic
as primary argument.Minor changes:
convertGenesToSymbols
method for SummarizedExperiment
.
Previously, if geneName
column was a factor, this function would error.
This issue has been fixed by ensuring that the symbols provided in geneName
are coerced to a character vector.Major changes:
makeGRangesFromGFF
and other GFF utility
functions, including makeGene2symbolFromGFF
and makeTx2geneFromGFF
.
Note that makeGRangesFromGFF
now returns additional metadata columns
accessible with S4Vectors::mcols
, and that these columns are now sorted
alphabetically.Migrated functions:
Previously, these functions were exported in the bcbioBase package, but they provide non-bcbio-specific functionality, and should be included here in the basejump package instead:
assertFormalInterestingGroups
.gene2symbol
.interestingGroups
, uniteInterestingGroups
.sampleData
, sanitizeSampleData
.sampleNames
.selectSamples
.Providing basic SummarizedExperiment
class method support for counts
.
Minor changes:
geometricMean
generic was not exported correctly.Minor changes:
theme_midnight
and theme_paperwhite
now extend
ggplot2::theme_linedraw
, improving the consistency between these themes.rnaseq_counts
and single_cell_counts
, instead of the previous camel case conventions:
rnaseqCounts
, singleCellCounts
.Minor changes:
makeNames
argument from readFileByExtension
function. Use the
makeNames
family of functions manually after data import instead. This
helps avoid unwanted sanitization of data.Minor changes:
text
as the primary argument, instead of object
.Minor changes:
makeGRangesFromEnsembl
now supports remapping of UCSC genome build to
Ensembl. However, this isn't recommended, and will warn the user.convertUCSCBuildToEnsembl
now returns NULL
instead of erroring on
genome build match failure.stripTranscriptVersions
now matches ".
", "-
", and "_
" version
delimiters.dynamicPlotlist
function defunct.assertIsCharacterOrNULL
and
assertIsDataFrameOrNULL
in a future release.Infrastructure changes:
Minor changes:
theme_midnight
and theme_paperwhite
.Minor changes:
GenomeInfoDb::seqnames
.readGFF
working example to reflect switch to GRanges
return.Major changes:
readGFF
now uses rtracklayer::import
internally to return GFF file
as a GRanges
object instead of a data.frame
.Minor changes:
assertIsGFF
and parseGFFAttributes
functions are now defunct.makeGRangesFromGFF
,
makeGene2symbolFromGFF
, and makeTx2geneFromGFF
.sanitizeSampleData
to bcbioBase package.Minor changes:
fixNA
and removeNA
.theme_midnight
and theme_paperwhite
.
Now using British spelling internally for ggplot code.strip.background
for theme_paperwhite
, removing the black box
around the labels when facet wrapping is enabled.Minor changes:
geomean
in favor of geometricMean
.grepString
.hgnc2gene
call.panther(organism = "XXX")
.nocov
where appropriate.Minor changes:
emptyRanges
: Now using match.arg
internally to capture seqname
argument..assignCamelArgs
and .assignCamelFormals
internal
functions.localOrRemoteFile
.New functions:
emptyRanges
enables easy creation of placeholder ranges for GRanges
objects, where transgene and FASTA spike-ins are needed.hgnc2gene
enables easy mapping of HGNC to Ensembl gene
identifiers.mgi2gene
enables easy mapping of MGI to Ensembl gene identifiers.panther
function enables easy querying of the PANTHER website.
Human, mouse, nematode worm, and fruit fly are currently supported. The
specific PANTHER release (e.g. 13) can be declared using the release
argument. Otherwise, the function will return the most recent annotations
from the PANTHER website.isURL
check function.readJSON
adds support for JSON files. Like the other read functions, it
supports both local files and remote URLs.ggplot2 themes:
theme_midnight
and theme_paperwhite
provide minimal, high contrast
ggplot2 themes with bold sans serif labels.Major changes:
loadData
now supports .rda
, .rds
, and .RData
files. The function
will error by design if multiple data extensions are detected inside the
directory specified with the dir
argument.Minor changes:
basejump-package.R
file.globals.R
file..biocLite
function. Now using requireNamespace
instead, without attempting to install automatically.message
, warning
, and stop
instead of
the rlang equivalents.getMethod
where applicable.multiassignAsEnvir
is now recommended in place of
multiassignAsNewEnvir
.readFileByExtension
will now attempt to use the rio package for
file extensions that are not natively supported.writeCounts
now uses mapply
internally.assertFormalAnnotationCol
to bcbioBase package.Major changes:
ensembl
, genes
, and transcripts
.
These functions allow the return of GRanges
, DataFrame
, and data.frame
class objects from AnnotationHub using ensembldb.broadClass
definition code to match against chromosome
from Ensembl if available.loadDataAsName
now works with unquoted names, improving consistency
with loadData
(non-standard evaluation).Minor changes:
convertUCSCBuildToEnsembl
function, for easy remapping of
UCSC to Ensembl genome build names (e.g. hg38
to GRCh38
).plotCorrelationHeatmap
here from
bcbioRNASeq, for improved consistency with other heatmap functions.makeNames
variant of base::make.names
that sanitizes
using underscores rather than dots.readYAML
from a generic to standard function.BiocCheck
.assertAreGeneAnnotations
,
assertAreTranscriptAnnotations
, isAnImplicitInteger
.Deprecations:
annotable
function has been deprecated in favor of the new ensembl
function.checkAnnotable
deprecated in favor of assertIsAnnotable
.checkGene2symbol
deprecated in favor of assertIsGene2symbol
.checkTx2gene
deprecated in favor of assertIsTx2gene
.assertFormalColorFunction
deprecated in favor of
assertIsHexColorFunctionOrNULL
.initializeDir
deprecated in favor of initializeDirectory
.summarizeRows
, wash
, packageSE
, prepareSE
,
metadataTable
, comp
, revcomp
, symbol2gene
.sanitizeColData
function.assertAllAreNonExisting
function.midnightTheme
as a theme_midnight
alias to match the
syntax in the ggplot2 package.annotable
to simply work on
the Entrez identifier column (entrez
). If a manually passed in data
frame still has duplicates, the function will now abort instead of attempting
to use collapseToString
.assertColorScaleContinuousOrNULL
, assertColorScaleDiscreteOrNULL
,
assertFillScaleContinuousOrNULL
, assertFillScaleDiscreteOrNULL
.assert_formal_annotation_col
, assert_formal_color_function
,
assert_formal_compress
, assert_formal_gene2symbol
,
assert_formal_header_level
, assert_has_rownames
,
assert_is_a_number_or_null
, assert_is_a_string_or_null
,
assert_is_an_implicit_integer
, assert_is_an_implicit_integer_or_null
assert_is_an_integer_or_null
, assert_is_annotable
,
assert_is_character_or_null
, assert_is_data.frame_or_null
,
assert_is_gene2symbol
, assert_is_implicit_integer
,
assert_is_implicit_integer_or_null
, assert_is_tx2gene
,
has_rownames
, initializeDirectory
, is_implicit_integer
.md*
functions to markdown*
.convertGenesToSymbols
and convertTranscriptsToGenes
functions. Previously some of this functionality was contained within the
gene2symbol
and tx2gene
generics for the character method. This
behavior was inconsistent with gene2symbol
and tx2gene
usage in the
bcbio R packages, so I decided to split these out into separate functions.
Now gene2symbol
and tx2gene
work consistently with the annotable
function to return gene-to-symbol and transcript-to-gene identifier mappings
in a data.frame
.markdownHeader
, markdownList
, and markdownPlotlist
are now
exported as S4 generics. The md*
function variants are now exported as
aliases.geomean
has been renamed to geometricMean
.bcbio
, checkInterestingGroups
, flatFiles
, interestingGroups
,
metrics
, plotDot
, plotGene
, plotQC
, plotViolin
,
prepareSummarizedExperiment
, prepareTemplate
, readDataVersions
,
readLogFile
, readProgramVersions
, readSampleMetadataFile
,
sampleMetadata
, sampleYAML
, sampleYAMLMetadata
,
sampleYAMLMetrics
, and selectSamples
. These functions are now
deprecated here in basejump (see deprecated.R
file for more
information).comp
and revcomp
have been deprecated in favor of complement
and reverseComplement
from the Biostrings package.abort
, inform
, and warn
, in place of stop
,
message
, and warning
, respectively.loadData
. Additionally, the
file name must match the internal name in the RData file, otherwise
loadData
will warn the user. This is more strict than the default
behavior of base::load
, but helps prevent accidental overwrite in the
current working environment.localOrRemoteFile
, previously an internal function, is now exported.annotable
now uses internal GRCh37 annotations from the annotables
package, which is saved in the extdata/
directory internally. Previously,
these genome annotations were accessed from lazy loaded data saved in the
data/
directory of the package repository.annotables
now checks for all packages attached by ensembldb and
AnnotationHub and forces detachment at the end of the function call.
Otherwise, this can result in the unwanted effect of ensembldb masking
other user-loaded functions, such as the tidyverse suite (e.g.
dplyr::select
).camel
now handles delimited numbers a little differently. Previously,
delimiters in between numbers (e.g. the commas in "1,000,000") were stripped.
Sometimes this can result in confusing names. For example, if we have a
column formatted in dotted case containing a decimal (e.g. "resolution.1.6"),
the decimal would be stripped (e.g. "resolution16" in camel). Now, we
sanitize a numeric delimiter as a lower case "x" character (e.g.
"resolution1x6"). This ensures that numbers containing decimals remain
semantically meaningful when sanitized with camel
.gsub
(and grepl
) calls have been simplified to use the
default order of "pattern, replacement, x".readSampleMetadataFile
. We
were detecting the presence of index
column but should instead check
against sequence
column.dynamicPlotlist
and mdPlotlist
plotting utilities.uniqueSymbols
parameter to annotable
function.plotHeatmap
functionality.tpm
generic from bcbioRNASeq, for future use in
bcbioSingleCell.plotHeatmap
.plotQuantileHeatmap
, which works
similarly as plotHeatmap
.matrix
and dgCMatrix
method support in aggregateReplicates
and aggregateFeatures
functions. Both of these functions now use a
consistent groupings
parameter, which uses a named factor to define the
mappings of either samples (columns) for aggregateReplicates
or
genes/transcripts (rows) for aggregateFeatures
.makeNames
sanitization functions. Now they will work on
names(x)
for vectors by default.detectOrganism
to match against "H. sapiens", etc.makeNames
utilities: camel
,
dotted
, snake
, and upperCamel
.NA
values from LibreOffice and
Microsoft Excel output in readFileByExtension
. This function now
sets ""
, NA
, and #N/A
strings as NA
correctly.fc2lr
to foldChangeToLogRatio
and lr2fc
and
logRatioToFoldChange
.plotDot
and plotViolin
generics here from bcbioSingleCell.microplate
code from the wormbase package here, since
it's of general interest.checkAnnotable
, checkGene2symbol
, checkTx2gene
, and
sanitizeAnnotable
utility functions that will be used in the bcbio R
packages.midnightTheme
ggplot2 theme. Originally this was defined as
darkTheme
in the bcbioSingleCell package, but can be useful for other
plots and has been moved here for general bioinformatics usage. The theme now
uses ggplot2::theme_minimal
as the base, with some color tweaks, namely
dark gray axes without white axis lines.stats::formula
and
utils::capture.output
.loadData
and loadDataAsName
now default to replace = TRUE
. If an
object with the same name exists in the destination environment, then a
warning is generated.collapseToString
only attempts to dynamically return the original
object class on objects that aren't class data.frame
. I updated this code
to behave more nicely with grouped tibbles (grouped_df
), which are a
virtual class of data.frame
and therefore can't be coerced using
as(object, "grouped_df")
.comp
and revcomp
now return NULL
for integers and numerics.prepareSummarizedExperiment
, added support for dropping NULL
objects in assays list. This is useful for handling output from
bcbioRNASeq when transformLimit
is reached. In this case, the rlog
and
vst
matrices aren't generated and set NULL
in the assays list. Using
Filter(Negate(is.null), assays)
we can drop these NULL
objects and
prevent a downstream dimension mismatch in the
SummarizedExperiment::SummarizedExperiment
call.readSampleMetadataFile
. This
now checks for a sequence column containing ACGT nucleotides. When those are
detected, the revcomp
column is generated. Otherwise this step is skipped.
This is useful for handling multiplexed sample metadata from 10X Genomics
Cell Ranger single-cell RNA-seq samples.annotable
function to include nested Entrez identifiers in the
entrez
column. This is useful for downstream functional analysis.plotQC
generic.toStringUnique
code, which is still in use in the
wormbase package.summarizeRows
(now collapseToString
) and
wash
functions.detectOrganism
. Now allowing NULL
return for unsupported
organism, with a warning.saveData
. Now will skip on existing files
when overwrite = FALSE
.readDataVersions
, which shouldn't have the column types
defined, using col_types = "ccT"
.loadDataAsName
. Now rather than
using a named character vector for the mappings
argument, the user can
simply pass the key value pairs in as dots. For example, newName1 =
"oldName1", newName2 = "oldName2"
. The legacy mappings
method will still
work, as long as the dots argument is a length of 1.NULL
instead of current
for
annotable
, gene2symbol
, symbol2gene
and tx2gene
functions.rowData
to be left unset in prepareSummarizedExperiment
. This is
useful for setting up objects that don't contain gene annotations.pattern
, patternCol
arguments) in readSampleMetadata
. This feature wasn't fully baked and
doesn't offer enough functionality to the user.prepareSummarizedExperiment
.basejump-package.R
file.sampleDirs
generic.detectOrganism
and added support for
chicken genome.prepareSummarizedExperiment
to make
sample loading with loadRNASeq
and loadSingleCell
in the bcbio
packages less confusing.NULL
returns in readDataVersions
, readLogFile
, and
readProgramVersions
utility functions.*GTF
alias functions to simply wrap the *GFF
functions with S4 methods support.readSampleMetadataFile
.camel
syntax for both lax and strict modes. Added
upperCamel
function.str_
to base grep
and gsub
in internal functions.setMethod
calls using signature
.loadRemoteData
to a standard function instead of using S4
dispatch, allowing the envir
argument to be set properly.DESCRIPTION
file.multiassignAsNewEnv
to multiassignAsNewEnvir
*GFF
function variants for gene2symbolFromGTF
and
tx2geneFromGTF
.aggregateReplicates
, bcbio
,
bcbio<-
, interestingGroups
, metrics
, plotGene
,
sampleDirs
, sampleMetadata
, selectSamples
. These functions are
saved in bcbioGenerics.R
file.readDataVersions
(deprecated .dataVersions
),
readLogFile
(deprecated .logFile
), readProgramVersions
(deprecated .programs
), sampleYAML
(deprecated .sampleYAML
),
sampleYAMLMetadata
(deprecated sampleYAMLMetadata
),
sampleYAMLMetrics
(deprecated .sampleYAMLMetrics
).metadataTable
function.methods-*.R
files where applicable.assays
in prepareSummarizedExperiment
generic definition as
primary object.assignAndSaveData
to add silent return of file path.%>%
)..prepareSampleMetadata
utility function, for use with loading
sample metadata from an external CSV, Excel, or YAML file.loadData
functionality back to the package.loadDataAsName
function.annotable
function documentation and support for Ensembl
release versions.camel
, dotted
, and snake
name
functions. Added the strict
argument to camel
and dotted
.makeNames
functions, by splitting each
into their own separate methods file.geomean
function. Also improved internal code
of geomean
based on Paul McMurdie's Stack Overflow post. See function
documentation for more information.tx2gene
functions.%>%
), Matrix
, DataFrame
, and tibble
.saveData
function.as(object, "tibble")
collapse
function to collapseToString
, to avoid NAMESPACE
collisions with tidyverse packages (dplyr, glue).annotable
function to query Ensembl using the ensembldb
package rather than annotables.prepareSE
to prepareSummarizedExperiment
. Improved row and
column name handling in the function. It now outputs more helpful diagnostic
messages on error.detectHPC
function to allow for unit testing.packageSE
to prepareSE
for better semantic meaning.…
).localOrRemote
utility function.prepareTemplate
function.data-raw/
scripts.onLoad.R
script back to ensure proper attachment of annotables
data package.readFileByExtension
, readGTF
, and
readYAML
functions.parent.frame
assignment not work correctly.packageSE
.assign_data
for use in bcbioSingleCell sample loops.as_tibble
now
provides better consistency for rowname conversion.removeNA
utility function.saveData
utility functions.Add the following code to your website.
For more information on customizing the embed code, read Embedding Snippets.