Skip to content

Latest commit

 

History

History
196 lines (138 loc) · 10.3 KB

release_notes.rst

File metadata and controls

196 lines (138 loc) · 10.3 KB

Note

Also see the release notes of :mod:`anndata`.

On master November 5, 2018

Version 1.3 September 3, 2018

RNA velocity in single cells [Manno18]_:

  • Scanpy and AnnData support loom's layers so that computations for single-cell RNA velocity [Manno18]_ become feasible thanks to S Rybakov and V Bergen
  • the package scvelo perfectly 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 (preprint to come)

Plotting of marker genes and quality control, see this section and scroll down, a few examples are

There is a section on imputation:

Further changes:

And several consistency fixes.

Version 1.2 June 8, 2018

Version 1.1 May 31, 2018

Version 1.0 March 28, 2018

Scanpy is much faster and more memory efficient. Preprocess, cluster and visualize 1.3M cells in 6 h, 130K cells in 14 min and 68K cells in 3 min.

The API gained a preprocessing function :func:`~scanpy.api.pp.neighbors` and a class :func:`~scanpy.api.Neighbors` to which all basic graph computations are delegated.

Upgrading to 1.0 isn't fully backwards compatible in the following changes:

  • the graph-based tools :func:`~scanpy.api.tl.louvain` :func:`~scanpy.api.tl.dpt` :func:`~scanpy.api.tl.draw_graph` :func:`~scanpy.api.tl.umap` :func:`~scanpy.api.tl.diffmap` :func:`~scanpy.api.tl.paga` now require prior computation of the graph: sc.pp.neighbors(adata, n_neighbors=5); sc.tl.louvain(adata) instead of previously sc.tl.louvain(adata, n_neighbors=5)
  • install numba via conda install numba, which replaces cython
  • the default connectivity measure (dpt will look different using default settings) changed. setting method='gauss' in sc.pp.neighbors uses gauss kernel connectivities and reproduces the previous behavior, see, for instance this example
  • 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_by with groupby (consistency with pandas)
  • it is worth checking out the notebook examples to see changes, e.g., here
  • upgrading scikit-learn from 0.18 to 0.19 changed the implementation of PCA, some results might therefore look slightly different

Further changes are:

Version 0.4.4 February 26, 2018

Version 0.4.3 February 9, 2018

Version 0.4.2 January 7, 2018

  • amendments in PAGA and its plotting functions

Version 0.4 December 23, 2017

Version 0.3.2 November 29, 2017

Version 0.3 November 16, 2017

Version 0.2.9 October 25, 2017

Initial release of partition-based graph abstraction (PAGA).

Version 0.2.1 July 24, 2017

Scanpy now 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.

Version 0.1 May 1, 2017

Scanpy computationally outperforms the Cell Ranger R kit and allows reproducing most of Seurat's guided clustering tutorial.