Steady-state Ligand-Receptor inference

liana provides different statistical methods to infer ligand-receptor interactions from single-cell transcriptomics data omics data using prior knowledge. In this notebook we showcase how to use liana in its most basic form with toy data.

We also refer users to the Cell-cell communication chapter in the best-practices guide from Theis lab. There we provide an overview of the common limitations and assumptions in CCC inference from (dissociated single-cell) transcriptomics data.

Loading Packages

[1]:
# import liana
import liana as li
# needed for visualization and toy data
import scanpy as sc

Loading toy data

In the most general case, liana’s ligand-receptor methods use anndata objects with processed single-cell transcriptomics data, with pre-defined cell labels (identities), to infer ligand-receptor interactions among all pairs of cell identities.

To load the example data-set, simply run:

[2]:
adata = sc.datasets.pbmc68k_reduced()

The example single-cell data consists processed data with PBMCs cell types

[3]:
sc.pl.umap(adata, color='bulk_labels', title='', frameon=False)
/home/dbdimitrov/anaconda3/envs/spiana/lib/python3.10/site-packages/scanpy/plotting/_tools/scatterplots.py:394: UserWarning: No data for colormapping provided via 'c'. Parameters 'cmap' will be ignored
../_images/notebooks_basic_usage_8_1.png

Background

liana typically works with the log1p-trasformed counts matrix, in this object the normalized counts are stored in raw:

[4]:
adata.raw.X
[4]:
<700x765 sparse matrix of type '<class 'numpy.float32'>'
        with 174400 stored elements in Compressed Sparse Row format>

Preferably, one would use liana with all features (genes) for which we have enough counts, but for the sake of this tutorial we are working with a matrix pre-filtered to the variable features alone.

In the background, liana aggregates the counts matrix and generates statistics, typically related to cell identies. These statistics are then utilized by each of the methods in liana.

Methods

[5]:
li.mt.show_methods()
[5]:
Method Name Magnitude Score Specificity Score Reference
0 CellPhoneDB lr_means cellphone_pvals Efremova, M., Vento-Tormo, M., Teichmann, S.A....
0 Connectome expr_prod scaled_weight Raredon, M.S.B., Yang, J., Garritano, J., Wang...
0 log2FC None lr_logfc Dimitrov, D., Türei, D., Garrido-Rodriguez, M....
0 NATMI expr_prod spec_weight Hou, R., Denisenko, E., Ong, H.T., Ramilowski,...
0 SingleCellSignalR lrscore None Cabello-Aguilar, S., Alame, M., Kon-Sun-Tack, ...
0 Rank_Aggregate magnitude_rank specificity_rank Dimitrov, D., Türei, D., Garrido-Rodriguez, M....
0 Geometric Mean lr_gmeans gmean_pvals CellPhoneDBv2's permutation approach applied t...
0 scSeqComm inter_score None Baruzzo, G., Cesaro, G., Di Camillo, B. 2022. ...
0 CellChat lr_probs cellchat_pvals Jin, S., Guerrero-Juarez, C.F., Zhang, L., Cha...

Each method infers relevant ligand-receptor interactions relying on different assumptions and each method returns different ligand-receptor scores, typically a pair per method. One score corresponding to the magnitude (strength) of interaction and the other reflecting how specificity of a given interaction to a pair cell identities.

Note

Method Class

Methods in liana are callable instances of the Method class. To obtain further information for each method the user can refer to the methods documentation ?method_name or ?method.__call__. Alternatively, users can use the method.describe function to get a short summary for each method.

For example, if the user wishes to learn more about liana’s rank_aggregate implementation, where we combine the scores of multiple methods, they could do the following:

[6]:
# import liana's rank_aggregate
from liana.mt import rank_aggregate
[7]:
?rank_aggregate.__call__
Signature:
rank_aggregate.__call__(
    adata: 'an.AnnData | MuData',
    groupby: 'str',
    resource_name: 'str' = 'consensus',
    expr_prop: 'float' = 0.1,
    min_cells: 'int' = 5,
    groupby_pairs: 'Optional[DataFrame]' = None,
    base: 'float' = 2.718281828459045,
    aggregate_method: 'str' = 'rra',
    consensus_opts: 'Optional[list]' = None,
    return_all_lrs: 'bool' = False,
    key_added: 'str' = 'liana_res',
    use_raw: 'Optional[bool]' = True,
    layer: 'Optional[str]' = None,
    de_method: 'str' = 't-test',
    n_perms: 'int' = 1000,
    seed: 'int' = 1337,
    n_jobs: 'int' = 1,
    resource: 'Optional[DataFrame]' = None,
    interactions: 'Optional[list]' = None,
    mdata_kwargs: 'dict' = {},
    inplace: 'bool' = True,
    verbose: 'Optional[bool]' = False,
)
Docstring:
Get an aggregate of ligand-receptor scores from multiple methods.

