Skip to content

Commit

Permalink
release 1.3.7
Browse files Browse the repository at this point in the history
  • Loading branch information
falexwolf committed Jan 2, 2019
1 parent 9df0f70 commit c017b2a
Show file tree
Hide file tree
Showing 2 changed files with 21 additions and 24 deletions.
43 changes: 21 additions & 22 deletions scanpy/plotting/__init__.py
Original file line number Diff line number Diff line change
@@ -1,25 +1,4 @@
from .anndata import scatter, violin, ranking, clustermap, stacked_violin, heatmap, dotplot, matrixplot, tracksplot

from .preprocessing import filter_genes_dispersion, highly_variable_genes

from .tools.scatterplots import pca, diffmap, draw_graph, tsne, phate, umap
from .tools import pca_loadings, pca_scatter, pca_overview, pca_variance_ratio
from .tools.paga import paga, paga_adjacency, paga_compare, paga_path
from .tools import dpt_timeseries, dpt_groups_pseudotime
from .tools import rank_genes_groups, rank_genes_groups_violin
from .tools import rank_genes_groups_dotplot, rank_genes_groups_heatmap, rank_genes_groups_stacked_violin, rank_genes_groups_matrixplot, rank_genes_groups_tracksplot
from .tools import sim

from .rcmod import set_rcParams_scanpy, set_rcParams_defaults
from . import palettes

from .utils import matrix
from .utils import timeseries, timeseries_subplot, timeseries_as_heatmap

from .qc import highest_expr_genes


__doc__ = """\
"""
Plotting: PL
============
Expand Down Expand Up @@ -119,3 +98,23 @@
pl.sim
"""

from .anndata import scatter, violin, ranking, clustermap, stacked_violin, heatmap, dotplot, matrixplot, tracksplot

from .preprocessing import filter_genes_dispersion, highly_variable_genes

from .tools.scatterplots import pca, diffmap, draw_graph, tsne, phate, umap
from .tools import pca_loadings, pca_scatter, pca_overview, pca_variance_ratio
from .tools.paga import paga, paga_adjacency, paga_compare, paga_path
from .tools import dpt_timeseries, dpt_groups_pseudotime
from .tools import rank_genes_groups, rank_genes_groups_violin
from .tools import rank_genes_groups_dotplot, rank_genes_groups_heatmap, rank_genes_groups_stacked_violin, rank_genes_groups_matrixplot, rank_genes_groups_tracksplot
from .tools import sim

from .rcmod import set_rcParams_scanpy, set_rcParams_defaults
from . import palettes

from .utils import matrix
from .utils import timeseries, timeseries_subplot, timeseries_as_heatmap

from .qc import highest_expr_genes
2 changes: 0 additions & 2 deletions scanpy/tools/__init__.py
Original file line number Diff line number Diff line change
Expand Up @@ -11,5 +11,3 @@
from .louvain import louvain
from .sim import sim
from .score_genes import score_genes, score_genes_cell_cycle


0 comments on commit c017b2a

Please sign in to comment.