SASCRiP


NameSASCRiP JSON
Version 1.1.0 PyPI version JSON
download
home_pagehttps://github.com/Darisia/SASCRiP
SummaryA python package with wrapper functions that use the widely used Seurat and BUStools to perform single-cell RNA sequencing data pre-processing and visualisation
upload_time2024-02-16 04:31:30
maintainer
docs_urlNone
authorDarisia Moonsamy
requires_python>=3.7
license
keywords single-cell rna sequencing data pre-processing wrapper functions
VCS
bugtrack_url
requirements No requirements were recorded.
Travis-CI No Travis.
coveralls test coverage No coveralls.
            # SASCRiP Documentation
Sequencing Analysis of Single-Cell RNA in Python (SASCRiP) is a python package with wrapper functions that use the widely used Seurat and BUStools to perform single-cell RNA sequencing data pre-processing and visualisation

## Table of Contents
1. [Installation](https://github.com/Darisia/SASCRiP/blob/main/README.md#installation)
2. <details>
     <summary><a href="https://github.com/Darisia/SASCRiP/blob/main/README.md#sascrip-functions:-user-guide">SASCRiP functions: User guide</a></summary>
     <br>
     <a href="https://github.com/Darisia/SASCRiP/blob/main/README.md#edit_10xv1_fastq">edit_10v1_fastq</a>
     <br>
     <a href="https://github.com/Darisia/SASCRiP/blob/main/README.md#check_ercc">check_ercc</a>
     <br>
     <a href="https://github.com/Darisia/SASCRiP/blob/main/README.md#kallisto_bustools_count">kallisto_bustools_count</a>
     <br>
     <a href="https://github.com/Darisia/SASCRiP/blob/main/README.md#include_ercc_bus_count">include_ERCC_bus_count</a>
     <br>
     <a href="https://github.com/Darisia/SASCRiP/blob/main/README.md#run_cqc">run_cqc</a>
     <br>
     <a href="https://github.com/Darisia/SASCRiP/blob/main/README.md#stransform_normalize">sctransform_normalize</a>
     <br>
     <a href="https://github.com/Darisia/SASCRiP/blob/main/README.md#sascrip_preprocess">sascrip_preprocess</a>
     </details>
3. [Authors](https://github.com/Darisia/SASCRiP#authors)
4. [License](https://github.com/Darisia/SASCRiP#license)
5. [Reference](https://github.com/Darisia/SASCRiP#reference)
6. [Read next](https://github.com/Darisia/SASCRiP#read-next)


## Installation

### Requirements

SASCRiP uses multiple single-cell analysis packages such as Seurat and kb-python. Since SASCRiP makes use of the R packages such as Seurat and Tidyverse for plotting, these packages are required. A full list of the requirements is shown below

1. Python (>v3.7) is required to run SASCRiP functions
2. R (>v3.6) is required to be installed 
3. Seurat R package (can be installed through SASCRiP)
4. Tidyverse R package (can be installed through SASCRiP)
5. kb-python (can be installed when SASCRiP is installed)

### Installation code

The SASCRiP package can be installed using pip from the terminal

```bash

pip install SASCRiP

```

## SASCRiP functions: User guide

## `install_R_packages`

This function allows the user to install missing R packages that are required for SASCRiP to work. `install_R_packages` first checks if the package is installed and if not, install.packages() is run.

#### Usage

````python
import SASCRiP
from SASCRiP import sascrip_functions

sascrip_functions.install_R_packages()

````  

## `edit_10xv1_fastq`

`edit_10xv1_fastq` prepares FastQ files, obtained using the 10xv1 sequencing chemistry, for input into Kallisto for pseudoalignment. The directory/s containing the FastQ files are input into `edit_10xv1_fastq` which searches for the RA FastQ file that contains both the UMI and transcript sequence. The UMI and Transcript sequences are separated into their own FastQ files. The directory/s containing all these FastQ files can be input into kallisto_bustools_count for further processing. The produced FastQ files will be saved in the same directory containing all the input FastQ files.

#### Usage

````python
import SASCRiP
from SASCRiP import sascrip_functions

sascrip_functions.edit_10xv1_fastq(input_directories)

````

#### Required parameters

| Parameter | Description |
| --- | --- |
| `input_directories` (str-list) | Path to the directory/s containing the RA 10xv1 FastQ files. If there are more than one directories. A list should be given with all input directories |


## `check_ercc`

`check_ercc` allows the user to check if the single-cell dataset may contain RNA spike-ins that can be used as an additional cell-quality control metric. If `check_ercc is run`, True or False - depending on whether ERCCs are included or not, will be returned as standard output 

#### Usage

````python
import SASCRiP
from SASCRiP import sascrip_functions

sascrip_functions.check_ercc(
     ERCC_fasta,
     output_directory_path,
     list_of_fastqs,
     single_cell_technology,
     input_directory = False,
     read_separator = None,
     UMI_bp = '0',
     barcode_bp = '0',
     transcript_bp = '0'
)

````
#### Required Parameters
___________________


| Parameter | Description |
| --- | --- |
| `ERCC_fasta` (str) | Path to the ERCC FASTA file |
| `output_directory_path` (str) | Path to the output directory where output files will be saved |
| `list_of_fastqs` (str-list) | Python list of the paths to input FastQ files in the *order specified by Kallisto. The folder containing all the input files can be given instead and the relevant FastQ files will be captured and sorted in the correct order. To use this feature - input the path to the directory here (If multiple directories are used, input all the directories as a list), set input_directory = True and provide the strings used to separate the reads in the read_separator parameter. * See example below |
| `single_cell_technology` (str) | The single-cell sequencing technology that was used as *specified by Kallisto. If 10xv1 technology was used, the UMI_bp and barcode_bp parameters are required |

#### Optional parameters
___________________

| Parameter | Description |
| --- | --- |
|`input_directory` (bool) | Indicate whether the list_of_fastqs parameter is given the path to the directory containing all input FastQ files * See example below |
| `read_separator` (str-list) | The strings used to separate the input reads. Within a list - the first element should contain the string used to identify read 1, the second element should contain the string used to identify read 2 and if "10xv1" FastQ files are used, a third element is required that contains the string used to identify read 3. * See example below |
| `UMI_bp` (str) | The number of base pairs sequenced for the UMI sequence. If 10xv1 technology is used, this parameter is required |
| `barcode_bp` (str) | The number of base pairs sequenced for the barcode sequence. If 10xv1 technology is used, this parameter is required |
| `transcript_bp` (str) | The number of base pairs sequenced for the transcript sequence |


* **Kallisto specified FastQ file order and single-cell technologies**

| Single-cell tech |     FastQ file order     |
| ---------------- | ------------------------ |
| 10xv1            | Transcript, UMI, barcode |
| 10xv2            | barcode-UMI, Transcript  |
| 10xv3            | barcode-UMI, Transcript  |
| CELSeq           | barcode-UMI, Transcript  |
| CELSeq2          | barcode-UMI, Transcript  |
| DropSeq          | barcode-UMI, Transcript  |
| inDrops          | barcode-UMI, Transcript  |
| SCRBSeq          | barcode-UMI, Transcript  |
| SureCell         | barcode-UMI, Transcript  |

* **Working with more than one set of fastq files**

Include the additional sets in the fastq list, keeping the sets together. For example: if you have 2 sets of FastQ files from the 10xv2 chemistry

```python

list_of_fastqs = ["barcode_UMI_R1_1.fastq.gz", "Transcript_R2_1.fastq.gz", "barcode_UMI_R1_2.fastq.gz", "Transcript_R2_2.fastq.gz"]

```
Additionally, the directory/s containing all the relevant FastQ files can be given to the `list_of_fastqs` parameter and the FastQ files will be captured and sorted within the function, provided that `input_directory` is set to True and the `read_separator` is given. An example showing how these parameters should be set is shown below. 

Two sets of FastQ files (as shown below) are contained within a directory called "FastQ_directory":
barcode_UMI_R1_1.fastq.gz
Transcript_R2_1.fastq.gz
barcode_UMI_R1_2.fastq.gz
Transcript_R2_2.fastq.gz

```python

list_of_fastqs = "path/to/FastQ_directory"
input_directory = True
read_separator = ["R1", "R2"]

```


## `kallisto_bustools_count`

Runs both Kallisto and Bustools through kb-python to perform pseudoalignment and gene quantification respectively. `kallisto_bustools_count` generates unfiltered and filtered count matrices for the single-cell dataset of interest

#### Usage

````python
import SASCRiP
from SASCRiP import sascrip_functions

sascrip_functions.kallisto_bustools_count(
     list_of_fastqs,
     single_cell_technology,
     output_directory_path,
     species_index,
     species_t2g,
     input_directory = False,
     read_separator = None,
     generate_index = False,
     species_fasta = None,
     species_gtf = None,
     k_mer_length = 31,
     intron = False,
     filter = True,
     UMI_bp = '0',
     barcode_bp = '0',
     transcript_bp = '0',
     whitelist_path = None,
     path_to_prefix_count_files = 'unfiltered_counts',
     memory = '4G'
)

````
#### Required parameters
___________________

| Parameter | Description |
| --- | --- |
| `list_of_fastqs` (str-list) | Python list of the paths to input FastQ files in the *order specified by Kallisto. The folder containing all the input files can be given instead and the relevant FastQ files will be captured and sorted in the correct order. To use this feature - input the path to the directory here (If multiple directories are used, input all the directories as a list), set input_directory = True and provide the strings used to separate the reads in the read_separator parameter. * See example above (working with more than one set of FastQ files) |
| `single_cell_technology` (str) | The single-cell sequencing technology that was used as *specified by Kallisto. If 10xv1 technology was used, the UMI_bp and barcode_bp parameters are required |
| `output_directory_path` (str) | Path to the main output directory where all files and new directories will be created and saved |
| `species_index` (str) | Path to the kallisto_index for the species of interest. If the Kallisto index needs to be generated, set species_index = None, generate_index = True and species_fasta = "path/to/cDNA FASTA". |
| `species_t2g` (str) | Path to the transcript-to-genes mapping file for the species of interest. If the transcripts-to-genes mapping file needs to be generated, set species_t2g = None, generate_index = True and species_gtf = "path/to/GTF file". |


#### Optional parameters
___________________

| Parameter | Description |
| --- | --- |
| `input_directory` (bool) | Indicate whether the list_of_fastqs parameter is given the path to the directory containing all input FastQ files * See example above (working with more than one set of FastQ files) |
| `read_separator` (str-list) | The strings used to separate the input reads. Within a list - the first element should contain the string used to identify read 1, the second element should contain the string used to identify read 2 and if "10xv1" FastQ files are used, a third element is required that contains the string used to identify read 3. * See example above (working with more than one set of FastQ files) |
| `generate_index` (bool) | Indicate whether the Kallisto Index should be generated within the function. If set to True: the species_fasta and the species_gtf are required |
| `species_fasta` (str) | Path to the transcriptome (cDNA) FASTA file for the species of interest. This will be used to generate the Kallisto index. If generate_index is set to True, this parameter is required |
| `species_gtf` (str) | Path to the GTF file for the species of interest. This will be used to create the transcripts-to-genes mapping file. If generate_index is set to True, this parameter is required. |
| `k_mer_length` (int) | The length of the K-mers that should be generated when creating the Kallisto index |
| `intron` (bool) | Indicate whether or not to include intron transcript ids |
| `filter` (bool) | Indicate whether or not to filter the BUS file prior to generating the gene-count matrix in mtx format |
| `UMI_bp` (str) | The number of base pairs sequenced for the UMI sequence. If 10xv1 technology is used, this parameter is required |
| `barcode_bp` (str) | The number of base pairs sequenced for the barcode sequence. If 10xv1 technology is used, this parameter is required |
| `transcript_bp` (str) | The number of base pairs sequenced for the transcript sequence |
| `whitelist_path` (str) | Path to the barcode whitelist that will be used for barcode correction |
| `path_to_prefix_count_files` (str) | Prefix of the output matrix files and indices |
| `memory` (str) | Amount of memory to use |


* **Kallisto specified FastQ file order and single-cell technologies**

Please see table above

* **Working with more than one set of fastq files**

Please see description above


## `include_ERCC_bus_count`

`include_ERCC_bus_count` first checks if ERCC spike-ins are included in the dataset and generates counts with `kallisto_bustools_count` accordingly. To check if spike-ins are present, a Kallisto index is generated from the ERCC FASTA and the FastQ sequences from the dataset are aligned to the ERCC index. if no sequences align to the ERCC index, the gene-count matrix will be generated without including ERCC sequences. However, if there are seqeunces that align to the ERCC index, the ERCC FASTA seqeunce and the species FASTA sequence will be combined to create a new kallisto index. Therefore, the final gene-count matrix will include ERCC sequences.

#### Usage

````python
import SASCRiP
from SASCRiP import sascrip_functions

sascrip_functions.include_ERCC_bus_count(
     list_of_fastqs,
     single_cell_technology,
     output_directory_path,
     ERCC_fasta,
     species_index,
     species_t2g,
     species_fasta,
     input_directory = False,
     read_separator = None,
     generate_index = False,
     species_gtf = None,
     k_mer_length = 31,
     intron = False,
     filter = True,
     UMI_bp = '0',
     barcode_bp = '0',
     transcript_bp = '0',
     whitelist_path = None,
     path_to_prefix_count_files = 'unfiltered_counts',
     memory = '4G'
)

````
#### Required parameters
___________________

| Parameter | Description |
| --- | --- |
|`list_of_fastqs` (str-list) | Python list of the paths to input FastQ files in the *order specified by Kallisto. The folder containing all the input files can be given instead and the relevant FastQ files will be captured and sorted in the correct order. To use this feature - input the path to the directory here (If multiple directories are used, input all the directories as a list), set input_directory = True and provide the strings used to separate the reads in the read_separator parameter. * See example above (working with more than one set of FastQ files) |
| `single_cell_technology` (str) | The single-cell sequencing technology that was used as *specified by Kallisto. If 10xv1 technology was used, the UMI_bp and barcode_bp parameters are required |
| `output_directory_path` (str) | Path to the main output directory where all files and new directories will be created and saved |
| `ERCC_fasta` (str) | Path to the ERCC FASTA file
| `species_index` (str) | Path to the kallisto_index for the species of interest. If the Kallisto index needs to be generated, set species_index = None, generate_index = True and species_fasta = "path/to/cDNA FASTA". |
| `species_t2g` (str) | Path to the transcript-to-genes mapping file for the species of interest. If the transcripts-to-genes mapping file needs to be generated, set species_t2g = None, generate_index = True and species_gtf = "path/to/GTF file". |
| `species_fasta` (str) | Path to the transcriptome (cDNA) FASTA file for the species of interest. This will be required if ERCCs are included in the dataset |


#### Optional parameters
___________________

| Parameter | Description |
| --- | --- |
| `input_directory` (bool) | Indicate whether the list_of_fastqs parameter is given the path to the directory containing all input FastQ files * See example above (working with more than one set of FastQ files) |
| `read_separator` (str-list) | The strings used to separate the input reads. Within a list - the first element should contain the string used to identify read 1, the second element should contain the string used to identify read 2 and if "10xv1" FastQ files are used, a third element is required that contains the string used to identify read 3. * See example above (working with more than one set of FastQ files) |
| `generate_index` (bool) | Indicate whether the Kallisto Index should be generated within the function. If set to True: the species_fasta and the species_gtf are required |
| `species_gtf` (str) | Path to the GTF file for the species of interest. This will be used to create the transcripts-to-genes mapping file. If generate_index is set to True, this parameter is required. |
| `k_mer_length` (int) | The length of the K-mers that should be generated when creating the Kallisto index |
| `intron` (bool) | Indicate whether or not to include intron transcript ids |
| `filter` (bool) | Indicate whether or not to filter the BUS file prior to generating the gene-count matrix in mtx format |
| `UMI_bp` (str) | The number of base pairs sequenced for the UMI sequence. If 10xv1 technology is used, this parameter is required |
| `barcode_bp` (str) | The number of base pairs sequenced for the barcode sequence. If 10xv1 technology is used, this parameter is required |
| `transcript_bp` (str) | The number of base pairs sequenced for the transcript sequence |
| `whitelist_path` (str) | Path to the barcode whitelist that will be used for barcode correction |
| `path_to_prefix_count_files` (str) | Prefix of the output matrix files and indices |
| `memory` (str) | Amount of memory to use |

* **Kallisto specified FastQ file order and single-cell technologies**

Please see table above

* **Working with more than one set of fastq files**

Please see description above


## `seurat_matrix`

This SASCRiP function is designed to check the input matrix and index files to make sure it is in the correct format for use with Seurat. If the input files are not in the correct format `seurat_matrix` rearranges the files and saves the new files in the specified output directory.  

#### Usage

````python
import SASCRiP
from SASCRiP import sascrip_functions

sascrip_functions.seurat_matrix(
     matrix_file,
     gene_index,
     barcode_index,
     output_directory,
     t2g_file = None,
     add_hgnc = True
)

````
#### Required parameters
___________________

| Parameters | Description |
| --- | --- |
| `matrix_file` (str) | Path to the mtx matrix file |
| `gene_index` (str) | Path to the gene index file |
| `barcode_index` (str) | Path to the barcode index file |
| `output_directory` (str) | Path to the output directory where the new matrix files will be saved, if new files are generated |
| `t2g_file` (str) | Path to the transcripts to genes file used for alignment or generated during alignment. To convert ENSG gene names to HGNC gene symbols this parameter is required and the add_hgnc parameter should be set to True |
| `add_hgnc` (bool) | Indicate whether to convert the ENSG gene names to HGNC gene symbols. If set to True, the t2g_file parameter is required |



## `run_cqc`

This is the main cell quality control function. `run_cqc` runs Seurat functions on the input Seurat-compatible mtx matrix and performs cell quality control through the use of filtering thresholds. Multiple parameters are included within this function to allow for many different types of inputs and outputs for integration with many other single-cell analysis tools

#### Usage

````python
import SASCRiP
from SASCRiP import sascrip_functions

sascrip_functions.run_cqc(
     input_file_or_folder,
     sample_ID,
     output_directory_path = "working_directory,
     generate_seurat_object = True,
     subset_seurat_object = True,
     generate_default_plots = True,
     gene_column = 1,
     input_seurat_object = False,
     transcripts_to_genes_file = None,
     gene_lower = 200,
     gene_higher_method = "MAD",
     gene_higher = "to_be_calculated",
     mitochondria_percent = 10,
     nMADs = 6,
     nSD = 6,
     extract_cell_metrics = False,
     output_matrix = False
)

````
#### Required parameters
___________________

| Parameter | Description |
| --- | --- |
| `input_file_or_folder` (str) | Path to the folder containing the Seurat-compatible matrices or path to the hdf5 file. Additionally, saved seurat objects in rds or rdata format can be input here. If a Seurat object is input, the input_seurat_object parameter must be set to True |
| `sample_ID` (str) | The name of the sample |

#### Optional parameters
___________________

| Parameter | Description |
| --- | --- |
| `output_directory_path` (str) | The path to the output directory where all output files and directories will be created and saved |
| `generate_seurat_object` (bool) | Indicate whether a seurat object should be generated from the input mtx matrix. If a Seurat object is input in the input_file_or_folder parameter, this parameter is required to be set to False. If a gene count matrix is input, this parameters is required to be set to True |
| `subset_seurat_object` (bool) | Indicate whether the Seurat object should be subset, removing low-quality cells identified by given thresholds |
| `generate_default_plots` (bool) | Indicate whether deafault plots should be generated to visualise the single-cell data and identified low-quality cells |
| `gene_column` (int) | The column number in the genes index file that should be used for the row names (gene names) in the Seurat object. 1-based |
| `input_seurat_object` (bool) | Indicate whether the input_file_or_folder parameter contains the path to a saved Seurat object. If so, this parameter should be set to True |
| `transcripts_to_genes_files` (str) | Path to the transcripts-to-genes mapping file that will allow ENSG gene names to be converted into corresponding HGNC gene symbols (within the seurat object) if required |
| `gene_lower` (int/None) | Minimum number of genes that should be detected in healthy cells. If this cell metric should not be used to identify low-quality cells then gene_lower should be set to None. However, if this parameter is set to None and generate_default_plots is set to True, a warning will be returned as the visualisations that use this threshold cannot be generated |
| `gene_higher_method` (str) | One of three methods - "MAD" (Median Absolute Deviation), "SD" (Standard Deviation), or "Manual" - that should be used to identify outliers using total gene count per cell. If Manual is selected, a value must be given for the gene_higher parameter |
| `gene_higher` (int/None) | Maximum number of genes that should be detected in single cells. If the gene_higher_method is set to "Manual", a value for gene_higher must be given. If this cell metric should not be used to identify cell doublets then gene_higher should be set to None. However, if this parameter is set to None and generate_default_plots is set to True, a warning will be returned as the visualisations that use this threshold cannot be generated |
| `mitochondria_percent` (int/None) | The maximum percentage of mitochondrial genes within a cell. If this cell metric should not be used to identify damaged cells then mitochondria_percent should be set to None. However, if this parameter is set to None and generate_default_plots is set to True, a warning will be returned as the visualisations that use this threshold cannot be generated |
| `nMADs` (int) | If the "MAD" method is selected in gene_higher_method, the value given to nMADs is used as the threshold to classify cells as outliers |
| `nSD` (int) | If the "SD" method is selected in gene_higher_method, the value given to nSD is used as the threshold to classify cells as outliers |
| `extract_cell_metrics` (bool) | Indicate whether to extract the calculated cell metrics as a .tsv file |
| `output_matrix (bool)` | Indicate whether to generate an mtx matrix file from the filtered Seurat data. This matrix will contain all healthy single cells characterised by the given thresholds |



## `stransform_normalize`

`sctransform_normalize` takes the raw UMI counts from healthy single cells (stored within a seurat object) and generates gene expression values using sctransform through Seurat. A saved Seurat object containing log normalised expression values as well as corrected counts. Additionally, the top 2000 highly variable genes are returned. This information is required for downstream analysis such as clustering or data integration. 

#### Usage

````python
import SASCRiP
from SASCRiP import sascrip_functions

sascrip_functions.sctransform_normalize(
     seurat_object,
     sample_ID,
     output_directory_path = "working_directory,
     output_log_matrix = False,
     output_count_matrix = False,
     transcripts_to_genes_file = None,
     **additional_sctransform_arguments
)

````
#### Required parameters
_________________________

| Parameter | Description |
| --- | --- |
| `seurat_object` (str) | Path to the saved filtered Seurat object |
| `sample_ID` (str) | Name of sample |


#### Optional parameters
________________________

| Parameter | Description |
| --- | --- |
| `output_directory_path` (str) | Path to the output directory where all generated files and dircetories will be saved |
| `output_log_matrix` (bool) | Indicate whether to additionally store the gene expression values per cell in an mtx matrix |
| `output_count_matrix` (bool) | Indicate whether to additionally store the corrected UMI counts in an mtx matrix |
| `transcripts_to_genes_files` (str) | Path to the transcripts-to-genes mapping file that will allow ENSG gene names to be converted into corresponding HGNC gene symbols (within the seurat object) if required |
| **additional_sctransform_arguments (dict) | Additional parameters (with key words) that should be passed to Seurat's SCTransform function - which additionally passes the parameters to the original stransform::vst function. In order to use parameter - the additional parameters to be passed should be in the form of a python dictionary where the key word is the parameter name (str) and the value is the given parameter value (in it's correct data type) - *see example below |

* Example when using additional_sctransform_arguments - To access the SCTransform parameter "conserve.memory" and set it to True:

```python

import SASCRiP
from SASCRiP import sascrip_functions

# Set up the dictionary for the additional parameters
additional_parameters = {"conserve.memory": True} # Note: If the parameter requires a boolean type, please use Pythons boolean datatype (True/False)

# Run sctransform_normalize with additional parameters
sascrip_functions.sctransform_normalize(
     seurat_object,
     sample_ID,
     **additional_parameters # Indicate the keyword dictionary using "**"
)

```


## `sascrip_preprocess`

`sascrip_preprocess` allows the user to run the entire single-cell RNA sequencing data pre-processing steps with one function. The sascrip_preprocess parameters can be customised to adjust the default settings. 

#### Usage

````python
import SASCRiP
from SASCRiP import sascrip_functions

sascrip_functions.sascrip_preprocess(
     output_directory_path,
     sample_ID,
     list_of_fastqs,
     single_cell_technology,
     species_index,
     species_t2g,
     input_directory = False,
     read_separator = None,
     filter = True,
     include_checkpoints = False,
     kallisto_bustools_count_parameters = None,
     run_cqc_parameters = None,
     additional_sctransform_arguments = None
)

````
#### Required parameters
___________________

| Parameter | Description |
| --- | --- |
| `output_directory` (str) | Path to the output directory where output files will be saved |
| `sample_ID` (str) | Name of the sample |
| `list_of_fastqs` (str-list) | Python list of the paths to input FastQ files in the *order specified by Kallisto. The folder containing all the input files can be given instead and the relevant FastQ files will be captured and sorted in the correct order. To use this feature - input the path to the directory here (If multiple directories are used, input all the directories as a list), set input_directory = True and provide the strings used to separate the reads in the read_separator parameter. * See example above (working with more than one set of FastQ files) |
| `single_cell_technology` (str) | The single-cell sequencing technology that was used as *specified by Kallisto. If 10xv1 technology was used, the UMI_bp and barcode_bp parameters are required |
| `species_index` (str) | Path to the kallisto_index for the species of interest. If no index is given (species_index = None), the default Kallisto index created using the GRCh 38 transcriptome assembly will be used. If the kallisto_index needs to be generated, set kallisto_index = None and create a keyword dictionary (as described for **additional_sctransform_arguments) for the following kallisto_bustools_count parameters; "generate_index", "species_fasta", "species_gtf". This dictionary should be created for kallisto_bustools_count_parameters |
| `species_t2g` (str) |  Path to the transcript-to-genes mapping file for the species of interest. If no mapping file is given, the default file created using the GRCh 38 GTF file will be used. If the transcripts-to-genes mapping file needs to be generated, set species_t2g = None. The dictionary supplied to kallisto_bustools_count_parameters will allow the kallisto_bustools_count function to create both the kallisto index and the transcripts-to-genes mapping file |        

#### Optional parameters
___________________

| Parameter | Description |
| --- | --- |
| `input_directory` (bool) | Indicate whether the list_of_fastqs parameter is given the path to the directory containing all input FastQ files * See example above (working with more than one set of FastQ files) |
| `read_separator` (str-list) | The strings used to separate the input reads. Within a list - the first element should contain the string used to identify read 1, the second element should contain the string used to identify read 2 and if "10xv1" FastQ files are used, a third element is required that contains the string used to identify read 3. * See example above (working with more than one set of FastQ files) |
| `filter` (bool) | Indicate whether to filter the BUS file prior to generating the count matrix |
| `include_checkpoints` (bool) | Indicate whether to print all log statements to standard output |
| `kallisto_bustools_count_parameters` (dict) | Any additional parameters to be adjusted for the kallisto_bustools_count function in the same format as described above for **additional_sctransform_arguments. In this case the ** is not needed |
| `run_cqc_parameters` (dict) | Any additional parameters to be adjusted for the run_cqc functions in the same format as described above for **additional_sctransform_arguments. In this case the ** is not needed |
| `additional_sctransform_arguments` (dict) | Additional parameters (with key words) that should be passed to Seurat's SCTransform function - which additionally passes the parameters to the original stransform::vst function. This dictionary should be created in the same format as previously described for this parameter. In this case the ** is not needed |


* **Kallisto specified FastQ file order and single-cell technologies**

Please see table above

* **Working with more than one set of fastq files**

Please see description above

## Authors

#### Darisia Moonsamy
email: darisia@outlook.com <br>
Institution: University of the Witwatersrand, Johannesburg, South Africa <br>
Department: School of Molecular and Cell Biology <br>
Research areas: Bioinformatics (genetics and immunology) <br>

#### Dr Nikki Gentle


## License

[GNU AGPL-3.0](https://opensource.org/licenses/AGPL-3.0)


## Reference
Bray, N. L., Pimentel, H., Melsted, P., & Pachter, L. (2016). Near-optimal probabilistic RNA-seq quantification. Nature biotechnology, 34(5), 525.

Melsted, P., Booeshaghi, A. S., Liu, L., Gao, F., Lu, L., Min, K. H., da Veiga Beltrame, E., Hjorleifsson, K. E., Gehring, J., & Pachter, L. (2021). Modular and efficient pre-processing of single-cell RNA-seq. Nature Biotechnology.

Stuart, T., Butler, A., Hoffman, P., Hafemeister, C., Papalexi, E., Mauck III, W.M., Hao, Y., Stoeckius, M., Smibert, P. and Satija, R., 2019. Comprehensive integration of single-cell data. Cell, 177(7), pp.1888-1902.

## Read next

#### [Seurat vignette: A guided clustering workflow](https://satijalab.org/seurat/articles/pbmc3k_tutorial.html) 

#### [Kallisto documentation](https://pachterlab.github.io/kallisto/manual)

#### [BUStools documentation](https://bustools.github.io/manual)



            

Raw data

            {
    "_id": null,
    "home_page": "https://github.com/Darisia/SASCRiP",
    "name": "SASCRiP",
    "maintainer": "",
    "docs_url": null,
    "requires_python": ">=3.7",
    "maintainer_email": "",
    "keywords": "single-cell RNA sequencing,data pre-processing,wrapper functions",
    "author": "Darisia Moonsamy",
    "author_email": "darisia@outlook.com",
    "download_url": "https://files.pythonhosted.org/packages/60/d8/4ec097fa24fd85ba6206de90bde64597c829f124a64434419c35a0e3334f/SASCRiP-1.1.0.tar.gz",
    "platform": null,
    "description": "# SASCRiP Documentation\nSequencing Analysis of Single-Cell RNA in Python (SASCRiP) is a python package with wrapper functions that use the widely used Seurat and BUStools to perform single-cell RNA sequencing data pre-processing and visualisation\n\n## Table of Contents\n1. [Installation](https://github.com/Darisia/SASCRiP/blob/main/README.md#installation)\n2. <details>\n     <summary><a href=\"https://github.com/Darisia/SASCRiP/blob/main/README.md#sascrip-functions:-user-guide\">SASCRiP functions: User guide</a></summary>\n     <br>\n     <a href=\"https://github.com/Darisia/SASCRiP/blob/main/README.md#edit_10xv1_fastq\">edit_10v1_fastq</a>\n     <br>\n     <a href=\"https://github.com/Darisia/SASCRiP/blob/main/README.md#check_ercc\">check_ercc</a>\n     <br>\n     <a href=\"https://github.com/Darisia/SASCRiP/blob/main/README.md#kallisto_bustools_count\">kallisto_bustools_count</a>\n     <br>\n     <a href=\"https://github.com/Darisia/SASCRiP/blob/main/README.md#include_ercc_bus_count\">include_ERCC_bus_count</a>\n     <br>\n     <a href=\"https://github.com/Darisia/SASCRiP/blob/main/README.md#run_cqc\">run_cqc</a>\n     <br>\n     <a href=\"https://github.com/Darisia/SASCRiP/blob/main/README.md#stransform_normalize\">sctransform_normalize</a>\n     <br>\n     <a href=\"https://github.com/Darisia/SASCRiP/blob/main/README.md#sascrip_preprocess\">sascrip_preprocess</a>\n     </details>\n3. [Authors](https://github.com/Darisia/SASCRiP#authors)\n4. [License](https://github.com/Darisia/SASCRiP#license)\n5. [Reference](https://github.com/Darisia/SASCRiP#reference)\n6. [Read next](https://github.com/Darisia/SASCRiP#read-next)\n\n\n## Installation\n\n### Requirements\n\nSASCRiP uses multiple single-cell analysis packages such as Seurat and kb-python. Since SASCRiP makes use of the R packages such as Seurat and Tidyverse for plotting, these packages are required. A full list of the requirements is shown below\n\n1. Python (>v3.7) is required to run SASCRiP functions\n2. R (>v3.6) is required to be installed \n3. Seurat R package (can be installed through SASCRiP)\n4. Tidyverse R package (can be installed through SASCRiP)\n5. kb-python (can be installed when SASCRiP is installed)\n\n### Installation code\n\nThe SASCRiP package can be installed using pip from the terminal\n\n```bash\n\npip install SASCRiP\n\n```\n\n## SASCRiP functions: User guide\n\n## `install_R_packages`\n\nThis function allows the user to install missing R packages that are required for SASCRiP to work. `install_R_packages` first checks if the package is installed and if not, install.packages() is run.\n\n#### Usage\n\n````python\nimport SASCRiP\nfrom SASCRiP import sascrip_functions\n\nsascrip_functions.install_R_packages()\n\n````  \n\n## `edit_10xv1_fastq`\n\n`edit_10xv1_fastq` prepares FastQ files, obtained using the 10xv1 sequencing chemistry, for input into Kallisto for pseudoalignment. The directory/s containing the FastQ files are input into `edit_10xv1_fastq` which searches for the RA FastQ file that contains both the UMI and transcript sequence. The UMI and Transcript sequences are separated into their own FastQ files. The directory/s containing all these FastQ files can be input into kallisto_bustools_count for further processing. The produced FastQ files will be saved in the same directory containing all the input FastQ files.\n\n#### Usage\n\n````python\nimport SASCRiP\nfrom SASCRiP import sascrip_functions\n\nsascrip_functions.edit_10xv1_fastq(input_directories)\n\n````\n\n#### Required parameters\n\n| Parameter | Description |\n| --- | --- |\n| `input_directories` (str-list) | Path to the directory/s containing the RA 10xv1 FastQ files. If there are more than one directories. A list should be given with all input directories |\n\n\n## `check_ercc`\n\n`check_ercc` allows the user to check if the single-cell dataset may contain RNA spike-ins that can be used as an additional cell-quality control metric. If `check_ercc is run`, True or False - depending on whether ERCCs are included or not, will be returned as standard output \n\n#### Usage\n\n````python\nimport SASCRiP\nfrom SASCRiP import sascrip_functions\n\nsascrip_functions.check_ercc(\n     ERCC_fasta,\n     output_directory_path,\n     list_of_fastqs,\n     single_cell_technology,\n     input_directory = False,\n     read_separator = None,\n     UMI_bp = '0',\n     barcode_bp = '0',\n     transcript_bp = '0'\n)\n\n````\n#### Required Parameters\n___________________\n\n\n| Parameter | Description |\n| --- | --- |\n| `ERCC_fasta` (str) | Path to the ERCC FASTA file |\n| `output_directory_path` (str) | Path to the output directory where output files will be saved |\n| `list_of_fastqs` (str-list) | Python list of the paths to input FastQ files in the *order specified by Kallisto. The folder containing all the input files can be given instead and the relevant FastQ files will be captured and sorted in the correct order. To use this feature - input the path to the directory here (If multiple directories are used, input all the directories as a list), set input_directory = True and provide the strings used to separate the reads in the read_separator parameter. * See example below |\n| `single_cell_technology` (str) | The single-cell sequencing technology that was used as *specified by Kallisto. If 10xv1 technology was used, the UMI_bp and barcode_bp parameters are required |\n\n#### Optional parameters\n___________________\n\n| Parameter | Description |\n| --- | --- |\n|`input_directory` (bool) | Indicate whether the list_of_fastqs parameter is given the path to the directory containing all input FastQ files * See example below |\n| `read_separator` (str-list) | The strings used to separate the input reads. Within a list - the first element should contain the string used to identify read 1, the second element should contain the string used to identify read 2 and if \"10xv1\" FastQ files are used, a third element is required that contains the string used to identify read 3. * See example below |\n| `UMI_bp` (str) | The number of base pairs sequenced for the UMI sequence. If 10xv1 technology is used, this parameter is required |\n| `barcode_bp` (str) | The number of base pairs sequenced for the barcode sequence. If 10xv1 technology is used, this parameter is required |\n| `transcript_bp` (str) | The number of base pairs sequenced for the transcript sequence |\n\n\n* **Kallisto specified FastQ file order and single-cell technologies**\n\n| Single-cell tech |     FastQ file order     |\n| ---------------- | ------------------------ |\n| 10xv1            | Transcript, UMI, barcode |\n| 10xv2            | barcode-UMI, Transcript  |\n| 10xv3            | barcode-UMI, Transcript  |\n| CELSeq           | barcode-UMI, Transcript  |\n| CELSeq2          | barcode-UMI, Transcript  |\n| DropSeq          | barcode-UMI, Transcript  |\n| inDrops          | barcode-UMI, Transcript  |\n| SCRBSeq          | barcode-UMI, Transcript  |\n| SureCell         | barcode-UMI, Transcript  |\n\n* **Working with more than one set of fastq files**\n\nInclude the additional sets in the fastq list, keeping the sets together. For example: if you have 2 sets of FastQ files from the 10xv2 chemistry\n\n```python\n\nlist_of_fastqs = [\"barcode_UMI_R1_1.fastq.gz\", \"Transcript_R2_1.fastq.gz\", \"barcode_UMI_R1_2.fastq.gz\", \"Transcript_R2_2.fastq.gz\"]\n\n```\nAdditionally, the directory/s containing all the relevant FastQ files can be given to the `list_of_fastqs` parameter and the FastQ files will be captured and sorted within the function, provided that `input_directory` is set to True and the `read_separator` is given. An example showing how these parameters should be set is shown below. \n\nTwo sets of FastQ files (as shown below) are contained within a directory called \"FastQ_directory\":\nbarcode_UMI_R1_1.fastq.gz\nTranscript_R2_1.fastq.gz\nbarcode_UMI_R1_2.fastq.gz\nTranscript_R2_2.fastq.gz\n\n```python\n\nlist_of_fastqs = \"path/to/FastQ_directory\"\ninput_directory = True\nread_separator = [\"R1\", \"R2\"]\n\n```\n\n\n## `kallisto_bustools_count`\n\nRuns both Kallisto and Bustools through kb-python to perform pseudoalignment and gene quantification respectively. `kallisto_bustools_count` generates unfiltered and filtered count matrices for the single-cell dataset of interest\n\n#### Usage\n\n````python\nimport SASCRiP\nfrom SASCRiP import sascrip_functions\n\nsascrip_functions.kallisto_bustools_count(\n     list_of_fastqs,\n     single_cell_technology,\n     output_directory_path,\n     species_index,\n     species_t2g,\n     input_directory = False,\n     read_separator = None,\n     generate_index = False,\n     species_fasta = None,\n     species_gtf = None,\n     k_mer_length = 31,\n     intron = False,\n     filter = True,\n     UMI_bp = '0',\n     barcode_bp = '0',\n     transcript_bp = '0',\n     whitelist_path = None,\n     path_to_prefix_count_files = 'unfiltered_counts',\n     memory = '4G'\n)\n\n````\n#### Required parameters\n___________________\n\n| Parameter | Description |\n| --- | --- |\n| `list_of_fastqs` (str-list) | Python list of the paths to input FastQ files in the *order specified by Kallisto. The folder containing all the input files can be given instead and the relevant FastQ files will be captured and sorted in the correct order. To use this feature - input the path to the directory here (If multiple directories are used, input all the directories as a list), set input_directory = True and provide the strings used to separate the reads in the read_separator parameter. * See example above (working with more than one set of FastQ files) |\n| `single_cell_technology` (str) | The single-cell sequencing technology that was used as *specified by Kallisto. If 10xv1 technology was used, the UMI_bp and barcode_bp parameters are required |\n| `output_directory_path` (str) | Path to the main output directory where all files and new directories will be created and saved |\n| `species_index` (str) | Path to the kallisto_index for the species of interest. If the Kallisto index needs to be generated, set species_index = None, generate_index = True and species_fasta = \"path/to/cDNA FASTA\". |\n| `species_t2g` (str) | Path to the transcript-to-genes mapping file for the species of interest. If the transcripts-to-genes mapping file needs to be generated, set species_t2g = None, generate_index = True and species_gtf = \"path/to/GTF file\". |\n\n\n#### Optional parameters\n___________________\n\n| Parameter | Description |\n| --- | --- |\n| `input_directory` (bool) | Indicate whether the list_of_fastqs parameter is given the path to the directory containing all input FastQ files * See example above (working with more than one set of FastQ files) |\n| `read_separator` (str-list) | The strings used to separate the input reads. Within a list - the first element should contain the string used to identify read 1, the second element should contain the string used to identify read 2 and if \"10xv1\" FastQ files are used, a third element is required that contains the string used to identify read 3. * See example above (working with more than one set of FastQ files) |\n| `generate_index` (bool) | Indicate whether the Kallisto Index should be generated within the function. If set to True: the species_fasta and the species_gtf are required |\n| `species_fasta` (str) | Path to the transcriptome (cDNA) FASTA file for the species of interest. This will be used to generate the Kallisto index. If generate_index is set to True, this parameter is required |\n| `species_gtf` (str) | Path to the GTF file for the species of interest. This will be used to create the transcripts-to-genes mapping file. If generate_index is set to True, this parameter is required. |\n| `k_mer_length` (int) | The length of the K-mers that should be generated when creating the Kallisto index |\n| `intron` (bool) | Indicate whether or not to include intron transcript ids |\n| `filter` (bool) | Indicate whether or not to filter the BUS file prior to generating the gene-count matrix in mtx format |\n| `UMI_bp` (str) | The number of base pairs sequenced for the UMI sequence. If 10xv1 technology is used, this parameter is required |\n| `barcode_bp` (str) | The number of base pairs sequenced for the barcode sequence. If 10xv1 technology is used, this parameter is required |\n| `transcript_bp` (str) | The number of base pairs sequenced for the transcript sequence |\n| `whitelist_path` (str) | Path to the barcode whitelist that will be used for barcode correction |\n| `path_to_prefix_count_files` (str) | Prefix of the output matrix files and indices |\n| `memory` (str) | Amount of memory to use |\n\n\n* **Kallisto specified FastQ file order and single-cell technologies**\n\nPlease see table above\n\n* **Working with more than one set of fastq files**\n\nPlease see description above\n\n\n## `include_ERCC_bus_count`\n\n`include_ERCC_bus_count` first checks if ERCC spike-ins are included in the dataset and generates counts with `kallisto_bustools_count` accordingly. To check if spike-ins are present, a Kallisto index is generated from the ERCC FASTA and the FastQ sequences from the dataset are aligned to the ERCC index. if no sequences align to the ERCC index, the gene-count matrix will be generated without including ERCC sequences. However, if there are seqeunces that align to the ERCC index, the ERCC FASTA seqeunce and the species FASTA sequence will be combined to create a new kallisto index. Therefore, the final gene-count matrix will include ERCC sequences.\n\n#### Usage\n\n````python\nimport SASCRiP\nfrom SASCRiP import sascrip_functions\n\nsascrip_functions.include_ERCC_bus_count(\n     list_of_fastqs,\n     single_cell_technology,\n     output_directory_path,\n     ERCC_fasta,\n     species_index,\n     species_t2g,\n     species_fasta,\n     input_directory = False,\n     read_separator = None,\n     generate_index = False,\n     species_gtf = None,\n     k_mer_length = 31,\n     intron = False,\n     filter = True,\n     UMI_bp = '0',\n     barcode_bp = '0',\n     transcript_bp = '0',\n     whitelist_path = None,\n     path_to_prefix_count_files = 'unfiltered_counts',\n     memory = '4G'\n)\n\n````\n#### Required parameters\n___________________\n\n| Parameter | Description |\n| --- | --- |\n|`list_of_fastqs` (str-list) | Python list of the paths to input FastQ files in the *order specified by Kallisto. The folder containing all the input files can be given instead and the relevant FastQ files will be captured and sorted in the correct order. To use this feature - input the path to the directory here (If multiple directories are used, input all the directories as a list), set input_directory = True and provide the strings used to separate the reads in the read_separator parameter. * See example above (working with more than one set of FastQ files) |\n| `single_cell_technology` (str) | The single-cell sequencing technology that was used as *specified by Kallisto. If 10xv1 technology was used, the UMI_bp and barcode_bp parameters are required |\n| `output_directory_path` (str) | Path to the main output directory where all files and new directories will be created and saved |\n| `ERCC_fasta` (str) | Path to the ERCC FASTA file\n| `species_index` (str) | Path to the kallisto_index for the species of interest. If the Kallisto index needs to be generated, set species_index = None, generate_index = True and species_fasta = \"path/to/cDNA FASTA\". |\n| `species_t2g` (str) | Path to the transcript-to-genes mapping file for the species of interest. If the transcripts-to-genes mapping file needs to be generated, set species_t2g = None, generate_index = True and species_gtf = \"path/to/GTF file\". |\n| `species_fasta` (str) | Path to the transcriptome (cDNA) FASTA file for the species of interest. This will be required if ERCCs are included in the dataset |\n\n\n#### Optional parameters\n___________________\n\n| Parameter | Description |\n| --- | --- |\n| `input_directory` (bool) | Indicate whether the list_of_fastqs parameter is given the path to the directory containing all input FastQ files * See example above (working with more than one set of FastQ files) |\n| `read_separator` (str-list) | The strings used to separate the input reads. Within a list - the first element should contain the string used to identify read 1, the second element should contain the string used to identify read 2 and if \"10xv1\" FastQ files are used, a third element is required that contains the string used to identify read 3. * See example above (working with more than one set of FastQ files) |\n| `generate_index` (bool) | Indicate whether the Kallisto Index should be generated within the function. If set to True: the species_fasta and the species_gtf are required |\n| `species_gtf` (str) | Path to the GTF file for the species of interest. This will be used to create the transcripts-to-genes mapping file. If generate_index is set to True, this parameter is required. |\n| `k_mer_length` (int) | The length of the K-mers that should be generated when creating the Kallisto index |\n| `intron` (bool) | Indicate whether or not to include intron transcript ids |\n| `filter` (bool) | Indicate whether or not to filter the BUS file prior to generating the gene-count matrix in mtx format |\n| `UMI_bp` (str) | The number of base pairs sequenced for the UMI sequence. If 10xv1 technology is used, this parameter is required |\n| `barcode_bp` (str) | The number of base pairs sequenced for the barcode sequence. If 10xv1 technology is used, this parameter is required |\n| `transcript_bp` (str) | The number of base pairs sequenced for the transcript sequence |\n| `whitelist_path` (str) | Path to the barcode whitelist that will be used for barcode correction |\n| `path_to_prefix_count_files` (str) | Prefix of the output matrix files and indices |\n| `memory` (str) | Amount of memory to use |\n\n* **Kallisto specified FastQ file order and single-cell technologies**\n\nPlease see table above\n\n* **Working with more than one set of fastq files**\n\nPlease see description above\n\n\n## `seurat_matrix`\n\nThis SASCRiP function is designed to check the input matrix and index files to make sure it is in the correct format for use with Seurat. If the input files are not in the correct format `seurat_matrix` rearranges the files and saves the new files in the specified output directory.  \n\n#### Usage\n\n````python\nimport SASCRiP\nfrom SASCRiP import sascrip_functions\n\nsascrip_functions.seurat_matrix(\n     matrix_file,\n     gene_index,\n     barcode_index,\n     output_directory,\n     t2g_file = None,\n     add_hgnc = True\n)\n\n````\n#### Required parameters\n___________________\n\n| Parameters | Description |\n| --- | --- |\n| `matrix_file` (str) | Path to the mtx matrix file |\n| `gene_index` (str) | Path to the gene index file |\n| `barcode_index` (str) | Path to the barcode index file |\n| `output_directory` (str) | Path to the output directory where the new matrix files will be saved, if new files are generated |\n| `t2g_file` (str) | Path to the transcripts to genes file used for alignment or generated during alignment. To convert ENSG gene names to HGNC gene symbols this parameter is required and the add_hgnc parameter should be set to True |\n| `add_hgnc` (bool) | Indicate whether to convert the ENSG gene names to HGNC gene symbols. If set to True, the t2g_file parameter is required |\n\n\n\n## `run_cqc`\n\nThis is the main cell quality control function. `run_cqc` runs Seurat functions on the input Seurat-compatible mtx matrix and performs cell quality control through the use of filtering thresholds. Multiple parameters are included within this function to allow for many different types of inputs and outputs for integration with many other single-cell analysis tools\n\n#### Usage\n\n````python\nimport SASCRiP\nfrom SASCRiP import sascrip_functions\n\nsascrip_functions.run_cqc(\n     input_file_or_folder,\n     sample_ID,\n     output_directory_path = \"working_directory,\n     generate_seurat_object = True,\n     subset_seurat_object = True,\n     generate_default_plots = True,\n     gene_column = 1,\n     input_seurat_object = False,\n     transcripts_to_genes_file = None,\n     gene_lower = 200,\n     gene_higher_method = \"MAD\",\n     gene_higher = \"to_be_calculated\",\n     mitochondria_percent = 10,\n     nMADs = 6,\n     nSD = 6,\n     extract_cell_metrics = False,\n     output_matrix = False\n)\n\n````\n#### Required parameters\n___________________\n\n| Parameter | Description |\n| --- | --- |\n| `input_file_or_folder` (str) | Path to the folder containing the Seurat-compatible matrices or path to the hdf5 file. Additionally, saved seurat objects in rds or rdata format can be input here. If a Seurat object is input, the input_seurat_object parameter must be set to True |\n| `sample_ID` (str) | The name of the sample |\n\n#### Optional parameters\n___________________\n\n| Parameter | Description |\n| --- | --- |\n| `output_directory_path` (str) | The path to the output directory where all output files and directories will be created and saved |\n| `generate_seurat_object` (bool) | Indicate whether a seurat object should be generated from the input mtx matrix. If a Seurat object is input in the input_file_or_folder parameter, this parameter is required to be set to False. If a gene count matrix is input, this parameters is required to be set to True |\n| `subset_seurat_object` (bool) | Indicate whether the Seurat object should be subset, removing low-quality cells identified by given thresholds |\n| `generate_default_plots` (bool) | Indicate whether deafault plots should be generated to visualise the single-cell data and identified low-quality cells |\n| `gene_column` (int) | The column number in the genes index file that should be used for the row names (gene names) in the Seurat object. 1-based |\n| `input_seurat_object` (bool) | Indicate whether the input_file_or_folder parameter contains the path to a saved Seurat object. If so, this parameter should be set to True |\n| `transcripts_to_genes_files` (str) | Path to the transcripts-to-genes mapping file that will allow ENSG gene names to be converted into corresponding HGNC gene symbols (within the seurat object) if required |\n| `gene_lower` (int/None) | Minimum number of genes that should be detected in healthy cells. If this cell metric should not be used to identify low-quality cells then gene_lower should be set to None. However, if this parameter is set to None and generate_default_plots is set to True, a warning will be returned as the visualisations that use this threshold cannot be generated |\n| `gene_higher_method` (str) | One of three methods - \"MAD\" (Median Absolute Deviation), \"SD\" (Standard Deviation), or \"Manual\" - that should be used to identify outliers using total gene count per cell. If Manual is selected, a value must be given for the gene_higher parameter |\n| `gene_higher` (int/None) | Maximum number of genes that should be detected in single cells. If the gene_higher_method is set to \"Manual\", a value for gene_higher must be given. If this cell metric should not be used to identify cell doublets then gene_higher should be set to None. However, if this parameter is set to None and generate_default_plots is set to True, a warning will be returned as the visualisations that use this threshold cannot be generated |\n| `mitochondria_percent` (int/None) | The maximum percentage of mitochondrial genes within a cell. If this cell metric should not be used to identify damaged cells then mitochondria_percent should be set to None. However, if this parameter is set to None and generate_default_plots is set to True, a warning will be returned as the visualisations that use this threshold cannot be generated |\n| `nMADs` (int) | If the \"MAD\" method is selected in gene_higher_method, the value given to nMADs is used as the threshold to classify cells as outliers |\n| `nSD` (int) | If the \"SD\" method is selected in gene_higher_method, the value given to nSD is used as the threshold to classify cells as outliers |\n| `extract_cell_metrics` (bool) | Indicate whether to extract the calculated cell metrics as a .tsv file |\n| `output_matrix (bool)` | Indicate whether to generate an mtx matrix file from the filtered Seurat data. This matrix will contain all healthy single cells characterised by the given thresholds |\n\n\n\n## `stransform_normalize`\n\n`sctransform_normalize` takes the raw UMI counts from healthy single cells (stored within a seurat object) and generates gene expression values using sctransform through Seurat. A saved Seurat object containing log normalised expression values as well as corrected counts. Additionally, the top 2000 highly variable genes are returned. This information is required for downstream analysis such as clustering or data integration. \n\n#### Usage\n\n````python\nimport SASCRiP\nfrom SASCRiP import sascrip_functions\n\nsascrip_functions.sctransform_normalize(\n     seurat_object,\n     sample_ID,\n     output_directory_path = \"working_directory,\n     output_log_matrix = False,\n     output_count_matrix = False,\n     transcripts_to_genes_file = None,\n     **additional_sctransform_arguments\n)\n\n````\n#### Required parameters\n_________________________\n\n| Parameter | Description |\n| --- | --- |\n| `seurat_object` (str) | Path to the saved filtered Seurat object |\n| `sample_ID` (str) | Name of sample |\n\n\n#### Optional parameters\n________________________\n\n| Parameter | Description |\n| --- | --- |\n| `output_directory_path` (str) | Path to the output directory where all generated files and dircetories will be saved |\n| `output_log_matrix` (bool) | Indicate whether to additionally store the gene expression values per cell in an mtx matrix |\n| `output_count_matrix` (bool) | Indicate whether to additionally store the corrected UMI counts in an mtx matrix |\n| `transcripts_to_genes_files` (str) | Path to the transcripts-to-genes mapping file that will allow ENSG gene names to be converted into corresponding HGNC gene symbols (within the seurat object) if required |\n| **additional_sctransform_arguments (dict) | Additional parameters (with key words) that should be passed to Seurat's SCTransform function - which additionally passes the parameters to the original stransform::vst function. In order to use parameter - the additional parameters to be passed should be in the form of a python dictionary where the key word is the parameter name (str) and the value is the given parameter value (in it's correct data type) - *see example below |\n\n* Example when using additional_sctransform_arguments - To access the SCTransform parameter \"conserve.memory\" and set it to True:\n\n```python\n\nimport SASCRiP\nfrom SASCRiP import sascrip_functions\n\n# Set up the dictionary for the additional parameters\nadditional_parameters = {\"conserve.memory\": True} # Note: If the parameter requires a boolean type, please use Pythons boolean datatype (True/False)\n\n# Run sctransform_normalize with additional parameters\nsascrip_functions.sctransform_normalize(\n     seurat_object,\n     sample_ID,\n     **additional_parameters # Indicate the keyword dictionary using \"**\"\n)\n\n```\n\n\n## `sascrip_preprocess`\n\n`sascrip_preprocess` allows the user to run the entire single-cell RNA sequencing data pre-processing steps with one function. The sascrip_preprocess parameters can be customised to adjust the default settings. \n\n#### Usage\n\n````python\nimport SASCRiP\nfrom SASCRiP import sascrip_functions\n\nsascrip_functions.sascrip_preprocess(\n     output_directory_path,\n     sample_ID,\n     list_of_fastqs,\n     single_cell_technology,\n     species_index,\n     species_t2g,\n     input_directory = False,\n     read_separator = None,\n     filter = True,\n     include_checkpoints = False,\n     kallisto_bustools_count_parameters = None,\n     run_cqc_parameters = None,\n     additional_sctransform_arguments = None\n)\n\n````\n#### Required parameters\n___________________\n\n| Parameter | Description |\n| --- | --- |\n| `output_directory` (str) | Path to the output directory where output files will be saved |\n| `sample_ID` (str) | Name of the sample |\n| `list_of_fastqs` (str-list) | Python list of the paths to input FastQ files in the *order specified by Kallisto. The folder containing all the input files can be given instead and the relevant FastQ files will be captured and sorted in the correct order. To use this feature - input the path to the directory here (If multiple directories are used, input all the directories as a list), set input_directory = True and provide the strings used to separate the reads in the read_separator parameter. * See example above (working with more than one set of FastQ files) |\n| `single_cell_technology` (str) | The single-cell sequencing technology that was used as *specified by Kallisto. If 10xv1 technology was used, the UMI_bp and barcode_bp parameters are required |\n| `species_index` (str) | Path to the kallisto_index for the species of interest. If no index is given (species_index = None), the default Kallisto index created using the GRCh 38 transcriptome assembly will be used. If the kallisto_index needs to be generated, set kallisto_index = None and create a keyword dictionary (as described for **additional_sctransform_arguments) for the following kallisto_bustools_count parameters; \"generate_index\", \"species_fasta\", \"species_gtf\". This dictionary should be created for kallisto_bustools_count_parameters |\n| `species_t2g` (str) |  Path to the transcript-to-genes mapping file for the species of interest. If no mapping file is given, the default file created using the GRCh 38 GTF file will be used. If the transcripts-to-genes mapping file needs to be generated, set species_t2g = None. The dictionary supplied to kallisto_bustools_count_parameters will allow the kallisto_bustools_count function to create both the kallisto index and the transcripts-to-genes mapping file |        \n\n#### Optional parameters\n___________________\n\n| Parameter | Description |\n| --- | --- |\n| `input_directory` (bool) | Indicate whether the list_of_fastqs parameter is given the path to the directory containing all input FastQ files * See example above (working with more than one set of FastQ files) |\n| `read_separator` (str-list) | The strings used to separate the input reads. Within a list - the first element should contain the string used to identify read 1, the second element should contain the string used to identify read 2 and if \"10xv1\" FastQ files are used, a third element is required that contains the string used to identify read 3. * See example above (working with more than one set of FastQ files) |\n| `filter` (bool) | Indicate whether to filter the BUS file prior to generating the count matrix |\n| `include_checkpoints` (bool) | Indicate whether to print all log statements to standard output |\n| `kallisto_bustools_count_parameters` (dict) | Any additional parameters to be adjusted for the kallisto_bustools_count function in the same format as described above for **additional_sctransform_arguments. In this case the ** is not needed |\n| `run_cqc_parameters` (dict) | Any additional parameters to be adjusted for the run_cqc functions in the same format as described above for **additional_sctransform_arguments. In this case the ** is not needed |\n| `additional_sctransform_arguments` (dict) | Additional parameters (with key words) that should be passed to Seurat's SCTransform function - which additionally passes the parameters to the original stransform::vst function. This dictionary should be created in the same format as previously described for this parameter. In this case the ** is not needed |\n\n\n* **Kallisto specified FastQ file order and single-cell technologies**\n\nPlease see table above\n\n* **Working with more than one set of fastq files**\n\nPlease see description above\n\n## Authors\n\n#### Darisia Moonsamy\nemail: darisia@outlook.com <br>\nInstitution: University of the Witwatersrand, Johannesburg, South Africa <br>\nDepartment: School of Molecular and Cell Biology <br>\nResearch areas: Bioinformatics (genetics and immunology) <br>\n\n#### Dr Nikki Gentle\n\n\n## License\n\n[GNU AGPL-3.0](https://opensource.org/licenses/AGPL-3.0)\n\n\n## Reference\nBray, N. L., Pimentel, H., Melsted, P., & Pachter, L. (2016). Near-optimal probabilistic RNA-seq quantification. Nature biotechnology, 34(5), 525.\n\nMelsted, P., Booeshaghi, A. S., Liu, L., Gao, F., Lu, L., Min, K. H., da Veiga Beltrame, E., Hjorleifsson, K. E., Gehring, J., & Pachter, L. (2021). Modular and efficient pre-processing of single-cell RNA-seq. Nature Biotechnology.\n\nStuart, T., Butler, A., Hoffman, P., Hafemeister, C., Papalexi, E., Mauck III, W.M., Hao, Y., Stoeckius, M., Smibert, P. and Satija, R., 2019. Comprehensive integration of single-cell data. Cell, 177(7), pp.1888-1902.\n\n## Read next\n\n#### [Seurat vignette: A guided clustering workflow](https://satijalab.org/seurat/articles/pbmc3k_tutorial.html) \n\n#### [Kallisto documentation](https://pachterlab.github.io/kallisto/manual)\n\n#### [BUStools documentation](https://bustools.github.io/manual)\n\n\n",
    "bugtrack_url": null,
    "license": "",
    "summary": "A python package with wrapper functions that use the widely used Seurat and BUStools to perform single-cell RNA sequencing data pre-processing and visualisation",
    "version": "1.1.0",
    "project_urls": {
        "Homepage": "https://github.com/Darisia/SASCRiP"
    },
    "split_keywords": [
        "single-cell rna sequencing",
        "data pre-processing",
        "wrapper functions"
    ],
    "urls": [
        {
            "comment_text": "",
            "digests": {
                "blake2b_256": "405e85ce4257b20fc859bdd815cd6cba2f0711fcd892bfffc89813f496941fb8",
                "md5": "30b4736ae804ab06d15a3c3ea5923d51",
                "sha256": "bae7c8481677b88366fc62f8a1fbaebcc0629b527ab52b26381a217c0e3537c1"
            },
            "downloads": -1,
            "filename": "SASCRiP-1.1.0-py3-none-any.whl",
            "has_sig": false,
            "md5_digest": "30b4736ae804ab06d15a3c3ea5923d51",
            "packagetype": "bdist_wheel",
            "python_version": "py3",
            "requires_python": ">=3.7",
            "size": 37570,
            "upload_time": "2024-02-16T04:31:28",
            "upload_time_iso_8601": "2024-02-16T04:31:28.377947Z",
            "url": "https://files.pythonhosted.org/packages/40/5e/85ce4257b20fc859bdd815cd6cba2f0711fcd892bfffc89813f496941fb8/SASCRiP-1.1.0-py3-none-any.whl",
            "yanked": false,
            "yanked_reason": null
        },
        {
            "comment_text": "",
            "digests": {
                "blake2b_256": "60d84ec097fa24fd85ba6206de90bde64597c829f124a64434419c35a0e3334f",
                "md5": "19975dc3ecf135fbcde1c1c61e4b0d91",
                "sha256": "591cf7d166b2b1c5ca2830231011d7dcce6947050f1a486edea304df23261759"
            },
            "downloads": -1,
            "filename": "SASCRiP-1.1.0.tar.gz",
            "has_sig": false,
            "md5_digest": "19975dc3ecf135fbcde1c1c61e4b0d91",
            "packagetype": "sdist",
            "python_version": "source",
            "requires_python": ">=3.7",
            "size": 28462,
            "upload_time": "2024-02-16T04:31:30",
            "upload_time_iso_8601": "2024-02-16T04:31:30.703974Z",
            "url": "https://files.pythonhosted.org/packages/60/d8/4ec097fa24fd85ba6206de90bde64597c829f124a64434419c35a0e3334f/SASCRiP-1.1.0.tar.gz",
            "yanked": false,
            "yanked_reason": null
        }
    ],
    "upload_time": "2024-02-16 04:31:30",
    "github": true,
    "gitlab": false,
    "bitbucket": false,
    "codeberg": false,
    "github_user": "Darisia",
    "github_project": "SASCRiP",
    "travis_ci": false,
    "coveralls": false,
    "github_actions": false,
    "lcname": "sascrip"
}
        
Elapsed time: 0.17392s