import numpy as np
import pandas as pd
import scanpy as sc
import matplotlib.pyplot as plt
import warnings
import os
import urllib.request
="ignore", category=Warning)
warnings.simplefilter(action
# verbosity: errors (0), warnings (1), info (2), hints (3)
= 3
sc.settings.verbosity # sc.logging.print_versions()
=80) sc.settings.set_figure_params(dpi
Code chunks run Python commands unless it starts with %%bash
, in which case, those chunks run shell commands.
1 Data preparation
First, let’s load all necessary libraries and the QC-filtered dataset from the previous step.
# download pre-computed data if missing or long compute
= True
fetch_data
# url for source and intermediate data
= "https://export.uppmax.uu.se/naiss2023-23-3/workshops/workshop-scrnaseq"
path_data
= "data/covid/results"
path_results if not os.path.exists(path_results):
=True)
os.makedirs(path_results, exist_ok
= "data/covid/results/scanpy_covid_qc.h5ad"
path_file # if fetch_data is false and path_file doesn't exist
if fetch_data and not os.path.exists(path_file):
urllib.request.urlretrieve(os.path.join('covid/results/scanpy_covid_qc.h5ad'), path_file)
path_data,
= sc.read_h5ad(path_file)
adata adata
AnnData object with n_obs × n_vars = 7222 × 19468
obs: 'type', 'sample', 'batch', 'n_genes_by_counts', 'total_counts', 'total_counts_mt', 'pct_counts_mt', 'total_counts_ribo', 'pct_counts_ribo', 'total_counts_hb', 'pct_counts_hb', 'percent_mt2', 'n_counts', 'n_genes', 'percent_chrY', 'XIST-counts', 'S_score', 'G2M_score', 'phase', 'doublet_scores', 'predicted_doublets', 'doublet_info'
var: 'gene_ids', 'feature_types', 'genome', 'mt', 'ribo', 'hb', 'n_cells_by_counts', 'mean_counts', 'pct_dropout_by_counts', 'total_counts', 'n_cells'
uns: 'doublet_info_colors', 'hvg', 'log1p', 'neighbors', 'pca', 'phase_colors', 'sample_colors', 'umap'
obsm: 'X_pca', 'X_umap'
obsp: 'connectivities', 'distances'
Before variable gene selection we need to normalize and log transform the data. Then store the full matrix in the raw
slot before doing variable gene selection.
# normalize to depth 10 000
=1e4)
sc.pp.normalize_per_cell(adata, counts_per_cell_after
# log transform
sc.pp.log1p(adata)
# store normalized counts in the raw slot,
# we will subset adata.X for variable genes, but want to keep all genes matrix as well.
= adata
adata.raw
adata
normalizing by total count per cell
finished (0:00:00): normalized adata.X and added
'n_counts', counts per cell before normalization (adata.obs)
WARNING: adata.X seems to be already log-transformed.
AnnData object with n_obs × n_vars = 7222 × 19468
obs: 'type', 'sample', 'batch', 'n_genes_by_counts', 'total_counts', 'total_counts_mt', 'pct_counts_mt', 'total_counts_ribo', 'pct_counts_ribo', 'total_counts_hb', 'pct_counts_hb', 'percent_mt2', 'n_counts', 'n_genes', 'percent_chrY', 'XIST-counts', 'S_score', 'G2M_score', 'phase', 'doublet_scores', 'predicted_doublets', 'doublet_info'
var: 'gene_ids', 'feature_types', 'genome', 'mt', 'ribo', 'hb', 'n_cells_by_counts', 'mean_counts', 'pct_dropout_by_counts', 'total_counts', 'n_cells'
uns: 'doublet_info_colors', 'hvg', 'log1p', 'neighbors', 'pca', 'phase_colors', 'sample_colors', 'umap'
obsm: 'X_pca', 'X_umap'
obsp: 'connectivities', 'distances'
2 Feature selection
We first need to define which features/genes are important in our dataset to distinguish cell types. For this purpose, we need to find genes that are highly variable across cells, which in turn will also provide a good separation of the cell clusters.
# compute variable genes
=0.0125, max_mean=3, min_disp=0.5)
sc.pp.highly_variable_genes(adata, min_meanprint("Highly variable genes: %d"%sum(adata.var.highly_variable))
#plot variable genes
sc.pl.highly_variable_genes(adata)
# subset for variable genes in the dataset
= adata[:, adata.var['highly_variable']] adata
extracting highly variable genes
finished (0:00:00)
--> added
'highly_variable', boolean vector (adata.var)
'means', float vector (adata.var)
'dispersions', float vector (adata.var)
'dispersions_norm', float vector (adata.var)
Highly variable genes: 2626
3 Z-score transformation
Now that the genes have been selected, we now proceed with PCA. Since each gene has a different expression level, it means that genes with higher expression values will naturally have higher variation that will be captured by PCA. This means that we need to somehow give each gene a similar weight when performing PCA (see below). The common practice is to center and scale each gene before performing PCA. This exact scaling called Z-score normalization is very useful for PCA, clustering and plotting heatmaps. Additionally, we can use regression to remove any unwanted sources of variation from the dataset, such as cell cycle
, sequencing depth
, percent mitochondria
etc. This is achieved by doing a generalized linear regression using these parameters as co-variates in the model. Then the residuals of the model are taken as the regressed data. Although perhaps not in the best way, batch effect regression can also be done here. By default, variables are scaled in the PCA step and is not done separately. But it could be achieved by running the commands below:
#run this line if you get the "AttributeError: swapaxes not found"
# adata = adata.copy()
# regress out unwanted variables
'total_counts', 'pct_counts_mt'])
sc.pp.regress_out(adata, [
# scale data, clip values exceeding standard deviation 10.
=10) sc.pp.scale(adata, max_value
regressing out ['total_counts', 'pct_counts_mt']
sparse input is densified and may lead to high memory use
finished (0:00:39)
4 PCA
Performing PCA has many useful applications and interpretations, which much depends on the data used. In the case of single-cell data, we want to segregate samples based on gene expression patterns in the data.
To run PCA, you can use the function pca()
.
='arpack') sc.tl.pca(adata, svd_solver
computing PCA
with n_comps=50
finished (0:00:02)
We then plot the first principal components.
# plot more PCS
='sample', components = ['1,2','3,4','5,6','7,8'], ncols=2) sc.pl.pca(adata, color
To identify genes that contribute most to each PC, one can retrieve the loading matrix information.
#Plot loadings
=[1,2,3,4,5,6,7,8])
sc.pl.pca_loadings(adata, components
# OBS! only plots the positive axes genes from each PC!!
The function to plot loading genes only plots genes on the positive axes. Instead plot as a heatmaps, with genes on both positive and negative side, one per pc, and plot their expression amongst cells ordered by their position along the pc.
# adata.obsm["X_pca"] is the embeddings
# adata.uns["pca"] is pc variance
# adata.varm['PCs'] is the loadings
= adata.var['gene_ids']
genes
for pc in [1,2,3,4]:
= adata.varm['PCs'][:,pc-1]
g = np.argsort(g)
o = np.concatenate((o[:10],o[-10:])).tolist()
sel = adata.obsm['X_pca'][:,pc-1]
emb # order by position on that pc
= adata[np.argsort(emb),]
tempdata = genes[sel].index.tolist(), groupby='predicted_doublets', swap_axes = True, use_raw=False) sc.pl.heatmap(tempdata, var_names
We can also plot the amount of variance explained by each PC.
=True, n_pcs = 50) sc.pl.pca_variance_ratio(adata, log
Based on this plot, we can see that the top 8 PCs retain a lot of information, while other PCs contain progressively less. However, it is still advisable to use more PCs since they might contain information about rare cell types (such as platelets and DCs in this dataset)
5 tSNE
We will now run BH-tSNE.
= 30) sc.tl.tsne(adata, n_pcs
computing tSNE
using 'X_pca' with n_pcs = 30
using sklearn.manifold.TSNE
finished: added
'X_tsne', tSNE coordinates (adata.obsm)
'tsne', tSNE parameters (adata.uns) (0:00:14)
We plot the tSNE scatterplot colored by dataset. We can clearly see the effect of batches present in the dataset.
='sample') sc.pl.tsne(adata, color
6 UMAP
The UMAP implementation in SCANPY uses a neighborhood graph as the distance matrix, so we need to first calculate the graph.
= 30, n_neighbors = 20) sc.pp.neighbors(adata, n_pcs
computing neighbors
using 'X_pca' with n_pcs = 30
finished: added to `.uns['neighbors']`
`.obsp['distances']`, distances for each pair of neighbors
`.obsp['connectivities']`, weighted adjacency matrix (0:00:04)
We can now run UMAP for cell embeddings.
sc.tl.umap(adata)='sample') sc.pl.umap(adata, color
computing UMAP
finished: added
'X_umap', UMAP coordinates (adata.obsm)
'umap', UMAP parameters (adata.uns) (0:00:11)
UMAP is plotted colored per dataset. Although less distinct as in the tSNE, we still see quite an effect of the different batches in the data.
# run with 10 components, save to a new object so that the umap with 2D is not overwritten.
= sc.tl.umap(adata, n_components=10, copy=True)
umap10 = plt.subplots(1, 3, figsize=(10, 4), constrained_layout=True)
fig, axs
='sample', title="UMAP",
sc.pl.umap(adata, color=False, ax=axs[0], legend_loc=None)
show='sample', title="UMAP10", show=False,
sc.pl.umap(umap10, color=axs[1], components=['1,2'], legend_loc=None)
ax='sample', title="UMAP10",
sc.pl.umap(umap10, color=False, ax=axs[2], components=['3,4'], legend_loc=None)
show
# we can also plot the umap with neighbor edges
='sample', title="UMAP", edges=True) sc.pl.umap(adata, color
computing UMAP
finished: added
'X_umap', UMAP coordinates (adata.obsm)
'umap', UMAP parameters (adata.uns) (0:00:13)
We can now plot PCA, UMAP and tSNE side by side for comparison. Have a look at the UMAP and tSNE. What similarities/differences do you see? Can you explain the differences based on what you learned during the lecture? Also, we can conclude from the dimensionality reductions that our dataset contains a batch effect that needs to be corrected before proceeding to clustering and differential gene expression analysis.
= plt.subplots(2, 2, figsize=(10, 8), constrained_layout=True)
fig, axs ='sample', components=['1,2'], ax=axs[0, 0], show=False)
sc.pl.pca(adata, color='sample', components=['1,2'], ax=axs[0, 1], show=False)
sc.pl.tsne(adata, color='sample', components=['1,2'], ax=axs[1, 0], show=False) sc.pl.umap(adata, color
Finally, we can compare the PCA, tSNE and UMAP.
We have now done Variable gene selection, PCA and UMAP with the settings we selected for you. Test a few different ways of selecting variable genes, number of PCs for UMAP and check how it influences your embedding.
7 Genes of interest
Let’s plot some marker genes for different cell types onto the embedding.
Markers | Cell Type |
---|---|
CD3E | T cells |
CD3E CD4 | CD4+ T cells |
CD3E CD8A | CD8+ T cells |
GNLY, NKG7 | NK cells |
MS4A1 | B cells |
CD14, LYZ, CST3, MS4A7 | CD14+ Monocytes |
FCGR3A, LYZ, CST3, MS4A7 | FCGR3A+ Monocytes |
FCER1A, CST3 | DCs |
=["CD3E", "CD4", "CD8A", "GNLY","NKG7", "MS4A1","CD14","LYZ","CST3","MS4A7","FCGR3A"]) sc.pl.umap(adata, color
The default is to plot gene expression in the normalized and log-transformed data. You can also plot it on the scaled and corrected data by using use_raw=False
. However, not all of these genes are included in the variable gene set, and hence are not included in the scaled adata.X
, so we first need to filter them.
= ["CD3E", "CD4", "CD8A", "GNLY","NKG7", "MS4A1","CD14","LYZ","CST3","MS4A7","FCGR3A"]
genes = adata.var.highly_variable
var_genes
var_genes.index[var_genes]= [x for x in genes if x in var_genes.index[var_genes]]
varg =varg, use_raw=False) sc.pl.umap(adata, color
Select some of your dimensionality reductions and plot some of the QC stats that were calculated in the previous lab. Can you see if some of the separation in your data is driven by quality of the cells?
=['n_genes_by_counts', 'total_counts', 'pct_counts_mt','pct_counts_ribo', 'pct_counts_hb'], ncols=3,use_raw=False) sc.pl.umap(adata, color
8 Save data
We can finally save the object for use in future steps.
'data/covid/results/scanpy_covid_qc_dr.h5ad') adata.write_h5ad(
9 Note
Just as a reminder, you need to keep in mind what you have in the X matrix. After these operations you have an X matrix with only variable genes, that are normalized, logtransformed and scaled.
We stored the expression of all genes in raw.X
after doing lognormalization so that matrix is a sparse matrix with logtransformed values.
print(adata.X.shape)
print(adata.raw.X.shape)
print(adata.X[:3,:3])
print(adata.raw.X[:10,:10])
(7222, 2626)
(7222, 19468)
[[-0.16998859 -0.06050171 -0.08070081]
[-0.19315341 -0.09975121 -0.31379319]
[-0.2051203 -0.11680799 -0.43194618]]
<Compressed Sparse Row sparse matrix of dtype 'float64'
with 2 stored elements and shape (10, 10)>
Coords Values
(1, 4) 0.7825693876867097
(8, 7) 1.1311041336746985
10 Session info
Click here
sc.logging.print_versions()
-----
anndata 0.10.8
scanpy 1.10.3
-----
CoreFoundation NA
Foundation NA
PIL 10.4.0
PyObjCTools NA
anyio NA
appnope 0.1.4
arrow 1.3.0
asciitree NA
asttokens NA
attr 24.2.0
attrs 24.2.0
babel 2.14.0
brotli 1.1.0
certifi 2024.08.30
cffi 1.17.1
charset_normalizer 3.3.2
cloudpickle 3.0.0
colorama 0.4.6
comm 0.2.2
cycler 0.12.1
cython_runtime NA
cytoolz 0.12.3
dask 2024.9.0
dateutil 2.9.0
debugpy 1.8.5
decorator 5.1.1
defusedxml 0.7.1
exceptiongroup 1.2.2
executing 2.1.0
fastjsonschema NA
fqdn NA
google NA
h5py 3.11.0
idna 3.10
igraph 0.11.6
ipykernel 6.29.5
isoduration NA
jedi 0.19.1
jinja2 3.1.4
joblib 1.4.2
json5 0.9.25
jsonpointer 3.0.0
jsonschema 4.23.0
jsonschema_specifications NA
jupyter_events 0.10.0
jupyter_server 2.14.2
jupyterlab_server 2.27.3
kiwisolver 1.4.7
legacy_api_wrap NA
leidenalg 0.10.2
llvmlite 0.43.0
markupsafe 2.1.5
matplotlib 3.9.2
matplotlib_inline 0.1.7
mpl_toolkits NA
msgpack 1.1.0
natsort 8.4.0
nbformat 5.10.4
networkx 3.3
numba 0.60.0
numcodecs 0.13.0
numpy 1.26.4
objc 10.3.1
overrides NA
packaging 24.1
pandas 1.5.3
parso 0.8.4
patsy 0.5.6
pickleshare 0.7.5
platformdirs 4.3.6
prometheus_client NA
prompt_toolkit 3.0.47
psutil 6.0.0
pure_eval 0.2.3
pycparser 2.22
pydev_ipython NA
pydevconsole NA
pydevd 2.9.5
pydevd_file_utils NA
pydevd_plugins NA
pydevd_tracing NA
pygments 2.18.0
pynndescent 0.5.13
pyparsing 3.1.4
pythonjsonlogger NA
pytz 2024.2
referencing NA
requests 2.32.3
rfc3339_validator 0.1.4
rfc3986_validator 0.1.1
rpds NA
scipy 1.14.1
send2trash NA
session_info 1.0.0
six 1.16.0
sklearn 1.5.2
sniffio 1.3.1
socks 1.7.1
sparse 0.15.4
sphinxcontrib NA
stack_data 0.6.2
statsmodels 0.14.3
texttable 1.7.0
threadpoolctl 3.5.0
tlz 0.12.3
toolz 0.12.1
torch 2.4.0.post101
torchgen NA
tornado 6.4.1
tqdm 4.66.5
traitlets 5.14.3
typing_extensions NA
umap 0.5.6
uri_template NA
urllib3 2.2.3
wcwidth 0.2.13
webcolors 24.8.0
websocket 1.8.0
yaml 6.0.2
zarr 2.18.3
zipp NA
zmq 26.2.0
zoneinfo NA
zstandard 0.23.0
-----
IPython 8.27.0
jupyter_client 8.6.3
jupyter_core 5.7.2
jupyterlab 4.2.5
notebook 7.2.2
-----
Python 3.10.10 | packaged by conda-forge | (main, Mar 24 2023, 20:17:34) [Clang 14.0.6 ]
macOS-14.6.1-x86_64-i386-64bit
-----
Session information updated at 2024-10-04 11:37