Learn R Programming

⚠️There's a newer version (5.0.3) of this package.Take me there.

Seurat v3.1.0

Seurat is an R toolkit for single cell genomics, developed and maintained by the Satija Lab at NYGC.

Instructions, documentation, and tutorials can be found at:

Seurat is also hosted on GitHub, you can view and clone the repository at

Seurat has been successfully installed on Mac OS X, Linux, and Windows, using the devtools package to install directly from GitHub

Improvements and new features will be added on a regular basis, please contact seuratpackage@gmail.com with any questions or if you would like to contribute

Version History

August 20, 2019

  • Version 3.1
  • Changes:
    • Support for SCTransform integration workflows
    • Integration speed ups: reference-based integration + reciprocal PCA

April 12, 2019

  • Version 3.0
  • Changes:
    • Preprint published describing new methods for identifying anchors across single-cell datasets
    • Restructured Seurat object with native support for multimodal data
    • Parallelization support via future

July 20, 2018

  • Version 2.4
  • Changes:
    • Java dependency removed and functionality rewritten in Rcpp

March 22, 2018

  • Version 2.3
  • Changes:
    • New utility functions
    • Speed and efficiency improvments

January 10, 2018

  • Version 2.2
  • Changes:
    • Support for multiple-dataset alignment with RunMultiCCA and AlignSubspace
    • New methods for evaluating alignment performance

October 12, 2017

  • Version 2.1
  • Changes:
    • Support for using MAST and DESeq2 packages for differential expression testing in FindMarkers
    • Support for multi-modal single-cell data via @assay slot

July 26, 2017

  • Version 2.0
  • Changes:
    • Preprint released for integrated analysis of scRNA-seq across conditions, technologies and species
    • Significant restructuring of code to support clarity and dataset exploration
    • Methods for scoring gene expression and cell-cycle phase

October 4, 2016

  • Version 1.4 released
  • Changes:
    • Improved tools for cluster evaluation/visualizations
    • Methods for combining and adding to datasets

August 22, 2016:

  • Version 1.3 released
  • Changes :
    • Improved clustering approach - see FAQ for details
    • All functions support sparse matrices
    • Methods for removing unwanted sources of variation
    • Consistent function names
    • Updated visualizations

May 21, 2015:

  • Drop-Seq manuscript published. Version 1.2 released
  • Changes :
    • Added support for spectral t-SNE and density clustering
    • New visualizations - including pcHeatmap, dot.plot, and feature.plot
    • Expanded package documentation, reduced import package burden
    • Seurat code is now hosted on GitHub, enables easy install through devtools
    • Small bug fixes

April 13, 2015:

  • Spatial mapping manuscript published. Version 1.1 released (initial release)

Copy Link

Version

Install

install.packages('Seurat')

Monthly Downloads

46,322

Version

3.1.0

License

GPL-3 | file LICENSE

Issues

Pull Requests

Stars

Forks

Maintainer

Last Published

May 10th, 2024

Functions in Seurat (3.1.0)

CollapseEmbeddingOutliers

Move outliers towards center on dimension reduction plot
CellScatter

Cell-cell scatter plot
CellCycleScoring

Score cell cycle phases
CellSelector

Cell selector
CustomDistance

Run a custom distance function on an input data matrix
CreateSeuratObject

Create a Seurat object
Cells

Get cells present in an object
BlackAndWhite

Create a custom color palette
DefaultAssay

Get and set the default assay
CollapseSpeciesExpressionMatrix

Slim down a multi-species expression matrix, when only one species is primarily of interenst.
Command

Get SeuratCommands
DoHeatmap

Feature expression heatmap
DotPlot

Dot plot visualization
Assays

Pull Assays or assay names
CombinePlots

Combine ggplot2-based plots into a single plot
CreateGeneActivityMatrix

Convert a peak matrix to a gene activity matrix
ColorDimSplit

Color dimensional reduction plot by tree split
CreateDimReducObject

Create a DimReduc object
Embeddings

Get cell embeddings
ElbowPlot

Quickly Pick Relevant Dimensions
CreateAssayObject

Create an Assay object
ExpMean

Calculate the mean of logged values
ExpVar

Calculate the variance of logged values
ExportToCellbrowser

Export Seurat object for UCSC cell browser
DimReduc-class

The Dimmensional Reduction Class
CalculateBarcodeInflections

Calculate the Barcode Distribution Inflection
DimPlot

Dimensional reduction plot
FetchData

Access cellular data
HVFInfo

Get highly variable feature information
ExpSD

Calculate the standard deviation of logged values
FindClusters

Cluster Determination
FindConservedMarkers

Finds markers that are conserved between the groups
FeaturePlot

Visualize 'features' on a dimensional reduction plot
HoverLocator

Hover Locator
FindNeighbors

SNN Graph Construction
MULTIseqDemux

Demultiplex samples based on classification method from MULTI-seq (McGinnis et al., bioRxiv 2018)
LogVMR

Calculate the variance to mean ratio of logged values
FindVariableFeatures

Find variable features
IntegrationData-class

The IntegrationData Class
GetAssay

Get an Assay object from a given Seurat object.
JS

Get JackStraw information
CaseMatch

Match the case of character vectors
DietSeurat

Slim down a Seurat object
DimHeatmap

Dimensional reduction heatmap
FeatureScatter

Scatter plot of single cell data
FindTransferAnchors

Find transfer anchors
JackStrawPlot