Parameters
----------
adata
    Annotated data object.
groupby
    Key to be used for grouping.
resource_name
    Name of the resource to be used for ligand-receptor inference. See `li.rs.show_resources()` for available resources.
expr_prop
    Minimum expression proportion for the ligands and receptors (+ their subunits) in the
    corresponding cell identities. Set to 0 to return unfiltered results.
min_cells
    Minimum cells (per cell identity if grouped by `groupby`) to be considered for downstream analysis.
groupby_pairs
    A DataFrame with columns `source` and `target` to be used to subset the possible combinations of interacting cell types.
    If None, all possible combinations are used.
base
    Exponent base used to reverse the log-transformation of the matrix. Relevant only for the `logfc` method.
aggregate_method
    Method aggregation approach, one of ['mean', 'rra'], where `mean` represents the
    mean rank, while 'rra' is the RobustRankAggregate (Kolde et al., 2014)
    of the interactions
consensus_opts
    Strategies to aggregate interactions across methods.
    Default is None - i.e. ['Specificity', 'Magnitude'] and both specificity and magnitude are aggregated.
return_all_lrs
    Bool whether to return all ligand-receptor pairs, or only those that surpass the `expr_prop`
    threshold. Ligand-receptor pairs that do not pass the `expr_prop` threshold will be assigned
    to the *worst* score of the ones that do. `False` by default.
key_added
    Key under which the results will be stored in `adata.uns` if `inplace` is True.
use_raw
    Use raw attribute of adata if present.
layer
    Layer in anndata.AnnData.layers to use. If None, use anndata.AnnData.X.
de_method
    Differential expression method. `scanpy.tl.rank_genes_groups` is used to rank genes
    according to 1vsRest. The default method is 't-test'.
verbose
    Verbosity flag.
n_perms
    Number of permutations for the permutation test. Relevant only for permutation-based methods
    (e.g., `CellPhoneDB`). If `None` is passed, no permutation testing is performed.
seed
    Random seed for reproducibility.
n_jobs
    Number of jobs to run in parallel.
resource
    A pandas dataframe with [`ligand`, `receptor`] columns.
    If provided will overrule the resource requested via `resource_name`
interactions
    List of tuples with ligand-receptor pairs `[(ligand, receptor), ...]` to be used for the analysis.
    If passed, it will overrule the resource requested via `resource` and `resource_name`.
mdata_kwargs
    Keyword arguments to be passed to `li.fun.mdata_to_anndata` if `adata` is an instance of `MuData`.
    If an AnnData object is passed, these arguments are ignored.
inplace
    Whether to store results in place, or else to return them.

Returns
-------
If ``inplace = False``, returns a `DataFrame` with ligand-receptor results
Otherwise, modifies the ``adata`` object with the following key:
    - :attr:`anndata.AnnData.uns` ``['liana_res']`` with the aforementioned DataFrame
File:      ~/anaconda3/envs/spiana/lib/python3.10/site-packages/liana/method/sc/_rank_aggregate.py
Type:      method

or alternatively:

[8]:
rank_aggregate.describe()
Rank_Aggregate returns `magnitude_rank`, `specificity_rank`. magnitude_rank and specificity_rank respectively represent an aggregate of the `magnitude`- and `specificity`-related scoring functions from the different methods.

Example Run

By default, LIANA+ uses human gene symbols. Though any other gene identifiers can be used. See the documentation and the Prior Knowledge tutorial for details.

Individual Methods

[9]:
# import all individual methods
from liana.method import singlecellsignalr, connectome, cellphonedb, natmi, logfc, cellchat, geometric_mean

Note

LIANA will by default use the .raw attribute of AnnData. If you wish to use .X set use_raw to False, or specify a layer.

LIANA will also by default use the ‘consensus’ resource to infer ligand-receptor interactions. This resource was created as a consensus from the resources literature-curated resources in OmniPath, and uses human gene symbols.

For different species, we provide ‘mouseconsensus’, for any other species you can provide your own resource, or translate LIANA’s resources via decoupler.

