Seurat 5.3.1
Changes
Additions
- Added option to use cluster_leidenfromigraphwhen running Leiden clustering (#9931)
- Added option to use umap2fromuwotwhen
running UMAP (#9918)
- Added option to use approx_powparameter fromuwotwhen running UMAP (#9449)
- Updated LoadXeniumto add support for Xenium protein
data (#10024)
- Added option to specify stroke size in FeaturePlot(#10053)
- Added label.size.cutoffparameter toDimPlotto allow users to label only clusters above a
certain size (#10092)
Fixes
- Fixed deprecated calls to Seurat functions GetAssayDataandPackageCheck(#9924), (#10102)
- Fixed errors in RunAzimuthrelating toFindTransferAnchors(#9924)
- Fixed errors in LeverageScorerelating to handling of
(variable) features (#9924)
- Updated PseudobulkExpressionto acccount for the case
that a category passed togroup.byhas only one value (#10092)
- Updated VlnPlotto use assay passed to the function if
specified (#10092)
- Updated FeatureScatterto allow gene names with
parentheses to be plotted (#10092)
- Updated SingleRasterMapto store object metadata
correctly (#10092)
- Updated FindClustersto order cluster factor levels
correctly when assigning a custom cluster name (#10092)
- Updated FindConservedMarkersto remove NA values (#9917)
- Updated visualization functions to avoid ggplot2
guides,aes_string, andfacet_griddeprecation warnings (#9409, #10116)
- Fixed DimPlotbug where metadata columns named ‘PC_1’,
‘UMAP_1’ etc override reduction embeddings (#10062)
Seurat 5.3.0 (2025-04-23)
Changes
- Fixed PseudobulkExpressionto forward relevant
arguments toNormalizeData(#9840)
- Fixed bugs in FindSpatiallyVariableFeatures; deprecated
theslotparameter in favor oflayer(#9836)
- Extended FindTransferAnchors’sreferenceargument to accept SCT inputs containing more than one SCT model; in
this case, the reference model that was fit against the largest number
of cells is used (#9833)
- Extended FindTransferAnchors’squeryargument to accept multi-layer inputs; updatedMappingScoreto support multi-layer query inputs (#9832)
- Updated LeverageScore.defaultto convertBPCells::IterableMatrixinputs with less than 7500 cells
into a sparse matrix before performing the calculation (#9831)
- Dropped VariableFeaturessetter fromSketchData(#9830)
- Extended Cells.SCTAssay’slayerargument
accept slot names:"counts","data","scale.data"; enabled compatibility withSketchData/LeverageScore(#9830)
- Updated SCTransform.StdAssayto simplify and speed up
the method (#9828)
- Updated AddModuleScoreto support multi-layer inputs
(#9826)
- Fixed PseudobulkExpressionto work withSeuratinputs containing more than one assay (9824)
- Added RunICA.StdAssay(#9825)
- Updated HarmonyIntegrationto callharmony::RunHarmonyin favor of the deprecatedharmony::HarmonyMatrix(#9789)
- Added raster.dpiparameter toVlnPlot(#9665)
- Fixed SpatialDimPlot(..., interactive = TRUE)to
supportSlideSeqandSTARmapinput types;
addedScaleFactors.SlideSeq&ScaleFactors.STARmapgenerics (#9691)
- Fixed PercentageFeatureSetso that theassayparameter is always respected; fixedPercentageFeatureSetto raise a warning if anyfeaturesare absent in the specifiedassayinstead of throwing an error (#9686)
- Fixed GroupCorrelationandGroupCorrelationPlotto be compatible withSeuratObject>= 5.0.0 (#9625)
Seurat 5.2.1 (2025-01-23)
Changes
- Fixed test_find_clusters.Rto accommodate variability
in label assignments given byFindClustersacross different
systems (#9641)
Seurat 5.2.0 (2024-12-20)
Changes
- Added group.byparameter toFindAllMarkers, allowing users to regroup their data using
a non-default identity class prior to performing differential expression
(#9550)
- Added image.typeparameter toRead10X_ImageenablingVisiumV1instances to
be populated instead of instances of the defaultVisiumV2class (#9556)
- Fixed IntegrateLayersto respect thedims.to.integrateparameter
- Added stroke.sizeparameter toDimPlot(#8180)
- Updated RunLeidento use theleidenbasepackage instead ofleiden; deprecated themethodparameter forRunLeidenandFindClusters; updatedRunLeidento resetrandom.seedto 1 if the value is 0 or less (#6792)
- Updated RunPCAto use theBPCells-provided
SVD solver onBPCellsmatrices; updatedJackStrawto supportBPCellsmatrices (#8271)
- Fixed RunPCAto avoid convertingBPCellsmatrices into dense matrices - significantly reduces the function’s
memory usage when running onBPCellsmatrices (#8966)
- Updated RunSLSIto supportBPCellsmatrices
- Fixed DietSeuratso that thelayersparameter is respected (#8197)
- Updated RunUMAPto supportumap-learnversion >= 0.5.0 (#9559)
- Updated LoadXeniumandReadXeniumto
accommodate the output fromXOAv3.0; updatedLoadXeniumto provide more fine-grained control over the
datatypes parsed in, including nucleus segmentation masks, segmentation
methods, and other experimental metadata; updatedReadXeniumto load cell_feature_matrix.h5 when present in
favor of the MEX format files; updatedReadXeniumto load
.parquet files usingarrowinstead of .csv.gz files to
support XOA 3.0 (#8604)
- Fixed LoadXeniumto accommodate datasets without “Blank
Codeword” or “Unassigned Codeword” matrices(#9135)
- Fixed ReadXeniumto properly parse multiple molecular
outputs at once (#8265)
- Added featuresparameter toLeverageScoreandSketchData
- Updated SketchData’sncellsparameter to
accept integer vector
Seurat 5.1.0 (2024-05-08)
Changes
- Updated interactive SpatialDimPlots to display spatial
coordinates
- Updated BuildClusterTreetoPseudobulkExpression(..., method = "aggregate")instead ofAverageExpression
- Fixed SpatialPlotto properly handle images with shared
cells
- Added cluster.nameparameter toBuildNicheAssay
- Added VisiumV2class, inheritsSeuratObject::FOV, returned byLoad10X_Spatial
- Updated Load10X_Spatialto support loading Visium HD
datasets - addedbin.sizeparameter
- Updated Read10X_Coordinatesto handle newtissue_coordinates.parquetfiles
- Added shapeparameter toSpatialPlotand
wrappers:SpatialFeaturePlotandSpatialDimPlot
- Added image.scaleparameter toSpatialPlotand related functions:SpatialFeaturePlot/ISpatialFeaturePlotandSpatialDimPlot/ISpatialDimPlot
- Restored image.nameparameter toRead10X_Image
- Added scaleparameter toRadius.VisiumV1
- Fixed calculation of spot.radiusattribute forVisiumV1instance returned byRead10X_Image—
replacescale.factors$fiducialwithscale.factors$spot
- Added Read10X_CoordinatesandRead10X_ScaleFactors
- Fixed SpatialPlotto properly handle mutli-assaySeuratinstances
Seurat 5.0.3 (2024-03-18)
Changes
- Fixed PercentAboveto discount null values (#8412)
- Added logparameter toFeatureScatter
- Fixed handling of clip.rangeforSCTransformwhenncellsis less than the size
of the passed dataset
Seurat 5.0.2 (2024-02-28)
Changes
- Fixed AverageExpressionto handlefeaturesvector whenlayer="scale.data"andreturn.seurat=TRUE
- Added fc.slotparameter toFindMarkers
- Fixed SCTransformto handlevars.to.regress(#8148) and
(#8349)
- Fixed SCTransformto handle fetching residuals (#8185)
Seurat 5.0.1 (2023-11-16)
Changes
- Fixed SCTransform.StdAssayto 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 PseudobulkExpressionby adding ‘g’ to cell
names that started with numeric values
- Improved PseudobulkExpressionby adding each variable
specified ingroup.byas columns in the object metadata
whenreturn.seurat=TRUE
- Fixed DimPlotandFeatureScatterwhich
were breaking when using thesplit.byargument with a
variable that contained NAs
Seurat 5.0.0 (2023-10-25)
Added
- Add BridgeCellsRepresentationto construct a dictionary
representation for each unimodal dataset.
- Add BuildNicheAssayto 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 CalcDispersionto calculate the dispersion of
features.
- Add CCAIntegrationto perform Seurat-CCA
Integration.
- Add CountSketchto generate a CountSketch random
matrix.
- Add CreateCategoryMatrixto create a one-hot matrix for
a given label.
- Add DISPto find variable features based on
dispersion.
- Add FastRPCAIntegrationas a convenience wrapper
function around the following three functions that are often run
together when performing integration.
- Add FetchResiduals_referenceas a temporary function to
get residuals from the reference.
- Add FetchResidualsto call
sctransform::get_residuals.
- Add FetchResidualSCTModelto calculate Pearson
residuals of features not in the scale.data.
- Add FindBridgeAnchorto find bridge anchors between two
unimodal datasets.
- Add FindBridgeIntegrationAnchorsto find a set of
anchors for integration between unimodal query and the other unimodal
reference using a pre-computed BridgeReferenceSet.
- Add FindBridgeTransferAnchorsto find a set of anchors
for label transfer between unimodal query and the other unimodal
reference using a pre-computed BridgeReferenceSet.
- Add GaussianSketchto perform Gaussian sketching.
- Add HarmonyIntegrationto perform Harmony
integration.
- Add IntegrateLayersto integrate layers in an assay
object.
- Add JointPCAIntegrationto perform Seurat-Joint PCA
Integration.
- Add LeverageScoreto compute the leverage scores for a
given object.
- Add LoadCurioSeekerto load Curio Seeker data.
- Add MVPto find variable features based on
mean.var.plot.
- Add NNtoGraphto convert the Neighbor class to an
asymmetrical Graph class.
- Add PrepareBridgeReferenceto preprocess the multi-omic
bridge and unimodal reference datasets into an extended reference.
- Add ProjectCellEmbeddingsto project query data onto
the reference dimensional reduction.
- Add ProjectDatato project high-dimensional single-cell
RNA expression data from a full dataset onto the lower-dimensional
embedding of the sketch of the dataset.
- Add ProjectDimReducto project query data to reference
dimensional reduction.
- Add ProjectIntegrationto integrate embeddings from the
integrated sketched.assay.
- Add PseudobulkExpressionto normalize the count data
present in a given assay.
- Add Read10X_probe_metadatato read the probe metadata
from a 10x Genomics probe barcode matrix file in HDF5 format.
- Add RPCAIntegrationto perform Seurat-RPCA
Integration.
- Add RunGraphLaplacianto run a graph Laplacian
dimensionality reduction.
- Add SelectIntegrationFeatures5to select integration
features for v5 assays.
- Add SelectSCTIntegrationFeaturesto select SCT
integration features.
- Add SketchDatato use sketching methods to downsample
high-dimensional single-cell RNA expression data for help with
scalability for large datasets.
- Add TransferSketchLabelsto transfer cell type labels
from a sketched dataset to a full dataset based on the similarities in
the lower-dimensional space.
- Add UnSketchEmbeddingsto transfer embeddings from
sketched cells to the full data.
- Add VSTto apply a variance stabilizing transformation
for selection of variable features.
Changes
- Change FindTransferAnchorsso that anchor filtering is
not performed by default
- Change mergeso that layers will be added to a single
Seurat object instead of combining raw count matrices
- Deprecate slotparameter in favor oflayersin accessor and set methods
Seurat 4.4.0 (2023-09-27)
Added
- Add parallelization support with speed improvements for
PrepSCTFindMarkers
- Fix bug in LoadNanostring(#7566)
Changes
- Fix bug in as.Seurat.SingleCellExperiment()(#6692)
- Support for Visium probe information introduced in Spaceranger 2.1
(#7141)
- Add LoadCurioSeekerto load sequencing-based spatial
datasets generated using the Curio Seeker
- Fix fold change calculation for assays (#7095)
- Fix pt.sizebug when rasterization is set to true (#7379)
- Fix FoldChangeandFindMarkersto 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
Seurat 4.3.0 (2022-11-18)
Added
- Add support for imaging-based spatial datasets
Changes
- Fix bug in FindMarkers()when run post
Integration/Transfer (#6856)
Seurat 4.2.1 (2022-11-08)
Changes
- Replaced import from spatstat.corewithspatstat.explore
- Fix bug in FindMarkers()when usingSCTassay (#6856)
Seurat 4.2.0 (2022-09-21)
Changes
- 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.noiseparameter inVlnPlot()(#5756)
- Fix uwot model backwards compatibility (#6345)
- Allow pseudocount.usein differential expression
functions to be set at theAssaylevel
Seurat 4.1.1 (2022-05-01)
Changes
- Fix giveCsparserelated warnings inRead10X_h5
- Fix ident labeling for SpatialPlot(#5774)
- Fix ReadMtxon Windows (#5687)
- Fix VlnPlotto switch on rasterization only when
required (#5846)
- Fix ncolbehavior inSpatialPlot(#5774)
- Set jitterto FALSE inFeatureScatter(#5876)
- Update Cellsmethods to new signature
(x, ...)
- Replace use of default.stringsAsFactors()withgetOption("stringsAsFactors")
Seurat 4.1.0 (2022-01-14)
Added
- Add raster.dpiparameter toDimPlot/FeaturePlotto optionally rasterize individual
points (#5392)
- Add support for sctransform v2, differential expression with SCT
assay
Changes
- Update ReadParseBioto support split-pipe 0.9.6p (#5446)
- Fixes for MAST differential expression (#5441)
- Fix scaling options when using split.byinFeaturePlot()(#5243)
Seurat 4.0.6 (2021-12-16)
Added
Changes
- Add rasterparameter toVlnPlotto
optionally rasterize individual points (#5076)
- Add min.cells.groupparameter toFindConservedMarkers(#5079)
- Set do.centerto FALSE forlsiprojectinFindTransferAnchors
- Fix error message in ReadMtx()(#5158)
- Add label.colorparameter toFeaturePlot(#5314)
- Fix issues in ProjectUMAP(#5257, #5104, #5373)
Seurat 4.0.5 (2021-10-04)
Changes
- Update documentation for to.upperparameter 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-learnmethod (#5194)
Seurat 4.0.4 (2021-08-19)
Added
- Add reductionparameter toBuildClusterTree()(#4598)
- Add DensMAP option to RunUMAP()(#4630)
- Add imageparameter toLoad10X_Spatial()andimage.nameparameter toRead10X_Image()(#4641)
- Add ReadSTARsolo()function to read output from
STARsolo
- Add densifyparameter toFindMarkers()
- Add ReadParsebio()function to read output from Parse
Biosciences
- Add the image.alphaparameter toSpatialDimPlot()andSpatialFeaturePlot()
- Add support for the correlation metric in RunUMAP(#4972)
Changes
- 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()
Seurat 4.0.3 (2021-06-10)
Added
- Add jitterparameter toFeatureScatter()
Changes
- 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.typesparameter inGeneSymbolThesarus()(#4545)
- Transfer scale.dataslot as well when converting withas.SingleCellExperiment.Seurat()
- Enable alphaparameter forSpatialDimPlot()
- Fix as.SingleCellExperiment.Seurat()conversion for
atypicalreducedDimcomponents
Seurat 4.0.2 (2020-05-20)
Added
- New AddAzimuthScores()andAddAzimuthResults()functions
- Add shuffleparameter toFeatureScatter()(#4280)
- Add lsiprojectandrpcaoptions forFindTransferAnchors()
- Add rlsioption forFindIntegrationAnchors()
## Changes
- Preserve feature metadata when converting from
SingleCellExperimenttoSeuratObjectclass (#4205)
- Preserve multiple assays when converting from
SingleCellExperimenttoSeuratObjectclass (#3764)
- Fix passing of score.threshparameter inScoreJackStraw()(#4268)
- Fix FC calculation in FindMarkers()non-log transformed
data.
- Add umap-learn version >= 0.5.0 compatibility for
RunUMAP()
- Fix DotPlotto uselog1pwhenscale=False(#4298)
- Fix split and shuffled DimPlot
- Disallow NULL or another length 0 vector for ident.1inFindMarkers()
- 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.nameparameter inFindMarkers()(#4474)
- Deprecate group.byparameter inPlotPerturbScore()in favor ofmixscape.class.
Seurat 4.0.1 (2020-03-17)
Added
- Add direction option to PlotClusterTree()
- Add colsparameter toJackStrawPlot()
- Add ReadMtx()to read local and remote mtx files with
associated cell and feature name files
Changes
- 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=TRUEinSingleDimPlot(),
print NA points under all others.
- Remove default parameter value for data.dirinRead10X()
- Import spatstat fxns from subpackages (spatstat.core,
spatstat.geom)
- RunUMAPnow checks for graph/neighbor consistency
Seurat 4.0.0 (2020-01-27)
Added
- Expose FoldChange()component inFindMarkers().
- Add the merge.DimReducmethod
- Add IntegrateEmbeddings()to correct embeddings ofDimReducs
- Add ProjectUMAP()to project query cells into a
reference UMAP space
- Add MapQuery()as a wrapper aroundIntegrateData(),IntegrateEmbeddings(), andProjectUMAP()
- Add MappingScoreto 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()
Changes
- Default neighbor finding algorithm changed from “rann” to
“annoy”
- Default ncellsparameter inSCTransform()changed to 5000
- Default fold change in FindMarkers()changed from ln to
log2
- Implementation improvements to AverageExpression()
- AnchorSetclass re-implemented as a virtual class from
which- IntegrationAnchorSetand- TransferAnchorSetnow 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.quosureusage withas_labeldue 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 formalized- Assaysubclass- SCTAssay()
- When using normalization.method='SCT'inFindTransferAnchors(), normalize query using reference SCT
model when possible.
- Change default Neighbor name in FindNeighborstoAssay.nn
Removed
- CreateGeneActivityMatrixreplaced by- Signac::GeneActivity()
- RunLSIreplaced by by- Signac::RunTFIDF()and- Signac::RunSVD()
- ReadAlevinand- ReadAlevinCsvmoved to
SeuratWrappers
- ExportToCellbrowserand- StopCellbrowsermoved to SeuratWrappers
Seurat 3.2.3 - 2020-12-14
Added
- Titles added to DimPlotwhen specifyinggroup.byparameter
- keep.scaleparameter added to- FeaturePlotto control scaling across multiple features and/or splits.
Changes
- Samedeprecated in favor of- base::identity
- Fix in DietSeuratto work with specializedAssayobjects
- Fix p-value return when using the apeimplementation of
Moran’s I
- Fix bug in FindMarkers when using MAST with a latent variable
- Updates to Key<-.DimReducthat allow handling of
empty reduction column names
- Allow setting ctrlinCellCycleScoring
- 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
SetHighlightin plots
- Small change in CellRanger version detection logic of h5 file to
improve robustness to outside tools.
- do.cppdeprecated and will default to true
Seurat 3.2.2 (2020-09-25)
Changes
- Set the seed in WhichCellsregardless of whether or notidentsis 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
Seurat 3.2.1 (2020-09-04)
Added
- Added support for nearest neighbor input and
return.modelparameter inRunUMAP()
- Enable named color vectors in DoHeatmap()
- Add label.colorandlabel.boxparameters
toDimPlot
- Added shuffleandseedparameters toDimPlot()to help with overplotting
- Added new stacked violin plot functionality
Changes
- Allow setting slotparameter inRunUMAP
- Added support for FIt-SNE v1.2+
- Fix for Spatial*Plotwhen running with
interactive=TRUE
- Set max for number of items returned by Topand 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
Deprecated
- CreateActivityMatrixdeprecated in favor of- Signac::GeneActivity
- ReadAlevinand- ReadAlevinCsvdeprecated in
favor of- SeuratWrappers::ReadAlevin
- ExportToCellbrowserand- StopCellbrowserdeprecated in favor of- SeuratWrappers::ExportToCellbrowserand- SeuratWrappers::StopCellbrowser
- ReadH5ADand- WriteH5ADdeprecated in favor
of h5Seurat/H5AD functionality found in SeuratDisk
- as.loomand- as.Seurat.loomdeprecated in
favor of functionality found in SeuratDisk
Seurat 3.2.0 (2020-07-15)
Added
- 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).
Changes
- Removed add.iterparameter fromRunTSNEfunction
- Fixed integer overflow error in the WilcoxDETest function
- Minor visual fixes in DoHeatmapgroup 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 CellSelectorto use Shiny gadgets instead of
SDMTools
- Mark PointLocatoras defunct
- Remove SDMTools
- Fixed data slot return in AverageExpressionwhen
subsetting features and returning a Seurat object
Seurat 3.1.5 (2020-04-14)
Added
- New scaleparameter inDotPlot
- New keep.sparse parameter inCreateGeneActivityMatrix`
for a more memory efficient option
- Added ability to store model learned by UMAP and project new
data
- New strip.suffixoption inRead10X.
This changes the default behavior ofRead10X. A trailing-1present in all
cell names will not be removed by default.
- Added group.byparameter toFeatureScatter
Changes
- Replace wilcox.test with limma implementation for a faster
FindMarkers default method
- Better point separation for VlnPlots when using thesplit.byoption
- Efficiency improvements for anchor pairing
- Deprecate redundant sort.cellparameter 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 subsetandWhichCells
- Default split violin option is now a multi group option
- Preserve alpha in FeaturePlotwhen usingblend
- Update assay.usedslot forDimReducs when
Assay is renamed
Seurat 3.1.4 (2020-02-20)
Changes
- Fixes to DoHeatmapto remain compatible with ggplot2
v3.3
- Adoption of patchworkframework to replaceCombinePlots
Seurat 3.1.3 (2020-02-07)
Added
- New system agnostic Whichfunction to address problems
with FItSNE on Windows
Changes
- Export CellsByIdentitiesandRowMergeSparseMatricesfunctions
- 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
Seurat 3.1.2 (2019-12-11)
Added
- New silent slot updater
- New random seed options to RunCCA,RunTSNE,WhichCells,HTODemux,AddModuleScore,VlnPlot, andRidgePlot
- Enhancements for dealing with Assay-derived
objects
Changed
- Only run CalcN(generates nFeatures and nCounts) whencountschanges
- Fix issue regarding colons in feature names
- Change object class testing to use inheritsoris.*for R 4.0 compatability
Seurat 3.1.1 (2019-09-20)
Added
- New RegroupIdentsfunction to reassign idents based on
metadata column majority
- UpdateSymbolListfunction to pull new gene names from
HGNC
- Added support for H5AD layers as additional assays in a
Seuratobject
Changed
- Fix rownames issue when running UMAP on dist object
- Add support for new H5AD obsmandvarmstucture
- 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
Seurat 3.1.0 (2019-08-20)
Added
- New PrepSCTIntegrationfunction to facilitate
integration afterSCTransform
- Reference-based integration with the referenceparameter inFindIntegrationAnchors
- Reciprocal PCA as a reductionoption inFindIntegrationAnchors
- New CollapseEmbeddingOutliersfunction
- Enable FindTransferAnchorsafterSCTransform
- Added back ColorDimSplitfunctionality
- Include a code of conduct
- Added uwot support as new default UMAP method
- Added CheckDotsto catch unused parameters and suggest
updated names
- Reductionsand- Assaysassays functions to
list stored DimReducs and Assays
Changed
- Fix regex in LogSeuratCommand
- Check for NAs in feature names in Read10X
- Prevent dimnames for counts/data/scale.data matrices from being
arrays
- Updates ReadH5ADto 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 Assayspecification inBuildClusterTree
- Fix FeaturePlotwhen using bothblendandsplit.by
- Fix to WhichCellswhen passingcellsandinvert
- Fix to HoverLocatorlabels and title
- Ensure features names don’t contain pipes (|)
- Deprecation of RunLSIandRunALRA
- Fix legend bug when sorting in ExIPlot
Seurat 3.0.2 (2019-06-07)
Added
- Flag to skip singleton grouping in FindClusters
- New custom colors for blended FeaturePlots
- New GetResidualfunction
- New Seurat/Monocle converters
Changed
- Fix issue where certain assays weren’t being shown in the
Seuratobject
- Fix issue where we weren’t updating DimReducobject
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
Seurat 3.0.1 (2019-05-16)
Added
- 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)
Changed
- 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)
Seurat 3.0.0 (2019-04-16)
Added
- 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
Changed
- 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
Seurat 2.3.4 (2018-07-13)
Added
- GetIdent function added to pull identity info
Changed
- 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
Seurat 2.3.3 (2018-07-02)
Added
- New HTOHeatmap function
- Support for custom PNG arguments for vector-friendly plotting
- Fix for ‘NA’-labeled cells disappearing with custom color scale
Changed
- Replaced FNN with RANN
- Removed unused compiler flags
- Moved several lightly-used packages from ‘imports’ to
‘suggests’
Seurat 2.3.2 (2018-06-11)
Added
- 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
Seurat 2.3.1 (2018-05-03)
Added
- Support for UMAP
dimensional reduction technique
- New conversion functions for SingleCellExperiment and anndata
Changed
- 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.
Seurat 2.3.0 (2018-03-22)
Added
- 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
Changed
- MetaDE replaced with metap for combining p-values (MetaDE was
removed from CRAN)
- NMF heatmaps replaced (NMF to be archived by CRAN)
Seurat 2.2.1 (2018-02-14)
Changed
- MetaDE replaced with metap for combining p-values (MetaDE was
removed from CRAN)
- NMF heatmaps replaced (NMF to be archived by CRAN)
Seurat 2.2.0 (2018-01-10)
Added
- 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
Changed
- JoyPlot has been replaced with RidgePlot
- FindClusters is now more robust in making temp files
- MetaDE support for combining p-values in DE testing
Seurat 2.1.0 (2017-10-12)
Added
- Support for using MAST and DESeq2 packages for differential
expression testing in FindMarkers
- Support for multi-modal single-cell data via @assay slot
Changed
- Default DE test changed to Wilcoxon rank sum test
Seurat 2.0.1 (2017-08-18)
Added
- Now available on CRAN
- Updated documentation complete with examples
- Example datasets: pbmc_smallandcc.genes
- C++ implementation for parts of FindVariableGenes
- Minor bug fixes
Seurat 2.0.0 (2017-07-26)
Added
- 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)