利用贝叶斯的方法获得cell cluster的marker基因

理论

参考文章为:genesorteR
简单理解下,每个cell type的marker基因,它们的表达量一定具有cell type特异性的

假设单细胞表达矩阵为m×n的单细胞表达矩阵,m个基因和n个cell,并且n个细胞划分到了k个cell cluster里面,作者通过贝叶斯公式:



来反应每个cell cluster中的基因特异性

其中:

  1. t ∈ { t1 , t2 ,..., tk },代表不同的cell cluster
  2. P( ti | gj ) 代表在检测到 gene j (gj)有表达的条件下,观测该cell(单个cell)属于 cell cluster ti 的概率;其中 gj 代表 gene j
  3. P( gj | ti ) 代表在 cell cluster ti 的细胞中检测到基因 gj 有表达的概率
  4. P( gj ) 代表全部的 n 个细胞中都检测到 gj 的概率
  5. P( ti ) 代表全部的 n 个细胞属于 cell cluster ti 的概率

那么试想哪一种基因属于marker呢?也就是说 P( ti | gj ) 值越大,则 gjcell cluster ti 的marker 基因概率越大,根据定义,当 gj 有表达的时候,划分某一个细胞为 cell cluster ti 的概率越大,反而越说明 gjcell cluster ti 的marker基因

接下来作者定义:


为cell cluster的特异性分数,当 si j 的值为 1 时,代表在 cell cluster ti 中的细胞都检测到了 gj,而其他类型的细胞中没有检测到 gj

定义marker基因特异性分数:


代码部分

完整的流程为:

library(genesorteR)

data(kidneyTabulaMuris) #three cell types from kidney (Tabula Muris data)

#get specificity scores for each cell type
sg = sortGenes(kidneyTabulaMuris$exp, kidneyTabulaMuris$cellType)

head(sg$specScore) #specificity scores for each gene in each cluster

#define a small set of markers
mm = getMarkers(sg, quant = 0.99)

#cluster genes and make a heatmap
pp = plotMarkerHeat(sg$inputMat, sg$inputClass, mm$markers, clusterGenes=TRUE,
 outs = TRUE)

pp$gene_class_info #gene clusters

1.函数 sortGenes

sortGenes = function(x, classLabels, binarizeMethod = "median", TF_IDF = FALSE, returnInput = TRUE, cores = 1) {
  
  # kidneyTabulaMuris$exp 为表达的单细胞稀疏矩阵
  x = kidneyTabulaMuris$exp
  # kidneyTabulaMuris$cellType 为每个细胞对应的细胞类型
  classLabels = kidneyTabulaMuris$cellType
  binarizeMethod = "median"
  TF_IDF = FALSE
  returnInput = TRUE
  cores = 1
  
  # 因子化标记每个细胞对应的细胞类型
  classLabels = as.factor(classLabels)
  ww = which(as.vector(table(classLabels)) == 1)    

  # 将不同的因子类型转换为数字
  classLabelsNum = as.integer(classLabels)
  # 将上一步的结果因子化
  classLabelsLab = levels(classLabels)
  
  # 转换为 dgCMatrix
  x = as(x, "dgCMatrix")
  
  # 计算稀疏矩阵有表达(有数值的,没有数值的不纳入计算)基因表达量的中位数
  ## 将所有细胞中各个有表达(有数值的,没有数值的不纳入计算)基因按每一列(每个细胞)为单位拼成一列向量,并计算中位数
  xbin = binarize(x, method = binarizeMethod)
  
  # 稀疏矩阵求行总和,并去除0表达的情况
  rem = which((Matrix::rowSums(xbin$mat)) == 0)
  if (length(rem) > 0) {
    xbin$mat = xbin$mat[-rem,]
  }
  
  # 求每一个细胞类别(1,2,3)的概率,每一类别的数量除以总数量
  classProb = getClassProb(classLabelsNum)
  # 命名
  names(classProb) = classLabelsLab
  
  # 计算每个基因的概率,每个基因在各个细胞表达量的总和除以总的细胞数
  geneProb = getGeneProb(xbin$mat)
  
  # 计算每一类细胞(cell cluster)中每个基因的平均表达量,并定义为概率 P( gj | ti )
  condGeneCluster = getGeneConditionalCluster_stats(xbin$mat, classProb, classLabels, cores = cores)
  # 利用贝叶斯公式计算每个基因的后验概率
  clusterPostGene = getClusterPostGene(condGeneCluster, geneProb, classProb)
  # 计算特异性分数
  specScore = getSpecScore(clusterPostGene, condGeneCluster)
  
  tf_idf = NULL
  if (TF_IDF) {
    tf_idf = getClusterTFIDF(condGeneCluster)
  }
  
 
  result = list(binary = xbin$mat, cutoff = xbin$cutoff, 
                removed = rem, geneProb = geneProb, 
                condGeneProb = condGeneCluster, postClustProb = clusterPostGene, 
                specScore = specScore, classProb = classProb, 
                inputMat = x, inputClass = classLabels, tf_idf = tf_idf)
}

