Release notes
Version 1.8
1.8.3 the future
Docs
Bug fixes
Fixed finding variables with
use_raw=Trueandbasis=Noneinscanpy.pl.scatter()PR 2027 E RiceFixed
scanpy.external.pp.scrublet()to address issue 1957 FlMai and ensure raw counts are used for simulationFunctions in
scanpy.datasetsno longer throwOldFormatWarningswhen usinganndata0.8PR 2096 I Virshup
Performance
Ecosystem
1.8.2 2021-11-3
Docs
Update conda installation instructions PR 1974 L Heumos
Bug fixes
Fix plotting after
scanpy.tl.filter_rank_genes_groups()PR 1942 S RybakovFix
use_raw=Noneusinganndata.AnnData.var_namesifanndata.AnnData.rawis present inscanpy.tl.score_genes()PR 1999 M KleinFix compatibility with UMAP 0.5.2 PR 2028 L Mcinnes
Fixed non-determinism in
scanpy.pl.paga()node positions PR 1922 I Virshup
Ecosystem
Added PASTE (a tool to align and integrate spatial transcriptomics data) to scanpy ecosystem.
1.8.1 2021-07-07
Bug fixes
Fixed reproducibility of
scanpy.tl.score_genes(). Calculation and output is now float64 type. PR 1890 I KucinskiWorkarounds for some changes/ bugs in pandas 1.3 PR 1918 I Virshup
Fixed bug where
sc.pl.paga_comparecould mislabel nodes on the paga graph PR 1898 I VirshupFixed handling of
use_rawwithscanpy.tl.rank_genes_groups()PR 1934 I Virshup
1.8.0 2021-06-28
Metrics module
Added
scanpy.metricsmodule!Added
scanpy.metrics.gearys_c()for spatial autocorrelation PR 915 I VirshupAdded
scanpy.metrics.morans_i()for global spatial autocorrelation PR 1740 I Virshup, G PallaAdded
scanpy.metrics.confusion_matrix()for comparing labellings PR 915 I Virshup
Features
Added
layerandcopykwargs tonormalize_total()PR 1667 I VirshupAdded
vcenterandnormarguments to the plotting functions PR 1551 G EraslanStandardized and expanded available arguments to the
sc.pl.rank_genes_groups*family of functions. PR 1529 F Ramirez I Virshup - See examples sections ofrank_genes_groups_dotplot()andrank_genes_groups_matrixplot()for demonstrations.scanpy.tl.tsne()now supports the metric argument and records the passed parameters PR 1854 I Virshup
Ecosystem
Added
trikua feature selection method to the ecosystem page PR 1722 AM AscensiónAdded
dorotheaandprogenyto the ecosystem page PR 1767 P Badia-i-Mompel
Documentation
Added rendered examples to many plotting functions issue 1664 A Schaar L Zappia bio-la L Hetzel L Dony M Buttner K Hrovatin F Ramirez I Virshup LouisK92 mayarali
Integrated DocSearch, a find-as-you-type documentation index search. PR 1754 P Angerer
Reorganized reference docs PR 1753 I Virshup
Clarified docs issues for
neighbors(),diffmap(),calculate_qc_metrics()PR 1680 G PallaFixed typos in grouped plot doc-strings PR 1877 C Rands
Extended examples for differential expression plotting. PR 1529 F Ramirez - See
rank_genes_groups_dotplot()orrank_genes_groups_matrixplot()for examples.
Bug fixes
Fix
scanpy.pl.paga_path()TypeErrorwith recent versions of anndata PR 1047 P AngererFix detection of whether IPython is running PR 1844 I Virshup
Fixed reproducibility of
scanpy.tl.diffmap()(added random_state) PR 1858 I KucinskiFixed errors and warnings from embedding plots with small numbers of categories after
sns.set_palettewas called PR 1886 I VirshupFixed handling of
gene_symbolsargument in a number ofsc.pl.rank_genes_groups*functions PR 1529 F Ramirez I VirshupFixed handling of
use_rawforsc.tl.rank_genes_groupswhen no.rawis present PR 1895 I Virshupscanpy.pl.rank_genes_groups_violin()now works forraw=FalsePR 1669 M van den Beek
Development processes
Switched to flit for building and deploying the package, a simple tool with an easy to understand command line interface and metadata PR 1527 P Angerer
Use pre-commit for style checks PR 1684 PR 1848 L Heumos I Virshup
Deprecations
Dropped support for Python 3.6. More details here. PR 1897 I Virshup
Deprecated
layersandlayers_normkwargs tonormalize_total()PR 1667 I VirshupDeprecated
MulticoreTSNEbackend forscanpy.tl.tsne()PR 1854 I Virshup
Version 1.7
1.7.2 2021-04-07
Bug fixes
scanpy.logging.print_versions()now works whenpython<3.8PR 1691 I Virshupscanpy.pp.regress_out()now usesjoblibas the parallel backend, and should stop oversubscribing threads PR 1694 I Virshupscanpy.pp.highly_variable_genes()withflavor="seurat_v3"now returns correct gene means and -variances when used withbatch_keyPR 1732 J Lausescanpy.pp.highly_variable_genes()now throws a warning instead of an error when non-integer values are passed for method"seurat_v3". The check can be skipped by passingcheck_values=False. PR 1679 G Palla
Ecosystem
1.7.1 2021-02-24
Documentation
More twitter handles for core devs PR 1676 G Eraslan
Bug fixes
dendrogram()use1 - correlationas distance matrix to compute the dendrogram PR 1614 F RamirezFixed
obs_df()/var_df()erroring whenkeysnot passed PR 1637 I VirshupFixed argument handling for
scanpy.external.pp.scrublet()J ManningFixed passing of
kwargstoscanpy.pl.violin()whenstripplotwas also used PR 1655 M van den BeekFixed colorbar creation in
scanpy.pl.timeseries_as_heatmapPR 1654 M van den Beek
1.7.0 2021-02-03
Features
Add new 10x Visium datasets to
visium_sge()PR 1473 G PallaEnable download of source image for 10x visium datasets in
visium_sge()PR 1506 H SpitzerRefactor of
scanpy.pl.spatial(). Better support for plotting without an image, as well as directly providing images PR 1512 G PallaDict input for
scanpy.queries.enrich()PR 1488 G Eraslanrank_genes_groups_df()can now return fraction of cells in a group expressing a gene, and allows retrieving values for multiple groups at once PR 1388 G EraslanColor annotations for gene sets in
heatmap()are now matched to color for cluster PR 1511 L SikkemaPCA plots can now annotate axes with variance explained PR 1470 bfurtwa
Plots with
groupbyarguments can now group by values in the index by passing the index’s name (likepd.DataFrame.groupby). PR 1583 F RamirezAdded
na_colorandna_in_legendkeyword arguments toembedding()plots. Allows specifying color for missing or filtered values in plots likeumap()orspatial()PR 1356 I Virshupembedding()plots now support passingdictof{cluster_name: cluster_color, ...}for palette argument PR 1392 I Virshup
External tools (new)
Add Scanorama integration to scanpy external API (
scanorama_integrate()) [Hie19] PR 1332 B HieScrublet [Wolock19] integration:
scrublet(),scrublet_simulate_doublets(), and plotting methodscrublet_score_distribution()PR 1476 J Manninghashsolo()for HTO demultiplexing [Bernstein20] PR 1432 NJ BernsteinAdded scirpy (sc-AIRR analysis) to ecosystem page PR 1453 G Sturm
Added scvi-tools to ecosystem page PR 1421 A Gayoso
External tools (changes)
Updates for
palantir()andpalantir_results()PR 1245 A MousaFixes to
harmony_timeseries()docs PR 1248 A MousaSupport for
leidenclustering byscanpy.external.tl.phenograph()PR 1080 A MousaDeprecate
scanpy.external.pp.scviPR 1554 G XingUpdated default params of
sam()to work with larger data PR 1540 A Tarashansky
Documentation
New contribution guide PR 1544 I Virshup
zshinstallation instructions PR 1444 P Angerer
Performance
Speed up
read_10x_h5()PR 1402 P Weiler
Bugfixes
Consistent fold-change, fractions calculation for filter_rank_genes_groups PR 1391 S Rybakov
Fixed bug where
score_geneswould error if one gene was passed PR 1398 I VirshupFixed
log1pinplace on integer dense arrays PR 1400 I VirshupFix docstring formatting for
rank_genes_groups()PR 1417 P WeilerRemoved
PendingDeprecationWarning`s from use of `np.matrixPR 1424 P WeilerFixed indexing byg in
~scanpy.pp.highly_variable_genesPR 1456 V BergenFix default number of genes for marker_genes_overlap PR 1464 MD Luecken
Fixed passing
groupbyanddendrogram_keytodendrogram()PR 1465 M VarmaFixed download path of
pbmc3k_processedPR 1472 D StroblBetter error message when computing DE with a group of size 1 PR 1490 J Manning
Update cugraph API usage for v0.16 PR 1494 R Ilango
Fixed
marker_gene_overlapdefault value fortop_n_markersPR 1464 MD LueckenPass
random_stateto RAPIDs UMAP PR 1474 C NoletFixed
anndataversion requirement forconcat()(re-exported from scanpy assc.concat) PR 1491 I VirshupFixed the width of the progress bar when downloading data PR 1507 M Klein
Updated link for
moignard15dataset PR 1542 I VirshupFixed bug where calling
set_figure_paramscould block if IPython was installed, but not used. PR 1547 I Virshupviolin()no longer fails if.rawnot present PR 1548 I Virshupspatial()refactoring and better handling of spatial data PR 1512 G Palla
Version 1.6
1.6.0 2020-08-15
This release includes an overhaul of dotplot(), matrixplot(), and stacked_violin() (PR 1210 F Ramirez), and of the internals of rank_genes_groups() (PR 1156 S Rybakov).
Overhaul of dotplot(), matrixplot(), and stacked_violin() PR 1210 F Ramirez
An overhauled tutorial → tutorial: plotting/core.
New plotting classes can be accessed directly (e.g.,
DotPlot) or using thereturn_figparam.It is possible to plot log fold change and p-values in the
rank_genes_groups_dotplot()family of functions.Added
axparameter which allows embedding the plot in other images.Added option to include a bar plot instead of the dendrogram containing the cell/observation totals per category.
Return a dictionary of axes for further manipulation. This includes the main plot, legend and dendrogram to totals
Legends can be removed.
The
groupbyparam can take a list of categories, e.g.,groupby=[‘tissue’, ‘cell type’].Added padding parameter to
dotplotandstacked_violin. PR 1270Added title for colorbar and positioned as in dotplot for
matrixplot().dotplot()changes:Improved the colorbar and size legend for dotplots. Now the colorbar and size have titles, which can be modified using the
colorbar_titleandsize_titleparams. They also align at the bottom of the image and do not shrink if the dotplot image is smaller.Allow plotting genes in rows and categories in columns (
swap_axes).Using
DotPlot, thedot_edge_colorand line width can be modified, a grid can be added, and other modifications are enabled.A new style was added in which the dots are replaced by an empty circle and the square behind the circle is colored (like in matrixplots).
stacked_violin()changes:Violin colors can be colored based on average gene expression as in dotplots.
The linewidth of the violin plots is thinner.
Removed the tics for the y-axis as they tend to overlap with each other. Using the style method they can be displayed if needed.
Additions
concat()is now exported from scanpy, see Concatenation for more info. PR 1338 I VirshupAdded highly variable gene selection strategy from Seurat v3 PR 1204 A Gayoso
Added
backup_urlparam toread_10x_h5()PR 1296 A GayosoAllow prefix for
read_10x_mtx()PR 1250 G SturmOptional tie correction for the
'wilcoxon'method inrank_genes_groups()PR 1330 S RybakovUse
sinfoforprint_versions()and addprint_header()to do what it previously did. PR 1338 I Virshup PR 1373
Bug fixes
Avoid warning in
rank_genes_groups()if ‘t-test’ is passed PR 1303 A WolfRestrict sphinx version to <3.1, >3.0 PR 1297 I Virshup
Clean up
_ranksand fixdendrogramfor scipy 1.5 PR 1290 S RybakovUse
.rawto translate gene symbols if applicable PR 1278 E RiceFix
diffmap(issue 1262) G EraslanFix
neighborsinspring_projectissue 1260 S RybakovFix default size of dot in spatial plots PR 1255 issue 1253 giovp
Bumped version requirement of
scipytoscipy>1.4to supportrmatmatargument ofLinearOperatorissue 1246 I VirshupFix asymmetry of scores for the
'wilcoxon'method inrank_genes_groups()issue 754 S RybakovAvoid trimming of gene names in
rank_genes_groups()issue 753 S Rybakov
Version 1.5
1.5.1 2020-05-21
Bug fixes
1.5.0 2020-05-15
The 1.5.0 release adds a lot of new functionality, much of which takes advantage of anndata updates 0.7.0 - 0.7.2. Highlights of this release include support for spatial data, dedicated handling of graphs in AnnData, sparse PCA, an interface with scvi, and others.
Spatial data support
Basic analysis → tutorial: spatial/basic-analysis and integration with single cell data → tutorial: spatial/integration-scanorama G Palla
read_visium()read 10x Visium data PR 1034 G Palla, P Angerer, I Virshupvisium_sge()load Visium data directly from 10x Genomics PR 1013 M Mirkazemi, G Palla, P Angerer
New functionality
Many functions, like
neighbors()andumap(), now store cell-by-cell graphs inobspPR 1118 S Rybakovscale()andlog1p()can be used on any element inlayersorobsmPR 1173 I Virshup
External tools
scanpy.external.pp.scvifor preprocessing with scVI PR 1085 G XingGuide for using Scanpy in R PR 1186 L Zappia
Performance
pca()now uses efficient implicit centering for sparse matrices. This can lead to signifigantly improved performance for large datasets PR 1066 A Tarashanskyscore_genes()now has an efficient implementation for sparse matrices with missing values PR 1196 redst4r.
Warning
The new pca() implementation can result in slightly different results for sparse matrices. See the pr (PR 1066) and documentation for more info.
Code design
stacked_violin()can now be used as a subplot PR 1084 P Angererscore_genes()has improved logging PR 1119 G Eraslanscale()now saves mean and standard deviation in thevarPR 1173 A Wolfharmony_timeseries()PR 1091 A Mousa
Bug fixes
combat()now works whenobs_namesaren’t unique. PR 1215 I Virshupscale()can now be used on dense arrays without centering PR 1160 simonwmregress_out()now works when some features are constant PR 1194 simonwmnormalize_total()errored if the passed object was a view PR 1200 I Virshupneighbors()sometimes ignored then_pcsparam PR 1124 V Bergenebi_expression_atlas()which contained some out-of-date URLs PR 1102 I Virshuphighly_variable_genes()which could lead to incorrect results when thebatch_keyargument was used PR 1180 G Eraslaningest()where an inconsistent number of neighbors was used PR 1111 S Rybakov
Version 1.4
1.4.6 2020-03-17
Functionality in external
sam()self-assembling manifolds [Tarashansky19] PR 903 A Tarashanskyharmony_timeseries()for trajectory inference on discrete time points PR 994 A Mousawishbone()for trajectory inference (bifurcations) PR 1063 A Mousa
Code design
Bug fixes
1.4.5 2019-12-30
Please install scanpy==1.4.5.post3 instead of scanpy==1.4.5.
New functionality
ingest()maps labels and embeddings of reference data to new data → tutorial: integrating-data-using-ingest PR 651 S Rybakov, A Wolfqueriesrecieved many updates including enrichment through gprofiler and more advanced biomart queries PR 467 I Virshupset_figure_params()allows settingfigsizeand acceptsfacecolor='white', useful for working in dark mode A Wolf
Code design
downsample_countsnow always preserves the dtype of it’s input, instead of converting floats to ints PR 865 I Virshuprun neighbors on a GPU using rapids PR 850 T White
param docs from typed params P Angerer
embedding_density()now only takes one positional argument; similar forembedding_density(), which gains a paramgroupbyPR 965 A Wolfwebpage overhaul, ecosystem page, release notes, tutorials overhaul PR 960 PR 966 A Wolf
Warning
changed default
solverinpca()fromautotoarpackchanged default
use_rawinscore_genes()fromFalsetoNone
1.4.4 2019-07-20
New functionality
scanpy.getadds helper functions for extracting data in convenient formats PR 619 I Virshup
Bug fixes
Stopped deprecations warnings from AnnData
0.6.22I Virshup
Code design
normalize_total()gains paramexclude_highly_expressed, andfractionis renamed tomax_fractionwith better docs A Wolf
1.4.3 2019-05-14
Bug fixes
neighbors()correctly infersn_neighborsagain fromparams, which was temporarily broken inv1.4.2I Virshup
Code design
calculate_qc_metrics()is single threaded by default for datasets under 300,000 cells – allowing cached compilation PR 615 I Virshup
1.4.2 2019-05-06
New functionality
combat()supports additional covariates which may include adjustment variables or biological condition PR 618 G Eraslanhighly_variable_genes()has abatch_keyoption which performs HVG selection in each batch separately to avoid selecting genes that vary strongly across batches PR 622 G Eraslan
Bug fixes
rank_genes_groups()t-test implementation doesn’t return NaN when variance is 0, also changed to scipy’s implementation PR 621 I Virshupumap()withinit_pos='paga'detects correctdtypeA Wolflouvain()andleiden()auto-generatekey_added=louvain_Rupon passingrestrict_to, which was temporarily changed in1.4.1A Wolf
Code design
neighbors()andumap()got rid of UMAP legacy code and introduced UMAP as a dependency PR 576 S Rybakov
1.4.1 2019-04-26
New functionality
Scanpy has a command line interface again. Invoking it with
scanpy somecommand [args]callsscanpy-somecommand [args], except for builtin commands (currentlyscanpy settings) PR 604 P Angererebi_expression_atlas()allows convenient download of EBI expression atlas I Virshupmarker_gene_overlap()computes overlaps of marker genes M Lueckenfilter_rank_genes_groups()filters out genes based on fold change and fraction of cells expressing genes F Ramireznormalize_total()replacesnormalize_per_cell(), is more efficient and provides a parameter to only normalize using a fraction of expressed genes S Rybakovdownsample_counts()has been sped up, changed default value ofreplaceparameter toFalsePR 474 I Virshupembedding_density()computes densities on embeddings PR 543 M Lueckenpalantir()interfaces Palantir [Setty18] PR 493 A Mousa
Code design
.layerssupport of scatter plots F Ramirezfix double-logarithmization in compute of log fold change in
rank_genes_groups()A Muñoz-Rojasfix return sections of docs P Angerer
Version 1.3
1.3.6 2018-12-11
Major updates
a new plotting gallery for <no title> F Ramirez
tutorials are integrated on ReadTheDocs, Preprocessing and clustering 3k PBMCs and Trajectory inference for hematopoiesis in mouse A Wolf
Interactive exploration of analysis results through manifold viewers
CZI’s cellxgene directly reads
.h5adfiles the cellxgene developersthe UCSC Single Cell Browser requires exporting via
cellbrowser()M Haeussler
Code design
highly_variable_genes()supersedesfilter_genes_dispersion(), it gives the same results but, by default, expects logarithmized data and doesn’t subset A Wolf
1.3.5 2018-12-09
uncountable figure improvements PR 369 F Ramirez
1.3.4 2018-11-24
leiden()wraps the recent graph clustering package by [Traag18] K Polanskibbknn()wraps the recent batch correction package [Polanski19] K Polanskicalculate_qc_metrics()caculates a number of quality control metrics, similar tocalculateQCMetricsfrom Scater [McCarthy17] I Virshup
1.3.3 2018-11-05
Major updates
a fully distributed preprocessing backend T White and the Laserson Lab
Code design
read_10x_h5()andread_10x_mtx()read Cell Ranger 3.0 outputs PR 334 Q Gong
Note
Also see changes in anndata 0.6.
changed default compression to
Noneinwrite_h5ad()to speed up read and write, disk space use is usually less criticalperformance gains in
write_h5ad()due to better handling of strings and categories S Rybakov
1.3.1 2018-09-03
RNA velocity in single cells [Manno18]
Scanpy and AnnData support loom’s layers so that computations for single-cell RNA velocity [Manno18] become feasible S Rybakov and V Bergen
scvelo harmonizes with Scanpy and is able to process loom files with splicing information produced by Velocyto [Manno18], it runs a lot faster than the count matrix analysis of Velocyto and provides several conceptual developments
Plotting (Generic)
dotplot()for visualizing genes across conditions and clusters, see here PR 199 F Ramirezviolin()produces very compact overview figures with many panels PR 175 F Ramirez
There now is a section on imputation in external:
magic()for imputation using data diffusion [vanDijk18] PR 187 S Gigantedca()for imputation and latent space construction using an autoencoder [Eraslan18] PR 186 G Eraslan
Version 1.2
1.2.1 2018-06-08
Plotting of Generic marker genes and quality control.
highest_expr_genes()for quality control; plot genes with highest mean fraction of cells, similar toplotQCof Scater [McCarthy17] PR 169 F Ramirez
1.2.0 2018-06-08
Version 1.1
1.1.0 2018-06-01
set_figure_params()by default passesvector_friendly=Trueand allows you to produce reasonablly sized pdfs by rasterizing large scatter plots A Wolfdraw_graph()defaults to the ForceAtlas2 layout [Jacomy14] [Chippada18], which is often more visually appealing and whose computation is much faster S Wollockscatter()also plots along variables axis MD Lueckenregress_out()is back to multiprocessing F Ramirezread()reads compressed text files G Eraslanmitochondrial_genes()for querying mito genes FG Brundumnn_correct()for batch correction [Haghverdi18] [Kang18]sandbag(),cyclone()for scoring genes [Scialdone15] [Fechtner18]
Version 1.0
1.0.0 2018-03-30
Major updates
Scanpy is much faster and more memory efficient: preprocess, cluster and visualize 1.3M cells in 6h, 130K cells in 14min, and 68K cells in 3min A Wolf
the API gained a preprocessing function
neighbors()and a classNeighbors()to which all basic graph computations are delegated A Wolf
Warning
Upgrading to 1.0 isn’t fully backwards compatible in the following changes
the graph-based tools
louvain()dpt()draw_graph()umap()diffmap()paga()require prior computation of the graph:sc.pp.neighbors(adata, n_neighbors=5); sc.tl.louvain(adata)instead of previouslysc.tl.louvain(adata, n_neighbors=5)install
numbaviaconda install numba, which replaces cythonthe default connectivity measure (dpt will look different using default settings) changed. setting
method='gauss'insc.pp.neighborsuses gauss kernel connectivities and reproduces the previous behavior, see, for instance in the example paul15.namings of returned annotation have changed for less bloated AnnData objects, which means that some of the unstructured annotation of old AnnData files is not recognized anymore
replace occurances of
group_bywithgroupby(consistency withpandas)it is worth checking out the notebook examples to see changes, e.g. the seurat example.
upgrading scikit-learn from 0.18 to 0.19 changed the implementation of PCA, some results might therefore look slightly different
Further updates
UMAP [McInnes18] can serve as a first visualization of the data just as tSNE, in contrast to tSNE, UMAP directly embeds the single-cell graph and is faster; UMAP is also used for measuring connectivities and computing neighbors, see
neighbors()A Wolfgraph abstraction: AGA is renamed to PAGA:
paga(); now, it only measures connectivities between partitions of the single-cell graph, pseudotime and clustering need to be computed separately vialouvain()anddpt(), the connectivity measure has been improved A Wolflogistic regression for finding marker genes
rank_genes_groups()with parametermethod='logreg'A Wolflouvain()provides a better implementation for reclustering viarestrict_toA Wolfscanpy no longer modifies rcParams upon import, call
settings.set_figure_paramsto set the ‘scanpy style’ A Wolfdefault cache directory is
./cache/, setsettings.cachedirto change this; nested directories in this are avoided A Wolfshow edges in scatter plots based on graph visualization
draw_graph()andumap()by passingedges=TrueA Wolfdownsample_counts()for downsampling counts MD Lueckendefault
'louvain_groups'are called'louvain'A Wolf'X_diffmap'contains the zero component, plotting remains unchanged A Wolf
Version 0.4
0.4.3 2018-02-09
clustermap(): heatmap from hierarchical clustering, based onseaborn.clustermap()[Waskom16] A Wolfonly return
matplotlib.axes.Axesin plotting functions ofsc.plwhenshow=False, otherwiseNoneA Wolf
0.4.2 2018-01-07
amendments in PAGA and its plotting functions A Wolf
0.4.0 2017-12-23
export to SPRING [Weinreb17] for interactive visualization of data: spring tutorial S Wollock
Version 0.3
0.3.2 2017-11-29
finding marker genes via
rank_genes_groups_violin()improved, see issue 51 F Ramirez
0.3.0 2017-11-16
AnnDatagains methodconcatenate()A WolfAnnDatais available as the separate anndata package P Angerer, A Wolfresults of PAGA simplified A Wolf
Version 0.2
0.2.9 2017-10-25
Initial release of the new trajectory inference method PAGA
paga()computes an abstracted, coarse-grained (PAGA) graph of the neighborhood graph A Wolfpaga_compare()plot this graph next an embedding A Wolfpaga_path()plots a heatmap through a node sequence in the PAGA graph A Wolf
0.2.1 2017-07-24
Scanpy includes preprocessing, visualization, clustering, pseudotime and trajectory inference, differential expression testing and simulation of gene regulatory networks. The implementation efficiently deals with datasets of more than one million cells. A Wolf, P Angerer
Version 0.1
0.1.0 2017-05-17
Scanpy computationally outperforms and allows reproducing both the Cell Ranger R kit’s and most of Seurat’s clustering workflows. A Wolf, P Angerer