JackStraw Plot
NormalizeData

Normalize Data
Loadings

Get feature loadings
RunLSI

Run Latent Semantic Indexing on binary count matrix
PolyFeaturePlot

Polygon FeaturePlot
MixingMetric

Calculates a mixing metric
RunICA

Run Independent Component Analysis on gene expression
PrepSCTIntegration

Prepare an object list that has been run through SCTransform for integration
LocalStruct

Calculate the local structure preservation metric
FindIntegrationAnchors

Find integration anchors
Key

Get a key
FindMarkers

Gene expression markers of identity classes
HTOHeatmap

Hashtag oligo heatmap
Idents

Get, set, and manipulate an object's identity classes
HTODemux

Demultiplex samples based on data from cell 'hashing'
FindAllMarkers

Gene expression markers for all identity classes
ScoreJackStraw

Compute Jackstraw scores significance.
PlotClusterTree

Plot clusters as a tree
Graph-class

The Graph Class
JackStraw

Determine statistical significance of PCA scores.
GetResidual

Calculate pearson residuals of features not in the scale.data
ReadAlevin

Load in data from Alevin pipeline
GetAssayData

General accessor function for the Assay class
ProjectDim

Project Dimensional reduction onto full dataset
PCASigGenes

Significant genes from a PCA
RunUMAP

Run UMAP
JackStrawData-class

The JackStrawData Class
Project

Get and set project information
LabelPoints

Add text labels to a ggplot2 plot
OldWhichCells

Identify cells matching certain criteria
LabelClusters

Label clusters on a ggplot2-based scatter plot
IntegrateData

Integrate data
ReadAlevinCsv

Load in data from Alevin pipeline
GetIntegrationData

Get integation data
LogSeuratCommand

Log a command
Misc

Access miscellaneous data
L2CCA

L2-Normalize CCA
L2Dim

L2-normalization
LogNormalize

Normalize raw data
MinMax

Apply a ceiling and floor to all values in a matrix
SeuratCommand-class

The SeuratCommand Class
SelectIntegrationFeatures

Select integration features
PolyDimPlot

Polygon DimPlot
RidgePlot

Single cell ridge plot
PercentageFeatureSet

Calculate the percentage of all counts that belong to a given set of features
MetaFeature

Aggregate expression of multiple features into a single feature
RelativeCounts

Normalize raw data to fractions
RenameCells

Rename cells
PairwiseIntegrateReference

Pairwise dataset integration
SetAssayData

Setter for multimodal data
Reductions

Pull DimReducs or DimReduc names
MapQuery

Map queries to reference
RunALRA

Run Adaptively-thresholded Low Rank Approximation (ALRA)
StopCellbrowser

Stop Cellbrowser web server
SubsetByBarcodeInflections

Subset a Seurat Object based on the Barcode Distribution Inflection Points
ScaleData

Scale and center the data.
SampleUMI

Sample UMI
RunCCA

Perform Canonical Correlation Analysis
Stdev

Get the standard deviations for an object
SplitObject

Splits object into a list of subsetted objects.
SetIntegrationData

Set integation data
Tool

Get and set additional tool data
Read10X

Load in data from 10X
SeuratTheme

Seurat Themes
SCTransform

Use regularized negative binomial regression to normalize UMI count data
TopCells

Find cells with highest scores for a given dimensional reduction technique
TopFeatures

Find features with highest scores for a given dimensional reduction technique
RunPCA

Run Principal Component Analysis
Seurat-class

The Seurat Class
Read10X_h5

Read 10X hdf5 file
Seurat-package

Tools for single-cell genomics
RunTSNE

Run t-distributed Stochastic Neighbor Embedding
as.SingleCellExperiment

Convert objects to SingleCellExperiment objects
as.Seurat

Convert objects to Seurat objects
print.DimReduc

Print the results of a dimensional reduction analysis
VlnPlot

Single cell violin plot
SubsetData

Return a subset of the Seurat object
[.Seurat

Subset a Seurat object
UpdateSeuratObject

Update old Seurat object to accomodate new features
VariableFeaturePlot

View variable features
TransferData

Transfer Labels
as.list.SeuratCommand

Coerce a SeuratCommand to a list
VariableFeatures

Get and set variable feature information
TF.IDF

Term frequency-inverse document frequency
VizDimLoadings

Visualize Dimensional Reduction genes
seurat-class

The Seurat Class
WhichCells

Identify cells matching certain criteria
ReadH5AD

Read from and write to h5ad files
as.loom

Convert objects to loom objects
pbmc_small

A small example version of the PBMC dataset
as.CellDataSet

Convert objects to CellDataSet objects
as.Graph

Convert a matrix (or Matrix) to the Graph class.
as.sparse

Convert between data frames and sparse matrices
cc.genes

Cell cycle genes
merge.Assay

Merge Seurat Objects
Assay-class

The Assay Class
BarcodeInflectionsPlot

Plot the Barcode Distribution and Calculated Inflection Points
AddModuleScore

Calculate module scores for feature expression programs in single cells
AnchorSet-class

The AnchorSet Class
ALRAChooseKPlot

ALRA Approximate Rank Selection Plot
BuildClusterTree

Phylogenetic Analysis of Identity Classes
AugmentPlot

Augments ggplot2-based plot with a PNG image.
AverageExpression

Averaged feature expression by identity class
AddMetaData

Add in metadata associated with either cells or features.