小tip几个函数:

# 1 计算稀疏矩阵有表达(有数值的,没有数值的不纳入计算)基因表达量的中位数
binarize = function(x, method = "median") {
  # 计算稀疏矩阵有表达(有数值的,没有数值的不纳入计算)基因表达量的中位数
  if (method == "median") {
    pi = median(x@x)
  } else if (method == "mean") {
    pi = mean(x@x)
  } else if (method == "naive") {
    pi = min(x@x)
  } else if (method == "adaptiveMedian") {
    mm = Mclust(Matrix::rowSums(x), 1:20, modelNames=c("V"), verbose = FALSE)
    if (mm$G == 1) {
      stop("Error: you set binarizeMethod to adaptiveMedian but the optimal number of gene groups based on average expression is 1. Please use a different binarization method or use a different gene expression normalization. Also please consider reporting this error to mmibrahim@pm.me or on https://github.com/mahmoudibrahim/genesorteR/issues (preferred).")
    } else {
      pi = rep(0, mm$G)
      for (i in 1:mm$G) {
        pi[i] = median(x[which(mm$classification == i),]@x)
      }
    }
  } else if ((is.numeric(method)) & (method >= 0)) {
    pi = method
  } else {
    stop("Unrecognized binarization method! genesorteR stopped.")
  }
  
  
  if (method == "adaptiveMedian") {
    
    mat = list()
    for (i in 1:mm$G) {
      tx = x[which(mm$classification == i),]
      ww = which(tx@x >= pi[i])
      dp = diff(tx@p)
      colInd = (rep(seq_along(dp),dp))[ww]
      rowInd = (tx@i+1)[ww]
      genes = rownames(tx)
      mat[[i]] = Matrix::sparseMatrix(rowInd[1], colInd[1], dims=tx@Dim)
      mat[[i]][cbind(rowInd,colInd)] = 1
      mat[[i]] = as(mat[[i]], "dgCMatrix")
      rownames(mat[[i]]) = genes
    }
    mat = do.call(rbind, mat)
    x = mat[match(rownames(x),rownames(mat)),]
    
  } else {
    
    ww = which(x@x >= pi)
    dp = diff(x@p)
    colInd = (rep(seq_along(dp),dp))[ww]
    rowInd = (x@i+1)[ww]
    genes = rownames(x)
    x = Matrix::sparseMatrix(rowInd[1], colInd[1], dims=x@Dim)
    x[cbind(rowInd,colInd)] = 1
    x = as(x, "dgCMatrix")
    rownames(x) = genes
  }
  
  return(list(mat = x, cutoff = pi))
}


# 2 求每一个细胞类别(1,2,3)的概率,每一类别的数量除以总数量
getClassProb = function(x) {
  probs = table(x) / length(x)
  
  return(probs)
}

