scvi.model.base.RNASeqMixin#

class scvi.model.base.RNASeqMixin[source]#

General purpose methods for RNA-seq analysis.

Methods table#

differential_expression([adata, groupby, ...])

A unified method for differential expression analysis.

get_feature_correlation_matrix([adata, ...])

Generate gene-gene correlation matrix using scvi uncertainty and expression.

get_latent_library_size([adata, indices, ...])

Returns the latent library size for each cell.

get_likelihood_parameters([adata, indices, ...])

Estimates for the parameters of the likelihood \(p(x \mid z)\).

get_normalized_expression([adata, indices, ...])

Returns the normalized (decoded) gene expression.

posterior_predictive_sample([adata, ...])

Generate predictive samples from the posterior predictive distribution.

Methods#

RNASeqMixin.differential_expression(adata=None, groupby=None, group1=None, group2=None, idx1=None, idx2=None, mode='change', delta=0.25, batch_size=None, all_stats=True, batch_correction=False, batchid1=None, batchid2=None, fdr_target=0.05, silent=False, weights='uniform', filter_outlier_cells=False, importance_weighting_kwargs=None, **kwargs)[source]#

A unified method for differential expression analysis.

Implements 'vanilla' DE [Lopez et al., 2018] and 'change' mode DE [Boyeau et al., 2019].

Parameters:
  • adata (AnnData | None (default: None)) – AnnData object with equivalent structure to initial AnnData. If None, defaults to the AnnData object used to initialize the model.

  • groupby (str | None (default: None)) – The key of the observations grouping to consider.

  • group1 (list[str] | None (default: None)) – Subset of groups, e.g. [‘g1’, ‘g2’, ‘g3’], to which comparison shall be restricted, or all groups in groupby (default).

  • group2 (str | None (default: None)) – If None, compare each group in group1 to the union of the rest of the groups in groupby. If a group identifier, compare with respect to this group.

  • idx1 (list[int] | list[bool] | str | None (default: None)) – idx1 and idx2 can be used as an alternative to the AnnData keys. Custom identifier for group1 that can be of three sorts: (1) a boolean mask, (2) indices, or (3) a string. If it is a string, then it will query indices that verifies conditions on adata.obs, as described in pandas.DataFrame.query() If idx1 is not None, this option overrides group1 and group2.

  • idx2 (list[int] | list[bool] | str | None (default: None)) – Custom identifier for group2 that has the same properties as idx1. By default, includes all cells not specified in idx1.

  • mode (Literal['vanilla', 'change'] (default: 'change')) – Method for differential expression. See user guide for full explanation.

  • delta (float (default: 0.25)) – specific case of region inducing differential expression. In this case, we suppose that \(R \setminus [-\delta, \delta]\) does not induce differential expression (change model default case).

  • batch_size (int | None (default: None)) – Minibatch size for data loading into model. Defaults to scvi.settings.batch_size.

  • all_stats (bool (default: True)) – Concatenate count statistics (e.g., mean expression group 1) to DE results.

  • batch_correction (bool (default: False)) – Whether to correct for batch effects in DE inference.

  • batchid1 (list[str] | None (default: None)) – Subset of categories from batch_key registered in setup_anndata, e.g. [‘batch1’, ‘batch2’, ‘batch3’], for group1. Only used if batch_correction is True, and by default all categories are used.

  • batchid2 (list[str] | None (default: None)) – Same as batchid1 for group2. batchid2 must either have null intersection with batchid1, or be exactly equal to batchid1. When the two sets are exactly equal, cells are compared by decoding on the same batch. When sets have null intersection, cells from group1 and group2 are decoded on each group in group1 and group2, respectively.

  • fdr_target (float (default: 0.05)) – Tag features as DE based on posterior expected false discovery rate.

  • silent (bool (default: False)) – If True, disables the progress bar. Default: False.

  • weights (Optional[Literal['uniform', 'importance']] (default: 'uniform')) – Weights to use for sampling. If None, defaults to “uniform”.

  • filter_outlier_cells (bool (default: False)) – Whether to filter outlier cells with filter_outlier_cells().

  • importance_weighting_kwargs (dict | None (default: None)) – Keyword arguments passed into _get_importance_weights().

  • **kwargs – Keyword args for scvi.model.base.DifferentialComputation.get_bayes_factors()

Return type:

DataFrame

Returns:

Differential expression DataFrame.

RNASeqMixin.get_feature_correlation_matrix(adata=None, indices=None, n_samples=10, batch_size=64, rna_size_factor=1000, transform_batch=None, correlation_type='spearman')[source]#

Generate gene-gene correlation matrix using scvi uncertainty and expression.

Parameters:
  • adata (AnnData | None (default: None)) – AnnData object with equivalent structure to initial AnnData. If None, defaults to the AnnData object used to initialize the model.

  • indices (list[int] | None (default: None)) – Indices of cells in adata to use. If None, all cells are used.

  • n_samples (int (default: 10)) – Number of posterior samples to use for estimation.

  • batch_size (int (default: 64)) – Minibatch size for data loading into model. Defaults to scvi.settings.batch_size.

  • rna_size_factor (int (default: 1000)) – size factor for RNA prior to sampling gamma distribution.

  • transform_batch (list[Union[int, float, str]] | None (default: None)) –

    Batches to condition on. If transform_batch is:

    • None, then real observed batch is used.

    • int, then batch transform_batch is used.

    • list of int, then values are averaged over provided batches.

  • correlation_type (Literal['spearman', 'pearson'] (default: 'spearman')) – One of “pearson”, “spearman”.

