- bulk
a matrix or data.frame of unnormalizaed & untransformed bulk RNA-seq gene expression values with rows representing genes, columns
representing samples
- ref
a matrix or data.frame of untransformed scRNA-seq gene expression counts with rows representing genes, columns representing cells.
This data will be used to deconvolute provided bulk RNA-seq data.
- phenodata
a data.frame with rows representing cells, columns representing cell attributes. It should at least contain the first three
columns as:
cell barcodes
cell types
subject ids
- filter_ref
logical value indicating whether outlier genes & cells should be removed from the provided reference data. Defaults to TRUE
- marker_genes
a data.frame of two columns. First column represents cell types in ref; second column represents gene names of marker genes. If specified,
those genes will be used to construct signature matrix for mark-gene based deconvolution methods, such as CIBERSORT, OLS, nnls, FARDEEP and RLR. Default to NULL,
carry out differential analysis to identify marker genes for each cell type in ref.
- genes_to_remove
a vector of gene names to remove from the reference scRNA-seq data. Default to NULL.
- min_pct_ct
a numeric value indicating the minimum required proportion of expressing cells per cell type for marker gene identification. Only applicable when marker_genes
is NULL. Default to 0.05.
- decon_method
character value specifying the deconvolution method to use. Has to be one of "scaden", "CIBERSORT", "OLS", "nnls", "FARDEEP", "RLR",
"MuSiC", "SCDC", "scTAPE". See details for more information.
- norm_method_sc
character value specifying the normalization method to use for reference data. Has to be one of "none","LogNormalize",
"SCTransform", "scran", "scater", "Linnorm". See details for more information.
- norm_method_bulk
character value specifying the normalization method to use for bulk data. Has to be one of "none", "TMM",
"median_ratios", "TPM". See details for more information.
- trans_method_sc
character value specifying the transformation method to use for both bulk & reference data. Has to be one of "none", "log2", "sqrt",
"vst". See details for more information.
- trans_method_bulk
character value specifying the transformation method to use for both bulk & reference data. Has to be one of "none", "log2", "sqrt",
"vst". See details for more information.
- gene_length
a data.frame with two columns. The first column represents gene names that match with provided bulk data. The second column
represents length of each gene. Only applicable when norm_method is selected as "TPM".
- lfc_markers
log2 fold change cutoff used to identify marker genes for deconvolution. The option only applicable to marker-gene based
approaches, such as CIBERSORT, OLS, nnls, FARDEEP and RLR. Only applicable when marker_genes is NULL.
- marker_strategy
further strategy in selecting marker genes besides applying the log2 fold change cutoff. Can be chosen from: "all", "pos_fc",
"top_50p_logFC" or "top_50p_AveExpr". See details for more information. Only applicable when marker_genes is NULL.
- to_remove
character value representing the cell type to remove from reference data. Only applicable to simulation experiments in evaluating
effect of cell type removal from reference.
- ffpe_artifacts
logical value indicating whether to add simulated ffpe artifacts in the bulk data. Only applicable to simulation experiments in
evaluating the effect of FFPE artifacts.
- model
pre-constructed ffpe model data. Can be downloaded from github: https://github.com/Liuy12/SCdeconR/blob/master/data/ffpemodel.rda.
- prop
a matrix or data.frame of simulated cell proportion values with rows representing cell types, columns representing samples. Only applicable to simulation
experiments in evaluating the effect of cell type removal from reference.
- cibersortpath
full path to CIBERSORT.R script.
- pythonpath
full path to python binary where scaden was installed with.
- tmpdir
temporary processing directory for scaden or scTAPE.
- remove_tmpdir
a logical value indicating whether to remove tmpdir once scaden is completed. Default to TRUE.
- seed
random seed used for simulating FFPE artifacts. Only applicable when ffpe_artifacts is set to TRUE.
- nsamples
number of artificial bulk samples to simulate for scaden. Default to 1000.
- return_value_only
return a list of values only without performing deconvolution. This could be helpful in
cases where the user want to apply their own deconvolution algorithms. Default to FALSE.
- verbose
a logical value indicating whether to print messages. Default to FALSE.