当前位置:网站首页>补充材料 supplementary
补充材料 supplementary
2022-06-30 15:48:00 【youngleeyoung】
load("G:/silicosis/geo/GSE104154_scRNA-seq_fibrotic MC_bleomycin/normalized/only_AMs.rds")
markers=FindAllMarkers(subset_data,only.pos = T)
#openxlsx::write.xlsx(markers,file = "G:/silicosis/geo/GSE104154_scRNA-seq_fibrotic MC_bleomycin/normalized/makers_for_AM1_AM2_AM3.xlsx")
markers=openxlsx::read.xlsx("G:/silicosis/geo/GSE104154_scRNA-seq_fibrotic MC_bleomycin/normalized/makers_for_AM1_AM2_AM3.xlsx")
head(markers)
mymarkers=list()
for (eachcluster_markers in unique(markers$cluster)) {
#eachcluster_markers="AM1"
mymarkers[[paste0(eachcluster_markers)]]=markers[markers$cluster==eachcluster_markers,"gene"]
}
head(mymarkers)
fibrosis_gene=openxlsx::read.xlsx("G:/silicosis/fibrosis_geness/harmonizome_gfibrosis.xlsx")
head(fibrosis_gene)
fibrosis_gene=fibrosis_gene$Symbol
#intersect_fibrosis_gene_with_AM
intersected_fibrosis_genes=list()
for (eachcluster_AM in names(mymarkers)) {
intersected_fibrosis_genes[[eachcluster_AM]]=intersect(mymarkers[[eachcluster_AM]],fibrosis_gene)
}
intersected_fibrosis_genes
lapply(intersected_fibrosis_genes,length)
intersected_fibrosis_genes_as_a_vector=as.vector(unlist(intersected_fibrosis_genes))
marker_exp=AverageExpression(subset_data, features = intersected_fibrosis_genes_as_a_vector, return.seurat = TRUE)
DoHeatmap(marker_exp, features = intersected_fibrosis_genes_as_a_vector,
label=TRUE, group.bar = TRUE, draw.lines = FALSE)
getwd()
pdf('heatmap.pdf',width = 7,height = 14)
p=DoHeatmap(marker_exp, features = intersected_fibrosis_genes_as_a_vector,
label=TRUE, group.bar = TRUE, draw.lines = FALSE)
print(p)
dev.off()
#supplementary table S7
PF_silicosis_bleo=openxlsx::read.xlsx("G:\\silicosis\\sicosis\\Supplementary Table.xlsx",
sheet = "S7_hPF_Silica_Bleomycin")
head(PF_silicosis_bleo)
library(Hmisc)
library(dplyr)
disease_markers_for_AM3=list()
for (eachdisease in colnames(PF_silicosis_bleo)) {
#eachdisease="Silicosis,.Cluster.AM3"
disease_markers_for_AM3[[paste0(eachdisease)]]=PF_silicosis_bleo[,eachdisease] %>%
capitalize()%>% tolower() %>% na.omit() %>% unique() %>%capitalize()
}
head(disease_markers_for_AM3)
#https://www.jianshu.com/p/58f5429b5402
genes <- Reduce(intersect, list(disease_markers_for_AM3[[1]],
disease_markers_for_AM3[[2]],
disease_markers_for_AM3[[3]])) %>% capitalize()
length(genes)
getwd()
library(VennDiagram)#https://www.jianshu.com/p/b5a4c40c3a33
venn_list <- list(Human_PF = disease_markers_for_AM3[[1]],
Silicosis = disease_markers_for_AM3[[2]],
Bleomycin=disease_markers_for_AM3[[3]])
venn.diagram(venn_list, filename = 'venn2_for_humanPF-Silicosi-Bleomycin.png', imagetype = 'png',
fill = c('red', 'blue','orange'), alpha = 0.50, cat.col = rep('black', 3),
col = 'black', cex = 1.3, fontfamily = 'serif',
cat.cex = 1.3, cat.fontfamily = 'serif')
getwd()
#继续以上述4个分组为例,组间交集元素获得
inter <- get.venn.partitions(venn_list)
for (i in 1:nrow(inter)) inter[i,'values'] <- paste(inter[[i,'..values..']], collapse = ', ')
write.table(inter[-c(5, 6)], 'venn4_inter.txt', row.names = FALSE, sep = '\t', quote = FALSE)
for (i in 1:nrow(inter)) inter[i,'values'] <- paste(inter[[i,'..values..']], collapse = ', ')
openxlsx::write.xlsx(inter[-c(5, 6)], 'venn4_inter.xlsx', row.names = FALSE, sep = '\t', quote = FALSE)
边栏推荐
- 【机器学习】K-means聚类分析
- Niuke: how many different binary search trees are there
- [bjdctf2020]the mystery of ip|[ciscn2019 southeast China division]web11|ssti injection
- 删除有序数组中的重复项 II[双指针--多情况统一]
- Tencent two sides: @bean and @component are used on the same class. What happens?
- 7 月 2 日邀你来TD Hero 线上发布会
- Mathematical modeling for war preparation 36 time series model 2
- Additional: (not written yet, don't look at ~ ~ ~) webmvcconfigurer interface;
- [wechat applet] the hosting environment of the applet
- IO流_递归
猜你喜欢
9: Chapter 3: e-commerce engineering analysis: 4: [general module]; (to be written...)
编译丨迅为STM32P157开发板编译U-Boot源码
【微信小程序】小程序的宿主环境
Mathematical modeling for war preparation 33- grey prediction model 2
Rongsheng biology rushes to the scientific innovation board: it plans to raise 1.25 billion yuan, with an annual revenue of 260million yuan
居家办公浅谈远程协助快速提效心得 | 社区征文
[wechat applet] the hosting environment of the applet
香港回归25周年 香港故宫博物馆正式开放成文化新地标
JS Es5 can also create constants?
【微信小程序】常用组件基本使用(view/scroll-view/swiper、text/rich-text、button/image)
随机推荐
Etcd教程 — 第九章 Etcd之实现分布式锁
jspreadsheet/CE JExcel数据字段比给的字段(columns)多会导致空白列的问题解决方案
TCP Socket与TCP 连接
Raft introduction
2022 Blue Bridge Cup group B - expense reimbursement - (linear dp| status DP)
山西化工园区智能化管控平台建设时间表
I implement "stack" with C I
删除有序数组中的重复项 II[双指针--多情况统一]
Niuke network: longest continuous subarray with positive product
Halcon knowledge: regional topics [07]
2022蓝桥杯国赛B组-2022-(01背包求方案数)
Go micro tutorial - Chapter 1 getting started
2020 Blue Bridge Cup group B - move bricks - (greedy sorting +01 backpack)
药品管理系统加数据库,一夜做完,加报告
搬运两个负载均衡的笔记,日后省的找
differential analysis between different groups nichenet for silicosis成功运行!
On July 2, I invited you to TD Hero online conference
register_ Chrdev and CDEV_ init cdev_ Add usage differences
IndexSearch
Mathematical modeling for war preparation 36 time series model 2