Return type:

DataFrame

Returns:

Gene-gene correlation matrix

RNASeqMixin.get_latent_library_size(adata=None, indices=None, give_mean=True, batch_size=None)[source]#

Returns the latent library size for each cell.

This is denoted as \(\ell_n\) in the scVI paper.

Parameters:
  • adata (AnnData | None (default: None)) – AnnData object with equivalent structure to initial AnnData. If None, defaults to the AnnData object used to initialize the model.

  • indices (list[int] | None (default: None)) – Indices of cells in adata to use. If None, all cells are used.

  • give_mean (bool (default: True)) – Return the mean or a sample from the posterior distribution.

  • batch_size (int | None (default: None)) – Minibatch size for data loading into model. Defaults to scvi.settings.batch_size.

Return type:

ndarray

RNASeqMixin.get_likelihood_parameters(adata=None, indices=None, n_samples=1, give_mean=False, batch_size=None)[source]#

Estimates for the parameters of the likelihood \(p(x \mid z)\).

Parameters:
  • adata (AnnData | None (default: None)) – AnnData object with equivalent structure to initial AnnData. If None, defaults to the AnnData object used to initialize the model.

  • indices (list[int] | None (default: None)) – Indices of cells in adata to use. If None, all cells are used.

  • n_samples (int | None (default: 1)) – Number of posterior samples to use for estimation.

  • give_mean (bool | None (default: False)) – Return expected value of parameters or a samples

  • batch_size (int | None (default: None)) – Minibatch size for data loading into model. Defaults to scvi.settings.batch_size.

Return type:

dict[str, ndarray]

RNASeqMixin.get_normalized_expression(adata=None, indices=None, transform_batch=None, gene_list=None, library_size=1, n_samples=1, n_samples_overall=None, weights=None, batch_size=None, return_mean=True, return_numpy=None, **importance_weighting_kwargs)[source]#

Returns the normalized (decoded) gene expression.

This is denoted as \(\rho_n\) in the scVI paper.

Parameters:
  • adata (AnnData | None (default: None)) – AnnData object with equivalent structure to initial AnnData. If None, defaults to the AnnData object used to initialize the model.

  • indices (list[int] | None (default: None)) – Indices of cells in adata to use. If None, all cells are used.

  • transform_batch (list[Union[int, float, str]] | None (default: None)) –

    Batch to condition on. If transform_batch is:

    • None, then real observed batch is used.

    • int, then batch transform_batch is used.

  • gene_list (list[str] | None (default: None)) – Return frequencies of expression for a subset of genes. This can save memory when working with large datasets and few genes are of interest.

  • library_size (Union[float, Literal['latent']] (default: 1)) – Scale the expression frequencies to a common library size. This allows gene expression levels to be interpreted on a common scale of relevant magnitude. If set to “latent”, use the latent library size.

  • n_samples (int (default: 1)) – Number of posterior samples to use for estimation.

  • n_samples_overall (int (default: None)) – Number of posterior samples to use for estimation. Overrides n_samples.

  • weights (Optional[Literal['uniform', 'importance']] (default: None)) – Weights to use for sampling. If None, defaults to “uniform”.

  • batch_size (int | None (default: None)) – Minibatch size for data loading into model. Defaults to scvi.settings.batch_size.

  • return_mean (bool (default: True)) – Whether to return the mean of the samples.

  • return_numpy (bool | None (default: None)) – Return a ndarray instead of a DataFrame. DataFrame includes gene names as columns. If either n_samples=1 or return_mean=True, defaults to False. Otherwise, it defaults to True.

  • importance_weighting_kwargs – Keyword arguments passed into _get_importance_weights().

Return type:

ndarray | DataFrame

Returns:

If n_samples is provided and return_mean is False, this method returns a 3d tensor of shape (n_samples, n_cells, n_genes). If n_samples is provided and return_mean is True, it returns a 2d tensor of shape (n_cells, n_genes). In this case, return type is DataFrame unless return_numpy is True. Otherwise, the method expects n_samples_overall to be provided and returns a 2d tensor of shape (n_samples_overall, n_genes).

RNASeqMixin.posterior_predictive_sample(adata=None, indices=None, n_samples=1, gene_list=None, batch_size=None)[source]#

Generate predictive samples from the posterior predictive distribution.

The posterior predictive distribution is denoted as \(p(\hat{x} \mid x)\), where \(x\) is the input data and \(\hat{x}\) is the sampled data.

We sample from this distribution by first sampling n_samples times from the posterior distribution \(q(z \mid x)\) for a given observation, and then sampling from the likelihood \(p(\hat{x} \mid z)\) for each of these.

Parameters:
  • adata (AnnData | None (default: None)) – AnnData object with an equivalent structure to the model’s dataset. If None, defaults to the AnnData object used to initialize the model.

  • indices (list[int] | None (default: None)) – Indices of the observations in adata to use. If None, defaults to all the observations.

  • n_samples (int (default: 1)) – Number of Monte Carlo samples to draw from the posterior predictive distribution for each observation.

  • gene_list (list[str] | None (default: None)) – Names of the genes to which to subset. If None, defaults to all genes.

  • batch_size (int | None (default: None)) – Minibatch size to use for data loading and model inference. Defaults to scvi.settings.batch_size. Passed into _make_data_loader().

Return type:

GCXS

Returns:

Sparse multidimensional array of shape (n_obs, n_vars) if n_samples == 1, else (n_obs, n_vars, n_samples).