All Projects → northstaratlas → northstar

northstaratlas / northstar

Licence: MIT license
Single cell type annotation guided by cell atlases, with freedom to be queer

Programming Languages

python
139335 projects - #7 most used programming language
shell
77523 projects

Projects that are alternatives of or similar to northstar

dropClust
Version 2.1.0 released
Stars: ✭ 19 (-17.39%)
Mutual labels:  clustering, singlecell
Harmony
Harmony framework for connecting scRNA-seq data from discrete time points
Stars: ✭ 36 (+56.52%)
Mutual labels:  scrna-seq, scrna-seq-analysis
ascend
R package - Analysis of Single Cell Expression, Normalisation and Differential expression (ascend)
Stars: ✭ 22 (-4.35%)
Mutual labels:  singlecell, scrna-seq-analysis
single-cell-papers-with-code
Papers with code for single cell related papers
Stars: ✭ 20 (-13.04%)
Mutual labels:  scrna-seq, scrna-seq-analysis
SHARP
SHARP: Single-cell RNA-seq Hyper-fast and Accurate processing via ensemble Random Projection
Stars: ✭ 14 (-39.13%)
Mutual labels:  clustering, scrna-seq
SPLiT-Seq demultiplexing
An unofficial demultiplexing strategy for SPLiT-seq RNA-Seq data
Stars: ✭ 20 (-13.04%)
Mutual labels:  scrna-seq, scrna-seq-analysis
souporcell
Clustering scRNAseq by genotypes
Stars: ✭ 88 (+282.61%)
Mutual labels:  scrna-seq, scrna-seq-analysis
scarf
Toolkit for highly memory efficient analysis of single-cell RNA-Seq, scATAC-Seq and CITE-Seq data. Analyze atlas scale datasets with millions of cells on laptop.
Stars: ✭ 54 (+134.78%)
Mutual labels:  clustering, scrna-seq
scAlign
A deep learning-based tool for alignment and integration of single cell genomic data across multiple datasets, species, conditions, batches
Stars: ✭ 32 (+39.13%)
Mutual labels:  scrna-seq, scrna-seq-analysis
text clustering
文本聚类(Kmeans、DBSCAN、LDA、Single-pass)
Stars: ✭ 230 (+900%)
Mutual labels:  clustering
NNM
The PyTorch official implementation of the CVPR2021 Poster Paper NNM: Nearest Neighbor Matching for Deep Clustering.
Stars: ✭ 46 (+100%)
Mutual labels:  clustering
DBSCAN
c++ implementation of clustering by DBSCAN
Stars: ✭ 89 (+286.96%)
Mutual labels:  clustering
IntroduceToEclicpseVert.x
This repository contains the code of Vert.x examples contained in my articles published on platforms such as kodcu.com, medium, dzone. How to run each example is described in its readme file.
Stars: ✭ 27 (+17.39%)
Mutual labels:  clustering
ssdc
ssdeep cluster analysis for malware files
Stars: ✭ 24 (+4.35%)
Mutual labels:  clustering
cerebra
A tool for fast and accurate summarizing of variant calling format (VCF) files
Stars: ✭ 55 (+139.13%)
Mutual labels:  scrna-seq
scGEAToolbox
scGEAToolbox: Matlab toolbox for single-cell gene expression analyses
Stars: ✭ 15 (-34.78%)
Mutual labels:  scrna-seq
rabbitmq-clusterer
This project is ABANDONWARE. Use https://www.rabbitmq.com/cluster-formation.html instead.
Stars: ✭ 72 (+213.04%)
Mutual labels:  clustering
FixedEffectjlr
R interface for Fixed Effect Models
Stars: ✭ 20 (-13.04%)
Mutual labels:  clustering
WatsonCluster
A simple C# class using Watson TCP to enable a one-to-one high availability cluster.
Stars: ✭ 18 (-21.74%)
Mutual labels:  clustering
RcppML
Rcpp Machine Learning: Fast robust NMF, divisive clustering, and more
Stars: ✭ 52 (+126.09%)
Mutual labels:  clustering

Build Status License: MIT ReleaseVersion FOSSA Status Documentation Status

Logo

northstar

Single cell type annotation guided by cell atlases, with freedom to be queer.

Brief description

northstar is a Python package to identify cell types within single cell transcriptomics datasets. northstar's superpower is that it learns from cell atlases but still allows queer cells to make their own cluster if they want to.

Also, northstar was heavily developed during Pride Month.

Atlas resources

Atlas averages

Curated averages and subsamples from several atlases: https://northstaratlas.github.io/atlas_landmarks/

If you want us to add you cell atlas, open an issue on: https://github.com/northstaratlas/atlas_landmarks/issues

Documentation

https://northstar.readthedocs.io

Installation

pip install northstar

To automatically download and use our online atlas collection at https://northstaratlas.github.io/atlas_averages/, you will need to call:

pip install 'northstar[atlas-fetcher]'

Dependencies

  • numpy
  • scipy
  • pandas
  • scikit-learn
  • anndata
  • python-igraph>=0.8.0
  • leidenalg>=0.8.0

It is recommended that you install python-igraph and leidenalg using pip. However, any installation (e.g. conda) that includes recent enough versions of both packages should work.

Optional deps to use our online atlases:

  • requests
  • loompy
  • scanpy
  • pynndescent (only useful if you use scanpy as well)

If you have scanpy installed, northstar will use it to speed up a few operations (PCA, graph construction). You can turn this off in two ways:

  1. Uninstall scanpy is you don't need it for anything else, or
  2. Set the environment variable NORTHSTAR_SKIP_SCANPY to anything except empty string, e.g. in a notebook:
import os
os.environ['NORTHSTAR_SKIP_SCANPY'] = 'yes'
import northstar as ns

(rest of the notebook/script)

Hot-swapping between the two modes (w or w/o scanpy) is not currently supported.

Usage

See the paper below or the documentation for detailed instructions and examples. The simplest way to use northstar is to classify a new single cell dataset using one of the available atlases, e.g. Darmanis_2015 on brain cells:

import northstar

# Choose an atlas
atlas_name = 'Darmanis_2015'

# Get a gene expression matrix of the new dataset (here a
# random matrix for simplicity)
N = 200
L = 50
new_dataset = pd.DataFrame(
    data=np.random.rand(L, N).astype(np.float32),
    index=<gene_list>,
    columns=['cell_'+str(i+1) for i in range(N)],
    )

# Initialize northstar classes
model = northstar.Averages(
        atlas='Darmanis_2015',
        n_neighbors=5,
        n_pcs=10,
        )

# Run the classifier
model.fit(new_dataset)

# Get the cluster memberships for the new cells
membership = model.membership

Citation

If you use this software please cite the following paper:

Fabio Zanini*, Bojk A. Berghuis*, Robert C. Jones, Benedetta Nicolis di Robilant, Rachel Yuan Nong, Jeffrey Norton, Michael F. Clarke, Stephen R. Quake. Northstar enables automatic classification of known and novel cell types from tumor samples. Scientific Reports 10, Article number: 15251 (2020), DOI: https://doi.org/10.1038/s41598-020-71805-1

License

northstar is released under the MIT license.

NOTE: The module leidenalg to perform graph-based clstering is released under the GLP3 license. You agree with those licensing terms if you use leidenalg within northstar.

FOSSA Status

Note that the project description data, including the texts, logos, images, and/or trademarks, for each open source project belongs to its rightful owner. If you wish to add or remove any projects, please contact us at [email protected].