If you wish to use a different resource, please specify it via the resource_name parameter for internal resources, or provide an external one via resource or interactions.

[10]:
# run cellphonedb
cellphonedb(adata, groupby='bulk_labels', expr_prop=0.1, resource_name='consensus', verbose=True, key_added='cpdb_res')
Using `.raw`!
Using resource `consensus`.
0.94 of entities in the resource are missing from the data.
Generating ligand-receptor stats for 700 samples and 43 features
100%|██████████| 1000/1000 [00:09<00:00, 107.55it/s]

By default, liana will be run inplace and results will be assigned to adata.uns['liana_res']. Note that the high proportion of missing entities here is expected, as we are working on the reduced dimensions data.

[11]:
# by default, liana's output is saved in place:
adata.uns['cpdb_res'].head()
[11]:
ligand ligand_complex ligand_means ligand_props receptor receptor_complex receptor_means receptor_props source target lr_means cellphone_pvals
482 HLA-DRA HLA-DRA 4.537684 0.995833 CD4 CD4 0.612842 0.421053 Dendritic CD4+/CD45RO+ Memory 2.575263 0.0
321 HLA-DRA HLA-DRA 4.537684 0.995833 CD4 CD4 0.596125 0.500000 Dendritic CD4+/CD45RA+/CD25- Naive T 2.566905 0.0
989 HLA-DRA HLA-DRA 4.537684 0.995833 CD4 CD4 0.483977 0.302326 Dendritic CD14+ Monocyte 2.510830 0.0
651 HLA-DRA HLA-DRA 4.537684 0.995833 LAG3 LAG3 0.399500 0.240741 Dendritic CD8+ Cytotoxic T 2.468592 0.0
1392 HLA-DRA HLA-DRA 4.537684 0.995833 CD4 CD4 0.373671 0.270833 Dendritic Dendritic 2.455678 0.0

Here, we see that stats are provided for both ligand and receptor entities, more specifically: ligand and receptor are the two entities that potentially interact. As a reminder, CCC events are not limited to secreted signalling, but we refer to them as ligand and receptor for simplicity.

Also, in the case of heteromeric complexes, the ligand and receptor columns represent the subunit with minimum expression, while *_complex corresponds to the actual complex, with subunits being separated by _.

  • source and target columns represent the source/sender and target/receiver cell identity for each interaction, respectively

  • *_props: represents the proportion of cells that express the entity.

    By default, any interactions in which either entity is not expressed in above 10% of cells per cell type is considered as a false positive, under the assumption that since CCC occurs between cell types, a sufficient proportion of cells within should express the genes.

  • *_means: entity expression mean per cell type

  • lr_means: mean ligand-receptor expression, as a measure of ligand-receptor interaction magnitude

  • cellphone_pvals: permutation-based p-values, as a measure of interaction specificity

Note

ligand, receptor, source, and target columns are returned by every ligand-receptor method, while the rest of the columns can vary across the ligand-receptor methods, as each method infers relies on different assumptions and scoring functions, and hence each returns different ligand-receptor scores. Nevertheless, typically most methods use a pair of scoring functions - where one often corresponds to the magnitude (strength) of interaction and the other reflects how specificity of a given interaction to a pair cell identities.

Dotplot

We can now visualize the results that we just obtained.

LIANA provides some basic, but flexible plotting functionalities. Here, we will generate a dotplot of relevant ligand-receptor interactions.

[12]:
li.pl.dotplot(adata = adata,
              colour='lr_means',
              size='cellphone_pvals',
              inverse_size=True, # we inverse sign since we want small p-values to have large sizes
              source_labels=['CD34+', 'CD56+ NK', 'CD14+ Monocyte'],
              target_labels=['CD34+', 'CD56+ NK'],
              figure_size=(8, 7),
              # finally, since cpdbv2 suggests using a filter to FPs
              # we filter the pvals column to <= 0.05
              filter_fun=lambda x: x['cellphone_pvals'] <= 0.05,
              uns_key='cpdb_res' # uns_key to use, default is 'liana_res'
             )
Fontsize 0.00 < 1.0 pt not allowed by FreeType. Setting fontsize = 1 pt
../_images/notebooks_basic_usage_35_1.png
[12]:
<Figure Size: (800 x 700)>

Note

Missing dots here would represent interactions for which the ligand and receptor are not expressed above the expr_prop. One can change this threshold by setting expr_prop to a different value. Alternatively, setting return_all_lrs to True will return all ligand-receptor interactions, regardless of expression.

Tileplot

