RNA 速率這個概念最初是在2018年提出的,可以通過測序結(jié)果與mRNA剪切動力學(xué)相關(guān)聯(lián),利用新轉(zhuǎn)錄的未剪接的前體 mRNA 和成熟的剪接 mRNA 可以在常見的scRNA-seq、stRNA-seq 流程中區(qū)分的事實(shí),可以恢復(fù)定向動態(tài)信息,從而探索方向軌跡的演化。目前RNA速率分析可廣泛應(yīng)用于免疫微環(huán)境、發(fā)育模式、遺傳進(jìn)化等方向。那么今天我們一起來學(xué)習(xí)一下RNA速率分析流程及方法有哪些。
RNA速率分析1、獲得重復(fù)序列注釋文件
軟件依賴:RMBlast、TRF ——> conda 安裝即可
數(shù)據(jù)依賴:Repbase數(shù)據(jù)庫
鏈接:https://pan.baidu.com/s/1F4E5-6XaVni1I_S97TEIDg 提取碼:zq7t
下載后解壓得到一個Libraries的文件夾
Repeatmasker下載:wget http://www.repeatmasker.org/RepeatMasker-open-4-0-6.tar.gz
下載后解壓,將第二步 數(shù)據(jù)依賴 中Libraries文件夾下的內(nèi)容拷貝到Repeatmasker目錄下Libraries文件夾中
cp Libraries/* /path/to/Repeatmasker/Libraries/
安裝可參考以下教程:
基因組重復(fù)序列檢測:RepeatMasker的安裝及使用可自行搜索安裝
運(yùn)行Repeatmasker:
/share/nas1/guochao/biosoftware/RepeatMasker/RepeatMasker -pa 60 -species “Mus musculus” -poly -html -gff -dir repeat /path/to/genome.fa
-species : 物種拉丁名
-dir : 輸出結(jié)果目錄,需提前創(chuàng)建好!
RNA速率分析2、構(gòu)建loom文件
安裝velocyto:pip install -i https://pypi.tuna.tsinghua.edu.cn/simple velocyto
具體安裝方法可自行搜索
處理bam文件
perl腳本:
鏈接:https://pan.baidu.com/s/1F4E5-6XaVni1I_S97TEIDg? ? 提取碼:zq7t
perl am_add_flag.pl <BSTViewer_project/subdata/L1_heAuto/barcodes.tsv.gz> <sample/barcode.tsv> <BSTViewer_project/level_matrix/level_1/barcodes_cluster.tsv.gz>
:BSTMatrix輸出結(jié)果 01.fastq2BcUmi目錄下xxx.bc_umi_read.tsv.id
: BSTMatrix輸出結(jié)果05.AllheStat目錄下BSTViewer_project/subdata/L1_heAuto/barcodes.tsv.gz
<sample/barcode.tsv>: BSTMatrix輸出結(jié)果樣本名稱目錄下barcode.tsv文件
:BSTMatrix輸出結(jié)果05.AllheStat目錄BSTViewer_project/level_matrix/level_1/barcodes_cluster.tsv.gz
: BSTMatrix輸出結(jié)果 03.Umi2Gene 目錄下 xxxAligned.sortedByCoord.out.bam
: 輸出路徑
運(yùn)行velocyto:
velocyto run -o ./ -m /path/mouse/mus_repeat.gtf new.bam ../mouse/genes.gtf
-o : 輸出路徑
-m : 重復(fù)序列注釋文件(第一步獲得)
R轉(zhuǎn)化loom文件為h5ad文件
library(Seurat)
library(SeuratWrappers)
library(SeuratDisk)
loom_data bm bm[[“RNA”]] bm bm bm bm bm
DefaultAssay(bm) <- “RNA”
SaveH5Seurat(bm, filename = “test.h5Seurat”)
Convert(“test.h5Seurat”, dest = “h5ad”)
scvelo RNA速率分析
adata = scv.read(‘/path/test.h5ad’)
scv.pp.filter_and_normalize(adata, min_shared_counts=20, n_top_genes=2000)
scv.pp.moments(adata, n_pcs=30, n_neighbors=30)
scv.tl.velocity(adata)
scv.tl.velocity_graph(adata)
scv.set_figure_params(dpi=300)
scv.pl.velocity_embedding_stream(adata, basis=”umap”, size= 10, alpha=0.6, color=”seurat_clusters”)

RNA速率分析