kb-python


Namekb-python JSON
Version 0.29.1 PyPI version JSON
download
home_pagehttps://github.com/pachterlab/kb_python
SummaryPython wrapper around kallisto | bustools for scRNA-seq analysis
upload_time2024-10-21 08:05:22
maintainerPachter Lab
docs_urlNone
authorKyung Hoi (Joseph) Min
requires_python>=3.8
licenseBSD
keywords kallisto bustools
VCS
bugtrack_url
requirements anndata h5py Jinja2 loompy nbconvert nbformat ngs-tools numpy pandas plotly requests scanpy scikit-learn typing-extensions biopython
Travis-CI No Travis.
coveralls test coverage No coveralls.
            # kb-python
![github version](https://img.shields.io/badge/Version-0.29.1-informational)
[![pypi version](https://img.shields.io/pypi/v/kb-python)](https://pypi.org/project/kb-python/0.29.1/)
![python versions](https://img.shields.io/pypi/pyversions/kb_python)
![status](https://github.com/pachterlab/kb_python/workflows/CI/badge.svg)
[![codecov](https://codecov.io/gh/pachterlab/kb_python/branch/master/graph/badge.svg)](https://codecov.io/gh/pachterlab/kb_python)
[![pypi downloads](https://img.shields.io/pypi/dm/kb-python)](https://pypi.org/project/kb-python/)
[![docs](https://readthedocs.org/projects/kb-python/badge/?version=latest)](https://kb-python.readthedocs.io/en/latest/?badge=latest)
[![license](https://img.shields.io/pypi/l/kb-python)](LICENSE)

`kb-python` is a python package for processing single-cell RNA-sequencing. It wraps the [`kallisto` | `bustools`](https://www.kallistobus.tools) single-cell RNA-seq command line tools in order to unify multiple processing workflows. 

`kb-python` was first developed by [Kyung Hoi (Joseph) Min](https://twitter.com/lioscro) and [A. Sina Booeshaghi](https://twitter.com/sinabooeshaghi) while in [Lior Pachter](https://twitter.com/lpachter)'s lab at Caltech. If you use `kb-python` in a publication please [cite*](#cite):
```
Melsted, P., Booeshaghi, A.S., et al. 
Modular, efficient and constant-memory single-cell RNA-seq preprocessing. 
Nat Biotechnol  39, 813–818 (2021). 
https://doi.org/10.1038/s41587-021-00870-2
```

## Installation
The latest release can be installed with

```bash
pip install kb-python
```

The development version can be installed with
```bash
pip install git+https://github.com/pachterlab/kb_python
```

There are no prerequisite packages to install. The `kallisto` and `bustools` binaries are included with the package.

## Usage

`kb`  consists of five subcommands
```bash
$ kb
usage: kb [-h] [--list] <CMD> ...
positional arguments:
  <CMD>
    info      Display package and citation information
    compile   Compile `kallisto` and `bustools` binaries from source
    ref       Build a kallisto index and transcript-to-gene mapping
    count     Generate count matrices from a set of single-cell FASTQ files
    extract   Extract reads that were pseudoaligned to specific genes/transcripts (or extract all reads that were / were not pseudoaligned)
```

### `kb ref`: generate a pseudoalignment index

The `kb ref` command takes in a species annotation file (GTF) and associated genome (FASTA) and builds a species-specific index for pseudoalignment of reads. This must be run before `kb count`. Internally, `kb ref` extracts the coding regions from the GTF and builds a transcriptome FASTA that is then indexed with `kallisto index`.

```bash
kb ref -i index.idx -g t2g.txt -f1 transcriptome.fa <GENOME> <GENOME_ANNOTATION>
```
-  `<GENOME>` refers to a genome file (FASTA).
	- For example, the zebrafish genome is hosted by [ensembl](https://uswest.ensembl.org/Danio_rerio/Info/Index) and can be downloaded [here](http://ftp.ensembl.org/pub/release-107/fasta/danio_rerio/dna/Danio_rerio.GRCz11.dna.primary_assembly.fa.gz)
- `<GENOME_ANNOTATION>` refers to a genome annotation file (GTF)
	- For example, the zebrafish genome annotation file is hosted by [ensembl](https://uswest.ensembl.org/Danio_rerio/Info/Index) and can be downloaded [here](http://ftp.ensembl.org/pub/release-107/gtf/danio_rerio/Danio_rerio.GRCz11.107.gtf.gz)
- **Note:** The latest genome annotation and genome file for every species on ensembl can be found with the [`gget`](https://github.com/pachterlab/gget) command-line tool.

Prebuilt indices are available at https://github.com/pachterlab/kallisto-transcriptome-indices

#### Examples
```bash
# Index the transcriptome from genome FASTA (genome.fa.gz) and GTF (annotation.gtf.gz)
$ kb ref -i index.idx -g t2g.txt -f1 transcriptome.fa genome.fa.gz annotation.gtf.gz
# An example for downloading a prebuilt reference for mouse
$ kb ref -d mouse -i index.idx -g t2g.txt
```
---
### `kb count`: pseudoalign and count reads

The `kb count` command takes in the pseudoalignment index (built with `kb ref`) and sequencing reads generated by a sequencing machine to generate a count matrix. Internally, `kb count` runs numerous [`kallisto`](https://github.com/pachterlab/kallisto) and [`bustools`](https://github.com/BUStools/bustools/) commands comprising a single-cell workflow for the specified technology that generated the sequencing reads.

```bash
kb  count -i index.idx -g t2g.txt -o out/ -x <TECHNOLOGY> <FASTQ FILE[s]>
```
-  `<TECHNOLOGY>` refers to the assay that generated the sequencing reads.
	- For a list of supported assays run `kb --list`
- `<FASTQ FILE[s]>` refers to the a list of FASTQ files generated 
	- Different assays will have a different number of FASTQ files 
	- Different assays will place the different features in different FASTQ files
		- For example, sequencing a 10xv3 library on a NextSeq Illumina sequencer usually results in two FASTQ files. 
		- The `R1.fastq.gz` file (colloquially called "read 1") contains a 16 basepair cell barcode and a 12 basepair unique molecular identifier (UMI). 
		- The `R2.fastq.gz` file (colloquially called "read 2") contains the cDNA associated with the cell barcode-UMI pair in read 1.

#### Examples
```bash
# Quantify 10xv3 reads read1.fastq.gz and read2.fastq.gz
$ kb count -i index.idx -g t2g.txt -o out/ -x 10xv3 read1.fastq.gz read2.fastq.gz
```
---
### `kb info`: display package and citation information

The `kb info` command prints out package information including the version of `kb-python`, `kallisto`, and `bustools` along with their installation location.

```bash
$ kb info
kb_python 0.29.1 ...
kallisto: 0.51.1 ...
bustools: 0.44.1 ...
...
```
---
### `kb compile`: compile `kallisto` and `bustools` binaries from source
The `kb compile` command grabs the latest `kallisto` and `bustools` source and compiles the binaries. **Note**: this is not required to run `kb-python`.

## Use cases
`kb-python` facilitates fast and uniform pre-processing of single-cell sequencing data to answer relevant research questions. 
```bash
$ pip install kb-python gget ffq

# Goal: quantify publicly available scRNAseq data
$ kb ref -i index.idx -g t2g.txt -f1 transcriptome.fa $(gget ref --ftp -w dna,gtf homo_sapiens)
$ kb count -i index.idx -g t2g.txt -x 10xv3 -o out $(ffq --ftp SRR10668798 | jq -r '.[] | .url' | tr '\n' ' ')
# -> count matrix in out/ folder

# Goal: quantify 10xv2 feature barcode data, feature_barcodes.txt is a tab-delimited file
# containing barcode_sequence<tab>barcode_name
$ kb ref -i index.idx -g f2g.txt -f1 features.fa --workflow kite feature_barcodes.txt
$ kb count -i index.idx -g f2b.txt -x 10xv2 -o out/ --workflow kite --h5ad R1.fastq.gz R2.fastq.gz
# -> count matrix in out/ folder
```
Submitted by [@sbooeshaghi](https://github.com/sbooeshaghi/).

Do you have a cool use case for `kb-python`? Submit a PR (including the goal, code snippet, and your username) so that we can feature it here.

## Tutorials
For a list of tutorials that use `kb-python` please see [https://www.kallistobus.tools/](https://www.kallistobus.tools/).

## Documentation
Developer documentation is hosted on [Read the Docs](https://kb-python.readthedocs.io/en/latest/).

## Contributing
Thank you for wanting to improve `kb-python`! If you have believe you've found a bug, please submit an issue. 

If you have a new feature you'd like to add to `kb-python` please create a pull request. Pull requests should contain a message detailing the exact changes made, the reasons for the change, and tests that check for the correctness of those changes.

# Cite
If you use `kb-python` in a publication, please cite the following papers:

`kb-python`  & `kallisto` and/or `bustools`
```
@article{sullivan2023kallisto,
  title={kallisto, bustools, and kb-python for quantifying bulk, single-cell, and single-nucleus RNA-seq},
  author={Sullivan, Delaney K and Min, Kyung Hoi and Hj{\"o}rleifsson, Kristj{\'a}n Eldj{\'a}rn and Luebbert, Laura and Holley, Guillaume and Moses, Lambda and Gustafsson, Johan and Bray, Nicolas L and Pimentel, Harold and Booeshaghi, A Sina and others},
  journal={bioRxiv},
  pages={2023--11},
  year={2023},
  publisher={Cold Spring Harbor Laboratory}
}
```

`bustools` 
```tex
@article{melsted2021modular,
  title={\href{https://doi.org/10.1038/s41587-021-00870-2}{Modular, efficient and constant-memory single-cell RNA-seq preprocessing}},
  author={Melsted, P{\'a}ll and Booeshaghi, A. Sina and Liu, Lauren and Gao, Fan and Lu, Lambda and Min, Kyung Hoi Joseph and da Veiga Beltrame, Eduardo and Hj{\"o}rleifsson, Kristj{\'a}n Eldj{\'a}rn and Gehring, Jase and Pachter, Lior},
  author+an={1=first;2=first,highlight},
  journal={Nature biotechnology},
  year={2021},
  month={4},
  day={1},
  doi={https://doi.org/10.1038/s41587-021-00870-2}
}
```

`kallisto` 
```tex
@article{bray2016near,
  title={Near-optimal probabilistic RNA-seq quantification},
  author={Bray, Nicolas L and Pimentel, Harold and Melsted, P{\'a}ll and Pachter, Lior},
  journal={Nature biotechnology},
  volume={34},
  number={5},
  pages={525--527},
  year={2016},
  publisher={Nature Publishing Group}
}
```

`kITE`
```tex
@article{booeshaghi2024quantifying,
  title={Quantifying orthogonal barcodes for sequence census assays},
  author={Booeshaghi, A Sina and Min, Kyung Hoi and Gehring, Jase and Pachter, Lior},
  journal={Bioinformatics Advances},
  volume={4},
  number={1},
  pages={vbad181},
  year={2024},
  publisher={Oxford University Press}
}
```

`BUS` format
```tex
@article{melsted2019barcode,
  title={The barcode, UMI, set format and BUStools},
  author={Melsted, P{\'a}ll and Ntranos, Vasilis and Pachter, Lior},
  journal={Bioinformatics},
  volume={35},
  number={21},
  pages={4472--4473},
  year={2019},
  publisher={Oxford University Press}
}
```

`kb-python` was inspired by Sten Linnarsson’s `loompy fromfq` command (http://linnarssonlab.org/loompy/kallisto/index.html)

            

Raw data

            {
    "_id": null,
    "home_page": "https://github.com/pachterlab/kb_python",
    "name": "kb-python",
    "maintainer": "Pachter Lab",
    "docs_url": null,
    "requires_python": ">=3.8",
    "maintainer_email": "lpachter@caltech.edu",
    "keywords": "kallisto bustools",
    "author": "Kyung Hoi (Joseph) Min",
    "author_email": "phoenixter96@gmail.com",
    "download_url": "https://files.pythonhosted.org/packages/cb/5b/6d158ec9595aaaae1ae043d8343ba95cf49399941e3aa4c69310f1a79051/kb_python-0.29.1.tar.gz",
    "platform": null,
    "description": "# kb-python\n![github version](https://img.shields.io/badge/Version-0.29.1-informational)\n[![pypi version](https://img.shields.io/pypi/v/kb-python)](https://pypi.org/project/kb-python/0.29.1/)\n![python versions](https://img.shields.io/pypi/pyversions/kb_python)\n![status](https://github.com/pachterlab/kb_python/workflows/CI/badge.svg)\n[![codecov](https://codecov.io/gh/pachterlab/kb_python/branch/master/graph/badge.svg)](https://codecov.io/gh/pachterlab/kb_python)\n[![pypi downloads](https://img.shields.io/pypi/dm/kb-python)](https://pypi.org/project/kb-python/)\n[![docs](https://readthedocs.org/projects/kb-python/badge/?version=latest)](https://kb-python.readthedocs.io/en/latest/?badge=latest)\n[![license](https://img.shields.io/pypi/l/kb-python)](LICENSE)\n\n`kb-python` is a python package for processing single-cell RNA-sequencing. It wraps the [`kallisto` | `bustools`](https://www.kallistobus.tools) single-cell RNA-seq command line tools in order to unify multiple processing workflows. \n\n`kb-python` was first developed by [Kyung Hoi (Joseph) Min](https://twitter.com/lioscro) and [A. Sina Booeshaghi](https://twitter.com/sinabooeshaghi) while in [Lior Pachter](https://twitter.com/lpachter)'s lab at Caltech. If you use `kb-python` in a publication please [cite*](#cite):\n```\nMelsted, P., Booeshaghi, A.S., et al. \nModular, efficient and constant-memory single-cell RNA-seq preprocessing. \nNat Biotechnol  39, 813\u2013818 (2021). \nhttps://doi.org/10.1038/s41587-021-00870-2\n```\n\n## Installation\nThe latest release can be installed with\n\n```bash\npip install kb-python\n```\n\nThe development version can be installed with\n```bash\npip install git+https://github.com/pachterlab/kb_python\n```\n\nThere are no prerequisite packages to install. The `kallisto` and `bustools` binaries are included with the package.\n\n## Usage\n\n`kb`  consists of five subcommands\n```bash\n$ kb\nusage: kb [-h] [--list] <CMD> ...\npositional arguments:\n  <CMD>\n    info      Display package and citation information\n    compile   Compile `kallisto` and `bustools` binaries from source\n    ref       Build a kallisto index and transcript-to-gene mapping\n    count     Generate count matrices from a set of single-cell FASTQ files\n    extract   Extract reads that were pseudoaligned to specific genes/transcripts (or extract all reads that were / were not pseudoaligned)\n```\n\n### `kb ref`: generate a pseudoalignment index\n\nThe `kb ref` command takes in a species annotation file (GTF) and associated genome (FASTA) and builds a species-specific index for pseudoalignment of reads. This must be run before `kb count`. Internally, `kb ref` extracts the coding regions from the GTF and builds a transcriptome FASTA that is then indexed with `kallisto index`.\n\n```bash\nkb ref -i index.idx -g t2g.txt -f1 transcriptome.fa <GENOME> <GENOME_ANNOTATION>\n```\n-  `<GENOME>` refers to a genome file (FASTA).\n\t- For example, the zebrafish genome is hosted by [ensembl](https://uswest.ensembl.org/Danio_rerio/Info/Index) and can be downloaded [here](http://ftp.ensembl.org/pub/release-107/fasta/danio_rerio/dna/Danio_rerio.GRCz11.dna.primary_assembly.fa.gz)\n- `<GENOME_ANNOTATION>` refers to a genome annotation file (GTF)\n\t- For example, the zebrafish genome annotation file is hosted by [ensembl](https://uswest.ensembl.org/Danio_rerio/Info/Index) and can be downloaded [here](http://ftp.ensembl.org/pub/release-107/gtf/danio_rerio/Danio_rerio.GRCz11.107.gtf.gz)\n- **Note:** The latest genome annotation and genome file for every species on ensembl can be found with the [`gget`](https://github.com/pachterlab/gget) command-line tool.\n\nPrebuilt indices are available at https://github.com/pachterlab/kallisto-transcriptome-indices\n\n#### Examples\n```bash\n# Index the transcriptome from genome FASTA (genome.fa.gz) and GTF (annotation.gtf.gz)\n$ kb ref -i index.idx -g t2g.txt -f1 transcriptome.fa genome.fa.gz annotation.gtf.gz\n# An example for downloading a prebuilt reference for mouse\n$ kb ref -d mouse -i index.idx -g t2g.txt\n```\n---\n### `kb count`: pseudoalign and count reads\n\nThe `kb count` command takes in the pseudoalignment index (built with `kb ref`) and sequencing reads generated by a sequencing machine to generate a count matrix. Internally, `kb count` runs numerous [`kallisto`](https://github.com/pachterlab/kallisto) and [`bustools`](https://github.com/BUStools/bustools/) commands comprising a single-cell workflow for the specified technology that generated the sequencing reads.\n\n```bash\nkb  count -i index.idx -g t2g.txt -o out/ -x <TECHNOLOGY> <FASTQ FILE[s]>\n```\n-  `<TECHNOLOGY>` refers to the assay that generated the sequencing reads.\n\t- For a list of supported assays run `kb --list`\n- `<FASTQ FILE[s]>` refers to the a list of FASTQ files generated \n\t- Different assays will have a different number of FASTQ files \n\t- Different assays will place the different features in different FASTQ files\n\t\t- For example, sequencing a 10xv3 library on a NextSeq Illumina sequencer usually results in two FASTQ files. \n\t\t- The `R1.fastq.gz` file (colloquially called \"read 1\") contains a 16 basepair cell barcode and a 12 basepair unique molecular identifier (UMI). \n\t\t- The `R2.fastq.gz` file (colloquially called \"read 2\") contains the cDNA associated with the cell barcode-UMI pair in read 1.\n\n#### Examples\n```bash\n# Quantify 10xv3 reads read1.fastq.gz and read2.fastq.gz\n$ kb count -i index.idx -g t2g.txt -o out/ -x 10xv3 read1.fastq.gz read2.fastq.gz\n```\n---\n### `kb info`: display package and citation information\n\nThe `kb info` command prints out package information including the version of `kb-python`, `kallisto`, and `bustools` along with their installation location.\n\n```bash\n$ kb info\nkb_python 0.29.1 ...\nkallisto: 0.51.1 ...\nbustools: 0.44.1 ...\n...\n```\n---\n### `kb compile`: compile `kallisto` and `bustools` binaries from source\nThe `kb compile` command grabs the latest `kallisto` and `bustools` source and compiles the binaries. **Note**: this is not required to run `kb-python`.\n\n## Use cases\n`kb-python` facilitates fast and uniform pre-processing of single-cell sequencing data to answer relevant research questions. \n```bash\n$ pip install kb-python gget ffq\n\n# Goal: quantify publicly available scRNAseq data\n$ kb ref -i index.idx -g t2g.txt -f1 transcriptome.fa $(gget ref --ftp -w dna,gtf homo_sapiens)\n$ kb count -i index.idx -g t2g.txt -x 10xv3 -o out $(ffq --ftp SRR10668798 | jq -r '.[] | .url' | tr '\\n' ' ')\n# -> count matrix in out/ folder\n\n# Goal: quantify 10xv2 feature barcode data, feature_barcodes.txt is a tab-delimited file\n# containing barcode_sequence<tab>barcode_name\n$ kb ref -i index.idx -g f2g.txt -f1 features.fa --workflow kite feature_barcodes.txt\n$ kb count -i index.idx -g f2b.txt -x 10xv2 -o out/ --workflow kite --h5ad R1.fastq.gz R2.fastq.gz\n# -> count matrix in out/ folder\n```\nSubmitted by [@sbooeshaghi](https://github.com/sbooeshaghi/).\n\nDo you have a cool use case for `kb-python`? Submit a PR (including the goal, code snippet, and your username) so that we can feature it here.\n\n## Tutorials\nFor a list of tutorials that use `kb-python` please see [https://www.kallistobus.tools/](https://www.kallistobus.tools/).\n\n## Documentation\nDeveloper documentation is hosted on [Read the Docs](https://kb-python.readthedocs.io/en/latest/).\n\n## Contributing\nThank you for wanting to improve `kb-python`! If you have believe you've found a bug, please submit an issue. \n\nIf you have a new feature you'd like to add to `kb-python` please create a pull request. Pull requests should contain a message detailing the exact changes made, the reasons for the change, and tests that check for the correctness of those changes.\n\n# Cite\nIf you use `kb-python` in a publication, please cite the following papers:\n\n`kb-python`  & `kallisto` and/or `bustools`\n```\n@article{sullivan2023kallisto,\n  title={kallisto, bustools, and kb-python for quantifying bulk, single-cell, and single-nucleus RNA-seq},\n  author={Sullivan, Delaney K and Min, Kyung Hoi and Hj{\\\"o}rleifsson, Kristj{\\'a}n Eldj{\\'a}rn and Luebbert, Laura and Holley, Guillaume and Moses, Lambda and Gustafsson, Johan and Bray, Nicolas L and Pimentel, Harold and Booeshaghi, A Sina and others},\n  journal={bioRxiv},\n  pages={2023--11},\n  year={2023},\n  publisher={Cold Spring Harbor Laboratory}\n}\n```\n\n`bustools` \n```tex\n@article{melsted2021modular,\n  title={\\href{https://doi.org/10.1038/s41587-021-00870-2}{Modular, efficient and constant-memory single-cell RNA-seq preprocessing}},\n  author={Melsted, P{\\'a}ll and Booeshaghi, A. Sina and Liu, Lauren and Gao, Fan and Lu, Lambda and Min, Kyung Hoi Joseph and da Veiga Beltrame, Eduardo and Hj{\\\"o}rleifsson, Kristj{\\'a}n Eldj{\\'a}rn and Gehring, Jase and Pachter, Lior},\n  author+an={1=first;2=first,highlight},\n  journal={Nature biotechnology},\n  year={2021},\n  month={4},\n  day={1},\n  doi={https://doi.org/10.1038/s41587-021-00870-2}\n}\n```\n\n`kallisto` \n```tex\n@article{bray2016near,\n  title={Near-optimal probabilistic RNA-seq quantification},\n  author={Bray, Nicolas L and Pimentel, Harold and Melsted, P{\\'a}ll and Pachter, Lior},\n  journal={Nature biotechnology},\n  volume={34},\n  number={5},\n  pages={525--527},\n  year={2016},\n  publisher={Nature Publishing Group}\n}\n```\n\n`kITE`\n```tex\n@article{booeshaghi2024quantifying,\n  title={Quantifying orthogonal barcodes for sequence census assays},\n  author={Booeshaghi, A Sina and Min, Kyung Hoi and Gehring, Jase and Pachter, Lior},\n  journal={Bioinformatics Advances},\n  volume={4},\n  number={1},\n  pages={vbad181},\n  year={2024},\n  publisher={Oxford University Press}\n}\n```\n\n`BUS` format\n```tex\n@article{melsted2019barcode,\n  title={The barcode, UMI, set format and BUStools},\n  author={Melsted, P{\\'a}ll and Ntranos, Vasilis and Pachter, Lior},\n  journal={Bioinformatics},\n  volume={35},\n  number={21},\n  pages={4472--4473},\n  year={2019},\n  publisher={Oxford University Press}\n}\n```\n\n`kb-python` was inspired by Sten Linnarsson\u2019s `loompy fromfq` command (http://linnarssonlab.org/loompy/kallisto/index.html)\n",
    "bugtrack_url": null,
    "license": "BSD",
    "summary": "Python wrapper around kallisto | bustools for scRNA-seq analysis",
    "version": "0.29.1",
    "project_urls": {
        "Homepage": "https://github.com/pachterlab/kb_python"
    },
    "split_keywords": [
        "kallisto",
        "bustools"
    ],
    "urls": [
        {
            "comment_text": "",
            "digests": {
                "blake2b_256": "dd48a435abcc1926fefd87d19dce7cf1a1f447f37aeb412b5cddd6a6fdf8d30a",
                "md5": "8a2f5df58aceb08c3828da3fc363ad7b",
                "sha256": "59f3955c591dff5d3fd3423c6eabb2ea1926435ec164652d890a486ac017d953"
            },
            "downloads": -1,
            "filename": "kb_python-0.29.1-py3-none-any.whl",
            "has_sig": false,
            "md5_digest": "8a2f5df58aceb08c3828da3fc363ad7b",
            "packagetype": "bdist_wheel",
            "python_version": "py3",
            "requires_python": ">=3.8",
            "size": 36506062,
            "upload_time": "2024-10-21T08:04:50",
            "upload_time_iso_8601": "2024-10-21T08:04:50.430542Z",
            "url": "https://files.pythonhosted.org/packages/dd/48/a435abcc1926fefd87d19dce7cf1a1f447f37aeb412b5cddd6a6fdf8d30a/kb_python-0.29.1-py3-none-any.whl",
            "yanked": false,
            "yanked_reason": null
        },
        {
            "comment_text": "",
            "digests": {
                "blake2b_256": "cb5b6d158ec9595aaaae1ae043d8343ba95cf49399941e3aa4c69310f1a79051",
                "md5": "e2f4478ed78ebfdd85a887dc7277908f",
                "sha256": "d811dcf06327fc6e643779f75497be33ecfcaaf402304bd71085e5a7aea8afa8"
            },
            "downloads": -1,
            "filename": "kb_python-0.29.1.tar.gz",
            "has_sig": false,
            "md5_digest": "e2f4478ed78ebfdd85a887dc7277908f",
            "packagetype": "sdist",
            "python_version": "source",
            "requires_python": ">=3.8",
            "size": 36338962,
            "upload_time": "2024-10-21T08:05:22",
            "upload_time_iso_8601": "2024-10-21T08:05:22.398048Z",
            "url": "https://files.pythonhosted.org/packages/cb/5b/6d158ec9595aaaae1ae043d8343ba95cf49399941e3aa4c69310f1a79051/kb_python-0.29.1.tar.gz",
            "yanked": false,
            "yanked_reason": null
        }
    ],
    "upload_time": "2024-10-21 08:05:22",
    "github": true,
    "gitlab": false,
    "bitbucket": false,
    "codeberg": false,
    "github_user": "pachterlab",
    "github_project": "kb_python",
    "travis_ci": false,
    "coveralls": false,
    "github_actions": true,
    "requirements": [
        {
            "name": "anndata",
            "specs": [
                [
                    ">=",
                    "0.9.2"
                ]
            ]
        },
        {
            "name": "h5py",
            "specs": [
                [
                    ">=",
                    "2.10.0"
                ]
            ]
        },
        {
            "name": "Jinja2",
            "specs": [
                [
                    ">",
                    "2.10.1"
                ]
            ]
        },
        {
            "name": "loompy",
            "specs": [
                [
                    ">=",
                    "3.0.6"
                ]
            ]
        },
        {
            "name": "nbconvert",
            "specs": [
                [
                    ">=",
                    "5.6.0"
                ]
            ]
        },
        {
            "name": "nbformat",
            "specs": [
                [
                    ">=",
                    "4.4.0"
                ]
            ]
        },
        {
            "name": "ngs-tools",
            "specs": [
                [
                    ">=",
                    "1.8.6"
                ]
            ]
        },
        {
            "name": "numpy",
            "specs": [
                [
                    ">=",
                    "1.17.2"
                ]
            ]
        },
        {
            "name": "pandas",
            "specs": [
                [
                    ">=",
                    "1.5.3"
                ]
            ]
        },
        {
            "name": "plotly",
            "specs": [
                [
                    ">=",
                    "4.5.0"
                ]
            ]
        },
        {
            "name": "requests",
            "specs": [
                [
                    ">=",
                    "2.22.0"
                ]
            ]
        },
        {
            "name": "scanpy",
            "specs": [
                [
                    ">=",
                    "1.4.4.post1"
                ]
            ]
        },
        {
            "name": "scikit-learn",
            "specs": [
                [
                    ">=",
                    "0.21.3"
                ]
            ]
        },
        {
            "name": "typing-extensions",
            "specs": [
                [
                    ">=",
                    "3.7.4"
                ]
            ]
        },
        {
            "name": "biopython",
            "specs": [
                [
                    ">=",
                    "1.8"
                ]
            ]
        }
    ],
    "lcname": "kb-python"
}
        
Elapsed time: 1.21522s