Learn R Programming

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

Seurat v3.1.3

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

58,682

Version

3.1.3

License

GPL-3 | file LICENSE

Issues

Pull Requests

Stars

Forks

Maintainer

Paul Hoffman

Last Published

February 11th, 2020

Functions in Seurat (3.1.3)

CellsByIdentities

Get cell names grouped by identity class
CellSelector

Cell selector
CreateAssayObject

Create an Assay object
CreateDimReducObject

Create a DimReduc object
CollapseSpeciesExpressionMatrix

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

Discrete colour palettes from the pals package
ColorDimSplit

Color dimensional reduction plot by tree split
CollapseEmbeddingOutliers

Move outliers towards center on dimension reduction plot
DefaultAssay

Get and set the default assay
DimReduc-class

The Dimmensional Reduction Class
Cells

Get cells present in an object
CalculateBarcodeInflections

Calculate the Barcode Distribution Inflection
GetAssayData

General accessor function for the Assay class
LocalStruct

Calculate the local structure preservation metric
FindIntegrationAnchors

Find integration anchors
GetIntegrationData

Get integation data
FindAllMarkers

Gene expression markers for all identity classes
FetchData

Access cellular data
IntegrationData-class

The IntegrationData Class
FindConservedMarkers

Finds markers that are conserved between the groups
Assays

Pull Assays or assay names
DietSeurat

Slim down a Seurat object
CellCycleScoring

Score cell cycle phases
CaseMatch

Match the case of character vectors
CellScatter

Cell-cell scatter plot
CreateGeneActivityMatrix

Convert a peak matrix to a gene activity matrix
CombinePlots

Combine ggplot2-based plots into a single plot
LogNormalize

Normalize raw data
PlotClusterTree

Plot clusters as a tree
DoHeatmap

Feature expression heatmap
Command

Get SeuratCommands
PercentageFeatureSet

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

Is an object global/persistent?
FindVariableFeatures

Find variable features
DimHeatmap

Dimensional reduction heatmap
LogSeuratCommand

Log a command
RenameAssays

Rename assays in a Seurat object
DimPlot

Dimensional reduction plot
ElbowPlot

Quickly Pick Relevant Dimensions
Embeddings

Get cell embeddings
CreateSeuratObject

Create a Seurat object
FindMarkers

Gene expression markers of identity classes
ProjectDim

Project Dimensional reduction onto full dataset
Read10X

Load in data from 10X
RenameCells

Rename cells
SetAssayData

Setter for multimodal data
SetIntegrationData

Set integation data
TopCells

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

Dot plot visualization
FeatureScatter

Scatter plot of single cell data
GetAssay

Get an Assay object from a given Seurat object.
Key

Get a key
FeaturePlot

Visualize 'features' on a dimensional reduction plot
L2CCA

L2-Normalize CCA
CustomDistance

Run a custom distance function on an input data matrix
L2Dim

L2-normalization
ExpMean

Calculate the mean of logged values
BlackAndWhite

Create a custom color palette
ExpSD

Calculate the standard deviation of logged values
GetResidual

Calculate pearson residuals of features not in the scale.data
JackStrawData-class

The JackStrawData Class
ExpVar

Calculate the variance of logged values
Seurat-class

The Seurat Class
ExportToCellbrowser

Export Seurat object for UCSC cell browser
Seurat-package

Tools for single-cell genomics
VlnPlot

Single cell violin plot
JackStrawPlot

JackStraw Plot
as.loom

Convert objects to loom objects
OldWhichCells

Identify cells matching certain criteria
Idents

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

Polygon DimPlot
Graph-class

The Graph Class
as.CellDataSet

Convert objects to CellDataSet objects
Tool

Get and set additional tool data
WhichCells

Identify cells matching certain criteria
FindClusters

Cluster Determination
FindNeighbors

SNN Graph Construction
HVFInfo

Get highly variable feature information
TopFeatures

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