While dotplots are useful to visualize the most relevant interactions, LIANA’s tileplots are more useful when visualizing the statistics of ligands and receptors, individually.

[13]:
my_plot = li.pl.tileplot(adata = adata,
                         # NOTE: fill & label need to exist for both
                         # ligand_ and receptor_ columns
                         fill='means',
                         label='props',
                         label_fun=lambda x: f'{x:.2f}',
                         top_n=10,
                         orderby='cellphone_pvals',
                         orderby_ascending=True,
                         source_labels=['CD34+', 'CD56+ NK', 'CD14+ Monocyte'],
                         target_labels=['CD34+', 'CD56+ NK'],
                         uns_key='cpdb_res', # NOTE: default is 'liana_res'
                         source_title='Ligand',
                         target_title='Receptor',
                         figure_size=(8, 7)
                         )
my_plot
/home/dbdimitrov/anaconda3/envs/spiana/lib/python3.10/site-packages/liana/plotting/_common.py:104: SettingWithCopyWarning:
A value is trying to be set on a copy of a slice from a DataFrame.
Try using .loc[row_indexer,col_indexer] = value instead

See the caveats in the documentation: https://pandas.pydata.org/pandas-docs/stable/user_guide/indexing.html#returning-a-view-versus-a-copy
Fontsize 0.00 < 1.0 pt not allowed by FreeType. Setting fontsize = 1 pt
../_images/notebooks_basic_usage_39_1.png
[13]:
<Figure Size: (800 x 700)>

Rank Aggregate

In addition to the individual methods, LIANA also provides a consensus that integrates the predictions of individual methods. This is done by ranking and aggregating (RRA) the ligand-receptor interaction predictions from all methods.

[14]:
# Run rank_aggregate
li.mt.rank_aggregate(adata, groupby='bulk_labels', expr_prop=0.1, verbose=True)
Using `.raw`!
Using resource `consensus`.
0.94 of entities in the resource are missing from the data.
Generating ligand-receptor stats for 700 samples and 43 features
Assuming that counts were `natural` log-normalized!
Running CellPhoneDB
100%|██████████| 1000/1000 [00:05<00:00, 172.19it/s]
Running Connectome
Running log2FC
Running NATMI
Running SingleCellSignalR
[15]:
adata.uns['liana_res'].head()
[15]:
source target ligand_complex receptor_complex lr_means cellphone_pvals expr_prod scaled_weight lr_logfc spec_weight lrscore specificity_rank magnitude_rank
444 Dendritic CD4+/CD45RO+ Memory HLA-DRA CD4 2.575263 0.0 2.780884 0.723815 1.431302 0.065077 0.736772 0.001137 0.000653
294 Dendritic CD4+/CD45RA+/CD25- Naive T HLA-DRA CD4 2.566905 0.0 2.705027 0.709428 1.332656 0.063302 0.734081 0.001137 0.000911
447 Dendritic CD4+/CD45RO+ Memory HLA-DRB1 CD4 2.415010 0.0 2.584465 0.712731 1.331341 0.060203 0.729607 0.001137 0.001211
449 Dendritic CD4+/CD45RO+ Memory HLA-DPB1 CD4 2.367473 0.0 2.526199 0.731297 1.447014 0.068953 0.727352 0.001137 0.001377
297 Dendritic CD4+/CD45RA+/CD25- Naive T HLA-DRB1 CD4 2.406652 0.0 2.513965 0.698344 1.232695 0.058561 0.726870 0.001137 0.001741
[16]:
rank_aggregate.describe()
Rank_Aggregate returns `magnitude_rank`, `specificity_rank`. magnitude_rank and specificity_rank respectively represent an aggregate of the `magnitude`- and `specificity`-related scoring functions from the different methods.

The remainder of the columns in this dataframe are those coming from each of the methods included in the rank_aggregate - i.e. see the show_methods to map methods to scores.

Dotplot

We will now plot the most ‘relevant’ interactions ordered to the magnitude_rank results from aggregated_rank.

[17]:
li.pl.dotplot(adata = adata,
              colour='magnitude_rank',
              size='specificity_rank',
              inverse_size=True,
              inverse_colour=True,
              source_labels=['CD34+', 'CD56+ NK', 'CD14+ Monocyte'],
              target_labels=['CD34+', 'CD56+ NK'],
              top_n=10,
              orderby='magnitude_rank',
              orderby_ascending=True,
              figure_size=(8, 7)
             )