# 3 计算每个基因的概率,每个基因在各个细胞表达量的总和除以总的细胞数
getGeneProb = function(x) {
  ncell = ncol(x)
  
  probs = as.vector( (Matrix::rowSums(x)) / ncell )
  names(probs) = rownames(x)
  
  return(probs)
}

# 4 计算每一类细胞(cell cluster)中每个基因的平均表达量,并定义为概率 P( gj | ti )
getGeneConditionalCluster_stats = function(mat, classProb, classLabels, cores = 1) {
  lab = names(classProb)
  
  if (cores > 1) {
    geneProb = do.call(cbind, mclapply(1:length(lab), function(i) Matrix::rowMeans(mat[,which(classLabels == lab[i])]), mc.cores = cores))
  } else {
    geneProb = do.call(cbind, lapply(1:length(lab), function(i) Matrix::rowMeans(mat[,which(classLabels == lab[i])])))
  }
  
  geneProb = as(geneProb, "dgCMatrix")
  colnames(geneProb) = lab
  
  return(geneProb)
}


# 5 利用贝叶斯公式计算每个基因的后验概率
getClusterPostGene = function(condMat, geneProb, classProb) {
  
  # 计算贝叶斯公式的分子部分
  postProb = t(apply(log(condMat), 1, function(x) x + log(classProb)))
  # 计算贝叶斯公式的分母部分
  postProb = exp(apply(postProb, 2, function(x) x - log(geneProb)))
  
  colnames(postProb) = names(classProb)
  postProb = as(postProb, "dgCMatrix")
  
  return(postProb)  
}

# 6 计算特异性分数
getSpecScore = function(postMat, condMat) {
  # 计算特异性分数
  specScore = exp(log(postMat) + log(condMat))
  
  colnames(specScore) = colnames(condMat)
  specScore = as(specScore, "dgCMatrix")
  return(specScore)
}

注意这里的特异性分数的计算,由于变量condGeneCluster代表 P( gj | ti ),因此specScore = exp(log(postMat) + log(condMat))代表分数si j

2. 基于香农熵选出marker基因

library(mclust)
getMarkers = function(gs, quant = 0.99, mutualInfo = FALSE, classEnt = FALSE) {
  
  gs = sg
  quant = 0.99
  mutualInfo = FALSE
  classEnt = FALSE
  
  # 对 sij 分数进行标准化
  scored = apply(gs$specScore, 2, score)
  # 计算香浓熵
  ent = apply(scored, 1, getEntropy)
  # 排序并选出最大的值
  maxi = apply(scored, 1, max)
  ww = which(maxi > quantile(maxi, probs=quant))
  m = Mclust(ent[ww], 2, modelNames="E", verbose = FALSE)
  # 选出marker基因
  markers = names( which(m$classification == (which.min(m$parameters$mean)) ) )
  
  mutInfo = NULL
  if (mutualInfo == TRUE) {
    mutInfo = apply(gs$binary, 1, function(x) getMutInfo(x,gs$inputClass))
  }
  
  classEntropy = NULL
  if (classEnt == TRUE) {
    classEntropy = apply(scored, 2, getEntropy)
    names(classEntropy) = colnames(gs$specScore)
  }
  
  return(list(gene_shannon_index = ent, maxScaledSpecScore = maxi, markers = markers, 
              mutInfo = mutInfo, classEntropy = classEntropy))
}

几个函数:

score = function(x) {
  x  = ((x-min(x))/(max(x)-min(x)))
  return(x)
}

