Description Usage Arguments Value Author(s) See Also Examples
View source: R/SwarnUnadjLRT.R
This function is used to detect differentially expressed genes between two specified groups of cells in a raw read counts matrix of single-cell RNA-seq (scRNA-seq) data without adjustment for capture efficiency. It takes a non-negative integer matrix of scRNA-seq raw read counts object as input. So users should map the reads (obtained from sequencing libraries of the samples) to the corresponding genome and count the reads mapped to each gene according to the gene annotation to get the raw read counts matrix in advance.
1 2 3 4 5 6 7 8 9 10 11 12 13 14 | SwarnUnadjLRT(
CountData,
parallel,
norm.method,
group,
CellCluster,
CellAuxil,
maxit,
eps,
muoffset,
phioffset,
weights,
p.adjust.method
)
|
CountData |
Observed count data matrix for genes, rows represent genes, columns represent cells. |
parallel |
If FALSE (default), no parallel computation is used; if TRUE, parallel computation is performed. |
norm.method |
Method for normalizing the scRNA-seq count expression data, either 'DESeq2' (maximum likelihood, Ye et al., 2017) or 'TMM' (Robinson et al., 2010). |
group |
Vector which specifies the membership of the cells, i.e. two groups to be compared, corresponding to the columns in the count data matrix. |
CellCluster |
Vector which specifies the cluster memberships of the cells, i.e. each entry represents memberships of the columns of the count data matrix. |
CellAuxil |
Vector of cell level auxiliary information, corresponding to the columns in the counts matrix, default is NULL. |
maxit |
Maximum number of iterations for Expected-Maximization (EM) algorithm. |
eps |
Convergennce criteria for EM algorithm. |
muoffset |
Offset parameter for mean (mu) parameter, default is NULL. |
phioffset |
Offset parameter for zero inflation (phi) parameter, default is NULL. |
weights |
Observation wise weights for the cells, default is unity vector. |
p.adjust.method |
Character variable represents the method used for multiple hypothesis correction. It can be any value from ("holm", "hochberg", "hommel", "bonferroni", "BH", "BY"). |
A data frame containing the results from differential expression analysis, rows are genes and columns contain the following items:
1 totalMean_1, totalMean_2, NormMean_1, NormMean_2 are the total mean, normalized mean for cellular groups 1 and 2 respectively.
2 FoldChange, log2FC, NormFC, log2NormFC are the fold change, log fold change, and log normalized fold change for the genes respectively.
3 Stat.DE, Pval.DE, DE.Adj.pval, and DE.FDR are values of DE statistic, p-value, adjusted p-value, false discovery rate, obtained from DE analysis, for the genes.
4 Stat.DZI, Pval.DZI, DZI.Adj.pval, DZI.FDR are Differential Zero Inflation (DZI) statistic, DZI p-value, DZI adjusted p-value, DZI false discovery rate results obtained for each gene from DZI analysis.
Samarendra Das
TestData
, a test dataset for SwarnSeq.
dzinb
, dzinb funcion in SwarnSeq.
ZINBEM
, Expected-Maximization (EM) algorithm in SwarnSeq.
SwarnUnadjSeq
, SwarnUnadjSeq function in SwarnSeq.
1 2 3 4 5 6 7 8 9 10 11 12 13 14 15 16 17 | #Load the test count data, spike-in counts and spike-in concentration data for SwarnSeq.
data(TestData)
counts <- TestData$CountData
#specifying the group information, the group 1 and 2 have two hundred cells each.
group <- c(rep(1, 200), rep(2, 200))
#Specifying the cluster memberships of the cells in columns of countData.
cellcluster <- c(rep(1, 60), rep(2, 40), rep(3, 50),
rep(4, 50), rep(5, 30),
rep(6, 90),
rep(7, 80))
#Do not run
#parameters from EM algorithm for each gene.
#results <- SwarnUnadjLRT(CountData=counts, parallel=FALSE, norm.method="TMM", group=group,
# CellCluster=cellcluster, CellAuxil=NULL, maxit=500, eps=1e-10,
#muoffset=NULL, phioffset=NULL, weights=NULL, p.adjust.method="hochberg")
|
Add the following code to your website.
For more information on customizing the embed code, read Embedding Snippets.