- Updated interactive
SpatialDimPlot
s to display spatial coordinates - Updated
BuildClusterTree
toPseudobulkExpression(..., method = "aggregate")
instead ofAverageExpression
- Fixed
SpatialPlot
to properly handle images with shared cells - Added
cluster.name
parameter toBuildNicheAssay
- Added
VisiumV2
class, inheritsSeuratObject::FOV
, returned byLoad10X_Spatial
- Updated
Load10X_Spatial
to support loading Visium HD datasets - addedbin.size
parameter - Updated
Read10X_Coordinates
to handle newtissue_coordinates.parquet
files - Added
shape
parameter toSpatialPlot
and wrappers:SpatialFeaturePlot
andSpatialDimPlot
- Added
image.scale
parameter toSpatialPlot
and related functions:SpatialFeaturePlot
/ISpatialFeaturePlot
andSpatialDimPlot
/ISpatialDimPlot
- Restored
image.name
parameter toRead10X_Image
- Added
scale
parameter toRadius.VisiumV1
- Fixed calculation of
spot.radius
attribute forVisiumV1
instance returned byRead10X_Image
— replacescale.factors$fiducial
withscale.factors$spot
- Added
Read10X_Coordinates
andRead10X_ScaleFactors
- Fixed
SpatialPlot
to properly handle mutli-assaySeurat
instances
- Fixed
PercentAbove
to discount null values (#8412) - Added
log
parameter toFeatureScatter
- Fixed handling of
clip.range
forSCTransform
whenncells
is less than the size of the passed dataset
- Fixed
AverageExpression
to handlefeatures
vector whenlayer="scale.data"
andreturn.seurat=TRUE
- Added
fc.slot
parameter toFindMarkers
- Fixed
SCTransform
to handlevars.to.regress
(#8148) and (#8349) - Fixed
SCTransform
to handle fetching residuals (#8185)
- Fixed
SCTransform.StdAssay
to pass extra arguments tosctransform::vst()
. Fixes #875 - Fixed PercentageFeatureSet Layer calling (#8009)
- Fixed cell highlighting (#7914)
- Updated marker sorting to be by p-value with ties broken by absolute difference in percent expression
- Fixed issue with replicated barcodes in MappingScore (#7922)
- Improved
PseudobulkExpression
by adding 'g' to cell names that started with numeric values - Improved
PseudobulkExpression
by adding each variable specified ingroup.by
as columns in the object metadata whenreturn.seurat=TRUE
- Fixed
DimPlot
andFeatureScatter
which were breaking when using thesplit.by
argument with a variable that contained NAs
- Add
BridgeCellsRepresentation
to construct a dictionary representation for each unimodal dataset. - Add
BuildNicheAssay
to construct a new assay where each feature is a cell label. The values represent the sum of a particular cell label neighboring a given cell. - Add
CalcDispersion
to calculate the dispersion of features. - Add
CCAIntegration
to perform Seurat-CCA Integration. - Add
CountSketch
to generate a CountSketch random matrix. - Add
CreateCategoryMatrix
to create a one-hot matrix for a given label. - Add
DISP
to find variable features based on dispersion. - Add
FastRPCAIntegration
as a convenience wrapper function around the following three functions that are often run together when performing integration. - Add
FetchResiduals_reference
as a temporary function to get residuals from the reference. - Add
FetchResiduals
to call sctransform::get_residuals. - Add
FetchResidualSCTModel
to calculate Pearson residuals of features not in the scale.data. - Add
FindBridgeAnchor
to find bridge anchors between two unimodal datasets. - Add
FindBridgeIntegrationAnchors
to find a set of anchors for integration between unimodal query and the other unimodal reference using a pre-computed BridgeReferenceSet. - Add
FindBridgeTransferAnchors
to find a set of anchors for label transfer between unimodal query and the other unimodal reference using a pre-computed BridgeReferenceSet. - Add
GaussianSketch
to perform Gaussian sketching. - Add
HarmonyIntegration
to perform Harmony integration. - Add
IntegrateLayers
to integrate layers in an assay object. - Add
JointPCAIntegration
to perform Seurat-Joint PCA Integration. - Add
LeverageScore
to compute the leverage scores for a given object. - Add
LoadCurioSeeker
to load Curio Seeker data. - Add
MVP
to find variable features based on mean.var.plot. - Add
NNtoGraph
to convert the Neighbor class to an asymmetrical Graph class. - Add
PrepareBridgeReference
to preprocess the multi-omic bridge and unimodal reference datasets into an extended reference. - Add
ProjectCellEmbeddings
to project query data onto the reference dimensional reduction. - Add
ProjectData
to project high-dimensional single-cell RNA expression data from a full dataset onto the lower-dimensional embedding of the sketch of the dataset. - Add
ProjectDimReduc
to project query data to reference dimensional reduction. - Add
ProjectIntegration
to integrate embeddings from the integrated sketched.assay. - Add
PseudobulkExpression
to normalize the count data present in a given assay. - Add
Read10X_probe_metadata
to read the probe metadata from a 10x Genomics probe barcode matrix file in HDF5 format. - Add
RPCAIntegration
to perform Seurat-RPCA Integration. - Add
RunGraphLaplacian
to run a graph Laplacian dimensionality reduction. - Add
SelectIntegrationFeatures5
to select integration features for v5 assays. - Add
SelectSCTIntegrationFeatures
to select SCT integration features. - Add
SketchData
to use sketching methods to downsample high-dimensional single-cell RNA expression data for help with scalability for large datasets. - Add
TransferSketchLabels
to transfer cell type labels from a sketched dataset to a full dataset based on the similarities in the lower-dimensional space. - Add
UnSketchEmbeddings
to transfer embeddings from sketched cells to the full data. - Add
VST
to apply a variance stabilizing transformation for selection of variable features.
- Change
FindTransferAnchors
so that anchor filtering is not performed by default - Change
merge
so that layers will be added to a single Seurat object instead of combining raw count matrices - Deprecate
slot
parameter in favor oflayers
in accessor and set methods
- Add parallelization support with speed improvements for
PrepSCTFindMarkers
- Fix bug in
LoadNanostring
(#7566)
- Fix bug in
as.Seurat.SingleCellExperiment()
(#6692) - Support for Visium probe information introduced in Spaceranger 2.1 (#7141)
- Add
LoadCurioSeeker
to load sequencing-based spatial datasets generated using the Curio Seeker - Fix fold change calculation for assays (#7095)
- Fix
pt.size
bug when rasterization is set to true (#7379) - Fix
FoldChange
andFindMarkers
to support all normalization approaches (#7115,#7110,#7095,#6976,#6654,#6701,#6773, #7107) - Fix for handling newer ParseBio formats in
ReadParseBio
(#7565) - Fix for handling rasterization by default (#7842)
- Fix bug in
ReadMtx()
to add back missing parameters - Fix
SCTransform()
for V5 assays to retain gene attributes (#7557) - Fix
LeverageScore()
for objects with few features (#7650
- Add support for imaging-based spatial datasets
- Fix bug in
FindMarkers()
when run post Integration/Transfer (#6856)
- Replaced import from
spatstat.core
withspatstat.explore
- Fix bug in
FindMarkers()
when usingSCT
assay (#6856)
- Fix legend color in
DoHeatmap()
(#5783) - Fix bug in
ScaleData()
when regressing out one gene (#5970) - Fix name pulling in
PlotPerturbScore()
(#6081) - Support spaceranger 2.0 (#6208)
- Fix bug in
SpatialDimPlot()
when usinggroup.by
(#6179) - Add
add.noise
parameter inVlnPlot()
(#5756) - Fix uwot model backwards compatibility (#6345)
- Allow
pseudocount.use
in differential expression functions to be set at theAssay
level
- Fix
giveCsparse
related warnings inRead10X_h5
- Fix ident labeling for
SpatialPlot
(#5774) - Fix
ReadMtx
on Windows (#5687) - Fix
VlnPlot
to switch on rasterization only when required (#5846) - Fix
ncol
behavior inSpatialPlot
(#5774) - Set
jitter
to FALSE inFeatureScatter
(#5876) - Update
Cells
methods to new signature (x, ...
) - Replace use of
default.stringsAsFactors()
withgetOption("stringsAsFactors")
- Add
raster.dpi
parameter toDimPlot/FeaturePlot
to optionally rasterize individual points (#5392) - Add support for sctransform v2, differential expression with SCT assay
- Update
ReadParseBio
to support split-pipe 0.9.6p (#5446) - Fixes for MAST differential expression (#5441)
- Fix scaling options when using
split.by
inFeaturePlot()
(#5243)
- Implement supervised LSI
- Add
raster
parameter toVlnPlot
to optionally rasterize individual points (#5076) - Add
min.cells.group
parameter toFindConservedMarkers
(#5079) - Set
do.center
to FALSE forlsiproject
inFindTransferAnchors
- Fix error message in
ReadMtx()
(#5158) - Add
label.color
parameter toFeaturePlot
(#5314) - Fix issues in
ProjectUMAP
(#5257, #5104, #5373)
- Update documentation for
to.upper
parameter inLoad10X_Spatial()
(#4576) - Update concept tags for
RunSPCA()
(#4978) - Conditionally run tests/packages that use suggested packages (#5160)
- Set random state in
RunUMAP()
when using theumap-learn
method (#5194)
- Add
reduction
parameter toBuildClusterTree()
(#4598) - Add DensMAP option to
RunUMAP()
(#4630) - Add
image
parameter toLoad10X_Spatial()
andimage.name
parameter toRead10X_Image()
(#4641) - Add
ReadSTARsolo()
function to read output from STARsolo - Add
densify
parameter toFindMarkers()
- Add
ReadParsebio()
function to read output from Parse Biosciences - Add the
image.alpha
parameter toSpatialDimPlot()
andSpatialFeaturePlot()
- Add support for the correlation metric in
RunUMAP
(#4972)
- Warn and continue rather than erroring if not all features are available in
FindSpatiallyVariableFeatures()
(#4611) - Bug fix for SCT-based integration in selecting proper reference model (#4355)
- Bug fix for reading from absolute paths in ReadMtx (#4723)
- Bug fix in SingleCellExperiment conversion (#4633)
- Bug fix in
FindVariableFeatures()
when usingselection.method = "mvp"
andbinning.method = "equal_frequency"
(#4712) - Bug fix in
DoHeatmap()
to remove random characters from plot legend(#4660) - Fix cell renaming in
RunCCA()
- Fix issue in SingleCellExperiment conversion where the mainExp would not be set properly
- Fix for default dispersion info displayed in
VariableFeaturePlot()
- Add
jitter
parameter toFeatureScatter()
- Fix issues with
as.SingleCellExperiment.Seurat()
for the latest verion of SingleCellExperiment (#4532) - Ensure proper reference.reduction is used in
MapQuery()
- Fix to
UpdateSymbolList()
, no longer searches aliases and exposes thesearch.types
parameter inGeneSymbolThesarus()
(#4545) - Transfer
scale.data
slot as well when converting withas.SingleCellExperiment.Seurat()
- Enable
alpha
parameter forSpatialDimPlot()
- Fix
as.SingleCellExperiment.Seurat()
conversion for atypicalreducedDim
components
- New
AddAzimuthScores()
andAddAzimuthResults()
functions - Add
shuffle
parameter toFeatureScatter()
(#4280) - Add
lsiproject
andrpca
options forFindTransferAnchors()
- Add
rlsi
option forFindIntegrationAnchors()
- Preserve feature metadata when converting from
SingleCellExperiment
toSeuratObject
class (#4205) - Preserve multiple assays when converting from
SingleCellExperiment
toSeuratObject
class (#3764) - Fix passing of
score.thresh
parameter inScoreJackStraw()
(#4268) - Fix FC calculation in
FindMarkers()
non-log transformed data. - Add umap-learn version >= 0.5.0 compatibility for
RunUMAP()
- Fix
DotPlot
to uselog1p
whenscale=False
(#4298) - Fix split and shuffled
DimPlot
- Disallow NULL or another length 0 vector for
ident.1
inFindMarkers()
- Fix range shift when labeling clusters on a GeomSpatial plot
- Fix SpatialPlot distortion for non-square images.
- Fix future-related warnings in
FindIntegrationAnchors()
- Fix
fc.name
parameter inFindMarkers()
(#4474) - Deprecate
group.by
parameter inPlotPerturbScore()
in favor ofmixscape.class
.
- Add direction option to
PlotClusterTree()
- Add
cols
parameter toJackStrawPlot()
- Add
ReadMtx()
to read local and remote mtx files with associated cell and feature name files
- Equality added to differential expression thresholds in
FindMarkers
(e.g, >= logfc.threshold rather than >) Read10X()
now prepends dataset number for first dataset when reading multiple datasets- Bug fix for
subset.AnchorSet()
- Bug fix for fold change values in
FindMarkers()
when setting a different pseudocount (#4111) - Bug fix for
RunLDA()
related to proper passing of assay parameter. - When using
order=TRUE
inSingleDimPlot()
, print NA points under all others. - Remove default parameter value for
data.dir
inRead10X()
- Import spatstat fxns from subpackages (spatstat.core, spatstat.geom)
RunUMAP
now checks for graph/neighbor consistency
- Expose
FoldChange()
component inFindMarkers()
. - Add the
merge.DimReduc
method - Add
IntegrateEmbeddings()
to correct embeddings ofDimReduc
s - Add
ProjectUMAP()
to project query cells into a reference UMAP space - Add
MapQuery()
as a wrapper aroundIntegrateData()
,IntegrateEmbeddings()
, andProjectUMAP()
- Add
MappingScore
to compute a per-cell mapping score used in Azimuth - Add
AggregateExpression()
for summation based pseudobulk calculations - Add mixscape functionality via
CalcPerturbSig()
,PrepLDA()
,RunLDA()
,DEenrichRPlot()
,MixscapeHeatmap()
,MixscapeLDA()
,PlotPerturbScore()
,RunMixscape()
- Add
FindSubCluster()
to further cluster existing clusters - Add supervised PCA functionality via
RunSPCA()
- Add functionality to enable weighted nearest neighbor analyses via
FindMultiModalNeighbors()
- Add neighbor visualization plot via
NNPlot()
. - Add
PredictAssay()
to impute expression or embeddings from nearest neighbors - Add
Graphs()
function to access the names of the stored Graph objects or pull a specific one - Add checks for NA, NaN, logical, non-integer, and infinite values during CreateAssayObject and NormalizeData.default
- Add
AnnotateAnchors()
to aid in AnchorSet interpretation as well assubset.AnchorSet()
- Add flexibility of choice for cell column in
Read10X()
- Add rasterization option to
FeatureScatter()
andVariableFeaturePlot()
- Add step1 feature parameters in the SCTModel via
PrepVSTResults()
- Default neighbor finding algorithm changed from "rann" to "annoy"
- Default
ncells
parameter inSCTransform()
changed to 5000 - Default fold change in
FindMarkers()
changed from ln to log2 - Implementation improvements to
AverageExpression()
AnchorSet
class re-implemented as a virtual class from whichIntegrationAnchorSet
andTransferAnchorSet
now inherit.- Point size in
VlnPlot()
now set automatically if not specified - Return the sample.tree properly when integrating with a single reference dataset
- Replace
as.character.quosure
usage withas_label
due to deprecation - Minor changes to the exact calculation of the anchor weight matrix
- Default rasterization limit in
DimPlot()
andFeaturePlot()
changed from 50,000 to 100,000 SCTransform()
now returns a formalizedAssay
subclassSCTAssay()
- When using
normalization.method='SCT'
inFindTransferAnchors()
, normalize query using reference SCT model when possible. - Change default Neighbor name in
FindNeighbors
toAssay.nn
CreateGeneActivityMatrix
replaced bySignac::GeneActivity()
RunLSI
replaced by bySignac::RunTFIDF()
andSignac::RunSVD()
ReadAlevin
andReadAlevinCsv
moved to SeuratWrappersExportToCellbrowser
andStopCellbrowser
moved to SeuratWrappers
- Titles added to
DimPlot
when specifyinggroup.by
parameter keep.scale
parameter added toFeaturePlot
to control scaling across multiple features and/or splits.
Same
deprecated in favor ofbase::identity
- Fix in
DietSeurat
to work with specializedAssay
objects - Fix p-value return when using the
ape
implementation of Moran's I - Fix bug in FindMarkers when using MAST with a latent variable
- Updates to
Key<-.DimReduc
that allow handling of empty reduction column names - Allow setting
ctrl
inCellCycleScoring
- Modify subset.Seurat to allow specialized Assay subsetting methods
- Fix image selection in interactive spatial plots
- Update Rcpp functions with
export(rng=FALSE)
to avoid potential future warnings - Fix RenameCells bug for integrated SCT assays
- Fix highlight order with proper factor levels when using
SetHighlight
in plots - Small change in CellRanger version detection logic of h5 file to improve robustness to outside tools.
do.cpp
deprecated and will default to true
- Set the seed in
WhichCells
regardless of whether or notidents
is passed - Retain Graph and Neighbor objects when subsetting only on features
- Fix data.frame input to
CreateAssayObject()
when data.frame has no rownames. - Default annoy search to sequential if not using multicore future plans.
- Require sctransform >= 0.3.0
- Added support for nearest neighbor input and
return.model
parameter inRunUMAP()
- Enable named color vectors in
DoHeatmap()
- Add
label.color
andlabel.box
parameters toDimPlot
- Added
shuffle
andseed
parameters toDimPlot()
to help with overplotting - Added new stacked violin plot functionality
- Allow setting
slot
parameter inRunUMAP
- Added support for FIt-SNE v1.2+
- Fix for
Spatial*Plot
when running with interactive=TRUE - Set max for number of items returned by
Top
and remove duplicate items when balanced=TRUE - Fix logging bug when functions were run via
do.call()
- Fix handling of weight.by.var parameter when approx=FALSE in
RunPCA()
- Fix issue where feature names with dashes crashed
CellSelector
- Fix issue where errors in subsetting were being swallowed
- Fix issue where labeling uncropped spatial plots was broken
CreateActivityMatrix
deprecated in favor ofSignac::GeneActivity
ReadAlevin
andReadAlevinCsv
deprecated in favor ofSeuratWrappers::ReadAlevin
ExportToCellbrowser
andStopCellbrowser
deprecated in favor ofSeuratWrappers::ExportToCellbrowser
andSeuratWrappers::StopCellbrowser
ReadH5AD
andWriteH5AD
deprecated in favor of h5Seurat/H5AD functionality found in SeuratDiskas.loom
andas.Seurat.loom
deprecated in favor of functionality found in SeuratDisk
- Added ability to create a Seurat object from an existing Assay object, or any object inheriting from the Assay class
- Added ability to cluster idents and group features in
DotPlot
- Added ability to use RColorBrewer plaettes for split
DotPlots
- Added visualization and analysis functionality for spatially resolved datasets (Visium, Slide-seq).
- Removed
add.iter
parameter fromRunTSNE
function - Fixed integer overflow error in the WilcoxDETest function
- Minor visual fixes in
DoHeatmap
group bar + labels - Efficiency improvements in anchor scoring (
ScoreAnchors
) - Fix bug in
FindClusters()
when the last node has no edges - Default to weighted = TRUE when constructing igraph objects in
RunLeiden
. Remove corresponding weights parameter fromFindClusters()
. - Fix handling of keys in
FeatureScatter()
- Change
CellSelector
to use Shiny gadgets instead of SDMTools - Mark
PointLocator
as defunct - Remove
SDMTools
- Fixed data slot return in
AverageExpression
when subsetting features and returning a Seurat object
- New
scale
parameter inDotPlot
- New
keep.sparse parameter in
CreateGeneActivityMatrix` for a more memory efficient option - Added ability to store model learned by UMAP and project new data
- New
strip.suffix
option inRead10X
. This changes the default behavior ofRead10X
. A trailing-1
present in all cell names will not be removed by default. - Added
group.by
parameter toFeatureScatter
- Replace wilcox.test with limma implementation for a faster FindMarkers default method
- Better point separation for
VlnPlot
s when using thesplit.by
option - Efficiency improvements for anchor pairing
- Deprecate redundant
sort.cell
parameter inFeaturePlot
- Fixes to ensure correct class of Matrix passed to c++ functions
- Fixes for underscores in ident labels for
DotPlot
- Ensure preservation of matrix dimnames in
SampleUMI
- Fix non-standard evaluation problems in
subset
andWhichCells
- Default split violin option is now a multi group option
- Preserve alpha in
FeaturePlot
when usingblend
- Update
assay.used
slot forDimReduc
s when Assay is renamed
- Fixes to
DoHeatmap
to remain compatible with ggplot2 v3.3 - Adoption of
patchwork
framework to replaceCombinePlots
- New system agnostic
Which
function to address problems with FItSNE on Windows
- Export
CellsByIdentities
andRowMergeSparseMatrices
functions - nCount and nFeature metadata variables retained after subset and updated properly with
UpdateSeuratObject
- Fix uwot support for running directly on feature matrices
- Fixes for keys with underscores
- Fix issue with leiden option for
FindClusters
- Fix for data transfer when using sctransform
- SDMTools moved to Suggests as package is orphaned
- New silent slot updater
- New random seed options to
RunCCA
,RunTSNE
,WhichCells
,HTODemux
,AddModuleScore
,VlnPlot
, andRidgePlot
- Enhancements for dealing with
Assay
-derived objects
- Only run
CalcN
(generates nFeatures and nCounts) whencounts
changes - Fix issue regarding colons in feature names
- Change object class testing to use
inherits
oris.*
for R 4.0 compatability
- New
RegroupIdents
function to reassign idents based on metadata column majority UpdateSymbolList
function to pull new gene names from HGNC- Added support for H5AD layers as additional assays in a
Seurat
object
- Fix rownames issue when running UMAP on dist object
- Add support for new H5AD
obsm
andvarm
stucture - Fix issue when trying to read non-existent feature-level metadata from an H5AD file
- Fix in integration workflow when using SCTransform
- Improved error checking for
AddModuleScore
- cbind fix in reference-based integration (
MapQuery
) - Fix for convenience plots error hanging
- Ensure Seurat objects aren't stored in the command logs
- New
PrepSCTIntegration
function to facilitate integration afterSCTransform
- Reference-based integration with the
reference
parameter inFindIntegrationAnchors
- Reciprocal PCA as a
reduction
option inFindIntegrationAnchors
- New
CollapseEmbeddingOutliers
function - Enable
FindTransferAnchors
afterSCTransform
- Added back
ColorDimSplit
functionality - Include a code of conduct
- Added uwot support as new default UMAP method
- Added
CheckDots
to catch unused parameters and suggest updated names Reductions
andAssays
assays functions to list stored DimReducs and Assays
- Fix regex in
LogSeuratCommand
- Check for NAs in feature names in
Read10X
- Prevent dimnames for counts/data/scale.data matrices from being arrays
- Updates
ReadH5AD
to distinguish FVF methods - Fixes to UpdateSeuratObject for v2 objects
- Sink all output from stdout to stderr
- Fix to scale.data cell ordering after subsetting
- Enable
Assay
specification inBuildClusterTree
- Fix
FeaturePlot
when using bothblend
andsplit.by
- Fix to
WhichCells
when passingcells
andinvert
- Fix to
HoverLocator
labels and title - Ensure features names don't contain pipes (
|
) - Deprecation of
RunLSI
andRunALRA
- Fix legend bug when sorting in
ExIPlot
- Flag to skip singleton grouping in
FindClusters
- New custom colors for blended
FeaturePlot
s - New
GetResidual
function - New Seurat/Monocle converters
- Fix issue where certain assays weren't being shown in the
Seurat
object - Fix issue where we weren't updating
DimReduc
object column names - Fix line spacers in
DoHeatmap
- Fix uninformative labels in
FeaturePlot
- Fix unset identities when converting from SCE to Seurat
- Fix single colors being interpreted as palettes in
SingleDimPlot
- Ensure factor levels are always numerically increasing after
FindClusters
- Better cell highlighting colors for
DimPlot
- Fix to
levels<-.Seurat
- Add ability to use counts/scaled data in
BuildClusterTree
- Minor fix to split
ScaleData
- Add global option (Seurat.memsafe) to skip gc() calls
- Restore draw.lines to DoHeatmap, maintain size of color bar with different number of features (#1429)
- Enable split.by parameter for ScaleData
- Add slot parameter to FeaturePlot (#1483)
- Add assay parameter to DotPlot (#1404)
- Fix to color options for VlnPlot with split.by option (#1425)
- Improvements to conversion functions (loom, SCE)
- Fix for cluster tree reordering (#1434)
- Fix PercentageFeatureSet for single feature case
- Fix to fold change calculation and filtering for other slots in FindMarkers (#1454)
- Keep title vectorized in AugmentPlot (#1515)
- Export LogSeuratCommand function
- Fix for FindConservedMarkers when one ident is missing from a group (#1517)
- New method for identifying anchors across single-cell datasets
- Parallelization support via future
- Additional method for demultiplexing with MULTIseqDemux
- Support normalization via sctransform
- New option for clustering with the Leiden algorithm
- Support for reading 10X v3 files
- New function to export Seurat objects for the UCSC cell browser
- Support for data import from Alevin outputs
- Imputation of dropped out values via ALRA
- Significant code restructuring
- Most occurances of "gene(s)" in function names/arguments renamed to "feature(s)"
- Changes to the Seurat object class to facilitate multimodal data
- New BlendPlot implementation
- GetIdent function added to pull identity info
- DiffusionMap dependency replaced with destiny to avoid archival
- Java dependency removed and functionality rewritten in Rcpp
- Speed and efficiency improvements for Rcpp code
- More robust duplicate handling in CellCycleScoring
- New HTOHeatmap function
- Support for custom PNG arguments for vector-friendly plotting
- Fix for 'NA'-labeled cells disappearing with custom color scale
- Replaced FNN with RANN
- Removed unused compiler flags
- Moved several lightly-used packages from 'imports' to 'suggests'
- RenameCells added for easy renaming of all cells
- Read10X_h5 added to read in 10X formatted h5 files
- SetAssayData ensures cell order is the same between assay objects and the Seurat object
- Compatability updates for ggplot2 v2.3.0
- Support for UMAP dimensional reduction technique
- New conversion functions for SingleCellExperiment and anndata
- FetchData preserves cell order
- Require Matrix 1.2-14 or higher
- AddModuleScore no longer densifies sparse-matrices
- Various visualization fixes and improvements
- Default value for latent.vars in FindMarkers/FindAllMarkers changed to NULL.
- Support for HTO demultiplexing
- Utility functions: TransferIdent, CombineIdent, SplitObject, vector.friendly
- C++ implementation for parts of BuildSNN
- Preliminary parallelization support (regression and JackStraw)
- Support for FItSNE
- MetaDE replaced with metap for combining p-values (MetaDE was removed from CRAN)
- NMF heatmaps replaced (NMF to be archived by CRAN)
- MetaDE replaced with metap for combining p-values (MetaDE was removed from CRAN)
- NMF heatmaps replaced (NMF to be archived by CRAN)
- Multiple alignment functionality with RunMultiCCA and AlignSubspace extended to multiple datasets
- CalcAlignmentScore added to evaluate alignment quality
- MetageneBicorPlot added to guide CC selection
- Change cluster order in DoHeatmap with group.order parameter
- Ability to change plotting order and add a title to DimPlot
- do.clean and subset.raw options for SubsetData
- JoyPlot has been replaced with RidgePlot
- FindClusters is now more robust in making temp files
- MetaDE support for combining p-values in DE testing
- Support for using MAST and DESeq2 packages for differential expression testing in FindMarkers
- Support for multi-modal single-cell data via @assay slot
- Default DE test changed to Wilcoxon rank sum test
- Now available on CRAN
- Updated documentation complete with examples
- Example datasets:
pbmc_small
andcc.genes
- C++ implementation for parts of FindVariableGenes
- Minor bug fixes
- New method for aligning scRNA-seq datasets
- Significant code restructuring
- New methods for scoring gene expression and cell-cycle phases
- New visualization features (do.hover, do.identify)