/home/dbdimitrov/anaconda3/envs/spiana/lib/python3.10/site-packages/liana/plotting/_common.py:104: SettingWithCopyWarning:
A value is trying to be set on a copy of a slice from a DataFrame.
Try using .loc[row_indexer,col_indexer] = value instead

See the caveats in the documentation: https://pandas.pydata.org/pandas-docs/stable/user_guide/indexing.html#returning-a-view-versus-a-copy
Fontsize 0.00 < 1.0 pt not allowed by FreeType. Setting fontsize = 1 pt
../_images/notebooks_basic_usage_47_1.png
[17]:
<Figure Size: (800 x 700)>

Similarly, we can also treat the ranks provided by RRA as a probability distribution to which we can filter interactions according to how robustly and highly ranked they are across the different methods.

[18]:
my_plot = li.pl.dotplot(adata = adata,
                        colour='magnitude_rank',
                        inverse_colour=True,
                        size='specificity_rank',
                        inverse_size=True,
                        source_labels=['CD34+', 'CD56+ NK', 'CD14+ Monocyte'],
                        target_labels=['CD34+', 'CD56+ NK'],
                        filter_fun=lambda x: x['specificity_rank'] <= 0.01,
                       )
my_plot
Fontsize 0.00 < 1.0 pt not allowed by FreeType. Setting fontsize = 1 pt
../_images/notebooks_basic_usage_49_1.png
[18]:
<Figure Size: (800 x 600)>

Save the plot to a file:

[19]:
my_plot.save('dotplot.pdf')
/home/dbdimitrov/anaconda3/envs/spiana/lib/python3.10/site-packages/plotnine/ggplot.py:587: PlotnineWarning: Saving 8 x 6 in image.
/home/dbdimitrov/anaconda3/envs/spiana/lib/python3.10/site-packages/plotnine/ggplot.py:588: PlotnineWarning: Filename: dotplot.pdf
Fontsize 0.00 < 1.0 pt not allowed by FreeType. Setting fontsize = 1 pt

Customizing LIANA’s Plots

Finally, the plots in liana are built with plotnine and their aesthetics can be easily modified. For example:

[20]:
# we import plotnine
import plotnine as p9
[21]:
(my_plot +
 # change theme
 p9.theme_dark() +
 # modify theme
 p9.theme(
     # adjust facet size
     strip_text=p9.element_text(size=11),
     figure_size=(7, 4)
 )
)
Fontsize 0.00 < 1.0 pt not allowed by FreeType. Setting fontsize = 1 pt
../_images/notebooks_basic_usage_55_1.png
[21]:
<Figure Size: (700 x 400)>

For more plot modification options we refer the user to plotnine’s tutorials and to the following link for a quick intro: https://datacarpentry.org/python-ecology-lesson/07-visualization-ggplot-python/index.html.

Customizing LIANA’s rank aggregate

LIANA’s rank aggregate is also customizable, and the user can choose to include only a subset of the methods.

For example, let’s generate a consensus with geometric mean and logfc methods only:

[22]:
methods = [logfc, geometric_mean]
new_rank_aggregate = li.mt.AggregateClass(li.mt.aggregate_meta, methods=methods)
[25]:
new_rank_aggregate(adata,
                   groupby='bulk_labels',
                   expr_prop=0.1,
                   verbose=True,
                   # Note that with this option, we don't perform permutations
                   # and hence we exclude the p-value for geometric_mean, as well as specificity_rank
                   n_perms=None,
                   use_raw=True,
                   )
Using `.raw`!
Using resource `consensus`.
0.94 of entities in the resource are missing from the data.
Generating ligand-receptor stats for 700 samples and 43 features
Assuming that counts were `natural` log-normalized!
Running log2FC
Running Geometric Mean

Check the results

[26]:
adata.uns['liana_res'].head()
[26]:
source target ligand_complex receptor_complex lr_logfc lr_gmeans magnitude_rank
1092 CD14+ Monocyte CD56+ NK TIMP1 CD63 1.435273 2.126363 0.000776
1088 CD14+ Monocyte CD56+ NK S100A9 ITGB2 1.069681 2.048953 0.001553
847 CD14+ Monocyte CD14+ Monocyte S100A9 ITGB2 1.069747 1.979752 0.002329
1106 CD56+ NK CD56+ NK SPON2 ITGB2 1.860055 1.926317 0.003106
898 CD56+ NK CD14+ Monocyte SPON2 ITGB2 1.860121 1.861258 0.003882
[ ]: