changeset 0:6ea5a05a260a draft

planemo upload for repository https://github.com/galaxyproject/tools-iuc/tree/master/tools/scanpy/ commit 92f85afaed0097d1879317a9f513093fce5481d6
author iuc
date Mon, 04 Mar 2019 10:15:02 -0500
parents
children 6a76b60e05f5
files README.md README.rst filter.xml macros.xml test-data/krumsiek11.h5ad test-data/krumsiek11.loom test-data/krumsiek11_counts_per_cell test-data/paul15_subsample.h5ad test-data/pbmc68k_reduced.h5ad test-data/pl.clustermap.krumsiek11.png test-data/pl.diffmap.neighbors_gauss_braycurtis.recipe_weinreb17.paul15_subsampl.png test-data/pl.diffmap.neighbors_gauss_braycurtis.recipe_weinreb17.paul15_subsample.png test-data/pl.dotplot.krumsiek11.png test-data/pl.dpt_timeseries.dpt.diffmap.neighbors_gauss_braycurtis.recipe_weinreb17.paul15_subsample.png test-data/pl.heatmap.krumsiek11.png test-data/pl.highest_expr_genes.filter_genes_dispersion.krumsiek11-seurat.png test-data/pl.matrixplot.krumsiek11.png test-data/pl.paga.paul15_gauss_braycurtis.png test-data/pl.pca.pbmc68k_reduced.CD3D_CD79A_components_2d.pdf test-data/pl.pca_loadings.pp.pca.krumsiek11.png test-data/pl.pca_overview.pp.pca.krumsiek11.png test-data/pl.pca_variance_ratio.pp.pca.krumsiek11.png test-data/pl.scatter.krumsiek11.png test-data/pl.scatter.pca.krumsiek11.png test-data/pl.tsne.krumsiek11.png test-data/pl.umap.neighbors_umap_euclidean.recipe_weinreb17.paul15_subsample.png test-data/pl.violin.pbmc68k_reduced_custom.png test-data/pp.filter_cells.krumsiek11-min_counts.h5ad test-data/pp.filter_cells.krumsiek11-min_counts.loom test-data/pp.filter_cells.number_per_cell.krumsiek11-max_genes.tabular test-data/pp.filter_genes.krumsiek11-min_counts.h5ad test-data/pp.filter_genes.number_per_gene.krumsiek11-min_counts.tabular test-data/pp.filter_genes.number_per_gene.pbmc68k_reduced-max_cells.tabular test-data/pp.filter_genes_dispersion.krumsiek11-seurat.h5ad test-data/pp.filter_genes_dispersion.per_gene.krumsiek11-cell_ranger.tabular test-data/pp.filter_genes_dispersion.per_gene.krumsiek11-seurat.tabular test-data/pp.log1p.krumsiek11.h5ad test-data/pp.neighbors_gauss_braycurtis.recipe_weinreb17.paul15_subsample.h5ad test-data/pp.neighbors_umap_euclidean.recipe_weinreb17.paul15_subsample.h5ad test-data/pp.normalize_per_cell.krumsiek11.h5ad test-data/pp.normalize_per_cell.obs.krumsiek11.tabular test-data/pp.pca.krumsiek11.h5ad test-data/pp.pca.krumsiek11_chunk.h5ad test-data/pp.pca.variance.krumsiek11.tabular test-data/pp.recipe_seurat.recipe_zheng17.h5ad test-data/pp.recipe_weinreb17.paul15_subsample.h5ad test-data/pp.recipe_zheng17.random-randint.h5ad test-data/pp.regress_out.krumsiek11.h5ad test-data/pp.scale.krumsiek11.h5ad test-data/pp.scale_max_value.krumsiek11.h5ad test-data/pp.sqrt.krumsiek11.h5ad test-data/pp.subsample.krumsiek11_fraction.h5ad test-data/pp.subsample.krumsiek11_n_obs.h5ad test-data/random-randint.h5ad test-data/random.h5ad test-data/tl.diffmap.neighbors_gauss_braycurtis.recipe_weinreb17.paul15_subsample.X_diffmap.tabular test-data/tl.diffmap.neighbors_gauss_braycurtis.recipe_weinreb17.paul15_subsample.h5ad test-data/tl.dpt.diffmap.neighbors_gauss_braycurtis.recipe_weinreb17.paul15_subsample.h5ad test-data/tl.dpt.diffmap.neighbors_gauss_braycurtis.recipe_weinreb17.paul15_subsample.obs.tabular test-data/tl.dpt.neighbors.paul15_gauss_braycurtis.obs.tabular test-data/tl.louvain.neighbors_gauss_braycurtis.recipe_weinreb17.paul15_subsample.h5ad test-data/tl.paga.neighbors_gauss_braycurtis.recipe_weinreb17.paul15_subsample.h5ad test-data/tl.pca.krumsiek11.h5ad test-data/tl.pca.variance_ratio.krumsiek11.tabular test-data/tl.rank_genes_groups.krumsiek11.h5ad test-data/tl.score_genes.krumsiek11.h5ad test-data/tl.score_genes.krumsiek11.obs.tabular test-data/tl.score_genes_cell_cycle.krumsiek11.h5ad test-data/tl.score_genes_cell_cycle.krumsiek11.obs.tabular test-data/tl.tsne.krumsiek11.h5ad test-data/tl.tsne.krumsiek11_X_tsne.tabular test-data/tl.umap.neighbors_umap_euclidean.recipe_weinreb17.paul15_subsample.h5ad
diffstat 72 files changed, 8927 insertions(+), 0 deletions(-) [+]
line wrap: on
line diff
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/README.md	Mon Mar 04 10:15:02 2019 -0500
@@ -0,0 +1,138 @@
+Scanpy
+======
+
+## Classification of methods into steps
+
+Steps:
+
+1. Filtering
+
+    Methods | Description
+    --- | ---
+    `pp.filter_cells` | Filter cell outliers based on counts and numbers of genes expressed.
+    `pp.filter_genes` | Filter genes based on number of cells or counts.
+    `pp.filter_genes_dispersion` | Extract highly variable genes
+    `pp.highly_variable_genes` | Extract highly variable genes
+    `pp.subsample` | Subsample to a fraction of the number of observations
+    `queries.gene_coordinates` | (Could not find...)
+    `queries.mitochondrial_genes` | Retrieves Mitochondrial gene symbols for specific organism through BioMart for filtering
+
+2. Quality Plots
+
+   These are in-between stages used to measure the effectiveness of a Filtering/Normalisation/Conf.Removal stage either after processing or prior to.
+
+    Methods | Description | Notes
+    --- | --- | ---
+    `pp.calculate_qc_metrics` | Calculate quality control metrics
+    `pl.violin` | violin plot of features, lib. size, or subsets of. 
+    `pl.stacked_violin` | Same as above but for multiple series of features or cells
+
+3. Normalization
+
+    Methods | Description
+    --- | ---
+    `pp.normalize_per_cell` | Normalize total counts per cell
+    `pp.recipe_zheng17` | Normalization and filtering as of [Zheng17]
+    `pp.recipe_weinreb17` | Normalization and filtering as of [Weinreb17]
+    `pp.recipe_seurat` | Normalization and filtering as of Seurat [Satija15]
+    `pp.log1p` | Logarithmize the data matrix.
+    `pp.scale` | Scale data to unit variance and zero mean
+    `pp.sqrt` | 
+    `pp.downsample_counts` | Downsample counts so that each cell has no more than target_counts
+
+4. Conf. removal
+
+    Methods | Description
+    --- | ---
+   `pp.regress_out` | Regress out unwanted sources of variation
+   `pp.mnn_correct` | Correct batch effects by matching mutual nearest neighbors
+   `pp.dca` | Deep count autoencoder to denoise the data
+   `pp.magic` | Markov Affinity-based Graph Imputation of Cells (MAGIC) API to denoise
+   `tl.sim` | Simulate dynamic gene expression data [Wittman09]
+   `pp.calculate_qc_metrics` | Calculate quality control metrics
+   `tl.score_genes` | Score a set of genes
+   `tl.score_genes_cell_cycle` | Score cell cycle genes
+   `tl.cyclone` | Assigns scores and predicted class to observations based on cell-cycle genes [Scialdone15]
+   `tl.sandbag` | Calculates pairs of genes serving as markers for each cell-cycle phase [Scialdone15]
+
+5. Clustering and Heatmaps
+
+    Methods | Description
+    --- | ---
+    `tl.leiden` | Cluster cells into subgroups [Traag18] [Levine15]
+    `tl.louvain` | Cluster cells into subgroups [Blondel08] [Levine15] [Traag17]
+    `tl.pca` | Principal component analysis
+    `pp.pca` | Principal component analysis (appears to be the same func...)
+    `tl.diffmap` | Diffusion Maps
+    `tl.tsne` | t-SNE
+    `tl.umap` | Embed the neighborhood graph using UMAP
+    `tl.phate` | PHATE
+    `pp.neighbors` | Compute a neighborhood graph of observations
+    `tl.rank_genes_groups` | Rank genes for characterizing groups
+    `pl.rank_genes_groups` | 
+    `pl.rank_genes_groups_dotplot` | 
+    `pl.rank_genes_groups_heatmap` | 
+    `pl.rank_genes_groups_matrixplot` | 
+    `pl.rank_genes_groups_stacked_violin` | 
+    `pl.rank_genes_groups_violin` | 
+    `pl.matrix_plot` | 
+    `pl.heatmap` | 
+    `pl.highest_expr_genes` | 
+    `pl.diffmap` | 
+    
+6. Cluster Inspection and plotting
+
+    Methods that draw out the clusters computed in the previous stage, not heatmap or pseudotime related.
+
+    Methods | Description 
+    --- | --- 
+    `pl.clustermap` |
+    `pl.phate` | 
+    `pl.dotplot` | 
+    `pl.draw_graph` | (really general purpose, would not implement directly)
+    `pl.filter_genes_dispersion` | (depreciated for 'highly_variable_genes')
+    `pl.matrix` | (could not find in API)
+    `pl.pca` | 
+    `pl.pca_loadings` | 
+    `pl.pca_overview` | 
+    `pl.pca_variance_ratio` | 
+    `pl.ranking` | (not sure what this does...)
+    `pl.scatter` | ([very general purpose](https://icb-scanpy.readthedocs-hosted.com/en/latest/api/scanpy.api.pl.scatter.html), would not implement directly)
+    `pl.set_rcParams_defaults` | 
+    `pl.set_rcParams_scanpy` | 
+    `pl.sim` | 
+    `pl.tsne` | 
+    `pl.umap` | 
+
+7. Branch/Between-Cluster Inspection
+
+    Pseudotime analysis, relies on initial clustering.
+
+    Methods | Description
+    --- | ---
+    `tl.dpt` | Infer progression of cells through geodesic distance along the graph [Haghverdi16] [Wolf17i]
+    `pl.dpt_groups_pseudotime` | 
+    `pl.dpt_timeseries` | 
+    `tl.paga_compare_paths` | 
+    `tl.paga_degrees` | 
+    `tl.paga_expression_entropies` | 
+    `tl.paga` | Generate cellular maps of differentiation manifolds with complex topologies [Wolf17i]
+    `pl.paga` | 
+    `pl.paga_adjacency` | 
+    `pl.paga_compare` | 
+    `pl.paga_path` | 
+    `pl.timeseries` | 
+    `pl.timeseries_as_heatmap` | 
+    `pl.timeseries_subplot` | 
+
+
+Methods to sort | Description
+--- | --- 
+`tl.ROC_AUC_analysis` | (could not find in API)
+`tl.correlation_matrix` | (could not find in API)
+`rtools.mnn_concatenate` | (could not find in API)
+`utils.compute_association_matrix_of_groups` | (could not find in API) 
+`utils.cross_entropy_neighbors_in_rep` | (could not find in API)
+`utils.merge_groups` | (could not find in API)
+`utils.plot_category_association` | (could not find in API)
+`utils.select_groups` | (could not find in API)
\ No newline at end of file
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/README.rst	Mon Mar 04 10:15:02 2019 -0500
@@ -0,0 +1,105 @@
+The different methods from Scanpy have been grouped by themes:
+
+1. Filter in `filter.xml`
+  - Filter cell outliers based on counts and numbers of genes expressed, using `pp.filter_cells`
+  - Filter genes based on number of cells or counts, using `pp.filter_genes`
+  - Extract highly variable genes, using `pp.filter_genes_dispersion`
+  - `tl.highly_variable_genes` (need to be added)
+  - Subsample to a fraction of the number of observations, using `pp.subsample`
+  - `queries.gene_coordinates` (need to be added)
+  - `queries.mitochondrial_genes` (need to be added)
+
+2. Normalize in `normalize.xml`
+  - Normalize total counts per cell, using `pp.normalize_per_cell`
+  - Normalization and filtering as of Zheng et al. (2017), using `pp.recipe_zheng17`
+  - Normalization and filtering as of Weinreb et al (2017), using `pp.recipe_weinreb17`
+  - Normalization and filtering as of Seurat et al (2015), using `pp.recipe_seurat`
+  - Logarithmize the data matrix, using `pp.log1p`
+  - Scale data to unit variance and zero mean, using `pp.scale`
+  - Square root the data matrix, using `pp.sqrt`
+  - Downsample counts, using `pp.downsample_counts`
+
+3. Remove confounder in `remove_confounders.xml`
+  - Regress out unwanted sources of variation, using `pp.regress_out`
+  - `pp.mnn_correct` (need to be added)
+  - `pp.mnn_correct` (need to be added)
+  - `pp.magic` (need to be added)
+  - `tl.sim` (need to be added)
+  - `pp.calculate_qc_metrics` (need to be added)
+  - Score a set of genes, using `tl.score_genes`
+  - Score cell cycle genes, using `tl.score_genes_cell_cycle`
+  - `tl.cyclone` (need to be added)
+  - `tl.andbag` (need to be added)
+
+4. Cluster and reduce dimension in `cluster_reduce_dimension.xml`
+  - `tl.leiden` (need to be added)
+  - Cluster cells into subgroups, using `tl.louvain`
+  - Computes PCA (principal component analysis) coordinates, loadings and variance decomposition, using `pp.pca`
+  - Computes PCA (principal component analysis) coordinates, loadings and variance decomposition, using `tl.pca`
+  - Diffusion Maps, using `tl.diffmap`
+  - t-distributed stochastic neighborhood embedding (tSNE), using `tl.tsne`
+  - Embed the neighborhood graph using UMAP, using `tl.umap`
+  - `tl.phate` (need to be added)
+  - Compute a neighborhood graph of observations, using `pp.neighbors`
+  - Rank genes for characterizing groups, using `tl.rank_genes_groups`
+
+4. Inspect
+  - `tl.paga_compare_paths` (need to be added)
+  - `tl.paga_degrees` (need to be added)
+  - `tl.paga_expression_entropies` (need to be added)
+  - Generate cellular maps of differentiation manifolds with complex topologies, using `tl.paga`
+  - Infer progression of cells through geodesic distance along the graph, using `tl.dpt`
+
+5. Plot
+  1. Generic
+    - Scatter plot along observations or variables axes, using `pl.scatter`
+    - Heatmap of the expression values of set of genes, using `pl.heatmap`
+    - Makes a dot plot of the expression values, using `pl.dotplot`
+    - Violin plot, using `pl.violin`
+    - `pl.stacked_violin` (need to be added)
+    - Heatmap of the mean expression values per cluster, using `pl.matrixplot`
+    - Hierarchically-clustered heatmap, using `pl.clustermap`
+    - `pl.ranking` 
+
+  2. Preprocessing
+    - Plot the fraction of counts assigned to each gene over all cells, using `pl.highest_expr_genes`
+    - Plot dispersions versus means for genes, using `pl.filter_genes_dispersion`
+    - `pl.highly_variable_genes` (need to be added)
+    - `pl.calculate_qc_metrics` (need to be added)
+  
+  3. PCA
+    - Scatter plot in PCA coordinates, using `pl.pca`
+    - Rank genes according to contributions to PCs, using `pl.pca_loadings`
+    - Scatter plot in PCA coordinates, using `pl.pca_variance_ratio`
+    - Plot PCA results, using `pl.pca_overview`
+  
+  4. Embeddings
+    - Scatter plot in tSNE basis, using `pl.tsne`
+    - Scatter plot in UMAP basis, using `pl.umap`
+    - Scatter plot in Diffusion Map basis, using `pl.diffmap`
+    - `pl.draw_graph` (need to be added)
+
+  5. Branching trajectories and pseudotime, clustering
+    - Plot groups and pseudotime, using `pl.dpt_groups_pseudotime`
+    - Heatmap of pseudotime series, using `pl.dpt_timeseries`
+    - Plot the abstracted graph through thresholding low-connectivity edges, using `pl.paga`
+    - `pl.paga_compare` (need to be added)
+    - `pl.paga_path` (need to be added)
+
+  6. Marker genes: 
+    - Plot ranking of genes using dotplot plot, using `pl.rank_gene_groups`
+    - `pl.rank_genes_groups_dotplot` (need to be added)
+    - `pl.rank_genes_groups_heatmap` (need to be added)
+    - `pl.rank_genes_groups_matrixplot` (need to be added)
+    - `pl.rank_genes_groups_stacked_violin` (need to be added)
+    - `pl.rank_genes_groups_violin` (need to be added)
+
+  7. Misc
+    - `pl.phate` (need to be added)
+    - `pl.matrix` (need to be added)
+    - `pl.paga_adjacency` (need to be added)
+    - `pl.timeseries` (need to be added)
+    - `pl.timeseries_as_heatmap` (need to be added)
+    - `pl.timeseries_subplot` (need to be added)
+    
+  
\ No newline at end of file
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/filter.xml	Mon Mar 04 10:15:02 2019 -0500
@@ -0,0 +1,549 @@
+<tool id="scanpy_filter" name="Filter with scanpy" version="@galaxy_version@">
+    <description></description>
+    <macros>
+        <import>macros.xml</import>
+    </macros>
+    <expand macro="requirements"/>
+    <expand macro="version_command"/>
+    <command detect_errors="exit_code"><![CDATA[
+@CMD@
+      ]]></command>
+    <configfiles>
+        <configfile name="script_file"><![CDATA[
+@CMD_imports@
+@CMD_read_inputs@
+
+#if $method.method == 'pp.filter_cells'
+res = sc.pp.filter_cells(
+    #if $modify_anndata.modify_anndata == 'true'
+    adata,
+    #else
+    adata.X,
+    #end if
+    #if $method.filter.filter == 'min_counts'
+    min_counts=$method.filter.min_counts,
+    #elif $method.filter.filter == 'max_counts'
+    max_counts=$method.filter.max_counts,
+    #elif $method.filter.filter == 'min_genes'
+    min_genes=$method.filter.min_genes,
+    #elif $method.filter.filter == 'max_genes'
+    max_genes=$method.filter.max_genes,
+    #end if
+    copy=False)
+
+    #if $modify_anndata.modify_anndata == 'true'
+df = adata.obs
+    #else
+df = pd.DataFrame(data=dict(cell_subset=res[0], number_per_cell=res[1]))
+    #end if
+
+    #if $method.filter.filter == 'min_counts' or $method.filter.filter == 'max_counts'
+df.to_csv('$counts_per_cell', sep='\t')
+    #elif $method.filter.filter == 'min_genes' or $method.filter.filter == 'max_genes'
+df.to_csv('$genes_per_cell', sep='\t')
+    #end if
+
+#elif $method.method == 'pp.filter_genes'
+res = sc.pp.filter_genes(
+    #if $modify_anndata.modify_anndata == 'true'
+    adata,
+    #else
+    adata.X,
+    #end if
+    #if $method.filter.filter == 'min_counts'
+    min_counts=$method.filter.min_counts,
+    #elif $method.filter.filter == 'max_counts'
+    max_counts=$method.filter.max_counts,
+    #elif $method.filter.filter == 'min_cells'
+    min_cells=$method.filter.min_cells,
+    #elif $method.filter.filter == 'max_cells'
+    max_cells=$method.filter.max_cells,
+    #end if
+    copy=False)
+
+    #if $modify_anndata.modify_anndata == 'true'
+df = adata.var
+    #else
+df = pd.DataFrame(data=dict(gene_subset=res[0], number_per_gene=res[1]))
+    #end if
+
+    #if $method.filter.filter == 'min_counts' or $method.filter.filter == 'max_counts'
+df.to_csv('$counts_per_gene', sep='\t')
+    #elif $method.filter.filter == 'min_cells' or $method.filter.filter == 'max_cells'
+df.to_csv('$cells_per_gene', sep='\t')
+    #end if
+
+#elif $method.method == 'pp.filter_genes_dispersion'
+res = sc.pp.filter_genes_dispersion(
+    #if $modify_anndata.modify_anndata == 'true'
+    adata,
+    #else
+    adata.X,
+    #end if
+    flavor='$method.flavor.flavor',
+    #if $method.flavor.flavor=='seurat'
+    min_mean=$method.flavor.min_mean,
+    max_mean=$method.flavor.max_mean,
+    min_disp=$method.flavor.min_disp,
+        #if $method.flavor.max_disp
+    max_disp=$method.flavor.max_disp,
+        #end if
+    #else
+    n_top_genes=$method.flavor.n_top_genes,
+    #end if
+    n_bins=$method.n_bins,
+    log=$method.log,
+    copy=False)
+
+    #if $modify_anndata.modify_anndata == 'true'
+adata.var.to_csv('$per_gene', sep='\t')
+    #else
+pd.DataFrame(res).to_csv('$per_gene', sep='\t')
+    #end if
+
+#elif $method.method == 'pp.subsample'
+sc.pp.subsample(
+    data=adata,
+    #if $method.type.type == 'fraction'
+    fraction=$method.type.fraction,
+    #else if $method.type.type == 'n_obs'
+    n_obs=$method.type.n_obs,
+    #end if
+    random_state=$method.random_state,
+    copy=False)
+
+#end if
+
+@CMD_anndata_write_modify_outputs@
+]]></configfile>
+    </configfiles>
+    <inputs>
+        <expand macro="inputs_anndata"/>
+        <conditional name="method">
+            <param argument="method" type="select" label="Method used for filtering">
+                <option value="pp.filter_cells">Filter cell outliers based on counts and numbers of genes expressed, using `pp.filter_cells`</option>
+                <option value="pp.filter_genes">Filter genes based on number of cells or counts, using `pp.filter_genes`</option>
+                <option value="pp.filter_genes_dispersion">Extract highly variable genes, using `pp.filter_genes_dispersion`</option>
+                <!--<option value="pp.highly_variable_genes">, using `tl.highly_variable_genes`</option>!-->
+                <option value="pp.subsample">Subsample to a fraction of the number of observations, using `pp.subsample`</option>
+                <!--<option value="queries.gene_coordinates">, using `queries.gene_coordinates`</option>!-->
+                <!--<option value="queries.mitochondrial_genes">, using `queries.mitochondrial_genes`</option>!-->
+            </param>
+            <when value="pp.filter_cells">
+                <conditional name="filter">
+                    <param argument="filter" type="select" label="Filter">
+                        <option value="min_counts">Minimum number of counts</option>
+                        <option value="max_counts">Maximum number of counts</option>
+                        <option value="min_genes">Minimum number of genes expressed</option>
+                        <option value="max_genes">Maximum number of genes expressed</option>
+                    </param>
+                    <when value="min_counts">
+                        <param argument="min_counts" type="integer" min="0" value="" label="Minimum number of counts required for a cell to pass filtering" help=""/>
+                    </when>
+                    <when value="max_counts">
+                        <param argument="max_counts" type="integer" min="0" value="" label="Maximum number of counts required for a cell to pass filtering" help=""/>
+                    </when>
+                    <when value="min_genes">
+                        <param argument="min_genes" type="integer" min="0" value="" label="Minimum number of genes expressed required for a cell to pass filtering" help=""/>
+                    </when>    
+                    <when value="max_genes">
+                        <param argument="max_genes" type="integer" min="0" value="" label="Maximum number of genes expressed required for a cell to pass filtering" help=""/>
+                    </when>
+                </conditional>
+            </when>
+            <when value="pp.filter_genes">
+                <conditional name="filter">
+                    <param argument="filter" type="select" label="Filter">
+                        <option value="min_counts">Minimum number of counts</option>
+                        <option value="max_counts">Maximum number of counts</option>
+                        <option value="min_cells">Minimum number of cells expressed</option>
+                        <option value="max_cells">Maximum number of cells expressed</option>
+                    </param>
+                    <when value="min_counts">
+                        <param argument="min_counts" type="integer" min="0" value="" label="Minimum number of counts required for a gene to pass filtering" help=""/>
+                    </when>
+                    <when value="max_counts">
+                        <param argument="max_counts" type="integer" min="0" value="" label="Maximum number of counts required for a gene to pass filtering" help=""/>
+                    </when>
+                    <when value="min_cells">
+                        <param argument="min_cells" type="integer" min="0" value="" label="Minimum number of cells expressed required for a gene to pass filtering" help=""/>
+                    </when>    
+                    <when value="max_cells">
+                        <param argument="max_cells" type="integer" min="0" value="" label="Maximum number of cells expressed required for a gene to pass filtering" help=""/>
+                    </when>
+                </conditional>
+            </when>
+            <when value="pp.filter_genes_dispersion">
+                <conditional name='flavor'>
+                    <param argument="flavor" type="select" label="Flavor for computing normalized dispersion" help="">
+                        <option value="seurat">seurat: expects non-logarithmized data</option>
+                        <option value="cell_ranger">cell_ranger: usually called for logarithmized data</option>
+                    </param>
+                    <when value="seurat">
+                        <param argument="min_mean" type="float" value="0.0125" label="Minimal mean cutoff" help=""/>
+                        <param argument="max_mean" type="float" value="3" label="Maximal mean cutoff" help=""/>
+                        <param argument="min_disp" type="float" value="0.5" label="Minimal normalized dispersion cutoff" help=""/>
+                        <param argument="max_disp" type="float" value="" optional="true" label="Maximal normalized dispersion cutoff" help=""/>
+                    </when>
+                    <when value="cell_ranger">
+                        <param argument="n_top_genes" type="integer" value="" label="Number of highly-variable genes to keep" help=""/>
+                    </when>
+                </conditional>
+                <param argument="n_bins" type="integer" value="20" label="Number of bins for binning the mean gene expression" help="Normalization is done with respect to each bin. If just a single gene falls into a bin, the normalized dispersion is artificially set to 1"/>
+                <expand macro="param_log"/>
+            </when>
+            <when value="pp.subsample">
+                <conditional name="type">
+                    <param name="type" type="select" label="Type of subsampling">
+                        <option value="fraction">By fraction</option>
+                        <option value="n_obs">By number of observation</option>
+                    </param>
+                    <when value="fraction">
+                        <param argument="fraction" type="float" value="" label="Subsample to this `fraction` of the number of observations" help=""/>
+                    </when>
+                    <when value="n_obs">
+                        <param argument="n_obs" type="integer" min="0" value="" label="Subsample to this number of observations" help=""/>
+                    </when>
+                </conditional>
+                <param argument="random_state" type="integer" value="0" label="Random seed to change subsampling" help=""/>
+            </when>
+        </conditional>
+        <expand macro="anndata_modify_output_input"/>
+    </inputs>
+    <outputs>
+        <expand macro="anndata_modify_outputs"/>
+        <!-- for pp.filter_cells -->
+        <data name="counts_per_cell" format="tabular" label="${tool.name} on ${on_string}: Counts per cells after filtering">
+            <filter>method['method'] == 'pp.filter_cells' and (method['filter']['filter'] == 'min_counts' or method['filter']['filter'] == 'max_counts')</filter>
+        </data>
+        <data name="genes_per_cell" format="tabular" label="${tool.name} on ${on_string}: Number of genes per cell after filtering">
+            <filter>method['method'] == 'pp.filter_cells' and (method['filter']['filter'] == 'min_genes' or method['filter']['filter'] == 'max_genes')</filter>
+        </data>
+        <!-- for pp.filter_genes -->
+        <data name="counts_per_gene" format="tabular" label="${tool.name} on ${on_string}: Counts per genes after filtering">
+            <filter>method['method'] == 'pp.filter_genes' and (method['filter']['filter'] == 'min_counts' or method['filter']['filter'] == 'max_counts')</filter>
+        </data>
+        <data name="cells_per_gene" format="tabular" label="${tool.name} on ${on_string}: Number of cells per genes after filtering">
+            <filter>method['method'] == 'pp.filter_genes' and (method['filter']['filter'] == 'min_cells' or method['filter']['filter'] == 'max_cells')</filter>
+        </data>
+        <!-- for pp.filter_genes_dispersion -->
+        <data name="per_gene" format="tabular" label="${tool.name} on ${on_string}: Means, dispersions and normalized dispersions per gene">
+            <filter>method['method'] == 'pp.filter_genes_dispersion'</filter>
+        </data>
+    </outputs>
+    <tests>
+        <test expect_num_outputs="2">
+            <conditional name="input">
+                <param name="format" value="h5ad" />
+                <param name="adata" value="krumsiek11.h5ad" />
+            </conditional>
+            <conditional name="method">
+                <param name="method" value="pp.filter_cells"/>
+                <conditional name="filter">
+                    <param name="filter" value="min_counts"/>
+                    <param name="min_counts" value="3"/>
+                </conditional>
+            </conditional>
+            <conditional name="modify_anndata">
+                <param name="modify_anndata" value="true"/>
+                <param name="anndata_output_format" value="h5ad" />
+            </conditional>
+            <assert_stdout>
+                <has_text_matching expression="sc.pp.filter_cells"/>
+                <has_text_matching expression="min_counts=3"/>
+            </assert_stdout>
+            <output name="anndata_out_h5ad" file="pp.filter_cells.krumsiek11-min_counts.h5ad" ftype="h5" compare="sim_size"/>
+            <output name="counts_per_cell">
+                <assert_contents>
+                    <has_text_matching expression="cell_type\tn_counts" />
+                    <has_text_matching expression="46\tprogenitor\t3.028" />
+                    <has_text_matching expression="85\tEry\t3.7001" />
+                    <has_text_matching expression="150\tMk\t4.095" />
+                    <has_n_columns n="3" />
+                </assert_contents>
+            </output>
+        </test>
+        <test expect_num_outputs="2">
+            <conditional name="input">
+                <param name="format" value="loom" />
+                <param name="adata" value="krumsiek11.loom" />
+                <param name="sparse" value="True"/>
+                <param name="cleanup" value="False"/>
+                <param name="x_name"  value="spliced"/>
+                <param name="obs_names" value="CellID" />
+                <param name="var_names" value="Gene"/>
+            </conditional>
+            <conditional name="method">
+                <param name="method" value="pp.filter_cells"/>
+                <conditional name="filter">
+                    <param name="filter" value="min_counts"/>
+                    <param name="min_counts" value="3"/>
+                </conditional>
+            </conditional>
+            <conditional name="modify_anndata">
+                <param name="modify_anndata" value="true"/>
+                <param name="anndata_output_format" value="loom" />
+            </conditional>
+            <assert_stdout>
+                <has_text_matching expression="sc.pp.filter_cells"/>
+                <has_text_matching expression="min_counts=3"/>
+            </assert_stdout>
+            <output name="anndata_out_loom" file="pp.filter_cells.krumsiek11-min_counts.loom" ftype="loom" compare="sim_size"/>
+            <output name="counts_per_cell">
+                <assert_contents>
+                    <has_text_matching expression="cell_type\tn_counts" />
+                    <has_text_matching expression="46\tprogenitor\t3.028" />
+                    <has_text_matching expression="85\tEry\t3.7001" />
+                    <has_text_matching expression="97\tMo\t3.925" />
+                    <has_text_matching expression="150\tMk\t4.095" />
+                    <has_n_columns n="3" />
+                </assert_contents>
+            </output>
+        </test>
+        <test expect_num_outputs="1">
+            <conditional name="input">
+                <param name="format" value="h5ad" />
+                <param name="adata" value="krumsiek11.h5ad"/>
+            </conditional>
+            <conditional name="method">
+                <param name="method" value="pp.filter_cells"/>
+                <conditional name="filter">
+                    <param name="filter" value="max_genes"/>
+                    <param name="max_genes" value="100"/>
+                </conditional>
+            </conditional>
+            <conditional name="modify_anndata">
+                <param name="modify_anndata" value="false"/>
+            </conditional>
+            <assert_stdout>
+                <has_text_matching expression="sc.pp.filter_cells"/>
+                <has_text_matching expression="adata.X"/>
+                <has_text_matching expression="max_genes=100"/>
+            </assert_stdout>
+            <output name="genes_per_cell" file="pp.filter_cells.number_per_cell.krumsiek11-max_genes.tabular"/>
+        </test>
+        <test expect_num_outputs="2">
+            <conditional name="input">
+                <param name="format" value="h5ad" />
+                <param name="adata" value="krumsiek11.h5ad" />
+            </conditional>
+            <conditional name="method">
+                <param name="method" value="pp.filter_genes"/>
+                <conditional name="filter">
+                    <param name="filter" value="min_counts"/>
+                    <param name="min_counts" value="3"/>
+                </conditional>
+            </conditional>
+            <conditional name="modify_anndata">
+                <param name="modify_anndata" value="true"/>
+                <param name="anndata_output_format" value="h5ad" />
+            </conditional>
+            <assert_stdout>
+                <has_text_matching expression="sc.pp.filter_genes"/>
+                <has_text_matching expression="min_counts=3"/>
+            </assert_stdout>
+            <output name="anndata_out_h5ad" file="pp.filter_genes.krumsiek11-min_counts.h5ad" ftype="h5" compare="sim_size"/>
+            <output name="counts_per_gene" file="pp.filter_genes.number_per_gene.krumsiek11-min_counts.tabular"/>
+        </test>
+        <test expect_num_outputs="1">
+            <conditional name="input">
+                <param name="format" value="h5ad" />
+                <param name="adata" value="pbmc68k_reduced.h5ad"/>
+            </conditional>
+            <conditional name="method">
+                <param name="method" value="pp.filter_genes"/>
+                <conditional name="filter">
+                    <param name="filter" value="max_cells"/>
+                    <param name="max_cells" value="500"/>
+                </conditional>
+            </conditional>
+            <conditional name="modify_anndata">
+                <param name="modify_anndata" value="false"/>
+            </conditional>
+            <assert_stdout>
+                <has_text_matching expression="sc.pp.filter_genes"/>
+                <has_text_matching expression="adata.X"/>
+                <has_text_matching expression="max_cells=500"/>
+            </assert_stdout>
+            <output name="cells_per_gene" file="pp.filter_genes.number_per_gene.pbmc68k_reduced-max_cells.tabular"/>
+        </test>
+        <test expect_num_outputs="2">
+            <conditional name="input">
+                <param name="format" value="h5ad" />
+                <param name="adata" value="krumsiek11.h5ad" />
+            </conditional>
+            <conditional name="method">
+                <param name="method" value="pp.filter_genes_dispersion"/>
+                <conditional name="flavor">
+                    <param name="flavor" value="seurat"/>
+                    <param name="min_mean" value="0.0125"/>
+                    <param name="max_mean" value="3"/>
+                    <param name="min_disp" value="0.5"/>
+                </conditional>
+                <param name="n_bins" value="20" />
+                <param name="log" value="true"/>
+            </conditional>
+            <conditional name="modify_anndata">
+                <param name="modify_anndata" value="true"/>
+                <param name="anndata_output_format" value="h5ad" />
+            </conditional>
+            <assert_stdout>
+                <has_text_matching expression="sc.pp.filter_genes_dispersion"/>
+                <has_text_matching expression="flavor='seurat'"/>
+                <has_text_matching expression="min_mean=0.0125"/>
+                <has_text_matching expression="max_mean=3.0"/>
+                <has_text_matching expression="min_disp=0.5"/>
+                <has_text_matching expression="n_bins=20"/>
+                <has_text_matching expression="log=True"/>
+            </assert_stdout>
+            <output name="anndata_out_h5ad" file="pp.filter_genes_dispersion.krumsiek11-seurat.h5ad" ftype="h5" compare="sim_size"/>
+            <output name="per_gene" file="pp.filter_genes_dispersion.per_gene.krumsiek11-seurat.tabular"/>
+        </test>
+        <test expect_num_outputs="1">
+            <conditional name="input">
+                <param name="format" value="h5ad" />
+                <param name="adata" value="krumsiek11.h5ad" />
+            </conditional>
+            <conditional name="method">
+                <param name="method" value="pp.filter_genes_dispersion"/>
+                <conditional name="flavor">
+                    <param name="flavor" value="cell_ranger"/>
+                    <param name="n_top_genes" value="2"/>
+                </conditional>
+                <param name="n_bins" value="20"/>
+                <param name="log" value="true"/>
+            </conditional>
+            <conditional name="modify_anndata">
+                <param name="modify_anndata" value="false"/>
+            </conditional>
+            <assert_stdout>
+                <has_text_matching expression="sc.pp.filter_genes_dispersion"/>
+                <has_text_matching expression="flavor='cell_ranger'"/>
+                <has_text_matching expression="n_top_genes=2"/>
+                <has_text_matching expression="n_bins=20"/>
+                <has_text_matching expression="og=True"/>
+            </assert_stdout>
+            <output name="per_gene" file="pp.filter_genes_dispersion.per_gene.krumsiek11-cell_ranger.tabular"/>
+        </test>
+        <test expect_num_outputs="1">
+            <conditional name="input">
+                <param name="format" value="h5ad" />
+                <param name="adata" value="krumsiek11.h5ad" />
+            </conditional>
+            <conditional name="method">
+                <param name="method" value="pp.subsample"/>
+                <conditional name="type">
+                    <param name="type" value="fraction" />
+                    <param name="fraction" value="0.5"/>
+                </conditional>
+                <param name="random_state" value="0"/>
+            </conditional>
+            <conditional name="modify_anndata">
+                <param name="modify_anndata" value="true"/>
+                <param name="anndata_output_format" value="h5ad" />
+            </conditional>
+            <assert_stdout>
+                <has_text_matching expression="sc.pp.subsample"/>
+                <has_text_matching expression="fraction=0.5"/>
+                <has_text_matching expression="random_state=0"/>
+            </assert_stdout>
+            <output name="anndata_out_h5ad" file="pp.subsample.krumsiek11_fraction.h5ad" ftype="h5" compare="sim_size"/>
+        </test>
+        <test expect_num_outputs="1">
+            <conditional name="input">
+                <param name="format" value="h5ad" />
+                <param name="adata" value="krumsiek11.h5ad" />
+            </conditional>
+            <conditional name="method">
+                <param name="method" value="pp.subsample"/>
+                <conditional name="type">
+                    <param name="type" value="n_obs" />
+                    <param name="n_obs" value="10"/>
+                </conditional>
+                <param name="random_state" value="0"/>
+            </conditional>
+            <conditional name="modify_anndata">
+                <param name="modify_anndata" value="true"/>
+                <param name="anndata_output_format" value="h5ad" />
+            </conditional>
+            <assert_stdout>
+                <has_text_matching expression="sc.pp.subsample"/>
+                <has_text_matching expression="n_obs=10"/>
+                <has_text_matching expression="random_state=0"/>
+            </assert_stdout>
+            <output name="anndata_out_h5ad" file="pp.subsample.krumsiek11_n_obs.h5ad" ftype="h5" compare="sim_size"/>
+        </test>
+    </tests>
+    <help><![CDATA[
+
+Filter cells outliers based on counts and numbers of genes expressed (`pp.filter_cells`)
+========================================================================================
+
+For instance, only keep cells with at least `min_counts` counts or
+`min_genes` genes expressed. This is to filter measurement outliers, i.e.,
+"unreliable" observations.
+
+Only provide one of the optional parameters `min_counts`, `min_genes`,
+`max_counts`, `max_genes` per call.
+
+More details on the `scanpy documentation
+<https://scanpy.readthedocs.io/en/latest/api/scanpy.api.pp.filter_cells.html#scanpy.api.pp.filter_cells>`__
+
+Return
+------
+
+number_per_cell : Number per cell (either `n_counts` or `n_genes` per cell)
+
+
+Filter genes based on number of cells or counts (`pp.filter_genes`)
+===================================================================
+
+Keep genes that have at least `min_counts` counts or are expressed in at
+least `min_cells` cells or have at most `max_counts` counts or are expressed
+in at most `max_cells` cells.
+
+Only provide one of the optional parameters `min_counts`, `min_cells`,
+`max_counts`, `max_cells` per call.
+
+More details on the `scanpy documentation
+<https://scanpy.readthedocs.io/en/latest/api/scanpy.api.pp.filter_genes.html#scanpy.api.pp.filter_genes>`__
+
+Return
+------
+
+number_per_gene : Number per genes (either `n_counts` or `n_genes` per cell)
+
+
+Extract highly variable genes (`pp.filter_genes_dispersion`)
+============================================================
+
+If trying out parameters, pass the data matrix instead of AnnData.
+
+Depending on `flavor`, this reproduces the R-implementations of Seurat and Cell Ranger.
+
+The normalized dispersion is obtained by scaling with the mean and standard
+deviation of the dispersions for genes falling into a given bin for mean
+expression of genes. This means that for each bin of mean expression, highly
+variable genes are selected.
+
+Use `flavor='cell_ranger'` with care and in the same way as in `pp.recipe_zheng17`.
+
+More details on the `scanpy documentation
+<https://scanpy.readthedocs.io/en/latest/api/scanpy.api.pp.filter_genes_dispersion.html#scanpy.api.pp.filter_genes_dispersion>`__
+
+Returns
+-------
+- The annotated matrix filtered, with the annotations
+- A table with the means, dispersions, and normalized dispersions per gene, logarithmized when `log` is `True`.
+
+
+Subsample to a fraction of the number of observations (`pp.subsample`)
+======================================================================
+
+More details on the `scanpy documentation
+<https://scanpy.readthedocs.io/en/latest/api/scanpy.api.pp.subsample.html#scanpy.api.pp.subsample>`__
+
+
+    ]]></help>
+    <expand macro="citations"/>
+</tool>
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/macros.xml	Mon Mar 04 10:15:02 2019 -0500
@@ -0,0 +1,1084 @@
+<macros>
+    <token name="@version@">1.4</token>
+    <token name="@galaxy_version@"><![CDATA[@version@+galaxy0]]></token>
+    <xml name="requirements">
+        <requirements>
+            <requirement type="package" version="@version@">scanpy</requirement>
+            <requirement type="package" version="2.0.17">loompy</requirement>
+            <yield />
+        </requirements>
+    </xml>
+    <xml name="citations">
+        <citations>
+            <citation type="doi">10.1186/s13059-017-1382-0</citation>
+        </citations>
+    </xml>
+    <xml name="version_command">
+        <version_command><![CDATA[python -c "import scanpy.api as sc;print('scanpy version: %s' % sc.__version__)"]]></version_command>
+    </xml>
+    <token name="@CMD@"><![CDATA[
+cat '$script_file' &&
+python '$script_file'
+    ]]>
+    </token>
+    <token name="@CMD_imports@"><![CDATA[
+import scanpy.api as sc
+import pandas as pd
+import numpy as np
+    ]]>
+    </token>
+    <xml name="inputs_anndata">
+        <conditional name="input">
+            <param name="format" type="select" label="Format for the annotated data matrix">
+                <option value="loom">loom</option>
+                <option value="h5ad">h5ad-formatted hdf5 (anndata)</option>
+            </param>
+            <when value="loom">
+                <param name="adata" type="data" format="loom" label="Annotated data matrix"/>
+                <param name="sparse" type="boolean" truevalue="True" falsevalue="False" checked="true" label="Is the data matrix to read sparse?"/>
+                <param name="cleanup" type="boolean" truevalue="True" falsevalue="False" checked="false" label="Cleanup?"/>
+                <param name="x_name" type="text" value="spliced" label="X_name"/>
+                <param name="obs_names" type="text" value="CellID" label="obs_names"/>
+                <param name="var_names" type="text" value="Gene" label="var_names"/>
+            </when>
+            <when value="h5ad">
+                <param name="adata" type="data" format="h5" label="Annotated data matrix"/>
+            </when>
+        </conditional>
+    </xml>
+    <token name="@CMD_read_inputs@"><![CDATA[
+#if $input.format == 'loom'
+adata = sc.read_loom(
+    '$input.adata',
+    sparse=$input.sparse,
+    cleanup=$input.cleanup,
+    X_name='$input.x_name',
+    obs_names='$input.obs_names',
+    var_names='$input.var_names')
+#else if $input.format == 'h5ad'
+adata = sc.read_h5ad('$input.adata')
+#end if
+]]>
+    </token>
+    <xml name="anndata_output_format">
+        <param name="anndata_output_format" type="select" label="Format to write the annotated data matrix">
+            <option value="loom">loom</option>
+            <option value="h5ad">h5ad-formatted hdf5 (anndata)</option>
+        </param>
+    </xml>
+    <xml name="anndata_modify_output_input">
+        <conditional name="modify_anndata">
+            <param name="modify_anndata" type="select" label="Return modify annotate data matrix?">
+                <option value="true">Yes</option>
+                <option value="false">No</option>
+            </param>
+            <when value="true">
+                <expand macro="anndata_output_format"/>
+            </when>
+            <when value="false"/>
+        </conditional>
+    </xml>
+    <xml name="anndata_outputs">
+        <data name="anndata_out_h5ad" format="h5" from_work_dir="anndata.h5ad" label="${tool.name} on ${on_string}: Annotated data matrix">
+            <filter>anndata_output_format == 'h5ad'</filter>
+        </data>
+        <data name="anndata_out_loom" format="loom" from_work_dir="anndata.loom" label="${tool.name} on ${on_string}: Annotated data matrix">
+            <filter>anndata_output_format == 'loom'</filter>
+        </data>
+    </xml>
+    <xml name="anndata_modify_outputs">
+        <data name="anndata_out_h5ad" format="h5" from_work_dir="anndata.h5ad" label="${tool.name} on ${on_string}: Annotated data matrix">
+            <filter>modify_anndata['modify_anndata'] == 'true' and modify_anndata['anndata_output_format'] == 'h5ad'</filter>
+        </data>
+        <data name="anndata_out_loom" format="loom" from_work_dir="anndata.loom" label="${tool.name} on ${on_string}: Annotated data matrix">
+            <filter>modify_anndata['modify_anndata'] == 'true' and modify_anndata['anndata_output_format'] == 'loom'</filter>
+        </data>
+    </xml>
+    <token name="@CMD_anndata_write_outputs@"><![CDATA[
+#if $anndata_output_format == 'loom'
+adata.write_loom('anndata.loom')
+#else if $anndata_output_format == 'h5ad'
+adata.write('anndata.h5ad')
+#end if
+]]>
+    </token>
+    <token name="@CMD_anndata_write_modify_outputs@"><![CDATA[
+#if $modify_anndata.modify_anndata == 'true'
+    #if $modify_anndata.anndata_output_format == 'loom'
+adata.write_loom('anndata.loom')
+    #elif $modify_anndata.anndata_output_format == 'h5ad'
+adata.write('anndata.h5ad')
+    #end if
+#end if
+]]>
+    </token>
+    <xml name="svd_solver">
+        <param name="svd_solver" type="select" label="SVD solver to use" help="">
+            <option value="auto">Automatically chosen depending on the size of the problem</option>
+            <option value="arpack">ARPACK wrapper in SciPy</option>
+            <option value="randomized">Randomized algorithm due to Halko (2009)</option>
+        </param>
+    </xml>
+    <xml name="pca_random_state">
+        <param name="random_state" type="integer" value="0" label="Initial states for the optimization" help=""/>
+    </xml>
+    <xml name="param_plot_format">
+        <param name="format" type="select" label="Format for saving figures">
+            <option value="png">png</option>
+            <option value="pdf">pdf</option>
+            <option value="svg">svg</option>
+        </param>
+    </xml>
+    <xml name="numeric_distance_metric_options">
+        <option value="braycurtis">braycurtis</option>
+        <option value="canberra">canberra</option>
+        <option value="chebyshev">chebyshev</option>
+        <option value="cityblock">cityblock</option>
+        <option value="correlation">correlation</option>
+        <option value="cosine">cosine</option>
+        <option value="euclidean" selected="true">euclidean</option>
+        <option value="mahalanobis">mahalanobis</option>
+        <option value="matching">matching</option>
+        <option value="minkowski">minkowski</option>
+        <option value="seuclidean">seuclidean</option>
+        <option value="sqeuclidean">sqeuclidean</option>
+        <option value="wminkowski">wminkowski</option>
+    </xml>
+    <xml name="boolean_distance_metric_options">
+        <option value="dice">dice</option>
+        <option value="hamming">hamming</option>
+        <option value="jaccard">jaccard</option>
+        <option value="kulsinski">kulsinski</option>
+        <option value="rogerstanimoto">rogerstanimoto</option>
+        <option value="russellrao">russellrao</option>
+        <option value="sokalmichener">sokalmichener</option>
+        <option value="sokalsneath">sokalsneath</option>
+        <option value="yule">yule</option>
+    </xml>
+    <xml name="distance_metric_options">
+        <expand macro="numeric_distance_metric_options"/>
+        <expand macro="boolean_distance_metric_options"/>
+    </xml>
+    <xml name="seaborn_color_palette_options">
+        <option value="Accent">Accent</option>
+        <option value="Accent_r">Accent_r</option>
+        <option value="Blues">Blues</option>
+        <option value="Blues_r">Blues_r</option>
+        <option value="BrBG">BrBG</option>
+        <option value="BrBG_r">BrBG_r</option>
+        <option value="BuGn">BuGn</option>
+        <option value="BuGn_r">BuGn_r</option>
+        <option value="BuPu">BuPu</option>
+        <option value="BuPu_r">BuPu_r</option>
+        <option value="CMRmap">CMRmap</option>
+        <option value="CMRmap_r">CMRmap_r</option>
+        <option value="Dark2">Dark2</option>
+        <option value="Dark2_r">Dark2_r</option>
+        <option value="GnBu">GnBu</option>
+        <option value="GnBu_r">GnBu_r</option>
+        <option value="Greens">Greens</option>
+        <option value="Greens_r">Greens_r</option>
+        <option value="Greys">Greys</option>
+        <option value="Greys_r">Greys_r</option>
+        <option value="OrRd">OrRd</option>
+        <option value="OrRd_r">OrRd_r</option>
+        <option value="Oranges">Oranges</option>
+        <option value="Oranges_r">Oranges_r</option>
+        <option value="PRGn">PRGn</option>
+        <option value="PRGn_r">PRGn_r</option>
+        <option value="Paired">Paired</option>
+        <option value="Paired_r">Paired_r</option>
+        <option value="Pastel1">Pastel1</option>
+        <option value="Pastel1_r">Pastel1_r</option>
+        <option value="Pastel2">Pastel2</option>
+        <option value="Pastel2_r">Pastel2_r</option>
+        <option value="PiYG">PiYG</option>
+        <option value="PiYG_r">PiYG_r</option>
+        <option value="PuBu">PuBu</option>
+        <option value="PuBuGn">PuBuGn</option>
+        <option value="PuBuGn_r">PuBuGn_r</option>
+        <option value="PuBu_r">PuBu_r</option>
+        <option value="PuOr">PuOr</option>
+        <option value="PuOr_r">PuOr_r</option>
+        <option value="PuRd">PuRd</option>
+        <option value="PuRd_r">PuRd_r</option>
+        <option value="Purples">Purples</option>
+        <option value="Purples_r">Purples_r</option>
+        <option value="RdBu">RdBu</option>
+        <option value="RdBu_r">RdBu_r</option>
+        <option value="RdGy">RdGy</option>
+        <option value="RdPu">RdPu</option>
+        <option value="RdPu_r">RdPu_r</option>
+        <option value="RdYlBu">RdYlBu</option>
+        <option value="RdYlBu_r">RdYlBu_r</option>
+        <option value="RdYlGn">RdYlGn</option>
+        <option value="RdYlGn_r">RdYlGn_r</option>
+        <option value="Reds">Reds</option>
+        <option value="Reds_r">Reds_r</option>
+        <option value="Set1">Set1</option>
+        <option value="Set1_r">Set1_r</option>
+        <option value="Set2">Set2</option>
+        <option value="Set2_r">Set2_r</option>
+        <option value="Set3">Set3</option>
+        <option value="Set3_r">Set3_r</option>
+        <option value="Spectral">Spectral</option>
+        <option value="Spectral_r">Spectral_r</option>
+        <option value="Wistia">Wistia</option>
+        <option value="Wistia_r">Wistia_r</option>
+        <option value="YlGn">YlGn</option>
+        <option value="YlGn_r">YlGn_r</option>
+        <option value="YlGnBu">YlGnBu</option>
+        <option value="YlGnBu_r">YlGnBu_r</option>
+        <option value="YlOrBr">YlOrBr</option>
+        <option value="YlOrBr_r">YlOrBr_r</option>
+        <option value="YlOrRd">YlOrRd</option>
+        <option value="YlOrRd_r">YlOrRd_r</option>
+        <option value="afmhot">afmhot</option>
+        <option value="afmhot_r">afmhot_r</option>
+        <option value="autumn">autumn</option>
+        <option value="autumn_r">autumn_r</option>
+        <option value="binary">binary</option>
+        <option value="binary_r">binary_r</option>
+        <option value="bone">bone</option>
+        <option value="bone_r">bone_r</option>
+        <option value="brg">brg</option>
+        <option value="brg_r">brg_r</option>
+        <option value="bwr">bwr</option>
+        <option value="bwr_r">bwr_r</option>
+        <option value="cividis">cividis</option>
+        <option value="cividis_r">cividis_r</option>
+        <option value="cool">cool</option>
+        <option value="cool_r">cool_r</option>
+        <option value="coolwarm">coolwarm</option>
+        <option value="coolwarm_r">coolwarm_r</option>
+        <option value="copper">copper</option>
+        <option value="copper_r">copper_r</option>
+        <option value="cubehelix">cubehelix</option>
+        <option value="cubehelix_r">cubehelix_r</option>
+        <option value="flag">flag</option>
+        <option value="flag_r">flag_r</option>
+        <option value="gist_earth">gist_earth</option>
+        <option value="gist_earth_r">gist_earth_r</option>
+        <option value="gist_gray">gist_gray</option>
+        <option value="gist_gray_r">gist_gray_r</option>
+        <option value="gist_heat">gist_heat</option>
+        <option value="gist_heat_r">gist_heat_r</option>
+        <option value="gist_ncar">gist_ncar</option>
+        <option value="gist_ncar_r">gist_ncar_r</option>
+        <option value="gist_rainbow">gist_rainbow</option>
+        <option value="gist_rainbow_r">gist_rainbow_r</option>
+        <option value="gist_stern">gist_stern</option>
+        <option value="gist_stern_r">gist_stern_r</option>
+        <option value="gist_yarg">gist_yarg</option>
+        <option value="gist_yarg_r">gist_yarg_r</option>
+        <option value="gnuplot">gnuplot</option>
+        <option value="gnuplot_r">gnuplot_r</option>
+        <option value="gnuplot2">gnuplot2</option>
+        <option value="gnuplot2_r">gnuplot2_r</option>
+        <option value="gray">gray</option>
+        <option value="gray_r">gray_r</option>
+        <option value="hot">hot</option>
+        <option value="hot_r">hot_r</option>
+        <option value="hsv">hsv</option>
+        <option value="hsv_r">hsv_r</option>
+        <option value="icefire">icefire</option>
+        <option value="icefire_r">icefire_r</option>
+        <option value="inferno">inferno</option>
+        <option value="inferno_r">inferno_r</option>
+        <option value="jet">jet</option>
+        <option value="jet_r">jet_r</option>
+        <option value="magma">magma</option>
+        <option value="magma_r">magma_r</option>
+        <option value="mako">mako</option>
+        <option value="mako_r">mako_r</option>
+        <option value="nipy_spectral">nipy_spectral</option>
+        <option value="nipy_spectral_r">nipy_spectral_r</option>
+        <option value="ocean">ocean</option>
+        <option value="ocean_r">ocean_r</option>
+        <option value="pink">pink</option>
+        <option value="pink_r">pink_r</option>
+        <option value="plasma">plasma</option>
+        <option value="plasma_r">plasma_r</option>
+        <option value="prism">prism</option>
+        <option value="prism_r">prism_r</option>
+        <option value="rainbow">rainbow</option>
+        <option value="rainbow_r">rainbow_r</option>
+        <option value="rocket">rocket</option>
+        <option value="rocket_r">rocket_r</option>
+        <option value="seismic">seismic</option>
+        <option value="seismic_r">seismic_r</option>
+        <option value="spring">spring</option>
+        <option value="spring_r">spring_r</option>
+        <option value="summer">summer</option>
+        <option value="summer_r">summer_r</option>
+        <option value="tab10">tab10</option>
+        <option value="tab10_r">tab10_r</option>
+        <option value="tab20">tab20</option>
+        <option value="tab20_r">tab20_r</option>
+        <option value="tab20b">tab20b</option>
+        <option value="tab20b_r">tab20b_r</option>
+        <option value="tab20c">tab20c</option>
+        <option value="tab20c_r">tab20c_r</option>
+        <option value="terrain">terrain</option>
+        <option value="terrain_r">terrain_r</option>
+        <option value="twilight">twilight</option>
+        <option value="twilight_r">twilight_r</option>
+        <option value="twilight_shifted">twilight_shifted</option>
+        <option value="twilight_shifted_r">twilight_shifted_r</option>
+        <option value="viridis">viridis</option>
+        <option value="viridis_r">viridis_r</option>
+        <option value="vlag">vlag</option>
+        <option value="vlag_r">vlag_r</option>
+        <option value="winter">winter</option>
+        <option value="winter_r">winter_r</option>
+    </xml>
+    <xml name="matplotlib_pyplot_colormap">
+        <option value="viridis">viridis (Perceptually Uniform Sequential)</option>
+        <option value="plasma">plasma (Perceptually Uniform Sequential)</option>
+        <option value="inferno">inferno (Perceptually Uniform Sequential)</option>
+        <option value="magma">magma (Perceptually Uniform Sequential)</option>
+        <option value="cividis">cividis (Perceptually Uniform Sequential)</option>
+        <option value="Greys">Greys (Sequential)</option>
+        <option value="Purples">Purples (Sequential)</option>
+        <option value="Blues">Blues (Sequential)</option>
+        <option value="Greens">Greens (Sequential)</option>
+        <option value="Oranges">Oranges (Sequential)</option>
+        <option value="Reds">Reds (Sequential)</option>
+        <option value="YlOrBr">YlOrBr (Sequential)</option>
+        <option value="YlOrRd">YlOrRd (Sequential)</option>
+        <option value="OrRd">OrRd (Sequential)</option>
+        <option value="PuRd">PuRd (Sequential)</option>
+        <option value="RdPu">RdPu (Sequential)</option>
+        <option value="BuPu">BuPu (Sequential)</option>
+        <option value="GnBu">GnBu (Sequential)</option>
+        <option value="PuBu">PuBu (Sequential)</option>
+        <option value="YlGnBu">YlGnBu (Sequential)</option>
+        <option value="PuBuGn">PuBuGn (Sequential)</option>
+        <option value="BuGn">BuGn (Sequential)</option>
+        <option value="YlGn">YlGn (Sequential)</option>
+        <option value="binary">binary (Sequential 2)</option>
+        <option value="gist_yarg">gist_yarg (Sequential 2)</option>
+        <option value="gist_gray">gist_gray (Sequential 2)</option>
+        <option value="gray">gray (Sequential 2)</option>
+        <option value="bone">bone (Sequential 2)</option>
+        <option value="pink">pink (Sequential 2)</option>
+        <option value="spring">spring (Sequential 2)</option>
+        <option value="summer">summer (Sequential 2)</option>
+        <option value="autumn">autumn (Sequential 2)</option>
+        <option value="winter">winter (Sequential 2)</option>
+        <option value="cool">cool (Sequential 2)</option>
+        <option value="Wistia">Wistia (Sequential 2)</option>
+        <option value="hot">hot (Sequential 2)</option>
+        <option value="afmhot">afmhot (Sequential 2)</option>
+        <option value="gist_heat">gist_heat (Sequential 2)</option>
+        <option value="copper">copper (Sequential 2)</option>
+        <option value="PiYG">PiYG (Diverging)</option>
+        <option value="PRGn">PRGn (Diverging)</option>
+        <option value="BrBG">BrBG (Diverging)</option>
+        <option value="PuOr">PuOr (Diverging)</option>
+        <option value="RdGy">RdGy (Diverging)</option>
+        <option value="RdBu">RdBu (Diverging)</option>
+        <option value="RdYlBu">RdYlBu (Diverging)</option>
+        <option value="RdYlGn">RdYlGn (Diverging)</option>
+        <option value="Spectral">Spectral (Diverging)</option>
+        <option value="coolwarm">coolwarm (Diverging)</option>
+        <option value="bwr">bwr (Diverging)</option>
+        <option value="seismic">seismic (Diverging)</option>
+        <option value="twilight">twilight (Cyclic)</option>
+        <option value="twilight_shifted">twilight_shifted (Cyclic)</option>
+        <option value="hsv">hsv (Cyclic)</option>
+        <option value="Pastel1">Pastel1 (Qualitative)</option>
+        <option value="Pastel2">Pastel2 (Qualitative)</option>
+        <option value="Paired">Paired (Qualitative)</option>
+        <option value="Accent">Accent (Qualitative)</option>
+        <option value="Dark2">Dark2 (Qualitative)</option>
+        <option value="Set1">Set1 (Qualitative)</option>
+        <option value="Set2">Set2 (Qualitative)</option>
+        <option value="Set3">Set3 (Qualitative)</option>
+        <option value="tab10">tab10 (Qualitative)</option>
+        <option value="tab20">tab20 (Qualitative)</option>
+        <option value="tab20b">tab20b (Qualitative)</option>
+        <option value="tab20c">tab20c (Qualitative)</option>
+        <option value="flag">flag (Miscellaneous)</option>
+        <option value="prism">prism (Miscellaneous)</option>
+        <option value="ocean">ocean (Miscellaneous)</option>
+        <option value="gist_earth">gist_earth (Miscellaneous)</option>
+        <option value="terrain">terrain (Miscellaneous)</option>
+        <option value="gist_stern">gist_stern (Miscellaneous)</option>
+        <option value="gnuplot">gnuplot (Miscellaneous)</option>
+        <option value="gnuplot2">gnuplot2 (Miscellaneous)</option>
+        <option value="CMRmap">CMRmap (Miscellaneous)</option>
+        <option value="cubehelix">cubehelix (Miscellaneous)</option>
+        <option value="brg">brg (Miscellaneous)</option>
+        <option value="gist_rainbow">gist_rainbow (Miscellaneous)</option>
+        <option value="rainbow">rainbow (Miscellaneous)</option>
+        <option value="jet">jet (Miscellaneous)</option>
+        <option value="nipy_spectral">nipy_spectral (Miscellaneous)</option>
+        <option value="gist_ncar">gist_ncar (Miscellaneous)</option>
+    </xml>
+    <xml name="param_groupby">
+        <param argument="groupby" type="text" value="" optional="true" label="The key of the observation grouping to consider" help="If it is given, the heatmap is ordered by the respective group. It is expected that to be a categorical. If it is not a categorical observation, it would be subdivided into `num_categories`."/>
+    </xml>
+    <xml name="param_use_raw">
+        <param argument="use_raw" type="boolean" truevalue="True" falsevalue="False" checked="false" label="Use `raw` attribute of input if present" help=""/>
+    </xml>
+    <xml name="param_log">
+        <param argument="log" type="boolean" truevalue="True" falsevalue="False" checked="false" label="Use the log of the values?" help=""/>
+    </xml>
+    <xml name="pl_figsize">
+        <conditional name="figsize">
+            <param name="test" type="select" label="Custom figure size" >
+                <option value="yes">Yes</option>
+                <option value="no" selected="true">No: the figure width is set based on the number of variable names and the height is set to 10.</option>
+            </param>
+            <when value="yes">
+                <param argument="width" type="integer" min="0" value="10" label="Figure width" help=""/>
+                <param argument="height" type="integer" min="0" value="10" label="Figure height" help=""/>
+            </when>
+            <when value="no"/>
+        </conditional>
+    </xml>
+    <token name="@CMD_params_figsize@"><![CDATA[
+
+    ]]></token>
+    <xml name="pl_var_names">
+        <conditional name="var_names">
+            <param name="type" type="select" label="Variables to plot (columns of the heatmaps)" >
+                <option value="all">All variables in `adata.var_names`</option>
+                <option value="custom">Subset of variables in `adata.var_names`</option>
+            </param>
+            <when value="all"/>
+            <when value="custom">
+                <param argument="var_names" type="text" value="" label="List of variables to plot" help="They should be a valid subset of `adata.var_names`, and separated by comma"/>
+            </when>
+        </conditional>
+    </xml>
+    <xml name="param_num_categories">
+        <param argument="num_categories" type="integer" min="0" value="7" label="Number of categories" help="It is only used if groupby observation is not categorical. This value determines the number of groups into which the groupby observation should be subdivided."/>
+    </xml>
+    <xml name="param_dendrogram">
+        <param argument="dendrogram" type="boolean" truevalue="True" falsevalue="False" checked="false" label="Compute and plot a dendrogram?" help="groupby categories are reordered accoring to the dendrogram order. If groups of var_names are set and those groups correspond to the groupby categories, those groups are also reordered. The ‘person’ method is used to compute the pairwise correlation between categories using all var_names in raw if use_raw is None, otherwise all adata.var_names are used. The linkage method used is complete."/>
+    </xml>
+    <xml name="pl_var_group_positions">
+        <repeat name="var_group_positions" title="Group of variables to highlight" help="This will draw a 'bracket' on top of the plot between the given start and end positions. If a label is given, it will be added on top of the bracket. ">
+            <param name="start" type="integer" min="0" value="" label="Start" help=""/>
+            <param name="end" type="integer" min="0" value="" label="End" help=""/>
+            <param argument="label" type="text" value="" label="Label" help=""/>
+        </repeat>
+    </xml>
+    <xml name="param_var_group_rotation">
+        <param argument="var_group_rotation" type="float" value="" optional="true" label="Label rotation degrees" help="By default, labels larger than 4 characters are rotated 90 degrees"/>
+    </xml>
+    <xml name="param_layer">
+        <param argument="layer" type="text" value="" label="Name of the AnnData object layer that wants to be plotted" help="By default `adata.raw.X` is plotted. If `use_raw=False` is set, then `adata.X` is plotted. If layer is set to a valid layer name, then the layer is plotted. layer takes precedence over `use_raw`."/>
+    </xml>
+    <token name="@CMD_param_plot_inputs@"><![CDATA[
+    adata=adata,
+    save='.$format',
+    show=False,
+    ]]></token>
+    <xml name="params_plots">
+        <expand macro="pl_var_names"/>
+        <expand macro="param_groupby"/>
+        <expand macro="param_log"/>
+        <expand macro="param_use_raw"/>
+        <expand macro="param_num_categories"/>
+        <expand macro="param_dendrogram"/>
+        <expand macro="pl_var_group_positions"/>
+        <expand macro="param_var_group_rotation"/>
+        <expand macro="pl_figsize"/>
+        <expand macro="param_layer"/>
+    </xml>
+    <token name="@CMD_params_plots@"><![CDATA[
+#if $method.var_names.type == 'all'
+    var_names=adata.var_names,
+#else
+    #set $var_names = ([x.strip() for x in str($method.var_names.var_names).split(',')])
+    var_names=$var_names,
+#end if
+#if str($method.groupby) != ''
+    groupby='$method.groupby',
+#end if
+    log=$method.log,
+    use_raw=$method.use_raw,
+    num_categories=$method.num_categories,
+    dendrogram=$method.dendrogram,
+    #if len($method.var_group_positions) > 0:
+        #set $var_group_positions=[]
+        #set $var_group_labels=[]
+        #for $i, $s in enumerate($method.var_group_positions)
+            #silent $var_group_positions.append((int($s.start), int($s.end)))
+            #silent $var_group_labels.append(str($s.label))
+        #end for
+    var_group_positions=$var_group_positions,
+    var_group_labels=$var_group_labels,
+    #else
+    var_group_positions=None,
+    var_group_labels=None,
+    #end if
+#if $method.var_group_rotation
+    var_group_rotation=$method.var_group_rotation,
+#end if
+#if $method.figsize.test == 'yes'
+    figsize=($method.figsize.width, $method.figsize.height),
+#end if
+#if $method.layer != ''
+    layer='$method.layer',
+#end if
+    ]]></token>
+    <xml name="matplotlib_color">
+        <option value="AliceBlue">AliceBlue</option>
+        <option value="AntiqueWhite">AntiqueWhite</option>
+        <option value="Aqua">Aqua</option>
+        <option value="Aquamarine">Aquamarine</option>
+        <option value="Azure">Azure</option>
+        <option value="Beige">Beige</option>
+        <option value="Bisque">Bisque</option>
+        <option value="Black">Black</option>
+        <option value="BlanchedAlmond">BlanchedAlmond</option>
+        <option value="Blue">Blue</option>
+        <option value="BlueViolet">BlueViolet</option>
+        <option value="Brown">Brown</option>
+        <option value="BurlyWood">BurlyWood</option>
+        <option value="CadetBlue">CadetBlue</option>
+        <option value="Chartreuse">Chartreuse</option>
+        <option value="Chocolate">Chocolate</option>
+        <option value="Coral">Coral</option>
+        <option value="CornflowerBlue">CornflowerBlue</option>
+        <option value="Cornsilk">Cornsilk</option>
+        <option value="Crimson">Crimson</option>
+        <option value="Cyan">Cyan</option>
+        <option value="DarkBlue">DarkBlue</option>
+        <option value="DarkCyan">DarkCyan</option>
+        <option value="DarkGoldenRod">DarkGoldenRod</option>
+        <option value="DarkGray">DarkGray</option>
+        <option value="DarkGrey">DarkGrey</option>
+        <option value="DarkGreen">DarkGreen</option>
+        <option value="DarkKhaki">DarkKhaki</option>
+        <option value="DarkMagenta">DarkMagenta</option>
+        <option value="DarkOliveGreen">DarkOliveGreen</option>
+        <option value="DarkOrange">DarkOrange</option>
+        <option value="DarkOrchid">DarkOrchid</option>
+        <option value="DarkRed">DarkRed</option>
+        <option value="DarkSalmon">DarkSalmon</option>
+        <option value="DarkSeaGreen">DarkSeaGreen</option>
+        <option value="DarkSlateBlue">DarkSlateBlue</option>
+        <option value="DarkSlateGray">DarkSlateGray</option>
+        <option value="DarkSlateGrey">DarkSlateGrey</option>
+        <option value="DarkTurquoise">DarkTurquoise</option>
+        <option value="DarkViolet">DarkViolet</option>
+        <option value="DeepPink">DeepPink</option>
+        <option value="DeepSkyBlue">DeepSkyBlue</option>
+        <option value="DimGray">DimGray</option>
+        <option value="DimGrey">DimGrey</option>
+        <option value="DodgerBlue">DodgerBlue</option>
+        <option value="FireBrick">FireBrick</option>
+        <option value="FloralWhite">FloralWhite</option>
+        <option value="ForestGreen">ForestGreen</option>
+        <option value="Fuchsia">Fuchsia</option>
+        <option value="Gainsboro">Gainsboro</option>
+        <option value="GhostWhite">GhostWhite</option>
+        <option value="Gold">Gold</option>
+        <option value="GoldenRod">GoldenRod</option>
+        <option value="Gray">Gray</option>
+        <option value="Grey">Grey</option>
+        <option value="Green">Green</option>
+        <option value="GreenYellow">GreenYellow</option>
+        <option value="HoneyDew">HoneyDew</option>
+        <option value="HotPink">HotPink</option>
+        <option value="IndianRed">IndianRed</option>
+        <option value="Indigo">Indigo</option>
+        <option value="Ivory">Ivory</option>
+        <option value="Khaki">Khaki</option>
+        <option value="Lavender">Lavender</option>
+        <option value="LavenderBlush">LavenderBlush</option>
+        <option value="LawnGreen">LawnGreen</option>
+        <option value="LemonChiffon">LemonChiffon</option>
+        <option value="LightBlue">LightBlue</option>
+        <option value="LightCoral">LightCoral</option>
+        <option value="LightCyan">LightCyan</option>
+        <option value="LightGoldenRodYellow">LightGoldenRodYellow</option>
+        <option value="LightGray">LightGray</option>
+        <option value="LightGrey">LightGrey</option>
+        <option value="LightGreen">LightGreen</option>
+        <option value="LightPink">LightPink</option>
+        <option value="LightSalmon">LightSalmon</option>
+        <option value="LightSeaGreen">LightSeaGreen</option>
+        <option value="LightSkyBlue">LightSkyBlue</option>
+        <option value="LightSlateGray">LightSlateGray</option>
+        <option value="LightSlateGrey">LightSlateGrey</option>
+        <option value="LightSteelBlue">LightSteelBlue</option>
+        <option value="LightYellow">LightYellow</option>
+        <option value="Lime">Lime</option>
+        <option value="LimeGreen">LimeGreen</option>
+        <option value="Linen">Linen</option>
+        <option value="Magenta">Magenta</option>
+        <option value="Maroon">Maroon</option>
+        <option value="MediumAquaMarine">MediumAquaMarine</option>
+        <option value="MediumBlue">MediumBlue</option>
+        <option value="MediumOrchid">MediumOrchid</option>
+        <option value="MediumPurple">MediumPurple</option>
+        <option value="MediumSeaGreen">MediumSeaGreen</option>
+        <option value="MediumSlateBlue">MediumSlateBlue</option>
+        <option value="MediumSpringGreen">MediumSpringGreen</option>
+        <option value="MediumTurquoise">MediumTurquoise</option>
+        <option value="MediumVioletRed">MediumVioletRed</option>
+        <option value="MidnightBlue">MidnightBlue</option>
+        <option value="MintCream">MintCream</option>
+        <option value="MistyRose">MistyRose</option>
+        <option value="Moccasin">Moccasin</option>
+        <option value="NavajoWhite">NavajoWhite</option>
+        <option value="Navy">Navy</option>
+        <option value="OldLace">OldLace</option>
+        <option value="Olive">Olive</option>
+        <option value="OliveDrab">OliveDrab</option>
+        <option value="Orange">Orange</option>
+        <option value="OrangeRed">OrangeRed</option>
+        <option value="Orchid">Orchid</option>
+        <option value="PaleGoldenRod">PaleGoldenRod</option>
+        <option value="PaleGreen">PaleGreen</option>
+        <option value="PaleTurquoise">PaleTurquoise</option>
+        <option value="PaleVioletRed">PaleVioletRed</option>
+        <option value="PapayaWhip">PapayaWhip</option>
+        <option value="PeachPuff">PeachPuff</option>
+        <option value="Peru">Peru</option>
+        <option value="Pink">Pink</option>
+        <option value="Plum">Plum</option>
+        <option value="PowderBlue">PowderBlue</option>
+        <option value="Purple">Purple</option>
+        <option value="RebeccaPurple">RebeccaPurple</option>
+        <option value="Red">Red</option>
+        <option value="RosyBrown">RosyBrown</option>
+        <option value="RoyalBlue">RoyalBlue</option>
+        <option value="SaddleBrown">SaddleBrown</option>
+        <option value="Salmon">Salmon</option>
+        <option value="SandyBrown">SandyBrown</option>
+        <option value="SeaGreen">SeaGreen</option>
+        <option value="SeaShell">SeaShell</option>
+        <option value="Sienna">Sienna</option>
+        <option value="Silver">Silver</option>
+        <option value="SkyBlue">SkyBlue</option>
+        <option value="SlateBlue">SlateBlue</option>
+        <option value="SlateGray">SlateGray</option>
+        <option value="SlateGrey">SlateGrey</option>
+        <option value="Snow">Snow</option>
+        <option value="SpringGreen">SpringGreen</option>
+        <option value="SteelBlue">SteelBlue</option>
+        <option value="Tan">Tan</option>
+        <option value="Teal">Teal</option>
+        <option value="Thistle">Thistle</option>
+        <option value="Tomato">Tomato</option>
+        <option value="Turquoise">Turquoise</option>
+        <option value="Violet">Violet</option>
+        <option value="Wheat">Wheat</option>
+        <option value="White">White</option>
+        <option value="WhiteSmoke">WhiteSmoke</option>
+        <option value="Yellow">Yellow</option>
+        <option value="YellowGreen">YellowGreen</option>
+    </xml>
+    <xml name="param_matplotlib_pyplot_edgecolors">
+        <param argument="edgecolors" type="select" label="Edge color of the marker" help="">
+            <option value="face">The edge color will always be the same as the face color</option>
+            <option value="none">No patch boundary will be drawn</option>
+            <expand macro="matplotlib_color"/>
+        </param>
+    </xml>
+    <xml name="param_alpha">
+        <param argument="alpha" type="float" value="" min="0" max="1" optional="true" label="Alpha blending value" help="Between 0 (transparent) and 1 (opaque)"/>
+    </xml>
+    <xml name="param_vmin">
+        <param argument="vmin" type="float" value="" optional="true" label="Minimum value to normalize luminance data" help="If not set, it is inferred from the data and other keyword arguments"/>
+    </xml>
+    <xml name="param_vmax">
+        <param argument="vmax" type="float" value="" optional="true" label="Maximum value to normalize luminance data" help="If not set, it is inferred from the data and other keyword arguments"/>
+    </xml>    
+    <xml name="section_matplotlib_pyplot_scatter">
+        <section name="matplotlib_pyplot_scatter" title="Parameters for matplotlib.pyplot.scatter">
+            <!--<param argument="marker" type="select" label="Marker style" help="">
+                <option value="o">o</option>
+                <option value="v">v</option>
+                <option value="^">^</option>
+                <option value="8">8</option>
+                <option value="s">s</option>
+                <option value="p">p</option>
+                <option value="*">*</option>
+                <option value="h">h</option>
+                <option value="H">H</option>
+                <option value="D">D</option>
+                <option value="d">d</option>
+                <option value="P">P</option>
+                <option value="X">X</option>
+            </param>-->
+            <expand macro="param_alpha"/>
+            <expand macro="param_vmin"/>
+            <expand macro="param_vmax"/>
+            <param argument="linewidths" type="float" value="0" label="Linewidth of the marker edges" help=""/>
+            <expand macro="param_matplotlib_pyplot_edgecolors"/>
+        </section>
+    </xml>
+    <token name="@CMD_params_matplotlib_pyplot_scatter@"><![CDATA[
+    #if $method.matplotlib_pyplot_scatter.vmin
+    vmin=$method.matplotlib_pyplot_scatter.vmin,
+    #end if
+    #if $method.matplotlib_pyplot_scatter.vmax
+    vmax=$method.matplotlib_pyplot_scatter.vmax,
+    #end if
+    #if $method.matplotlib_pyplot_scatter.alpha
+    alpha=$method.matplotlib_pyplot_scatter.alpha,
+    #end if
+    linewidths=$method.matplotlib_pyplot_scatter.linewidths,
+    edgecolors='$method.matplotlib_pyplot_scatter.edgecolors'
+    ]]></token>
+    <xml name="section_violin_plots">
+        <section name="violin_plot" title="Violin plot attributes">
+            <conditional name="stripplot">
+                <param argument="stripplot" type="select" label="Add a stripplot on top of the violin plot" help="">
+                    <option value="True">Yes</option>
+                    <option value="False">No</option>
+                </param>
+                <when value="True">
+                    <conditional name="jitter">
+                        <param argument="jitter" type="select" label="Add a jitter to the stripplot" help="">
+                            <option value="True">Yes</option>
+                            <option value="False">No</option>
+                        </param>
+                        <when value="True">
+                            <param argument="size" type="integer" min="0" value="1" label="Size of the jitter points" help=""/>
+                        </when>
+                        <when value="False"/>
+                    </conditional>
+                </when>
+                <when value="False"/>
+            </conditional>
+            <conditional name="multi_panel">
+                <param argument="multi_panel" type="select" label="Display keys in multiple panels" help="Also when `groupby is not provided">
+                    <option value="True">Yes</option>
+                    <option value="False" selected="true">No</option>
+                </param>
+                <when value="True">
+                    <param argument="width" type="integer" min="0" value="" optional="true" label="Width of the figure" help=""/>
+                    <param argument="height" type="integer" min="0" value="" optional="true" label="Height of the figure" help=""/>
+                </when>
+                <when value="False"/>
+            </conditional>
+            <param argument="scale" type="select" label="Method used to scale the width of each violin">
+                <option value="area">area: each violin will have the same area</option>
+                <option value="count">count: the width of the violins will be scaled by the number of observations in that bin</option>
+                <option value="width" selected="true">width: each violin will have the same width</option>
+            </param>
+        </section>
+    </xml>
+    <token name="@CMD_params_violin_plots@"><![CDATA[
+    stripplot=$method.violin_plot.stripplot.stripplot,
+#if $method.violin_plot.stripplot.stripplot == "True"
+    jitter=$method.violin_plot.stripplot.jitter.jitter,
+    #if $method.violin_plot.stripplot.jitter.jitter == "True"
+    size=$method.violin_plot.stripplot.jitter.size,
+    #end if
+#end if
+    multi_panel=$method.violin_plot.multi_panel.multi_panel, 
+#if $method.multi_panel.violin_plot.multi_panel == "True" and $method.violin_plot.multi_panel.width and $method.violin_plot.multi_panel.height
+    figsize=($method.violin_plot.multi_panel.width, $method.violin_plot.multi_panel.height)
+#end if
+    scale='$method.violin_plot.scale',
+    ]]></token>
+    <xml name="seaborn_violinplot">
+        <section name="seaborn_violinplot" title="Parameters for seaborn.violinplot">
+            <param argument="bw" type="select" label="Name of a reference rule when computing the kernel bandwidth">
+                <option value="scott">scott</option>
+                <option value="silverman">silverman</option>
+            </param>
+            <param argument="orient" type="select" optional="true" label="Orientation of the plot">
+                <option value="v">vertical</option>
+                <option value="h">horizontal</option>
+            </param>
+            <param argument="linewidth" type="float" value="0" label="Width of the gray lines that frame the plot elements" help=""/>
+            <param argument="color" type="select" label="Color for all of the elements" help="">
+                <expand macro="matplotlib_color"/>
+            </param>
+            <param argument="palette" type="select" label="Colors to use for the different levels of the hue variable" help="">
+                <expand macro="matplotlib_pyplot_colormap"/>
+            </param>
+            <param argument="saturation" type="float" value="0.75" min="0" max="1" label="Proportion of the original saturation to draw colors at" help=""/>
+        </section>
+    </xml>
+    <token name="@CMD_params_seaborn_violinplot@"><![CDATA[
+    bw='$method.seaborn_violinplot.bw',
+#if $method.seaborn_violinplot.orient
+    orient='$method.seaborn_violinplot.orient',
+#end if
+    linewidth=$method.seaborn_violinplot.linewidth,
+    color='$method.seaborn_violinplot.color',
+    palette='$method.seaborn_violinplot.palette',
+    saturation=$method.seaborn_violinplot.saturation,
+    ]]></token>
+    <xml name="param_color">
+        <param argument="color" type="text" value="" optional="true" label="Keys for annotations of observations/cells or variables/genes`" help="One or a list of comma-separated index or key from either `.obs` or `.var`"/>
+    </xml>
+    <token name="@CMD_param_color@"><![CDATA[
+#if str($method.color) != ''
+    #set $color = ([x.strip() for x in str($method.color).split(',')])
+    color=$color,
+#else
+    color=None,
+#end if
+    ]]></token>
+    <xml name="pl_groups">
+        <param argument="groups" type="text" value="" optional="true" label="Categorical observation annotations, comma-separated" help=""/>
+    </xml>
+    <token name="@CMD_params_pl_groups@"><![CDATA[
+#if str($method.groups) != ''
+    #set $groups=([x.strip() for x in str($method.groups).split(',')])
+    groups=$groups,
+#else
+    groups=None,
+#end if
+    ]]></token>
+    <xml name="pl_components">
+        <repeat name="components" title="Component">
+            <param argument="axis1" type="text" value="1" label="Axis 1" help=""/>
+            <param argument="axis2" type="text" value="2" label="Axis 2" help=""/>
+        </repeat>
+    </xml>
+    <token name="@CMD_params_pl_components@"><![CDATA[
+#if len($method.plot.components) > 0
+    #set $components=[]
+    #for $i, $s in enumerate($method.plot.components)
+        #silent $components.append(str($s.axis1) + ',' + str($s.axis2))
+    #end for
+    components=$components,
+#else
+    components=None,
+#end if
+    ]]>
+    </token>
+    <xml name="param_projection">
+        <param argument="projection" type="select" label="Projection of plot" help="">
+            <option value="2d">2d</option>
+            <option value="3d">3d</option>
+        </param>
+    </xml>
+    <xml name="param_legend_loc">
+        <param argument="legend_loc" type="select" label="Location of legend" help="">
+            <option value="none">none</option>
+            <option value="right margin" selected="true">right margin</option>
+            <option value="on data">on data</option>
+            <option value="on data export">on data export</option>
+            <option value="best">best</option>
+            <option value="upper right">upper right</option>
+            <option value="upper left">upper left</option>
+            <option value="lower left">lower left</option>
+            <option value="lower right">lower right</option>
+            <option value="center left">center left</option>
+            <option value="center right">center right</option>
+            <option value="lower center">lower center</option>
+            <option value="upper center">upper center</option>
+            <option value="center">center</option>
+        </param>
+    </xml>
+    <xml name="param_legend_fontsize">
+        <param argument="legend_fontsize" type="integer" min="0" value="1" label="Legend font size" help=""/>
+    </xml>
+    <xml name="param_legend_fontweight">
+        <param argument="legend_fontweight" type="select" label="Legend font weight" help="">
+            <option value="light">light</option>
+            <option value="normal" selected="true">normal</option>
+            <option value="medium">medium</option>
+            <option value="semibold">semibold</option>
+            <option value="bold">bold</option>
+            <option value="heavy">heavy</option>
+            <option value="black">black</option>
+        </param>
+    </xml>
+    <xml name="param_palette">
+        <param argument="palette" type="select" label="Colors to use for plotting g categorical annotation groups" help="">
+            <expand macro="matplotlib_pyplot_colormap"/>
+        </param>
+    </xml>
+    <xml name="param_color_map">
+        <param argument="color_map" type="select" label="Colors to use for plotting categorical annotation groups" help="">
+            <expand macro="matplotlib_pyplot_colormap"/>
+        </param>
+    </xml>
+    <xml name="param_frameon">
+        <param argument="frameon" type="boolean" truevalue="True" falsevalue="False" checked="true" label="Draw a frame around the scatter plot?" help=""/>
+    </xml>
+    <xml name="param_right_margin">
+        <param argument="right_margin" type="float" value="1" label="Width of the space right of each plotting panel" help=""/>
+    </xml>
+    <xml name="param_left_margin">
+        <param argument="left_margin" type="float" value="1" label="Width of the space left of each plotting panel" help=""/>
+    </xml>
+    <xml name="param_size">
+        <param argument="size" type="float" value="1" label="Point size" help=""/>
+    </xml>
+    <xml name="param_title">
+        <param argument="title" type="text" value="" optional="true" label="Title for panels" help="Titles must be separated by a comma"/>
+    </xml>
+    <xml name="param_sort_order">
+        <param argument="sort_order" type="boolean" truevalue="True" falsevalue="False" checked="true" label="Sort order?" help="For continuous annotations used as color parameter, plot data points with higher values on top of others."/>
+    </xml>
+    <xml name="param_sort_order">
+        <param argument="sort_order" type="boolean" truevalue="True" falsevalue="False" checked="true" label="Sort order?" help="For continuous annotations used as color parameter, plot data points with higher values on top of others."/>
+    </xml>
+    <xml name="param_ncols">
+        <param argument="ncols" type="integer" min="0" value="4" label="Number of panels per row" help=""/>
+    </xml>
+    <xml name="param_wspace">
+        <param argument="wspace" type="float" min="0" value="0.1" label="Width of the space between multiple panels" help=""/>
+    </xml>
+    <xml name="param_hspace">
+        <param argument="hspace" type="float" min="0" value="0.25" label="Geight of the space between multiple panels" help=""/>
+    </xml>
+    <xml name="pl_edges">
+        <conditional name="edges">
+            <param argument="edges" type="select" label="Show edges?">
+                <option value="True">Yes</option>
+                <option value="False" selected="true">No</option>
+            </param>
+            <when value="True">
+                <param name="edges_width" type="float" min="0" value="0.1" label="Width of edges"/>
+                <param name="edges_color" type="select" label="Color of edges">
+                    <expand macro="matplotlib_color"/>
+                </param>
+            </when>
+            <when value="False"/>
+        </conditional>
+    </xml>
+    <token name="@CMD_pl_edges@"><![CDATA[
+#if str($method.edges.edges) == 'True'
+    edges=True,
+    edges_width=$method.edges.edges_width,
+    edges_color='$method.edges.edges_color',
+#else
+    edges=False,
+#end if
+    ]]>
+    </token>
+    <xml name="param_arrows">
+        <param name="arrows" type="boolean" truevalue="True" falsevalue="False" checked="false" label="Show arrows?" help="It requires to run `tl.rna_velocity` before."/>
+    </xml>
+    <xml name="param_cmap">
+        <param argument="cmap" type="select" label="Colors to use for plotting categorical annotation groups" help="">
+            <expand macro="matplotlib_pyplot_colormap"/>
+        </param>
+    </xml>
+    <xml name="pl_attribute_section">
+        <section name="plot" title="Plot attributes">
+            <expand macro="pl_components"/>
+            <expand macro="param_projection"/>
+            <expand macro="param_legend_loc"/>
+            <expand macro="param_legend_fontsize"/>
+            <expand macro="param_legend_fontweight"/>
+            <expand macro="param_size"/>
+            <expand macro="param_palette"/>
+            <expand macro="param_frameon"/>
+            <expand macro="param_ncols"/>
+            <expand macro="param_wspace"/>
+            <expand macro="param_hspace"/>
+            <expand macro="param_title"/>
+        </section>
+    </xml>
+    <token name="@CMD_pl_attribute_section@"><![CDATA[
+    projection='$method.plot.projection',
+    legend_loc='$method.plot.legend_loc',
+    legend_fontsize=$method.plot.legend_fontsize,
+    legend_fontweight='$method.plot.legend_fontweight',
+    size=$method.plot.size,
+    palette='$method.plot.palette',
+    frameon=$method.plot.frameon,
+    ncols=$method.plot.ncols,
+    wspace=$method.plot.wspace,
+    hspace=$method.plot.hspace,
+    #if $method.plot.title
+    title='$method.plot.title',
+    #end if
+    ]]>
+    </token>
+    <xml name="inputs_paga">
+        <param argument="threshold" type="float" min="0" value="0.01" label="Threshold to draw edges" help="Do not draw edges for weights below this threshold. Set to 0 if you want all edges. Discarding low-connectivity edges helps in getting a much clearer picture of the graph."/>
+        <expand macro="pl_groups"/>
+        <param argument="color" type="text" value="" label="The node colors" help="Gene name or obs. annotation, and also plots the degree of the abstracted graph when passing 'degree_dashed', 'degree_solid'."/>
+        <param argument="pos" type="data" format="tabular,csv,tsv" optional="true" label="Two-column tabular file storing the x and y coordinates for drawing" help=""/>
+        <param argument="labels" type="text" value="" label="Comma-separated node labels" help="If none is provided, this defaults to the group labels stored in the categorical for which `tl.paga` has been computed."/>
+        <param argument="layout" type="select" value="" label="Plotting layout" help="">
+            <option value="fa">fa: ForceAtlas2</option>
+            <option value="fr">fr: Fruchterman-Reingold</option>
+            <option value="fr">rt: stands for Reingold Tilford</option>
+            <option value="fr">eq_tree: equally spaced tree</option>
+        </param>
+        <param argument="init_pos" type="data" format="tabular,csv,tsv" optional="true" label="Two-column tabular file storing the x and y coordinates for initializing the layout" help=""/>
+        <param argument="random_state" type="integer" value="0" label="Random state" help="For layouts with random initialization like 'fr', change this to use different intial states for the optimization. If `None`, the initial state is not reproducible."/>
+        <param argument="root" type="text" value="" label="Comma-separated roots" help="If choosing a tree layout, this is the index of the root node or a list of root node indices. If this is a non-empty vector then the supplied node IDs are used as the roots of the trees (or a single tree if the graph is connected). If this is `None` or an empty list, the root vertices are automatically calculated based on topological sorting."/>
+        <param argument="transitions" type="text" value="" label="Key corresponding to the matrix storing the arrows" help="Key for `.uns['paga']`, e.g. 'transistions_confidence'"/>
+        <param argument="solid_edges" type="text" value="paga_connectivities" label="Key corresponding to the matrix storing the edges to be drawn solid black" help="Key for `.uns['paga']`"/>
+        <param argument="dashed_edges" type="text" value="" optional="true" label="Key corresponding to the matrix storing the edges to be drawn dashed grey" help="Key for `.uns['paga']`. If not set, no dashed edges are drawn."/>
+        <param argument="single_component" type="boolean" truevalue="True" falsevalue="False" checked="false" label="Restrict to largest connected component?" help=""/>
+        <param argument="fontsize" type="integer" min="0" value="1" label="Font size for node labels" help=""/>
+        <param argument="node_size_scale" type="float" min="0" value="1.0" label="Size of the nodes" help=""/>
+        <param argument="node_size_power" type="float" min="0" value="0.5" label="Power with which groups sizes influence the radius of the nodes" help=""/>
+        <param argument="edge_width_scale" type="float" min="0" value="5" label="Scale for edge width" help=""/>
+        <param argument="min_edge_width" type="float" min="0" value="" optional="true" label="Min width of solid edges" help=""/>
+        <param argument="max_edge_width" type="float" min="0" value="" optional="true" label="Max width of solid and dashed edges" help=""/>
+        <param argument="arrowsize" type="integer" min="0" value="30" label="Arrow size" help="For directed graphs, choose the size of the arrow head head's length and width."/>
+        <param argument="normalize_to_color" type="boolean" truevalue="True" falsevalue="False" checked="false" label="Normalize categorical plots to color or the underlying grouping?" help=""/>
+        <expand macro="param_cmap"/>
+        <expand macro="param_title"/>
+        <expand macro="param_frameon"/>
+    </xml>
+    <token name="@CMD_params_pl_paga@"><![CDATA[
+    threshold=$method.threshold,
+#if str($method.groups) != ''
+    #set $groups=([x.strip() for x in str($method.groups).split(',')])
+    groups=$groups,
+#else
+    groups=None,
+#end if
+    color='$method.color',
+#if $method.pos
+    pos=np.fromfile($method.pos, dtype=dt),
+#end if
+#if str($method.labels) != ''
+    #set $labels=([x.strip() for x in str($method.labels).split(',')])
+    labels=$labels,
+#end if
+    layout='$method.layout',
+#if $method.init_pos
+    init_pos=np.fromfile($method.init_pos, dtype=dt),
+#end if
+    random_state=$method.random_state,
+#if str($method.root) != ''
+    #set $root=([int(x.strip()) for x in str($method.root).split(',')])
+    root=$root,
+#end if
+#if $method.transitions
+    transitions='$method.transitions',
+#end if
+    solid_edges='$method.solid_edges',
+#if $method.dashed_edges
+    dashed_edges='$method.dashed_edges',
+#end if
+    single_component=$method.single_component,
+    fontsize=$method.fontsize,
+    node_size_scale=$method.node_size_scale,
+    node_size_power=$method.node_size_power,
+    edge_width_scale=$method.edge_width_scale,
+#if $method.min_edge_width
+    min_edge_width=$method.min_edge_width,
+#end if
+#if $method.max_edge_width
+    max_edge_width=$method.max_edge_width,
+#end if
+    arrowsize=$method.arrowsize,
+    normalize_to_color=$method.normalize_to_color,
+    cmap='$method.cmap',
+#if $method.title
+    title='$method.title',
+#end if
+    frameon=$method.frameon,
+    ]]>
+    </token>
+    <xml name="param_swap_axes">
+        <param argument="swap_axes" type="boolean" truevalue="True" falsevalue="False" checked="false" label="Swap axes?" help="By default, the x axis contains `var_names` (e.g. genes) and the y axis the `groupby` categories (if any). By setting `swap_axes` then x are the `groupby` categories and y the `var_names`."/>
+    </xml>
+</macros>
Binary file test-data/krumsiek11.h5ad has changed
Binary file test-data/krumsiek11.loom has changed
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/test-data/krumsiek11_counts_per_cell	Mon Mar 04 10:15:02 2019 -0500
@@ -0,0 +1,640 @@
+2.408400297164916992e+00
+2.452799797058105469e+00
+2.441299915313720703e+00
+2.371799945831298828e+00
+2.295799970626831055e+00
+2.236100196838378906e+00
+2.159400224685668945e+00
+2.094000101089477539e+00
+2.050699949264526367e+00
+2.009300231933593750e+00
+1.965499877929687500e+00
+1.940399885177612305e+00
+1.925999999046325684e+00
+1.915199875831604004e+00
+1.916800022125244141e+00
+1.921400070190429688e+00
+1.931500196456909180e+00
+1.958499908447265625e+00
+1.997500061988830566e+00
+2.039499998092651367e+00
+2.084599733352661133e+00
+2.127799987792968750e+00
+2.187099933624267578e+00
+2.239099979400634766e+00
+2.285900115966796875e+00
+2.337300062179565430e+00
+2.391999959945678711e+00
+2.438399791717529297e+00
+2.489500045776367188e+00
+2.545399904251098633e+00
+2.599499940872192383e+00
+2.647500276565551758e+00
+2.696399927139282227e+00
+2.719100236892700195e+00
+2.758599758148193359e+00
+2.798499822616577148e+00
+2.817299842834472656e+00
+2.856800079345703125e+00
+2.882500171661376953e+00
+2.892000198364257812e+00
+2.910799741744995117e+00
+2.925500154495239258e+00
+2.948799848556518555e+00
+2.968800067901611328e+00
+2.992099761962890625e+00
+3.009699821472167969e+00
+3.028200149536132812e+00
+3.031499862670898438e+00
+3.045699834823608398e+00
+3.049900054931640625e+00
+3.059900045394897461e+00
+3.072500228881835938e+00
+3.077599763870239258e+00
+3.089499950408935547e+00
+3.088899850845336914e+00
+3.107500076293945312e+00
+3.107999801635742188e+00
+3.108199834823608398e+00
+3.120700120925903320e+00
+3.125699996948242188e+00
+3.139300107955932617e+00
+3.160399913787841797e+00
+3.179100036621093750e+00
+3.196399927139282227e+00
+3.225399732589721680e+00
+3.246099948883056641e+00
+3.276799917221069336e+00
+3.294199943542480469e+00
+3.331000328063964844e+00
+3.366000175476074219e+00
+3.403100013732910156e+00
+3.429600000381469727e+00
+3.460299730300903320e+00
+3.506799936294555664e+00
+3.535099744796752930e+00
+3.563699722290039062e+00
+3.601699829101562500e+00
+3.628099918365478516e+00
+3.656300067901611328e+00
+3.690200090408325195e+00
+3.716900110244750977e+00
+3.735100030899047852e+00
+3.751500129699707031e+00
+3.772299766540527344e+00
+3.786999940872192383e+00
+3.799900054931640625e+00
+3.813199996948242188e+00
+3.829000234603881836e+00
+3.841199874877929688e+00
+3.855699777603149414e+00
+3.879299879074096680e+00
+3.888599872589111328e+00
+3.891200065612792969e+00
+3.899099826812744141e+00
+3.896700143814086914e+00
+3.900700330734252930e+00
+3.902399778366088867e+00
+3.909000158309936523e+00
+3.924799919128417969e+00
+3.909100055694580078e+00
+3.908500194549560547e+00
+3.913800001144409180e+00
+3.918300151824951172e+00
+3.918600082397460938e+00
+3.923599958419799805e+00
+3.930300235748291016e+00
+3.933600187301635742e+00
+3.939800024032592773e+00
+3.939800024032592773e+00
+3.940799951553344727e+00
+3.939599990844726562e+00
+3.949400186538696289e+00
+3.946899890899658203e+00
+3.949199914932250977e+00
+3.959100008010864258e+00
+3.953099966049194336e+00
+3.948199987411499023e+00
+3.958700180053710938e+00
+3.947399854660034180e+00
+3.947599887847900391e+00
+3.953999996185302734e+00
+3.963799953460693359e+00
+3.958499908447265625e+00
+3.948000192642211914e+00
+3.955900192260742188e+00
+3.960099935531616211e+00
+3.953900098800659180e+00
+3.940199851989746094e+00
+3.943799972534179688e+00
+3.938899993896484375e+00
+3.939199686050415039e+00
+3.939899921417236328e+00
+3.942100048065185547e+00
+3.947299718856811523e+00
+3.950499773025512695e+00
+3.946299791336059570e+00
+3.943099975585937500e+00
+3.937799930572509766e+00
+3.936500072479248047e+00
+3.951900005340576172e+00
+3.955199956893920898e+00
+3.950200080871582031e+00
+3.952800035476684570e+00
+3.943200111389160156e+00
+3.935600042343139648e+00
+3.929900169372558594e+00
+3.941400051116943359e+00
+3.930999994277954102e+00
+3.941400051116943359e+00
+3.955500125885009766e+00
+3.956299781799316406e+00
+3.946699857711791992e+00
+3.932600021362304688e+00
+3.923200130462646484e+00
+3.933800220489501953e+00
+3.930399894714355469e+00
+3.928800106048583984e+00
+3.926499843597412109e+00
+3.939000129699707031e+00
+3.948799848556518555e+00
+2.407099962234497070e+00
+2.459100008010864258e+00
+2.451099872589111328e+00
+2.396099805831909180e+00
+2.329699993133544922e+00
+2.263400077819824219e+00
+2.202099800109863281e+00
+2.148999929428100586e+00
+2.086499929428100586e+00
+2.037899732589721680e+00
+2.005300045013427734e+00
+1.980700016021728516e+00
+1.954999923706054688e+00
+1.942199945449829102e+00
+1.941300153732299805e+00
+1.949399948120117188e+00
+1.963600039482116699e+00
+1.991100072860717773e+00
+2.019500017166137695e+00
+2.062200069427490234e+00
+2.099699974060058594e+00
+2.147199869155883789e+00
+2.189300060272216797e+00
+2.252599954605102539e+00
+2.305799961090087891e+00
+2.360599994659423828e+00
+2.418299913406372070e+00
+2.466599941253662109e+00
+2.517600059509277344e+00
+2.552000045776367188e+00
+2.596099853515625000e+00
+2.629899978637695312e+00
+2.675899982452392578e+00
+2.714099884033203125e+00
+2.741899967193603516e+00
+2.783499956130981445e+00
+2.818200111389160156e+00
+2.844200134277343750e+00
+2.886999845504760742e+00
+2.921300172805786133e+00
+2.947200059890747070e+00
+2.996900081634521484e+00
+3.025799751281738281e+00
+3.045400142669677734e+00
+3.089999914169311523e+00
+3.117900133132934570e+00
+3.151299953460693359e+00
+3.181499958038330078e+00
+3.237699985504150391e+00
+3.274699687957763672e+00
+3.312700033187866211e+00
+3.364599943161010742e+00
+3.413300037384033203e+00
+3.455899715423583984e+00
+3.493399858474731445e+00
+3.521699666976928711e+00
+3.544100284576416016e+00
+3.567100048065185547e+00
+3.573799848556518555e+00
+3.594200134277343750e+00
+3.611599922180175781e+00
+3.623600006103515625e+00
+3.627799987792968750e+00
+3.631000280380249023e+00
+3.633599996566772461e+00
+3.629300117492675781e+00
+3.631299972534179688e+00
+3.638499975204467773e+00
+3.626599788665771484e+00
+3.619099855422973633e+00
+3.603900194168090820e+00
+3.594299793243408203e+00
+3.592899799346923828e+00
+3.597899913787841797e+00
+3.605900049209594727e+00
+3.596999883651733398e+00
+3.586699724197387695e+00
+3.595699787139892578e+00
+3.604900121688842773e+00
+3.612499713897705078e+00
+3.620199918746948242e+00
+3.633599996566772461e+00
+3.640199899673461914e+00
+3.663199663162231445e+00
+3.677999973297119141e+00
+3.700099945068359375e+00
+3.740899801254272461e+00
+3.765499830245971680e+00
+3.805799961090087891e+00
+3.846299648284912109e+00
+3.862800121307373047e+00
+3.883700132369995117e+00
+3.911299943923950195e+00
+3.939899921417236328e+00
+3.952800035476684570e+00
+3.966100215911865234e+00
+3.994499921798706055e+00
+4.005899906158447266e+00
+4.015599727630615234e+00
+4.036499977111816406e+00
+4.057400226593017578e+00
+4.062900066375732422e+00
+4.067600250244140625e+00
+4.076700210571289062e+00
+4.076000213623046875e+00
+4.078199863433837891e+00
+4.077000141143798828e+00
+4.093100070953369141e+00
+4.080200195312500000e+00
+4.092900276184082031e+00
+4.097700119018554688e+00
+4.080499649047851562e+00
+4.067900180816650391e+00
+4.073300361633300781e+00
+4.076399803161621094e+00
+4.085100173950195312e+00
+4.077300071716308594e+00
+4.076200008392333984e+00
+4.080200195312500000e+00
+4.078400135040283203e+00
+4.066500186920166016e+00
+4.055600166320800781e+00
+4.053299903869628906e+00
+4.052399635314941406e+00
+4.052700042724609375e+00
+4.058700084686279297e+00
+4.065699577331542969e+00
+4.060500144958496094e+00
+4.059799671173095703e+00
+4.054600238800048828e+00
+4.053100109100341797e+00
+4.054999828338623047e+00
+4.058799743652343750e+00
+4.060400009155273438e+00
+4.067599773406982422e+00
+4.059499740600585938e+00
+4.062000274658203125e+00
+4.055999755859375000e+00
+4.057600021362304688e+00
+4.054600238800048828e+00
+4.045300006866455078e+00
+4.043200016021728516e+00
+4.045300483703613281e+00
+4.053100109100341797e+00
+4.032400131225585938e+00
+4.026299953460693359e+00
+4.029700279235839844e+00
+4.030099868774414062e+00
+4.029600143432617188e+00
+4.028599739074707031e+00
+4.044600009918212891e+00
+4.037399768829345703e+00
+4.032099723815917969e+00
+4.044800281524658203e+00
+4.051599979400634766e+00
+4.043399810791015625e+00
+4.049400329589843750e+00
+4.070099830627441406e+00
+4.081900119781494141e+00
+4.079800605773925781e+00
+2.394400119781494141e+00
+2.447099685668945312e+00
+2.428200006484985352e+00
+2.382099866867065430e+00
+2.310499668121337891e+00
+2.237499713897705078e+00
+2.180900096893310547e+00
+2.120899915695190430e+00
+2.073999881744384766e+00
+2.035700082778930664e+00
+1.997299909591674805e+00
+1.960000038146972656e+00
+1.933499813079833984e+00
+1.922099947929382324e+00
+1.901300072669982910e+00
+1.885300040245056152e+00
+1.867299914360046387e+00
+1.854500174522399902e+00
+1.851300120353698730e+00
+1.843599915504455566e+00
+1.846300005912780762e+00
+1.846699953079223633e+00
+1.847900032997131348e+00
+1.858900070190429688e+00
+1.871000051498413086e+00
+1.890400052070617676e+00
+1.916300177574157715e+00
+1.924000024795532227e+00
+1.946200013160705566e+00
+1.970500111579895020e+00
+1.995200157165527344e+00
+2.030999898910522461e+00
+2.063699960708618164e+00
+2.101999998092651367e+00
+2.151399850845336914e+00
+2.198199987411499023e+00
+2.237499952316284180e+00
+2.288900136947631836e+00
+2.342400312423706055e+00
+2.384900093078613281e+00
+2.429300069808959961e+00
+2.474900007247924805e+00
+2.529999971389770508e+00
+2.579999923706054688e+00
+2.615100145339965820e+00
+2.651299953460693359e+00
+2.690599918365478516e+00
+2.729199886322021484e+00
+2.770900011062622070e+00
+2.809800148010253906e+00
+2.840899944305419922e+00
+2.875800132751464844e+00
+2.897199869155883789e+00
+2.912499666213989258e+00
+2.941200017929077148e+00
+2.967499971389770508e+00
+2.995100259780883789e+00
+3.033900022506713867e+00
+3.057100057601928711e+00
+3.092799901962280273e+00
+3.138499975204467773e+00
+3.169900178909301758e+00
+3.214200019836425781e+00
+3.259000062942504883e+00
+3.290100097656250000e+00
+3.327300071716308594e+00
+3.367499828338623047e+00
+3.406300067901611328e+00
+3.449200391769409180e+00
+3.499700069427490234e+00
+3.540199756622314453e+00
+3.565999984741210938e+00
+3.588100194931030273e+00
+3.600499868392944336e+00
+3.614799976348876953e+00
+3.630699872970581055e+00
+3.627500057220458984e+00
+3.617300033569335938e+00
+3.614999771118164062e+00
+3.615100145339965820e+00
+3.611300230026245117e+00
+3.615400075912475586e+00
+3.615299701690673828e+00
+3.608300209045410156e+00
+3.605599880218505859e+00
+3.600100040435791016e+00
+3.591399908065795898e+00
+3.578599691390991211e+00
+3.571600198745727539e+00
+3.557199716567993164e+00
+3.560299873352050781e+00
+3.555500030517578125e+00
+3.561499834060668945e+00
+3.561499834060668945e+00
+3.560699939727783203e+00
+3.589500188827514648e+00
+3.601899862289428711e+00
+3.605400085449218750e+00
+3.611400127410888672e+00
+3.624899864196777344e+00
+3.640100002288818359e+00
+3.652900218963623047e+00
+3.679800271987915039e+00
+3.685100078582763672e+00
+3.699399948120117188e+00
+3.704900026321411133e+00
+3.722100019454956055e+00
+3.731600284576416016e+00
+3.751000165939331055e+00
+3.761499881744384766e+00
+3.777699947357177734e+00
+3.789600133895874023e+00
+3.805400133132934570e+00
+3.825700044631958008e+00
+3.845600128173828125e+00
+3.865399837493896484e+00
+3.870899915695190430e+00
+3.895600080490112305e+00
+3.903699636459350586e+00
+3.910399675369262695e+00
+3.923700094223022461e+00
+3.924299716949462891e+00
+3.929199934005737305e+00
+3.943899869918823242e+00
+3.954200267791748047e+00
+3.972000122070312500e+00
+3.975000143051147461e+00
+3.984800338745117188e+00
+3.994400024414062500e+00
+4.001999855041503906e+00
+4.019299983978271484e+00
+4.028100013732910156e+00
+4.035899639129638672e+00
+4.048800468444824219e+00
+4.044399738311767578e+00
+4.058400154113769531e+00
+4.063999652862548828e+00
+4.064199924468994141e+00
+4.064599990844726562e+00
+4.064500331878662109e+00
+4.077300071716308594e+00
+4.081399917602539062e+00
+4.084300041198730469e+00
+4.092800140380859375e+00
+4.091700077056884766e+00
+4.092100143432617188e+00
+4.096999645233154297e+00
+4.081199645996093750e+00
+4.093699932098388672e+00
+4.081700325012207031e+00
+4.095000267028808594e+00
+4.098299980163574219e+00
+4.080500125885009766e+00
+4.079499721527099609e+00
+4.086300373077392578e+00
+4.072200298309326172e+00
+4.061200141906738281e+00
+4.075200080871582031e+00
+4.066499710083007812e+00
+4.076799869537353516e+00
+2.399500131607055664e+00
+2.461999654769897461e+00
+2.458400011062622070e+00
+2.410799980163574219e+00
+2.324100017547607422e+00
+2.264699935913085938e+00
+2.213299989700317383e+00
+2.159399986267089844e+00
+2.099900007247924805e+00
+2.056699991226196289e+00
+2.025199890136718750e+00
+1.996799945831298828e+00
+1.957400202751159668e+00
+1.931800007820129395e+00
+1.910700082778930664e+00
+1.889699935913085938e+00
+1.894500017166137695e+00
+1.883400201797485352e+00
+1.879799962043762207e+00
+1.875000000000000000e+00
+1.869399905204772949e+00
+1.858600139617919922e+00
+1.871700048446655273e+00
+1.882499933242797852e+00
+1.887800097465515137e+00
+1.892300009727478027e+00
+1.885900020599365234e+00
+1.903299808502197266e+00
+1.912000060081481934e+00
+1.921299934387207031e+00
+1.914299964904785156e+00
+1.915700197219848633e+00
+1.928300023078918457e+00
+1.931900024414062500e+00
+1.930599927902221680e+00
+1.941800117492675781e+00
+1.945299983024597168e+00
+1.956899881362915039e+00
+1.964700222015380859e+00
+1.967999935150146484e+00
+1.966400027275085449e+00
+1.972699880599975586e+00
+1.986699938774108887e+00
+1.998100042343139648e+00
+2.006099939346313477e+00
+2.014899969100952148e+00
+2.035799980163574219e+00
+2.059900045394897461e+00
+2.089900016784667969e+00
+2.121299982070922852e+00
+2.151399850845336914e+00
+2.189300060272216797e+00
+2.239999771118164062e+00
+2.283900260925292969e+00
+2.331199884414672852e+00
+2.380800008773803711e+00
+2.435999870300292969e+00
+2.480200052261352539e+00
+2.528899908065795898e+00
+2.568600177764892578e+00
+2.605000019073486328e+00
+2.632200241088867188e+00
+2.671899795532226562e+00
+2.700799942016601562e+00
+2.706700086593627930e+00
+2.725800037384033203e+00
+2.728600025177001953e+00
+2.746000051498413086e+00
+2.749099969863891602e+00
+2.746299982070922852e+00
+2.745100021362304688e+00
+2.740399837493896484e+00
+2.721600055694580078e+00
+2.733300209045410156e+00
+2.745200157165527344e+00
+2.753600120544433594e+00
+2.758900165557861328e+00
+2.772200107574462891e+00
+2.782299995422363281e+00
+2.797100067138671875e+00
+2.812000274658203125e+00
+2.839200019836425781e+00
+2.853300094604492188e+00
+2.865500211715698242e+00
+2.880899906158447266e+00
+2.884700059890747070e+00
+2.877900123596191406e+00
+2.896800041198730469e+00
+2.896899938583374023e+00
+2.901299953460693359e+00
+2.904000043869018555e+00
+2.914000034332275391e+00
+2.928899765014648438e+00
+2.939800024032592773e+00
+2.936100006103515625e+00
+2.950000047683715820e+00
+2.941200017929077148e+00
+2.934599876403808594e+00
+2.946899890899658203e+00
+2.952399969100952148e+00
+2.942699909210205078e+00
+2.946599960327148438e+00
+2.946300029754638672e+00
+2.943899869918823242e+00
+2.942800045013427734e+00
+2.943900108337402344e+00
+2.951200008392333984e+00
+2.949299812316894531e+00
+2.955400228500366211e+00
+2.943600177764892578e+00
+2.935999870300292969e+00
+2.948500156402587891e+00
+2.950099945068359375e+00
+2.951200008392333984e+00
+2.960999965667724609e+00
+2.963699817657470703e+00
+2.971600294113159180e+00
+2.975999832153320312e+00
+2.958300113677978516e+00
+2.944900035858154297e+00
+2.919999837875366211e+00
+2.921499967575073242e+00
+2.922800064086914062e+00
+2.929299831390380859e+00
+2.933599948883056641e+00
+2.934400081634521484e+00
+2.943200111389160156e+00
+2.958299875259399414e+00
+2.960800170898437500e+00
+2.952000141143798828e+00
+2.953899860382080078e+00
+2.946300029754638672e+00
+2.940300226211547852e+00
+2.945899724960327148e+00
+2.938000202178955078e+00
+2.931699991226196289e+00
+2.925199985504150391e+00
+2.920900106430053711e+00
+2.926300048828125000e+00
+2.927299976348876953e+00
+2.919699907302856445e+00
+2.934800148010253906e+00
+2.934599876403808594e+00
+2.930900096893310547e+00
+2.936100006103515625e+00
+2.930900096893310547e+00
+2.926499843597412109e+00
+2.933099985122680664e+00
+2.932799816131591797e+00
+2.937399864196777344e+00
+2.932799816131591797e+00
+2.935299873352050781e+00
+2.923399925231933594e+00
+2.914299964904785156e+00
+2.917200088500976562e+00
+2.901000022888183594e+00
+2.908900022506713867e+00
+2.912899732589721680e+00
+2.921400070190429688e+00
+2.925299882888793945e+00
Binary file test-data/paul15_subsample.h5ad has changed
Binary file test-data/pbmc68k_reduced.h5ad has changed
Binary file test-data/pl.clustermap.krumsiek11.png has changed
Binary file test-data/pl.diffmap.neighbors_gauss_braycurtis.recipe_weinreb17.paul15_subsampl.png has changed
Binary file test-data/pl.diffmap.neighbors_gauss_braycurtis.recipe_weinreb17.paul15_subsample.png has changed
Binary file test-data/pl.dotplot.krumsiek11.png has changed
Binary file test-data/pl.dpt_timeseries.dpt.diffmap.neighbors_gauss_braycurtis.recipe_weinreb17.paul15_subsample.png has changed
Binary file test-data/pl.heatmap.krumsiek11.png has changed
Binary file test-data/pl.highest_expr_genes.filter_genes_dispersion.krumsiek11-seurat.png has changed
Binary file test-data/pl.matrixplot.krumsiek11.png has changed
Binary file test-data/pl.paga.paul15_gauss_braycurtis.png has changed
Binary file test-data/pl.pca.pbmc68k_reduced.CD3D_CD79A_components_2d.pdf has changed
Binary file test-data/pl.pca_loadings.pp.pca.krumsiek11.png has changed
Binary file test-data/pl.pca_overview.pp.pca.krumsiek11.png has changed
Binary file test-data/pl.pca_variance_ratio.pp.pca.krumsiek11.png has changed
Binary file test-data/pl.scatter.krumsiek11.png has changed
Binary file test-data/pl.scatter.pca.krumsiek11.png has changed
Binary file test-data/pl.tsne.krumsiek11.png has changed
Binary file test-data/pl.umap.neighbors_umap_euclidean.recipe_weinreb17.paul15_subsample.png has changed
Binary file test-data/pl.violin.pbmc68k_reduced_custom.png has changed
Binary file test-data/pp.filter_cells.krumsiek11-min_counts.h5ad has changed
Binary file test-data/pp.filter_cells.krumsiek11-min_counts.loom has changed
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/test-data/pp.filter_cells.number_per_cell.krumsiek11-max_genes.tabular	Mon Mar 04 10:15:02 2019 -0500
@@ -0,0 +1,641 @@
+	cell_subset	number_per_cell
+0	True	9
+1	True	9
+2	True	9
+3	True	8
+4	True	8
+5	True	8
+6	True	8
+7	True	7
+8	True	8
+9	True	8
+10	True	7
+11	True	7
+12	True	7
+13	True	7
+14	True	8
+15	True	10
+16	True	10
+17	True	10
+18	True	11
+19	True	11
+20	True	11
+21	True	11
+22	True	11
+23	True	11
+24	True	11
+25	True	11
+26	True	11
+27	True	11
+28	True	11
+29	True	11
+30	True	11
+31	True	11
+32	True	11
+33	True	11
+34	True	11
+35	True	11
+36	True	11
+37	True	11
+38	True	11
+39	True	11
+40	True	11
+41	True	11
+42	True	11
+43	True	11
+44	True	11
+45	True	11
+46	True	11
+47	True	11
+48	True	10
+49	True	10
+50	True	10
+51	True	10
+52	True	10
+53	True	10
+54	True	10
+55	True	10
+56	True	11
+57	True	11
+58	True	11
+59	True	10
+60	True	10
+61	True	11
+62	True	10
+63	True	11
+64	True	10
+65	True	10
+66	True	11
+67	True	11
+68	True	11
+69	True	10
+70	True	10
+71	True	10
+72	True	10
+73	True	10
+74	True	11
+75	True	10
+76	True	10
+77	True	10
+78	True	9
+79	True	10
+80	True	9
+81	True	9
+82	True	10
+83	True	9
+84	True	9
+85	True	9
+86	True	9
+87	True	9
+88	True	9
+89	True	9
+90	True	9
+91	True	10
+92	True	10
+93	True	9
+94	True	9
+95	True	9
+96	True	9
+97	True	7
+98	True	7
+99	True	6
+100	True	6
+101	True	7
+102	True	8
+103	True	8
+104	True	8
+105	True	8
+106	True	9
+107	True	9
+108	True	9
+109	True	8
+110	True	8
+111	True	10
+112	True	9
+113	True	8
+114	True	9
+115	True	10
+116	True	9
+117	True	8
+118	True	7
+119	True	7
+120	True	7
+121	True	7
+122	True	9
+123	True	9
+124	True	9
+125	True	8
+126	True	7
+127	True	6
+128	True	6
+129	True	8
+130	True	8
+131	True	8
+132	True	8
+133	True	10
+134	True	10
+135	True	8
+136	True	6
+137	True	6
+138	True	8
+139	True	9
+140	True	8
+141	True	7
+142	True	7
+143	True	8
+144	True	7
+145	True	7
+146	True	7
+147	True	5
+148	True	6
+149	True	8
+150	True	9
+151	True	6
+152	True	6
+153	True	6
+154	True	7
+155	True	8
+156	True	7
+157	True	7
+158	True	7
+159	True	8
+160	True	9
+161	True	8
+162	True	8
+163	True	9
+164	True	9
+165	True	9
+166	True	8
+167	True	8
+168	True	9
+169	True	9
+170	True	8
+171	True	9
+172	True	9
+173	True	10
+174	True	10
+175	True	10
+176	True	10
+177	True	10
+178	True	10
+179	True	10
+180	True	10
+181	True	10
+182	True	10
+183	True	10
+184	True	10
+185	True	10
+186	True	10
+187	True	10
+188	True	11
+189	True	11
+190	True	11
+191	True	11
+192	True	11
+193	True	11
+194	True	11
+195	True	11
+196	True	11
+197	True	11
+198	True	11
+199	True	11
+200	True	11
+201	True	11
+202	True	11
+203	True	11
+204	True	11
+205	True	11
+206	True	11
+207	True	11
+208	True	11
+209	True	11
+210	True	11
+211	True	11
+212	True	11
+213	True	11
+214	True	11
+215	True	11
+216	True	11
+217	True	11
+218	True	11
+219	True	11
+220	True	11
+221	True	11
+222	True	11
+223	True	11
+224	True	11
+225	True	11
+226	True	11
+227	True	11
+228	True	11
+229	True	11
+230	True	11
+231	True	11
+232	True	11
+233	True	11
+234	True	11
+235	True	11
+236	True	11
+237	True	11
+238	True	11
+239	True	11
+240	True	11
+241	True	11
+242	True	11
+243	True	11
+244	True	11
+245	True	11
+246	True	11
+247	True	11
+248	True	11
+249	True	11
+250	True	11
+251	True	11
+252	True	11
+253	True	11
+254	True	11
+255	True	11
+256	True	11
+257	True	11
+258	True	11
+259	True	11
+260	True	11
+261	True	11
+262	True	11
+263	True	11
+264	True	11
+265	True	11
+266	True	11
+267	True	11
+268	True	11
+269	True	11
+270	True	11
+271	True	11
+272	True	10
+273	True	11
+274	True	11
+275	True	11
+276	True	11
+277	True	11
+278	True	11
+279	True	10
+280	True	11
+281	True	9
+282	True	9
+283	True	8
+284	True	9
+285	True	9
+286	True	10
+287	True	9
+288	True	9
+289	True	9
+290	True	9
+291	True	9
+292	True	9
+293	True	10
+294	True	10
+295	True	10
+296	True	10
+297	True	9
+298	True	10
+299	True	9
+300	True	8
+301	True	8
+302	True	8
+303	True	8
+304	True	8
+305	True	9
+306	True	8
+307	True	8
+308	True	8
+309	True	8
+310	True	9
+311	True	8
+312	True	9
+313	True	9
+314	True	10
+315	True	10
+316	True	10
+317	True	10
+318	True	10
+319	True	10
+320	True	4
+321	True	8
+322	True	8
+323	True	8
+324	True	8
+325	True	7
+326	True	8
+327	True	8
+328	True	7
+329	True	9
+330	True	8
+331	True	9
+332	True	8
+333	True	8
+334	True	8
+335	True	10
+336	True	10
+337	True	9
+338	True	10
+339	True	10
+340	True	10
+341	True	10
+342	True	10
+343	True	10
+344	True	10
+345	True	11
+346	True	11
+347	True	11
+348	True	11
+349	True	11
+350	True	11
+351	True	11
+352	True	11
+353	True	11
+354	True	11
+355	True	11
+356	True	11
+357	True	11
+358	True	11
+359	True	11
+360	True	11
+361	True	11
+362	True	11
+363	True	11
+364	True	11
+365	True	11
+366	True	11
+367	True	11
+368	True	11
+369	True	11
+370	True	11
+371	True	11
+372	True	11
+373	True	11
+374	True	11
+375	True	11
+376	True	11
+377	True	11
+378	True	11
+379	True	11
+380	True	11
+381	True	11
+382	True	11
+383	True	11
+384	True	11
+385	True	11
+386	True	11
+387	True	11
+388	True	11
+389	True	11
+390	True	11
+391	True	11
+392	True	11
+393	True	11
+394	True	11
+395	True	11
+396	True	11
+397	True	11
+398	True	11
+399	True	11
+400	True	11
+401	True	11
+402	True	11
+403	True	11
+404	True	11
+405	True	11
+406	True	11
+407	True	11
+408	True	11
+409	True	11
+410	True	11
+411	True	11
+412	True	11
+413	True	11
+414	True	11
+415	True	11
+416	True	11
+417	True	11
+418	True	11
+419	True	11
+420	True	11
+421	True	11
+422	True	11
+423	True	11
+424	True	11
+425	True	11
+426	True	11
+427	True	11
+428	True	11
+429	True	11
+430	True	11
+431	True	11
+432	True	11
+433	True	11
+434	True	11
+435	True	11
+436	True	11
+437	True	11
+438	True	11
+439	True	11
+440	True	11
+441	True	11
+442	True	11
+443	True	11
+444	True	11
+445	True	11
+446	True	10
+447	True	10
+448	True	10
+449	True	10
+450	True	10
+451	True	11
+452	True	11
+453	True	11
+454	True	10
+455	True	10
+456	True	11
+457	True	10
+458	True	10
+459	True	11
+460	True	11
+461	True	10
+462	True	9
+463	True	10
+464	True	10
+465	True	10
+466	True	10
+467	True	9
+468	True	10
+469	True	10
+470	True	11
+471	True	11
+472	True	9
+473	True	9
+474	True	9
+475	True	9
+476	True	9
+477	True	10
+478	True	10
+479	True	9
+480	True	8
+481	True	10
+482	True	10
+483	True	10
+484	True	8
+485	True	8
+486	True	9
+487	True	8
+488	True	9
+489	True	10
+490	True	11
+491	True	11
+492	True	11
+493	True	9
+494	True	10
+495	True	10
+496	True	10
+497	True	10
+498	True	11
+499	True	11
+500	True	11
+501	True	11
+502	True	11
+503	True	11
+504	True	11
+505	True	11
+506	True	11
+507	True	11
+508	True	11
+509	True	11
+510	True	11
+511	True	11
+512	True	11
+513	True	11
+514	True	11
+515	True	11
+516	True	11
+517	True	11
+518	True	11
+519	True	11
+520	True	11
+521	True	11
+522	True	11
+523	True	11
+524	True	11
+525	True	11
+526	True	11
+527	True	11
+528	True	11
+529	True	11
+530	True	11
+531	True	11
+532	True	11
+533	True	11
+534	True	11
+535	True	11
+536	True	10
+537	True	10
+538	True	10
+539	True	10
+540	True	10
+541	True	10
+542	True	11
+543	True	11
+544	True	11
+545	True	11
+546	True	11
+547	True	10
+548	True	9
+549	True	9
+550	True	10
+551	True	11
+552	True	10
+553	True	9
+554	True	9
+555	True	9
+556	True	8
+557	True	9
+558	True	7
+559	True	8
+560	True	8
+561	True	10
+562	True	9
+563	True	8
+564	True	8
+565	True	8
+566	True	8
+567	True	8
+568	True	6
+569	True	6
+570	True	6
+571	True	6
+572	True	8
+573	True	8
+574	True	7
+575	True	9
+576	True	7
+577	True	7
+578	True	8
+579	True	8
+580	True	6
+581	True	7
+582	True	7
+583	True	8
+584	True	6
+585	True	5
+586	True	5
+587	True	5
+588	True	6
+589	True	7
+590	True	6
+591	True	8
+592	True	7
+593	True	7
+594	True	8
+595	True	7
+596	True	7
+597	True	8
+598	True	5
+599	True	4
+600	True	5
+601	True	6
+602	True	5
+603	True	6
+604	True	7
+605	True	7
+606	True	9
+607	True	10
+608	True	8
+609	True	8
+610	True	10
+611	True	10
+612	True	9
+613	True	8
+614	True	8
+615	True	8
+616	True	7
+617	True	8
+618	True	7
+619	True	6
+620	True	6
+621	True	7
+622	True	7
+623	True	7
+624	True	8
+625	True	6
+626	True	7
+627	True	7
+628	True	7
+629	True	6
+630	True	5
+631	True	7
+632	True	6
+633	True	6
+634	True	7
+635	True	6
+636	True	8
+637	True	8
+638	True	6
+639	True	8
Binary file test-data/pp.filter_genes.krumsiek11-min_counts.h5ad has changed
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/test-data/pp.filter_genes.number_per_gene.krumsiek11-min_counts.tabular	Mon Mar 04 10:15:02 2019 -0500
@@ -0,0 +1,12 @@
+index	n_counts
+Gata2	163.95355
+Gata1	203.95117
+Fog1	83.94181
+EKLF	70.69286
+Fli1	57.56072
+SCL	202.67444
+Cebpa	469.87094
+Pu.1	250.78569
+cJun	188.10158
+EgrNab	164.99693
+Gfi1	159.99155
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/test-data/pp.filter_genes.number_per_gene.pbmc68k_reduced-max_cells.tabular	Mon Mar 04 10:15:02 2019 -0500
@@ -0,0 +1,222 @@
+	gene_subset	number_per_gene
+0	True	34
+1	True	123
+2	True	281
+3	True	54
+4	True	253
+5	True	63
+6	True	9
+7	True	266
+8	True	101
+9	True	233
+10	True	267
+11	True	285
+12	True	332
+13	True	197
+14	True	158
+15	True	64
+16	True	285
+17	True	229
+18	True	43
+19	True	199
+20	True	271
+21	True	318
+22	True	132
+23	True	83
+24	True	88
+25	True	87
+26	True	71
+27	True	258
+28	True	58
+29	True	348
+30	True	280
+31	True	150
+32	True	121
+33	True	237
+34	True	29
+35	True	220
+36	True	103
+37	True	87
+38	True	115
+39	True	100
+40	True	139
+41	True	23
+42	True	162
+43	True	76
+44	True	180
+45	True	51
+46	True	244
+47	True	132
+48	True	244
+49	True	82
+50	True	172
+51	True	27
+52	True	100
+53	True	327
+54	True	277
+55	True	282
+56	True	245
+57	True	21
+58	True	52
+59	True	19
+60	True	227
+61	True	288
+62	True	274
+63	True	301
+64	True	316
+65	True	314
+66	True	271
+67	True	270
+68	True	283
+69	True	245
+70	True	263
+71	True	312
+72	True	285
+73	True	228
+74	True	170
+75	True	11
+76	True	228
+77	True	192
+78	True	140
+79	True	15
+80	True	22
+81	True	10
+82	True	233
+83	True	129
+84	True	12
+85	True	297
+86	True	295
+87	True	127
+88	True	208
+89	True	281
+90	True	265
+91	True	254
+92	True	122
+93	True	76
+94	True	237
+95	True	74
+96	True	65
+97	True	45
+98	True	90
+99	True	147
+100	True	189
+101	True	170
+102	True	207
+103	True	14
+104	True	307
+105	True	267
+106	True	111
+107	True	94
+108	True	306
+109	True	126
+110	True	269
+111	True	116
+112	True	140
+113	True	260
+114	True	201
+115	True	198
+116	True	155
+117	True	256
+118	True	214
+119	True	70
+120	True	304
+121	True	336
+122	True	201
+123	True	305
+124	True	301
+125	True	301
+126	True	338
+127	True	81
+128	True	256
+129	True	277
+130	True	237
+131	True	173
+132	True	228
+133	True	64
+134	True	52
+135	True	34
+136	True	333
+137	True	285
+138	True	132
+139	True	32
+140	True	275
+141	True	31
+142	True	244
+143	True	15
+144	True	54
+145	True	289
+146	True	186
+147	True	283
+148	True	333
+149	True	53
+150	True	26
+151	True	173
+152	True	19
+153	True	109
+154	True	138
+155	True	264
+156	True	293
+157	True	225
+158	True	150
+159	True	62
+160	True	350
+161	True	13
+162	True	341
+163	True	223
+164	True	177
+165	True	15
+166	True	202
+167	True	101
+168	True	203
+169	True	271
+170	True	305
+171	True	45
+172	True	322
+173	True	164
+174	True	213
+175	True	55
+176	True	143
+177	True	112
+178	True	266
+179	True	168
+180	True	9
+181	True	300
+182	True	249
+183	True	101
+184	True	55
+185	True	312
+186	True	181
+187	True	256
+188	True	27
+189	True	242
+190	True	210
+191	True	12
+192	True	203
+193	True	41
+194	True	205
+195	True	315
+196	True	94
+197	True	262
+198	True	316
+199	True	13
+200	True	94
+201	True	204
+202	True	245
+203	True	11
+204	True	238
+205	True	301
+206	True	219
+207	True	106
+208	True	253
+209	True	134
+210	True	262
+211	True	222
+212	True	82
+213	True	153
+214	True	122
+215	True	211
+216	True	49
+217	True	211
+218	True	176
+219	True	329
+220	True	8
Binary file test-data/pp.filter_genes_dispersion.krumsiek11-seurat.h5ad has changed
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/test-data/pp.filter_genes_dispersion.per_gene.krumsiek11-cell_ranger.tabular	Mon Mar 04 10:15:02 2019 -0500
@@ -0,0 +1,12 @@
+	gene_subset	means	dispersions	dispersions_norm
+0	False	0.22807331	-1.513815	
+1	False	0.27662647	-0.6374868	
+2	False	0.12324284	-1.1931922	
+3	True	0.10477218	-0.8270577	0.67448974
+4	True	0.08612139	-0.880823	0.67448974
+5	False	0.2751125	-0.6042374	
+6	False	0.55053085	-1.5924454	
+7	False	0.3306357	-0.91260546	
+8	False	0.25766766	-0.86990273	
+9	False	0.22937028	-0.7354343	
+10	False	0.223133	-0.96748924	
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/test-data/pp.filter_genes_dispersion.per_gene.krumsiek11-seurat.tabular	Mon Mar 04 10:15:02 2019 -0500
@@ -0,0 +1,9 @@
+index	means	dispersions	dispersions_norm
+Fog1	0.12324284	-1.1931922	1.0
+EKLF	0.10477218	-0.8270577	0.70710677
+SCL	0.2751125	-0.6042374	0.707108
+Cebpa	0.55053085	-1.5924454	1.0
+Pu.1	0.3306357	-0.91260546	1.0
+cJun	0.25766766	-0.86990273	1.0
+EgrNab	0.22937028	-0.7354343	0.7071069
+Gfi1	0.223133	-0.96748924	1.0
Binary file test-data/pp.log1p.krumsiek11.h5ad has changed
Binary file test-data/pp.neighbors_gauss_braycurtis.recipe_weinreb17.paul15_subsample.h5ad has changed
Binary file test-data/pp.neighbors_umap_euclidean.recipe_weinreb17.paul15_subsample.h5ad has changed
Binary file test-data/pp.normalize_per_cell.krumsiek11.h5ad has changed
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/test-data/pp.normalize_per_cell.obs.krumsiek11.tabular	Mon Mar 04 10:15:02 2019 -0500
@@ -0,0 +1,641 @@
+index	cell_type
+0	progenitor
+1	progenitor
+2	progenitor
+3	progenitor
+4	progenitor
+5	progenitor
+6	progenitor
+7	progenitor
+8	progenitor
+9	progenitor
+10	progenitor
+11	progenitor
+12	progenitor
+13	progenitor
+14	progenitor
+15	progenitor
+16	progenitor
+17	progenitor
+18	progenitor
+19	progenitor
+20	progenitor
+21	progenitor
+22	progenitor
+23	progenitor
+24	progenitor
+25	progenitor
+26	progenitor
+27	progenitor
+28	progenitor
+29	progenitor
+30	progenitor
+31	progenitor
+32	progenitor
+33	progenitor
+34	progenitor
+35	progenitor
+36	progenitor
+37	progenitor
+38	progenitor
+39	progenitor
+40	progenitor
+41	progenitor
+42	progenitor
+43	progenitor
+44	progenitor
+45	progenitor
+46	progenitor
+47	progenitor
+48	progenitor
+49	progenitor
+50	progenitor
+51	progenitor
+52	progenitor
+53	progenitor
+54	progenitor
+55	progenitor
+56	progenitor
+57	progenitor
+58	progenitor
+59	progenitor
+60	progenitor
+61	progenitor
+62	progenitor
+63	progenitor
+64	progenitor
+65	progenitor
+66	progenitor
+67	progenitor
+68	progenitor
+69	progenitor
+70	progenitor
+71	progenitor
+72	progenitor
+73	progenitor
+74	progenitor
+75	progenitor
+76	progenitor
+77	progenitor
+78	progenitor
+79	progenitor
+80	Mo
+81	Mo
+82	Mo
+83	Mo
+84	Mo
+85	Mo
+86	Mo
+87	Mo
+88	Mo
+89	Mo
+90	Mo
+91	Mo
+92	Mo
+93	Mo
+94	Mo
+95	Mo
+96	Mo
+97	Mo
+98	Mo
+99	Mo
+100	Mo
+101	Mo
+102	Mo
+103	Mo
+104	Mo
+105	Mo
+106	Mo
+107	Mo
+108	Mo
+109	Mo
+110	Mo
+111	Mo
+112	Mo
+113	Mo
+114	Mo
+115	Mo
+116	Mo
+117	Mo
+118	Mo
+119	Mo
+120	Mo
+121	Mo
+122	Mo
+123	Mo
+124	Mo
+125	Mo
+126	Mo
+127	Mo
+128	Mo
+129	Mo
+130	Mo
+131	Mo
+132	Mo
+133	Mo
+134	Mo
+135	Mo
+136	Mo
+137	Mo
+138	Mo
+139	Mo
+140	Mo
+141	Mo
+142	Mo
+143	Mo
+144	Mo
+145	Mo
+146	Mo
+147	Mo
+148	Mo
+149	Mo
+150	Mo
+151	Mo
+152	Mo
+153	Mo
+154	Mo
+155	Mo
+156	Mo
+157	Mo
+158	Mo
+159	Mo
+0	progenitor
+1	progenitor
+2	progenitor
+3	progenitor
+4	progenitor
+5	progenitor
+6	progenitor
+7	progenitor
+8	progenitor
+9	progenitor
+10	progenitor
+11	progenitor
+12	progenitor
+13	progenitor
+14	progenitor
+15	progenitor
+16	progenitor
+17	progenitor
+18	progenitor
+19	progenitor
+20	progenitor
+21	progenitor
+22	progenitor
+23	progenitor
+24	progenitor
+25	progenitor
+26	progenitor
+27	progenitor
+28	progenitor
+29	progenitor
+30	progenitor
+31	progenitor
+32	progenitor
+33	progenitor
+34	progenitor
+35	progenitor
+36	progenitor
+37	progenitor
+38	progenitor
+39	progenitor
+40	progenitor
+41	progenitor
+42	progenitor
+43	progenitor
+44	progenitor
+45	progenitor
+46	progenitor
+47	progenitor
+48	progenitor
+49	progenitor
+50	progenitor
+51	progenitor
+52	progenitor
+53	progenitor
+54	progenitor
+55	progenitor
+56	progenitor
+57	progenitor
+58	progenitor
+59	progenitor
+60	progenitor
+61	progenitor
+62	progenitor
+63	progenitor
+64	progenitor
+65	progenitor
+66	progenitor
+67	progenitor
+68	progenitor
+69	progenitor
+70	progenitor
+71	progenitor
+72	progenitor
+73	progenitor
+74	progenitor
+75	progenitor
+76	progenitor
+77	progenitor
+78	progenitor
+79	progenitor
+80	Ery
+81	Ery
+82	Ery
+83	Ery
+84	Ery
+85	Ery
+86	Ery
+87	Ery
+88	Ery
+89	Ery
+90	Ery
+91	Ery
+92	Ery
+93	Ery
+94	Ery
+95	Ery
+96	Ery
+97	Ery
+98	Ery
+99	Ery
+100	Ery
+101	Ery
+102	Ery
+103	Ery
+104	Ery
+105	Ery
+106	Ery
+107	Ery
+108	Ery
+109	Ery
+110	Ery
+111	Ery
+112	Ery
+113	Ery
+114	Ery
+115	Ery
+116	Ery
+117	Ery
+118	Ery
+119	Ery
+120	Ery
+121	Ery
+122	Ery
+123	Ery
+124	Ery
+125	Ery
+126	Ery
+127	Ery
+128	Ery
+129	Ery
+130	Ery
+131	Ery
+132	Ery
+133	Ery
+134	Ery
+135	Ery
+136	Ery
+137	Ery
+138	Ery
+139	Ery
+140	Ery
+141	Ery
+142	Ery
+143	Ery
+144	Ery
+145	Ery
+146	Ery
+147	Ery
+148	Ery
+149	Ery
+150	Ery
+151	Ery
+152	Ery
+153	Ery
+154	Ery
+155	Ery
+156	Ery
+157	Ery
+158	Ery
+159	Ery
+0	progenitor
+1	progenitor
+2	progenitor
+3	progenitor
+4	progenitor
+5	progenitor
+6	progenitor
+7	progenitor
+8	progenitor
+9	progenitor
+10	progenitor
+11	progenitor
+12	progenitor
+13	progenitor
+14	progenitor
+15	progenitor
+16	progenitor
+17	progenitor
+18	progenitor
+19	progenitor
+20	progenitor
+21	progenitor
+22	progenitor
+23	progenitor
+24	progenitor
+25	progenitor
+26	progenitor
+27	progenitor
+28	progenitor
+29	progenitor
+30	progenitor
+31	progenitor
+32	progenitor
+33	progenitor
+34	progenitor
+35	progenitor
+36	progenitor
+37	progenitor
+38	progenitor
+39	progenitor
+40	progenitor
+41	progenitor
+42	progenitor
+43	progenitor
+44	progenitor
+45	progenitor
+46	progenitor
+47	progenitor
+48	progenitor
+49	progenitor
+50	progenitor
+51	progenitor
+52	progenitor
+53	progenitor
+54	progenitor
+55	progenitor
+56	progenitor
+57	progenitor
+58	progenitor
+59	progenitor
+60	progenitor
+61	progenitor
+62	progenitor
+63	progenitor
+64	progenitor
+65	progenitor
+66	progenitor
+67	progenitor
+68	progenitor
+69	progenitor
+70	progenitor
+71	progenitor
+72	progenitor
+73	progenitor
+74	progenitor
+75	progenitor
+76	progenitor
+77	progenitor
+78	progenitor
+79	progenitor
+80	Mk
+81	Mk
+82	Mk
+83	Mk
+84	Mk
+85	Mk
+86	Mk
+87	Mk
+88	Mk
+89	Mk
+90	Mk
+91	Mk
+92	Mk
+93	Mk
+94	Mk
+95	Mk
+96	Mk
+97	Mk
+98	Mk
+99	Mk
+100	Mk
+101	Mk
+102	Mk
+103	Mk
+104	Mk
+105	Mk
+106	Mk
+107	Mk
+108	Mk
+109	Mk
+110	Mk
+111	Mk
+112	Mk
+113	Mk
+114	Mk
+115	Mk
+116	Mk
+117	Mk
+118	Mk
+119	Mk
+120	Mk
+121	Mk
+122	Mk
+123	Mk
+124	Mk
+125	Mk
+126	Mk
+127	Mk
+128	Mk
+129	Mk
+130	Mk
+131	Mk
+132	Mk
+133	Mk
+134	Mk
+135	Mk
+136	Mk
+137	Mk
+138	Mk
+139	Mk
+140	Mk
+141	Mk
+142	Mk
+143	Mk
+144	Mk
+145	Mk
+146	Mk
+147	Mk
+148	Mk
+149	Mk
+150	Mk
+151	Mk
+152	Mk
+153	Mk
+154	Mk
+155	Mk
+156	Mk
+157	Mk
+158	Mk
+159	Mk
+0	progenitor
+1	progenitor
+2	progenitor
+3	progenitor
+4	progenitor
+5	progenitor
+6	progenitor
+7	progenitor
+8	progenitor
+9	progenitor
+10	progenitor
+11	progenitor
+12	progenitor
+13	progenitor
+14	progenitor
+15	progenitor
+16	progenitor
+17	progenitor
+18	progenitor
+19	progenitor
+20	progenitor
+21	progenitor
+22	progenitor
+23	progenitor
+24	progenitor
+25	progenitor
+26	progenitor
+27	progenitor
+28	progenitor
+29	progenitor
+30	progenitor
+31	progenitor
+32	progenitor
+33	progenitor
+34	progenitor
+35	progenitor
+36	progenitor
+37	progenitor
+38	progenitor
+39	progenitor
+40	progenitor
+41	progenitor
+42	progenitor
+43	progenitor
+44	progenitor
+45	progenitor
+46	progenitor
+47	progenitor
+48	progenitor
+49	progenitor
+50	progenitor
+51	progenitor
+52	progenitor
+53	progenitor
+54	progenitor
+55	progenitor
+56	progenitor
+57	progenitor
+58	progenitor
+59	progenitor
+60	progenitor
+61	progenitor
+62	progenitor
+63	progenitor
+64	progenitor
+65	progenitor
+66	progenitor
+67	progenitor
+68	progenitor
+69	progenitor
+70	progenitor
+71	progenitor
+72	progenitor
+73	progenitor
+74	progenitor
+75	progenitor
+76	progenitor
+77	progenitor
+78	progenitor
+79	progenitor
+80	Neu
+81	Neu
+82	Neu
+83	Neu
+84	Neu
+85	Neu
+86	Neu
+87	Neu
+88	Neu
+89	Neu
+90	Neu
+91	Neu
+92	Neu
+93	Neu
+94	Neu
+95	Neu
+96	Neu
+97	Neu
+98	Neu
+99	Neu
+100	Neu
+101	Neu
+102	Neu
+103	Neu
+104	Neu
+105	Neu
+106	Neu
+107	Neu
+108	Neu
+109	Neu
+110	Neu
+111	Neu
+112	Neu
+113	Neu
+114	Neu
+115	Neu
+116	Neu
+117	Neu
+118	Neu
+119	Neu
+120	Neu
+121	Neu
+122	Neu
+123	Neu
+124	Neu
+125	Neu
+126	Neu
+127	Neu
+128	Neu
+129	Neu
+130	Neu
+131	Neu
+132	Neu
+133	Neu
+134	Neu
+135	Neu
+136	Neu
+137	Neu
+138	Neu
+139	Neu
+140	Neu
+141	Neu
+142	Neu
+143	Neu
+144	Neu
+145	Neu
+146	Neu
+147	Neu
+148	Neu
+149	Neu
+150	Neu
+151	Neu
+152	Neu
+153	Neu
+154	Neu
+155	Neu
+156	Neu
+157	Neu
+158	Neu
+159	Neu
Binary file test-data/pp.pca.krumsiek11.h5ad has changed
Binary file test-data/pp.pca.krumsiek11_chunk.h5ad has changed
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/test-data/pp.pca.variance.krumsiek11.tabular	Mon Mar 04 10:15:02 2019 -0500
@@ -0,0 +1,10 @@
+7.540945410728454590e-01
+2.517578899860382080e-01
+8.900784701108932495e-02
+4.575614631175994873e-02
+2.166538313031196594e-02
+5.896944552659988403e-03
+2.081273589283227921e-03
+1.173791475594043732e-03
+1.542696409160271287e-04
+3.281867248006165028e-05
Binary file test-data/pp.recipe_seurat.recipe_zheng17.h5ad has changed
Binary file test-data/pp.recipe_weinreb17.paul15_subsample.h5ad has changed
Binary file test-data/pp.recipe_zheng17.random-randint.h5ad has changed
Binary file test-data/pp.regress_out.krumsiek11.h5ad has changed
Binary file test-data/pp.scale.krumsiek11.h5ad has changed
Binary file test-data/pp.scale_max_value.krumsiek11.h5ad has changed
Binary file test-data/pp.sqrt.krumsiek11.h5ad has changed
Binary file test-data/pp.subsample.krumsiek11_fraction.h5ad has changed
Binary file test-data/pp.subsample.krumsiek11_n_obs.h5ad has changed
Binary file test-data/random-randint.h5ad has changed
Binary file test-data/random.h5ad has changed
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/test-data/tl.diffmap.neighbors_gauss_braycurtis.recipe_weinreb17.paul15_subsample.X_diffmap.tabular	Mon Mar 04 10:15:02 2019 -0500
@@ -0,0 +1,100 @@
+1.006254479289054871e-01	7.390013337135314941e-02	5.162549763917922974e-02	-6.088243797421455383e-02	1.660361140966415405e-02	2.669865079224109650e-02	-1.013666391372680664e-01	5.378784239292144775e-02	2.008118629455566406e-01	1.484276503324508667e-01	1.083310469985008240e-01	1.318635195493698120e-01	1.997928470373153687e-01	-7.899370044469833374e-02	-2.425468564033508301e-01
+9.916571527719497681e-02	-6.192789599299430847e-02	3.743748366832733154e-02	5.766532197594642639e-02	2.186784986406564713e-03	-1.058542281389236450e-01	5.377947166562080383e-02	1.402157917618751526e-02	1.486204266548156738e-01	8.553525805473327637e-02	2.134956121444702148e-01	-9.449188411235809326e-02	-9.736447781324386597e-02	-6.411797553300857544e-02	-3.109178543090820312e-01
+1.063194051384925842e-01	8.235514909029006958e-02	9.153002500534057617e-02	-1.288201361894607544e-01	2.123118191957473755e-02	-5.571385100483894348e-02	4.388944245874881744e-03	-1.907968819141387939e-01	5.077145248651504517e-02	-5.320586264133453369e-02	-2.017502486705780029e-02	2.888677455484867096e-02	-3.507991880178451538e-02	5.667190253734588623e-02	7.913256995379924774e-03
+9.840648621320724487e-02	-4.607489332556724548e-02	3.584916703402996063e-03	1.064319070428609848e-02	-1.083880066871643066e-01	1.248296573758125305e-01	6.351136416196823120e-02	1.885401159524917603e-01	-2.020059973001480103e-01	3.631909489631652832e-01	1.699842363595962524e-01	1.017943695187568665e-01	-1.385858207941055298e-01	3.727469593286514282e-02	8.702995628118515015e-02
+1.002686843276023865e-01	8.042127639055252075e-02	-1.485065966844558716e-01	-1.834145635366439819e-01	1.185779422521591187e-01	-4.452232271432876587e-03	2.401492185890674591e-02	1.709450007183477283e-04	-1.044583246111869812e-01	1.082587465643882751e-01	8.498968929052352905e-02	1.078867260366678238e-02	1.678988523781299591e-02	-4.863050952553749084e-02	-8.437795564532279968e-03
+1.039626300334930420e-01	6.898555904626846313e-02	-5.245065316557884216e-02	-1.401370912790298462e-01	1.724163144826889038e-01	-9.417925775051116943e-02	5.670287460088729858e-02	-2.294020541012287140e-02	-1.041278913617134094e-01	-4.751206189393997192e-02	-2.486055344343185425e-02	1.906321793794631958e-01	-1.133706346154212952e-01	1.018952578306198120e-01	-1.696813404560089111e-01
+1.031595841050148010e-01	6.644981354475021362e-02	-3.434765338897705078e-02	-8.121536672115325928e-02	-2.303110063076019287e-01	6.845026742666959763e-03	-3.113305754959583282e-02	3.572509065270423889e-02	-2.340330332517623901e-01	1.681309342384338379e-01	2.042572945356369019e-01	-2.152139544486999512e-01	3.323959186673164368e-02	-1.992796063423156738e-01	1.612142026424407959e-01
+1.063378602266311646e-01	9.444754570722579956e-02	1.147621273994445801e-01	-1.788049340248107910e-01	1.663699001073837280e-01	-1.299377232789993286e-01	9.099455177783966064e-02	8.901253342628479004e-02	-3.782828152179718018e-02	1.340985000133514404e-01	-1.110952645540237427e-01	-1.353431493043899536e-01	9.196916222572326660e-02	-5.004190653562545776e-02	1.283620446920394897e-01
+1.019066423177719116e-01	3.868932276964187622e-02	-5.681320559233427048e-03	2.885684370994567871e-02	-1.618600785732269287e-01	-7.793435454368591309e-02	-6.321301311254501343e-02	-7.030926644802093506e-02	-8.451142162084579468e-02	1.784774512052536011e-01	-5.302700772881507874e-02	2.233742922544479370e-02	-8.568169549107551575e-03	-3.328817337751388550e-02	-2.190946601331233978e-02
+1.055724918842315674e-01	6.597422808408737183e-02	1.207857206463813782e-01	-1.769655644893646240e-01	-1.941676251590251923e-02	-2.537060342729091644e-02	2.017348445951938629e-02	2.019873559474945068e-01	2.603957951068878174e-01	-8.517616987228393555e-02	1.920531690120697021e-01	3.013696968555450439e-01	1.285752207040786743e-01	-6.937998533248901367e-02	2.583270706236362457e-02
+1.013405695557594299e-01	7.315808534622192383e-02	-4.366664588451385498e-02	2.623320743441581726e-02	-1.268581300973892212e-01	-9.996589273214340210e-02	3.801496233791112900e-03	-1.574327796697616577e-01	8.082801103591918945e-02	-1.715112775564193726e-01	1.981573849916458130e-01	-9.785132110118865967e-02	-4.965898115187883377e-03	9.352693706750869751e-02	3.635504096746444702e-02
+1.001976355910301208e-01	7.669639587402343750e-02	5.201552435755729675e-02	2.700087428092956543e-01	2.118834294378757477e-02	-5.663126334547996521e-02	-8.477722853422164917e-02	9.727138280868530273e-02	-8.382367901504039764e-03	-1.135666593909263611e-01	1.608509272336959839e-01	1.184404194355010986e-01	1.566798686981201172e-01	-7.676979992538690567e-03	4.270016402006149292e-02
+9.744150936603546143e-02	-1.296482831239700317e-01	-1.239879243075847626e-02	1.855848357081413269e-02	-2.284491062164306641e-02	-1.009282022714614868e-01	7.055556029081344604e-02	4.106458649039268494e-02	-6.035594642162322998e-02	-1.043885275721549988e-01	-1.532001048326492310e-01	4.817606508731842041e-02	7.467575371265411377e-02	-1.860609161667525768e-03	3.278955444693565369e-02
+9.364669770002365112e-02	-1.809429824352264404e-01	-1.568255946040153503e-02	-1.347039826214313507e-02	5.973972380161285400e-03	-5.848481878638267517e-02	-5.189557373523712158e-02	-3.990079089999198914e-02	2.690394036471843719e-02	3.291362524032592773e-02	5.178750306367874146e-02	-1.781906234100461006e-03	1.922948169521987438e-03	3.529559448361396790e-02	-4.709535860456526279e-04
+9.947066009044647217e-02	8.559655398130416870e-02	-1.963858157396316528e-01	-5.146042443811893463e-03	-2.873218990862369537e-02	3.527766466140747070e-02	3.702211426571011543e-03	-5.826206132769584656e-02	-5.298026651144027710e-02	1.265548728406429291e-02	-9.924994409084320068e-02	7.643856108188629150e-02	-3.946479875594377518e-03	-6.800348311662673950e-02	1.005024369806051254e-02
+9.972835332155227661e-02	-5.728941038250923157e-02	1.164532150141894817e-03	-2.283337898552417755e-02	-8.941999077796936035e-02	1.752964705228805542e-01	7.918696850538253784e-02	-1.626298427581787109e-01	5.423834919929504395e-02	1.800755560398101807e-01	-3.383423760533332825e-02	3.943570330739021301e-02	2.784142494201660156e-01	1.194428130984306335e-01	-1.088062301278114319e-01
+1.063553839921951294e-01	6.921559572219848633e-02	2.080408483743667603e-01	-7.342543452978134155e-02	1.763515174388885498e-01	-5.611616000533103943e-02	6.127767637372016907e-02	-1.789846867322921753e-01	-1.116973087191581726e-01	5.425352230668067932e-02	4.038978368043899536e-02	-1.916505545377731323e-01	1.254186034202575684e-01	6.859276443719863892e-02	6.871620565652847290e-02
+9.730846434831619263e-02	-1.349723786115646362e-01	-3.723482042551040649e-02	3.166849538683891296e-02	4.175714775919914246e-02	-8.143801242113113403e-02	1.949654072523117065e-01	5.183657631278038025e-02	6.802517175674438477e-02	5.463999882340431213e-02	-4.301572218537330627e-03	-7.239108532667160034e-02	1.697570271790027618e-02	-1.546490471810102463e-02	8.058656007051467896e-02
+9.557868540287017822e-02	-1.378565728664398193e-01	-1.682972908020019531e-02	-1.662165974266827106e-03	-2.648654952645301819e-02	-9.425739943981170654e-02	6.581720709800720215e-02	-1.690089106559753418e-01	3.114995732903480530e-02	-2.066969871520996094e-02	1.702432520687580109e-02	-4.617675766348838806e-02	-3.817678987979888916e-02	-4.838168621063232422e-02	-4.461381956934928894e-02
+9.572254866361618042e-02	-1.157653778791427612e-01	-2.745305374264717102e-02	2.824329398572444916e-02	1.683281175792217255e-02	-7.204449176788330078e-02	1.442870348691940308e-01	-1.112484484910964966e-01	5.254449322819709778e-02	-4.310525953769683838e-02	-6.537265330553054810e-02	9.152984619140625000e-02	1.099050277844071388e-03	4.806879535317420959e-02	8.303747326135635376e-02
+1.017507240176200867e-01	6.871048361063003540e-02	-2.869148179888725281e-02	-1.148616150021553040e-01	-2.352946251630783081e-01	-2.909171022474765778e-02	5.929908156394958496e-02	1.573819369077682495e-01	-2.147024124860763550e-01	-3.502381592988967896e-02	-5.037564784288406372e-02	7.337512075901031494e-02	-1.265074359253048897e-03	1.872758269309997559e-01	4.964049533009529114e-02
+9.428320080041885376e-02	-1.354417204856872559e-01	8.272815495729446411e-03	2.385292761027812958e-02	-8.242442272603511810e-03	-7.430975139141082764e-02	-1.742218136787414551e-01	-5.538051947951316833e-03	-1.018167193979024887e-02	1.547044795006513596e-02	8.455148199573159218e-04	5.404802784323692322e-02	5.126107111573219299e-02	-6.693445146083831787e-03	-1.268707681447267532e-02
+9.686828404664993286e-02	7.426099479198455811e-02	-1.982558220624923706e-01	-3.170682583004236221e-03	1.799695640802383423e-01	-3.648606827482581139e-03	2.222890593111515045e-02	2.509209886193275452e-02	3.848403692245483398e-02	-9.611283242702484131e-02	-1.264516962692141533e-03	7.569468766450881958e-02	-4.498184472322463989e-02	4.383683577179908752e-02	-5.853280797600746155e-02
+1.042621433734893799e-01	6.099966540932655334e-02	1.840294301509857178e-01	1.754992753267288208e-01	6.823045015335083008e-02	-6.831583380699157715e-02	-6.362004578113555908e-02	-1.517322100698947906e-02	-1.908881068229675293e-01	2.010526834055781364e-03	-2.508206292986869812e-02	-1.952427774667739868e-01	1.529918909072875977e-01	8.812237530946731567e-03	-3.321791067719459534e-02
+9.637255966663360596e-02	7.963524758815765381e-02	-1.717496514320373535e-01	5.302957445383071899e-02	8.758340775966644287e-02	4.953101277351379395e-02	-1.924332347698509693e-03	1.019738893955945969e-02	5.325353518128395081e-02	2.628941275179386139e-02	-8.831731975078582764e-02	1.133090700022876263e-03	3.478634357452392578e-02	-4.082480445504188538e-02	2.803635410964488983e-02
+1.061019226908683777e-01	-1.301048509776592255e-02	8.831021934747695923e-02	5.576367303729057312e-02	-2.309499494731426239e-02	3.766698539257049561e-01	6.932982802391052246e-02	-1.278860960155725479e-02	-9.938260912895202637e-02	-1.299702078104019165e-01	-1.411890983581542969e-01	2.314591221511363983e-02	2.776186168193817139e-01	1.167302802205085754e-01	-1.185707077383995056e-01
+1.057639271020889282e-01	8.270046114921569824e-02	1.476289331912994385e-01	-6.666278839111328125e-02	-5.550191178917884827e-02	-3.524509444832801819e-02	-7.368044555187225342e-02	1.785134151577949524e-02	1.306160390377044678e-01	-2.507601305842399597e-02	-3.894129768013954163e-02	-1.468869149684906006e-01	-4.083442315459251404e-02	-1.527885906398296356e-02	1.039780024439096451e-02
+1.033702343702316284e-01	4.658226296305656433e-02	9.960353374481201172e-02	2.222209423780441284e-01	9.922166168689727783e-02	1.302605494856834412e-02	-5.205357074737548828e-02	4.135281778872013092e-04	-9.018164128065109253e-02	1.557689346373081207e-02	-1.260346621274948120e-01	4.821802303194999695e-02	-7.068537920713424683e-02	-2.585342526435852051e-01	1.349274534732103348e-02
+9.477795660495758057e-02	-1.554774045944213867e-01	-6.355965044349431992e-03	-3.065563924610614777e-02	-2.320274477824568748e-03	2.243204414844512939e-02	8.106533437967300415e-03	-5.485361907631158829e-03	-7.122739404439926147e-02	-4.912284016609191895e-02	-1.642951183021068573e-02	-3.334269672632217407e-02	9.506576508283615112e-02	3.177214413881301880e-02	-7.037246599793434143e-03
+1.041858941316604614e-01	4.901642724871635437e-02	1.881349086761474609e-01	2.629276830703020096e-03	2.207450568675994873e-02	1.956734210252761841e-01	-5.738193169236183167e-02	-1.309214830398559570e-01	5.612225830554962158e-02	-4.862225800752639771e-02	1.449161618947982788e-01	2.058826237916946411e-01	-6.669452041387557983e-02	-1.336530447006225586e-01	-4.366984590888023376e-02
+1.014385446906089783e-01	-4.612392559647560120e-02	-6.257595028728246689e-03	6.506688147783279419e-02	5.844650417566299438e-02	1.481245607137680054e-01	7.974769175052642822e-02	-5.714906007051467896e-02	2.003025263547897339e-02	-8.641435950994491577e-02	-2.218966186046600342e-02	2.825243771076202393e-02	-5.980410613119602203e-03	-4.802919924259185791e-02	-2.706299908459186554e-02
+1.019275709986686707e-01	-9.805458039045333862e-02	-2.528023440390825272e-03	-2.206768654286861420e-02	-6.094220653176307678e-02	1.697291433811187744e-01	2.995367646217346191e-01	1.458646506071090698e-01	-1.148837730288505554e-01	-1.631249487400054932e-01	6.046377122402191162e-02	-6.091985478997230530e-02	-9.345711767673492432e-02	-1.146302819252014160e-01	-6.680992990732192993e-02
+9.670515358448028564e-02	-1.625915020704269409e-01	-2.481849864125251770e-03	-4.520184919238090515e-02	-1.349300728179514408e-03	-2.573280408978462219e-02	-3.020944632589817047e-02	7.099823653697967529e-02	4.214366152882575989e-02	-2.898849919438362122e-02	2.248373813927173615e-02	-5.621459335088729858e-02	-8.263271301984786987e-02	-7.671217899769544601e-03	-7.041502743959426880e-03
+9.790167957544326782e-02	7.039222121238708496e-02	-1.774167567491531372e-01	-3.065176308155059814e-02	1.744043976068496704e-01	9.052980691194534302e-02	-3.136295452713966370e-02	-2.621344476938247681e-02	-1.041591726243495941e-02	-1.250211596488952637e-01	-2.442165464162826538e-02	-5.774322524666786194e-02	-1.320297718048095703e-01	-9.654930979013442993e-02	1.349056810140609741e-01
+9.792804718017578125e-02	5.769139528274536133e-02	-9.987217187881469727e-02	9.300402551889419556e-02	-6.949677597731351852e-03	-3.404668346047401428e-02	9.231559932231903076e-02	5.160513147711753845e-02	1.609171479940414429e-01	1.343503147363662720e-01	-1.734616011381149292e-01	-1.384260654449462891e-01	-9.630931913852691650e-02	-7.621422410011291504e-02	-1.551136225461959839e-01
+9.476174414157867432e-02	-1.110036522150039673e-01	-1.526500005275011063e-02	-3.676902130246162415e-02	-9.109597653150558472e-02	-9.239159524440765381e-02	1.616749167442321777e-02	-1.986319273710250854e-01	-8.253418840467929840e-03	2.224889211356639862e-02	-1.059062080457806587e-03	-4.505279660224914551e-02	3.057709522545337677e-02	-2.214481681585311890e-02	4.315280541777610779e-02
+9.417848289012908936e-02	6.193256750702857971e-02	-1.422626525163650513e-01	1.917927898466587067e-02	-1.250294223427772522e-02	-4.498282819986343384e-02	6.364709883928298950e-02	-2.036240696907043457e-02	2.362496964633464813e-02	-7.819373160600662231e-02	1.323003172874450684e-01	2.130920812487602234e-02	-5.405363161116838455e-03	6.362792104482650757e-02	1.635468006134033203e-02
+9.548019617795944214e-02	-1.779708117246627808e-01	-8.975042030215263367e-03	-2.999478019773960114e-02	4.545003920793533325e-02	5.566985532641410828e-02	-5.788084492087364197e-02	1.256971210241317749e-01	-4.598109424114227295e-02	-4.915640503168106079e-02	-4.440484568476676941e-02	2.092318236827850342e-02	2.757432311773300171e-02	1.070784498006105423e-02	2.980512753129005432e-02
+9.977434575557708740e-02	5.892081186175346375e-02	-9.230908751487731934e-02	9.639902040362358093e-03	-1.274359226226806641e-01	-1.662229187786579132e-02	4.402523860335350037e-02	-8.202790468931198120e-02	1.435073465108871460e-02	5.877543985843658447e-02	9.935144335031509399e-02	2.146081533282995224e-03	-2.864263765513896942e-02	-4.906255006790161133e-02	-3.847812861204147339e-02
+1.027446687221527100e-01	7.624021172523498535e-02	1.120918523520231247e-02	8.831836283206939697e-02	-1.509995460510253906e-01	6.561069935560226440e-02	-8.483945578336715698e-02	-1.304500848054885864e-01	3.499194234609603882e-02	-6.071432679891586304e-02	1.464422196149826050e-01	-4.895902425050735474e-02	2.498662322759628296e-01	-1.350328773260116577e-01	5.197114497423171997e-02
+1.007124558091163635e-01	-9.498898684978485107e-02	1.600779406726360321e-02	-6.713904440402984619e-02	9.510654956102371216e-02	2.613145112991333008e-01	5.298715829849243164e-02	2.186571434140205383e-02	-1.953593045473098755e-01	-6.295756995677947998e-02	-4.816478863358497620e-02	-7.176841050386428833e-02	1.176497116684913635e-01	7.941282540559768677e-02	-1.130634639412164688e-02
+1.058567389845848083e-01	5.670538917183876038e-02	9.846317023038864136e-02	2.081715762615203857e-01	-6.757875531911849976e-02	-1.148305535316467285e-01	3.380669280886650085e-02	2.123793512582778931e-01	-1.718706488609313965e-01	-2.019357532262802124e-01	2.760044531896710396e-03	-1.770434081554412842e-01	2.421746402978897095e-02	-2.580799460411071777e-01	-1.511664241552352905e-01
+9.994039684534072876e-02	-5.237572267651557922e-02	-3.030188940465450287e-02	1.411070674657821655e-01	-2.770690061151981354e-02	1.953638531267642975e-02	1.266712099313735962e-01	9.288331866264343262e-02	7.042742520570755005e-02	-1.118599325418472290e-01	-1.744727045297622681e-01	-6.401036866009235382e-03	1.090899556875228882e-01	-1.459762454032897949e-01	-1.650056093931198120e-01
+9.939632564783096313e-02	8.044686913490295410e-02	-1.665522307157516479e-01	-3.347875922918319702e-02	-1.193663105368614197e-01	2.643955498933792114e-02	-2.088110893964767456e-02	-2.552646957337856293e-02	-8.814702183008193970e-02	2.117055468261241913e-02	-3.291779011487960815e-02	1.364665105938911438e-02	2.119231596589088440e-02	-9.942702949047088623e-02	4.783578217029571533e-02
+9.181451052427291870e-02	-1.824584603309631348e-01	-1.307924278080463409e-02	-4.180047288537025452e-02	7.577048614621162415e-03	-7.718593627214431763e-02	-1.775113046169281006e-01	-3.451743349432945251e-02	1.008456572890281677e-02	-1.162463147193193436e-02	6.200802046805620193e-03	5.095251370221376419e-03	3.772788448259234428e-03	1.403792575001716614e-02	-7.958821021020412445e-03
+1.020366400480270386e-01	5.088304728269577026e-02	3.272717446088790894e-02	-1.456688642501831055e-01	-2.295345254242420197e-02	-1.016464307904243469e-01	1.475215405225753784e-01	1.740464121103286743e-01	-4.927166271954774857e-03	2.739141285419464111e-01	-1.155362352728843689e-01	-4.547961056232452393e-02	6.654956191778182983e-02	-7.726808544248342514e-03	4.666358605027198792e-02
+1.017608344554901123e-01	1.159704197198152542e-02	1.786869317293167114e-01	-8.475835621356964111e-02	1.061371788382530212e-01	6.321826577186584473e-02	3.605883941054344177e-02	-2.101089507341384888e-01	-1.602706909179687500e-01	6.894896179437637329e-02	5.363681167364120483e-02	1.400205790996551514e-01	-1.765108257532119751e-01	-2.672278694808483124e-02	3.528797999024391174e-02
+1.053973138332366943e-01	5.980503559112548828e-02	1.294687092304229736e-01	8.599842339754104614e-02	-5.153755843639373779e-02	-1.123336516320705414e-02	-8.372586220502853394e-02	6.772116571664810181e-02	-2.525310218334197998e-02	-1.527518033981323242e-01	-6.109386309981346130e-02	9.316059201955795288e-02	3.940534591674804688e-02	6.032083183526992798e-02	1.056960150599479675e-01
+9.307835251092910767e-02	-1.894880682229995728e-01	-1.744995266199111938e-02	-2.943326905369758606e-02	2.312117069959640503e-02	-7.852952927350997925e-02	-9.915205091238021851e-02	-7.527264300733804703e-03	2.069273591041564941e-02	1.242756377905607224e-02	1.593445427715778351e-02	2.069955226033926010e-03	-1.014956273138523102e-02	-1.058064633980393410e-03	-2.485149540007114410e-02
+1.096552833914756775e-01	8.830883353948593140e-02	1.838217973709106445e-01	-1.679951250553131104e-01	1.281235069036483765e-01	-2.967997267842292786e-02	6.718355417251586914e-02	-6.985174864530563354e-02	-1.050625219941139221e-01	-1.021873503923416138e-01	1.065925285220146179e-01	1.964906789362430573e-02	-9.339028620161116123e-04	-1.147233247756958008e-01	-9.296967089176177979e-02
+1.084800511598587036e-01	6.826906651258468628e-02	2.033265233039855957e-01	-1.296351104974746704e-01	3.208687156438827515e-02	9.674745611846446991e-03	1.818936690688133240e-02	-9.582243114709854126e-02	7.843807339668273926e-02	4.039196297526359558e-02	-2.155345827341079712e-01	-1.577789783477783203e-01	1.516564339399337769e-01	6.666070222854614258e-02	7.346466928720474243e-02
+1.039668172597885132e-01	8.601240813732147217e-02	4.633598774671554565e-02	-1.770939119160175323e-02	5.830590799450874329e-02	9.115639328956604004e-02	-2.177701704204082489e-02	5.951844155788421631e-02	5.083320289850234985e-02	-2.459524758160114288e-02	-1.903394423425197601e-02	1.292291432619094849e-01	-1.702900677919387817e-01	-1.560598313808441162e-01	-8.106053620576858521e-02
+1.049690097570419312e-01	7.046835869550704956e-02	1.809345781803131104e-01	1.191162243485450745e-01	4.144360497593879700e-02	9.311024099588394165e-02	-6.507906317710876465e-02	-3.033739328384399414e-02	-6.379290670156478882e-02	1.814640760421752930e-01	-9.738548099994659424e-02	-7.513097673654556274e-02	-1.740936338901519775e-01	2.220288068056106567e-01	1.151594594120979309e-01
+1.052022203803062439e-01	6.111931055784225464e-02	6.439048796892166138e-02	2.338735014200210571e-01	2.994438074529170990e-02	-6.889136880636215210e-02	2.095837378874421120e-03	-4.114958271384239197e-02	-1.069214381277561188e-02	7.941628992557525635e-02	-1.962262839078903198e-01	1.201168522238731384e-01	-8.384832739830017090e-02	-9.490247815847396851e-03	1.106658428907394409e-01
+9.998116642236709595e-02	2.039877325296401978e-02	4.376422241330146790e-02	2.977356314659118652e-01	1.436971500515937805e-02	-1.688353270292282104e-01	-5.432502180337905884e-02	7.137454301118850708e-02	-1.399741619825363159e-01	1.189125776290893555e-01	1.475899368524551392e-01	-3.964446485042572021e-02	-7.533613592386245728e-02	2.176573425531387329e-01	5.747236777096986771e-03
+1.002084985375404358e-01	7.954944670200347900e-02	-8.533553779125213623e-02	-4.217643290758132935e-02	1.198484152555465698e-01	-3.491419553756713867e-02	6.017883121967315674e-02	1.294819116592407227e-01	3.572440519928932190e-02	1.924678124487400055e-02	1.396540645509958267e-02	3.103173151612281799e-02	1.801325939595699310e-02	-2.653031144291162491e-03	2.304823510348796844e-02
+9.777025133371353149e-02	-1.042842194437980652e-01	2.082869783043861389e-02	-3.860146924853324890e-02	5.125629529356956482e-02	2.080539464950561523e-01	-1.654386669397354126e-01	4.806843400001525879e-02	3.355716541409492493e-02	8.775050938129425049e-02	-1.434527039527893066e-01	-9.607073850929737091e-03	-5.951974168419837952e-02	-8.223409205675125122e-02	-1.461203955113887787e-02
+1.019103005528450012e-01	8.671076595783233643e-02	-7.325944304466247559e-02	-1.174783334136009216e-01	1.129657402634620667e-01	-3.813041374087333679e-02	-1.566699706017971039e-02	-5.187815427780151367e-02	8.993184566497802734e-02	-4.521354660391807556e-02	-4.131594672799110413e-02	-4.266967996954917908e-02	3.811590373516082764e-02	-4.174317046999931335e-02	2.299142330884933472e-01
+9.619058668613433838e-02	6.313768029212951660e-02	-1.249785348773002625e-01	3.527817502617835999e-02	7.962471991777420044e-02	2.284124493598937988e-02	-7.864867150783538818e-02	-3.863862156867980957e-02	8.502854034304618835e-04	1.686216890811920166e-02	1.423155814409255981e-01	-1.534306257963180542e-01	1.124335378408432007e-01	1.857865899801254272e-01	-5.905169993638992310e-02
+1.007009595632553101e-01	7.516346126794815063e-02	-1.312321573495864868e-01	-7.602021098136901855e-02	-1.610904335975646973e-01	-7.157172262668609619e-02	-3.855035081505775452e-02	-1.936252266168594360e-01	-9.300149232149124146e-02	4.600097984075546265e-02	-1.138332858681678772e-01	4.203705117106437683e-02	-4.520619660615921021e-02	1.347151994705200195e-01	-1.294217556715011597e-01
+1.001875400543212891e-01	-1.132487505674362183e-01	-4.163928329944610596e-03	6.681708991527557373e-02	-4.600565880537033081e-02	1.763418167829513550e-01	3.313385546207427979e-01	-1.129601299762725830e-01	2.431528642773628235e-02	6.325863301753997803e-02	-4.059148952364921570e-02	-1.118210423737764359e-02	-2.038956433534622192e-01	-1.425022631883621216e-01	-5.723150447010993958e-03
+9.407982230186462402e-02	8.001462370157241821e-02	-2.035376876592636108e-01	8.062360808253288269e-03	1.538903564214706421e-01	2.830612286925315857e-02	-1.518529467284679413e-02	-3.077569231390953064e-02	4.123907536268234253e-03	-2.103170193731784821e-02	9.613325446844100952e-02	-7.903409004211425781e-02	3.125510737299919128e-02	8.903456619009375572e-04	-6.428617238998413086e-02
+9.406865388154983521e-02	-1.791881918907165527e-01	-8.276556618511676788e-03	-2.965002134442329407e-02	5.700163543224334717e-02	-1.148957666009664536e-02	-1.332757174968719482e-01	5.545758455991744995e-02	-6.686314940452575684e-03	2.468170970678329468e-02	-2.053959295153617859e-02	1.643142849206924438e-02	1.258462551049888134e-03	-5.143086309544742107e-04	5.937817506492137909e-03
+9.649397432804107666e-02	8.027059584856033325e-02	-1.631885468959808350e-01	2.333489991724491119e-02	2.121080607175827026e-01	1.130969263613224030e-02	-2.103595063090324402e-02	4.660079628229141235e-02	2.096206415444612503e-03	1.953577436506748199e-02	2.901989594101905823e-02	-3.907585889101028442e-02	4.627696797251701355e-02	1.089777275919914246e-01	1.461862493306398392e-02
+1.033540964126586914e-01	7.794149965047836304e-02	1.151292398571968079e-01	2.309635728597640991e-01	3.235552087426185608e-02	-1.148650571703910828e-01	-4.997650533914566040e-02	5.795754119753837585e-02	-1.963078230619430542e-01	-4.085578769445419312e-02	-6.560879200696945190e-02	1.799988597631454468e-01	-1.434233337640762329e-01	1.321845650672912598e-01	-1.391446888446807861e-01
+9.632616490125656128e-02	7.860046625137329102e-02	-1.156974583864212036e-01	6.384550780057907104e-02	9.553812444210052490e-02	1.855529658496379852e-02	-7.110892981290817261e-02	2.114013768732547760e-03	3.175996243953704834e-02	7.492856681346893311e-02	5.438266322016716003e-02	1.752818352542817593e-03	5.380610749125480652e-02	1.135067045688629150e-01	-7.447752356529235840e-02
+1.018153354525566101e-01	4.603661969304084778e-02	-1.248271390795707703e-01	-8.571246266365051270e-02	-1.614183336496353149e-01	-3.166115283966064453e-02	3.251006454229354858e-02	-8.094025403261184692e-02	-8.872838318347930908e-02	-6.665214151144027710e-02	-7.572681456804275513e-02	8.980319648981094360e-02	-1.394795030355453491e-01	-1.250675879418849945e-02	1.468008477240800858e-02
+1.032287180423736572e-01	9.694153815507888794e-02	-2.908578841015696526e-03	-2.182907015085220337e-01	1.721379160881042480e-01	-7.366006076335906982e-02	5.815453082323074341e-02	1.759700179100036621e-01	6.568897515535354614e-02	-1.107818484306335449e-01	-7.642934471368789673e-02	-1.505851596593856812e-01	-7.711775600910186768e-02	7.467343658208847046e-02	7.080453447997570038e-03
+1.065864339470863342e-01	5.720582604408264160e-02	1.948722153902053833e-01	-7.787132263183593750e-02	1.477451622486114502e-01	-5.413819104433059692e-02	6.531537324190139771e-02	-1.822435259819030762e-01	-1.397956609725952148e-01	-1.097136139869689941e-01	8.924543112516403198e-02	1.279107034206390381e-01	1.993209309875965118e-02	-5.507615953683853149e-02	-3.446640679612755775e-03
+9.265841543674468994e-02	-1.751434653997421265e-01	-2.025607787072658539e-02	-2.595988102257251740e-03	5.127311125397682190e-02	-8.045714930631220341e-04	-6.226925179362297058e-02	9.989995509386062622e-02	5.121784750372171402e-03	1.036263331770896912e-01	7.005699723958969116e-02	3.461425006389617920e-02	-7.322895526885986328e-02	1.146115548908710480e-02	-1.859322073869407177e-03
+9.542080014944076538e-02	-1.547558456659317017e-01	-2.360189519822597504e-02	5.806864798069000244e-02	-6.534500978887081146e-03	-7.163854315876960754e-03	2.721503973007202148e-01	6.798323243856430054e-02	5.726485326886177063e-02	6.443656980991363525e-02	6.527258455753326416e-02	-4.411538690328598022e-02	1.094646845012903214e-02	2.960695512592792511e-02	-2.624839730560779572e-02
+9.617692232131958008e-02	8.400613814592361450e-02	-1.936585009098052979e-01	-6.250149570405483246e-03	6.989545375108718872e-02	5.721643567085266113e-03	-6.330724805593490601e-03	3.107380308210849762e-02	-4.174800962209701538e-02	5.090944096446037292e-02	5.953476950526237488e-02	-6.513056810945272446e-03	5.078724771738052368e-02	-3.625847026705741882e-02	1.019463595002889633e-02
+1.049788594245910645e-01	8.304906636476516724e-02	5.656645819544792175e-02	-1.640451848506927490e-01	-2.389858067035675049e-01	4.443007335066795349e-02	-7.840061932802200317e-02	1.193439811468124390e-01	-1.223825477063655853e-02	1.019432842731475830e-01	3.284224867820739746e-02	1.366260647773742676e-01	1.669918745756149292e-01	-1.151861101388931274e-01	-3.699916601181030273e-02
+9.868630021810531616e-02	8.215790241956710815e-02	-9.707875549793243408e-02	1.376012861728668213e-01	1.388198435306549072e-01	1.623931713402271271e-02	-4.843015596270561218e-02	5.262994766235351562e-02	1.130281016230583191e-02	3.778235986828804016e-02	4.424711223691701889e-03	-2.095900475978851318e-02	1.682416908442974091e-02	-5.163656547665596008e-02	8.480735123157501221e-02
+9.740426391363143921e-02	9.016389399766921997e-02	-1.474756747484207153e-01	7.034499198198318481e-02	8.572756499052047729e-02	2.408424019813537598e-02	-9.561213850975036621e-02	8.399785496294498444e-03	4.017020016908645630e-02	-1.322972401976585388e-02	-2.936635166406631470e-02	-3.563411533832550049e-02	-7.874042540788650513e-02	6.455113738775253296e-02	1.021147053688764572e-02
+9.785865992307662964e-02	2.002363093197345734e-02	-2.186168543994426727e-02	1.725570708513259888e-01	1.872270740568637848e-02	2.384064793586730957e-01	8.567645400762557983e-02	-3.716270625591278076e-02	8.989029377698898315e-02	-4.444942995905876160e-02	3.172029852867126465e-01	-7.634723186492919922e-02	7.728370279073715210e-02	1.805804371833801270e-01	9.173929691314697266e-02
+9.979384392499923706e-02	5.984103679656982422e-02	-5.989267304539680481e-02	-3.894945234060287476e-02	-1.764608323574066162e-01	-2.952952124178409576e-02	-8.314014226198196411e-02	4.754667729139328003e-02	-5.578798055648803711e-02	-9.455468505620956421e-02	9.188339859247207642e-02	-3.511780407279729843e-03	-1.166689470410346985e-01	9.548252820968627930e-02	-7.699102908372879028e-02
+1.049434468150138855e-01	5.845416337251663208e-02	1.641098409891128540e-01	-8.518899790942668915e-03	3.210408240556716919e-02	-1.310225725173950195e-01	8.615318685770034790e-02	-9.180887788534164429e-02	1.344605237245559692e-01	5.034093931317329407e-02	5.061811208724975586e-02	-6.799745559692382812e-02	-9.547847509384155273e-02	-1.987753435969352722e-02	-2.295717298984527588e-01
+1.013745963573455811e-01	3.942378982901573181e-02	-9.149497747421264648e-02	-1.120824217796325684e-01	-2.214438915252685547e-01	-2.176503837108612061e-02	-4.737643059343099594e-03	-1.330705732107162476e-01	-1.559747606515884399e-01	-2.740937769412994385e-01	-4.498530551791191101e-02	-5.058288201689720154e-02	-7.116720080375671387e-02	1.151673570275306702e-01	-4.305647686123847961e-02
+9.708176553249359131e-02	-1.062218919396400452e-01	-2.149707637727260590e-02	2.858676761388778687e-02	-1.854398660361766815e-02	-8.187077194452285767e-02	-8.343760669231414795e-02	-5.610152706503868103e-02	5.596423521637916565e-02	-1.519521772861480713e-01	-5.628714337944984436e-02	-9.399947710335254669e-03	-3.974910452961921692e-02	-3.937162831425666809e-02	1.491279304027557373e-01
+9.829887002706527710e-02	7.933630794286727905e-02	-9.475814551115036011e-02	9.995894879102706909e-02	-3.750766441226005554e-02	9.170225262641906738e-02	-6.639271229505538940e-02	-3.619616851210594177e-02	7.452869415283203125e-02	2.267530746757984161e-02	-5.552818253636360168e-02	-1.913725398480892181e-02	-1.615663059055805206e-02	-6.091057881712913513e-02	-5.618408694863319397e-02
+1.007776707410812378e-01	8.432733267545700073e-02	-8.283563703298568726e-02	2.562934346497058868e-02	-4.028012230992317200e-02	1.287396103143692017e-01	-4.740872979164123535e-02	-9.946762770414352417e-02	7.258672267198562622e-02	9.603270143270492554e-02	-2.146127820014953613e-01	2.005861401557922363e-01	4.016991704702377319e-03	9.881404042243957520e-02	-1.784754395484924316e-01
+9.105507284402847290e-02	-1.669324934482574463e-01	-2.300198376178741455e-02	-1.525159459561109543e-02	-2.397251874208450317e-02	-1.262844651937484741e-01	9.313737973570823669e-03	-1.240491420030593872e-01	3.332263603806495667e-02	-4.020209889858961105e-03	1.576019078493118286e-02	3.266835701651871204e-04	2.482586540281772614e-02	2.369339764118194580e-02	3.293184854555875063e-04
+1.065719574689865112e-01	3.809507191181182861e-02	9.304562211036682129e-02	-4.252380505204200745e-02	-1.260530948638916016e-01	2.520525753498077393e-01	-9.897017478942871094e-02	-2.133223414421081543e-02	2.489262372255325317e-01	-9.046503901481628418e-02	8.635894209146499634e-02	-1.634506434202194214e-01	-3.197543323040008545e-01	4.913535341620445251e-02	1.959136575460433960e-01
+9.264313429594039917e-02	-1.881375163793563843e-01	-1.751124672591686249e-02	-2.905825152993202209e-02	1.871072687208652496e-02	-7.512912154197692871e-02	-1.051722019910812378e-01	-5.402390379458665848e-03	3.364746272563934326e-02	5.512980278581380844e-03	7.305745035409927368e-03	4.229303449392318726e-03	5.940871778875589371e-03	3.234712639823555946e-03	-2.847168780863285065e-02
+1.048633009195327759e-01	7.608785480260848999e-02	1.051750108599662781e-01	7.690056692808866501e-03	-1.414654403924942017e-01	7.320459187030792236e-02	-1.152660772204399109e-01	4.983460530638694763e-02	2.327303886413574219e-01	9.326806664466857910e-02	-1.704614013433456421e-01	-1.848956942558288574e-01	-5.976792424917221069e-02	1.592061072587966919e-01	-1.650659143924713135e-01
+9.381422400474548340e-02	-1.856523603200912476e-01	-3.959448076784610748e-03	-4.706517234444618225e-02	4.505594074726104736e-02	2.624286152422428131e-02	-2.089477628469467163e-01	1.239063516259193420e-01	-2.390718087553977966e-02	-1.709154099225997925e-01	-1.105205416679382324e-01	-1.508438773453235626e-02	1.035469919443130493e-01	1.673432067036628723e-02	5.120269581675529480e-02
+1.030855774879455566e-01	8.343014866113662720e-02	-1.017857119441032410e-01	1.229696534574031830e-02	-3.135662153363227844e-02	-9.643211215734481812e-02	-8.517875522375106812e-02	-9.448844194412231445e-02	-2.268776111304759979e-02	8.870540559291839600e-02	-6.994637101888656616e-02	8.937536925077438354e-02	8.529035001993179321e-02	-3.078667521476745605e-01	1.380416750907897949e-01
+1.029732674360275269e-01	6.471338868141174316e-02	3.752776980400085449e-02	6.338411569595336914e-02	-9.442648291587829590e-02	-7.978357374668121338e-02	-6.381234526634216309e-02	5.312698706984519958e-02	1.511745750904083252e-01	-1.171831693500280380e-02	-4.243907332420349121e-02	2.028077393770217896e-01	3.521358594298362732e-02	2.125239185988903046e-02	2.735166251659393311e-01
+9.390673786401748657e-02	-1.700727343559265137e-01	5.626420490443706512e-03	-5.743062123656272888e-02	6.509607285261154175e-02	4.419220983982086182e-02	-1.206412538886070251e-01	-2.198786288499832153e-02	-6.157751753926277161e-02	6.935269385576248169e-02	5.418083444237709045e-02	-2.927818335592746735e-02	2.737504616379737854e-02	6.675768643617630005e-03	-4.358346015214920044e-02
+1.045850887894630432e-01	3.966004028916358948e-02	7.888220995664596558e-02	1.084793508052825928e-01	-3.825098276138305664e-02	5.556414648890495300e-02	-2.386018633842468262e-03	-1.735868491232395172e-02	1.626232713460922241e-01	-3.189559327438473701e-03	-3.677500039339065552e-02	-1.077032759785652161e-01	-6.530553102493286133e-02	-1.181415840983390808e-01	2.054665982723236084e-01
+1.013580858707427979e-01	6.717060506343841553e-02	-7.871925085783004761e-02	-4.536754917353391647e-03	-8.628232032060623169e-02	-4.364237934350967407e-02	5.463447421789169312e-02	7.559294998645782471e-02	1.829659007489681244e-02	-3.810231760144233704e-02	1.445978041738271713e-02	-1.330154389142990112e-01	7.491165399551391602e-02	-5.850773304700851440e-02	5.279816687107086182e-03
+1.007874831557273865e-01	-6.051312014460563660e-02	-2.818964421749114990e-03	1.158334836363792419e-01	-6.604961305856704712e-02	-6.636043637990951538e-02	3.605647683143615723e-01	6.230036914348602295e-02	1.247871741652488708e-01	4.024268593639135361e-03	-4.460835456848144531e-02	1.964040845632553101e-01	1.187151372432708740e-01	2.093635946512222290e-01	2.515807449817657471e-01
+1.040665134787559509e-01	7.813188433647155762e-02	1.352884173393249512e-01	-9.691929072141647339e-02	2.978404052555561066e-02	-6.218590214848518372e-02	3.118260763585567474e-02	2.100257873535156250e-01	5.309388414025306702e-02	-3.683280944824218750e-02	1.081678271293640137e-01	1.159011572599411011e-01	-9.071216732263565063e-02	1.454317569732666016e-01	1.560889184474945068e-02
+9.596666693687438965e-02	-1.235919669270515442e-01	-6.143675185739994049e-03	4.618058353662490845e-02	-4.854806885123252869e-02	-1.566148698329925537e-01	1.086631417274475098e-01	-5.864029750227928162e-02	7.967603951692581177e-02	-4.821031168103218079e-02	-7.968238554894924164e-03	-5.616628099232912064e-03	-7.662835996598005295e-03	-5.304025113582611084e-02	-9.814745932817459106e-02
+9.450878947973251343e-02	-1.617153137922286987e-01	-1.475114375352859497e-02	-3.400534763932228088e-02	3.202979266643524170e-02	-7.523473352193832397e-03	-7.037699967622756958e-02	5.858044326305389404e-02	-2.339935861527919769e-02	6.765121361240744591e-05	-7.621700875461101532e-03	-2.569160657003521919e-03	1.386285480111837387e-02	-9.449950885027647018e-04	-9.074879810214042664e-03
+9.348812699317932129e-02	-1.875597685575485229e-01	-1.796119287610054016e-02	-2.141974493861198425e-02	2.915703505277633667e-02	-5.883788317441940308e-02	-1.005370840430259705e-01	3.347435966134071350e-02	2.262158133089542389e-02	1.751536689698696136e-02	3.964411094784736633e-02	-3.229109104722738266e-03	-1.950366050004959106e-02	1.035222597420215607e-02	-1.544480863958597183e-02
+9.449574351310729980e-02	-1.709264367818832397e-01	4.125457257032394409e-03	-6.873404979705810547e-02	4.397033154964447021e-02	1.867942214012145996e-01	-1.137310042977333069e-01	6.536182016134262085e-02	-8.733030408620834351e-02	4.486828297376632690e-02	6.879048049449920654e-02	3.395766764879226685e-02	-1.334057748317718506e-01	-3.880335018038749695e-02	5.785062164068222046e-02
+9.526924788951873779e-02	-1.083553209900856018e-01	1.990574225783348083e-02	1.783852465450763702e-02	-5.172537639737129211e-02	-1.314793080091476440e-01	-3.332496806979179382e-02	-1.304124593734741211e-01	7.114066183567047119e-02	4.942291602492332458e-02	1.143850944936275482e-02	3.503248840570449829e-02	8.114560507237911224e-03	2.840096876025199890e-02	6.378748267889022827e-02
+1.035511195659637451e-01	7.710250467061996460e-02	5.883126333355903625e-02	-1.181510612368583679e-01	-1.791930794715881348e-01	-2.050231397151947021e-02	-4.374536871910095215e-02	2.246104925870895386e-01	1.195801421999931335e-02	-1.478822380304336548e-01	-9.886784851551055908e-02	-9.984883666038513184e-02	-6.099858880043029785e-02	8.420736342668533325e-02	-9.065923094749450684e-02
Binary file test-data/tl.diffmap.neighbors_gauss_braycurtis.recipe_weinreb17.paul15_subsample.h5ad has changed
Binary file test-data/tl.dpt.diffmap.neighbors_gauss_braycurtis.recipe_weinreb17.paul15_subsample.h5ad has changed
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/test-data/tl.dpt.diffmap.neighbors_gauss_braycurtis.recipe_weinreb17.paul15_subsample.obs.tabular	Mon Mar 04 10:15:02 2019 -0500
@@ -0,0 +1,101 @@
+index	paul15_clusters	dpt_groups	dpt_order	dpt_order_indices
+578	13Baso	2	53	27
+2242	3Ery	1	30	46
+2690	10GMP	2	66	45
+70	5Ery	1	32	65
+758	15Mo	2	67	8
+465	16Neu	2	68	80
+245	16Neu	2	69	87
+2172	10GMP	2	70	90
+2680	10GMP	0	4	36
+1790	7MEP	2	71	59
+855	11DC	2	72	82
+2721	10GMP	2	73	30
+104	2Ery	1	38	62
+1106	2Ery	1	40	32
+2367	15Mo	3	93	35
+124	2Ery	1	41	37
+2477	8Mk	2	74	31
+1968	2Ery	1	42	78
+563	1Ery	1	43	28
+276	2Ery	1	44	56
+192	16Neu	2	75	42
+2409	2Ery	1	45	44
+2054	15Mo	3	95	75
+720	8Mk	2	76	48
+2225	14Mo	3	97	98
+878	6Ery	1	29	54
+156	7MEP	2	77	79
+1244	8Mk	0	0	40
+10	2Ery	1	18	83
+1108	6Ery	2	65	25
+353	5Ery	1	11	1
+182	5Ery	1	16	97
+2053	3Ery	1	13	3
+2291	16Neu	3	92	96
+2056	10GMP	2	79	95
+1047	2Ery	1	14	94
+1947	14Mo	0	8	92
+1390	3Ery	1	15	60
+2317	14Mo	2	90	12
+2348	11DC	2	82	69
+953	5Ery	1	27	13
+628	9GMP	2	83	15
+2691	5Ery	1	20	17
+1499	16Neu	3	96	18
+1083	2Ery	1	21	19
+831	14Mo	0	2	21
+15	7MEP	0	1	86
+2005	7MEP	2	87	66
+1662	3Ery	1	23	84
+2457	7MEP	2	64	89
+757	7MEP	2	81	70
+1642	14Mo	2	91	68
+2520	10GMP	2	89	67
+1393	7MEP	2	88	0
+2170	6Ery	1	25	73
+988	14Mo	2	86	76
+1338	2Ery	1	19	77
+2189	16Neu	2	85	81
+446	13Baso	2	84	85
+2276	14Mo	0	9	88
+317	2Ery	1	37	91
+1540	16Neu	3	99	93
+2164	4Ery	1	12	72
+227	15Mo	2	78	64
+906	12Baso	2	63	49
+716	15Mo	0	3	29
+912	14Mo	1	47	2
+2688	11DC	2	52	4
+1678	7MEP	2	51	5
+1063	6Ery	1	39	6
+1041	5Ery	1	50	7
+2279	15Mo	3	98	9
+558	13Baso	2	62	10
+2196	14Mo	2	54	11
+1270	13Baso	3	94	16
+2259	3Ery	1	22	20
+2410	13Baso	2	55	23
+886	7MEP	2	56	26
+2072	13Baso	1	17	63
+443	5Ery	1	26	34
+910	13Baso	0	5	99
+2608	15Mo	2	57	50
+2645	1Ery	1	10	39
+616	6Ery	1	28	41
+1866	2Ery	1	48	58
+923	7MEP	2	58	57
+1716	4Ery	1	46	55
+2476	11DC	0	6	47
+1872	10GMP	2	59	53
+1009	4Ery	1	49	52
+1680	6Ery	0	7	38
+1490	14Mo	2	60	51
+1454	2Ery	1	36	33
+2580	9GMP	2	61	14
+958	1Ery	1	35	74
+2626	2Ery	1	34	22
+1677	3Ery	1	33	43
+982	4Ery	1	31	24
+202	2Ery	1	24	71
+891	10GMP	2	80	61
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/test-data/tl.dpt.neighbors.paul15_gauss_braycurtis.obs.tabular	Mon Mar 04 10:15:02 2019 -0500
@@ -0,0 +1,2731 @@
+index	paul15_clusters	dpt_pseudotime	dpt_groups	dpt_order	dpt_order_indices
+0	7MEP	0.077775456	1	172	404
+1	15Mo	0.70791066	2	2592	1876
+2	3Ery	0.9299172	1	1309	2408
+3	15Mo	0.6765072	2	2406	1880
+4	3Ery	0.86704516	1	1154	2098
+5	15Mo	0.58440965	2	1808	823
+6	4Ery	0.60054153	1	688	1149
+7	2Ery	0.43734095	1	539	2385
+8	3Ery	0.2407884	1	367	2384
+9	2Ery	0.8557937	1	1110	155
+10	2Ery	0.8691475	1	1164	2372
+11	17Neu	0.30127475	2	1456	2365
+12	14Mo	0.63893527	2	2068	164
+13	13Baso	0.5479835	2	1748	607
+14	3Ery	0.8603202	1	1134	167
+15	7MEP	0.117413916	1	270	1172
+16	3Ery	0.6879372	1	786	1908
+17	3Ery	0.84132445	1	1055	805
+18	2Ery	0.8558495	1	1111	2413
+19	8Mk	0.1685136	0	98	2417
+20	3Ery	0.27082652	1	399	1126
+21	9GMP	0.35508415	2	1510	2436
+22	8Mk	0.12326076	0	100	1815
+23	10GMP	0.36161897	2	1515	1616
+24	15Mo	0.65855885	2	2259	2511
+25	16Neu	0.6648798	2	2312	438
+26	4Ery	0.7767835	1	889	437
+27	13Baso	0.411375	2	1588	1607
+28	17Neu	0.2787515	2	1438	1089
+29	3Ery	0.7026065	1	798	2475
+30	2Ery	0.78192663	1	899	614
+31	3Ery	0.4758986	1	578	112
+32	5Ery	0.52930063	1	627	851
+33	3Ery	0.5440802	1	638	115
+34	13Baso	0.5579254	2	1766	2457
+35	1Ery	0.9610762	1	1324	423
+36	3Ery	0.94298	1	1317	1109
+37	6Ery	0.35788366	1	471	2452
+38	15Mo	0.73092824	2	2657	1858
+39	3Ery	0.47530073	1	577	1117
+40	3Ery	0.8309953	1	1021	1843
+41	14Mo	0.64247084	2	2108	384
+42	19Lymph	0.4615774	0	113	2323
+43	12Baso	0.3523068	2	1509	185
+44	3Ery	0.8736262	1	1184	1299
+45	14Mo	0.64636815	2	2144	2032
+46	6Ery	0.41744366	1	524	1306
+47	4Ery	0.7252952	1	817	261
+48	7MEP	0.2547727	2	1422	2154
+49	2Ery	0.8350906	1	1032	723
+50	13Baso	0.36504018	2	1520	2051
+51	14Mo	0.66908467	2	2351	720
+52	6Ery	0.26223817	1	393	737
+53	18Eos	0.3815021	2	1544	1393
+54	4Ery	0.8454671	1	1065	718
+55	3Ery	0.7204466	1	813	715
+56	3Ery	0.624237	1	720	308
+57	14Mo	0.63932437	2	2076	1384
+58	2Ery	0.84006816	1	1050	1378
+59	13Baso	0.6566314	2	2235	1348
+60	2Ery	0.85520875	1	1106	1370
+61	13Baso	0.6836325	2	2458	1360
+62	13Baso	0.6240188	2	1957	2136
+63	14Mo	0.6315316	2	2004	2522
+64	7MEP	0.12562352	0	94	2172
+65	7MEP	0.20317915	1	333	2025
+66	7MEP	0.14576882	2	1346	793
+67	10GMP	0.4374045	2	1628	1505
+68	12Baso	0.35526624	2	1511	2293
+69	6Ery	0.15430509	1	295	1484
+70	5Ery	0.29059684	1	421	636
+71	5Ery	0.41076174	1	516	1222
+72	14Mo	0.63960767	2	2078	2269
+73	4Ery	0.820214	1	994	1238
+74	16Neu	0.6670669	2	2332	248
+75	16Neu	0.6509542	2	2187	1244
+76	3Ery	0.66913307	1	766	1457
+77	2Ery	0.89367026	1	1250	1455
+78	6Ery	0.76215255	1	863	1265
+79	13Baso	0.59909	2	1840	229
+80	13Baso	0.45156288	2	1649	2221
+81	10GMP	0.49630007	2	1711	2005
+82	14Mo	0.6566849	2	2236	1280
+83	5Ery	0.45687908	1	559	743
+84	7MEP	0.14249937	0	127	350
+85	7MEP	0.0928669	1	216	2540
+86	5Ery	0.6481682	1	746	2097
+87	6Ery	0.26217386	1	392	1654
+88	2Ery	0.8884944	1	1232	499
+89	10GMP	0.07816703	1	173	2564
+90	10GMP	0.36928764	2	1526	2687
+91	2Ery	0.85090935	1	1086	1651
+92	7MEP	0.2221476	2	1399	890
+93	6Ery	0.22915362	1	356	1726
+94	7MEP	0.08779579	1	199	64
+95	14Mo	0.6131882	2	1902	961
+96	16Neu	0.6578041	2	2246	1790
+97	10GMP	0.43475908	2	1624	1787
+98	3Ery	0.79592675	1	927	19
+99	3Ery	0.8079216	1	959	2592
+100	13Baso	0.6605006	2	2280	22
+101	1Ery	1.0	1	1331	523
+102	14Mo	0.6370637	2	2050	541
+103	15Mo	0.7214093	2	2628	1738
+104	2Ery	0.73762625	1	832	540
+105	5Ery	0.21692096	1	344	474
+106	2Ery	0.8745584	1	1190	2611
+107	5Ery	0.30303305	1	430	1774
+108	3Ery	0.87296826	1	1179	2661
+109	14Mo	0.58798885	2	1815	2659
+110	10GMP	0.44662797	2	1644	922
+111	2Ery	0.8643726	1	1145	525
+112	7MEP	0.14947182	0	31	974
+113	4Ery	0.7285211	1	823	42
+114	9GMP	0.40913528	2	1585	993
+115	7MEP	0.13643783	0	33	1630
+116	3Ery	0.85794955	1	1122	2631
+117	16Neu	0.7009699	2	2561	1034
+118	11DC	0.5372636	3	2701	1647
+119	10GMP	0.37033108	2	1531	1681
+120	6Ery	0.32231367	1	446	2713
+121	3Ery	0.2562019	1	387	452
+122	2Ery	0.8032558	1	947	2718
+123	5Ery	0.79876626	1	935	2707
+124	2Ery	0.8192419	1	992	2708
+125	2Ery	0.80044454	1	940	1055
+126	5Ery	0.43929636	1	542	513
+127	14Mo	0.64730495	2	2154	84
+128	5Ery	0.5184172	1	619	2551
+129	14Mo	0.7214278	2	2629	2549
+130	3Ery	0.47004408	1	573	1808
+131	2Ery	0.8697594	1	1168	2544
+132	16Neu	0.63243085	2	2010	506
+133	2Ery	0.8984441	1	1267	840
+134	13Baso	0.4428648	2	1634	2657
+135	16Neu	0.6703501	2	2360	1130
+136	2Ery	0.8305287	1	1019	479
+137	3Ery	0.87886757	1	1206	2232
+138	3Ery	0.7002867	1	797	2091
+139	14Mo	0.6564193	2	2233	867
+140	5Ery	0.6211381	1	714	870
+141	16Neu	0.72532946	2	2645	2617
+142	14Mo	0.6286634	2	1984	999
+143	14Mo	0.51324356	2	1722	1095
+144	13Baso	0.64119786	2	2095	1875
+145	3Ery	0.8538894	1	1097	1023
+146	14Mo	0.6575185	2	2243	1857
+147	7MEP	0.10140075	1	239	1036
+148	14Mo	0.4708468	2	1678	2547
+149	10GMP	0.4715659	2	1680	2531
+150	2Ery	0.36951056	1	477	165
+151	14Mo	0.42858633	2	1617	1065
+152	15Mo	0.7037679	2	2576	1264
+153	14Mo	0.6135021	2	1905	1420
+154	16Neu	0.69316083	2	2518	2065
+155	10GMP	0.28390962	0	9	1942
+156	7MEP	0.2121948	2	1394	907
+157	5Ery	0.27825853	1	405	1271
+158	16Neu	0.70022595	2	2556	2334
+159	2Ery	0.66383225	1	756	1527
+160	16Neu	0.65058297	2	2183	1745
+161	14Mo	0.708129	2	2593	1125
+162	10GMP	0.4450716	2	1639	994
+163	16Neu	0.680672	2	2440	1288
+164	8Mk	0.13923419	0	12	2612
+165	7MEP	0.06780942	1	150	771
+166	14Mo	0.66853946	2	2348	1624
+167	7MEP	0.10103297	0	14	826
+168	2Ery	0.8126849	1	973	1110
+169	14Mo	0.64315915	2	2115	2545
+170	14Mo	0.63719016	2	2051	2378
+171	4Ery	0.57008606	1	658	1150
+172	5Ery	0.4821834	1	586	0
+173	14Mo	0.63845503	2	2063	89
+174	14Mo	0.66212815	2	2290	617
+175	10GMP	0.17640513	2	1369	2563
+176	6Ery	0.1496883	1	293	1186
+177	5Ery	0.45723748	1	560	1839
+178	14Mo	0.6476841	2	2156	2674
+179	3Ery	0.87447643	1	1188	1664
+180	5Ery	0.3488127	1	464	2653
+181	15Mo	0.6801838	2	2435	1324
+182	5Ery	0.68149966	1	782	2483
+183	14Mo	0.643272	2	2116	1576
+184	16Neu	0.65975946	2	2271	332
+185	8Mk	0.120203294	0	43	2361
+186	3Ery	0.8554299	1	1108	429
+187	14Mo	0.539332	2	1743	972
+188	12Baso	0.24081178	2	1409	367
+189	14Mo	0.508386	2	1719	1304
+190	3Ery	0.8632086	1	1140	396
+191	5Ery	0.24971066	1	377	1228
+192	16Neu	0.67274857	2	2383	2609
+193	15Mo	0.66296846	2	2297	1165
+194	13Baso	0.5965145	2	1832	566
+195	5Ery	0.5286252	1	626	965
+196	3Ery	0.7429267	1	845	515
+197	13Baso	0.5819139	2	1804	2514
+198	12Baso	0.2439489	2	1414	632
+199	8Mk	0.19748142	2	1380	94
+200	7MEP	0.13545541	2	1338	2434
+201	6Ery	0.30099535	1	428	952
+202	2Ery	0.8127602	1	975	1781
+203	3Ery	0.98407465	1	1330	377
+204	3Ery	0.9179601	1	1298	2016
+205	15Mo	0.7134846	2	2614	1710
+206	3Ery	0.23517895	1	365	2565
+207	3Ery	0.7918414	1	918	1545
+208	3Ery	0.5082045	1	606	1451
+209	8Mk	0.12728901	2	1336	1128
+210	2Ery	0.8392874	1	1047	2421
+211	2Ery	0.847325	1	1073	597
+212	14Mo	0.66207683	2	2289	1259
+213	3Ery	0.7848031	1	904	2101
+214	15Mo	0.6804725	2	2436	1890
+215	14Mo	0.64867747	2	2165	1564
+216	7MEP	0.116653435	1	269	85
+217	15Mo	0.6827861	2	2452	1071
+218	3Ery	0.49434087	1	596	1979
+219	3Ery	0.71508265	1	811	2487
+220	13Baso	0.5699776	2	1783	2672
+221	15Mo	0.6881255	2	2489	2418
+222	3Ery	0.85323954	1	1095	2649
+223	15Mo	0.67160183	2	2372	2288
+224	13Baso	0.6387988	2	2067	2727
+225	3Ery	0.6746057	1	774	2636
+226	15Mo	0.615951	2	1916	1693
+227	15Mo	0.6776098	2	2414	1714
+228	13Baso	0.6914276	2	2505	1500
+229	19Lymph	0.3576403	0	79	631
+230	4Ery	0.6243151	1	721	2453
+231	3Ery	0.621136	1	713	2468
+232	14Mo	0.62987256	2	1997	1284
+233	4Ery	0.8434601	1	1061	1707
+234	6Ery	0.28282624	1	410	1209
+235	16Neu	0.7272877	2	2649	2001
+236	14Mo	0.64645416	2	2147	1437
+237	3Ery	0.9233844	1	1303	2160
+238	17Neu	0.2620721	2	1427	1406
+239	15Mo	0.68135357	2	2444	147
+240	4Ery	0.31448224	1	443	886
+241	3Ery	0.8143819	1	980	1859
+242	6Ery	0.1648995	1	305	929
+243	14Mo	0.6433311	2	2117	699
+244	3Ery	0.6715719	1	770	2603
+245	16Neu	0.72223574	2	2633	1584
+246	14Mo	0.6560468	2	2229	923
+247	15Mo	0.70611167	2	2588	354
+248	7MEP	0.14242269	0	74	512
+249	13Baso	0.59484446	2	1829	2630
+250	15Mo	0.5749542	2	1789	847
+251	14Mo	0.6360989	2	2039	382
+252	3Ery	0.6995043	1	794	376
+253	2Ery	0.7657745	1	873	1118
+254	2Ery	0.9259877	1	1307	2493
+255	14Mo	0.6237018	2	1955	314
+256	2Ery	0.8576858	1	1121	2443
+257	13Baso	0.3868042	2	1549	770
+258	2Ery	0.85599273	1	1112	2280
+259	3Ery	0.63856417	1	737	829
+260	13Baso	0.4650997	2	1670	1376
+261	12Baso	0.15308021	0	47	1702
+262	2Ery	0.81991804	1	993	569
+263	10GMP	0.38973424	2	1554	551
+264	5Ery	0.41918328	1	526	2516
+265	13Baso	0.66921073	2	2352	959
+266	3Ery	0.73407704	1	827	1254
+267	9GMP	0.34716716	2	1502	2020
+268	15Mo	0.6841512	2	2461	1593
+269	2Ery	0.8626446	1	1138	216
+270	10GMP	0.34952182	2	1505	15
+271	5Ery	0.4013932	1	507	1369
+272	5Ery	0.45606565	1	558	2159
+273	2Ery	0.849991	1	1083	676
+274	14Mo	0.57874835	2	1795	1900
+275	13Baso	0.6373881	2	2054	1225
+276	2Ery	0.8385346	1	1046	2194
+277	14Mo	0.6281297	2	1977	852
+278	16Neu	0.6924414	2	2511	759
+279	12Baso	0.20147559	2	1383	1773
+280	14Mo	0.62524277	2	1963	1581
+281	14Mo	0.6104051	2	1885	466
+282	3Ery	0.85490453	1	1103	2366
+283	14Mo	0.59650874	2	1831	2090
+284	13Baso	0.5622208	2	1770	1854
+285	12Baso	0.4156711	2	1594	2028
+286	5Ery	0.401165	1	506	2251
+287	10GMP	0.17313975	2	1364	1719
+288	14Mo	0.6204749	2	1937	2428
+289	4Ery	0.5120924	1	614	397
+290	15Mo	0.66839075	2	2344	1400
+291	11DC	0.81752753	3	2721	1680
+292	3Ery	0.509725	1	608	763
+293	4Ery	0.813106	1	976	176
+294	4Ery	0.38181266	1	489	2706
+295	4Ery	0.76509076	1	871	69
+296	4Ery	0.87591106	1	1197	539
+297	5Ery	0.51063365	1	610	2131
+298	1Ery	0.8824672	1	1212	2170
+299	16Neu	0.68615955	2	2473	2438
+300	14Mo	0.66951203	2	2355	1300
+301	2Ery	0.8850476	1	1221	1665
+302	5Ery	0.5097156	1	607	1143
+303	15Mo	0.6580656	2	2251	1494
+304	5Ery	0.35025886	1	466	2521
+305	2Ery	0.6263539	1	723	242
+306	5Ery	0.43606016	1	537	1565
+307	1Ery	0.8860106	1	1224	1223
+308	7MEP	0.1397054	0	56	616
+309	2Ery	0.7918758	1	919	2569
+310	14Mo	0.5742414	2	1787	327
+311	10GMP	0.15935415	2	1353	2017
+312	2Ery	0.69286364	1	790	1187
+313	14Mo	0.6649285	2	2314	1529
+314	6Ery	0.10972625	1	255	582
+315	9GMP	0.14322571	2	1345	2670
+316	3Ery	0.9303544	1	1310	2283
+317	2Ery	0.7869174	1	909	2602
+318	3Ery	0.66672796	1	762	1921
+319	12Baso	0.27733576	2	1436	2513
+320	2Ery	0.55252093	1	648	2450
+321	18Eos	0.45194703	2	1651	2709
+322	5Ery	0.54942983	1	643	909
+323	3Ery	0.5205649	1	621	1583
+324	15Mo	0.65866643	2	2261	1977
+325	14Mo	0.47523555	2	1686	947
+326	2Ery	0.8473012	1	1072	1749
+327	6Ery	0.17107	1	310	1275
+328	14Mo	0.48355934	2	1701	1289
+329	2Ery	0.87861824	1	1205	2586
+330	5Ery	0.505223	1	605	2326
+331	12Baso	0.28409764	2	1443	1958
+332	7MEP	0.08240016	1	184	1864
+333	17Neu	0.30939132	2	1469	65
+334	14Mo	0.66331893	2	2300	1725
+335	2Ery	0.8038146	1	949	2509
+336	5Ery	0.38177764	1	488	1969
+337	2Ery	0.8165995	1	986	800
+338	14Mo	0.6248555	2	1960	625
+339	13Baso	0.6698477	2	2357	1012
+340	15Mo	0.6653694	2	2315	2402
+341	2Ery	0.84707874	1	1069	1891
+342	13Baso	0.50575787	2	1718	2166
+343	16Neu	0.69383293	2	2522	2214
+344	5Ery	0.62179655	1	716	105
+345	14Mo	0.6385502	2	2064	881
+346	16Neu	0.6549534	2	2222	1724
+347	14Mo	0.6457497	2	2136	2183
+348	16Neu	0.73303634	2	2661	1044
+349	14Mo	0.6448673	2	2130	1660
+350	8Mk	0.17507522	0	84	713
+351	10GMP	0.37040418	2	1532	1906
+352	14Mo	0.61959416	2	1929	1372
+353	5Ery	0.40641704	1	509	819
+354	7MEP	0.105552085	1	247	2325
+355	2Ery	0.704613	1	800	1257
+356	14Mo	0.5300463	2	1734	93
+357	13Baso	0.6452987	2	2133	442
+358	2Ery	0.6124332	1	703	1735
+359	5Ery	0.48546103	1	589	1441
+360	14Mo	0.66013944	2	2278	854
+361	14Mo	0.61078626	2	1890	1653
+362	9GMP	0.41911614	2	1601	878
+363	4Ery	0.7925654	1	920	2625
+364	10GMP	0.40233228	2	1574	2294
+365	13Baso	0.63581777	2	2037	206
+366	10GMP	0.4421752	2	1631	956
+367	7MEP	0.08295093	1	188	8
+368	10GMP	0.4315819	2	1620	1472
+369	3Ery	0.34624436	1	460	553
+370	2Ery	0.85490924	1	1104	1184
+371	14Mo	0.63569385	2	2036	1688
+372	10GMP	0.33941463	2	1498	1461
+373	15Mo	0.6217826	2	1945	2542
+374	13Baso	0.6368307	2	2047	1877
+375	7MEP	0.14716133	2	1347	1514
+376	6Ery	0.10848203	1	252	1981
+377	7MEP	0.089286804	1	203	191
+378	5Ery	0.48074317	1	582	1008
+379	14Mo	0.6641282	2	2306	1925
+380	13Baso	0.6347226	2	2029	495
+381	10GMP	0.47413307	2	1684	1340
+382	7MEP	0.10748043	1	251	1965
+383	3Ery	0.71404564	1	810	1363
+384	7MEP	0.12329549	0	41	755
+385	13Baso	0.5557078	2	1759	1108
+386	1Ery	0.9219727	1	1301	1232
+387	14Mo	0.62004715	2	1933	121
+388	13Baso	0.63923115	2	2075	2598
+389	10GMP	0.28631178	2	1449	1310
+390	9GMP	0.40028816	2	1570	2036
+391	3Ery	0.54397213	1	637	1219
+392	13Baso	0.6493458	2	2169	87
+393	2Ery	0.87499654	1	1193	52
+394	13Baso	0.55176985	2	1751	2030
+395	2Ery	0.77246344	1	883	2295
+396	6Ery	0.08341501	1	190	1509
+397	6Ery	0.1342663	1	289	2158
+398	13Baso	0.6409392	2	2091	413
+399	3Ery	0.43239743	1	535	20
+400	13Baso	0.6209341	2	1940	2307
+401	11DC	0.7856716	3	2714	2635
+402	14Mo	0.6582676	2	2255	633
+403	10GMP	0.30549538	2	1460	1935
+404	8Mk	0.14833952	0	0	2104
+405	9GMP	0.39605552	2	1561	157
+406	2Ery	0.86013585	1	1132	2292
+407	13Baso	0.5227784	2	1725	866
+408	14Mo	0.62507004	2	1961	2606
+409	13Baso	0.40922868	2	1586	1056
+410	14Mo	0.65985715	2	2275	234
+411	5Ery	0.6274364	1	727	679
+412	14Mo	0.62796974	2	1976	1580
+413	5Ery	0.2694085	1	398	2259
+414	13Baso	0.6257928	2	1967	1113
+415	12Baso	0.28527358	2	1447	2703
+416	16Neu	0.71621954	2	2622	989
+417	11DC	0.74025565	3	2708	670
+418	13Baso	0.38879004	2	1552	1910
+419	13Baso	0.64534235	2	2134	1712
+420	2Ery	0.8532722	1	1096	1902
+421	2Ery	0.51078266	1	611	70
+422	14Mo	0.6014195	2	1841	2669
+423	7MEP	0.14008638	0	35	2419
+424	4Ery	0.45593196	1	557	1813
+425	6Ery	0.36709392	1	476	621
+426	13Baso	0.6532763	2	2203	598
+427	14Mo	0.63075477	2	2000	1834
+428	14Mo	0.6530416	2	2200	201
+429	6Ery	0.0827596	1	186	496
+430	12Baso	0.24686788	2	1417	107
+431	6Ery	0.3102571	1	437	1315
+432	14Mo	0.51882905	2	1724	2691
+433	2Ery	0.62175816	1	715	2132
+434	13Baso	0.6699973	2	2358	1212
+435	13Baso	0.6662049	2	2321	1592
+436	14Mo	0.6477791	2	2158	2537
+437	7MEP	0.123604	0	26	431
+438	7MEP	0.15461057	0	25	779
+439	15Mo	0.6744562	2	2394	1452
+440	5Ery	0.34425217	1	459	2284
+441	5Ery	0.34624964	1	461	2375
+442	5Ery	0.22933012	1	357	1487
+443	5Ery	0.5118294	1	612	240
+444	15Mo	0.65862507	2	2260	1882
+445	1Ery	0.84866804	1	1076	798
+446	13Baso	0.60363805	2	1853	120
+447	10GMP	0.46272323	2	1666	900
+448	12Baso	0.18676578	2	1374	807
+449	4Ery	0.7650713	1	870	1227
+450	7MEP	0.2256337	2	1400	1249
+451	15Mo	0.75476885	2	2682	486
+452	19Lymph	0.38952795	0	121	1600
+453	13Baso	0.6425501	2	2109	1803
+454	13Baso	0.6495441	2	2172	1597
+455	3Ery	0.83562136	1	1034	603
+456	3Ery	0.5236729	1	625	817
+457	15Mo	0.6848527	2	2468	1366
+458	16Neu	0.7599826	2	2686	1476
+459	13Baso	0.63763773	2	2056	440
+460	2Ery	0.8596655	1	1127	369
+461	15Mo	0.69842416	2	2547	441
+462	17Neu	0.2473733	2	1420	2639
+463	15Mo	0.5663368	2	1776	2398
+464	13Baso	0.45943582	2	1660	180
+465	16Neu	0.7275373	2	2651	1478
+466	6Ery	0.12873061	1	281	304
+467	5Ery	0.38838756	1	496	1285
+468	15Mo	0.6964181	2	2534	2623
+469	9GMP	0.28303823	2	1441	1619
+470	13Baso	0.64596003	2	2139	724
+471	15Mo	0.667781	2	2342	37
+472	13Baso	0.646025	2	2142	1392
+473	6Ery	0.17066944	2	1359	1788
+474	7MEP	0.14379716	0	105	1120
+475	12Baso	0.32452637	2	1483	2084
+476	15Mo	0.75072384	2	2677	425
+477	2Ery	0.85723346	1	1119	150
+478	13Baso	0.46502942	2	1669	1395
+479	10GMP	0.04609275	1	136	2424
+480	14Mo	0.7017341	2	2565	1482
+481	14Mo	0.6459697	2	2140	1066
+482	14Mo	0.6316111	2	2006	1608
+483	15Mo	0.76426214	2	2689	2458
+484	5Ery	0.40057713	1	504	2683
+485	16Neu	0.70215905	2	2568	893
+486	5Ery	0.32978076	1	451	2560
+487	14Mo	0.6755249	2	2403	680
+488	13Baso	0.6602428	2	2279	336
+489	15Mo	0.7713684	2	2694	294
+490	2Ery	0.8126877	1	974	2302
+491	2Ery	0.8082449	1	960	1025
+492	2Ery	0.74070585	1	839	2229
+493	13Baso	0.6101216	2	1879	1791
+494	13Baso	0.62257403	2	1948	750
+495	5Ery	0.25217026	1	380	1200
+496	5Ery	0.30277514	1	429	467
+497	9GMP	0.31012443	2	1471	522
+498	14Mo	0.6401772	2	2085	2150
+499	7MEP	0.16820945	0	88	565
+500	14Mo	0.55811936	2	1767	729
+501	11DC	0.80639267	3	2717	1054
+502	16Neu	0.6617467	2	2287	508
+503	2Ery	0.864137	1	1144	1675
+504	2Ery	0.6137529	1	705	484
+505	10GMP	0.31055188	2	1472	1347
+506	8Mk	0.1370245	0	132	286
+507	2Ery	0.80149466	1	944	271
+508	5Ery	0.39723697	1	502	1657
+509	13Baso	0.6037775	2	1855	353
+510	13Baso	0.69680727	2	2538	2568
+511	12Baso	0.42132813	2	1605	2615
+512	7MEP	0.10560555	1	248	1633
+513	7MEP	0.12565278	0	126	1703
+514	13Baso	0.64961535	2	2173	2663
+515	6Ery	0.085308544	1	196	2146
+516	5Ery	0.6439022	1	744	71
+517	16Neu	0.7725779	2	2695	845
+518	14Mo	0.6656286	2	2319	1176
+519	13Baso	0.63517976	2	2030	2222
+520	2Ery	0.81653786	1	985	786
+521	14Mo	0.6342387	2	2022	1538
+522	5Ery	0.38896155	1	497	2397
+523	7MEP	0.1556482	0	101	2079
+524	10GMP	0.5638895	2	1772	46
+525	19Lymph	0.48256105	0	111	1160
+526	14Mo	0.3686559	2	1525	264
+527	4Ery	0.74954736	1	852	836
+528	14Mo	0.59603536	2	1830	975
+529	12Baso	0.2087188	2	1392	1362
+530	9GMP	0.33148324	2	1488	1279
+531	15Mo	0.6408987	2	2089	2368
+532	17Neu	0.32455087	2	1484	1772
+533	7MEP	0.1741925	2	1366	966
+534	16Neu	0.74533373	2	2670	1453
+535	13Baso	0.6146607	2	1911	399
+536	3Ery	0.61985815	1	711	663
+537	15Mo	0.7284772	2	2653	306
+538	3Ery	0.6763472	1	776	1620
+539	7MEP	0.15466575	1	296	7
+540	8Mk	0.16307598	0	104	2359
+541	19Lymph	0.42836544	0	102	1920
+542	3Ery	0.5690135	1	656	126
+543	13Baso	0.64463484	2	2128	1302
+544	9GMP	0.5115024	2	1721	2178
+545	3Ery	0.54827344	1	641	1164
+546	3Ery	0.50083554	1	603	1549
+547	2Ery	0.8716601	1	1174	2024
+548	16Neu	0.7249372	2	2644	2278
+549	14Mo	0.64264417	2	2111	2389
+550	16Neu	0.70089287	2	2559	1488
+551	6Ery	0.11350911	1	263	1588
+552	14Mo	0.61121625	2	1893	1757
+553	5Ery	0.2416494	1	369	1191
+554	14Mo	0.6541473	2	2213	642
+555	14Mo	0.603425	2	1852	2236
+556	19Lymph	0.3211038	2	1482	964
+557	15Mo	0.6540754	2	2212	424
+558	13Baso	0.38293752	2	1546	272
+559	14Mo	0.6346919	2	2028	83
+560	13Baso	0.6240437	2	1958	177
+561	17Neu	0.32463032	2	1485	848
+562	14Mo	0.64171094	2	2104	1201
+563	1Ery	0.89444435	1	1254	2282
+564	2Ery	0.66557753	1	759	1195
+565	5Ery	0.39078924	1	499	2228
+566	6Ery	0.084743336	1	194	2242
+567	15Mo	0.7315276	2	2660	2000
+568	10GMP	0.38337302	2	1548	1771
+569	6Ery	0.11344586	1	262	876
+570	10GMP	0.3764257	2	1537	2652
+571	7MEP	0.17333683	2	1365	1182
+572	14Mo	0.6663886	2	2323	2310
+573	13Baso	0.5989463	2	1838	130
+574	2Ery	0.78037155	1	896	1446
+575	14Mo	0.61368805	2	1907	1028
+576	14Mo	0.68448853	2	2463	747
+577	6Ery	0.1388644	2	1342	39
+578	13Baso	0.44603145	2	1641	31
+579	14Mo	0.63326806	2	2018	1098
+580	14Mo	0.60686463	2	1869	2215
+581	2Ery	0.6770244	1	777	1053
+582	6Ery	0.17573795	1	314	378
+583	13Baso	0.5537081	2	1755	853
+584	10GMP	0.4111725	2	1587	2610
+585	15Mo	0.72743326	2	2650	1766
+586	16Neu	0.71139854	2	2607	172
+587	10GMP	0.39828664	2	1567	1669
+588	1Ery	0.9460409	1	1318	1765
+589	14Mo	0.6798868	2	2434	359
+590	12Baso	0.23929562	2	1407	2344
+591	10GMP	0.40722921	2	1583	2164
+592	12Baso	0.3664537	2	1522	1059
+593	16Neu	0.74401665	2	2667	1915
+594	10GMP	0.43295795	2	1622	1987
+595	13Baso	0.6242127	2	1959	1889
+596	16Neu	0.77508634	2	2697	218
+597	6Ery	0.092420846	1	211	1883
+598	5Ery	0.2949211	1	426	1716
+599	10GMP	0.3908214	2	1555	682
+600	13Baso	0.64001375	2	2084	2360
+601	19Lymph	0.42590317	2	1613	953
+602	14Mo	0.66540164	2	2316	1513
+603	5Ery	0.3331635	1	455	546
+604	13Baso	0.6260039	2	1970	1804
+605	13Baso	0.6328634	2	2013	330
+606	13Baso	0.6554083	2	2226	208
+607	19Lymph	0.3922469	0	13	302
+608	13Baso	0.58468205	2	1809	292
+609	4Ery	0.81208336	1	970	1727
+610	12Baso	0.13101894	2	1337	297
+611	10GMP	0.31112838	2	1473	421
+612	11DC	0.66302377	3	2703	443
+613	1Ery	0.95398074	1	1321	868
+614	19Lymph	0.46889454	0	30	289
+615	3Ery	0.8039646	1	950	1674
+616	6Ery	0.17005633	1	308	2272
+617	6Ery	0.079491004	1	174	1794
+618	2Ery	0.8108383	1	969	1178
+619	2Ery	0.89846635	1	1268	128
+620	13Baso	0.6315816	2	2005	2637
+621	3Ery	0.29319444	1	425	323
+622	15Mo	0.7548594	2	2683	2550
+623	2Ery	0.848683	1	1077	1511
+624	10GMP	0.37897837	2	1541	2546
+625	5Ery	0.2112121	1	338	456
+626	13Baso	0.6426201	2	2110	195
+627	9GMP	0.3768515	2	1539	32
+628	9GMP	0.4180773	2	1600	809
+629	12Baso	0.2954596	2	1452	1122
+630	17Neu	0.25745127	2	1424	1614
+631	6Ery	0.09741229	1	229	1026
+632	7MEP	0.086468436	1	198	2464
+633	6Ery	0.27443242	1	402	1323
+634	14Mo	0.6217398	2	1944	2403
+635	14Mo	0.6520949	2	2191	2267
+636	19Lymph	0.46130726	0	70	957
+637	13Baso	0.64642656	2	2145	391
+638	13Baso	0.6049071	2	1859	33
+639	2Ery	0.74058735	1	838	1497
+640	13Baso	0.55703986	2	1764	1764
+641	7MEP	0.19205247	2	1376	545
+642	3Ery	0.4525858	1	554	2049
+643	13Baso	0.5722917	2	1785	322
+644	15Mo	0.6433463	2	2118	1709
+645	13Baso	0.6136032	2	1906	1904
+646	11DC	0.82615495	3	2726	1776
+647	17Neu	0.3186474	2	1480	2266
+648	13Baso	0.4441894	2	1637	320
+649	14Mo	0.6288334	2	1987	1405
+650	2Ery	0.64118856	1	742	2093
+651	11DC	0.8071333	3	2718	1035
+652	13Baso	0.4832031	2	1699	1063
+653	13Baso	0.6284224	2	1982	2400
+654	2Ery	0.819176	1	991	1621
+655	2Ery	0.8488807	1	1078	2134
+656	16Neu	0.6857466	2	2471	542
+657	14Mo	0.6729518	2	2385	2046
+658	10GMP	0.3658734	2	1521	171
+659	16Neu	0.71132725	2	2606	1463
+660	13Baso	0.68996805	2	2500	2039
+661	10GMP	0.59056973	2	1822	943
+662	16Neu	0.70749354	2	2591	1068
+663	2Ery	0.4338399	1	536	731
+664	14Mo	0.6162951	2	1917	2122
+665	12Baso	0.27064347	2	1431	1822
+666	9GMP	0.3098769	2	1470	1992
+667	2Ery	0.8363557	1	1037	1030
+668	2Ery	0.90653366	1	1282	1941
+669	2Ery	0.73101	1	824	2601
+670	6Ery	0.28610852	1	417	1067
+671	13Baso	0.6164028	2	1919	2185
+672	14Mo	0.56116444	2	1769	1112
+673	2Ery	0.6612147	1	754	1367
+674	5Ery	0.6210599	1	712	1042
+675	16Neu	0.76595235	2	2691	2562
+676	6Ery	0.12076999	1	273	2429
+677	13Baso	0.52741665	2	1732	1659
+678	14Mo	0.63084096	2	2001	1718
+679	5Ery	0.28350767	1	411	933
+680	5Ery	0.38075808	1	487	2063
+681	2Ery	0.8939503	1	1251	1723
+682	4Ery	0.49549425	1	599	1408
+683	2Ery	0.8664545	1	1152	1896
+684	10GMP	0.57947654	2	1799	1153
+685	5Ery	0.740495	1	837	1460
+686	13Baso	0.56466454	2	1774	2333
+687	13Baso	0.5797826	2	1800	2502
+688	2Ery	0.8003816	1	939	6
+689	12Baso	0.20204893	2	1385	1115
+690	12Baso	0.24330032	2	1413	979
+691	15Mo	0.71477133	2	2619	777
+692	13Baso	0.62924224	2	1991	2518
+693	13Baso	0.60825145	2	1872	2042
+694	13Baso	0.64782107	2	2159	2157
+695	13Baso	0.5847888	2	1811	1230
+696	10GMP	0.4357155	2	1625	927
+697	14Mo	0.7345531	2	2662	1759
+698	13Baso	0.6283173	2	1981	1775
+699	7MEP	0.103556946	1	243	1596
+700	13Baso	0.64230245	2	2107	924
+701	9GMP	0.12152586	2	1335	1783
+702	14Mo	0.6385707	2	2065	1329
+703	1Ery	0.9481687	1	1320	358
+704	3Ery	0.6277475	1	728	1777
+705	13Baso	0.66072595	2	2282	504
+706	13Baso	0.5893507	2	1817	727
+707	15Mo	0.70296514	2	2573	2331
+708	2Ery	0.82399166	1	1003	1873
+709	13Baso	0.5684177	2	1779	1135
+710	5Ery	0.8380937	1	1044	2492
+711	14Mo	0.70300424	2	2574	536
+712	3Ery	0.7991048	1	936	674
+713	6Ery	0.22432314	1	350	231
+714	2Ery	0.86723423	1	1155	140
+715	19Lymph	0.45584658	0	55	433
+716	15Mo	0.6725893	2	2380	344
+717	12Baso	0.34575555	2	1500	849
+718	7MEP	0.14431368	0	54	2075
+719	2Ery	0.96817917	1	1327	1004
+720	8Mk	0.17376061	0	51	56
+721	14Mo	0.6647712	2	2310	230
+722	14Mo	0.6627206	2	2294	858
+723	8Mk	0.11834818	0	49	305
+724	5Ery	0.35409144	1	470	1999
+725	14Mo	0.48222873	2	1696	1587
+726	2Ery	0.8306106	1	1020	1792
+727	3Ery	0.6161433	1	706	411
+728	9GMP	0.40361157	2	1577	704
+729	5Ery	0.39105207	1	500	1318
+730	3Ery	0.8553065	1	1107	1338
+731	5Ery	0.57465094	1	663	2181
+732	14Mo	0.6538144	2	2209	1652
+733	2Ery	0.8474706	1	1074	2033
+734	2Ery	0.887854	1	1229	1156
+735	14Mo	0.65256727	2	2195	2715
+736	16Neu	0.6543899	2	2217	1550
+737	9GMP	0.10761528	0	52	259
+738	16Neu	0.68983334	2	2498	2328
+739	15Mo	0.6925738	2	2513	1210
+740	10GMP	0.47501078	2	1685	1260
+741	3Ery	0.87342465	1	1182	2369
+742	14Mo	0.6471326	2	2153	650
+743	8Mk	0.10799089	0	83	1811
+744	14Mo	0.6589257	2	2266	516
+745	15Mo	0.673175	2	2387	1845
+746	16Neu	0.61969304	2	1932	86
+747	5Ery	0.47493407	1	576	2027
+748	14Mo	0.6512268	2	2188	1489
+749	16Neu	0.68403685	2	2460	901
+750	4Ery	0.38624105	1	494	1968
+751	2Ery	0.8742041	1	1186	2619
+752	13Baso	0.6502912	2	2182	883
+753	14Mo	0.6713383	2	2368	1290
+754	13Baso	0.55580646	2	1761	673
+755	5Ery	0.25347868	1	384	1508
+756	13Baso	0.49856633	2	1714	159
+757	7MEP	0.1614083	2	1355	977
+758	15Mo	0.6717412	2	2373	2519
+759	6Ery	0.1256032	1	278	564
+760	16Neu	0.66683507	2	2330	2379
+761	15Mo	0.6686958	2	2350	2089
+762	12Baso	0.25790322	2	1425	318
+763	6Ery	0.14769283	1	292	998
+764	13Baso	0.5901514	2	1820	1000
+765	14Mo	0.6979707	2	2544	838
+766	16Neu	0.6811836	2	2442	76
+767	14Mo	0.67708206	2	2409	1878
+768	14Mo	0.621875	2	1946	1523
+769	2Ery	0.8832284	1	1216	2315
+770	6Ery	0.10987611	1	257	244
+771	6Ery	0.075167954	1	165	1532
+772	13Baso	0.6038462	2	1856	982
+773	14Mo	0.65487355	2	2221	1838
+774	16Neu	0.69641143	2	2533	225
+775	2Ery	0.8790577	1	1207	1132
+776	2Ery	0.8726579	1	1178	538
+777	5Ery	0.6029266	1	691	581
+778	2Ery	0.8410844	1	1053	1491
+779	5Ery	0.3103411	1	438	1985
+780	1Ery	0.8890763	1	1234	1976
+781	13Baso	0.60364896	2	1854	1197
+782	14Mo	0.62564826	2	1966	182
+783	14Mo	0.63690966	2	2048	1158
+784	16Neu	0.7576488	2	2684	2114
+785	1Ery	0.88962495	1	1237	2524
+786	6Ery	0.41560265	1	520	16
+787	14Mo	0.6396559	2	2080	2591
+788	14Mo	0.6898833	2	2499	1996
+789	15Mo	0.66662127	2	2325	1685
+790	13Baso	0.66595095	2	2320	312
+791	15Mo	0.57936394	2	1797	2105
+792	1Ery	0.8687093	1	1162	1855
+793	8Mk	0.17402695	0	66	2100
+794	15Mo	0.6552263	2	2225	252
+795	14Mo	0.6975138	2	2541	2192
+796	10GMP	0.42752558	2	1614	1296
+797	9GMP	0.33357996	2	1492	138
+798	4Ery	0.31955263	1	445	29
+799	15Mo	0.65194166	2	2189	1826
+800	4Ery	0.2086904	1	337	355
+801	11DC	0.81749105	3	2720	2321
+802	2Ery	0.8861418	1	1225	2567
+803	14Mo	0.63292384	2	2015	2190
+804	14Mo	0.65235615	2	2192	2356
+805	8Mk	0.15916522	0	17	2169
+806	13Baso	0.4927984	2	1707	2725
+807	6Ery	0.32438838	1	448	1180
+808	13Baso	0.58428156	2	1807	2102
+809	4Ery	0.52932966	1	628	1946
+810	13Baso	0.46944234	2	1676	383
+811	15Mo	0.68911505	2	2494	219
+812	13Baso	0.581498	2	1803	1267
+813	4Ery	0.73880947	1	833	55
+814	2Ery	0.8628668	1	1139	2268
+815	16Neu	0.71517575	2	2620	2135
+816	2Ery	0.8395569	1	1048	1561
+817	5Ery	0.33653572	1	456	47
+818	2Ery	0.8530897	1	1094	1286
+819	5Ery	0.226795	1	353	2083
+820	10GMP	0.46068278	2	1662	1615
+821	13Baso	0.62820035	2	1979	1533
+822	13Baso	0.6062524	2	1867	2167
+823	8Mk	0.12845227	0	5	113
+824	16Neu	0.6377254	2	2057	669
+825	13Baso	0.59449005	2	1827	2151
+826	7MEP	0.07577381	1	167	2235
+827	4Ery	0.81749684	1	988	266
+828	13Baso	0.61778253	2	1923	1332
+829	6Ery	0.111053385	1	259	2088
+830	2Ery	0.7808952	1	898	2173
+831	14Mo	0.56237787	2	1771	2182
+832	16Neu	0.6737545	2	2390	104
+833	2Ery	0.88356143	1	1217	813
+834	13Baso	0.47939748	2	1690	1391
+835	14Mo	0.5561544	2	1762	2068
+836	6Ery	0.42176428	1	527	1213
+837	2Ery	0.8498424	1	1082	685
+838	2Ery	0.6687169	1	765	639
+839	2Ery	0.8090744	1	965	492
+840	8Mk	0.0	1	133	1051
+841	2Ery	0.8322366	1	1023	2297
+842	4Ery	0.88659936	1	1226	1585
+843	14Mo	0.6327262	2	2012	2665
+844	17Neu	0.27431032	2	1434	1413
+845	5Ery	0.41218385	1	517	196
+846	13Baso	0.6355582	2	2034	934
+847	7MEP	0.10656101	1	250	1926
+848	3Ery	0.45876855	1	561	1041
+849	5Ery	0.6230367	1	717	2482
+850	13Baso	0.68684834	2	2479	1937
+851	8Mk	0.1794823	0	32	2094
+852	6Ery	0.123965696	1	277	527
+853	5Ery	0.48125213	1	583	1983
+854	5Ery	0.2322284	1	360	1252
+855	11DC	0.7186674	3	2706	2277
+856	5Ery	0.7709247	1	881	955
+857	15Mo	0.6434417	2	2119	1140
+858	2Ery	0.62511003	1	722	1077
+859	2Ery	0.8470971	1	1071	1390
+860	15Mo	0.69026136	2	2501	1551
+861	15Mo	0.6993242	2	2550	1141
+862	13Baso	0.64839834	2	2164	1402
+863	14Mo	0.64083284	2	2088	78
+864	14Mo	0.61081946	2	1891	1819
+865	14Mo	0.6775297	2	2413	1365
+866	5Ery	0.2810868	1	407	869
+867	7MEP	0.058422204	1	139	2441
+868	3Ery	0.5119496	1	613	2165
+869	2Ery	0.7632259	1	866	2305
+870	7MEP	0.058981095	1	140	449
+871	1Ery	0.9139394	1	1290	295
+872	14Mo	0.6620114	2	2288	1327
+873	2Ery	0.8274752	1	1013	253
+874	15Mo	0.6483364	2	2163	1317
+875	13Baso	0.6110736	2	1892	1206
+876	4Ery	0.4658348	1	569	2676
+877	13Baso	0.6845588	2	2465	968
+878	6Ery	0.23311144	1	362	1094
+879	9GMP	0.39298093	2	1557	1997
+880	3Ery	0.9422073	1	1315	1069
+881	6Ery	0.2174569	1	345	856
+882	1Ery	0.8281847	1	1015	2554
+883	4Ery	0.6566011	1	752	395
+884	13Baso	0.64384097	2	2122	2110
+885	9GMP	0.37670454	2	1538	1683
+886	7MEP	0.10163303	1	240	1789
+887	14Mo	0.6344943	2	2023	1380
+888	13Baso	0.6354775	2	2032	2262
+889	13Baso	0.65199023	2	2190	26
+890	19Lymph	0.44437763	0	92	2015
+891	10GMP	0.41616938	2	1598	1537
+892	9GMP	0.3629158	2	1516	2729
+893	5Ery	0.37944368	1	485	1007
+894	16Neu	0.7048353	2	2581	1503
+895	14Mo	0.6263806	2	1971	1840
+896	15Mo	0.64785504	2	2161	574
+897	2Ery	0.85117954	1	1088	1196
+898	3Ery	0.87546855	1	1196	830
+899	13Baso	0.49733177	2	1712	30
+900	6Ery	0.3238728	1	447	2552
+901	4Ery	0.6516421	1	749	2121
+902	3Ery	0.89433396	1	1253	1471
+903	16Neu	0.7193694	2	2625	1970
+904	9GMP	0.3964659	2	1563	213
+905	9GMP	0.30621108	2	1462	2330
+906	12Baso	0.19354893	2	1377	1029
+907	7MEP	0.07072888	1	156	1314
+908	16Neu	0.6752211	2	2399	2207
+909	6Ery	0.18569969	1	322	317
+910	13Baso	0.6563779	2	2232	2123
+911	17Neu	0.29974103	2	1454	1570
+912	14Mo	0.6534837	2	2207	1784
+913	3Ery	0.87053186	1	1170	944
+914	16Neu	0.72223777	2	2634	1556
+915	13Baso	0.49937096	2	1715	2007
+916	14Mo	0.6667526	2	2328	2559
+917	3Ery	0.9001362	1	1271	1824
+918	14Mo	0.65668595	2	2237	207
+919	16Neu	0.67296433	2	2386	309
+920	2Ery	0.8623044	1	1136	363
+921	18Eos	0.4923125	2	1706	2582
+922	7MEP	0.12347177	0	110	1193
+923	7MEP	0.10440958	1	246	2363
+924	5Ery	0.61088234	1	700	1698
+925	16Neu	0.7056496	2	2584	2465
+926	2Ery	0.8131659	1	977	1465
+927	5Ery	0.60621905	1	696	98
+928	13Baso	0.66167134	2	2286	1817
+929	6Ery	0.10191569	1	242	1138
+930	14Mo	0.6598487	2	2273	1869
+931	12Baso	0.33732682	2	1497	2644
+932	13Baso	0.5476418	2	1747	1261
+933	5Ery	0.5906549	1	679	1039
+934	2Ery	0.74454355	1	846	1686
+935	2Ery	0.8776953	1	1203	123
+936	14Mo	0.62958187	2	1994	712
+937	16Neu	0.75214845	2	2678	2346
+938	14Mo	0.5931602	2	1824	1589
+939	1Ery	0.85897005	1	1125	688
+940	11DC	0.7140351	3	2705	125
+941	1Ery	0.90289366	1	1275	1802
+942	13Baso	0.4886552	2	1704	2080
+943	3Ery	0.57208216	1	661	1995
+944	5Ery	0.78966916	1	913	507
+945	16Neu	0.66735464	2	2335	2704
+946	16Neu	0.64990026	2	2176	1823
+947	6Ery	0.19188966	1	325	122
+948	1Ery	0.95985454	1	1323	1341
+949	14Mo	0.6542649	2	2216	335
+950	16Neu	0.6627863	2	2296	615
+951	2Ery	0.84598047	1	1066	1991
+952	10GMP	0.08845335	1	201	1894
+953	5Ery	0.4995515	1	601	2126
+954	14Mo	0.6496404	2	2174	1061
+955	2Ery	0.7534978	1	856	1821
+956	6Ery	0.2362472	1	366	1722
+957	5Ery	0.5435398	1	636	1410
+958	1Ery	0.93300325	1	1312	1416
+959	5Ery	0.11386657	1	265	99
+960	15Mo	0.68349713	2	2457	491
+961	19Lymph	0.46141756	0	95	1706
+962	10GMP	0.45743412	2	1656	2471
+963	2Ery	0.8374839	1	1042	1837
+964	5Ery	0.4531866	1	556	1989
+965	7MEP	0.084898815	1	195	839
+966	6Ery	0.43114048	1	533	1763
+967	11DC	0.7936443	3	2715	1700
+968	4Ery	0.7689675	1	877	1293
+969	15Mo	0.70987904	2	2602	618
+970	3Ery	0.8505681	1	1085	609
+971	2Ery	0.8948285	1	1258	2270
+972	7MEP	0.08292271	1	187	976
+973	1Ery	0.8829068	1	1215	168
+974	7MEP	0.12577914	0	112	490
+975	5Ery	0.42749405	1	528	202
+976	3Ery	0.81268126	1	972	293
+977	3Ery	0.6640961	1	757	926
+978	13Baso	0.56478524	2	1775	2357
+979	3Ery	0.60273427	1	690	2077
+980	15Mo	0.6795556	2	2431	241
+981	15Mo	0.65382504	2	2210	2022
+982	4Ery	0.6718976	1	772	1161
+983	14Mo	0.6137736	2	1908	2014
+984	2Ery	0.8784753	1	1204	1381
+985	2Ery	0.9023916	1	1274	520
+986	16Neu	0.7355067	2	2664	337
+987	13Baso	0.6506317	2	2185	1194
+988	14Mo	0.5872188	2	1814	827
+989	5Ery	0.28580442	1	416	1780
+990	16Neu	0.72113186	2	2627	1886
+991	14Mo	0.6397594	2	2082	654
+992	16Neu	0.68629026	2	2475	124
+993	8Mk	0.14575514	0	114	262
+994	7MEP	0.07290588	1	162	73
+995	8Mk	0.1731009	2	1363	1276
+996	14Mo	0.63830286	2	2062	1309
+997	10GMP	0.5596618	2	1768	1552
+998	5Ery	0.6676558	1	763	1448
+999	10GMP	0.06017755	1	142	2141
+1000	3Ery	0.6683017	1	764	2285
+1001	13Baso	0.55241865	2	1753	2711
+1002	14Mo	0.6228725	2	1952	2019
+1003	3Ery	0.89444697	1	1255	708
+1004	2Ery	0.6237472	1	719	1622
+1005	2Ery	0.87733173	1	1201	1524
+1006	14Mo	0.67475116	2	2395	1814
+1007	2Ery	0.77810943	1	893	2253
+1008	6Ery	0.2502513	1	378	2393
+1009	4Ery	0.8477745	1	1075	1800
+1010	15Mo	0.72438604	2	2641	1093
+1011	13Baso	0.625923	2	1969	1171
+1012	6Ery	0.2116992	1	339	1322
+1013	12Baso	0.241332	2	1410	873
+1014	16Neu	0.71099925	2	2605	1542
+1015	14Mo	0.65833217	2	2258	882
+1016	15Mo	0.68636656	2	2477	1047
+1017	13Baso	0.6281412	2	1978	1994
+1018	2Ery	0.8525291	1	1092	2381
+1019	14Mo	0.6325913	2	2011	136
+1020	14Mo	0.63238937	2	2009	726
+1021	12Baso	0.23162247	2	1405	40
+1022	10GMP	0.36753675	2	1523	1268
+1023	7MEP	0.06477637	1	145	841
+1024	2Ery	0.9055604	1	1281	1964
+1025	4Ery	0.38482952	1	491	1142
+1026	3Ery	0.5311635	1	631	2124
+1027	16Neu	0.69670516	2	2536	2130
+1028	5Ery	0.47192428	1	575	1828
+1029	2Ery	0.7866273	1	906	2106
+1030	3Ery	0.57709146	1	667	2455
+1031	2Ery	0.8905674	1	1241	2289
+1032	14Mo	0.67772084	2	2415	49
+1033	14Mo	0.6638529	2	2303	1424
+1034	8Mk	0.1516028	0	117	455
+1035	5Ery	0.560876	1	651	2120
+1036	7MEP	0.06540081	1	147	1389
+1037	7MEP	0.15955405	2	1354	667
+1038	16Neu	0.6911479	2	2503	2496
+1039	2Ery	0.7982678	1	933	1732
+1040	13Baso	0.57449526	2	1788	2249
+1041	5Ery	0.7450413	1	848	1281
+1042	5Ery	0.5835692	1	674	963
+1043	14Mo	0.67798233	2	2417	2301
+1044	6Ery	0.22363286	1	348	710
+1045	14Mo	0.6427963	2	2112	1543
+1046	7MEP	0.20434572	2	1388	276
+1047	2Ery	0.8285279	1	1016	210
+1048	13Baso	0.55571544	2	1760	816
+1049	2Ery	0.85431355	1	1101	1147
+1050	14Mo	0.60291684	2	1847	58
+1051	2Ery	0.74081326	1	840	1241
+1052	15Mo	0.67978317	2	2432	2286
+1053	3Ery	0.47961193	1	581	778
+1054	5Ery	0.39112484	1	501	1752
+1055	10GMP	0.118801765	0	125	17
+1056	6Ery	0.282436	1	409	1436
+1057	15Mo	0.65960735	2	2270	1307
+1058	1Ery	0.8692105	1	1165	1842
+1059	4Ery	0.49002138	1	592	2237
+1060	12Baso	0.22066869	2	1397	1085
+1061	4Ery	0.80479723	1	954	233
+1062	13Baso	0.66299826	2	2298	1374
+1063	6Ery	0.56429964	1	652	1708
+1064	3Ery	0.860155	1	1133	1520
+1065	8Mk	0.06855479	1	151	54
+1066	6Ery	0.37594453	1	481	951
+1067	3Ery	0.57971704	1	670	1572
+1068	3Ery	0.5723653	1	662	1175
+1069	4Ery	0.77009803	1	880	341
+1070	16Neu	0.7301309	2	2656	1717
+1071	7MEP	0.09317789	1	217	859
+1072	3Ery	0.93976355	1	1313	326
+1073	15Mo	0.69830996	2	2546	211
+1074	10GMP	0.40547022	2	1580	733
+1075	12Baso	0.34969506	2	1506	1009
+1076	3Ery	0.8839603	1	1218	445
+1077	3Ery	0.75600326	1	858	623
+1078	14Mo	0.65650856	2	2234	655
+1079	9GMP	0.30345842	2	1457	1100
+1080	12Baso	0.34091386	2	1499	1785
+1081	15Mo	0.69627076	2	2531	1694
+1082	15Mo	0.69796383	2	2543	837
+1083	2Ery	0.8552079	1	1105	273
+1084	14Mo	0.67056966	2	2362	1636
+1085	4Ery	0.8434504	1	1060	970
+1086	3Ery	0.8724864	1	1177	91
+1087	14Mo	0.6467807	2	2150	1312
+1088	14Mo	0.61021507	2	1881	897
+1089	8Mk	0.16311651	0	28	2626
+1090	16Neu	0.7889746	2	2700	1239
+1091	10GMP	0.35130596	2	1508	2155
+1092	2Ery	0.86561024	1	1151	1018
+1093	2Ery	0.8262713	1	1010	2684
+1094	3Ery	0.76929796	1	878	818
+1095	9GMP	0.062133025	1	143	222
+1096	15Mo	0.7245428	2	2642	420
+1097	14Mo	0.6413537	2	2098	145
+1098	5Ery	0.4778644	1	579	1157
+1099	14Mo	0.6297302	2	1995	2128
+1100	2Ery	0.84896135	1	1079	1967
+1101	13Baso	0.6062387	2	1866	1049
+1102	14Mo	0.66546875	2	2317	1134
+1103	14Mo	0.6328881	2	2014	282
+1104	14Mo	0.63566077	2	2035	370
+1105	2Ery	0.8989492	1	1269	1083
+1106	2Ery	0.91494644	1	1293	60
+1107	13Baso	0.6179538	2	1924	730
+1108	6Ery	0.25476006	1	385	186
+1109	7MEP	0.16892433	0	36	1598
+1110	7MEP	0.07623508	1	168	9
+1111	13Baso	0.5669007	2	1777	18
+1112	3Ery	0.5811692	1	672	258
+1113	3Ery	0.28452298	1	414	2510
+1114	14Mo	0.63123655	2	2002	1458
+1115	2Ery	0.60073036	1	689	2002
+1116	2Ery	0.857597	1	1120	1454
+1117	8Mk	0.15077296	0	39	1631
+1118	7MEP	0.1088423	1	253	1396
+1119	16Neu	0.7011181	2	2562	477
+1120	5Ery	0.36378887	1	474	1116
+1121	14Mo	0.6881218	2	2488	256
+1122	2Ery	0.53030884	1	629	116
+1123	14Mo	0.6795253	2	2430	1354
+1124	8Mk	0.13904361	2	1343	1897
+1125	7MEP	0.07285468	1	161	939
+1126	19Lymph	0.48664865	0	20	2387
+1127	14Mo	0.6793881	2	2428	460
+1128	12Baso	0.09220565	1	209	1553
+1129	13Baso	0.61038405	2	1884	2449
+1130	12Baso	0.03015226	1	135	1379
+1131	13Baso	0.6104455	2	1886	1417
+1132	4Ery	0.6747478	1	775	406
+1133	14Mo	0.6439471	2	2124	1064
+1134	2Ery	0.85488564	1	1102	14
+1135	5Ery	0.61810255	1	709	2113
+1136	11DC	0.76570946	3	2710	920
+1137	16Neu	0.7239118	2	2639	2021
+1138	3Ery	0.7961342	1	929	269
+1139	11DC	0.82728386	3	2727	814
+1140	3Ery	0.75501496	1	857	190
+1141	4Ery	0.75924146	1	861	1170
+1142	3Ery	0.8325254	1	1025	1907
+1143	6Ery	0.1635885	1	302	1425
+1144	15Mo	0.6284626	2	1983	503
+1145	17Neu	0.31717202	2	1478	111
+1146	14Mo	0.66776276	2	2341	2558
+1147	4Ery	0.8396043	1	1049	2205
+1148	9GMP	0.47953835	2	1692	1167
+1149	7MEP	0.11174975	0	6	1743
+1150	7MEP	0.07759933	1	171	1801
+1151	14Mo	0.64665836	2	2148	1092
+1152	13Baso	0.611278	2	1894	683
+1153	4Ery	0.594645	1	684	1971
+1154	13Baso	0.44740975	2	1646	4
+1155	14Mo	0.63800603	2	2060	714
+1156	3Ery	0.63815874	1	734	1331
+1157	2Ery	0.8541479	1	1098	2426
+1158	3Ery	0.6833606	1	783	1637
+1159	14Mo	0.63237417	2	2008	1944
+1160	6Ery	0.41831213	1	525	1990
+1161	2Ery	0.81438726	1	982	1199
+1162	10GMP	0.57068044	2	1784	792
+1163	13Baso	0.6300749	2	1999	1350
+1164	5Ery	0.4418342	1	545	10
+1165	7MEP	0.084248796	1	193	1058
+1166	13Baso	0.6201975	2	1936	1796
+1167	3Ery	0.8650133	1	1148	1793
+1168	2Ery	0.8759184	1	1198	131
+1169	14Mo	0.61966926	2	1931	1567
+1170	3Ery	0.863604	1	1141	913
+1171	2Ery	0.8268499	1	1011	1973
+1172	10GMP	0.1268016	0	15	2581
+1173	13Baso	0.6273109	2	1972	1922
+1174	14Mo	0.63742167	2	2055	547
+1175	4Ery	0.84698796	1	1068	1311
+1176	5Ery	0.4125936	1	518	1577
+1177	18Eos	0.38251024	2	1545	1086
+1178	2Ery	0.51684177	1	618	776
+1179	14Mo	0.6631688	2	2299	108
+1180	3Ery	0.7101149	1	807	1629
+1181	13Baso	0.54651254	2	1746	2409
+1182	5Ery	0.46659335	1	571	741
+1183	12Baso	0.28087816	2	1439	2553
+1184	5Ery	0.2417437	1	370	44
+1185	2Ery	0.9036633	1	1277	2383
+1186	7MEP	0.079829425	1	176	751
+1187	5Ery	0.17355415	1	312	1272
+1188	16Neu	0.68730265	2	2481	179
+1189	15Mo	0.65371096	2	2208	2312
+1190	14Mo	0.42172712	2	1606	106
+1191	5Ery	0.44938573	1	553	1836
+1192	16Neu	0.6587863	2	2263	1868
+1193	2Ery	0.7951527	1	922	393
+1194	2Ery	0.81660724	1	987	2543
+1195	6Ery	0.4634244	1	564	1899
+1196	2Ery	0.7808549	1	897	898
+1197	5Ery	0.6813551	1	781	296
+1198	14Mo	0.64095074	2	2092	1168
+1199	2Ery	0.8684184	1	1161	1464
+1200	3Ery	0.38792273	1	495	1677
+1201	5Ery	0.4596099	1	562	1005
+1202	16Neu	0.74491954	2	2669	1961
+1203	10GMP	0.46610743	2	1672	935
+1204	14Mo	0.6754392	2	2401	984
+1205	1Ery	0.9149159	1	1292	329
+1206	2Ery	0.7681644	1	875	137
+1207	3Ery	0.91241074	1	1286	775
+1208	15Mo	0.69770885	2	2542	1866
+1209	7MEP	0.098461516	1	234	1217
+1210	4Ery	0.6391501	1	739	1339
+1211	7MEP	0.17547216	2	1367	1574
+1212	5Ery	0.30726743	1	434	298
+1213	2Ery	0.7399551	1	836	1733
+1214	13Baso	0.6082896	2	1873	1262
+1215	14Mo	0.6345061	2	2025	973
+1216	15Mo	0.6381655	2	2061	769
+1217	2Ery	0.8800809	1	1209	833
+1218	14Mo	0.49605003	2	1710	1076
+1219	6Ery	0.2607627	1	391	1521
+1220	12Baso	0.39608195	2	1562	2353
+1221	2Ery	0.8880517	1	1230	301
+1222	19Lymph	0.43763757	0	71	1762
+1223	6Ery	0.16897786	1	307	2577
+1224	14Mo	0.6442689	2	2125	307
+1225	6Ery	0.12208061	1	275	802
+1226	17Neu	0.30859023	2	1467	842
+1227	6Ery	0.32498127	1	449	1812
+1228	6Ery	0.083925694	1	191	1442
+1229	9GMP	0.3509799	2	1507	734
+1230	3Ery	0.6041777	1	695	1221
+1231	14Mo	0.6293684	2	1992	1236
+1232	6Ery	0.2549454	1	386	88
+1233	15Mo	0.6179794	2	1925	1895
+1234	15Mo	0.74893093	2	2676	780
+1235	13Baso	0.6322805	2	2007	2466
+1236	3Ery	0.88811684	1	1231	1528
+1237	16Neu	0.709806	2	2601	785
+1238	7MEP	0.15549415	0	73	1729
+1239	3Ery	0.85182375	1	1090	2260
+1240	13Baso	0.67908466	2	2425	1635
+1241	3Ery	0.8403477	1	1051	1031
+1242	14Mo	0.63419366	2	2021	1485
+1243	14Mo	0.62830806	2	1980	1676
+1244	8Mk	0.113320716	0	75	1480
+1245	16Neu	0.71186113	2	2609	1573
+1246	14Mo	0.53000796	2	1733	1720
+1247	17Neu	0.3064897	2	1463	1650
+1248	3Ery	0.94688237	1	1319	2456
+1249	5Ery	0.32592246	1	450	1691
+1250	10GMP	0.42177463	2	1607	77
+1251	16Neu	0.68124163	2	2443	681
+1252	2Ery	0.75185335	1	854	2147
+1253	14Mo	0.59024215	2	1821	902
+1254	6Ery	0.11473352	1	266	563
+1255	14Mo	0.635554	2	2033	1003
+1256	13Baso	0.68569887	2	2470	1916
+1257	5Ery	0.22840591	1	355	1611
+1258	10GMP	0.2605162	2	1426	971
+1259	7MEP	0.09247267	1	212	2050
+1260	2Ery	0.63952	1	740	2203
+1261	2Ery	0.7968384	1	932	1388
+1262	2Ery	0.882711	1	1214	2140
+1263	14Mo	0.64771414	2	2157	1909
+1264	7MEP	0.06920466	1	152	2023
+1265	8Mk	0.15897211	0	78	2439
+1266	14Mo	0.6718906	2	2375	2354
+1267	2Ery	0.71611214	1	812	133
+1268	2Ery	0.83113605	1	1022	619
+1269	14Mo	0.60498536	2	1861	1105
+1270	13Baso	0.62136436	2	1942	1847
+1271	7MEP	0.07138902	1	157	917
+1272	4Ery	0.8744125	1	1187	1429
+1273	13Baso	0.6487906	2	2166	1295
+1274	13Baso	0.6505869	2	2184	985
+1275	5Ery	0.19478288	1	327	941
+1276	2Ery	0.821031	1	995	2156
+1277	18Eos	0.44732574	2	1645	1185
+1278	15Mo	0.687931	2	2484	2066
+1279	5Ery	0.42844564	1	530	1874
+1280	7MEP	0.14508064	0	82	2645
+1281	2Ery	0.8372359	1	1041	1024
+1282	13Baso	0.6352205	2	2031	668
+1283	14Mo	0.6588784	2	2264	1562
+1284	6Ery	0.09831304	1	232	1668
+1285	5Ery	0.35140684	1	467	2073
+1286	4Ery	0.7260739	1	818	1207
+1287	13Baso	0.6025444	2	1845	1313
+1288	7MEP	0.07410913	1	163	2211
+1289	5Ery	0.1964183	1	328	1438
+1290	5Ery	0.6572922	1	753	871
+1291	10GMP	0.31954953	2	1481	2329
+1292	16Neu	0.656264	2	2230	1205
+1293	2Ery	0.81009805	1	968	1106
+1294	14Mo	0.66084933	2	2283	2462
+1295	3Ery	0.9020579	1	1273	2171
+1296	2Ery	0.7002239	1	796	1852
+1297	10GMP	0.45521277	2	1655	2469
+1298	16Neu	0.69374883	2	2521	204
+1299	8Mk	0.12591279	0	44	2053
+1300	6Ery	0.16110094	1	300	1643
+1301	15Mo	0.6880167	2	2487	386
+1302	5Ery	0.4403574	1	543	1782
+1303	10GMP	0.41275603	2	1591	237
+1304	7MEP	0.08308525	1	189	1865
+1305	14Mo	0.6678024	2	2343	2108
+1306	19Lymph	0.4654791	0	46	1640
+1307	2Ery	0.84222424	1	1057	254
+1308	15Mo	0.67331016	2	2388	2265
+1309	3Ery	0.8212606	1	996	2
+1310	6Ery	0.25925377	1	389	316
+1311	1Ery	0.87208563	1	1175	1760
+1312	2Ery	0.8509749	1	1087	958
+1313	3Ery	0.91319674	1	1287	1072
+1314	4Ery	0.7866477	1	907	1467
+1315	6Ery	0.30339223	1	431	880
+1316	13Baso	0.65679574	2	2239	1423
+1317	3Ery	0.76592153	1	874	36
+1318	5Ery	0.6288591	1	729	588
+1319	14Mo	0.66389763	2	2304	1248
+1320	13Baso	0.6713691	2	2369	703
+1321	13Baso	0.6159448	2	1915	613
+1322	3Ery	0.8269319	1	1012	1662
+1323	4Ery	0.53566575	1	633	948
+1324	7MEP	0.08135115	1	181	35
+1325	10GMP	0.3694047	2	1527	2497
+1326	11DC	0.8223326	3	2724	2034
+1327	3Ery	0.76549166	1	872	719
+1328	13Baso	0.5231296	2	1728	2004
+1329	2Ery	0.6115133	1	702	2201
+1330	13Baso	0.6287122	2	1985	203
+1331	2Ery	0.8673369	1	1156	101
+1332	4Ery	0.7363593	1	828	2239
+1333	10GMP	0.3999526	2	1569	2074
+1334	16Neu	0.77446324	2	2696	2412
+1335	14Mo	0.56400186	2	1773	701
+1336	16Neu	0.6851315	2	2469	209
+1337	10GMP	0.3462297	2	1501	610
+1338	2Ery	0.629861	1	730	200
+1339	2Ery	0.88049614	1	1210	2720
+1340	6Ery	0.25285503	1	381	1428
+1341	3Ery	0.80378735	1	948	1697
+1342	14Mo	0.68048346	2	2437	577
+1343	14Mo	0.5515361	2	1750	1124
+1344	15Mo	0.6967234	2	2537	2230
+1345	10GMP	0.4367374	2	1626	315
+1346	13Baso	0.6474184	2	2155	66
+1347	3Ery	0.40064362	1	505	375
+1348	7MEP	0.11959786	0	59	2198
+1349	13Baso	0.64031935	2	2087	2142
+1350	2Ery	0.8690809	1	1163	1954
+1351	14Mo	0.63615495	2	2041	2477
+1352	14Mo	0.66708755	2	2333	2303
+1353	15Mo	0.69279313	2	2514	311
+1354	4Ery	0.8580644	1	1123	1037
+1355	15Mo	0.63452184	2	2027	757
+1356	14Mo	0.6742395	2	2391	2473
+1357	10GMP	0.31783035	2	1479	2571
+1358	13Baso	0.4334908	2	1623	2648
+1359	16Neu	0.6670978	2	2334	473
+1360	8Mk	0.16658957	0	61	1385
+1361	13Baso	0.60866374	2	1875	2191
+1362	5Ery	0.42812812	1	529	2137
+1363	6Ery	0.2534542	1	383	995
+1364	14Mo	0.6185627	2	1927	287
+1365	2Ery	0.76304656	1	865	571
+1366	6Ery	0.33673868	1	457	533
+1367	3Ery	0.5813914	1	673	1211
+1368	14Mo	0.5450077	2	1745	2523
+1369	7MEP	0.117591284	1	271	175
+1370	7MEP	0.14648554	0	60	2026
+1371	14Mo	0.6177499	2	1922	1539
+1372	5Ery	0.22615391	1	352	2580
+1373	13Baso	0.61065614	2	1887	2206
+1374	2Ery	0.843609	1	1062	448
+1375	16Neu	0.7248304	2	2643	2647
+1376	12Baso	0.11186951	1	260	641
+1377	14Mo	0.6378474	2	2058	906
+1378	8Mk	0.16314757	0	58	1678
+1379	4Ery	0.8600882	1	1130	1768
+1380	3Ery	0.7756422	1	887	199
+1381	2Ery	0.8146958	1	984	1679
+1382	14Mo	0.6529985	2	2199	1945
+1383	7MEP	0.24721782	2	1419	279
+1384	19Lymph	0.43719482	0	57	1386
+1385	7MEP	0.17151555	2	1360	689
+1386	10GMP	0.20190144	2	1384	2638
+1387	13Baso	0.61634314	2	1918	1586
+1388	2Ery	0.8959704	1	1261	1046
+1389	2Ery	0.83624583	1	1036	1579
+1390	3Ery	0.7584983	1	859	1559
+1391	3Ery	0.73954135	1	834	2213
+1392	6Ery	0.35832307	1	472	529
+1393	7MEP	0.19090831	0	53	2003
+1394	8Mk	0.3340445	2	1493	156
+1395	2Ery	0.37219444	1	478	2008
+1396	1Ery	0.8568995	1	1118	2685
+1397	9GMP	0.31491053	2	1476	1060
+1398	13Baso	0.6675197	2	2338	2520
+1399	15Mo	0.6684812	2	2347	92
+1400	6Ery	0.14498438	1	290	450
+1401	13Baso	0.6666415	2	2326	2012
+1402	3Ery	0.76168996	1	862	1535
+1403	16Neu	0.6581206	2	2252	2362
+1404	14Mo	0.6627434	2	2295	1885
+1405	5Ery	0.5590065	1	649	1021
+1406	7MEP	0.10122778	1	238	1412
+1407	13Baso	0.6397155	2	2081	590
+1408	4Ery	0.5938736	1	682	1827
+1409	13Baso	0.6788156	2	2422	188
+1410	2Ery	0.8073373	1	957	1013
+1411	15Mo	0.6726594	2	2382	1536
+1412	7MEP	0.23244335	2	1406	1795
+1413	3Ery	0.7422081	1	844	690
+1414	10GMP	0.43908823	2	1630	198
+1415	13Baso	0.6379811	2	2059	2600
+1416	3Ery	0.80744195	1	958	2162
+1417	1Ery	0.860122	1	1131	430
+1418	13Baso	0.45912775	2	1659	1932
+1419	13Baso	0.5510796	2	1749	1383
+1420	7MEP	0.07011532	1	153	462
+1421	16Neu	0.7218068	2	2630	2197
+1422	14Mo	0.6811293	2	2441	48
+1423	3Ery	0.94251055	1	1316	2263
+1424	2Ery	0.83532125	1	1033	630
+1425	1Ery	0.8637626	1	1143	762
+1426	13Baso	0.60657907	2	1868	1258
+1427	15Mo	0.6815699	2	2446	238
+1428	8Mk	0.1359186	2	1340	1473
+1429	2Ery	0.9020185	1	1272	1603
+1430	14Mo	0.6935044	2	2519	1638
+1431	14Mo	0.65258944	2	2196	665
+1432	14Mo	0.66938215	2	2353	2664
+1433	9GMP	0.416056	2	1596	1526
+1434	14Mo	0.6599	2	2277	844
+1435	14Mo	0.41167793	2	1589	1474
+1436	2Ery	0.8416091	1	1056	319
+1437	7MEP	0.09943954	1	236	1960
+1438	2Ery	0.91367626	1	1289	28
+1439	16Neu	0.65825665	2	2254	1183
+1440	10GMP	0.44560406	2	1640	2503
+1441	6Ery	0.23138134	1	359	469
+1442	2Ery	0.88703346	1	1228	1953
+1443	15Mo	0.6917211	2	2507	331
+1444	14Mo	0.5684295	2	1780	1566
+1445	15Mo	0.679012	2	2424	2246
+1446	3Ery	0.4708218	1	574	2096
+1447	12Baso	0.332191	2	1490	415
+1448	2Ery	0.82248193	1	998	1829
+1449	13Baso	0.6094279	2	1876	389
+1450	13Baso	0.6437005	2	2121	2388
+1451	7MEP	0.091493025	1	208	2570
+1452	6Ery	0.31090593	1	439	629
+1453	5Ery	0.4312712	1	534	2258
+1454	2Ery	0.85656106	1	1116	911
+1455	19Lymph	0.4460546	0	77	1758
+1456	14Mo	0.61074066	2	1889	11
+1457	12Baso	0.12560087	0	76	1079
+1458	2Ery	0.8563323	1	1114	1835
+1459	16Neu	0.7154216	2	2621	1604
+1460	4Ery	0.5978003	1	685	403
+1461	6Ery	0.24436565	1	372	2539
+1462	13Baso	0.50379235	2	1716	905
+1463	4Ery	0.5703159	1	659	1247
+1464	2Ery	0.87595403	1	1199	2149
+1465	4Ery	0.79584503	1	926	2583
+1466	15Mo	0.577664	2	1794	2118
+1467	1Ery	0.94204926	1	1314	1226
+1468	15Mo	0.7046206	2	2580	2478
+1469	13Baso	0.65555763	2	2227	333
+1470	15Mo	0.68244976	2	2450	666
+1471	3Ery	0.7844587	1	902	497
+1472	6Ery	0.240804	1	368	505
+1473	12Baso	0.26299474	2	1428	611
+1474	12Baso	0.27563432	2	1435	2103
+1475	13Baso	0.43879652	2	1629	1673
+1476	5Ery	0.34125823	1	458	1397
+1477	16Neu	0.6925171	2	2512	2161
+1478	6Ery	0.3492895	1	465	1145
+1479	13Baso	0.6715968	2	2371	1357
+1480	2Ery	0.89122385	1	1244	647
+1481	14Mo	0.6834755	2	2456	1291
+1482	3Ery	0.37358156	1	480	556
+1483	14Mo	0.67236036	2	2377	475
+1484	8Mk	0.103387676	0	69	532
+1485	2Ery	0.8909487	1	1242	561
+1486	9GMP	0.42873144	2	1618	2264
+1487	4Ery	0.31388837	1	442	2006
+1488	3Ery	0.44765	1	550	530
+1489	3Ery	0.65097034	1	748	1797
+1490	14Mo	0.65750307	2	2242	1447
+1491	2Ery	0.68054473	1	778	2163
+1492	10GMP	0.44493625	2	1638	797
+1493	16Neu	0.71061057	2	2603	1394
+1494	6Ery	0.16362946	1	303	2218
+1495	14Mo	0.62305784	2	1953	2694
+1496	16Neu	0.699929	2	2552	2244
+1497	5Ery	0.54693127	1	639	931
+1498	10GMP	0.47982457	2	1693	372
+1499	16Neu	0.6626213	2	2293	1080
+1500	12Baso	0.09705941	1	228	717
+1501	11DC	0.68174493	3	2704	1337
+1502	15Mo	0.69304824	2	2517	267
+1503	2Ery	0.7789428	1	894	2382
+1504	13Baso	0.5973336	2	1833	2335
+1505	7MEP	0.14866821	0	67	270
+1506	13Baso	0.62055576	2	1939	1075
+1507	13Baso	0.64692336	2	2151	1229
+1508	2Ery	0.66359746	1	755	1091
+1509	6Ery	0.2632227	1	396	43
+1510	14Mo	0.66405094	2	2305	21
+1511	5Ery	0.5220847	1	623	68
+1512	16Neu	0.709367	2	2598	2616
+1513	5Ery	0.49977124	1	602	2296
+1514	6Ery	0.24703214	1	375	1984
+1515	18Eos	0.36365065	2	1518	23
+1516	14Mo	0.6452469	2	2132	892
+1517	14Mo	0.5987	2	1836	2508
+1518	13Baso	0.67004424	2	2359	1515
+1519	15Mo	0.7018006	2	2566	2306
+1520	2Ery	0.84509635	1	1064	50
+1521	2Ery	0.88473237	1	1219	658
+1522	13Baso	0.5750397	2	1791	592
+1523	3Ery	0.6706715	1	768	1022
+1524	2Ery	0.8249246	1	1005	2445
+1525	15Mo	0.6866875	2	2478	526
+1526	12Baso	0.2721438	2	1433	90
+1527	7MEP	0.0719679	1	159	1325
+1528	3Ery	0.88943565	1	1236	1623
+1529	4Ery	0.17542325	1	313	2204
+1530	15Mo	0.6922373	2	2509	2245
+1531	14Mo	0.68392676	2	2459	119
+1532	4Ery	0.67179215	1	771	351
+1533	4Ery	0.7281175	1	821	1901
+1534	13Baso	0.5573176	2	1765	2107
+1535	9GMP	0.22831179	2	1402	2338
+1536	12Baso	0.24196415	2	1411	2425
+1537	2Ery	0.7775586	1	891	570
+1538	4Ery	0.4167773	1	521	885
+1539	9GMP	0.18077041	2	1371	627
+1540	16Neu	0.7000713	2	2553	2392
+1541	16Neu	0.711996	2	2610	624
+1542	2Ery	0.8274982	1	1014	2187
+1543	2Ery	0.83813167	1	1045	2574
+1544	16Neu	0.68959004	2	2497	53
+1545	7MEP	0.09135728	1	207	1177
+1546	14Mo	0.6085557	2	1874	558
+1547	14Mo	0.5837528	2	1806	2529
+1548	14Mo	0.42819872	2	1615	568
+1549	5Ery	0.4433239	1	546	257
+1550	5Ery	0.63846225	1	736	2364
+1551	3Ery	0.759146	1	860	2442
+1552	3Ery	0.82191306	1	997	418
+1553	2Ery	0.85990936	1	1128	1699
+1554	18Eos	0.48251304	2	1697	263
+1555	14Mo	0.669426	2	2354	599
+1556	3Ery	0.7909011	1	914	2474
+1557	14Mo	0.67126137	2	2367	879
+1558	14Mo	0.6196451	2	1930	2640
+1559	12Baso	0.20481816	2	1390	1731
+1560	14Mo	0.66692865	2	2331	2700
+1561	4Ery	0.7252938	1	816	405
+1562	3Ery	0.9096519	1	1283	1220
+1563	14Mo	0.6545225	2	2218	904
+1564	7MEP	0.09285175	1	215	1951
+1565	5Ery	0.16696979	1	306	1988
+1566	12Baso	0.2844469	2	1444	2247
+1567	2Ery	0.86976653	1	1169	587
+1568	15Mo	0.6723477	2	2376	1905
+1569	14Mo	0.67039394	2	2361	1333
+1570	3Ery	0.7870239	1	911	390
+1571	14Mo	0.6567271	2	2238	2507
+1572	2Ery	0.8469243	1	1067	2273
+1573	3Ery	0.8916135	1	1245	2446
+1574	2Ery	0.88169545	1	1211	364
+1575	16Neu	0.6871232	2	2480	2632
+1576	7MEP	0.081835866	1	183	2588
+1577	2Ery	0.8724617	1	1176	728
+1578	10GMP	0.43688247	2	1627	2394
+1579	7MEP	0.20481804	2	1389	2515
+1580	5Ery	0.28392234	1	412	1074
+1581	5Ery	0.12625182	1	280	2045
+1582	13Baso	0.44350016	2	1636	2431
+1583	6Ery	0.18663187	1	323	591
+1584	7MEP	0.104152106	1	245	2313
+1585	3Ery	0.74200606	1	842	114
+1586	10GMP	0.20334549	2	1387	409
+1587	5Ery	0.6267103	1	725	584
+1588	5Ery	0.44826776	1	551	27
+1589	1Ery	0.79994	1	938	1435
+1590	13Baso	0.6533033	2	2204	2604
+1591	15Mo	0.7135097	2	2615	1303
+1592	3Ery	0.30849886	1	435	2226
+1593	6Ery	0.1162077	1	268	2255
+1594	14Mo	0.662425	2	2292	285
+1595	11DC	0.6088318	3	2702	2117
+1596	3Ery	0.6107711	1	699	1433
+1597	3Ery	0.3320114	1	454	2528
+1598	3Ery	0.8557388	1	1109	891
+1599	16Neu	0.70054805	2	2558	2721
+1600	3Ery	0.3304239	1	452	628
+1601	9GMP	0.42355162	2	1609	362
+1602	14Mo	0.61034906	2	1883	2092
+1603	12Baso	0.26882833	2	1429	2533
+1604	9GMP	0.3050091	2	1459	1833
+1605	14Mo	0.6235331	2	1954	511
+1606	14Mo	0.6436629	2	2120	1190
+1607	8Mk	0.16535313	0	27	1250
+1608	5Ery	0.3772782	1	482	1998
+1609	15Mo	0.6033987	2	1851	1601
+1610	15Mo	0.6916678	2	2506	2320
+1611	3Ery	0.89479434	1	1257	1884
+1612	16Neu	0.6998624	2	2551	2336
+1613	15Mo	0.7058695	2	2586	601
+1614	4Ery	0.5308266	1	630	796
+1615	3Ery	0.72790354	1	820	1548
+1616	8Mk	0.13033713	0	23	2506
+1617	15Mo	0.70582956	2	2585	151
+1618	14Mo	0.6772816	2	2411	1486
+1619	5Ery	0.35269663	1	469	1914
+1620	3Ery	0.43719077	1	538	368
+1621	4Ery	0.56681836	1	654	1734
+1622	2Ery	0.8243618	1	1004	594
+1623	8Mk	0.36968464	2	1528	1358
+1624	7MEP	0.07554779	1	166	97
+1625	10GMP	0.52283514	2	1726	696
+1626	15Mo	0.52485013	2	1730	1345
+1627	14Mo	0.69505656	2	2526	1578
+1628	13Baso	0.523437	2	1729	67
+1629	3Ery	0.8731233	1	1180	1475
+1630	7MEP	0.13116732	0	115	1414
+1631	2Ery	0.8568905	1	1117	366
+1632	13Baso	0.6675366	2	2339	1642
+1633	2Ery	0.40800852	1	512	1934
+1634	10GMP	0.45468482	2	1654	134
+1635	2Ery	0.89049804	1	1240	1755
+1636	2Ery	0.8500862	1	1084	1582
+1637	2Ery	0.8680575	1	1158	648
+1638	12Baso	0.26892823	2	1430	1492
+1639	14Mo	0.6330346	2	2016	162
+1640	1Ery	0.92570883	1	1306	1440
+1641	14Mo	0.65772533	2	2245	578
+1642	14Mo	0.44257668	2	1632	2671
+1643	2Ery	0.92098576	1	1300	2662
+1644	14Mo	0.62538725	2	1965	110
+1645	16Neu	0.6786202	2	2419	1277
+1646	14Mo	0.69725275	2	2540	1154
+1647	8Mk	0.12294512	0	118	2618
+1648	16Neu	0.6141055	2	1910	2690
+1649	16Neu	0.65636754	2	2231	80
+1650	2Ery	0.89231056	1	1247	2256
+1651	8Mk	0.16745563	0	91	321
+1652	5Ery	0.6367235	1	732	1872
+1653	6Ery	0.2325324	1	361	1715
+1654	19Lymph	0.3715497	0	87	1634
+1655	15Mo	0.6345103	2	2026	1297
+1656	13Baso	0.47103396	2	1679	962
+1657	5Ery	0.4027044	1	508	2605
+1658	14Mo	0.67367053	2	2389	2624
+1659	5Ery	0.5844034	1	677	1418
+1660	6Ery	0.22374375	1	349	464
+1661	16Neu	0.68844825	2	2491	2675
+1662	3Ery	0.95886254	1	1322	820
+1663	15Mo	0.6390114	2	2072	1666
+1664	7MEP	0.080711186	1	179	2040
+1665	7MEP	0.1629603	1	301	2377
+1666	10GMP	0.46123955	2	1663	447
+1667	14Mo	0.67514896	2	2397	2069
+1668	3Ery	0.91156393	1	1284	2176
+1669	4Ery	0.48368582	1	587	478
+1670	13Baso	0.6253027	2	1964	260
+1671	15Mo	0.6966194	2	2535	2081
+1672	11DC	0.77270126	3	2711	1203
+1673	17Neu	0.3134791	2	1475	2505
+1674	4Ery	0.51323014	1	615	1704
+1675	6Ery	0.39889574	1	503	1736
+1676	3Ery	0.8910627	1	1243	810
+1677	3Ery	0.8766213	1	1200	2076
+1678	7MEP	0.193549	2	1378	148
+1679	8Mk	0.1981625	2	1381	1656
+1680	6Ery	0.14513375	1	291	149
+1681	11DC	0.40359208	0	119	1739
+1682	16Neu	0.69352436	2	2520	1938
+1683	3Ery	0.77419066	1	885	2488
+1684	14Mo	0.68951887	2	2496	381
+1685	4Ery	0.6904364	1	789	740
+1686	4Ery	0.7984339	1	934	325
+1687	11DC	0.81469065	3	2719	1705
+1688	3Ery	0.24274349	1	371	2404
+1689	14Mo	0.68927556	2	2495	2086
+1690	15Mo	0.6766163	2	2407	834
+1691	3Ery	0.8936424	1	1249	1939
+1692	10GMP	0.55306745	2	1754	1148
+1693	6Ery	0.09553083	1	226	1498
+1694	2Ery	0.84981155	1	1081	2199
+1695	16Neu	0.64594793	2	2138	2196
+1696	15Mo	0.6778577	2	2416	725
+1697	7MEP	0.13725281	2	1341	1554
+1698	3Ery	0.79541224	1	924	2485
+1699	10GMP	0.3888651	2	1553	652
+1700	3Ery	0.8099065	1	967	2217
+1701	14Mo	0.6428752	2	2113	328
+1702	7MEP	0.1123341	1	261	2451
+1703	6Ery	0.40910578	1	513	2696
+1704	10GMP	0.46800724	2	1674	942
+1705	10GMP	0.475795	2	1687	2517
+1706	3Ery	0.80853486	1	961	921
+1707	7MEP	0.09838557	1	233	806
+1708	2Ery	0.8442322	1	1063	1761
+1709	4Ery	0.54982644	1	644	2719
+1710	7MEP	0.09087004	1	205	1218
+1711	13Baso	0.60435915	2	1857	81
+1712	6Ery	0.28859922	1	419	899
+1713	15Mo	0.6912013	2	2504	2447
+1714	8Mk	0.09570589	1	227	756
+1715	10GMP	0.45364356	2	1653	915
+1716	4Ery	0.495359	1	598	1462
+1717	4Ery	0.8470872	1	1070	2722
+1718	3Ery	0.5906336	1	678	342
+1719	7MEP	0.13319716	1	287	189
+1720	2Ery	0.8919373	1	1246	2650
+1721	16Neu	0.6880136	2	2486	544
+1722	3Ery	0.8053245	1	956	143
+1723	3Ery	0.59154844	1	681	1924
+1724	6Ery	0.22257026	1	346	432
+1725	6Ery	0.20377606	1	334	407
+1726	7MEP	0.1297355	0	93	1625
+1727	4Ery	0.510408	1	609	2643
+1728	16Neu	0.6644082	2	2308	1328
+1729	2Ery	0.88991064	1	1238	1628
+1730	13Baso	0.5726026	2	1786	1626
+1731	10GMP	0.3958362	2	1559	1923
+1732	3Ery	0.83655345	1	1039	677
+1733	3Ery	0.88259953	1	1213	1246
+1734	10GMP	0.4321658	2	1621	356
+1735	6Ery	0.23063724	1	358	2056
+1736	14Mo	0.46822906	2	1675	1753
+1737	15Mo	0.6830026	2	2454	2689
+1738	7MEP	0.12200386	0	103	1747
+1739	13Baso	0.47224212	2	1681	2340
+1740	14Mo	0.65805936	2	2250	2223
+1741	14Mo	0.6589044	2	2265	2500
+1742	14Mo	0.62280583	2	1951	2129
+1743	2Ery	0.86529046	1	1149	187
+1744	16Neu	0.67238283	2	2378	2184
+1745	7MEP	0.072708435	1	160	1368
+1746	14Mo	0.67883795	2	2423	1181
+1747	10GMP	0.5326319	2	1738	932
+1748	14Mo	0.67177117	2	2374	13
+1749	6Ery	0.1943064	1	326	1419
+1750	14Mo	0.70148546	2	2563	1343
+1751	16Neu	0.71217567	2	2611	394
+1752	2Ery	0.84113747	1	1054	2714
+1753	10GMP	0.5308541	2	1736	1001
+1754	16Neu	0.67722404	2	2410	1692
+1755	14Mo	0.44348124	2	1635	583
+1756	14Mo	0.62986475	2	1996	2680
+1757	5Ery	0.4486881	1	552	1888
+1758	12Baso	0.29997686	2	1455	2481
+1759	4Ery	0.608385	1	697	385
+1760	3Ery	0.93125504	1	1311	1048
+1761	13Baso	0.4945602	2	1708	754
+1762	2Ery	0.88564116	1	1222	835
+1763	4Ery	0.8098541	1	966	2371
+1764	4Ery	0.54715794	1	640	640
+1765	3Ery	0.4847664	1	588	1534
+1766	3Ery	0.4818962	1	585	34
+1767	13Baso	0.6032167	2	1849	500
+1768	12Baso	0.19436117	2	1379	997
+1769	14Mo	0.7001368	2	2554	672
+1770	16Neu	0.7694436	2	2693	284
+1771	3Ery	0.46443757	1	568	831
+1772	5Ery	0.43072644	1	532	524
+1773	6Ery	0.12614644	1	279	1335
+1774	7MEP	0.15390535	0	107	686
+1775	4Ery	0.6085397	1	698	978
+1776	4Ery	0.55131096	1	646	463
+1777	5Ery	0.6136177	1	704	1111
+1778	14Mo	0.6061997	2	1865	2479
+1779	14Mo	0.5798578	2	1801	709
+1780	2Ery	0.81780946	1	989	1444
+1781	12Baso	0.08904648	1	202	2613
+1782	3Ery	0.92293984	1	1302	1963
+1783	5Ery	0.6114831	1	701	220
+1784	2Ery	0.78893	1	912	1162
+1785	2Ery	0.8497637	1	1080	643
+1786	16Neu	0.67526925	2	2400	1730
+1787	7MEP	0.11976697	0	97	310
+1788	5Ery	0.3613712	1	473	1040
+1789	2Ery	0.7742951	1	886	250
+1790	7MEP	0.12033818	0	96	2673
+1791	3Ery	0.38577488	1	493	1522
+1792	4Ery	0.6270341	1	726	2341
+1793	2Ery	0.869429	1	1167	2047
+1794	5Ery	0.5165175	1	617	1466
+1795	10GMP	0.24297883	2	1412	274
+1796	1Ery	0.8693192	1	1166	2536
+1797	10GMP	0.33169156	2	1489	791
+1798	11DC	0.72751445	3	2707	2048
+1799	16Neu	0.7109443	2	2604	684
+1800	2Ery	0.82551384	1	1009	687
+1801	2Ery	0.8654962	1	1150	1779
+1802	2Ery	0.80108505	1	941	2145
+1803	5Ery	0.3306596	1	453	812
+1804	5Ery	0.5032347	1	604	197
+1805	14Mo	0.6597815	2	2272	2480
+1806	14Mo	0.6538647	2	2211	1547
+1807	16Neu	0.67879754	2	2421	808
+1808	10GMP	0.15473711	0	130	5
+1809	14Mo	0.63668495	2	2046	608
+1810	14Mo	0.6446677	2	2129	1867
+1811	4Ery	0.64378184	1	743	695
+1812	2Ery	0.8869364	1	1227	2561
+1813	6Ery	0.29299694	1	424	1818
+1814	2Ery	0.82496387	1	1006	988
+1815	19Lymph	0.4750859	0	22	109
+1816	16Neu	0.70976955	2	2600	2627
+1817	1Ery	0.7959445	1	928	706
+1818	13Baso	0.58503485	2	1813	1943
+1819	3Ery	0.7628702	1	864	2337
+1820	15Mo	0.7235883	2	2638	764
+1821	3Ery	0.80504435	1	955	1253
+1822	5Ery	0.5750943	1	665	661
+1823	2Ery	0.8029648	1	946	2234
+1824	2Ery	0.79181045	1	917	938
+1825	16Neu	0.73942995	2	2666	2459
+1826	4Ery	0.7040848	1	799	2416
+1827	12Baso	0.23985429	2	1408	825
+1828	3Ery	0.8340505	1	1028	2596
+1829	12Baso	0.28582445	2	1448	249
+1830	14Mo	0.65821326	2	2253	528
+1831	15Mo	0.68829876	2	2490	283
+1832	14Mo	0.64546055	2	2135	194
+1833	10GMP	0.42025235	2	1604	1504
+1834	6Ery	0.2966817	1	427	2339
+1835	12Baso	0.304595	2	1458	2351
+1836	2Ery	0.8745617	1	1191	1517
+1837	3Ery	0.8088716	1	963	2309
+1838	4Ery	0.67289364	1	773	573
+1839	7MEP	0.08026737	1	177	2188
+1840	4Ery	0.7797429	1	895	79
+1841	15Mo	0.7090332	2	2596	422
+1842	2Ery	0.8426888	1	1058	2557
+1843	7MEP	0.30047432	0	40	2248
+1844	14Mo	0.72341067	2	2637	1978
+1845	3Ery	0.6468191	1	745	1287
+1846	13Baso	0.64112496	2	2094	2677
+1847	3Ery	0.8997456	1	1270	1050
+1848	15Mo	0.66678786	2	2329	2527
+1849	15Mo	0.6607137	2	2281	1767
+1850	13Baso	0.61071116	2	1888	1919
+1851	14Mo	0.61145175	2	1895	1609
+1852	4Ery	0.91678405	1	1296	555
+1853	14Mo	0.64882034	2	2167	446
+1854	6Ery	0.13039894	1	284	781
+1855	3Ery	0.69626176	1	792	509
+1856	14Mo	0.6438845	2	2123	772
+1857	8Mk	0.065373115	1	146	1711
+1858	8Mk	0.16909325	0	38	2180
+1859	7MEP	0.10165254	1	241	638
+1860	15Mo	0.67282104	2	2384	2430
+1861	15Mo	0.67878765	2	2420	1269
+1862	13Baso	0.6279648	2	1975	2099
+1863	16Neu	0.71328497	2	2613	2238
+1864	6Ery	0.20257135	1	332	2177
+1865	3Ery	0.923614	1	1304	1778
+1866	2Ery	0.8793438	1	1208	1101
+1867	13Baso	0.5847688	2	1810	822
+1868	3Ery	0.8747116	1	1192	1426
+1869	3Ery	0.79640377	1	930	580
+1870	13Baso	0.65268075	2	2197	2614
+1871	11DC	0.7843736	3	2713	2054
+1872	10GMP	0.45262593	2	1652	693
+1873	4Ery	0.61739683	1	708	1214
+1874	2Ery	0.9046305	1	1279	1546
+1875	7MEP	0.06351749	1	144	1361
+1876	7MEP	0.1423388	0	1	1449
+1877	6Ery	0.24661249	1	374	2642
+1878	3Ery	0.66917527	1	767	2435
+1879	16Neu	0.6929402	2	2516	493
+1880	7MEP	0.14202175	0	3	2219
+1881	14Mo	0.6289092	2	1988	1088
+1882	3Ery	0.31513155	1	444	2651
+1883	6Ery	0.4952584	1	597	1602
+1884	9GMP	0.42479885	2	1611	1129
+1885	12Baso	0.22971834	2	1404	281
+1886	3Ery	0.8183318	1	990	1131
+1887	14Mo	0.6396379	2	2079	1373
+1888	10GMP	0.55501586	2	1757	1850
+1889	4Ery	0.49318868	1	595	1456
+1890	7MEP	0.092693545	1	214	361
+1891	6Ery	0.21286751	1	341	864
+1892	14Mo	0.64291865	2	2114	875
+1893	14Mo	0.6299494	2	1998	552
+1894	4Ery	0.80439186	1	952	1152
+1895	3Ery	0.8886253	1	1233	1851
+1896	3Ery	0.5943844	1	683	2585
+1897	2Ery	0.85847515	1	1124	2573
+1898	16Neu	0.6953834	2	2529	2152
+1899	3Ery	0.8754178	1	1195	2011
+1900	7MEP	0.122030556	1	274	2318
+1901	18Eos	0.37064707	2	1533	2420
+1902	6Ery	0.2891313	1	420	95
+1903	13Baso	0.6295812	2	1993	2332
+1904	4Ery	0.55103993	1	645	2200
+1905	10GMP	0.3999108	2	1568	153
+1906	6Ery	0.22575957	1	351	645
+1907	2Ery	0.86368173	1	1142	575
+1908	12Baso	0.12744434	0	16	983
+1909	1Ery	0.8973962	1	1263	2622
+1910	4Ery	0.28796062	1	418	1648
+1911	13Baso	0.6237064	2	1956	535
+1912	14Mo	0.6649252	2	2313	1931
+1913	14Mo	0.7084656	2	2595	1955
+1914	13Baso	0.43091056	2	1619	2472
+1915	3Ery	0.49221727	1	593	1321
+1916	3Ery	0.89456785	1	1256	226
+1917	16Neu	0.67951095	2	2429	664
+1918	15Mo	0.7462156	2	2671	1387
+1919	14Mo	0.60336655	2	1850	671
+1920	3Ery	0.4382412	1	541	2072
+1921	6Ery	0.17945299	1	318	2427
+1922	2Ery	0.871122	1	1173	1371
+1923	10GMP	0.5263377	2	1731	828
+1924	14Mo	0.5133223	2	1723	1107
+1925	5Ery	0.25032014	1	379	1233
+1926	4Ery	0.7449228	1	847	2317
+1927	15Mo	0.67605036	2	2405	1364
+1928	13Baso	0.6363215	2	2043	2448
+1929	15Mo	0.68877196	2	2493	352
+1930	13Baso	0.6227394	2	1949	1558
+1931	14Mo	0.6148223	2	1912	1169
+1932	12Baso	0.24715036	2	1418	746
+1933	16Neu	0.66980743	2	2356	387
+1934	13Baso	0.44259718	2	1633	2658
+1935	6Ery	0.27593458	1	403	2352
+1936	15Mo	0.67519283	2	2398	1166
+1937	4Ery	0.7486727	1	850	288
+1938	14Mo	0.47311997	2	1682	2055
+1939	13Baso	0.47943172	2	1691	1506
+1940	15Mo	0.64577484	2	2137	400
+1941	3Ery	0.57714355	1	668	2314
+1942	10GMP	0.070291325	1	155	1270
+1943	13Baso	0.58958966	2	1818	2444
+1944	4Ery	0.86811495	1	1159	634
+1945	8Mk	0.19991656	2	1382	373
+1946	3Ery	0.7132808	1	809	768
+1947	14Mo	0.6595199	2	2269	2495
+1948	15Mo	0.67240435	2	2379	494
+1949	16Neu	0.6909981	2	2502	1930
+1950	15Mo	0.6419537	2	2105	2300
+1951	9GMP	0.3965054	2	1564	1742
+1952	16Neu	0.75975406	2	2685	1002
+1953	12Baso	0.28381324	2	1442	1495
+1954	10GMP	0.15789407	2	1350	1605
+1955	14Mo	0.6156825	2	1913	255
+1956	14Mo	0.64091545	2	2090	1911
+1957	14Mo	0.6667399	2	2327	62
+1958	7MEP	0.20166491	1	331	560
+1959	15Mo	0.65986997	2	2276	595
+1960	17Neu	0.27864906	2	1437	338
+1961	2Ery	0.8773501	1	1202	408
+1962	14Mo	0.65422183	2	2215	2287
+1963	14Mo	0.56948024	2	1782	280
+1964	4Ery	0.8325112	1	1024	1670
+1965	6Ery	0.25336298	1	382	1644
+1966	15Mo	0.68847847	2	2492	782
+1967	2Ery	0.8543089	1	1100	414
+1968	2Ery	0.6544664	1	750	2454
+1969	5Ery	0.20722313	1	336	1011
+1970	2Ery	0.7846794	1	903	604
+1971	2Ery	0.86650366	1	1153	895
+1972	14Mo	0.65335953	2	2205	1173
+1973	2Ery	0.87086326	1	1171	2422
+1974	14Mo	0.64784974	2	2160	2678
+1975	15Mo	0.64644957	2	2146	1862
+1976	5Ery	0.68117297	1	780	412
+1977	6Ery	0.18856433	1	324	277
+1978	13Baso	0.6024012	2	1844	1017
+1979	6Ery	0.09344822	1	218	821
+1980	13Baso	0.6463502	2	2143	1243
+1981	5Ery	0.2487112	1	376	698
+1982	15Mo	0.67440754	2	2393	653
+1983	3Ery	0.75009274	1	853	1144
+1984	10GMP	0.3602726	2	1514	142
+1985	2Ery	0.68055326	1	779	1330
+1986	14Mo	0.6499972	2	2178	2210
+1987	2Ery	0.49259976	1	594	649
+1988	14Mo	0.39688507	2	1565	1881
+1989	2Ery	0.80890965	1	964	2461
+1990	2Ery	0.86828595	1	1160	2599
+1991	2Ery	0.80403626	1	951	692
+1992	5Ery	0.57673305	1	666	1231
+1993	14Mo	0.67117536	2	2365	1903
+1994	1Ery	0.8286186	1	1017	936
+1995	5Ery	0.80122435	1	943	1099
+1996	4Ery	0.68955934	1	788	1756
+1997	2Ery	0.7694164	1	879	232
+1998	10GMP	0.4229138	2	1608	1893
+1999	2Ery	0.6264478	1	724	1163
+2000	2Ery	0.46427318	1	567	427
+2001	7MEP	0.09880815	1	235	678
+2002	2Ery	0.8563361	1	1115	1114
+2003	7MEP	0.20913294	2	1393	2327
+2004	1Ery	0.9793543	1	1328	63
+2005	7MEP	0.120198704	0	81	620
+2006	9GMP	0.33027112	2	1487	482
+2007	2Ery	0.79102075	1	915	1235
+2008	17Neu	0.2165167	2	1395	1159
+2009	14Mo	0.6415271	2	2101	1020
+2010	14Mo	0.6582938	2	2257	132
+2011	13Baso	0.6124933	2	1899	1019
+2012	7MEP	0.22798298	2	1401	843
+2013	16Neu	0.6818719	2	2447	605
+2014	2Ery	0.8146313	1	983	1103
+2015	2Ery	0.777303	1	890	803
+2016	7MEP	0.0895867	1	204	1639
+2017	6Ery	0.17116767	1	311	2370
+2018	14Mo	0.6592349	2	2267	579
+2019	4Ery	0.8235734	1	1002	2534
+2020	6Ery	0.11544419	1	267	2705
+2021	2Ery	0.8626003	1	1137	1242
+2022	4Ery	0.8143835	1	981	521
+2023	1Ery	0.89807314	1	1264	887
+2024	5Ery	0.44429657	1	547	2133
+2025	19Lymph	0.43129748	0	65	1215
+2026	8Mk	0.17650904	2	1370	1655
+2027	4Ery	0.6485199	1	747	1355
+2028	6Ery	0.13082534	1	285	559
+2029	13Baso	0.6387254	2	2066	380
+2030	6Ery	0.2625394	1	394	519
+2031	13Baso	0.68463624	2	2467	1282
+2032	7MEP	0.15132725	0	45	888
+2033	3Ery	0.63677657	1	733	1255
+2034	3Ery	0.9651047	1	1326	846
+2035	13Baso	0.6402312	2	2086	1104
+2036	3Ery	0.25938085	1	390	371
+2037	15Mo	0.7038739	2	2577	365
+2038	14Mo	0.6409798	2	2093	2498
+2039	6Ery	0.57188356	1	660	251
+2040	10GMP	0.46220222	2	1664	2231
+2041	16Neu	0.72600836	2	2647	1351
+2042	4Ery	0.6036259	1	693	2281
+2043	14Mo	0.67074907	2	2363	1928
+2044	14Mo	0.69637376	2	2532	2538
+2045	10GMP	0.40583676	2	1581	2254
+2046	3Ery	0.569849	1	657	1809
+2047	10GMP	0.57624406	2	1793	374
+2048	14Mo	0.579438	2	1798	783
+2049	3Ery	0.5491811	1	642	2168
+2050	4Ery	0.89484614	1	1259	102
+2051	19Lymph	0.45043454	0	50	170
+2052	14Mo	0.63899744	2	2070	2174
+2053	3Ery	0.91924924	1	1299	2555
+2054	15Mo	0.6080715	2	1871	275
+2055	15Mo	0.62048286	2	1938	1174
+2056	10GMP	0.5305052	2	1735	459
+2057	15Mo	0.6861956	2	2474	824
+2058	15Mo	0.6948545	2	2525	1377
+2059	14Mo	0.65828204	2	2256	1415
+2060	13Baso	0.6422325	2	2106	1155
+2061	16Neu	0.6530804	2	2202	1216
+2062	14Mo	0.6674573	2	2336	996
+2063	4Ery	0.5908803	1	680	173
+2064	14Mo	0.7168721	2	2623	345
+2065	9GMP	0.07012496	1	154	702
+2066	3Ery	0.90438986	1	1278	2029
+2067	14Mo	0.70408374	2	2578	224
+2068	3Ery	0.7396626	1	835	12
+2069	10GMP	0.46418574	2	1667	2463
+2070	16Neu	0.68280315	2	2453	2052
+2071	16Neu	0.74487156	2	2668	2512
+2072	13Baso	0.6166507	2	1920	1663
+2073	1Ery	0.9122819	1	1285	2405
+2074	6Ery	0.12010768	2	1333	2410
+2075	2Ery	0.62364227	1	718	388
+2076	14Mo	0.4704426	2	1677	57
+2077	2Ery	0.81381094	1	979	2324
+2078	14Mo	0.68794745	2	2485	72
+2079	5Ery	0.41744316	1	523	1887
+2080	2Ery	0.80113226	1	942	787
+2081	9GMP	0.4653097	2	1671	1407
+2082	13Baso	0.64523923	2	2131	991
+2083	2Ery	0.7261229	1	819	2530
+2084	3Ery	0.36534402	1	475	600
+2085	16Neu	0.69453007	2	2523	498
+2086	13Baso	0.47883293	2	1689	2035
+2087	14Mo	0.6494066	2	2170	1349
+2088	4Ery	0.7367926	1	829	863
+2089	3Ery	0.66645044	1	761	531
+2090	6Ery	0.1291099	1	283	1956
+2091	7MEP	0.056733537	1	138	398
+2092	10GMP	0.41920593	2	1602	1198
+2093	4Ery	0.5591511	1	650	2038
+2094	2Ery	0.74885994	1	851	1846
+2095	16Neu	0.67567194	2	2404	144
+2096	12Baso	0.28507507	2	1446	2726
+2097	19Lymph	0.49170446	0	86	2298
+2098	7MEP	0.1605838	0	4	1097
+2099	13Baso	0.605269	2	1862	2728
+2100	4Ery	0.6968858	1	793	2220
+2101	7MEP	0.09267421	1	213	2009
+2102	4Ery	0.7114726	1	808	2216
+2103	12Baso	0.31265053	2	1474	2548
+2104	5Ery	0.27636003	1	404	562
+2105	2Ery	0.6957384	1	791	1950
+2106	2Ery	0.8342915	1	1029	2060
+2107	9GMP	0.37111098	2	1534	700
+2108	1Ery	0.9238522	1	1305	41
+2109	11DC	0.8207592	3	2723	453
+2110	3Ery	0.77302086	1	884	626
+2111	14Mo	0.64440787	2	2126	549
+2112	16Neu	0.6845104	2	2464	1045
+2113	2Ery	0.86199117	1	1135	1701
+2114	5Ery	0.6838892	1	784	1892
+2115	14Mo	0.7069924	2	2590	169
+2116	15Mo	0.70460546	2	2579	183
+2117	9GMP	0.41586024	2	1595	243
+2118	9GMP	0.3085363	2	1466	644
+2119	14Mo	0.6685519	2	2349	857
+2120	2Ery	0.8360756	1	1035	1606
+2121	4Ery	0.783292	1	901	1450
+2122	5Ery	0.57507414	1	664	884
+2123	4Ery	0.78699994	1	910	1856
+2124	3Ery	0.832915	1	1026	1133
+2125	16Neu	0.6711163	2	2364	1224
+2126	2Ery	0.80447596	1	953	2111
+2127	16Neu	0.7052392	2	2583	2347
+2128	2Ery	0.8542717	1	1099	543
+2129	13Baso	0.5384484	2	1742	1810
+2130	2Ery	0.8329389	1	1027	349
+2131	6Ery	0.15527849	1	297	2082
+2132	6Ery	0.30687633	1	433	1516
+2133	14Mo	0.63449717	2	2024	357
+2134	2Ery	0.5680869	1	655	419
+2135	2Ery	0.7231623	1	815	1832
+2136	8Mk	0.16048568	0	62	347
+2137	8Mk	0.1726428	2	1362	1940
+2138	14Mo	0.65011233	2	2180	1695
+2139	14Mo	0.6773409	2	2412	470
+2140	1Ery	0.89664775	1	1262	481
+2141	4Ery	0.82275635	1	999	2467
+2142	7MEP	0.15743081	2	1349	472
+2143	16Neu	0.66750526	2	2337	1980
+2144	16Neu	0.70344424	2	2575	45
+2145	14Mo	0.5802189	2	1802	637
+2146	3Ery	0.41057852	1	515	1975
+2147	2Ery	0.8942725	1	1252	236
+2148	16Neu	0.71181357	2	2608	1151
+2149	17Neu	0.30724865	2	1464	2274
+2150	6Ery	0.389531	1	498	1087
+2151	2Ery	0.73148656	1	825	1507
+2152	14Mo	0.61232585	2	1898	2252
+2153	16Neu	0.694811	2	2524	742
+2154	7MEP	0.11341574	0	48	127
+2155	2Ery	0.85201895	1	1091	1346
+2156	3Ery	0.9030044	1	1276	178
+2157	2Ery	0.60391945	1	694	1263
+2158	6Ery	0.26373413	1	397	436
+2159	6Ery	0.12028013	1	272	694
+2160	6Ery	0.09996323	1	237	1974
+2161	10GMP	0.3171716	2	1477	896
+2162	12Baso	0.24629442	2	1416	2316
+2163	12Baso	0.33325067	2	1491	874
+2164	4Ery	0.48971823	1	591	862
+2165	2Ery	0.7636216	1	868	215
+2166	4Ery	0.21512702	1	342	1273
+2167	2Ery	0.7283576	1	822	1853
+2168	14Mo	0.63706326	2	2049	2386
+2169	3Ery	0.70776916	1	805	392
+2170	6Ery	0.16007033	1	298	2087
+2171	3Ery	0.91672903	1	1295	2595
+2172	10GMP	0.11713233	0	64	454
+2173	2Ery	0.73693043	1	830	514
+2174	14Mo	0.63719594	2	2052	954
+2175	16Neu	0.6987632	2	2549	2411
+2176	18Eos	0.46421897	2	1668	946
+2177	13Baso	0.60571575	2	1864	2641
+2178	6Ery	0.4413626	1	544	1986
+2179	14Mo	0.6663534	2	2322	2186
+2180	13Baso	0.6047043	2	1858	2138
+2181	2Ery	0.6322943	1	731	2589
+2182	2Ery	0.73714256	1	831	752
+2183	5Ery	0.22337405	1	347	160
+2184	10GMP	0.5424852	2	1744	1274
+2185	5Ery	0.58056796	1	671	987
+2186	14Mo	0.65004367	2	2179	2319
+2187	13Baso	0.38061342	2	1542	75
+2188	14Mo	0.5990634	2	1839	748
+2189	16Neu	0.67928094	2	2427	799
+2190	2Ery	0.7072574	1	803	889
+2191	10GMP	0.17182612	2	1361	635
+2192	4Ery	0.69983137	1	795	804
+2193	16Neu	0.74717647	2	2673	2578
+2194	6Ery	0.12228281	1	276	2682
+2195	15Mo	0.69697773	2	2539	735
+2196	14Mo	0.481579	2	1695	1431
+2197	12Baso	0.25398225	2	1421	1870
+2198	7MEP	0.1515282	2	1348	2358
+2199	10GMP	0.48150906	2	1694	1382
+2200	15Mo	0.6134794	2	1904	428
+2201	3Ery	0.9816575	1	1329	2233
+2202	15Mo	0.687787	2	2482	2061
+2203	3Ery	0.8949059	1	1260	426
+2204	9GMP	0.3697843	2	1529	1590
+2205	2Ery	0.86475164	1	1147	1972
+2206	7MEP	0.18592173	2	1373	2587
+2207	3Ery	0.7866803	1	908	912
+2208	13Baso	0.67510855	2	2396	1189
+2209	16Neu	0.72892773	2	2654	732
+2210	13Baso	0.62875456	2	1986	981
+2211	2Ery	0.91360193	1	1288	1806
+2212	15Mo	0.7016115	2	2564	557
+2213	7MEP	0.20696306	2	1391	554
+2214	6Ery	0.21564977	1	343	2290
+2215	5Ery	0.47826403	1	580	1962
+2216	13Baso	0.6415891	2	2102	949
+2217	10GMP	0.48348582	2	1700	736
+2218	9GMP	0.33444256	2	1494	1563
+2219	13Baso	0.61015546	2	1880	2541
+2220	13Baso	0.6414967	2	2100	2240
+2221	12Baso	0.23967613	0	80	773
+2222	5Ery	0.4127397	1	519	346
+2223	13Baso	0.53685087	2	1740	2655
+2224	15Mo	0.69292533	2	2515	2489
+2225	14Mo	0.68154234	2	2445	794
+2226	10GMP	0.4133284	2	1592	606
+2227	15Mo	0.69849974	2	2548	1469
+2228	4Ery	0.46375704	1	565	2723
+2229	5Ery	0.385249	1	492	246
+2230	8Mk	0.13920906	2	1344	1292
+2231	13Baso	0.6361022	2	2040	1649
+2232	7MEP	0.05403806	1	137	910
+2233	14Mo	0.6530433	2	2201	139
+2234	14Mo	0.5925539	2	1823	1078
+2235	2Ery	0.7323095	1	826	59
+2236	6Ery	0.4528237	1	555	82
+2237	2Ery	0.8432304	1	1059	918
+2238	13Baso	0.605687	2	1863	1571
+2239	7MEP	0.11755518	2	1332	1316
+2240	16Neu	0.6546519	2	2220	2261
+2241	14Mo	0.6770125	2	2408	2607
+2242	3Ery	0.4639031	1	566	1490
+2243	16Neu	0.6714399	2	2370	146
+2244	19Lymph	0.33609483	2	1496	2415
+2245	10GMP	0.3701854	2	1530	1641
+2246	12Baso	0.28477326	2	1445	96
+2247	10GMP	0.39766094	2	1566	2693
+2248	13Baso	0.6022758	2	1843	2308
+2249	1Ery	0.8371591	1	1040	2407
+2250	16Neu	0.70589364	2	2587	1740
+2251	6Ery	0.13127595	1	286	303
+2252	14Mo	0.64700466	2	2152	1403
+2253	2Ery	0.82499635	1	1007	1830
+2254	14Mo	0.63644993	2	2045	1439
+2255	10GMP	0.41342857	2	1593	402
+2256	14Mo	0.45166066	2	1650	2059
+2257	16Neu	0.68779993	2	2483	2010
+2258	9GMP	0.29806805	2	1453	1015
+2259	3Ery	0.28418076	1	413	24
+2260	3Ery	0.8900317	1	1239	444
+2261	14Mo	0.65727025	2	2240	324
+2262	2Ery	0.7756985	1	888	2504
+2263	12Baso	0.25738034	2	1423	1192
+2264	9GMP	0.3284291	2	1486	1283
+2265	1Ery	0.9269184	1	1308	1741
+2266	3Ery	0.5524589	1	647	744
+2267	5Ery	0.5385854	1	635	2018
+2268	2Ery	0.72299737	1	814	2710
+2269	8Mk	0.1450639	0	72	1947
+2270	2Ery	0.8123234	1	971	1057
+2271	16Neu	0.6861541	2	2472	184
+2272	5Ery	0.51646894	1	616	1805
+2273	10GMP	0.4011455	2	1572	930
+2274	13Baso	0.6467122	2	2149	2299
+2275	16Neu	0.6951681	2	2528	410
+2276	14Mo	0.682048	2	2449	1959
+2277	2Ery	0.7518913	1	855	1434
+2278	5Ery	0.4463402	1	548	360
+2279	15Mo	0.6665214	2	2324	488
+2280	7MEP	0.11089291	1	258	100
+2281	15Mo	0.6362843	2	2042	1849
+2282	5Ery	0.46050462	1	563	705
+2283	6Ery	0.17737627	1	316	1294
+2284	5Ery	0.3110654	1	440	2486
+2285	2Ery	0.82316566	1	1000	2717
+2286	3Ery	0.84055614	1	1052	928
+2287	15Mo	0.6252049	2	1962	502
+2288	7MEP	0.093994364	1	223	872
+2289	3Ery	0.8348598	1	1031	212
+2290	15Mo	0.6541831	2	2214	174
+2291	16Neu	0.72196656	2	2631	2322
+2292	6Ery	0.28103682	1	406	1594
+2293	7MEP	0.12403332	0	68	1499
+2294	6Ery	0.23398003	1	364	722
+2295	6Ery	0.26265463	1	395	1404
+2296	10GMP	0.35667357	2	1513	950
+2297	4Ery	0.74140203	1	841	193
+2298	13Baso	0.6412573	2	2097	1062
+2299	14Mo	0.659851	2	2274	1179
+2300	13Baso	0.62273943	2	1950	334
+2301	3Ery	0.83779365	1	1043	2668
+2302	6Ery	0.38192347	1	490	2494
+2303	8Mk	0.1587749	2	1352	1033
+2304	14Mo	0.6684768	2	2346	1319
+2305	2Ery	0.76399285	1	869	1510
+2306	9GMP	0.3644747	2	1519	379
+2307	6Ery	0.27283794	1	400	2666
+2308	15Mo	0.65796417	2	2248	1728
+2309	13Baso	0.5989121	2	1837	2597
+2310	3Ery	0.46712264	1	572	721
+2311	16Neu	0.705165	2	2582	2399
+2312	2Ery	0.87455803	1	1189	25
+2313	9GMP	0.40771082	2	1584	1912
+2314	14Mo	0.6209725	2	1941	313
+2315	3Ery	0.67137545	1	769	340
+2316	14Mo	0.64795446	2	2162	602
+2317	14Mo	0.6185241	2	1926	1102
+2318	16Neu	0.61268246	2	1900	2634
+2319	14Mo	0.6507614	2	2186	518
+2320	9GMP	0.42399663	2	1610	790
+2321	3Ery	0.70559496	1	801	435
+2322	13Baso	0.6621849	2	2291	2179
+2323	10GMP	0.09689186	0	42	572
+2324	14Mo	0.6395658	2	2077	2279
+2325	3Ery	0.22725825	1	354	789
+2326	6Ery	0.19913639	1	330	1401
+2327	14Mo	0.63130796	2	2003	1957
+2328	4Ery	0.6387464	1	738	916
+2329	3Ery	0.91441214	1	1291	1848
+2330	2Ery	0.78619975	1	905	760
+2331	2Ery	0.6162418	1	707	1560
+2332	14Mo	0.6132759	2	1903	74
+2333	2Ery	0.59782857	1	686	1352
+2334	8Mk	0.0716718	1	158	1359
+2335	10GMP	0.34835994	2	1504	945
+2336	10GMP	0.42562163	2	1612	2062
+2337	14Mo	0.58994395	2	1819	2143
+2338	10GMP	0.37443513	2	1535	1398
+2339	16Neu	0.5973936	2	1834	1632
+2340	10GMP	0.535815	2	1739	2342
+2341	10GMP	0.575714	2	1792	1146
+2342	13Baso	0.66768014	2	2340	471
+2343	16Neu	0.74733114	2	2674	1305
+2344	2Ery	0.48927283	1	590	290
+2345	16Neu	0.7068425	2	2589	2695
+2346	2Ery	0.7993624	1	937	2304
+2347	14Mo	0.64454055	2	2127	1399
+2348	11DC	0.77966017	3	2712	166
+2349	14Mo	0.67828345	2	2418	2119
+2350	11DC	0.8193215	3	2722	761
+2351	14Mo	0.5975821	2	1835	51
+2352	13Baso	0.62019694	2	1935	265
+2353	2Ery	0.8849061	1	1220	1432
+2354	2Ery	0.89835846	1	1266	1555
+2355	16Neu	0.69804776	2	2545	300
+2356	2Ery	0.70729023	1	804	1933
+2357	2Ery	0.813244	1	978	339
+2358	14Mo	0.65291417	2	2198	434
+2359	5Ery	0.4375554	1	540	1518
+2360	2Ery	0.49677417	1	600	135
+2361	7MEP	0.08250079	1	185	1569
+2362	9GMP	0.22949281	2	1403	1084
+2363	2Ery	0.79525113	1	923	2043
+2364	10GMP	0.38761884	2	1550	2125
+2365	7MEP	0.11530837	0	11	1993
+2366	6Ery	0.12890644	1	282	2716
+2367	15Mo	0.72396135	2	2640	1557
+2368	5Ery	0.4297445	1	531	753
+2369	5Ery	0.6404548	1	741	1320
+2370	15Mo	0.63315356	2	2017	2243
+2371	14Mo	0.55626947	2	1763	1479
+2372	8Mk	0.18666373	0	10	223
+2373	14Mo	0.6951088	2	2527	758
+2374	15Mo	0.71457255	2	2618	1748
+2375	4Ery	0.3136344	1	441	1266
+2376	14Mo	0.6806364	2	2439	1568
+2377	13Baso	0.46263322	2	1665	1483
+2378	6Ery	0.07720606	1	170	1744
+2379	4Ery	0.66574943	1	760	1948
+2380	13Baso	0.6798532	2	2433	716
+2381	4Ery	0.8288398	1	1018	2460
+2382	9GMP	0.34733096	2	1503	1411
+2383	3Ery	0.87371475	1	1185	192
+2384	8Mk	0.1628251	0	8	1860
+2385	8Mk	0.17507626	0	7	657
+2386	15Mo	0.64891386	2	2168	919
+2387	2Ery	0.85948324	1	1126	745
+2388	12Baso	0.28881237	2	1450	1308
+2389	3Ery	0.44663027	1	549	1658
+2390	15Mo	0.7544474	2	2681	832
+2391	15Mo	0.70832664	2	2594	1356
+2392	9GMP	0.3782199	2	1540	2697
+2393	3Ery	0.82500637	1	1008	1982
+2394	10GMP	0.4043604	2	1578	439
+2395	15Mo	0.70180154	2	2567	1006
+2396	16Neu	0.7094669	2	2599	2208
+2397	4Ery	0.41689843	1	522	1667
+2398	3Ery	0.34780616	1	463	1936
+2399	14Mo	0.6648095	2	2311	908
+2400	3Ery	0.56477123	1	653	1786
+2401	16Neu	0.747985	2	2675	1204
+2402	6Ery	0.2128088	1	340	2593
+2403	5Ery	0.5359135	1	634	487
+2404	13Baso	0.47670355	2	1688	2095
+2405	13Baso	0.63909686	2	2073	1927
+2406	11DC	0.80448216	3	2716	3
+2407	13Baso	0.6579749	2	2249	1690
+2408	8Mk	0.15944088	0	2	2241
+2409	2Ery	0.8732728	1	1181	767
+2410	13Baso	0.6392303	2	2074	1754
+2411	13Baso	0.6497706	2	2175	1618
+2412	8Mk	0.12146916	2	1334	2139
+2413	8Mk	0.15110475	0	18	865
+2414	15Mo	0.7290775	2	2655	227
+2415	14Mo	0.65769506	2	2244	1032
+2416	14Mo	0.59432644	2	1826	1696
+2417	19Lymph	0.4123435	0	19	1043
+2418	6Ery	0.0937595	1	221	2349
+2419	5Ery	0.2927591	1	423	1645
+2420	15Mo	0.61311096	2	1901	1861
+2421	7MEP	0.09230204	1	210	1807
+2422	15Mo	0.6275315	2	1973	1409
+2423	15Mo	0.7024908	2	2570	1746
+2424	6Ery	0.37272123	1	479	1445
+2425	12Baso	0.374947	2	1536	1240
+2426	2Ery	0.8678376	1	1157	2579
+2427	13Baso	0.61677027	2	1921	2189
+2428	3Ery	0.13405718	1	288	1127
+2429	4Ery	0.5838998	1	676	1917
+2430	14Mo	0.6049731	2	1860	1123
+2431	10GMP	0.40722016	2	1582	980
+2432	16Neu	0.7229327	2	2636	1052
+2433	15Mo	0.7028502	2	2572	2380
+2434	6Ery	0.088195406	1	200	589
+2435	13Baso	0.6099504	2	1878	181
+2436	19Lymph	0.48263437	0	21	214
+2437	15Mo	0.7132833	2	2612	1342
+2438	6Ery	0.16044432	1	299	2646
+2439	2Ery	0.8983329	1	1265	2376
+2440	15Mo	0.68199843	2	2448	163
+2441	3Ery	0.763347	1	867	1422
+2442	13Baso	0.3885291	2	1551	766
+2443	6Ery	0.109848134	1	256	1251
+2444	13Baso	0.62163365	2	1943	239
+2445	9GMP	0.36769238	2	1524	2225
+2446	10GMP	0.40150535	2	1573	1427
+2447	10GMP	0.49733847	2	1713	2013
+2448	14Mo	0.6195339	2	1928	2440
+2449	2Ery	0.8599925	1	1129	2276
+2450	6Ery	0.18230976	1	320	1470
+2451	10GMP	0.48743266	2	1702	2499
+2452	7MEP	0.1394679	0	37	217
+2453	6Ery	0.098027945	1	230	2070
+2454	14Mo	0.62580544	2	1968	1737
+2455	2Ery	0.8343916	1	1030	2590
+2456	2Ery	0.8930366	1	1248	1481
+2457	7MEP	0.1583388	0	34	960
+2458	5Ery	0.37846878	1	483	61
+2459	13Baso	0.5932444	2	1825	1531
+2460	13Baso	0.67264545	2	2381	749
+2461	14Mo	0.6289595	2	1989	268
+2462	3Ery	0.91584027	1	1294	2679
+2463	13Baso	0.6389582	2	2069	576
+2464	4Ery	0.5352128	1	632	2112
+2465	3Ery	0.79563874	1	925	877
+2466	2Ery	0.8893126	1	1235	2525
+2467	15Mo	0.64599633	2	2141	2031
+2468	7MEP	0.098038815	1	231	457
+2469	1Ery	0.9175697	1	1297	1336
+2470	15Mo	0.70232856	2	2569	1256
+2471	2Ery	0.8088573	1	962	656
+2472	13Baso	0.61581767	2	1914	2271
+2473	8Mk	0.16175224	2	1356	299
+2474	9GMP	0.39294595	2	1556	2057
+2475	19Lymph	0.401504	0	29	992
+2476	11DC	0.83260536	3	2729	2576
+2477	8Mk	0.15840083	2	1351	1016
+2478	17Neu	0.30917424	2	1468	1525
+2479	13Baso	0.56794083	2	1778	850
+2480	13Baso	0.5836316	2	1805	1575
+2481	13Baso	0.5553429	2	1758	1188
+2482	3Ery	0.74793005	1	849	2202
+2483	12Baso	0.08150453	1	182	2257
+2484	16Neu	0.7787617	2	2699	1278
+2485	10GMP	0.48257285	2	1698	2078
+2486	15Mo	0.66139513	2	2284	1721
+2487	7MEP	0.093530186	1	219	1301
+2488	13Baso	0.47382277	2	1683	1121
+2489	13Baso	0.6551932	2	2224	221
+2490	14Mo	0.70019925	2	2555	1831
+2491	16Neu	0.75426584	2	2680	1661
+2492	3Ery	0.618178	1	710	1966
+2493	7MEP	0.10903393	1	254	1929
+2494	13Baso	0.66365105	2	2302	811
+2495	13Baso	0.62224656	2	1947	1689
+2496	3Ery	0.83639663	1	1038	1684
+2497	1Ery	0.96489525	1	1325	1544
+2498	14Mo	0.6359203	2	2038	738
+2499	15Mo	0.68266135	2	2451	788
+2500	10GMP	0.5370043	2	1741	660
+2501	15Mo	0.69207484	2	2508	860
+2502	4Ery	0.5999748	1	687	1949
+2503	9GMP	0.28303713	2	1440	1038
+2504	14Mo	0.6587052	2	2262	1713
+2505	9GMP	0.46793306	2	1673	228
+2506	13Baso	0.4284357	2	1616	1610
+2507	10GMP	0.40072194	2	1571	1443
+2508	9GMP	0.36307558	2	1517	2501
+2509	5Ery	0.206745	1	335	1530
+2510	2Ery	0.85622334	1	1113	2660
+2511	7MEP	0.15218267	0	24	278
+2512	13Baso	0.63900906	2	2071	1477
+2513	6Ery	0.18187873	1	319	739
+2514	7MEP	0.086027704	1	197	1353
+2515	10GMP	0.40493324	2	1579	2224
+2516	7MEP	0.11370079	1	264	1879
+2517	10GMP	0.48908544	2	1705	1502
+2518	3Ery	0.603479	1	692	154
+2519	5Ery	0.6642799	1	758	1430
+2520	10GMP	0.2213473	2	1398	1682
+2521	6Ery	0.16384254	1	304	1298
+2522	19Lymph	0.42111105	0	63	343
+2523	8Mk	0.17561243	2	1368	2085
+2524	4Ery	0.6863057	1	785	2153
+2525	14Mo	0.68457437	2	2466	2058
+2526	16Neu	0.76318586	2	2687	1627
+2527	14Mo	0.6029595	2	1848	2373
+2528	10GMP	0.41606435	2	1597	2275
+2529	10GMP	0.3832248	2	1547	1898
+2530	13Baso	0.6399165	2	2083	2667
+2531	7MEP	0.06764174	1	149	1081
+2532	15Mo	0.7349211	2	2663	2044
+2533	10GMP	0.41968215	2	1603	774
+2534	15Mo	0.63357824	2	2019	468
+2535	15Mo	0.70095366	2	2560	1671
+2536	14Mo	0.57897764	2	1796	1027
+2537	5Ery	0.30924976	1	436	1344
+2538	13Baso	0.6363929	2	2044	510
+2539	9GMP	0.30604842	2	1461	2195
+2540	7MEP	0.12865993	0	85	1646
+2541	14Mo	0.65453565	2	2219	795
+2542	6Ery	0.24453323	1	373	1208
+2543	2Ery	0.875324	1	1194	1082
+2544	8Mk	0.14983484	0	131	765
+2545	7MEP	0.076306544	1	169	2355
+2546	5Ery	0.52226824	1	624	1073
+2547	7MEP	0.066203676	1	148	461
+2548	13Baso	0.64165103	2	2103	2227
+2549	7MEP	0.11259012	0	129	2175
+2550	5Ery	0.52167547	1	622	861
+2551	8Mk	0.13939515	0	128	1612
+2552	2Ery	0.78287274	1	900	1496
+2553	2Ery	0.87357134	1	1183	1540
+2554	4Ery	0.7719138	1	882	1769
+2555	14Mo	0.6372479	2	2053	2490
+2556	15Mo	0.72091544	2	2626	158
+2557	13Baso	0.6017395	2	1842	2584
+2558	3Ery	0.8647292	1	1146	1599
+2559	2Ery	0.79122263	1	916	550
+2560	5Ery	0.38041356	1	486	2535
+2561	13Baso	0.58490855	2	1812	117
+2562	3Ery	0.583769	1	675	1119
+2563	6Ery	0.07960463	1	175	1750
+2564	8Mk	0.13324028	0	89	2212
+2565	6Ery	0.09108617	1	206	480
+2566	15Mo	0.7761393	2	2698	1519
+2567	2Ery	0.70591587	1	802	2395
+2568	5Ery	0.40738502	1	510	485
+2569	6Ery	0.1705262	1	309	2470
+2570	9GMP	0.29190302	2	1451	2423
+2571	8Mk	0.16206147	2	1357	2621
+2572	15Mo	0.72827166	2	2652	2433
+2573	13Baso	0.6118404	2	1897	707
+2574	10GMP	0.3810285	2	1543	711
+2575	15Mo	0.7313654	2	2659	2144
+2576	15Mo	0.68629396	2	2476	152
+2577	2Ery	0.88597876	1	1223	2037
+2578	13Baso	0.65249115	2	2193	2067
+2579	14Mo	0.67910296	2	2426	2116
+2580	9GMP	0.18270402	2	1372	1468
+2581	2Ery	0.8709566	1	1172	894
+2582	3Ery	0.79323703	1	921	2311
+2583	17Neu	0.30743563	2	1465	2127
+2584	16Neu	0.70031714	2	2557	925
+2585	13Baso	0.61163205	2	1896	1617
+2586	6Ery	0.19725235	1	329	1613
+2587	13Baso	0.6533818	2	2206	2250
+2588	10GMP	0.40287164	2	1576	247
+2589	13Baso	0.6502484	2	2181	2345
+2590	13Baso	0.6834406	2	2455	2115
+2591	2Ery	0.688018	1	787	662
+2592	6Ery	0.12651962	0	99	1
+2593	15Mo	0.6755107	2	2402	161
+2594	14Mo	0.7261339	2	2648	2391
+2595	14Mo	0.64953417	2	2171	1913
+2596	13Baso	0.59475803	2	1828	1841
+2597	14Mo	0.6645899	2	2309	2656
+2598	6Ery	0.25804225	1	388	1512
+2599	13Baso	0.62906736	2	1990	2396
+2600	17Neu	0.24564813	2	1415	1816
+2601	2Ery	0.57878715	1	669	1237
+2602	6Ery	0.17745727	1	317	969
+2603	7MEP	0.10395351	1	244	1493
+2604	10GMP	0.41230786	2	1590	1799
+2605	10GMP	0.4576448	2	1657	1014
+2606	6Ery	0.28113517	1	408	659
+2607	15Mo	0.6573654	2	2241	586
+2608	15Mo	0.7311963	2	2658	2148
+2609	6Ery	0.08423186	1	192	1245
+2610	4Ery	0.48178568	1	584	1541
+2611	8Mk	0.1514135	0	106	1751
+2612	6Ery	0.0745854	1	164	2437
+2613	13Baso	0.5688611	2	1781	1863
+2614	13Baso	0.6075742	2	1870	205
+2615	5Ery	0.40751126	1	511	1591
+2616	10GMP	0.35635096	2	1512	2628
+2617	10GMP	0.06013551	1	141	2699
+2618	10GMP	0.4497829	2	1647	2374
+2619	2Ery	0.6560231	1	751	691
+2620	11DC	0.82389486	3	2725	815
+2621	16Neu	0.70278895	2	2571	1459
+2622	14Mo	0.6140961	2	1909	416
+2623	5Ery	0.35220554	1	468	2064
+2624	10GMP	0.4581429	2	1658	2702
+2625	6Ery	0.2331504	1	363	903
+2626	2Ery	0.8517103	1	1089	2556
+2627	10GMP	0.5886404	2	1816	990
+2628	15Mo	0.71380967	2	2616	103
+2629	16Neu	0.7658805	2	2690	129
+2630	6Ery	0.10605643	1	249	1421
+2631	19Lymph	0.49200097	0	116	2291
+2632	10GMP	0.4024464	2	1575	2701
+2633	15Mo	0.74645966	2	2672	245
+2634	13Baso	0.6655569	2	2318	914
+2635	5Ery	0.27344576	1	401	2698
+2636	7MEP	0.0952574	1	225	2432
+2637	4Ery	0.5201689	1	620	1844
+2638	7MEP	0.20242327	2	1386	1820
+2639	3Ery	0.34670848	1	462	1137
+2640	19Lymph	0.39383155	2	1558	2367
+2641	13Baso	0.64991057	2	2177	1010
+2642	13Baso	0.60973185	2	1877	1096
+2643	13Baso	0.5230509	2	1727	1375
+2644	3Ery	0.7968286	1	931	548
+2645	1Ery	0.90491605	1	1280	141
+2646	15Mo	0.680559	2	2438	2654
+2647	8Mk	0.19091079	2	1375	2041
+2648	7MEP	0.16938637	2	1358	2594
+2649	7MEP	0.09380821	1	222	235
+2650	13Baso	0.51128185	2	1720	585
+2651	13Baso	0.610333	2	1882	465
+2652	5Ery	0.46644995	1	570	2572
+2653	6Ery	0.081108525	1	180	537
+2654	15Mo	0.7258329	2	2646	2209
+2655	13Baso	0.65495956	2	2223	2414
+2656	14Mo	0.70919186	2	2597	1070
+2657	10GMP	0.024275031	1	134	38
+2658	13Baso	0.6201747	2	1934	2608
+2659	7MEP	0.16126071	0	109	2575
+2660	15Mo	0.6923601	2	2510	567
+2661	8Mk	0.12896974	0	108	348
+2662	9GMP	0.44657716	2	1643	697
+2663	4Ery	0.40954873	1	514	2532
+2664	17Neu	0.27121463	2	1432	986
+2665	2Ery	0.7420347	1	843	2692
+2666	14Mo	0.66429305	2	2307	1825
+2667	15Mo	0.6961924	2	2530	593
+2668	14Mo	0.6633796	2	2301	2071
+2669	6Ery	0.29194444	1	422	1202
+2670	6Ery	0.1773625	1	315	534
+2671	10GMP	0.44642723	2	1642	1918
+2672	6Ery	0.093622796	1	220	2633
+2673	13Baso	0.57497	2	1790	2193
+2674	6Ery	0.08036224	1	178	2343
+2675	12Baso	0.46036804	2	1661	2401
+2676	3Ery	0.7683511	1	876	1234
+2677	13Baso	0.60261667	2	1846	476
+2678	13Baso	0.6276549	2	1974	937
+2679	16Neu	0.6842092	2	2462	2686
+2680	10GMP	0.5541122	2	1756	2491
+2681	16Neu	0.7632191	2	2688	2390
+2682	13Baso	0.6525333	2	2194	451
+2683	5Ery	0.3786639	1	484	622
+2684	2Ery	0.8525614	1	1093	784
+2685	9GMP	0.2187171	2	1396	1952
+2686	16Neu	0.7529708	2	2679	458
+2687	8Mk	0.10772686	0	90	2526
+2688	11DC	0.7538068	3	2709	2681
+2689	13Baso	0.5315107	2	1737	483
+2690	10GMP	0.4498889	2	1648	2629
+2691	5Ery	0.3065879	1	432	675
+2692	15Mo	0.73867893	2	2665	2724
+2693	13Baso	0.65786403	2	2247	1770
+2694	9GMP	0.33484194	2	1495	489
+2695	14Mo	0.6684571	2	2345	517
+2696	13Baso	0.48865384	2	1703	1334
+2697	14Mo	0.6743835	2	2392	596
+2698	15Mo	0.7228256	2	2635	2566
+2699	15Mo	0.7144696	2	2617	2484
+2700	10GMP	0.396035	2	1560	1090
+2701	15Mo	0.7221009	2	2632	118
+2702	16Neu	0.7181373	2	2624	1595
+2703	6Ery	0.28456205	1	415	612
+2704	2Ery	0.8019648	1	945	1501
+2705	13Baso	0.6341026	2	2020	940
+2706	5Ery	0.15244874	1	294	855
+2707	7MEP	0.15042938	0	123	1798
+2708	19Lymph	0.4686537	0	124	417
+2709	6Ery	0.18361242	1	321	2688
+2710	13Baso	0.6592802	2	2268	1136
+2711	2Ery	0.8232841	1	1001	1672
+2712	11DC	0.83255297	3	2728	2348
+2713	7MEP	0.15196408	0	120	1871
+2714	13Baso	0.5522318	2	1752	401
+2715	2Ery	0.63822633	1	735	967
+2716	14Mo	0.67126095	2	2366	2406
+2717	13Baso	0.66159946	2	2285	501
+2718	8Mk	0.1306417	0	122	651
+2719	13Baso	0.49483874	2	1709	1687
+2720	7MEP	0.1357271	2	1339	801
+2721	10GMP	0.41721123	2	1599	291
+2722	10GMP	0.5053347	2	1717	2350
+2723	14Mo	0.6557509	2	2228	2109
+2724	16Neu	0.7669956	2	2692	1326
+2725	2Ery	0.70807374	1	806	2620
+2726	13Baso	0.6412319	2	2096	646
+2727	7MEP	0.09423482	1	224	1139
+2728	15Mo	0.64149666	2	2099	2712
+2729	3Ery	0.77763766	1	892	2476
Binary file test-data/tl.louvain.neighbors_gauss_braycurtis.recipe_weinreb17.paul15_subsample.h5ad has changed
Binary file test-data/tl.paga.neighbors_gauss_braycurtis.recipe_weinreb17.paul15_subsample.h5ad has changed
Binary file test-data/tl.pca.krumsiek11.h5ad has changed
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/test-data/tl.pca.variance_ratio.krumsiek11.tabular	Mon Mar 04 10:15:02 2019 -0500
@@ -0,0 +1,10 @@
+6.436238884925842285e-01
+2.148767709732055664e-01
+7.596869766712188721e-02
+3.905308619141578674e-02
+1.849153265357017517e-02
+5.033073481172323227e-03
+1.776377670466899872e-03
+1.001837081275880337e-03
+1.316703710472211242e-04
+2.801087975967675447e-05
Binary file test-data/tl.rank_genes_groups.krumsiek11.h5ad has changed
Binary file test-data/tl.score_genes.krumsiek11.h5ad has changed
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/test-data/tl.score_genes.krumsiek11.obs.tabular	Mon Mar 04 10:15:02 2019 -0500
@@ -0,0 +1,641 @@
+index	cell_type	score
+0	progenitor	
+1	progenitor	
+2	progenitor	
+3	progenitor	
+4	progenitor	
+5	progenitor	
+6	progenitor	
+7	progenitor	
+8	progenitor	
+9	progenitor	
+10	progenitor	
+11	progenitor	
+12	progenitor	
+13	progenitor	
+14	progenitor	
+15	progenitor	
+16	progenitor	
+17	progenitor	
+18	progenitor	
+19	progenitor	
+20	progenitor	
+21	progenitor	
+22	progenitor	
+23	progenitor	
+24	progenitor	
+25	progenitor	
+26	progenitor	
+27	progenitor	
+28	progenitor	
+29	progenitor	
+30	progenitor	
+31	progenitor	
+32	progenitor	
+33	progenitor	
+34	progenitor	
+35	progenitor	
+36	progenitor	
+37	progenitor	
+38	progenitor	
+39	progenitor	
+40	progenitor	
+41	progenitor	
+42	progenitor	
+43	progenitor	
+44	progenitor	
+45	progenitor	
+46	progenitor	
+47	progenitor	
+48	progenitor	
+49	progenitor	
+50	progenitor	
+51	progenitor	
+52	progenitor	
+53	progenitor	
+54	progenitor	
+55	progenitor	
+56	progenitor	
+57	progenitor	
+58	progenitor	
+59	progenitor	
+60	progenitor	
+61	progenitor	
+62	progenitor	
+63	progenitor	
+64	progenitor	
+65	progenitor	
+66	progenitor	
+67	progenitor	
+68	progenitor	
+69	progenitor	
+70	progenitor	
+71	progenitor	
+72	progenitor	
+73	progenitor	
+74	progenitor	
+75	progenitor	
+76	progenitor	
+77	progenitor	
+78	progenitor	
+79	progenitor	
+80	Mo	
+81	Mo	
+82	Mo	
+83	Mo	
+84	Mo	
+85	Mo	
+86	Mo	
+87	Mo	
+88	Mo	
+89	Mo	
+90	Mo	
+91	Mo	
+92	Mo	
+93	Mo	
+94	Mo	
+95	Mo	
+96	Mo	
+97	Mo	
+98	Mo	
+99	Mo	
+100	Mo	
+101	Mo	
+102	Mo	
+103	Mo	
+104	Mo	
+105	Mo	
+106	Mo	
+107	Mo	
+108	Mo	
+109	Mo	
+110	Mo	
+111	Mo	
+112	Mo	
+113	Mo	
+114	Mo	
+115	Mo	
+116	Mo	
+117	Mo	
+118	Mo	
+119	Mo	
+120	Mo	
+121	Mo	
+122	Mo	
+123	Mo	
+124	Mo	
+125	Mo	
+126	Mo	
+127	Mo	
+128	Mo	
+129	Mo	
+130	Mo	
+131	Mo	
+132	Mo	
+133	Mo	
+134	Mo	
+135	Mo	
+136	Mo	
+137	Mo	
+138	Mo	
+139	Mo	
+140	Mo	
+141	Mo	
+142	Mo	
+143	Mo	
+144	Mo	
+145	Mo	
+146	Mo	
+147	Mo	
+148	Mo	
+149	Mo	
+150	Mo	
+151	Mo	
+152	Mo	
+153	Mo	
+154	Mo	
+155	Mo	
+156	Mo	
+157	Mo	
+158	Mo	
+159	Mo	
+0	progenitor	
+1	progenitor	
+2	progenitor	
+3	progenitor	
+4	progenitor	
+5	progenitor	
+6	progenitor	
+7	progenitor	
+8	progenitor	
+9	progenitor	
+10	progenitor	
+11	progenitor	
+12	progenitor	
+13	progenitor	
+14	progenitor	
+15	progenitor	
+16	progenitor	
+17	progenitor	
+18	progenitor	
+19	progenitor	
+20	progenitor	
+21	progenitor	
+22	progenitor	
+23	progenitor	
+24	progenitor	
+25	progenitor	
+26	progenitor	
+27	progenitor	
+28	progenitor	
+29	progenitor	
+30	progenitor	
+31	progenitor	
+32	progenitor	
+33	progenitor	
+34	progenitor	
+35	progenitor	
+36	progenitor	
+37	progenitor	
+38	progenitor	
+39	progenitor	
+40	progenitor	
+41	progenitor	
+42	progenitor	
+43	progenitor	
+44	progenitor	
+45	progenitor	
+46	progenitor	
+47	progenitor	
+48	progenitor	
+49	progenitor	
+50	progenitor	
+51	progenitor	
+52	progenitor	
+53	progenitor	
+54	progenitor	
+55	progenitor	
+56	progenitor	
+57	progenitor	
+58	progenitor	
+59	progenitor	
+60	progenitor	
+61	progenitor	
+62	progenitor	
+63	progenitor	
+64	progenitor	
+65	progenitor	
+66	progenitor	
+67	progenitor	
+68	progenitor	
+69	progenitor	
+70	progenitor	
+71	progenitor	
+72	progenitor	
+73	progenitor	
+74	progenitor	
+75	progenitor	
+76	progenitor	
+77	progenitor	
+78	progenitor	
+79	progenitor	
+80	Ery	
+81	Ery	
+82	Ery	
+83	Ery	
+84	Ery	
+85	Ery	
+86	Ery	
+87	Ery	
+88	Ery	
+89	Ery	
+90	Ery	
+91	Ery	
+92	Ery	
+93	Ery	
+94	Ery	
+95	Ery	
+96	Ery	
+97	Ery	
+98	Ery	
+99	Ery	
+100	Ery	
+101	Ery	
+102	Ery	
+103	Ery	
+104	Ery	
+105	Ery	
+106	Ery	
+107	Ery	
+108	Ery	
+109	Ery	
+110	Ery	
+111	Ery	
+112	Ery	
+113	Ery	
+114	Ery	
+115	Ery	
+116	Ery	
+117	Ery	
+118	Ery	
+119	Ery	
+120	Ery	
+121	Ery	
+122	Ery	
+123	Ery	
+124	Ery	
+125	Ery	
+126	Ery	
+127	Ery	
+128	Ery	
+129	Ery	
+130	Ery	
+131	Ery	
+132	Ery	
+133	Ery	
+134	Ery	
+135	Ery	
+136	Ery	
+137	Ery	
+138	Ery	
+139	Ery	
+140	Ery	
+141	Ery	
+142	Ery	
+143	Ery	
+144	Ery	
+145	Ery	
+146	Ery	
+147	Ery	
+148	Ery	
+149	Ery	
+150	Ery	
+151	Ery	
+152	Ery	
+153	Ery	
+154	Ery	
+155	Ery	
+156	Ery	
+157	Ery	
+158	Ery	
+159	Ery	
+0	progenitor	
+1	progenitor	
+2	progenitor	
+3	progenitor	
+4	progenitor	
+5	progenitor	
+6	progenitor	
+7	progenitor	
+8	progenitor	
+9	progenitor	
+10	progenitor	
+11	progenitor	
+12	progenitor	
+13	progenitor	
+14	progenitor	
+15	progenitor	
+16	progenitor	
+17	progenitor	
+18	progenitor	
+19	progenitor	
+20	progenitor	
+21	progenitor	
+22	progenitor	
+23	progenitor	
+24	progenitor	
+25	progenitor	
+26	progenitor	
+27	progenitor	
+28	progenitor	
+29	progenitor	
+30	progenitor	
+31	progenitor	
+32	progenitor	
+33	progenitor	
+34	progenitor	
+35	progenitor	
+36	progenitor	
+37	progenitor	
+38	progenitor	
+39	progenitor	
+40	progenitor	
+41	progenitor	
+42	progenitor	
+43	progenitor	
+44	progenitor	
+45	progenitor	
+46	progenitor	
+47	progenitor	
+48	progenitor	
+49	progenitor	
+50	progenitor	
+51	progenitor	
+52	progenitor	
+53	progenitor	
+54	progenitor	
+55	progenitor	
+56	progenitor	
+57	progenitor	
+58	progenitor	
+59	progenitor	
+60	progenitor	
+61	progenitor	
+62	progenitor	
+63	progenitor	
+64	progenitor	
+65	progenitor	
+66	progenitor	
+67	progenitor	
+68	progenitor	
+69	progenitor	
+70	progenitor	
+71	progenitor	
+72	progenitor	
+73	progenitor	
+74	progenitor	
+75	progenitor	
+76	progenitor	
+77	progenitor	
+78	progenitor	
+79	progenitor	
+80	Mk	
+81	Mk	
+82	Mk	
+83	Mk	
+84	Mk	
+85	Mk	
+86	Mk	
+87	Mk	
+88	Mk	
+89	Mk	
+90	Mk	
+91	Mk	
+92	Mk	
+93	Mk	
+94	Mk	
+95	Mk	
+96	Mk	
+97	Mk	
+98	Mk	
+99	Mk	
+100	Mk	
+101	Mk	
+102	Mk	
+103	Mk	
+104	Mk	
+105	Mk	
+106	Mk	
+107	Mk	
+108	Mk	
+109	Mk	
+110	Mk	
+111	Mk	
+112	Mk	
+113	Mk	
+114	Mk	
+115	Mk	
+116	Mk	
+117	Mk	
+118	Mk	
+119	Mk	
+120	Mk	
+121	Mk	
+122	Mk	
+123	Mk	
+124	Mk	
+125	Mk	
+126	Mk	
+127	Mk	
+128	Mk	
+129	Mk	
+130	Mk	
+131	Mk	
+132	Mk	
+133	Mk	
+134	Mk	
+135	Mk	
+136	Mk	
+137	Mk	
+138	Mk	
+139	Mk	
+140	Mk	
+141	Mk	
+142	Mk	
+143	Mk	
+144	Mk	
+145	Mk	
+146	Mk	
+147	Mk	
+148	Mk	
+149	Mk	
+150	Mk	
+151	Mk	
+152	Mk	
+153	Mk	
+154	Mk	
+155	Mk	
+156	Mk	
+157	Mk	
+158	Mk	
+159	Mk	
+0	progenitor	
+1	progenitor	
+2	progenitor	
+3	progenitor	
+4	progenitor	
+5	progenitor	
+6	progenitor	
+7	progenitor	
+8	progenitor	
+9	progenitor	
+10	progenitor	
+11	progenitor	
+12	progenitor	
+13	progenitor	
+14	progenitor	
+15	progenitor	
+16	progenitor	
+17	progenitor	
+18	progenitor	
+19	progenitor	
+20	progenitor	
+21	progenitor	
+22	progenitor	
+23	progenitor	
+24	progenitor	
+25	progenitor	
+26	progenitor	
+27	progenitor	
+28	progenitor	
+29	progenitor	
+30	progenitor	
+31	progenitor	
+32	progenitor	
+33	progenitor	
+34	progenitor	
+35	progenitor	
+36	progenitor	
+37	progenitor	
+38	progenitor	
+39	progenitor	
+40	progenitor	
+41	progenitor	
+42	progenitor	
+43	progenitor	
+44	progenitor	
+45	progenitor	
+46	progenitor	
+47	progenitor	
+48	progenitor	
+49	progenitor	
+50	progenitor	
+51	progenitor	
+52	progenitor	
+53	progenitor	
+54	progenitor	
+55	progenitor	
+56	progenitor	
+57	progenitor	
+58	progenitor	
+59	progenitor	
+60	progenitor	
+61	progenitor	
+62	progenitor	
+63	progenitor	
+64	progenitor	
+65	progenitor	
+66	progenitor	
+67	progenitor	
+68	progenitor	
+69	progenitor	
+70	progenitor	
+71	progenitor	
+72	progenitor	
+73	progenitor	
+74	progenitor	
+75	progenitor	
+76	progenitor	
+77	progenitor	
+78	progenitor	
+79	progenitor	
+80	Neu	
+81	Neu	
+82	Neu	
+83	Neu	
+84	Neu	
+85	Neu	
+86	Neu	
+87	Neu	
+88	Neu	
+89	Neu	
+90	Neu	
+91	Neu	
+92	Neu	
+93	Neu	
+94	Neu	
+95	Neu	
+96	Neu	
+97	Neu	
+98	Neu	
+99	Neu	
+100	Neu	
+101	Neu	
+102	Neu	
+103	Neu	
+104	Neu	
+105	Neu	
+106	Neu	
+107	Neu	
+108	Neu	
+109	Neu	
+110	Neu	
+111	Neu	
+112	Neu	
+113	Neu	
+114	Neu	
+115	Neu	
+116	Neu	
+117	Neu	
+118	Neu	
+119	Neu	
+120	Neu	
+121	Neu	
+122	Neu	
+123	Neu	
+124	Neu	
+125	Neu	
+126	Neu	
+127	Neu	
+128	Neu	
+129	Neu	
+130	Neu	
+131	Neu	
+132	Neu	
+133	Neu	
+134	Neu	
+135	Neu	
+136	Neu	
+137	Neu	
+138	Neu	
+139	Neu	
+140	Neu	
+141	Neu	
+142	Neu	
+143	Neu	
+144	Neu	
+145	Neu	
+146	Neu	
+147	Neu	
+148	Neu	
+149	Neu	
+150	Neu	
+151	Neu	
+152	Neu	
+153	Neu	
+154	Neu	
+155	Neu	
+156	Neu	
+157	Neu	
+158	Neu	
+159	Neu	
Binary file test-data/tl.score_genes_cell_cycle.krumsiek11.h5ad has changed
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/test-data/tl.score_genes_cell_cycle.krumsiek11.obs.tabular	Mon Mar 04 10:15:02 2019 -0500
@@ -0,0 +1,641 @@
+index	cell_type	S_score	G2M_score	phase
+0	progenitor	0.2681	0.20055	S
+1	progenitor	0.24346666	0.15855001	S
+2	progenitor	0.2276	0.13482499	S
+3	progenitor	0.21043333	0.12637499	S
+4	progenitor	0.19113334	0.1272	S
+5	progenitor	0.17531666	0.13072497	S
+6	progenitor	0.16073334	0.13242501	S
+7	progenitor	0.15353334	0.13672501	S
+8	progenitor	0.14314999	0.1399	S
+9	progenitor	0.1337	0.14515	G2M
+10	progenitor	0.12695001	0.15165001	G2M
+11	progenitor	0.11726667	0.16077498	G2M
+12	progenitor	0.11081667	0.16735	G2M
+13	progenitor	0.104849994	0.17429999	G2M
+14	progenitor	0.09816667	0.18152499	G2M
+15	progenitor	0.095350005	0.186625	G2M
+16	progenitor	0.09528333	0.19447501	G2M
+17	progenitor	0.09463333	0.199675	G2M
+18	progenitor	0.0947	0.205275	G2M
+19	progenitor	0.0947	0.20802501	G2M
+20	progenitor	0.097733326	0.21100001	G2M
+21	progenitor	0.09881667	0.21964999	G2M
+22	progenitor	0.10131666	0.22662501	G2M
+23	progenitor	0.104849994	0.23022501	G2M
+24	progenitor	0.112266675	0.23387499	G2M
+25	progenitor	0.120283335	0.2393	G2M
+26	progenitor	0.12826668	0.24174997	G2M
+27	progenitor	0.13323334	0.24710001	G2M
+28	progenitor	0.13971666	0.25280002	G2M
+29	progenitor	0.14393334	0.256775	G2M
+30	progenitor	0.15066667	0.259775	G2M
+31	progenitor	0.15316668	0.26244998	G2M
+32	progenitor	0.15993333	0.26487502	G2M
+33	progenitor	0.16430001	0.266275	G2M
+34	progenitor	0.16598332	0.270625	G2M
+35	progenitor	0.17068332	0.2715	G2M
+36	progenitor	0.17713334	0.276475	G2M
+37	progenitor	0.17893334	0.27514997	G2M
+38	progenitor	0.18013333	0.278025	G2M
+39	progenitor	0.18251666	0.279675	G2M
+40	progenitor	0.18876666	0.27925	G2M
+41	progenitor	0.19041668	0.281775	G2M
+42	progenitor	0.19083333	0.2824	G2M
+43	progenitor	0.19411668	0.281725	G2M
+44	progenitor	0.19639999	0.2844	G2M
+45	progenitor	0.19843334	0.285375	G2M
+46	progenitor	0.20406666	0.284075	G2M
+47	progenitor	0.20673332	0.28625	G2M
+48	progenitor	0.20769998	0.2885	G2M
+49	progenitor	0.21186668	0.28935	G2M
+50	progenitor	0.21285	0.28867498	G2M
+51	progenitor	0.21443334	0.28855002	G2M
+52	progenitor	0.21568334	0.28705	G2M
+53	progenitor	0.21788335	0.29035	G2M
+54	progenitor	0.22551665	0.28815	G2M
+55	progenitor	0.22586668	0.28689998	G2M
+56	progenitor	0.23069999	0.2816	G2M
+57	progenitor	0.23118332	0.282375	G2M
+58	progenitor	0.23160002	0.28230003	G2M
+59	progenitor	0.23546667	0.28329998	G2M
+60	progenitor	0.23661667	0.28195	G2M
+61	progenitor	0.24134998	0.27899998	G2M
+62	progenitor	0.24546666	0.27855	G2M
+63	progenitor	0.24836665	0.27609998	G2M
+64	progenitor	0.25375	0.27562502	G2M
+65	progenitor	0.25834998	0.273525	G2M
+66	progenitor	0.26393333	0.27015	G2M
+67	progenitor	0.26746666	0.26622498	S
+68	progenitor	0.2706333	0.267025	S
+69	progenitor	0.27618334	0.2651	S
+70	progenitor	0.28033334	0.263975	S
+71	progenitor	0.2868167	0.2622	S
+72	progenitor	0.29141667	0.26174998	S
+73	progenitor	0.29198334	0.26385	S
+74	progenitor	0.29348332	0.26275003	S
+75	progenitor	0.29788333	0.263575	S
+76	progenitor	0.30125	0.26232502	S
+77	progenitor	0.29955	0.261825	S
+78	progenitor	0.30065	0.2623	S
+79	progenitor	0.30573332	0.2588	S
+80	Mo	0.30818334	0.25555003	S
+81	Mo	0.31073332	0.25422502	S
+82	Mo	0.31378332	0.25410002	S
+83	Mo	0.31268334	0.25304997	S
+84	Mo	0.31355	0.25059998	S
+85	Mo	0.3157	0.251275	S
+86	Mo	0.3139333	0.25072497	S
+87	Mo	0.3151833	0.25165	S
+88	Mo	0.3149333	0.25079998	S
+89	Mo	0.31440002	0.25172502	S
+90	Mo	0.31251666	0.254725	S
+91	Mo	0.31613332	0.25347498	S
+92	Mo	0.31813332	0.25372502	S
+93	Mo	0.31543335	0.25340003	S
+94	Mo	0.31663334	0.257025	S
+95	Mo	0.31793332	0.25435	S
+96	Mo	0.3184333	0.2527	S
+97	Mo	0.31743336	0.25052497	S
+98	Mo	0.3164667	0.24747501	S
+99	Mo	0.31841668	0.2466	S
+100	Mo	0.31648335	0.24679999	S
+101	Mo	0.31504998	0.2501	S
+102	Mo	0.31489998	0.250375	S
+103	Mo	0.31256667	0.25195	S
+104	Mo	0.31425	0.250675	S
+105	Mo	0.31441668	0.248675	S
+106	Mo	0.31828332	0.24724999	S
+107	Mo	0.32236665	0.25105	S
+108	Mo	0.32341668	0.2527	S
+109	Mo	0.32334998	0.25145	S
+110	Mo	0.32061666	0.2516	S
+111	Mo	0.3239333	0.24855	S
+112	Mo	0.3217833	0.248275	S
+113	Mo	0.3194833	0.25055	S
+114	Mo	0.32711667	0.24814999	S
+115	Mo	0.32861665	0.244375	S
+116	Mo	0.33048332	0.244225	S
+117	Mo	0.33173332	0.24415	S
+118	Mo	0.32801664	0.24665	S
+119	Mo	0.3321833	0.245675	S
+120	Mo	0.32905	0.24717501	S
+121	Mo	0.33133334	0.245975	S
+122	Mo	0.33201668	0.24515	S
+123	Mo	0.33265	0.24475	S
+124	Mo	0.32968336	0.24344999	S
+125	Mo	0.32461664	0.245175	S
+126	Mo	0.32303333	0.24647498	S
+127	Mo	0.32363334	0.24472499	S
+128	Mo	0.3234	0.24480002	S
+129	Mo	0.32494998	0.24702501	S
+130	Mo	0.32526666	0.24975002	S
+131	Mo	0.32278332	0.24785002	S
+132	Mo	0.3201	0.24885	S
+133	Mo	0.32130003	0.25125	S
+134	Mo	0.32468334	0.2521	S
+135	Mo	0.32040003	0.25545	S
+136	Mo	0.31931666	0.25560004	S
+137	Mo	0.31963333	0.25262502	S
+138	Mo	0.31644997	0.253575	S
+139	Mo	0.31913334	0.251575	S
+140	Mo	0.32393336	0.24987501	S
+141	Mo	0.32683334	0.2504	S
+142	Mo	0.32791668	0.24740002	S
+143	Mo	0.329	0.247075	S
+144	Mo	0.32784998	0.24852501	S
+145	Mo	0.32766664	0.24740002	S
+146	Mo	0.32676667	0.2485	S
+147	Mo	0.3254	0.24985	S
+148	Mo	0.32301664	0.24805	S
+149	Mo	0.32369998	0.25047502	S
+150	Mo	0.3267	0.250475	S
+151	Mo	0.3280667	0.252875	S
+152	Mo	0.32885	0.25315002	S
+153	Mo	0.32688335	0.2515	S
+154	Mo	0.32666668	0.25325	S
+155	Mo	0.3258167	0.25137502	S
+156	Mo	0.32818332	0.2465	S
+157	Mo	0.32963336	0.24692501	S
+158	Mo	0.3318167	0.24837498	S
+159	Mo	0.33176666	0.247625	S
+0	progenitor	0.26751667	0.2007	S
+1	progenitor	0.24345	0.157325	S
+2	progenitor	0.22616667	0.139575	S
+3	progenitor	0.20503333	0.13499999	S
+4	progenitor	0.18988334	0.1349	S
+5	progenitor	0.17425	0.134875	S
+6	progenitor	0.16213334	0.13455	S
+7	progenitor	0.14678332	0.14125	S
+8	progenitor	0.1336	0.146375	G2M
+9	progenitor	0.1237	0.15342501	G2M
+10	progenitor	0.11621666	0.16017501	G2M
+11	progenitor	0.10858333	0.1669	G2M
+12	progenitor	0.09945001	0.17515	G2M
+13	progenitor	0.09445	0.182875	G2M
+14	progenitor	0.091649994	0.18862501	G2M
+15	progenitor	0.08881667	0.196275	G2M
+16	progenitor	0.08878334	0.20034999	G2M
+17	progenitor	0.09183334	0.208125	G2M
+18	progenitor	0.094516665	0.21419999	G2M
+19	progenitor	0.094349995	0.223	G2M
+20	progenitor	0.09643334	0.228775	G2M
+21	progenitor	0.09933333	0.232925	G2M
+22	progenitor	0.10111666	0.2406	G2M
+23	progenitor	0.10683333	0.24365	G2M
+24	progenitor	0.11198333	0.24744998	G2M
+25	progenitor	0.1187	0.24800001	G2M
+26	progenitor	0.12223333	0.253475	G2M
+27	progenitor	0.12516668	0.25777498	G2M
+28	progenitor	0.13296667	0.261875	G2M
+29	progenitor	0.13638332	0.2664	G2M
+30	progenitor	0.14060001	0.27075002	G2M
+31	progenitor	0.14363334	0.27295002	G2M
+32	progenitor	0.14310001	0.277825	G2M
+33	progenitor	0.14686668	0.2806	G2M
+34	progenitor	0.14746666	0.28705	G2M
+35	progenitor	0.1488	0.291375	G2M
+36	progenitor	0.14686665	0.295125	G2M
+37	progenitor	0.14803334	0.29590002	G2M
+38	progenitor	0.14774999	0.30242503	G2M
+39	progenitor	0.14461668	0.30615002	G2M
+40	progenitor	0.14245	0.3091	G2M
+41	progenitor	0.14150001	0.313175	G2M
+42	progenitor	0.13565	0.316325	G2M
+43	progenitor	0.12808332	0.3198	G2M
+44	progenitor	0.12049997	0.3262	G2M
+45	progenitor	0.11080001	0.33355	G2M
+46	progenitor	0.09916668	0.33852503	G2M
+47	progenitor	0.08836666	0.34457502	G2M
+48	progenitor	0.0756	0.35015002	G2M
+49	progenitor	0.061966658	0.354175	G2M
+50	progenitor	0.04515001	0.361325	G2M
+51	progenitor	0.026250005	0.365675	G2M
+52	progenitor	0.008533329	0.371575	G2M
+53	progenitor	-0.0058666766	0.36895004	G2M
+54	progenitor	-0.01971668	0.36967498	G2M
+55	progenitor	-0.035949945	0.36804998	G2M
+56	progenitor	-0.04824999	0.36305	G2M
+57	progenitor	-0.06161666	0.35704997	G2M
+58	progenitor	-0.07620004	0.34805	G2M
+59	progenitor	-0.09081668	0.341575	G2M
+60	progenitor	-0.103000015	0.32840002	G2M
+61	progenitor	-0.11609998	0.317375	G2M
+62	progenitor	-0.12736666	0.30952498	G2M
+63	progenitor	-0.13890001	0.30077502	G2M
+64	progenitor	-0.15153334	0.28985	G2M
+65	progenitor	-0.16445002	0.28004998	G2M
+66	progenitor	-0.17231664	0.26997498	G2M
+67	progenitor	-0.18360004	0.2623	G2M
+68	progenitor	-0.19526666	0.250675	G2M
+69	progenitor	-0.20973334	0.24382502	G2M
+70	progenitor	-0.22153333	0.23462497	G2M
+71	progenitor	-0.23176664	0.22642499	G2M
+72	progenitor	-0.23878333	0.21525	G2M
+73	progenitor	-0.24899998	0.20759997	G2M
+74	progenitor	-0.25769997	0.196425	G2M
+75	progenitor	-0.266	0.190525	G2M
+76	progenitor	-0.27291664	0.185325	G2M
+77	progenitor	-0.27909997	0.17939998	G2M
+78	progenitor	-0.28546664	0.16992497	G2M
+79	progenitor	-0.2924833	0.16142498	G2M
+80	Ery	-0.30063334	0.158275	G2M
+81	Ery	-0.3081833	0.14844999	G2M
+82	Ery	-0.31410003	0.13829997	G2M
+83	Ery	-0.32265	0.12857503	G2M
+84	Ery	-0.33280006	0.12172499	G2M
+85	Ery	-0.34323335	0.11087498	G2M
+86	Ery	-0.3550667	0.09400001	G2M
+87	Ery	-0.36045003	0.074499995	G2M
+88	Ery	-0.36565	0.056499988	G2M
+89	Ery	-0.37118334	0.03820002	G2M
+90	Ery	-0.3749	0.026174992	G2M
+91	Ery	-0.37931666	0.019950002	G2M
+92	Ery	-0.38785002	0.012800008	G2M
+93	Ery	-0.3930334	0.0039000213	G2M
+94	Ery	-0.39623332	-0.0038750172	G1
+95	Ery	-0.40098336	-0.008474976	G1
+96	Ery	-0.41044998	-0.008125007	G1
+97	Ery	-0.41723332	-0.0113250315	G1
+98	Ery	-0.42673334	-0.008574992	G1
+99	Ery	-0.43113336	-0.009875029	G1
+100	Ery	-0.4387667	-0.009699941	G1
+101	Ery	-0.44501665	-0.006850004	G1
+102	Ery	-0.44808337	-0.0041999817	G1
+103	Ery	-0.45334998	-0.0044499934	G1
+104	Ery	-0.4579167	-0.0024499893	G1
+105	Ery	-0.4625	0.0014250278	G2M
+106	Ery	-0.46655002	0.003275007	G2M
+107	Ery	-0.4705	0.0074749887	G2M
+108	Ery	-0.47354996	0.011525005	G2M
+109	Ery	-0.47571668	0.012849987	G2M
+110	Ery	-0.47741672	0.014274985	G2M
+111	Ery	-0.47899997	0.015850008	G2M
+112	Ery	-0.48184994	0.017825007	G2M
+113	Ery	-0.48310003	0.021875024	G2M
+114	Ery	-0.48716664	0.023850024	G2M
+115	Ery	-0.48626667	0.024949968	G2M
+116	Ery	-0.4891	0.03274998	G2M
+117	Ery	-0.4909666	0.035274982	G2M
+118	Ery	-0.4974334	0.037799954	G2M
+119	Ery	-0.5008334	0.040574998	G2M
+120	Ery	-0.50525	0.044800013	G2M
+121	Ery	-0.50745004	0.045899987	G2M
+122	Ery	-0.51255	0.048699975	G2M
+123	Ery	-0.5148666	0.051825017	G2M
+124	Ery	-0.51621664	0.054074973	G2M
+125	Ery	-0.52003336	0.058725	G2M
+126	Ery	-0.5201167	0.06525004	G2M
+127	Ery	-0.5232334	0.06755	G2M
+128	Ery	-0.5255166	0.06912503	G2M
+129	Ery	-0.52691674	0.071750015	G2M
+130	Ery	-0.5294833	0.07469997	G2M
+131	Ery	-0.5308	0.07885	G2M
+132	Ery	-0.53328335	0.08200002	G2M
+133	Ery	-0.53339994	0.082275	G2M
+134	Ery	-0.5356667	0.08287498	G2M
+135	Ery	-0.53651667	0.083850026	G2M
+136	Ery	-0.53586674	0.08415002	G2M
+137	Ery	-0.5371834	0.08655003	G2M
+138	Ery	-0.53768337	0.08915001	G2M
+139	Ery	-0.5387167	0.086775005	G2M
+140	Ery	-0.5398166	0.08837497	G2M
+141	Ery	-0.5402333	0.09094998	G2M
+142	Ery	-0.5395833	0.09077501	G2M
+143	Ery	-0.5413166	0.094074994	G2M
+144	Ery	-0.5375334	0.094500035	G2M
+145	Ery	-0.5376667	0.09659997	G2M
+146	Ery	-0.5442666	0.09917498	G2M
+147	Ery	-0.5433	0.10099995	G2M
+148	Ery	-0.54293334	0.09899998	G2M
+149	Ery	-0.5396333	0.09729999	G2M
+150	Ery	-0.53550005	0.09580001	G2M
+151	Ery	-0.5340333	0.094500005	G2M
+152	Ery	-0.53835	0.094024986	G2M
+153	Ery	-0.5339166	0.09344998	G2M
+154	Ery	-0.5354667	0.095400006	G2M
+155	Ery	-0.5398333	0.09622499	G2M
+156	Ery	-0.54073334	0.09739998	G2M
+157	Ery	-0.54269993	0.09609997	G2M
+158	Ery	-0.54613334	0.09427503	G2M
+159	Ery	-0.5469167	0.09325001	G2M
+0	progenitor	0.26924998	0.20047499	S
+1	progenitor	0.24753334	0.15694998	S
+2	progenitor	0.2261	0.129575	S
+3	progenitor	0.20549999	0.12205	S
+4	progenitor	0.18906666	0.118075006	S
+5	progenitor	0.17461666	0.1156	S
+6	progenitor	0.1549	0.112900004	S
+7	progenitor	0.14206666	0.11277501	S
+8	progenitor	0.12825	0.11547499	S
+9	progenitor	0.11403333	0.116174996	G2M
+10	progenitor	0.10465	0.11955001	G2M
+11	progenitor	0.09291667	0.123825	G2M
+12	progenitor	0.08646667	0.12455	G2M
+13	progenitor	0.07824999	0.13115	G2M
+14	progenitor	0.07111666	0.13497499	G2M
+15	progenitor	0.06305	0.138225	G2M
+16	progenitor	0.059816666	0.14175001	G2M
+17	progenitor	0.055983335	0.1487	G2M
+18	progenitor	0.05093333	0.15525001	G2M
+19	progenitor	0.048833337	0.161075	G2M
+20	progenitor	0.047583334	0.16835001	G2M
+21	progenitor	0.040233333	0.1783	G2M
+22	progenitor	0.038650002	0.18339998	G2M
+23	progenitor	0.034033336	0.19080001	G2M
+24	progenitor	0.0334	0.19689998	G2M
+25	progenitor	0.036050003	0.19765002	G2M
+26	progenitor	0.037483335	0.20150003	G2M
+27	progenitor	0.0379	0.205475	G2M
+28	progenitor	0.03891667	0.21019998	G2M
+29	progenitor	0.041166663	0.21605001	G2M
+30	progenitor	0.041533336	0.22262499	G2M
+31	progenitor	0.0463	0.226375	G2M
+32	progenitor	0.048683327	0.22929999	G2M
+33	progenitor	0.057249997	0.233375	G2M
+34	progenitor	0.06268333	0.236	G2M
+35	progenitor	0.06565	0.23992498	G2M
+36	progenitor	0.06738335	0.24414998	G2M
+37	progenitor	0.07278331	0.24974999	G2M
+38	progenitor	0.07835	0.25365	G2M
+39	progenitor	0.08574999	0.25655	G2M
+40	progenitor	0.089816675	0.25997502	G2M
+41	progenitor	0.094816685	0.268325	G2M
+42	progenitor	0.10088334	0.27127498	G2M
+43	progenitor	0.10618336	0.27574998	G2M
+44	progenitor	0.11181665	0.27997503	G2M
+45	progenitor	0.12016666	0.28125003	G2M
+46	progenitor	0.120766655	0.2857	G2M
+47	progenitor	0.12061668	0.289625	G2M
+48	progenitor	0.12701666	0.292675	G2M
+49	progenitor	0.13323334	0.294025	G2M
+50	progenitor	0.13686669	0.29399997	G2M
+51	progenitor	0.14141665	0.296375	G2M
+52	progenitor	0.14054999	0.29835	G2M
+53	progenitor	0.13769999	0.30177498	G2M
+54	progenitor	0.13920003	0.306425	G2M
+55	progenitor	0.13541666	0.30935	G2M
+56	progenitor	0.13395001	0.31435	G2M
+57	progenitor	0.12931666	0.319175	G2M
+58	progenitor	0.12291667	0.32285002	G2M
+59	progenitor	0.11760001	0.32947502	G2M
+60	progenitor	0.1109	0.33325002	G2M
+61	progenitor	0.098733336	0.33807498	G2M
+62	progenitor	0.08863334	0.345725	G2M
+63	progenitor	0.074066654	0.347775	G2M
+64	progenitor	0.062050015	0.3543	G2M
+65	progenitor	0.050833344	0.359575	G2M
+66	progenitor	0.038566664	0.36534998	G2M
+67	progenitor	0.022033334	0.37015	G2M
+68	progenitor	0.009916633	0.37007502	G2M
+69	progenitor	-0.002099961	0.37010002	G2M
+70	progenitor	-0.013416678	0.36807504	G2M
+71	progenitor	-0.026216656	0.36464998	G2M
+72	progenitor	-0.04154995	0.357625	G2M
+73	progenitor	-0.054400027	0.35250002	G2M
+74	progenitor	-0.06606665	0.3451	G2M
+75	progenitor	-0.07311666	0.33777502	G2M
+76	progenitor	-0.077833325	0.32635	G2M
+77	progenitor	-0.08776665	0.3159	G2M
+78	progenitor	-0.09445	0.30395	G2M
+79	progenitor	-0.102666676	0.2935	G2M
+80	Mk	-0.10896668	0.282375	G2M
+81	Mk	-0.12169999	0.27165002	G2M
+82	Mk	-0.12861666	0.26255003	G2M
+83	Mk	-0.13356665	0.2516	G2M
+84	Mk	-0.1381667	0.2421	G2M
+85	Mk	-0.14588335	0.23299998	G2M
+86	Mk	-0.14643335	0.220175	G2M
+87	Mk	-0.15011665	0.216025	G2M
+88	Mk	-0.15608332	0.20797502	G2M
+89	Mk	-0.1635333	0.20320001	G2M
+90	Mk	-0.1667167	0.19779998	G2M
+91	Mk	-0.16811666	0.18747498	G2M
+92	Mk	-0.16958332	0.17795	G2M
+93	Mk	-0.17056668	0.16855001	G2M
+94	Mk	-0.17408332	0.16107498	G2M
+95	Mk	-0.17345	0.1532	G2M
+96	Mk	-0.17251664	0.147325	G2M
+97	Mk	-0.17686662	0.141125	G2M
+98	Mk	-0.17819998	0.1339	G2M
+99	Mk	-0.18205002	0.12702498	G2M
+100	Mk	-0.18008336	0.12057501	G2M
+101	Mk	-0.17778334	0.10987502	G2M
+102	Mk	-0.17706665	0.10052502	G2M
+103	Mk	-0.17208335	0.09229997	G2M
+104	Mk	-0.17455	0.09097502	G2M
+105	Mk	-0.17273334	0.087374985	G2M
+106	Mk	-0.17373335	0.08560002	G2M
+107	Mk	-0.17395002	0.07944998	G2M
+108	Mk	-0.17468333	0.07655001	G2M
+109	Mk	-0.1739833	0.07757497	G2M
+110	Mk	-0.17766666	0.08107501	G2M
+111	Mk	-0.17615	0.07807499	G2M
+112	Mk	-0.17605004	0.077325016	G2M
+113	Mk	-0.17686665	0.07712501	G2M
+114	Mk	-0.17955002	0.07734999	G2M
+115	Mk	-0.17851666	0.07519999	G2M
+116	Mk	-0.17718336	0.076775014	G2M
+117	Mk	-0.17596671	0.07339999	G2M
+118	Mk	-0.1750167	0.07412499	G2M
+119	Mk	-0.17744997	0.076675	G2M
+120	Mk	-0.1789	0.074625015	G2M
+121	Mk	-0.17714998	0.071624994	G2M
+122	Mk	-0.1736333	0.068425	G2M
+123	Mk	-0.17461663	0.06832498	G2M
+124	Mk	-0.17366666	0.069875	G2M
+125	Mk	-0.17350003	0.07087502	G2M
+126	Mk	-0.17423335	0.073125005	G2M
+127	Mk	-0.17289999	0.07657498	G2M
+128	Mk	-0.17336664	0.07489997	G2M
+129	Mk	-0.16989997	0.07117501	G2M
+130	Mk	-0.16938332	0.06972501	G2M
+131	Mk	-0.17073336	0.07189995	G2M
+132	Mk	-0.16995004	0.07332501	G2M
+133	Mk	-0.16946661	0.07052502	G2M
+134	Mk	-0.16478333	0.070250005	G2M
+135	Mk	-0.16570002	0.072375	G2M
+136	Mk	-0.16755003	0.073075026	G2M
+137	Mk	-0.16876668	0.076124996	G2M
+138	Mk	-0.16663334	0.07460004	G2M
+139	Mk	-0.1660833	0.07682499	G2M
+140	Mk	-0.16843331	0.0783	G2M
+141	Mk	-0.17143327	0.07712501	G2M
+142	Mk	-0.17213336	0.07727498	G2M
+143	Mk	-0.16951668	0.07885	G2M
+144	Mk	-0.16820005	0.078149974	G2M
+145	Mk	-0.16826665	0.07882503	G2M
+146	Mk	-0.17055002	0.08182496	G2M
+147	Mk	-0.17345	0.082975	G2M
+148	Mk	-0.17216668	0.086125016	G2M
+149	Mk	-0.17273334	0.09057501	G2M
+150	Mk	-0.17401668	0.092824996	G2M
+151	Mk	-0.17518333	0.091575	G2M
+152	Mk	-0.17483333	0.09237501	G2M
+153	Mk	-0.17593333	0.092875004	G2M
+154	Mk	-0.1739333	0.094374955	G2M
+155	Mk	-0.1740667	0.09417495	G2M
+156	Mk	-0.17770004	0.09324998	G2M
+157	Mk	-0.17335	0.09350002	G2M
+158	Mk	-0.1704	0.09047499	G2M
+159	Mk	-0.17143336	0.089825004	G2M
+0	progenitor	0.2660833	0.20005001	S
+1	progenitor	0.24146667	0.1564	S
+2	progenitor	0.22096668	0.12695	S
+3	progenitor	0.19886668	0.112325005	S
+4	progenitor	0.18153334	0.102675	S
+5	progenitor	0.16055	0.10249999	S
+6	progenitor	0.14478332	0.098000005	S
+7	progenitor	0.13021666	0.092875004	S
+8	progenitor	0.11686668	0.091899976	S
+9	progenitor	0.10476667	0.091975	S
+10	progenitor	0.09625	0.094950005	S
+11	progenitor	0.09105	0.09615001	G2M
+12	progenitor	0.0822	0.102025	G2M
+13	progenitor	0.074	0.10612498	G2M
+14	progenitor	0.062583335	0.10890001	G2M
+15	progenitor	0.052600004	0.11175001	G2M
+16	progenitor	0.045050006	0.112574995	G2M
+17	progenitor	0.038033333	0.11227499	G2M
+18	progenitor	0.03231667	0.11082502	G2M
+19	progenitor	0.028383333	0.11277501	G2M
+20	progenitor	0.021966662	0.11262502	G2M
+21	progenitor	0.02043334	0.110575005	G2M
+22	progenitor	0.017400004	0.110875025	G2M
+23	progenitor	0.017300002	0.111875	G2M
+24	progenitor	0.015683334	0.112075	G2M
+25	progenitor	0.014233332	0.11295	G2M
+26	progenitor	0.012683332	0.11170004	G2M
+27	progenitor	0.011016667	0.112225026	G2M
+28	progenitor	0.010216668	0.116024986	G2M
+29	progenitor	0.0077833347	0.11819999	G2M
+30	progenitor	0.004733335	0.119224995	G2M
+31	progenitor	0.002683334	0.12180002	G2M
+32	progenitor	0.006133329	0.11839999	G2M
+33	progenitor	0.0052000023	0.116349995	G2M
+34	progenitor	0.006116666	0.115775004	G2M
+35	progenitor	0.0019833297	0.115449995	G2M
+36	progenitor	0.0007166676	0.114999995	G2M
+37	progenitor	0.00016666204	0.113325	G2M
+38	progenitor	-0.0018666722	0.116224974	G2M
+39	progenitor	-0.0030833334	0.11517501	G2M
+40	progenitor	-0.0030166656	0.11082499	G2M
+41	progenitor	-0.0019833334	0.10034999	G2M
+42	progenitor	0.0010500029	0.094025	G2M
+43	progenitor	-0.0039666668	0.086150005	G2M
+44	progenitor	-0.0024000034	0.077549994	G2M
+45	progenitor	-0.0036166683	0.07370001	G2M
+46	progenitor	-0.00485	0.0651	G2M
+47	progenitor	-0.002550004	0.05520001	G2M
+48	progenitor	0.0003666673	0.041975006	G2M
+49	progenitor	-0.0010499991	0.030874997	G2M
+50	progenitor	0.0007333346	0.014625013	G2M
+51	progenitor	9.999983e-05	-0.0017999709	S
+52	progenitor	0.0018333336	-0.01987499	S
+53	progenitor	0.00090000033	-0.032900006	S
+54	progenitor	0.0029999996	-0.05064997	S
+55	progenitor	0.003983334	-0.068574995	S
+56	progenitor	-0.0008500004	-0.08140004	G1
+57	progenitor	-0.0029833335	-0.09470001	G1
+58	progenitor	-0.0021333336	-0.106824994	G1
+59	progenitor	-0.0015000002	-0.11555001	G1
+60	progenitor	-0.0022999998	-0.12255001	G1
+61	progenitor	-0.0017666668	-0.13125	G1
+62	progenitor	0.0033999998	-0.14297503	S
+63	progenitor	0.006316666	-0.15117502	S
+64	progenitor	0.005033333	-0.15187496	S
+65	progenitor	0.0031333338	-0.15367502	S
+66	progenitor	0.0035666667	-0.15197498	S
+67	progenitor	0.005016666	-0.14580002	S
+68	progenitor	0.0061	-0.142575	S
+69	progenitor	0.00515	-0.13665	S
+70	progenitor	0.0028499998	-0.12865001	S
+71	progenitor	0.0030833331	-0.12112501	S
+72	progenitor	0.0032833333	-0.11669999	S
+73	progenitor	0.0006166666	-0.11475003	S
+74	progenitor	-0.0006833335	-0.11412498	G1
+75	progenitor	-2.3283064e-10	-0.11702502	G1
+76	progenitor	0.0007333332	-0.121425	S
+77	progenitor	0.0005833333	-0.12972501	S
+78	progenitor	-0.0015333334	-0.13869998	G1
+79	progenitor	-0.0023	-0.14877501	G1
+80	Neu	-0.0046166666	-0.157125	G1
+81	Neu	-0.0035666665	-0.16639996	G1
+82	Neu	-0.0011666667	-0.17409998	G1
+83	Neu	-0.0026166667	-0.180325	G1
+84	Neu	-0.0001833333	-0.18502498	G1
+85	Neu	0.0035666665	-0.18762502	S
+86	Neu	0.0024333335	-0.19062501	S
+87	Neu	0.0023	-0.19277498	S
+88	Neu	0.0014833333	-0.19762498	S
+89	Neu	0.0024333335	-0.201725	S
+90	Neu	0.003866667	-0.20430002	S
+91	Neu	0.0067999996	-0.20865002	S
+92	Neu	0.0079333335	-0.21332502	S
+93	Neu	0.0068	-0.21907501	S
+94	Neu	0.0058	-0.22292498	S
+95	Neu	0.0069666663	-0.22795	S
+96	Neu	0.0023833334	-0.22915001	S
+97	Neu	0.0056166667	-0.230375	S
+98	Neu	0.0051666666	-0.23027502	S
+99	Neu	0.001966667	-0.23169999	S
+100	Neu	0.0033666668	-0.23169999	S
+101	Neu	0.0047333334	-0.233675	S
+102	Neu	0.0045666667	-0.23272496	S
+103	Neu	0.00060000026	-0.23024999	S
+104	Neu	0.0036833333	-0.22662503	S
+105	Neu	0.0025166667	-0.22107498	S
+106	Neu	0.0038833334	-0.22109997	S
+107	Neu	0.0033666666	-0.21907501	S
+108	Neu	0.0042666667	-0.218675	S
+109	Neu	0.0038	-0.2165	S
+110	Neu	0.004633333	-0.21385	S
+111	Neu	0.003266667	-0.21305001	S
+112	Neu	0.0034166668	-0.21077499	S
+113	Neu	0.0017166669	-0.21184999	S
+114	Neu	0.0012666667	-0.21437502	S
+115	Neu	-0.0016333334	-0.2153	G1
+116	Neu	-0.00043333336	-0.215675	G1
+117	Neu	0.0018833333	-0.21865001	S
+118	Neu	0.0014666667	-0.22187501	S
+119	Neu	-0.0020833332	-0.21787499	G1
+120	Neu	-0.0039000001	-0.21329997	G1
+121	Neu	-0.0023	-0.20820004	G1
+122	Neu	-0.00195	-0.21035	G1
+123	Neu	-0.0058833333	-0.20732501	G1
+124	Neu	-0.0070166667	-0.20714998	G1
+125	Neu	-0.008633333	-0.20389998	G1
+126	Neu	-0.006616667	-0.20832503	G1
+127	Neu	-0.003116667	-0.21047503	G1
+128	Neu	-0.0055833333	-0.21289998	G1
+129	Neu	-0.0042333333	-0.216575	G1
+130	Neu	-0.005016667	-0.21945003	G1
+131	Neu	-0.0020833334	-0.21799998	G1
+132	Neu	-0.0032	-0.21150002	G1
+133	Neu	-0.0033333339	-0.20989999	G1
+134	Neu	-0.0011666667	-0.21257499	G1
+135	Neu	-0.0023	-0.21222499	G1
+136	Neu	-0.0034666667	-0.2146	G1
+137	Neu	-0.0011833335	-0.21350002	G1
+138	Neu	-0.00325	-0.21377501	G1
+139	Neu	-0.0040166667	-0.213925	G1
+140	Neu	-0.0024666665	-0.21455	G1
+141	Neu	0.0028333336	-0.21975	S
+142	Neu	0.0032833333	-0.220325	S
+143	Neu	0.004766667	-0.22119999	S
+144	Neu	0.00705	-0.22362499	S
+145	Neu	0.0036	-0.22555003	S
+146	Neu	0.006733333	-0.22377498	S
+147	Neu	0.0025000002	-0.22509998	S
+148	Neu	0.0018	-0.221075	S
+149	Neu	6.666663e-05	-0.22125	S
+150	Neu	-0.0014499999	-0.219875	G1
+151	Neu	-0.0012833332	-0.21900001	G1
+152	Neu	-0.0001999999	-0.21767499	G1
+153	Neu	-0.0032666668	-0.21407498	G1
+154	Neu	-0.0017	-0.2116	G1
+155	Neu	-0.0028166666	-0.2077	G1
+156	Neu	-0.00245	-0.2053	G1
+157	Neu	-0.0011166666	-0.203825	G1
+158	Neu	-0.001966667	-0.20535001	G1
+159	Neu	-0.0027	-0.20725003	G1
Binary file test-data/tl.tsne.krumsiek11.h5ad has changed
--- /dev/null	Thu Jan 01 00:00:00 1970 +0000
+++ b/test-data/tl.tsne.krumsiek11_X_tsne.tabular	Mon Mar 04 10:15:02 2019 -0500
@@ -0,0 +1,640 @@
+1.519449996948242188e+01	-1.959712028503417969e+01
+1.430198860168457031e+01	-1.977149772644042969e+01
+1.366461181640625000e+01	-1.944742584228515625e+01
+1.320474624633789062e+01	-1.861057281494140625e+01
+1.247396755218505859e+01	-1.828991889953613281e+01
+1.173612689971923828e+01	-1.787339973449707031e+01
+1.088126182556152344e+01	-1.741477966308593750e+01
+1.004744911193847656e+01	-1.688929176330566406e+01
+9.242062568664550781e+00	-1.633218383789062500e+01
+8.551974296569824219e+00	-1.572820758819580078e+01
+7.994421005249023438e+00	-1.496002674102783203e+01
+7.534011363983154297e+00	-1.414666461944580078e+01
+7.137795925140380859e+00	-1.332961750030517578e+01
+6.881215572357177734e+00	-1.266186618804931641e+01
+6.554283618927001953e+00	-1.194301605224609375e+01
+6.316970825195312500e+00	-1.134942722320556641e+01
+6.111618518829345703e+00	-1.060422611236572266e+01
+5.999991416931152344e+00	-9.829056739807128906e+00
+5.852959632873535156e+00	-8.975935935974121094e+00
+5.754123687744140625e+00	-8.093419075012207031e+00
+5.681646823883056641e+00	-7.331385612487792969e+00
+5.690028667449951172e+00	-6.516033649444580078e+00
+5.646613597869873047e+00	-5.590456008911132812e+00
+5.599578380584716797e+00	-4.722455978393554688e+00
+5.614356040954589844e+00	-3.809689283370971680e+00
+5.634355068206787109e+00	-2.910351276397705078e+00
+5.672942161560058594e+00	-1.983908414840698242e+00
+5.692958831787109375e+00	-1.081819057464599609e+00
+5.783164501190185547e+00	-2.481995671987533569e-01
+5.843826293945312500e+00	7.042319178581237793e-01
+5.949952125549316406e+00	1.492690682411193848e+00
+6.069711208343505859e+00	2.275426864624023438e+00
+6.275776386260986328e+00	3.030730962753295898e+00
+6.595882892608642578e+00	3.702220201492309570e+00
+7.062664508819580078e+00	4.283195495605468750e+00
+7.793676853179931641e+00	4.937045097351074219e+00
+8.450625419616699219e+00	5.439468860626220703e+00
+8.976801872253417969e+00	5.800347328186035156e+00
+9.408540725708007812e+00	6.086088657379150391e+00
+9.624043464660644531e+00	6.300896167755126953e+00
+9.998101234436035156e+00	6.388058185577392578e+00
+1.015411567687988281e+01	6.684517383575439453e+00
+1.054878711700439453e+01	6.530696868896484375e+00
+1.051755142211914062e+01	7.047624111175537109e+00
+1.096314525604248047e+01	6.734574794769287109e+00
+1.081092071533203125e+01	7.304609775543212891e+00
+1.132081222534179688e+01	6.912662506103515625e+00
+1.108376121520996094e+01	7.558815956115722656e+00
+1.164056396484375000e+01	7.036955833435058594e+00
+1.156700229644775391e+01	7.518383026123046875e+00
+1.154088020324707031e+01	7.928282260894775391e+00
+1.207668018341064453e+01	7.159606933593750000e+00
+1.173250007629394531e+01	8.000703811645507812e+00
+1.227454090118408203e+01	7.442850112915039062e+00
+1.242261028289794922e+01	7.537978172302246094e+00
+1.215592193603515625e+01	8.201261520385742188e+00
+1.233993148803710938e+01	8.318535804748535156e+00
+1.286047077178955078e+01	7.827185630798339844e+00
+1.295083713531494141e+01	8.165453910827636719e+00
+1.292353916168212891e+01	8.663576126098632812e+00
+1.346461200714111328e+01	8.328847885131835938e+00
+1.345806503295898438e+01	8.873760223388671875e+00
+1.391223335266113281e+01	8.757353782653808594e+00
+1.401749229431152344e+01	9.183512687683105469e+00
+1.442186355590820312e+01	9.189196586608886719e+00
+1.467169475555419922e+01	9.464248657226562500e+00
+1.498757743835449219e+01	9.662472724914550781e+00
+1.532551097869873047e+01	9.858908653259277344e+00
+1.565018653869628906e+01	1.008980083465576172e+01
+1.600958251953125000e+01	1.033419132232666016e+01
+1.638028717041015625e+01	1.058873081207275391e+01
+1.671751213073730469e+01	1.081599426269531250e+01
+1.702677536010742188e+01	1.102662467956542969e+01
+1.735839462280273438e+01	1.126764965057373047e+01
+1.768183517456054688e+01	1.148044204711914062e+01
+1.798530006408691406e+01	1.169673252105712891e+01
+1.830868339538574219e+01	1.191948986053466797e+01
+1.863975524902343750e+01	1.215364551544189453e+01
+1.890919685363769531e+01	1.233603668212890625e+01
+1.918737411499023438e+01	1.253067302703857422e+01
+1.943779945373535156e+01	1.270529937744140625e+01
+1.969866561889648438e+01	1.289004135131835938e+01
+1.991425132751464844e+01	1.304120349884033203e+01
+2.017987442016601562e+01	1.323388767242431641e+01
+2.040896415710449219e+01	1.338729381561279297e+01
+2.062232589721679688e+01	1.354360771179199219e+01
+2.096486663818359375e+01	1.378573703765869141e+01
+2.128372192382812500e+01	1.400026988983154297e+01
+2.152831077575683594e+01	1.418010902404785156e+01
+2.176774978637695312e+01	1.434060382843017578e+01
+2.202329635620117188e+01	1.453587150573730469e+01
+2.214831542968750000e+01	1.463249778747558594e+01
+2.241675758361816406e+01	1.479472541809082031e+01
+2.259708786010742188e+01	1.497193908691406250e+01
+2.293710899353027344e+01	1.523318481445312500e+01
+2.342670822143554688e+01	1.557933998107910156e+01
+2.347536087036132812e+01	1.558963871002197266e+01
+2.382227897644042969e+01	1.570930099487304688e+01
+2.417185783386230469e+01	1.566785049438476562e+01
+2.428434562683105469e+01	1.576723003387451172e+01
+2.455209732055664062e+01	1.595398712158203125e+01
+2.468761444091796875e+01	1.613147163391113281e+01
+2.464599418640136719e+01	1.625864791870117188e+01
+2.402994346618652344e+01	1.637825584411621094e+01
+2.420136642456054688e+01	1.649662017822265625e+01
+2.439298439025878906e+01	1.662086677551269531e+01
+2.483859443664550781e+01	1.674679374694824219e+01
+2.513903617858886719e+01	1.695731735229492188e+01
+2.563834190368652344e+01	1.734886550903320312e+01
+2.601669692993164062e+01	1.763721847534179688e+01
+2.631583976745605469e+01	1.795486831665039062e+01
+2.676579093933105469e+01	1.829559707641601562e+01
+2.692498588562011719e+01	1.850955772399902344e+01
+2.670789718627929688e+01	1.826943016052246094e+01
+2.776752853393554688e+01	1.864731407165527344e+01
+2.804006767272949219e+01	1.874873161315917969e+01
+2.837374496459960938e+01	1.887251091003417969e+01
+2.858731651306152344e+01	1.895317840576171875e+01
+2.893033218383789062e+01	1.899625968933105469e+01
+2.920270919799804688e+01	1.923521423339843750e+01
+2.908079528808593750e+01	1.930040359497070312e+01
+2.881806373596191406e+01	1.963607215881347656e+01
+2.837572479248046875e+01	2.008276557922363281e+01
+2.850660133361816406e+01	2.065936660766601562e+01
+2.822839164733886719e+01	2.081925773620605469e+01
+2.783299255371093750e+01	2.125234985351562500e+01
+2.771877670288085938e+01	2.163210105895996094e+01
+2.806879997253417969e+01	2.183656883239746094e+01
+2.754817008972167969e+01	2.219980812072753906e+01
+2.757462692260742188e+01	2.242136192321777344e+01
+2.786672401428222656e+01	2.259445381164550781e+01
+2.798934173583984375e+01	2.249581527709960938e+01
+2.813786697387695312e+01	2.310935211181640625e+01
+2.884139823913574219e+01	2.335542297363281250e+01
+3.007760047912597656e+01	2.289342689514160156e+01
+2.936184692382812500e+01	2.306303405761718750e+01
+2.976509857177734375e+01	2.280924415588378906e+01
+2.976928329467773438e+01	2.275210762023925781e+01
+2.923083686828613281e+01	2.273618698120117188e+01
+2.863209533691406250e+01	2.241547584533691406e+01
+2.856137847900390625e+01	2.191716003417968750e+01
+2.917070007324218750e+01	2.142210006713867188e+01
+2.893469047546386719e+01	2.134685516357421875e+01
+2.945779800415039062e+01	2.131125259399414062e+01
+2.994835090637207031e+01	2.148306846618652344e+01
+3.043681907653808594e+01	2.190646553039550781e+01
+3.089968490600585938e+01	2.222963714599609375e+01
+3.117464256286621094e+01	2.260366630554199219e+01
+3.123556518554687500e+01	2.245041084289550781e+01
+3.142994499206542969e+01	2.221017456054687500e+01
+3.156655693054199219e+01	2.189936447143554688e+01
+3.195521354675292969e+01	2.169896697998046875e+01
+3.202001571655273438e+01	2.117776870727539062e+01
+3.200063705444335938e+01	2.095647048950195312e+01
+3.165214729309082031e+01	2.095225524902343750e+01
+3.138283157348632812e+01	2.084561538696289062e+01
+3.116673278808593750e+01	2.074891853332519531e+01
+3.095396804809570312e+01	2.047431373596191406e+01
+3.068896293640136719e+01	2.040144157409667969e+01
+3.090114593505859375e+01	1.997779273986816406e+01
+1.498956680297851562e+01	-2.000693702697753906e+01
+1.461296749114990234e+01	-1.916615676879882812e+01
+1.395829200744628906e+01	-1.885794258117675781e+01
+1.329383563995361328e+01	-1.854416275024414062e+01
+1.254649257659912109e+01	-1.820742607116699219e+01
+1.175938796997070312e+01	-1.784438133239746094e+01
+1.094490242004394531e+01	-1.743411064147949219e+01
+1.011238574981689453e+01	-1.695932769775390625e+01
+9.188405990600585938e+00	-1.635845947265625000e+01
+8.455326080322265625e+00	-1.573983764648437500e+01
+7.938644886016845703e+00	-1.500514602661132812e+01
+7.502311706542968750e+00	-1.408854484558105469e+01
+7.127816677093505859e+00	-1.331874847412109375e+01
+6.739945888519287109e+00	-1.247959613800048828e+01
+6.462102413177490234e+00	-1.178158283233642578e+01
+6.234076023101806641e+00	-1.107353591918945312e+01
+6.062172889709472656e+00	-1.043037414550781250e+01
+5.907937526702880859e+00	-9.624246597290039062e+00
+5.843192100524902344e+00	-8.768447875976562500e+00
+5.764114379882812500e+00	-7.843537330627441406e+00
+5.793562412261962891e+00	-7.041807174682617188e+00
+5.741854190826416016e+00	-6.241024971008300781e+00
+5.748571872711181641e+00	-5.266113758087158203e+00
+5.754120826721191406e+00	-4.291143417358398438e+00
+5.737640380859375000e+00	-3.475124120712280273e+00
+5.686614513397216797e+00	-2.612289905548095703e+00
+5.620985507965087891e+00	-1.785307526588439941e+00
+5.576149940490722656e+00	-1.079447031021118164e+00
+5.524374961853027344e+00	-2.045297622680664062e-01
+5.518512248992919922e+00	4.384059011936187744e-01
+5.484440803527832031e+00	1.248336315155029297e+00
+5.411953926086425781e+00	1.961502552032470703e+00
+5.305812358856201172e+00	2.785603046417236328e+00
+5.155598640441894531e+00	3.396890401840209961e+00
+4.911914348602294922e+00	3.877811670303344727e+00
+4.676707267761230469e+00	4.307043075561523438e+00
+4.371220588684082031e+00	4.657607555389404297e+00
+4.108384132385253906e+00	4.937944412231445312e+00
+3.744378805160522461e+00	5.277939319610595703e+00
+3.368552923202514648e+00	5.519053459167480469e+00
+2.979829311370849609e+00	5.733540534973144531e+00
+2.493579864501953125e+00	5.991160392761230469e+00
+2.047721147537231445e+00	6.254181385040283203e+00
+1.587406039237976074e+00	6.525527000427246094e+00
+1.052006840705871582e+00	6.863051414489746094e+00
+4.923111200332641602e-01	7.164324283599853516e+00
+-1.428566724061965942e-01	7.524271965026855469e+00
+-7.602795362472534180e-01	7.903379440307617188e+00
+-1.321702122688293457e+00	8.266837120056152344e+00
+-1.915228128433227539e+00	8.651373863220214844e+00
+-2.516287326812744141e+00	9.036515235900878906e+00
+-3.153395652770996094e+00	9.402061462402343750e+00
+-3.753569126129150391e+00	9.754068374633789062e+00
+-4.317489147186279297e+00	1.007455444335937500e+01
+-4.874936580657958984e+00	1.037624359130859375e+01
+-5.397341251373291016e+00	1.069829559326171875e+01
+-5.903509140014648438e+00	1.099493503570556641e+01
+-6.412646293640136719e+00	1.130889701843261719e+01
+-6.886572837829589844e+00	1.162083911895751953e+01
+-7.410312652587890625e+00	1.192810630798339844e+01
+-7.879826545715332031e+00	1.225764465332031250e+01
+-8.360558509826660156e+00	1.253490257263183594e+01
+-8.820272445678710938e+00	1.278684902191162109e+01
+-9.285845756530761719e+00	1.307506275177001953e+01
+-9.776107788085937500e+00	1.333807945251464844e+01
+-1.026987743377685547e+01	1.358285045623779297e+01
+-1.074603652954101562e+01	1.380372810363769531e+01
+-1.122331047058105469e+01	1.396387672424316406e+01
+-1.172157478332519531e+01	1.408565425872802734e+01
+-1.220548629760742188e+01	1.414283370971679688e+01
+-1.265199756622314453e+01	1.412061977386474609e+01
+-1.309470748901367188e+01	1.408809566497802734e+01
+-1.348059082031250000e+01	1.399751567840576172e+01
+-1.383464431762695312e+01	1.398513317108154297e+01
+-1.414979362487792969e+01	1.378194141387939453e+01
+-1.446493911743164062e+01	1.387856483459472656e+01
+-1.463082313537597656e+01	1.359884262084960938e+01
+-1.494718647003173828e+01	1.381147861480712891e+01
+-1.503487682342529297e+01	1.335581588745117188e+01
+-1.534351348876953125e+01	1.339269256591796875e+01
+-1.560981750488281250e+01	1.354783248901367188e+01
+-1.569540309906005859e+01	1.310216331481933594e+01
+-1.605055046081542969e+01	1.326550674438476562e+01
+-1.626288795471191406e+01	1.304940032958984375e+01
+-1.648871040344238281e+01	1.294476413726806641e+01
+-1.683050727844238281e+01	1.279960632324218750e+01
+-1.730596160888671875e+01	1.262320995330810547e+01
+-1.783937644958496094e+01	1.238847064971923828e+01
+-1.842344284057617188e+01	1.213757991790771484e+01
+-1.893957710266113281e+01	1.191846656799316406e+01
+-1.923557281494140625e+01	1.176790428161621094e+01
+-1.952064132690429688e+01	1.164642047882080078e+01
+-1.986314201354980469e+01	1.158161735534667969e+01
+-2.007551002502441406e+01	1.127789306640625000e+01
+-2.043986129760742188e+01	1.150233840942382812e+01
+-2.044832229614257812e+01	1.101467418670654297e+01
+-2.090215682983398438e+01	1.133619880676269531e+01
+-2.091041946411132812e+01	1.079715442657470703e+01
+-2.135299491882324219e+01	1.114088058471679688e+01
+-2.130964660644531250e+01	1.056653690338134766e+01
+-2.181983757019042969e+01	1.101214694976806641e+01
+-2.186160850524902344e+01	1.059363365173339844e+01
+-2.188577461242675781e+01	1.024540424346923828e+01
+-2.237776947021484375e+01	1.076501178741455078e+01
+-2.237619400024414062e+01	1.013141822814941406e+01
+-2.279039764404296875e+01	1.054817008972167969e+01
+-2.274655151367187500e+01	9.961177825927734375e+00
+-2.325898742675781250e+01	1.039122581481933594e+01
+-2.316371726989746094e+01	9.749513626098632812e+00
+-2.323829460144042969e+01	9.685460090637207031e+00
+-2.370261192321777344e+01	1.019186687469482422e+01
+-2.379556083679199219e+01	1.012642955780029297e+01
+-2.371839523315429688e+01	9.434461593627929688e+00
+-2.396697616577148438e+01	9.503683090209960938e+00
+-2.435767936706542969e+01	9.781260490417480469e+00
+-2.442046356201171875e+01	9.257395744323730469e+00
+-2.482602691650390625e+01	9.489546775817871094e+00
+-2.488292503356933594e+01	9.021290779113769531e+00
+-2.524648666381835938e+01	9.177652359008789062e+00
+-2.544638061523437500e+01	8.853031158447265625e+00
+-2.580229187011718750e+01	8.917053222656250000e+00
+-2.588181495666503906e+01	8.581427574157714844e+00
+-2.618779373168945312e+01	8.583885192871093750e+00
+-2.651391410827636719e+01	8.407377243041992188e+00
+-2.692565536499023438e+01	8.180121421813964844e+00
+-2.723373985290527344e+01	8.082084655761718750e+00
+-2.755004501342773438e+01	7.898454189300537109e+00
+-2.794644355773925781e+01	7.654985904693603516e+00
+-2.815190124511718750e+01	7.698884487152099609e+00
+-2.845031547546386719e+01	7.352103233337402344e+00
+-2.890771484375000000e+01	7.411153793334960938e+00
+-2.900829887390136719e+01	6.876704216003417969e+00
+-2.941636276245117188e+01	7.047492980957031250e+00
+-2.934052085876464844e+01	6.572987556457519531e+00
+-2.960076141357421875e+01	6.745438098907470703e+00
+-2.988158226013183594e+01	7.363039016723632812e+00
+-2.993129730224609375e+01	7.358628749847412109e+00
+-3.008759689331054688e+01	6.989631652832031250e+00
+-3.031802749633789062e+01	6.627227783203125000e+00
+-3.022566986083984375e+01	6.296202182769775391e+00
+-3.021055984497070312e+01	5.842995643615722656e+00
+-3.040733528137207031e+01	5.609436511993408203e+00
+-3.046053314208984375e+01	5.395218372344970703e+00
+-3.085074615478515625e+01	5.340609550476074219e+00
+-3.121930885314941406e+01	5.371227741241455078e+00
+-3.189941978454589844e+01	5.794063568115234375e+00
+-3.172226333618164062e+01	5.458642482757568359e+00
+-3.212743377685546875e+01	6.212404727935791016e+00
+-3.186577987670898438e+01	6.195385932922363281e+00
+-3.139741706848144531e+01	5.710520744323730469e+00
+-3.095080947875976562e+01	5.985283374786376953e+00
+-3.125561714172363281e+01	6.178828716278076172e+00
+-3.108602905273437500e+01	6.450035095214843750e+00
+-3.096449089050292969e+01	6.490964412689208984e+00
+-3.132374572753906250e+01	6.782985210418701172e+00
+-3.176959037780761719e+01	6.753077507019042969e+00
+-3.181257820129394531e+01	7.040874481201171875e+00
+-3.140870857238769531e+01	7.280425548553466797e+00
+-3.097803306579589844e+01	7.438276290893554688e+00
+-3.093710708618164062e+01	7.769052982330322266e+00
+1.500478839874267578e+01	-2.000301551818847656e+01
+1.432255458831787109e+01	-1.978222846984863281e+01
+1.387027454376220703e+01	-1.889958763122558594e+01
+1.297251129150390625e+01	-1.908622169494628906e+01
+1.223621273040771484e+01	-1.871154975891113281e+01
+1.146624660491943359e+01	-1.834025573730468750e+01
+1.064380455017089844e+01	-1.796647644042968750e+01
+9.816320419311523438e+00	-1.761868286132812500e+01
+9.033103942871093750e+00	-1.727870941162109375e+01
+8.182817459106445312e+00	-1.702559661865234375e+01
+7.356253147125244141e+00	-1.682770919799804688e+01
+6.575311660766601562e+00	-1.668647384643554688e+01
+5.919045925140380859e+00	-1.656130981445312500e+01
+5.276240825653076172e+00	-1.642891883850097656e+01
+4.796197414398193359e+00	-1.623974037170410156e+01
+4.359724521636962891e+00	-1.594994926452636719e+01
+4.108604907989501953e+00	-1.557783985137939453e+01
+3.986813545227050781e+00	-1.519550609588623047e+01
+3.914374351501464844e+00	-1.469902896881103516e+01
+3.887741565704345703e+00	-1.433164405822753906e+01
+3.935781955718994141e+00	-1.396360874176025391e+01
+3.930557727813720703e+00	-1.351707458496093750e+01
+3.949935197830200195e+00	-1.319506549835205078e+01
+3.971924066543579102e+00	-1.279794597625732422e+01
+4.020776748657226562e+00	-1.240507507324218750e+01
+4.059137821197509766e+00	-1.212783336639404297e+01
+4.106081962585449219e+00	-1.174833488464355469e+01
+4.168742656707763672e+00	-1.143153476715087891e+01
+4.236765384674072266e+00	-1.101284217834472656e+01
+4.360839843750000000e+00	-1.057085132598876953e+01
+4.406698226928710938e+00	-1.008703041076660156e+01
+4.529386997222900391e+00	-9.453354835510253906e+00
+4.599452018737792969e+00	-8.738915443420410156e+00
+4.692072391510009766e+00	-8.035175323486328125e+00
+4.744140148162841797e+00	-7.291034221649169922e+00
+4.785398960113525391e+00	-6.566891193389892578e+00
+4.830268859863281250e+00	-5.932011604309082031e+00
+4.861711502075195312e+00	-5.176522254943847656e+00
+4.869889736175537109e+00	-4.419118881225585938e+00
+4.874684810638427734e+00	-3.677832365036010742e+00
+4.837759971618652344e+00	-2.985409021377563477e+00
+4.793349266052246094e+00	-2.222023963928222656e+00
+4.742292404174804688e+00	-1.341412067413330078e+00
+4.729558944702148438e+00	-4.474111795425415039e-01
+4.684596061706542969e+00	3.560279011726379395e-01
+4.634653568267822266e+00	1.079953074455261230e+00
+4.524694442749023438e+00	1.841942429542541504e+00
+4.379073143005371094e+00	2.478236913681030273e+00
+4.227398872375488281e+00	3.206149339675903320e+00
+4.016226291656494141e+00	3.733858346939086914e+00
+3.822162628173828125e+00	4.069042205810546875e+00
+3.581884384155273438e+00	4.397959709167480469e+00
+3.286976814270019531e+00	4.571344375610351562e+00
+3.091281175613403320e+00	4.763269424438476562e+00
+2.827449083328247070e+00	5.077735424041748047e+00
+2.499896049499511719e+00	5.304326057434082031e+00
+2.121214151382446289e+00	5.577417850494384766e+00
+1.720514535903930664e+00	5.894199848175048828e+00
+1.304005980491638184e+00	6.208359718322753906e+00
+8.685010075569152832e-01	6.557740211486816406e+00
+3.669449388980865479e-01	6.963505268096923828e+00
+-1.721915304660797119e-01	7.403415679931640625e+00
+-7.663390040397644043e-01	7.855837345123291016e+00
+-1.388889670372009277e+00	8.298553466796875000e+00
+-1.943781375885009766e+00	8.684960365295410156e+00
+-2.479212045669555664e+00	9.073223114013671875e+00
+-2.997384786605834961e+00	9.457818984985351562e+00
+-3.525500535964965820e+00	9.891167640686035156e+00
+-4.056096553802490234e+00	1.028625679016113281e+01
+-4.583847522735595703e+00	1.064746761322021484e+01
+-5.054540634155273438e+00	1.098964977264404297e+01
+-5.544031143188476562e+00	1.131860351562500000e+01
+-6.003753662109375000e+00	1.163733768463134766e+01
+-6.497929096221923828e+00	1.196173191070556641e+01
+-6.966747283935546875e+00	1.228101062774658203e+01
+-7.394323825836181641e+00	1.258726501464843750e+01
+-7.858018875122070312e+00	1.292651271820068359e+01
+-8.300802230834960938e+00	1.324019241333007812e+01
+-8.711668014526367188e+00	1.353731727600097656e+01
+-9.180095672607421875e+00	1.387454319000244141e+01
+-9.614488601684570312e+00	1.424319458007812500e+01
+-1.007412052154541016e+01	1.461664772033691406e+01
+-1.044652748107910156e+01	1.497562885284423828e+01
+-1.078557872772216797e+01	1.534432983398437500e+01
+-1.107970809936523438e+01	1.575110054016113281e+01
+-1.132011890411376953e+01	1.616895294189453125e+01
+-1.147408103942871094e+01	1.660325241088867188e+01
+-1.159761142730712891e+01	1.697063636779785156e+01
+-1.167907810211181641e+01	1.736269378662109375e+01
+-1.177475929260253906e+01	1.774766159057617188e+01
+-1.179359817504882812e+01	1.805616378784179688e+01
+-1.193311882019042969e+01	1.834666824340820312e+01
+-1.178981304168701172e+01	1.866196632385253906e+01
+-1.207547473907470703e+01	1.895456695556640625e+01
+-1.175395679473876953e+01	1.923110008239746094e+01
+-1.218051338195800781e+01	1.946474266052246094e+01
+-1.176941680908203125e+01	1.974290084838867188e+01
+-1.222651767730712891e+01	1.996805381774902344e+01
+-1.180904483795166016e+01	2.024877357482910156e+01
+-1.229897785186767578e+01	2.045320892333984375e+01
+-1.182109355926513672e+01	2.071548652648925781e+01
+-1.231146240234375000e+01	2.095605850219726562e+01
+-1.186601448059082031e+01	2.124744606018066406e+01
+-1.236336803436279297e+01	2.141614151000976562e+01
+-1.193141746520996094e+01	2.175752258300781250e+01
+-1.241631412506103516e+01	2.192844200134277344e+01
+-1.199300479888916016e+01	2.221041488647460938e+01
+-1.238021183013916016e+01	2.247828483581542969e+01
+-1.199292182922363281e+01	2.281546783447265625e+01
+-1.238444709777832031e+01	2.305181312561035156e+01
+-1.247124958038330078e+01	2.334230041503906250e+01
+-1.207973670959472656e+01	2.357795333862304688e+01
+-1.212642478942871094e+01	2.384264564514160156e+01
+-1.255272674560546875e+01	2.402886009216308594e+01
+-1.238298988342285156e+01	2.436409950256347656e+01
+-1.216121292114257812e+01	2.466678619384765625e+01
+-1.257125568389892578e+01	2.486196517944335938e+01
+-1.226768016815185547e+01	2.520759773254394531e+01
+-1.261207389831542969e+01	2.544205474853515625e+01
+-1.231635761260986328e+01	2.577915954589843750e+01
+-1.261852264404296875e+01	2.603954124450683594e+01
+-1.230546760559082031e+01	2.624601364135742188e+01
+-1.268360519409179688e+01	2.650520896911621094e+01
+-1.236873340606689453e+01	2.685009765625000000e+01
+-1.274808597564697266e+01	2.707357406616210938e+01
+-1.243924808502197266e+01	2.735658836364746094e+01
+-1.271586036682128906e+01	2.772787857055664062e+01
+-1.266768741607666016e+01	2.803464508056640625e+01
+-1.252505111694335938e+01	2.831885910034179688e+01
+-1.295148658752441406e+01	2.858435821533203125e+01
+-1.250114059448242188e+01	2.896177864074707031e+01
+-1.304860973358154297e+01	2.905310821533203125e+01
+-1.254526042938232422e+01	2.929536056518554688e+01
+-1.314877891540527344e+01	2.947608184814453125e+01
+-1.253485965728759766e+01	2.975452804565429688e+01
+-1.325769996643066406e+01	2.978500366210937500e+01
+-1.257121181488037109e+01	3.004287338256835938e+01
+-1.297705268859863281e+01	3.020166206359863281e+01
+-1.338008689880371094e+01	3.025804710388183594e+01
+-1.255828762054443359e+01	3.060608482360839844e+01
+-1.304891777038574219e+01	3.078635406494140625e+01
+-1.353245735168457031e+01	3.077283287048339844e+01
+-1.257018470764160156e+01	3.112714576721191406e+01
+-1.259445953369140625e+01	3.134266281127929688e+01
+-1.321218585968017578e+01	3.134980201721191406e+01
+-1.384150886535644531e+01	3.121469879150390625e+01
+-1.332170581817626953e+01	3.156810760498046875e+01
+-1.396394634246826172e+01	3.149240112304687500e+01
+-1.256836509704589844e+01	3.184507942199707031e+01
+-1.249545764923095703e+01	3.204616928100585938e+01
+-1.393046283721923828e+01	3.186539077758789062e+01
+-1.319760322570800781e+01	3.202274703979492188e+01
+-1.327605819702148438e+01	3.215747451782226562e+01
+-1.263215637207031250e+01	3.238197708129882812e+01
+-1.284642887115478516e+01	3.266262817382812500e+01
+-1.349841785430908203e+01	3.268850326538085938e+01
+-1.318416500091552734e+01	3.275908660888671875e+01
+-1.373381233215332031e+01	3.253596496582031250e+01
+-1.397634792327880859e+01	3.241618347167968750e+01
+-1.416055107116699219e+01	3.210470962524414062e+01
+1.519157028198242188e+01	-1.958878326416015625e+01
+1.457129764556884766e+01	-1.917020225524902344e+01
+1.359157276153564453e+01	-1.946026229858398438e+01
+1.287304592132568359e+01	-1.914947700500488281e+01
+1.210420131683349609e+01	-1.882128334045410156e+01
+1.129815769195556641e+01	-1.847361564636230469e+01
+1.042076206207275391e+01	-1.815397453308105469e+01
+9.530649185180664062e+00	-1.791489601135253906e+01
+8.640604972839355469e+00	-1.768378639221191406e+01
+7.709612369537353516e+00	-1.753995704650878906e+01
+6.856063842773437500e+00	-1.746722412109375000e+01
+6.048251152038574219e+00	-1.744015121459960938e+01
+5.320816040039062500e+00	-1.742907905578613281e+01
+4.705689907073974609e+00	-1.746013069152832031e+01
+4.049237728118896484e+00	-1.768472671508789062e+01
+3.473331689834594727e+00	-1.805345535278320312e+01
+2.909212350845336914e+00	-1.853056144714355469e+01
+2.478405475616455078e+00	-1.893709182739257812e+01
+2.212615489959716797e+00	-1.920447540283203125e+01
+1.847805619239807129e+00	-1.940276718139648438e+01
+1.938012123107910156e+00	-1.978323745727539062e+01
+1.344429969787597656e+00	-1.963901138305664062e+01
+1.186423897743225098e+00	-1.968894767761230469e+01
+1.731386184692382812e+00	-2.038927841186523438e+01
+1.698425769805908203e+00	-2.044876670837402344e+01
+1.323356032371520996e+00	-2.029269790649414062e+01
+7.940269112586975098e-01	-1.998773384094238281e+01
+6.675070524215698242e-01	-2.011802291870117188e+01
+9.162614941596984863e-01	-2.054009628295898438e+01
+1.317226886749267578e+00	-2.094679641723632812e+01
+1.379263043403625488e+00	-2.110140037536621094e+01
+3.021827340126037598e-01	-2.041438674926757812e+01
+6.052624583244323730e-01	-2.088957214355468750e+01
+9.993489980697631836e-01	-2.135301780700683594e+01
+1.169998496770858765e-01	-2.080017852783203125e+01
+4.316897988319396973e-01	-2.120102882385253906e+01
+7.697367072105407715e-01	-2.163237953186035156e+01
+-8.408156037330627441e-02	-2.126119422912597656e+01
+4.105027914047241211e-01	-2.186485862731933594e+01
+-2.143531590700149536e-01	-2.161681938171386719e+01
+2.036221921443939209e-01	-2.211894798278808594e+01
+-3.578900992870330811e-01	-2.209511947631835938e+01
+-2.937529981136322021e-01	-2.254646301269531250e+01
+-6.835632920265197754e-01	-2.282362937927246094e+01
+-8.549175858497619629e-01	-2.312219429016113281e+01
+-1.089745283126831055e+00	-2.342636299133300781e+01
+-1.334982752799987793e+00	-2.375599670410156250e+01
+-1.603065133094787598e+00	-2.410448074340820312e+01
+-1.868363380432128906e+00	-2.447567558288574219e+01
+-2.131114006042480469e+00	-2.481787872314453125e+01
+-2.427117586135864258e+00	-2.520965003967285156e+01
+-2.740909099578857422e+00	-2.562973213195800781e+01
+-3.094910383224487305e+00	-2.609432029724121094e+01
+-3.435918569564819336e+00	-2.652889823913574219e+01
+-3.807741641998291016e+00	-2.701901054382324219e+01
+-4.176965236663818359e+00	-2.750226974487304688e+01
+-4.454822540283203125e+00	-2.787204551696777344e+01
+-4.718333721160888672e+00	-2.821150016784667969e+01
+-4.954905986785888672e+00	-2.851899719238281250e+01
+-5.175796508789062500e+00	-2.880293083190917969e+01
+-5.383171558380126953e+00	-2.907129096984863281e+01
+-5.606428146362304688e+00	-2.935140991210937500e+01
+-5.810335159301757812e+00	-2.963175201416015625e+01
+-5.961075782775878906e+00	-2.984211921691894531e+01
+-6.120621204376220703e+00	-2.997475814819335938e+01
+-6.267724037170410156e+00	-3.018155479431152344e+01
+-6.368298530578613281e+00	-3.034743118286132812e+01
+-6.617300033569335938e+00	-3.059912872314453125e+01
+-6.769649982452392578e+00	-3.084154129028320312e+01
+-7.040493965148925781e+00	-3.096394538879394531e+01
+-7.070486545562744141e+00	-3.133316230773925781e+01
+-7.472252845764160156e+00	-3.129552268981933594e+01
+-7.198812007904052734e+00	-3.181031608581542969e+01
+-7.375448703765869141e+00	-3.184250068664550781e+01
+-7.808299064636230469e+00	-3.158501434326171875e+01
+-7.517695903778076172e+00	-3.200878143310546875e+01
+-7.892563343048095703e+00	-3.178424453735351562e+01
+-7.906096935272216797e+00	-3.212149047851562500e+01
+-8.138989448547363281e+00	-3.230306243896484375e+01
+-8.466623306274414062e+00	-3.264995193481445312e+01
+-8.862235069274902344e+00	-3.305974960327148438e+01
+-9.331901550292968750e+00	-3.352828979492187500e+01
+-9.656491279602050781e+00	-3.384295654296875000e+01
+-9.914769172668457031e+00	-3.408930206298828125e+01
+-1.019091510772705078e+01	-3.430453491210937500e+01
+-1.040180301666259766e+01	-3.444690704345703125e+01
+-1.051032924652099609e+01	-3.453202819824218750e+01
+-1.091506290435791016e+01	-3.476406860351562500e+01
+-1.149002265930175781e+01	-3.500469589233398438e+01
+-1.197370433807373047e+01	-3.517875289916992188e+01
+-1.232476329803466797e+01	-3.519157791137695312e+01
+-1.294825935363769531e+01	-3.516530990600585938e+01
+-1.365509510040283203e+01	-3.510067749023437500e+01
+-1.494047737121582031e+01	-3.510100555419921875e+01
+-1.603278160095214844e+01	-3.530395126342773438e+01
+-1.675340843200683594e+01	-3.538857650756835938e+01
+-1.685874938964843750e+01	-3.548091506958007812e+01
+-1.720363044738769531e+01	-3.578920364379882812e+01
+-1.728767013549804688e+01	-3.575481796264648438e+01
+-1.765481567382812500e+01	-3.578696060180664062e+01
+-1.770997047424316406e+01	-3.586181640625000000e+01
+-1.802918624877929688e+01	-3.607511138916015625e+01
+-1.811597633361816406e+01	-3.632243728637695312e+01
+-1.818618965148925781e+01	-3.667174530029296875e+01
+-1.818774414062500000e+01	-3.734482192993164062e+01
+-1.822867012023925781e+01	-3.886906051635742188e+01
+-1.810912132263183594e+01	-3.913828659057617188e+01
+-1.797933578491210938e+01	-3.962589645385742188e+01
+-1.796797180175781250e+01	-3.975232315063476562e+01
+-1.775218009948730469e+01	-4.022003555297851562e+01
+-1.732578849792480469e+01	-4.068730926513671875e+01
+-1.690691375732421875e+01	-4.064323806762695312e+01
+-1.648787307739257812e+01	-4.081156158447265625e+01
+-1.638434219360351562e+01	-4.061108398437500000e+01
+-1.680851173400878906e+01	-4.017563629150390625e+01
+-1.704722785949707031e+01	-3.969401168823242188e+01
+-1.717719459533691406e+01	-3.948302078247070312e+01
+-1.720919418334960938e+01	-3.910422134399414062e+01
+-1.715806961059570312e+01	-3.882429885864257812e+01
+-1.673982048034667969e+01	-3.908253097534179688e+01
+-1.371504497528076172e+01	-3.877840805053710938e+01
+-1.305936717987060547e+01	-3.902551651000976562e+01
+-1.310692214965820312e+01	-3.922296524047851562e+01
+-1.254828739166259766e+01	-3.958239746093750000e+01
+-1.200624752044677734e+01	-3.997818374633789062e+01
+-1.164904689788818359e+01	-3.977762603759765625e+01
+-1.198938465118408203e+01	-4.017607116699218750e+01
+-1.291513729095458984e+01	-4.103605651855468750e+01
+-1.404931831359863281e+01	-4.105354309082031250e+01
+-1.425574493408203125e+01	-4.136027145385742188e+01
+-1.431068229675292969e+01	-4.164620971679687500e+01
+-1.393457221984863281e+01	-4.161294937133789062e+01
+-1.195437526702880859e+01	-4.098776245117187500e+01
+-1.204803180694580078e+01	-4.089416503906250000e+01
+-1.241441440582275391e+01	-4.070640182495117188e+01
+-1.255411720275878906e+01	-4.045176315307617188e+01
+-1.321313571929931641e+01	-3.998711013793945312e+01
+-1.294196605682373047e+01	-4.011898803710937500e+01
+-1.318817043304443359e+01	-4.022884750366210938e+01
+-1.352913379669189453e+01	-4.006181716918945312e+01
+-1.343410015106201172e+01	-3.986800384521484375e+01
+-1.463830280303955078e+01	-3.964513778686523438e+01
+-1.519129276275634766e+01	-3.914448165893554688e+01
+-1.532430076599121094e+01	-3.890964889526367188e+01
+-1.599927234649658203e+01	-3.833520889282226562e+01
+-1.656130027770996094e+01	-3.767085647583007812e+01
+-1.636859703063964844e+01	-3.757136535644531250e+01
+-1.660573577880859375e+01	-3.731252288818359375e+01
+-1.584738540649414062e+01	-3.749007797241210938e+01
+-1.584149074554443359e+01	-3.753525161743164062e+01
+-1.577875041961669922e+01	-3.789312744140625000e+01
+-1.547798728942871094e+01	-3.753144836425781250e+01
+-1.501726150512695312e+01	-3.742636871337890625e+01
+-1.278185081481933594e+01	-3.781040191650390625e+01
+-1.196537017822265625e+01	-3.777410125732421875e+01
+-1.159818267822265625e+01	-3.774356079101562500e+01
+-1.136351585388183594e+01	-3.779747009277343750e+01
+-1.120591926574707031e+01	-3.794934082031250000e+01
+-1.131576633453369141e+01	-3.840375137329101562e+01
+-1.147500324249267578e+01	-3.856223678588867188e+01
Binary file test-data/tl.umap.neighbors_umap_euclidean.recipe_weinreb17.paul15_subsample.h5ad has changed