Title: | Robust Outlier-aware Estimation of Composition and Heterogeneity for Single-cell Data |
---|---|
Description: | A robust and outlier-aware method for testing differential tissue composition from single-cell data. This model can infer changes in tissue composition and heterogeneity, and can produce realistic data simulations based on any existing dataset. This model can also transfer knowledge from a large set of integrated datasets to increase accuracy further. |
Authors: | Stefano Mangiola [aut, cre] |
Maintainer: | Stefano Mangiola <[email protected]> |
License: | GPL-3 |
Version: | 1.11.0 |
Built: | 2024-10-31 04:39:56 UTC |
Source: | https://github.com/bioc/sccomp |
A tidy example dataset containing cell counts per cell group (cluster), sample, and phenotype for differential analysis. This dataset represents the counts of cells in various phenotypes and cell groups across multiple samples.
data(counts_obj)
data(counts_obj)
A tidy data frame with the following columns:
sample: Factor, representing the sample identifier.
type: Factor, indicating the sample type (e.g., benign, cancerous).
phenotype: Factor, representing the cell phenotype (e.g., B_cell, HSC, etc.).
count: Integer, representing the number of cells for each cell group within each sample.
cell_group: Factor, representing the cell group (e.g., BM, B1, Dm, etc.).
A tibble
representing cell counts per cluster, with columns for sample, type, phenotype, cell group, and counts.
This function retrieves the number of output samples from a Stan fit object, supporting different methods (MHC and Variational) based on the available data within the object.
get_output_samples(fit)
get_output_samples(fit)
fit |
A |
The number of output samples used in the Stan model. Returns from MHC if available, otherwise from Variational inference.
# Assuming 'fit' is a stanfit object obtained from running a Stan model print("samples_count = get_output_samples(fit)")
# Assuming 'fit' is a stanfit object obtained from running a Stan model print("samples_count = get_output_samples(fit)")
A custom ggplot2
theme used for creating publication-quality multi-panel plots. This theme modifies the appearance of plots by adjusting text sizes, spacing between panels, and axis formatting, ensuring better readability for complex figures.
data(multipanel_theme)
data(multipanel_theme)
A ggplot2
theme with the following adjustments:
text: Font size adjustments for plot titles, axis labels, and legend text.
panel.spacing: Adjusts the spacing between panels in multi-panel plots.
axis.text: Customises axis text appearance for better readability.
A ggplot2
theme object.
This function creates a series of 1D interval plots for cell-group effects, highlighting significant differences based on a given significance threshold.
plot_1D_intervals( .data, significance_threshold = 0.05, test_composition_above_logit_fold_change = attr(.data, "test_composition_above_logit_fold_change") )
plot_1D_intervals( .data, significance_threshold = 0.05, test_composition_above_logit_fold_change = attr(.data, "test_composition_above_logit_fold_change") )
.data |
Data frame containing the main data. |
significance_threshold |
Numeric value specifying the significance threshold for highlighting differences. Default is 0.025. |
test_composition_above_logit_fold_change |
A positive integer. It is the effect threshold used for the hypothesis test. A value of 0.2 correspond to a change in cell proportion of 10% for a cell type with baseline proportion of 50%. That is, a cell type goes from 45% to 50%. When the baseline proportion is closer to 0 or 1 this effect thrshold has consistent value in the logit uncontrained scale. |
A combined plot of 1D interval plots.
# Example usage: # plot_1D_intervals(.data, "cell_group", 0.025, theme_minimal())
# Example usage: # plot_1D_intervals(.data, "cell_group", 0.025, theme_minimal())
This function creates a 2D interval plot for mean-variance association, highlighting significant differences based on a given significance threshold.
plot_2D_intervals( .data, significance_threshold = 0.05, test_composition_above_logit_fold_change = attr(.data, "test_composition_above_logit_fold_change") )
plot_2D_intervals( .data, significance_threshold = 0.05, test_composition_above_logit_fold_change = attr(.data, "test_composition_above_logit_fold_change") )
.data |
Data frame containing the main data. |
significance_threshold |
Numeric value specifying the significance threshold for highlighting differences. Default is 0.025. |
test_composition_above_logit_fold_change |
A positive integer. It is the effect threshold used for the hypothesis test. A value of 0.2 correspond to a change in cell proportion of 10% for a cell type with baseline proportion of 50%. That is, a cell type goes from 45% to 50%. When the baseline proportion is closer to 0 or 1 this effect thrshold has consistent value in the logit uncontrained scale. |
A ggplot object representing the 2D interval plot.
# Example usage: # plot_2D_intervals(.data, "cell_group", theme_minimal(), 0.025)
# Example usage: # plot_2D_intervals(.data, "cell_group", theme_minimal(), 0.025)
This function creates a boxplot of cell-group proportions, optionally highlighting significant differences based on a given significance threshold.
plot_boxplot( .data, data_proportion, factor_of_interest, .cell_group, .sample, significance_threshold = 0.05, my_theme )
plot_boxplot( .data, data_proportion, factor_of_interest, .cell_group, .sample, significance_threshold = 0.05, my_theme )
.data |
Data frame containing the main data. |
data_proportion |
Data frame containing proportions of cell groups. |
factor_of_interest |
A factor indicating the biological condition of interest. |
.cell_group |
The cell group to be analysed. |
.sample |
The sample identifier. |
significance_threshold |
Numeric value specifying the significance threshold for highlighting differences. Default is 0.025. |
my_theme |
A ggplot2 theme object to be applied to the plot. |
A ggplot object representing the boxplot.
# Example usage: # plot_boxplot(.data, data_proportion, "condition", "cell_group", "sample", 0.025, theme_minimal())
# Example usage: # plot_boxplot(.data, data_proportion, "condition", "cell_group", "sample", 0.025, theme_minimal())
This function creates a scatterplot of cell-group proportions, optionally highlighting significant differences based on a given significance threshold.
plot_scatterplot( .data, data_proportion, factor_of_interest, .cell_group, .sample, significance_threshold = 0.05, my_theme )
plot_scatterplot( .data, data_proportion, factor_of_interest, .cell_group, .sample, significance_threshold = 0.05, my_theme )
.data |
Data frame containing the main data. |
data_proportion |
Data frame containing proportions of cell groups. |
factor_of_interest |
A factor indicating the biological condition of interest. |
.cell_group |
The cell group to be analysed. |
.sample |
The sample identifier. |
significance_threshold |
Numeric value specifying the significance threshold for highlighting differences. Default is 0.025. |
my_theme |
A ggplot2 theme object to be applied to the plot. |
A ggplot object representing the scatterplot.
# Example usage: # plot_scatterplot(.data, data_proportion, "condition", "cell_group", "sample", 0.025, theme_minimal())
# Example usage: # plot_scatterplot(.data, data_proportion, "condition", "cell_group", "sample", 0.025, theme_minimal())
This function plots a summary of the results of the model.
## S3 method for class 'sccomp_tbl' plot( x, significance_threshold = 0.05, test_composition_above_logit_fold_change = attr(.data, "test_composition_above_logit_fold_change"), ... )
## S3 method for class 'sccomp_tbl' plot( x, significance_threshold = 0.05, test_composition_above_logit_fold_change = attr(.data, "test_composition_above_logit_fold_change"), ... )
x |
A tibble including a cell_group name column | sample name column | read counts column | factor columns | Pvalue column | a significance column |
significance_threshold |
Numeric value specifying the significance threshold for highlighting differences. Default is 0.025. |
test_composition_above_logit_fold_change |
A positive integer. It is the effect threshold used for the hypothesis test. A value of 0.2 correspond to a change in cell proportion of 10% for a cell type with baseline proportion of 50%. That is, a cell type goes from 45% to 50%. When the baseline proportion is closer to 0 or 1 this effect thrshold has consistent value in the logit uncontrained scale. |
... |
For internal use |
A ggplot
message("Use the following example after having installed install.packages(\"cmdstanr\", repos = c(\"https://stan-dev.r-universe.dev/\", getOption(\"repos\")))") if (instantiate::stan_cmdstan_exists()) { data("counts_obj") estimate = sccomp_estimate( counts_obj, ~ type, ~1, sample, cell_group, count, cores = 1 ) # estimate |> plot() }
message("Use the following example after having installed install.packages(\"cmdstanr\", repos = c(\"https://stan-dev.r-universe.dev/\", getOption(\"repos\")))") if (instantiate::stan_cmdstan_exists()) { data("counts_obj") estimate = sccomp_estimate( counts_obj, ~ type, ~1, sample, cell_group, count, cores = 1 ) # estimate |> plot() }
This function plots a boxplot of the results of the model.
sccomp_boxplot( .data, factor, significance_threshold = 0.05, test_composition_above_logit_fold_change = attr(.data, "test_composition_above_logit_fold_change") )
sccomp_boxplot( .data, factor, significance_threshold = 0.05, test_composition_above_logit_fold_change = attr(.data, "test_composition_above_logit_fold_change") )
.data |
A tibble including a cell_group name column | sample name column | read counts column | factor columns | Pvalue column | a significance column |
factor |
A character string for a factor of interest included in the model |
significance_threshold |
A real. FDR threshold for labelling significant cell-groups. |
test_composition_above_logit_fold_change |
A positive integer. It is the effect threshold used for the hypothesis test. A value of 0.2 correspond to a change in cell proportion of 10% for a cell type with baseline proportion of 50%. That is, a cell type goes from 45% to 50%. When the baseline proportion is closer to 0 or 1 this effect thrshold has consistent value in the logit uncontrained scale. |
A ggplot
message("Use the following example after having installed install.packages(\"cmdstanr\", repos = c(\"https://stan-dev.r-universe.dev/\", getOption(\"repos\")))") if (instantiate::stan_cmdstan_exists()) { data("counts_obj") estimate = sccomp_estimate( counts_obj, ~ type, ~1, sample, cell_group, count, cores = 1 ) |> sccomp_test() # estimate |> sccomp_boxplot() }
message("Use the following example after having installed install.packages(\"cmdstanr\", repos = c(\"https://stan-dev.r-universe.dev/\", getOption(\"repos\")))") if (instantiate::stan_cmdstan_exists()) { data("counts_obj") estimate = sccomp_estimate( counts_obj, ~ type, ~1, sample, cell_group, count, cores = 1 ) |> sccomp_test() # estimate |> sccomp_boxplot() }
sccomp_calculate_residuals
computes the residuals between observed cell group proportions and the predicted proportions from a fitted sccomp
model. This function is useful for assessing model fit and identifying cell groups or samples where the model may not adequately capture the observed data. The residuals are calculated as the difference between the observed proportions and the predicted mean proportions from the model.
sccomp_calculate_residuals(.data)
sccomp_calculate_residuals(.data)
.data |
A tibble of class |
The function performs the following steps:
Extracts the predicted mean proportions for each cell group and sample using sccomp_predict()
.
Calculates the observed proportions from the original count data.
Computes residuals by subtracting the predicted proportions from the observed proportions.
Returns a tibble containing the sample, cell group, residuals, and exposure (total counts per sample).
A tibble (tbl
) with the following columns:
sample - A character column representing the sample identifiers.
cell_group - A character column representing the cell group identifiers.
residuals - A numeric column representing the residuals, calculated as the difference between observed and predicted proportions.
exposure - A numeric column representing the total counts (sum of counts across cell groups) for each sample.
if (instantiate::stan_cmdstan_exists() && .Platform$OS.type == "unix") { # Load example data data("counts_obj") # Fit the sccomp model estimates <- sccomp_estimate( counts_obj, formula_composition = ~ type, formula_variability = ~1, .sample = sample, .cell_group = cell_group, .count = count, approximate_posterior_inference = "all", cores = 1 ) # Calculate residuals residuals <- sccomp_calculate_residuals(estimates) # View the residuals print(residuals) }
if (instantiate::stan_cmdstan_exists() && .Platform$OS.type == "unix") { # Load example data data("counts_obj") # Fit the sccomp model estimates <- sccomp_estimate( counts_obj, formula_composition = ~ type, formula_variability = ~1, .sample = sample, .cell_group = cell_group, .count = count, approximate_posterior_inference = "all", cores = 1 ) # Calculate residuals residuals <- sccomp_calculate_residuals(estimates) # View the residuals print(residuals) }
The sccomp_estimate
function performs linear modeling on a table of cell counts or proportions,
which includes a cell-group identifier, sample identifier, abundance (counts or proportions), and factors
(continuous or discrete). The user can define a linear model using an R formula,
where the first factor is the factor of interest. Alternatively, sccomp
accepts
single-cell data containers (e.g., Seurat, SingleCellExperiment, cell metadata, or
group-size) and derives the count data from cell metadata.
sccomp_estimate( .data, formula_composition = ~1, formula_variability = ~1, .sample, .cell_group, .abundance = NULL, cores = detectCores(), bimodal_mean_variability_association = FALSE, percent_false_positive = 5, inference_method = "pathfinder", prior_mean = list(intercept = c(0, 1), coefficients = c(0, 1)), prior_overdispersion_mean_association = list(intercept = c(5, 2), slope = c(0, 0.6), standard_deviation = c(10, 20)), .sample_cell_group_pairs_to_exclude = NULL, output_directory = "sccomp_draws_files", verbose = TRUE, enable_loo = FALSE, noise_model = "multi_beta_binomial", exclude_priors = FALSE, use_data = TRUE, mcmc_seed = sample(1e+05, 1), max_sampling_iterations = 20000, pass_fit = TRUE, ..., .count = NULL, approximate_posterior_inference = NULL, variational_inference = NULL )
sccomp_estimate( .data, formula_composition = ~1, formula_variability = ~1, .sample, .cell_group, .abundance = NULL, cores = detectCores(), bimodal_mean_variability_association = FALSE, percent_false_positive = 5, inference_method = "pathfinder", prior_mean = list(intercept = c(0, 1), coefficients = c(0, 1)), prior_overdispersion_mean_association = list(intercept = c(5, 2), slope = c(0, 0.6), standard_deviation = c(10, 20)), .sample_cell_group_pairs_to_exclude = NULL, output_directory = "sccomp_draws_files", verbose = TRUE, enable_loo = FALSE, noise_model = "multi_beta_binomial", exclude_priors = FALSE, use_data = TRUE, mcmc_seed = sample(1e+05, 1), max_sampling_iterations = 20000, pass_fit = TRUE, ..., .count = NULL, approximate_posterior_inference = NULL, variational_inference = NULL )
.data |
A tibble including cell_group name column, sample name column, abundance column (counts or proportions), and factor columns. |
formula_composition |
A formula describing the model for differential abundance. |
formula_variability |
A formula describing the model for differential variability. |
.sample |
A column name as a symbol for the sample identifier. |
.cell_group |
A column name as a symbol for the cell-group identifier. |
.abundance |
A column name as a symbol for the cell-group abundance, which can be counts (> 0) or proportions (between 0 and 1, summing to 1 across |
cores |
Number of cores to use for parallel calculations. |
bimodal_mean_variability_association |
Logical, whether to model mean-variability as bimodal. |
percent_false_positive |
A real number between 0 and 100 for outlier identification. |
inference_method |
Character string specifying the inference method to use ('pathfinder', 'hmc', or 'variational'). |
prior_mean |
A list specifying prior knowledge about the mean distribution, including intercept and coefficients. |
prior_overdispersion_mean_association |
A list specifying prior knowledge about mean/variability association. |
.sample_cell_group_pairs_to_exclude |
A column name indicating sample/cell-group pairs to exclude. |
output_directory |
A character string specifying the output directory for Stan draws. |
verbose |
Logical, whether to print progression details. |
enable_loo |
Logical, whether to enable model comparison using the LOO package. |
noise_model |
A character string specifying the noise model (e.g., 'multi_beta_binomial'). |
exclude_priors |
Logical, whether to run a prior-free model. |
use_data |
Logical, whether to run the model data-free. |
mcmc_seed |
An integer seed for MCMC reproducibility. |
max_sampling_iterations |
Integer to limit the maximum number of iterations for large datasets. |
pass_fit |
Logical, whether to include the Stan fit as an attribute in the output. |
... |
Additional arguments passed to the |
.count |
DEPRECATED. Use |
approximate_posterior_inference |
DEPRECATED. Use |
variational_inference |
DEPRECATED. Use |
A tibble (tbl
) with the following columns:
cell_group - The cell groups being tested.
parameter - The parameter being estimated from the design matrix described by the input formula_composition
and formula_variability
.
factor - The covariate factor in the formula, if applicable (e.g., not present for Intercept or contrasts).
c_lower - Lower (2.5%) quantile of the posterior distribution for a composition (c) parameter.
c_effect - Mean of the posterior distribution for a composition (c) parameter.
c_upper - Upper (97.5%) quantile of the posterior distribution for a composition (c) parameter.
c_pH0 - Probability of the null hypothesis (no difference) for a composition (c). This is not a p-value.
c_FDR - False-discovery rate of the null hypothesis for a composition (c).
c_n_eff - Effective sample size for a composition (c) parameter.
c_R_k_hat - R statistic for a composition (c) parameter, should be within 0.05 of 1.0.
v_lower - Lower (2.5%) quantile of the posterior distribution for a variability (v) parameter.
v_effect - Mean of the posterior distribution for a variability (v) parameter.
v_upper - Upper (97.5%) quantile of the posterior distribution for a variability (v) parameter.
v_pH0 - Probability of the null hypothesis for a variability (v).
v_FDR - False-discovery rate of the null hypothesis for a variability (v).
v_n_eff - Effective sample size for a variability (v) parameter.
v_R_k_hat - R statistic for a variability (v) parameter.
count_data - Nested input count data.
message("Use the following example after having installed cmdstanr with install.packages(\"cmdstanr\", repos = c(\"https://stan-dev.r-universe.dev/\", getOption(\"repos\")))") if (instantiate::stan_cmdstan_exists()) { data("counts_obj") estimate <- sccomp_estimate( counts_obj, ~ type, ~1, sample, cell_group, abundance, cores = 1 ) }
message("Use the following example after having installed cmdstanr with install.packages(\"cmdstanr\", repos = c(\"https://stan-dev.r-universe.dev/\", getOption(\"repos\")))") if (instantiate::stan_cmdstan_exists()) { data("counts_obj") estimate <- sccomp_estimate( counts_obj, ~ type, ~1, sample, cell_group, abundance, cores = 1 ) }
This function replicates counts from a real-world dataset.
sccomp_predict( fit, formula_composition = NULL, new_data = NULL, number_of_draws = 500, mcmc_seed = sample(1e+05, 1), summary_instead_of_draws = TRUE )
sccomp_predict( fit, formula_composition = NULL, new_data = NULL, number_of_draws = 500, mcmc_seed = sample(1e+05, 1), summary_instead_of_draws = TRUE )
fit |
The result of sccomp_estimate. |
formula_composition |
A formula. The formula describing the model for differential abundance, for example ~treatment. This formula can be a sub-formula of your estimated model; in this case all other factor will be factored out. |
new_data |
A sample-wise data frame including the column that represent the factors in your formula. If you want to predict proportions for 10 samples, there should be 10 rows. T |
number_of_draws |
An integer. How may copies of the data you want to draw from the model joint posterior distribution. |
mcmc_seed |
An integer. Used for Markov-chain Monte Carlo reproducibility. By default a random number is sampled from 1 to 999999. This itself can be controlled by set.seed() |
summary_instead_of_draws |
Return the summary values (i.e. mean and quantiles) of the predicted proportions, or return single draws. Single draws can be helful to better analyse the uncertainty of the prediction. |
A tibble (tbl
) with the following columns:
cell_group - A character column representing the cell group being tested.
sample - A factor column representing the sample name for which the predictions are made.
proportion_mean - A numeric column representing the predicted mean proportions from the model.
proportion_lower - A numeric column representing the lower bound (2.5%) of the 95% credible interval for the predicted proportions.
proportion_upper - A numeric column representing the upper bound (97.5%) of the 95% credible interval for the predicted proportions.
message("Use the following example after having installed install.packages(\"cmdstanr\", repos = c(\"https://stan-dev.r-universe.dev/\", getOption(\"repos\")))") if (instantiate::stan_cmdstan_exists() && .Platform$OS.type == "unix") { data("counts_obj") sccomp_estimate( counts_obj, ~ type, ~1, sample, cell_group, count, cores = 1 ) |> sccomp_predict() }
message("Use the following example after having installed install.packages(\"cmdstanr\", repos = c(\"https://stan-dev.r-universe.dev/\", getOption(\"repos\")))") if (instantiate::stan_cmdstan_exists() && .Platform$OS.type == "unix") { data("counts_obj") sccomp_estimate( counts_obj, ~ type, ~1, sample, cell_group, count, cores = 1 ) |> sccomp_predict() }
This function calculates the proportional fold change for single-cell composition data from sccomp analysis, comparing two conditions.
sccomp_proportional_fold_change(.data, formula_composition, from, to)
sccomp_proportional_fold_change(.data, formula_composition, from, to)
.data |
A |
formula_composition |
The formula for the composition model. |
from |
The label for the control group (e.g., "healthy"). |
to |
The label for the treatment group (e.g., "cancer"). |
Note! This statistic is just descriptive and should not be used to define significance. Use sccomp_test() for that. This statistics is just meant to help interpretation. While fold increase in proportion is easier to understand than fold change in logit space, the first is not linear (the same change for rare cell types does not necessarily have the same weight that for abundant cell types), while the latter is linear, and used to infer probabilities.
A tibble with cell groups and their respective proportional fold change.
## Not run: # Example usage result <- sccomp_proportional_fold_change(sccomp_data, formula_composition, "healthy", "cancer") ## End(Not run)
## Not run: # Example usage result <- sccomp_proportional_fold_change(sccomp_data, formula_composition, "healthy", "cancer") ## End(Not run)
The sccomp_remove_outliers
function takes as input a table of cell counts with columns for cell-group identifier, sample identifier, integer count, and factors (continuous or discrete). The user can define a linear model using an input R formula, where the first factor is the factor of interest. Alternatively, sccomp
accepts single-cell data containers (e.g., Seurat, SingleCellExperiment, cell metadata, or group-size) and derives the count data from cell metadata.
sccomp_remove_outliers( .estimate, percent_false_positive = 5, cores = detectCores(), inference_method = "pathfinder", output_directory = "sccomp_draws_files", verbose = TRUE, mcmc_seed = sample(1e+05, 1), max_sampling_iterations = 20000, enable_loo = FALSE, approximate_posterior_inference = NULL, variational_inference = NULL, ... )
sccomp_remove_outliers( .estimate, percent_false_positive = 5, cores = detectCores(), inference_method = "pathfinder", output_directory = "sccomp_draws_files", verbose = TRUE, mcmc_seed = sample(1e+05, 1), max_sampling_iterations = 20000, enable_loo = FALSE, approximate_posterior_inference = NULL, variational_inference = NULL, ... )
.estimate |
A tibble including a cell_group name column, sample name column, read counts column (optional depending on the input class), and factor columns. |
percent_false_positive |
A real number between 0 and 100 (not inclusive), used to identify outliers with a specific false positive rate. |
cores |
Integer, the number of cores to be used for parallel calculations. |
inference_method |
Character string specifying the inference method to use ('pathfinder', 'hmc', or 'variational'). |
output_directory |
A character string specifying the output directory for Stan draws. |
verbose |
Logical, whether to print progression details. |
mcmc_seed |
Integer, used for Markov-chain Monte Carlo reproducibility. By default, a random number is sampled from 1 to 999999. |
max_sampling_iterations |
Integer, limits the maximum number of iterations in case a large dataset is used, to limit computation time. |
enable_loo |
Logical, whether to enable model comparison using the R package LOO. This is useful for comparing fits between models, similar to ANOVA. |
approximate_posterior_inference |
DEPRECATED, use the |
variational_inference |
Logical, whether to use variational Bayes for posterior inference. It is faster and convenient. Setting this argument to |
... |
Additional arguments passed to the |
A tibble (tbl
), with the following columns:
cell_group - The cell groups being tested.
parameter - The parameter being estimated from the design matrix described by the input formula_composition and formula_variability.
factor - The covariate factor in the formula, if applicable (e.g., not present for Intercept or contrasts).
c_lower - Lower (2.5%) quantile of the posterior distribution for a composition (c) parameter.
c_effect - Mean of the posterior distribution for a composition (c) parameter.
c_upper - Upper (97.5%) quantile of the posterior distribution for a composition (c) parameter.
c_n_eff - Effective sample size, the number of independent draws in the sample. The higher, the better.
c_R_k_hat - R statistic, a measure of chain equilibrium, should be within 0.05 of 1.0.
v_lower - Lower (2.5%) quantile of the posterior distribution for a variability (v) parameter.
v_effect - Mean of the posterior distribution for a variability (v) parameter.
v_upper - Upper (97.5%) quantile of the posterior distribution for a variability (v) parameter.
v_n_eff - Effective sample size for a variability (v) parameter.
v_R_k_hat - R statistic for a variability (v) parameter, a measure of chain equilibrium.
count_data - Nested input count data.
message("Use the following example after having installed install.packages(\"cmdstanr\", repos = c(\"https://stan-dev.r-universe.dev/\", getOption(\"repos\")))") if (instantiate::stan_cmdstan_exists()) { data("counts_obj") estimate = sccomp_estimate( counts_obj, ~ type, ~1, sample, cell_group, count, cores = 1 ) |> sccomp_remove_outliers(cores = 1) }
message("Use the following example after having installed install.packages(\"cmdstanr\", repos = c(\"https://stan-dev.r-universe.dev/\", getOption(\"repos\")))") if (instantiate::stan_cmdstan_exists()) { data("counts_obj") estimate = sccomp_estimate( counts_obj, ~ type, ~1, sample, cell_group, count, cores = 1 ) |> sccomp_remove_outliers(cores = 1) }
This function uses the model to remove unwanted variation from a dataset using the estimates of the model. For example, if you fit your data with the formula ~ factor_1 + factor_2
and use the formula ~ factor_1
to remove unwanted variation, the factor_2
effect will be factored out.
sccomp_remove_unwanted_variation( .data, formula_composition_keep = NULL, formula_composition = NULL, formula_variability = NULL, cores = detectCores() )
sccomp_remove_unwanted_variation( .data, formula_composition_keep = NULL, formula_composition = NULL, formula_variability = NULL, cores = detectCores() )
.data |
A tibble. The result of |
formula_composition_keep |
A formula. The formula describing the model for differential abundance, for example |
formula_composition |
DEPRECATED. Use |
formula_variability |
DEPRECATED. Use |
cores |
Integer, the number of cores to be used for parallel calculations. |
A tibble (tbl
) with the following columns:
sample - A character column representing the sample name for which data was adjusted.
cell_group - A character column representing the cell group being tested.
adjusted_proportion - A numeric column representing the adjusted proportion after removing unwanted variation.
adjusted_counts - A numeric column representing the adjusted counts after removing unwanted variation.
logit_residuals - A numeric column representing the logit residuals calculated after adjustment.
message("Use the following example after having installed cmdstanr with install.packages(\"cmdstanr\", repos = c(\"https://stan-dev.r-universe.dev/\", getOption(\"repos\")))") if (instantiate::stan_cmdstan_exists()) { data("counts_obj") estimates = sccomp_estimate( counts_obj, ~ type, ~1, sample, cell_group, count, cores = 1 ) |> sccomp_remove_unwanted_variation() }
message("Use the following example after having installed cmdstanr with install.packages(\"cmdstanr\", repos = c(\"https://stan-dev.r-universe.dev/\", getOption(\"repos\")))") if (instantiate::stan_cmdstan_exists()) { data("counts_obj") estimates = sccomp_estimate( counts_obj, ~ type, ~1, sample, cell_group, count, cores = 1 ) |> sccomp_remove_unwanted_variation() }
This function replicates counts from a real-world dataset.
sccomp_replicate( fit, formula_composition = NULL, formula_variability = NULL, number_of_draws = 1, mcmc_seed = sample(1e+05, 1) )
sccomp_replicate( fit, formula_composition = NULL, formula_variability = NULL, number_of_draws = 1, mcmc_seed = sample(1e+05, 1) )
fit |
The result of sccomp_estimate. |
formula_composition |
A formula. The formula describing the model for differential abundance, for example ~treatment. This formula can be a sub-formula of your estimated model; in this case all other factor will be factored out. |
formula_variability |
A formula. The formula describing the model for differential variability, for example ~treatment. In most cases, if differentially variability is of interest, the formula should only include the factor of interest as a large anount of data is needed to define variability depending to each factors. This formula can be a sub-formula of your estimated model; in this case all other factor will be factored out. |
number_of_draws |
An integer. How may copies of the data you want to draw from the model joint posterior distribution. |
mcmc_seed |
An integer. Used for Markov-chain Monte Carlo reproducibility. By default a random number is sampled from 1 to 999999. This itself can be controlled by set.seed() |
A tibble tbl
with cell_group-wise statistics
A tibble (tbl
), with the following columns:
cell_group - A character column representing the cell group being tested.
sample - A factor column representing the sample name from which data was generated.
generated_proportions - A numeric column representing the proportions generated from the model.
generated_counts - An integer column representing the counts generated from the model.
replicate - An integer column representing the replicate number, where each row corresponds to a different replicate of the data.
message("Use the following example after having installed install.packages(\"cmdstanr\", repos = c(\"https://stan-dev.r-universe.dev/\", getOption(\"repos\")))") if (instantiate::stan_cmdstan_exists() && .Platform$OS.type == "unix") { data("counts_obj") sccomp_estimate( counts_obj, ~ type, ~1, sample, cell_group, count, cores = 1 ) |> sccomp_replicate() }
message("Use the following example after having installed install.packages(\"cmdstanr\", repos = c(\"https://stan-dev.r-universe.dev/\", getOption(\"repos\")))") if (instantiate::stan_cmdstan_exists() && .Platform$OS.type == "unix") { data("counts_obj") sccomp_estimate( counts_obj, ~ type, ~1, sample, cell_group, count, cores = 1 ) |> sccomp_replicate() }
This function test contrasts from a sccomp result.
sccomp_test( .data, contrasts = NULL, percent_false_positive = 5, test_composition_above_logit_fold_change = 0.1, pass_fit = TRUE )
sccomp_test( .data, contrasts = NULL, percent_false_positive = 5, test_composition_above_logit_fold_change = 0.1, pass_fit = TRUE )
.data |
A tibble. The result of sccomp_estimate. |
contrasts |
A vector of character strings. For example if your formula is |
percent_false_positive |
A real between 0 and 100 non included. This used to identify outliers with a specific false positive rate. |
test_composition_above_logit_fold_change |
A positive integer. It is the effect threshold used for the hypothesis test. A value of 0.2 correspond to a change in cell proportion of 10% for a cell type with baseline proportion of 50%. That is, a cell type goes from 45% to 50%. When the baseline proportion is closer to 0 or 1 this effect thrshold has consistent value in the logit uncontrained scale. |
pass_fit |
A boolean. Whether to pass the Stan fit as attribute in the output. Because the Stan fit can be very large, setting this to FALSE can be used to lower the memory imprint to save the output. |
A tibble (tbl
), with the following columns:
cell_group - The cell groups being tested.
parameter - The parameter being estimated from the design matrix described by the input formula_composition and formula_variability.
factor - The covariate factor in the formula, if applicable (e.g., not present for Intercept or contrasts).
c_lower - Lower (2.5%) quantile of the posterior distribution for a composition (c) parameter.
c_effect - Mean of the posterior distribution for a composition (c) parameter.
c_upper - Upper (97.5%) quantile of the posterior distribution for a composition (c) parameter.
c_pH0 - Probability of the c_effect being smaller or bigger than the test_composition_above_logit_fold_change
argument.
c_FDR - False discovery rate of the c_effect being smaller or bigger than the test_composition_above_logit_fold_change
argument. False discovery rate for Bayesian models is calculated differently from frequentists models, as detailed in Mangiola et al, PNAS 2023.
c_n_eff - Effective sample size, the number of independent draws in the sample. The higher, the better.
c_R_k_hat - R statistic, a measure of chain equilibrium, should be within 0.05 of 1.0.
v_lower - Lower (2.5%) quantile of the posterior distribution for a variability (v) parameter.
v_effect - Mean of the posterior distribution for a variability (v) parameter.
v_upper - Upper (97.5%) quantile of the posterior distribution for a variability (v) parameter.
v_pH0 - Probability of the v_effect being smaller or bigger than the test_composition_above_logit_fold_change
argument.
v_FDR - False discovery rate of the v_effect being smaller or bigger than the test_composition_above_logit_fold_change
argument. False discovery rate for Bayesian models is calculated differently from frequentists models, as detailed in Mangiola et al, PNAS 2023.
v_n_eff - Effective sample size for a variability (v) parameter.
v_R_k_hat - R statistic for a variability (v) parameter, a measure of chain equilibrium.
count_data - Nested input count data.
#'
message("Use the following example after having installed install.packages(\"cmdstanr\", repos = c(\"https://stan-dev.r-universe.dev/\", getOption(\"repos\")))") if (instantiate::stan_cmdstan_exists()) { data("counts_obj") estimates = sccomp_estimate( counts_obj, ~ 0 + type, ~1, sample, cell_group, count, cores = 1 ) |> sccomp_test("typecancer - typebenign") }
message("Use the following example after having installed install.packages(\"cmdstanr\", repos = c(\"https://stan-dev.r-universe.dev/\", getOption(\"repos\")))") if (instantiate::stan_cmdstan_exists()) { data("counts_obj") estimates = sccomp_estimate( counts_obj, ~ 0 + type, ~1, sample, cell_group, count, cores = 1 ) |> sccomp_test("typecancer - typebenign") }
Example SingleCellExperiment
object containing gene expression data for 106,297 cells across two assays: counts and logcounts. The object includes metadata and assay data for RNA expression, which can be used directly in differential analysis functions like sccomp_glm
.
data(sce_obj)
data(sce_obj)
A SingleCellExperiment
object with the following structure:
assays: Two assays: counts (raw RNA counts) and logcounts (log-transformed counts).
rowData: No additional row-level metadata is present.
colData: Metadata for each cell, including six fields: sample, type, nFeature_RNA, ident, and others.
dim: 1 feature and 106,297 cells.
colnames: Cell identifiers for all 106,297 cells.
A SingleCellExperiment
object containing single-cell RNA expression data.
Example Seurat
object containing gene expression data for 106,297 cells across a single assay. The object includes RNA counts and data layers, but no variable features are defined. This dataset can be directly used with functions like sccomp_glm
for differential abundance analysis.
data(seurat_obj)
data(seurat_obj)
A Seurat
object with the following structure:
assays: Contains gene expression data. The active assay is RNA
, with 1 feature and no variable features.
layers: Two layers: counts and data, representing raw and processed RNA expression values, respectively.
samples: 106,297 samples (cells) within the RNA assay.
A Seurat
object containing single-cell RNA expression data.
This function simulates counts from a linear model.
simulate_data( .data, .estimate_object, formula_composition, formula_variability = NULL, .sample = NULL, .cell_group = NULL, .coefficients = NULL, variability_multiplier = 5, number_of_draws = 1, mcmc_seed = sample(1e+05, 1), cores = detectCores() )
simulate_data( .data, .estimate_object, formula_composition, formula_variability = NULL, .sample = NULL, .cell_group = NULL, .coefficients = NULL, variability_multiplier = 5, number_of_draws = 1, mcmc_seed = sample(1e+05, 1), cores = detectCores() )
.data |
A tibble including a cell_group name column | sample name column | read counts column | factor columns | Pvalue column | a significance column |
.estimate_object |
The result of sccomp_estimate execution. This is used for sampling from real-data properties. |
formula_composition |
A formula. The sample formula used to perform the differential cell_group abundance analysis |
formula_variability |
A formula. The formula describing the model for differential variability, for example ~treatment. In most cases, if differentially variability is of interest, the formula should only include the factor of interest as a large anount of data is needed to define variability depending to each factors. |
.sample |
A column name as symbol. The sample identifier |
.cell_group |
A column name as symbol. The cell_group identifier |
.coefficients |
The column names for coefficients, for example, c(b_0, b_1) |
variability_multiplier |
A real scalar. This can be used for artificially increasing the variability of the simulation for benchmarking purposes. |
number_of_draws |
An integer. How may copies of the data you want to draw from the model joint posterior distribution. |
mcmc_seed |
An integer. Used for Markov-chain Monte Carlo reproducibility. By default a random number is sampled from 1 to 999999. This itself can be controlled by set.seed()#' @param cores Integer, the number of cores to be used for parallel calculations. |
cores |
Integer, the number of cores to be used for parallel calculations. |
A tibble (tbl
) with the following columns:
sample - A character column representing the sample name.
type - A factor column representing the type of the sample.
phenotype - A factor column representing the phenotype in the data.
count - An integer column representing the original cell counts.
cell_group - A character column representing the cell group identifier.
b_0 - A numeric column representing the first coefficient used for simulation.
b_1 - A numeric column representing the second coefficient used for simulation.
generated_proportions - A numeric column representing the generated proportions from the simulation.
generated_counts - An integer column representing the generated cell counts from the simulation.
replicate - An integer column representing the replicate number for each draw from the posterior distribution.
message("Use the following example after having installed install.packages(\"cmdstanr\", repos = c(\"https://stan-dev.r-universe.dev/\", getOption(\"repos\")))") if (instantiate::stan_cmdstan_exists()) { data("counts_obj") library(dplyr) estimate = sccomp_estimate( counts_obj, ~ type, ~1, sample, cell_group, count, cores = 1 ) # Set coefficients for cell_groups. In this case all coefficients are 0 for simplicity. counts_obj = counts_obj |> mutate(b_0 = 0, b_1 = 0) # Simulate data simulate_data(counts_obj, estimate, ~type, ~1, sample, cell_group, c(b_0, b_1)) }
message("Use the following example after having installed install.packages(\"cmdstanr\", repos = c(\"https://stan-dev.r-universe.dev/\", getOption(\"repos\")))") if (instantiate::stan_cmdstan_exists()) { data("counts_obj") library(dplyr) estimate = sccomp_estimate( counts_obj, ~ type, ~1, sample, cell_group, count, cores = 1 ) # Set coefficients for cell_groups. In this case all coefficients are 0 for simplicity. counts_obj = counts_obj |> mutate(b_0 = 0, b_1 = 0) # Simulate data simulate_data(counts_obj, estimate, ~type, ~1, sample, cell_group, c(b_0, b_1)) }