Find transfer anchors
RunICA

Run Independent Component Analysis on gene expression
SelectIntegrationFeatures

Select integration features
PCASigGenes

Significant genes from a PCA
HTODemux

Demultiplex samples based on data from cell 'hashing'
LabelPoints

Add text labels to a ggplot2 plot
RegroupIdents

Regroup idents based on meta.data info
SCTransform

Use regularized negative binomial regression to normalize UMI count data
NormalizeData

Normalize Data
LogVMR

Calculate the variance to mean ratio of logged values
HTOHeatmap

Hashtag oligo heatmap
RunLSI

Run Latent Semantic Indexing on binary count matrix
LabelClusters

Label clusters on a ggplot2-based scatter plot
HoverLocator

Hover Locator
MixingMetric

Calculates a mixing metric
RunUMAP

Run UMAP
Read10X_h5

Read 10X hdf5 file
SplitObject

Splits object into a list of subsetted objects.
PolyFeaturePlot

Polygon FeaturePlot
SampleUMI

Sample UMI
Stdev

Get the standard deviations for an object
ScoreJackStraw

Compute Jackstraw scores significance.
as.sparse

Convert between data frames and sparse matrices
RelativeCounts

Normalize raw data to fractions
VizDimLoadings

Visualize Dimensional Reduction genes
ReadAlevin

Load in data from Alevin pipeline
cc.genes

Cell cycle genes
TF.IDF

Term frequency-inverse document frequency
SubsetData

Return a subset of the Seurat object
JS

Get JackStraw information
MinMax

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

Determine statistical significance of PCA scores.
ReadAlevinCsv

Load in data from Alevin pipeline
MULTIseqDemux

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

Convert objects to SingleCellExperiment objects
MetaFeature

Aggregate expression of multiple features into a single feature
Reductions

Pull DimReducs or DimReduc names
RunALRA

Run Adaptively-thresholded Low Rank Approximation (ALRA)
RunPCA

Run Principal Component Analysis
IntegrateData

Integrate data
Loadings

Get feature loadings
UpdateSeuratObject

Update old Seurat object to accomodate new features
RunCCA

Perform Canonical Correlation Analysis
RunTSNE

Run t-distributed Stochastic Neighbor Embedding
print.DimReduc

Print the results of a dimensional reduction analysis
merge.Assay

Merge Seurat Objects
TransferData

Transfer Labels
ReadH5AD

Read from and write to h5ad files
cc.genes.updated.2019

Cell cycle genes: 2019 update
StopCellbrowser

Stop Cellbrowser web server
SeuratTheme

Seurat Themes
VariableFeaturePlot

View variable features
SeuratCommand-class

The SeuratCommand Class
VariableFeatures

Get and set variable feature information
[.Seurat

Subset a Seurat object
as.list.SeuratCommand

Coerce a SeuratCommand to a list
RidgePlot

Single cell ridge plot
PrepSCTIntegration

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

Get and set project information
Misc

Access miscellaneous data
RowMergeSparseMatrices

Merge two matrices by rowname
as.Seurat

Convert objects to Seurat objects
SubsetByBarcodeInflections

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

Get updated synonyms for gene symbols
ScaleData

Scale and center the data.
as.Graph

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

A small example version of the PBMC dataset
seurat-class

The Seurat Class
AddMetaData

Add in metadata associated with either cells or features.
ALRAChooseKPlot

ALRA Approximate Rank Selection Plot
AverageExpression

Averaged feature expression by identity class
Assay-class

The Assay Class
BarcodeInflectionsPlot

Plot the Barcode Distribution and Calculated Inflection Points
BuildClusterTree

Phylogenetic Analysis of Identity Classes
AddModuleScore

Calculate module scores for feature expression programs in single cells
AugmentPlot

Augments ggplot2-based plot with a PNG image.
AnchorSet-class

The AnchorSet Class