Learn R Programming

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

Seurat v3.0.1

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

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

49,115

Version

3.0.1

License

GPL-3 | file LICENSE

Issues

Pull Requests

Stars

Forks

Maintainer

Last Published

May 10th, 2024

Functions in Seurat (3.0.1)

CombinePlots

Combine ggplot2-based plots into a single plot
CaseMatch

Match the case of character vectors
CreateSeuratObject

Create a Seurat object
Embeddings

Get cell embeddings
CollapseSpeciesExpressionMatrix

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

Get cells present in an object
ExpMean

Calculate the mean of logged values
FindTransferAnchors

Find transfer anchors
CreateGeneActivityMatrix

Convert a peak matrix to a gene activity matrix
FindVariableFeatures

Find variable features
CellCycleScoring

Score cell cycle phases
ExportToCellbrowser

Export Seurat object for UCSC cell browser
FeaturePlot

Visualize 'features' on a dimensional reduction plot
Command

Get SeuratCommands
DimHeatmap

Dimensional reduction heatmap
DotPlot

Dot plot visualization
AugmentPlot

Augments ggplot2-based plot with a PNG image.
DimPlot

Dimensional reduction plot
ElbowPlot

Quickly Pick Relevant Dimensions
DimReduc-class

The Dimmensional Reduction Class
ALRAChooseKPlot

ALRA Approximate Rank Selection Plot
DoHeatmap

Feature expression heatmap
FindClusters

Cluster Determination
FindAllMarkers

Gene expression markers for all identity classes
DefaultAssay

Get and set the default assay
DietSeurat

Slim down a Seurat object
AddMetaData

Add in metadata associated with either cells or features.
CreateAssayObject

Create an Assay object
ExpSD

Calculate the standard deviation of logged values
ExpVar

Calculate the variance of logged values
GetIntegrationData

Get integation data
HVFInfo

Get highly variable feature information
HTODemux

Demultiplex samples based on data from cell 'hashing'
HTOHeatmap

Hashtag oligo heatmap
FindNeighbors

SNN Graph Construction
L2CCA

L2-Normalize CCA
JackStrawData-class

The JackStrawData Class
JackStraw

Determine statistical significance of PCA scores.
HoverLocator

Hover Locator
FindMarkers

Gene expression markers of identity classes
LogNormalize

Normalize raw data
L2Dim

L2-normalization
NormalizeData

Normalize Data
OldWhichCells

Identify cells matching certain criteria
FindIntegrationAnchors

Find integration anchors
IntegrationData-class

The IntegrationData Class
FindConservedMarkers

Finds markers that are conserved between the groups
CreateDimReducObject

Create a DimReduc object
Graph-class

The Graph Class
LogSeuratCommand

Log a command
PolyFeaturePlot

Polygon FeaturePlot
PlotClusterTree

Plot clusters as a tree
PolyDimPlot

Polygon DimPlot
ReadAlevinCsv

Load in data from Alevin pipeline
RelativeCounts

Normalize raw data to fractions
Project

Get and set project information
JS

Get JackStraw information
JackStrawPlot

JackStraw Plot
SplitObject

Splits object into a list of subsetted objects.
Stdev

Get the standard deviations for an object
RunALRA

Run Adaptively-thresholded Low Rank Approximation (ALRA)
Key

Get a key
MetaFeature

Aggregate expression of multiple features into a single feature
VlnPlot

Single cell violin plot
RunCCA

Perform Canonical Correlation Analysis
Loadings

Get feature loadings
MinMax

Apply a ceiling and floor to all values in a matrix
LocalStruct

Calculate the local structure preservation metric
GetAssayData

General accessor function for the Assay class
CustomDistance

Run a custom distance function on an input data matrix
GetAssay

Get an Assay object from a given Seurat object.
RunPCA

Run Principal Component Analysis
BlackAndWhite

Create a custom color palette
FeatureScatter

Scatter plot of single cell data
LogVMR

Calculate the variance to mean ratio of logged values
Idents

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

Compute Jackstraw scores significance.
as.Graph

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

Select integration features
MULTIseqDemux

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

Integrate data
FetchData

Access cellular data
PCASigGenes

Significant genes from a PCA
RunTSNE

Run t-distributed Stochastic Neighbor Embedding
LabelClusters

Label clusters on a ggplot2-based scatter plot
LabelPoints

Add text labels to a ggplot2 plot
Misc

Access miscellaneous data
RunICA

Run Independent Component Analysis on gene expression
PercentageFeatureSet

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

Setter for multimodal data
as.Seurat

Convert objects to Seurat objects
WhichCells

Identify cells matching certain criteria
RunLSI

Run Latent Semantic Indexing on binary count matrix
MixingMetric

Calculates a mixing metric
as.SingleCellExperiment

Convert objects to SingleCellExperiment objects
ProjectDim

Project Dimensional reduction onto full dataset
Read10X

Load in data from 10X
RenameCells

Rename cells
SetIntegrationData

Set integation data
RidgePlot

Single cell ridge plot
Read10X_h5

Read 10X hdf5 file
as.loom

Convert objects to loom objects
ReadAlevin

Load in data from Alevin pipeline
Tool

Get and set additional tool data
Seurat-class

The Seurat Class
TopCells

Find cells with highest scores for a given dimensional reduction technique
Seurat-package

Tools for single-cell genomics
SubsetData

Return a subset of the Seurat object
TF.IDF

Term frequency-inverse document frequency
RunUMAP

Run UMAP
TopFeatures

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

Use regularized negative binomial regression to normalize UMI count data
SeuratCommand-class

The SeuratCommand Class
TransferData

Transfer Labels
as.sparse

Convert between data frames and sparse matrices
SeuratTheme

Seurat Themes
seurat-class

The Seurat Class
UpdateSeuratObject

Update old Seurat object to accomodate new features
pbmc_small

A small example version of the PBMC dataset
cc.genes

Cell cycle genes
VariableFeaturePlot

View variable features
print.DimReduc

Print the results of a dimensional reduction analysis
SampleUMI

Sample UMI
[.Seurat

Subset a Seurat object
ScaleData

Scale and center the data.
StopCellbrowser

Stop Cellbrowser web server
SubsetByBarcodeInflections

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

Get and set variable feature information
VizDimLoadings

Visualize Dimensional Reduction genes
ReadH5AD

Read from and write to h5ad files
merge.Assay

Merge Seurat Objects
Assay-class

The Assay Class
CellScatter

Cell-cell scatter plot
CellSelector

Cell selector
AddModuleScore

Calculate module scores for feature expression programs in single cells
BuildClusterTree

Phylogenetic Analysis of Identity Classes
CalculateBarcodeInflections

Calculate the Barcode Distribution Inflection
AnchorSet-class

The AnchorSet Class
AverageExpression

Averaged feature expression by identity class
BarcodeInflectionsPlot

Plot the Barcode Distribution and Calculated Inflection Points