utilities of alevin-fry
Project description
pyroe
Introduction
Alevin-fry
is a fast, accurate, and memory frugal quantification tool for preprocessing single-cell RNA-sequencing data. Detailed information can be found in the alevin-fry pre-print, and paper.
The pyroe
package provides useful functions for analyzing single-cell or single-nucleus RNA-sequencing data using alevin-fry
, which consists of
- Preparing the spliced + intronic (splici) or spliced + unspliced (spliceu) reference for the
USA
mode ofalevin-fry
, which will export a unspliced, a spliced, and an ambiguous molecule count for each gene within each cell. - Fetching and loading the preprocessed quantification results of
alevin-fry
into python as anAnnData
object. - Converting the
mtx
format output ofalevin-fry
(specifically in USA mode) to other formats, such as theAnnData
nativeh5ad
format.
Installation
The pyroe
package can be accessed from its github repository, installed via pip
. To install the pyroe
package via pip
use the command:
pip install pyroe
To make use of the load_fry
function (which, itself, installs scanpy), you should also be sure to install the package with the scanpy
extra:
pip install pyroe[scanpy]
Alternatively, pyroe
can be installed via bioconda
, which will automatically install the variant of the package including load_fry
, and will
also install bedtools
to enable faster construction of the ** reference (see below). This installation can be performed with the command:
conda install pyroe
with the appropriate bioconda channel in the conda channel list.
Preparing a spliced + intronic (splici) reference for quantification with alevin-fry
The USA mode in alevin-fry requires a special index reference. Specifically, it requires either a spliced + intronic (splici)reference or a spliced + unspliced (spliceu) reference. The spliced + intronic (splici) reference contains the spliced transcripts plus the (merged and collapsed) intronic sequences of each gene. The make_splici_txome()
function is designed to make the spliced + intronic reference by taking a genome FASTA file and a gene annotation GTF file as the input. Details about the spliced + intronic can be found in Section S2 of the supplementary file of the alevin-fry paper. To run pyroe, you also need to specify the read length argument read_length
of the experiment you are working on and the flank trimming length flank_trim_length
. A final flank length will be computed as the difference between the read_length and flank trimming length and will be attached to the ends of each intron to absorb the intron-exon junctional reads. To make the splici index using pyroe
, one can call pyroe make-spliced+intronic
or its alias pyroe make-splici
.
Following is an example of calling the pyroe
to make the splici index reference. The final flank length is calculated as the difference between the read length and the flank_trim_length, i.e., 5-2=3. This function allows you to add extra spliced and unspliced sequences to the spliced + intronic index, which will be useful when some unannotated sequences, such as mitochondrial genes, are important for your experiment. Note : to make pyroe
work more quickly, it is recommended to have the latest version of bedtools
(Aaron R. Quinlan and Ira M. Hall, 2010) installed.
pyroe make-spliced+intronic extdata/small_example_genome.fa extdata/small_example.gtf 5 splici_txome \
--flank-trim-length 2 --filename-prefix transcriptome_splici --dedup-seqs
The pyroe
program writes two files to your specified output directory output_dir
. They are
- A FASTA file that stores the extracted splici sequences.
- A three columns' transcript-name-to-gene-name file that stores the name of each transcript in the spliced + intronic index reference, their corresponding gene name, and the splicing status (
S
for spliced andU
for unspliced) of those transcripts.
Full usage
usage: pyroe make-spliced+intronic [-h] [--filename-prefix FILENAME_PREFIX]
[--flank-trim-length FLANK_TRIM_LENGTH]
[--extra-spliced EXTRA_SPLICED]
[--extra-unspliced EXTRA_UNSPLICED]
[--bt-path BT_PATH] [--dedup-seqs] [--no-bt]
[--no-flanking-merge]
genome-path gtf-path read-length output-dir
positional arguments:
genome-path The path to a gtf file.
gtf-path The path to a gtf file.
read-length The read length of the single-cell experiment
being processed (determines flank size).
output-dir The output directory where splici reference
files will be written.
optional arguments:
-h, --help show this help message and exit
--filename-prefix FILENAME_PREFIX
The file name prefix of the generated output files.
--flank-trim-length FLANK_TRIM_LENGTH
Determines the amount subtracted from the read length
to get the flank length.
--extra-spliced EXTRA_SPLICED
The path to an extra spliced sequence fasta file.
--extra-unspliced EXTRA_UNSPLICED
The path to an extra unspliced sequence fasta file.
--bt-path BT_PATH The path to bedtools v2.30.0 or greater.
--dedup-seqs A flag indicates whether identical sequences will be
deduplicated.
--no-bt A flag indicates whether to disable bedtools.
--no-flanking-merge A flag indicates whether introns will be merged after
adding flanking length.
the spliced + intronic (splici) index
The spliced + intronic index of a given species consists of the transcriptome of the species, i.e., the spliced transcripts, and the intronic sequences of the species. Within a gene, if the flanked intronic sequences overlap with each other, the overlapped intronic sequences will be collapsed as a single intronic sequence to make sure each base will appear only once in the intronic sequences. For more detailed information, please check the section S2 in the supplementary file of alevin-fry manuscript.
Prepare spliced + unspliced (spliceu) index for quantification with alevin-fry
Recently, He et al. introduced the spliced+unspliced (spliceu) index in alevin-fry. This requires the spliced + unspliced transcriptome. The command to make an spliced + unspliced transcriptome reference is similar to making a spliced + intronic reference. To make the splici index using pyroe
, one can call pyroe make-spliced+unspliced
or its alias pyroe make-spliceu
pyroe make-spliced+unspliced extdata/small_example_genome.fa extdata/small_example.gtf spliceu_txome \
--filename-prefix transcriptome_spliceu
Full usage
usage: pyroe make-spliced+unspliced [-h] [--filename-prefix FILENAME_PREFIX]
[--extra-spliced EXTRA_SPLICED]
[--extra-unspliced EXTRA_UNSPLICED]
[--bt-path BT_PATH] [--no-bt] [--dedup-seqs]
[--write-clean-gtf]
genome-path gtf-path output-dir
positional arguments:
genome-path The path to a genome fasta file.
gtf-path The path to a gtf file.
output-dir The output directory where Spliceu reference files
will be written.
options:
-h, --help show this help message and exit
--filename-prefix FILENAME_PREFIX
The file name prefix of the generated output files.
--extra-spliced EXTRA_SPLICED
The path to an extra spliced sequence fasta file.
--extra-unspliced EXTRA_UNSPLICED
The path to an extra unspliced sequence fasta file.
--bt-path BT_PATH The path to bedtools v2.30.0 or greater.
--no-bt A flag indicates whether bedtools will be used for
generating Spliceu reference files.
--dedup-seqs A flag indicates whether identical sequences will be
deduplicated.
--write-clean-gtf A flag indicates whether a clean gtf will be written
if encountered invalid records.
Notes on the input gene annotation GTF files
Pyroe build expanded transcriptome references, the spliced + intronic (splici) transcriptome reference and the spliced + unspliced (spliceu) transcriptome reference based on a genome build FASTA file and a gene annotation GTF file.
The input GTF file will be processed before extracting unspliced sequences. If pyroe finds invalid records, a clean_gtf.gtf
file will be generated in the specified output directory. Note : The features extracted in the spliced + unspliced transcriptome will not necessarily be those present in the clean_gtf.gtf
file — as this command will prefer the input in the user-provided file wherever possible. More specifically:
- Each non-gene record has to have a valid transcript_id. If this is not satisfied, it returns an error. Only the records with a valid transcript_id will be written to the clean_gtf.gtf.
- For gene_id and gene_name metadata field,
- If these two fields are entirely missing in the GTF file, An error will be returned. At the same time, in the clean_gtf.gtf, the two fields will be imputed using the transcript_id fields.
- If one of these two fields is completely missing, a warning will be generated, and the missing field will be imputed using the other one.
- if some records have missing gene_id and/or gene_name, a warning will be printed, and the missing values will be imputed by the following rules: For records miss gene_id or gene_name, impute the missing one using the other one; If both are missing, impute them using transcript_id, which cannot be missing.
- If there is no "transcript" or "gene" feature record, a warning will be printed. Moreover, those missing records will be imputed using the "exon" feature records: The Start and End site of the gene/transcript will be imputed as the bounds of their corresponding exons.
- If the boundaries defined in the transcripts'/genes' feature records do not match those implied by their exons' feature records, report a warning but still use transcripts'/genes' feature records to extract unspliced sequences. To be specific, if some but not all transcripts/genes have their corresponding transcripts'/genes' feature records, or the Start and/or End site defined in the transcript/gene feature records do not match the corresponding exons' bounds, then the existing transcripts'/genes' feature records will be used to extract unspliced transcripts. At the same time, in the clean_gtf.gtf, all genes/transcripts that appeared in the exon feature records will have their corresponding transcripts'/genes' feature records, in which the boundaries match the corresponding exons' bounds.
Processing alevin-fry quantification result
The quantification result of alevin-fry can be loaded into python by the load_fry()
function. This function takes a output directory returned by alevin-fry quant
command as the minimum input, and load the quantification result as an AnnData
object. When processing USA mode result, it assumes that the data comes from a single-cell RNA-sequencing experiment. If one wants to process single-nucleus RNA-sequencing data or prepare the single-cell data for RNA-velocity analysis, the output_format
argument should be set as snRNA
or velocity
correspondingly. One can also define customized output format, see the Full Usage section for detail.
Full Usage
load alevin-fry quantification result into an AnnData object
Required Parameters
frydir : str
The path to a output directory returned by alevin-fry quant command. \
The directory containing the alevin-fry quantification (i.e. the the quant.json file & alevin subdirectory).
Optional Parameters
output_format : str
or dict
A string represents one of the pre-defined output formats, which are "scRNA", "snRNA" and "velocity". \
If a customized format of the returned AnnData
is needed, one can pass a Dictionary.\
See Notes section for details.
quiet : bool
(default: True
)
True if function should be quiet.
False if messages (including error messages) should be printed out.
nonzero : bool
(default: False
)
True if cells with non-zero expression value across all genes should be filtered in each layer.
False if unexpressed genes should be kept.
load_fry
Notes
The output_format
argument takes either a dictionary that defines the customized format or
a string that represents one of the pre-defined format of the returned AnnData
object.
Each of the pre-defined formats contains a X
field and some optional extra AnnData.layers
obtained from the submatrices representing unspliced (U), spliced (S) and ambiguous (A) counts
returned by alevin-fry.
The following formats are defined:
-
"scRNA": This format is recommended for single cell RNA-sequencing experiments. It returns a
X
field that contains the S+A count of each gene in each cell, and aunspliced
field that contains the U count of each gene. -
"snRNA", "all" and "U+S+A": These three formats are the same. They return a
X
field that contains the U+S+A count of each gene in each cell without any extra layers. It is recommended for single-nucleus RNA-sequencing experiments. CellRanger 7 returns this format for both single-cell and single-nucleus experiments. -
"S+A": It returns a
X
field that contains the S+A count of each gene in each cell with no extra field. -
"raw": This format uses the S count matrix as the
X
field and put the U, S, and A counts into three separate layers, which are "unspliced", "spliced" and "ambiguous". -
"velocity": This format is the same as "scRNA", except it contains two extra layers: the "spliced" layer, which contains the S+A counts, and the "unspliced" layer, which contains the U counts.
A custom output format can be defined using a Dictionary specifying the desired format of the output Anndata
object.
If the input is not a USA mode quantification directory, this parameter is ignored
and the count matrix is returned in the X
field of the returned AnnData
object. If the input
quantification directory contains a USA mode quantification, then there are 3 sub-matrices that can
be referenced in the dictionary; 'U', 'S', 'A' containing, respectively, unspliced, spliced and
ambiguous counts. The dictionary should have entries of the form key
(str) : value
(list[str]).
The following constraints apply : there should be one key-value pair with the key X
, the resulting
counts will be returned in the X
field of the AnnData object. There can be an arbitrary number
of other key-value pairs, but each will be returned as a layer of the resulting AnnData object.
Within the key-value pairs, the key refers to the layer name that will be given to the combined
count matrix upon output, and the value should be a subset of ['U', 'S', 'A']
that defines
which sub-matrices should be summed. For example:
{'X' : ['S', 'A'], 'unspliced' : ['U']}
will result in a return AnnData object where the X field has a matrix in which each entry
corresponds to the summed spliced and ambiguous counts for each gene in each cell, and there
is an additional "unspliced" layer, whose counts are taken directly from the unspliced sub-matrix.
Returns
An AnnData object with X and layers corresponding to the requested output_format
.
Fetching and loading preprocessed quantification results
The raw data for many single-cell and single-nucleus RNA-seq experiments is publicly available. However, certain datasets are used again and again, to demonstrate data processing in tutorials, as benchmark datasets for novel methods (e.g. for clustering, dimensionality reduction, cell type identification, etc.). In particular, 10x Genomics hosts various publicly available datasets generated using their technology and processed via their Cell Ranger software on their website for download.
We have created a Nextflow-based alevin-fry
workflow that one can use to easily quantify single-cell RNA-sequencing data in a single workflow. The pipeline can be found here. To test out this initial pipeline, we have begun to reprocess the publicly-available datasets collected from the 10x website. We have focused the initial effort on standard single-cell and single-nucleus gene-expression data generated using the Chromium v2 and v3 chemistries, but hope to expand the pipeline to more complex protocols soon (e.g. feature barcoding experiments) and process those data as well. We note that these more complex protocols can already be processed with alevin-fry
(see the alevin-fry tutorials), but these have just not yet been incorprated into the automated Nextflow-based workflow linked above.
We provide two python functions:
fetch_processed_quant()
can fetch the quantification result of one or more available datasets according to the provideddataset_ids
vector, and store them to a local folder.load_processed_quant()
can fetch the quantification result of one or more available dataset asfetch_processed_quant()
, and load them into python asAnnData
objects. We also provide a CLI for fetching quantification results.
pyroe fetch-quant 1 3 6
or start python, and run
import pyroe
# fetch, decompress and load the quantification result of dastset #1, 3 and 6
pq_dict = pyroe.load_processed_quant([1,3,6])
# get the ProcessedQuant class object for dataset #1 and #3
pq_ds1 = pq_dict[1]
pq_ds3 = pq_dict[3]
# get the dataset name
pq_ds1.dataset_name
pq_ds3.dataset_name
# get the path to the quantification result
pq_ds1.quant_path
pq_ds3.quant_path
# get the AnnData
pq_ds1.anndata
pq_da3.anndata
Full usage
usage: pyroe fetch-quant [-h] [--fetch_dir FETCH_DIR] [--force] [--delete_tar]
[--quiet]
dataset-ids [dataset-ids ...]
positional arguments:
dataset-ids The ids of the datasets to fetch
optional arguments:
-h, --help show this help message and exit
--fetch_dir FETCH_DIR
The path to a directory for storing fetched datasets.
--force A flag indicates whether existing datasets will be redownloaded by force.
--delete_tar A flag indicates whether fetched tar files will be deleted.
--quiet A flag indicates whether help messaged should not be printed.
1. 500 Human PBMCs, 3' LT v3.1, Chromium Controller
2. 500 Human PBMCs, 3' LT v3.1, Chromium X
3. 1k PBMCs from a Healthy Donor (v3 chemistry)
4. 10k PBMCs from a Healthy Donor (v3 chemistry)
5. 10k Human PBMCs, 3' v3.1, Chromium X
6. 10k Human PBMCs, 3' v3.1, Chromium Controller
7. 10k Peripheral blood mononuclear cells (PBMCs) from a healthy donor, Single Indexed
8. 10k Peripheral blood mononuclear cells (PBMCs) from a healthy donor, Dual Indexed
9. 20k Human PBMCs, 3' HT v3.1, Chromium X
10. PBMCs from EDTA-Treated Blood Collection Tubes Isolated via SepMate-Ficoll Gradient (3' v3.1 Chemistry)
11. PBMCs from Heparin-Treated Blood Collection Tubes Isolated via SepMate-Ficoll Gradient (3' v3.1 Chemistry)
12. PBMCs from ACD-A Treated Blood Collection Tubes Isolated via SepMate-Ficoll Gradient (3' v3.1 Chemistry)
13. PBMCs from Citrate-Treated Blood Collection Tubes Isolated via SepMate-Ficoll Gradient (3' v3.1 Chemistry)
14. PBMCs from Citrate-Treated Cell Preparation Tubes (3' v3.1 Chemistry)
15. PBMCs from a Healthy Donor: Whole Transcriptome Analysis
16. Whole Blood RBC Lysis for PBMCs and Neutrophils, Granulocytes, 3'
17. Peripheral blood mononuclear cells (PBMCs) from a healthy donor - Manual (channel 5)
18. Peripheral blood mononuclear cells (PBMCs) from a healthy donor - Manual (channel 1)
19. Peripheral blood mononuclear cells (PBMCs) from a healthy donor - Chromium Connect (channel 5)
20. Peripheral blood mononuclear cells (PBMCs) from a healthy donor - Chromium Connect (channel 1)
21. Hodgkin's Lymphoma, Dissociated Tumor: Whole Transcriptome Analysis
22. 200 Sorted Cells from Human Glioblastoma Multiforme, 3’ LT v3.1
23. 750 Sorted Cells from Human Invasive Ductal Carcinoma, 3’ LT v3.1
24. 2k Sorted Cells from Human Glioblastoma Multiforme, 3’ v3.1
25. 7.5k Sorted Cells from Human Invasive Ductal Carcinoma, 3’ v3.1
26. Human Glioblastoma Multiforme: 3’v3 Whole Transcriptome Analysis
27. 1k Brain Cells from an E18 Mouse (v3 chemistry)
28. 10k Brain Cells from an E18 Mouse (v3 chemistry)
29. 1k Heart Cells from an E18 mouse (v3 chemistry)
30. 10k Heart Cells from an E18 mouse (v3 chemistry)
31. 10k Mouse E18 Combined Cortex, Hippocampus and Subventricular Zone Cells, Single Indexed
32. 10k Mouse E18 Combined Cortex, Hippocampus and Subventricular Zone Cells, Dual Indexed
33. 1k PBMCs from a Healthy Donor (v2 chemistry)
34. 1k Brain Cells from an E18 Mouse (v2 chemistry)
35. 1k Heart Cells from an E18 mouse (v2 chemistry)
The ProcessedQuant class
To store the information of a dataset, we provide the ProcessedQuant
class, which can be simply instantiated using a dataset id, for example, ProcessedQuant(2)
will return an instance of the ProcessedQuant
class containing the detail of dataset #2, 500 Human PBMCs, 3' LT v3.1, Chromium X. This class contains methods for fetching, decompressing and loading the quantification result of the corresponding dataset. After getting an instance of the class, i.e., running pq = ProcessedQuant(dataset_id)
, one can run the following commands to fetch, decompress and/or load the quantification result of the dataset:
pq.fetch_quant()
fetches the compressed quantification result of the corresponding dataset into a local directory and stores the path in itstar_path
attribute.pq.decompress_quant()
decompresses the fetched quantification result into a local directory and stores the path in itsquant_path
attribute.pq.load_quant()
loads the decompressed quantification result into python as anAnnData
object and stores the object in itsanndata
attribute.
Besides, we have some helper function for printing and loading the information of the available datasets:
ProcessedQuant.get_available_dataset_df()
returns the detail of available datasets as a pandas dataframe.ProcessedQuant.print_available_datasets()
prints the index and name of the available datasets.
Converting quantification results
The convert
sub-command of pyroe
can convert the output of alevin-fry
into several common formats, such as
the native AnnData
format (h5ad
). Further, when performing this conversion, it can organize the unspliced,
spliced, and ambiguous counts as desired by the user.
The sub-command takes as input a quantification directory produced by alevin-fry
, and an output location.
Additionally, the user should pass in command line parameters to describe the desired output structure, and
output format. The output structure defines how the U
, S
, and A
layers of the input quantification should
be represented in the converted matrix. The syntax for this flag exactly mimics the output_format
argument of
the load_fry
function, which you can read about here.
Note that, if you pass in a custom output structure, you should enclose your format description in quotes. For
example, to output to an object where the "main" layer (X
) contains the sum of U
, S
, and A
, and where
there is an additional layer named unspliced
having just the unspliced counts, you would pass
--output-structure '{ "X" : ["U", "S", "A"], "unspliced" : ["U"]}'
.
If you do not explicitly provide an --output-format
, the default of h5ad
will be used.
convert
command full usage
usage: pyroe convert [-h] [--output-structure OUTPUT_STRUCTURE] [--output-format OUTPUT_FORMAT] quant_dir output
positional arguments:
quant_dir The input quantification directory containing the matrix to be converted.
output The output name where the quantification matrix should be written. For `csvs` output format, this will be a directory. For all others, it will be a file.
optional arguments:
-h, --help show this help message and exit
--output-structure OUTPUT_STRUCTURE
The structure that U,S and A counts should occupy in the output matrix.
--output-format OUTPUT_FORMAT
The format in which the output should be written, one of {'loom', 'h5ad', 'zarr', 'csvs'}.
Project details
Release history Release notifications | RSS feed
Download files
Download the file for your platform. If you're not sure which to choose, learn more about installing packages.
Source Distribution
Built Distribution
File details
Details for the file pyroe-0.8.1.tar.gz
.
File metadata
- Download URL: pyroe-0.8.1.tar.gz
- Upload date:
- Size: 52.1 kB
- Tags: Source
- Uploaded using Trusted Publishing? No
- Uploaded via: twine/4.0.2 CPython/3.9.16
File hashes
Algorithm | Hash digest | |
---|---|---|
SHA256 | 2be4867b177918357b80728764e484a07a85742f2671ac392c723d7b73fda3dd |
|
MD5 | da84000e1a5ccb4f1e892c1a7368c2f5 |
|
BLAKE2b-256 | 5f7e0a45d2de48940ce499b71d5ae2622430f9dd2701e74170d01937fdf15a70 |
File details
Details for the file pyroe-0.8.1-py3-none-any.whl
.
File metadata
- Download URL: pyroe-0.8.1-py3-none-any.whl
- Upload date:
- Size: 49.0 kB
- Tags: Python 3
- Uploaded using Trusted Publishing? No
- Uploaded via: twine/4.0.2 CPython/3.9.16
File hashes
Algorithm | Hash digest | |
---|---|---|
SHA256 | 9429acac365d133c85f43782222ee173cd02751d160665140b9359d10b816d3a |
|
MD5 | 0474e2955dc76085523e2a62b5484ccf |
|
BLAKE2b-256 | a922704245d550d6b331aae236687e07293e87a98ea699e385042447bee84b6d |