getEntropy = function(x) {
  ent = 0
  w = which(x > 0)
  if (length(w) > 0) {
    w = x[w]
    ent = -(sum(w * (log(w))))
  }
  return(ent)
}
©著作权归作者所有,转载或内容合作请联系作者
  • 序言:七十年代末,一起剥皮案震惊了整个滨河市,随后出现的几起案子,更是在滨河造成了极大的恐慌,老刑警刘岩,带你破解...
    沈念sama阅读 204,445评论 6 478
  • 序言:滨河连续发生了三起死亡事件,死亡现场离奇诡异,居然都是意外死亡,警方通过查阅死者的电脑和手机,发现死者居然都...
    沈念sama阅读 85,889评论 2 381
  • 文/潘晓璐 我一进店门,熙熙楼的掌柜王于贵愁眉苦脸地迎上来,“玉大人,你说我怎么就摊上这事。” “怎么了?”我有些...
    开封第一讲书人阅读 151,047评论 0 337
  • 文/不坏的土叔 我叫张陵,是天一观的道长。 经常有香客问我,道长,这世上最难降的妖魔是什么? 我笑而不...
    开封第一讲书人阅读 54,760评论 1 276
  • 正文 为了忘掉前任,我火速办了婚礼,结果婚礼上,老公的妹妹穿的比我还像新娘。我一直安慰自己,他们只是感情好,可当我...
    茶点故事阅读 63,745评论 5 367
  • 文/花漫 我一把揭开白布。 她就那样静静地躺着,像睡着了一般。 火红的嫁衣衬着肌肤如雪。 梳的纹丝不乱的头发上,一...
    开封第一讲书人阅读 48,638评论 1 281
  • 那天,我揣着相机与录音,去河边找鬼。 笑死,一个胖子当着我的面吹牛,可吹牛的内容都是我干的。 我是一名探鬼主播,决...
    沈念sama阅读 38,011评论 3 398
  • 文/苍兰香墨 我猛地睁开眼,长吁一口气:“原来是场噩梦啊……” “哼!你这毒妇竟也来了?” 一声冷哼从身侧响起,我...
    开封第一讲书人阅读 36,669评论 0 258
  • 序言:老挝万荣一对情侣失踪,失踪者是张志新(化名)和其女友刘颖,没想到半个月后,有当地人在树林里发现了一具尸体,经...
    沈念sama阅读 40,923评论 1 299
  • 正文 独居荒郊野岭守林人离奇死亡,尸身上长有42处带血的脓包…… 初始之章·张勋 以下内容为张勋视角 年9月15日...
    茶点故事阅读 35,655评论 2 321
  • 正文 我和宋清朗相恋三年,在试婚纱的时候发现自己被绿了。 大学时的朋友给我发了我未婚夫和他白月光在一起吃饭的照片。...
    茶点故事阅读 37,740评论 1 330
  • 序言:一个原本活蹦乱跳的男人离奇死亡,死状恐怖,灵堂内的尸体忽然破棺而出,到底是诈尸还是另有隐情,我是刑警宁泽,带...
    沈念sama阅读 33,406评论 4 320
  • 正文 年R本政府宣布,位于F岛的核电站,受9级特大地震影响,放射性物质发生泄漏。R本人自食恶果不足惜,却给世界环境...
    茶点故事阅读 38,995评论 3 307
  • 文/蒙蒙 一、第九天 我趴在偏房一处隐蔽的房顶上张望。 院中可真热闹,春花似锦、人声如沸。这庄子的主人今日做“春日...
    开封第一讲书人阅读 29,961评论 0 19
  • 文/苍兰香墨 我抬头看了看天上的太阳。三九已至,却和暖如春,着一层夹袄步出监牢的瞬间,已是汗流浃背。 一阵脚步声响...
    开封第一讲书人阅读 31,197评论 1 260
  • 我被黑心中介骗来泰国打工, 没想到刚下飞机就差点儿被人妖公主榨干…… 1. 我叫王不留,地道东北人。 一个月前我还...
    沈念sama阅读 45,023评论 2 350
  • 正文 我出身青楼,却偏偏与公主长得像,于是被迫代替她去往敌国和亲。 传闻我的和亲对象是个残疾皇子,可洞房花烛夜当晚...
    茶点故事阅读 42,483评论 2 342

推荐阅读更多精彩内容