原文地址:http://www.reibang.com/p/50bcf4ba9d8a
(代碼太多擎淤,請看原貼)
還有 系統(tǒng)的使用affy處理芯片望几,看原貼:
http://www.reibang.com/p/859a7a7d040f
http://www.reibang.com/p/ccafb8a184c3
http://www.reibang.com/p/f44dc5d39bed
http://www.reibang.com/p/e867ed33f43e
http://www.reibang.com/p/cc171c5faf46
1. 快速入門
安裝并加載所需R包
source("http://bioconductor.org/biocLite.R");
biocLite(“CLL”)
# 載入CLL包棘幸,CLL包會自動調(diào)用affy包傅物,該包含有一系列處理函數(shù)
library(CLL)# read example dataset,(CLL包附帶的示例數(shù)據(jù)集)data("CLLbatch")# pre-process using RMA methodCLLrma<- rma(CLLbatch)# read expression value after pre-processinge <- exprs(CLLrma)# 查看部分?jǐn)?shù)據(jù)e[1:5,1:5]
image.png
2. 基因芯片數(shù)據(jù)預(yù)處理
2.1 數(shù)據(jù)輸入
# 載入CLL包翰绊,CLL包會自動調(diào)用affy包迅诬,該包含有一系列處理函數(shù)library(CLL)# read example dataset腋逆,(CLL包附帶的示例數(shù)據(jù)集)data("CLLbatch")# 查看數(shù)據(jù)類型data.class(CLLbatch)# 讀入所有樣本的狀態(tài)信息data(disease)# 查看所有樣本的狀態(tài)信息disease
image.png
# 查看"AffyBatch"的詳細(xì)介紹help(AffyBatch)phenoData(CLLbatch)featureData(CLLbatch)protocolData(CLLbatch)annotation(CLLbatch)exprs_matrix <- assayData(CLLbatch)[[1]]exprs_matrix[1:5,1:5]exprs(CLLbatch)[1:5,1:5]
image.png
2.2 質(zhì)量控制
質(zhì)量控制分三步,直觀觀察侈贷,平均值方法惩歉,數(shù)據(jù)擬合方法。這三個(gè)層次的質(zhì)量控制分別由image 函數(shù)俏蛮、simpleaffy 包和affyPLM包實(shí)現(xiàn)
2.2.1 用image包對芯片數(shù)據(jù)進(jìn)行質(zhì)量評估
# 查看第一張芯片的灰度圖像image(CLLbatch[,1])
如果圖像特別黑撑蚌,說明型號強(qiáng)度低;如果圖像特別亮搏屑,說明信號強(qiáng)度很有可能過飽和
image.png
2.2.2 用simpleaffy包對芯片數(shù)據(jù)進(jìn)行質(zhì)量評估
# 安裝simpleaffy包source('http://Bioconductor.org/biocLite.R')biocLite("simpleaffy")library(BiocInstaller)biocLite("simpleaffy")library(simpleaffy)library(CLL)data(CLLbatch)# 獲取質(zhì)量分析報(bào)告Data.qc <- qc(CLLbatch)# 圖型化顯示報(bào)告plot(Data.qc)
image.png
第一列是所有樣品的名稱
第二列檢出率和平均背景噪聲(往往較高的平均背景噪聲都伴隨著較低的檢出率)
第三列
藍(lán)色實(shí)現(xiàn)為尺度因子争涌,取值(-3,3)
"o" 不能超過1.25辣恋,否則數(shù)據(jù)質(zhì)量不好
“三角型“不能超過3亮垫,否則數(shù)據(jù)質(zhì)量不好
bioB 說明芯片檢測沒有達(dá)標(biāo)
2.2.3 用affyPLM包對芯片數(shù)據(jù)進(jìn)行質(zhì)量評估
source('http://Bioconductor.org/biocLite.R')biocLite('affyPLM')library(affyPLM)data(CLLbatch)# 對數(shù)據(jù)集做回歸分析模软,結(jié)果為一個(gè)PLMset類型的對象Pset <- fitPLM(CLLbatch)image(CLLbatch[,1])# 根據(jù)計(jì)算結(jié)果,畫權(quán)重圖image(Pset,type="weights",which=1, main="Weights")# 根據(jù)計(jì)算結(jié)果饮潦,畫殘差圖image(Pset,type="resids",which=1, main="Residuals")# 根據(jù)計(jì)算結(jié)果燃异,畫殘差符號圖image(Pset,type="sign.resids",which=1, main="Residuals.sign")
image.png
image.png
2.2.4 查看總體質(zhì)量
一個(gè)樣品的所有探針組的RLE分布可以用一個(gè)統(tǒng)計(jì)學(xué)中常用的箱型圖形表示
source('http://Bioconductor.org/biocLite.R')biocLite("RColorBrewer")library(affyPLM)library(RColorBrewer)library(CLL)# 讀入數(shù)據(jù)data("CLLbatch")# 對數(shù)據(jù)集做回歸計(jì)算Psel<-fitPLM(CLLbatch)# 載入一組顏色colors<-brewer.pal(12,"Set3")# 繪制RLE箱線圖Mbox(Pset, ylim=c(-1,1),col=colors,main="RLE",las=3);# 繪制NUSE箱線圖boxplot(Pset,ylim=c(0.95,1.22),col=colors,main="NUSE",las=3)
從以下兩幅圖中可以看出CLL1,CLL10 的質(zhì)量明顯有別與其他樣品继蜡,需要去除
image.png
image.png
2.2.5 查看RNA降解曲線
source('http://Bioconductor.org/biocLite.R')biocLite("affy")library(affy)library(RColorBrewer)library(CLL)data("CLLbatch")# 獲取降解數(shù)據(jù)data.deg <- AffyRNAdeg(CLLbatch)# 載入一組顏色colors <- brewer.pal(12,"Set3")# 繪制RNA降解圖plotAffyRNAdeg(data.deg, col=colors)# 在左上部位加注圖注legend("topleft", rownames(pData(CLLbatch)), col=colors, lwd=1, inset=0.05, cex=0.5)
image.png
去掉三個(gè)質(zhì)量差的
CLLbatch<-CLLbatch[, -match(c("CLL10.CEL","CLL1.CEL","CLL13.CEL"),? ? ? ? ? ? ? ? ? ? ? ? ? ? ? sampleNames(CLLbatch))]
2.2.6 從聚類分析的角度看數(shù)據(jù)質(zhì)量
source('http://Bioconductor.org/biocLite.R')biocLite("gcrma")biocLite("graph")biocLite("affycoretools")library(CLL)library(gcrma)library(graph)library(affycoretools)data(CLLbatch)data("disease")# 使用gcrma算法來預(yù)處理數(shù)據(jù)CLLgcrma<-gcrma(CLLbatch)# 提取基因表達(dá)矩陣eset<-exprs(CLLgcrma)# 計(jì)算樣品兩兩之間的Pearson相關(guān)系數(shù)pearson_cor<-cor(eset)# 得到Pearson距離的下三角矩陣dist.lower<-as.dist(1-pearson_cor)# 聚類分析hc<-hclust(dist.lower,"ave")plot(hc)# PCA分析samplenames<-sub(pattern="\\.CEL", replacement ="",colnames(eset))groups<-factor(disease[,2])plotPCA(eset,addtext=samplenames,groups=groups,groupnames=levels(groups))
從聚類分析的結(jié)果來看回俐,穩(wěn)定組(紅框)和惡化組分不開
image.png
從主成成份分析來看,也分不開
image.png
2.3 背景校正稀并、標(biāo)準(zhǔn)化和匯總
芯片數(shù)據(jù)通過質(zhì)量控制仅颇,剔除不合格的樣品,留下的樣品數(shù)據(jù)往往要通過三步處理(背景校正稻轨、標(biāo)準(zhǔn)化和匯總)才能得到下一步分析所需要的基因表達(dá)矩陣
去除背景噪聲的過程叫背景校正
標(biāo)準(zhǔn)化目的是使各次/組測量或各種實(shí)驗(yàn)條件下的測量可以相互比較
使用一定的統(tǒng)計(jì)方法將前面得到的熒光強(qiáng)度值從探針?biāo)絽R總到探針組水平
> bgcorrect.methods()[1]"bg.correct""mas""none""rma"> normalize.methods(CLLbatch) [1]"constant""contrasts""invariantset""loess""methods""qspline"[7]"quantiles""quantiles.robust""quantiles.probeset""scaling"> pmcorrect.methods()[1]"mas""methods""pmonly""subtractmm"> express.summary.stat.methods()[1]"avgdiff""liwong""mas""medianpolish""playerout"
參數(shù)說明
afbatch輸入數(shù)據(jù)的類型必須是AffyBatch對象
bgcorrect.method背景校正方法
bgcorrect.param指定背景校正方法的參數(shù)
normalize.method標(biāo)準(zhǔn)化方法
normalize.param指定標(biāo)準(zhǔn)化方法的參數(shù)
pmcorrect.methodPM調(diào)整方法
pmcorrect.param指定PM方法參數(shù)
summary.method匯總方法
summary.param指定匯總方法的參數(shù)
芯片內(nèi)標(biāo)準(zhǔn)化(Loess)前后MA圖
# 使用mas方法做背景校正>CLLmas5<- bg.correct(CLLbatch, method ="mas")# 使用constant方法標(biāo)準(zhǔn)化> data_mas5 <- normalize(CLLmas5, method="constant")# 查看每個(gè)樣品的縮放系數(shù)> head(pm(data_mas5)/pm(CLLmas5),5)CLL11.CELCLL12.CELCLL14.CELCLL15.CELCLL16.CELCLL17.CELCLL18.CELCLL19.CELCLL20.CELCLL21.CELCLL22.CELCLL23.CEL17521811.1558491.0238731.4931931.5493692.0002991.4515761.7765010.98251080.70708280.99587331.43236535668911.1558491.0238731.4931931.5493692.0002991.4515761.7765010.98251080.70708280.99587331.43236522769611.1558491.0238731.4931931.5493692.0002991.4515761.7765010.98251080.70708280.99587331.43236523791911.1558491.0238731.4931931.5493692.0002991.4515761.7765010.98251080.70708280.99587331.43236527517311.1558491.0238731.4931931.5493692.0002991.4515761.7765010.98251080.70708280.99587331.432365CLL24.CELCLL2.CELCLL3.CELCLL4.CELCLL5.CELCLL6.CELCLL7.CELCLL8.CELCLL9.CEL1752181.7060261.1563780.84254190.97750820.98165731.1829631.1149761.136390.89392483566891.7060261.1563780.84254190.97750820.98165731.1829631.1149761.136390.89392482276961.7060261.1563780.84254190.97750820.98165731.1829631.1149761.136390.89392482379191.7060261.1563780.84254190.97750820.98165731.1829631.1149761.136390.89392482751731.7060261.1563780.84254190.97750820.98165731.1829631.1149761.136390.8939248# 查看第二個(gè)樣品的縮放系數(shù)是怎么計(jì)算來的> mean(intensity(CLLmas5)[,1])/mean(intensity(CLLmas5)[,2])[1]1.155849
2.4 預(yù)處理的一體化算法
預(yù)處理方法
方法背景校正方法標(biāo)準(zhǔn)化方法匯總方法
MASSmasconstantmas
dChipmasinvariantsetliwong
RMArmaquantilemedianpolish
MAS5 每個(gè)芯片可以單獨(dú)進(jìn)行標(biāo)準(zhǔn)化灵莲;RMA 采用多芯片模型雕凹,需要對所有芯片一起進(jìn)行標(biāo)準(zhǔn)化殴俱。
MAS5 利用MM探針的信息去除背景噪聲,基本思路是MP-MM枚抵;RMA 不使用MM信息线欲,而是基于PM信號分布采用的隨機(jī)模型來估計(jì)表達(dá)值。
RMA處理后的數(shù)據(jù)是經(jīng)過2為底的對數(shù)轉(zhuǎn)換的汽摹,而MAS5不是李丰,這一點(diǎn)非常重要,因?yàn)榇蠖鄶?shù)芯片分析軟件和函數(shù)的輸入數(shù)據(jù)必須經(jīng)過對數(shù)變換逼泣。
比較不同算法的處理效果
library(affy)library(gcrma)library(affyPLM)library(RColorBrewer)library(CLL)data("CLLbatch")colors <- brewer.pal(12,"Set3")# use MAS5CLLmas5<- mas5(CLLbatch)# use rma CLLrma<- rma(CLLbatch)# use gcrmaCLLgcrma<- gcrma(CLLbatch)## hist plothist(CLLbatch, main="orignal", col=colors)legend("topright", rownames(pData(CLLbatch)), col=colors,? ? ? lwd=1, inset=0.05, cex=0.5, ncol=3)hist(CLLmas5, main="MAS 5.0", xlim=c(-150,2^10), col=colors)hist(CLLrma, main="RMA", col=colors)hist(CLLgcrma, main="gcRMA", col=colors)## boxplotboxplot(CLLbatch, col=colors, las=3, main="original")boxplot(CLLmas5, col=colors, las=3, ylim=c(0,1000), main="MAS 5.0")boxplot(CLLrma, col=colors, las=3, main="RMA")boxplot(CLLgcrma, col=colors, las=3, main="gcRMA")
RMA算法將多條曲線重合到了一起趴泌,有利于進(jìn)一步的差異分析,但卻出現(xiàn)了雙峰現(xiàn)象拉庶,不符合高斯正態(tài)分布嗜憔。很顯然gcRMA算法在這里表現(xiàn)的更好。
image.png
image.png
image.png
image.png
三個(gè)算法處理后的各樣品的中值都十分接近氏仗。MAS5算法總體而言還不錯(cuò)吉捶,有一定拖尾現(xiàn)象;而gcRMA的拖尾現(xiàn)象比RMA要明顯得多皆尔。這說明針對低表達(dá)量的基因呐舔,RMA算法比gcRMA算法表現(xiàn)更好一些。
image.png
image.png
image.png
image.png
通過MA圖來查看標(biāo)準(zhǔn)化處理的效
library(gcrma)library(RColorBrewer)library(CLL)library(affy)data("CLLbatch")colors<-brewer.pal(12."Set3")CLLgcrma<-gcrma(CLLbatch)MAplot(CLLbatch[,1:4],pairs=TRUE,plot.method="smoothScatter",cex=0.8,main="original MA plot")MAplot(CLLgcrma[,1:4],pairs=TRUE,plot.method="smoothScatter",cex=0.8,main="gcRMA MA plot")
原始數(shù)據(jù)中慷蠕,中值(紅線)偏離0珊拼,經(jīng)過gcRMA處理后,中值基本保持在零線上流炕。
image.png
image.png
3 基因芯片數(shù)據(jù)分析
3.1 選取差異表達(dá)基因
######## DEG analysis# 如果沒有安裝limma包杆麸,請取消下面兩行注釋# library(BiocInstaller)# biocLite("limma")# 導(dǎo)入包library(limma)library(gcrma)library(CLL)# 導(dǎo)入CLL數(shù)據(jù)data("CLLbatch")data(disease)# 移除 CLL1, CLL10, CLL13CLLbatch<-CLLbatch[, -match(c("CLL10.CEL","CLL1.CEL","CLL13.CEL"),? ? ? ? ? ? ? ? ? ? ? ? ? ? ? sampleNames(CLLbatch))]# 用gcRMA算法進(jìn)行預(yù)處理CLLgcrma<- gcrma(CLLbatch)# remove .CEL in sample namessampleNames(CLLgcrma) <- gsub(".CEL$","", sampleNames(CLLgcrma))# remove record in data disease about CLL1, 10 and 13.CELdisease <- disease[match(sampleNames(CLLgcrma), disease[,"SampleID"]), ]# 獲得余下21個(gè)樣品的基因表達(dá)矩陣eset <- exprs(CLLgcrma)# 提取實(shí)驗(yàn)條件信息disease <- factor(disease[,"Disease"])# 構(gòu)建實(shí)驗(yàn)設(shè)計(jì)矩陣design <- model.matrix(~-1+disease)# 構(gòu)建對比模型搁进,比較兩個(gè)實(shí)驗(yàn)條件下表達(dá)數(shù)據(jù)# 這里的.是簡寫而不是運(yùn)算符號contrast.matrix <- makeContrasts(contrasts ="diseaseprogres. - diseasestable",? ? ? ? ? ? ? ? ? ? ? ? ? ? ? ? levels=design)# 線性模型擬合fit <- lmFit(eset, design)# 根據(jù)對比模型進(jìn)行差值計(jì)算 fit1 <- contrasts.fit(fit, contrast.matrix)# 貝葉斯檢驗(yàn)fit2 <- eBayes(fit1)# 生成所有基因的檢驗(yàn)結(jié)果報(bào)告dif <- topTable(fit2, coef="diseaseprogres. - diseasestable", n=nrow(fit2), lfc=log2(1.5))# 用P.Value進(jìn)行篩選,得到全部差異表達(dá)基因dif <- dif[dif[,"P.Value"]<0.01,]# 顯示一部分報(bào)告結(jié)果head(dif)
>head(dif)logFCAveExprtP.Valueadj.P.ValB39400_at-0.99978505.634004-5.7273291.482860e-050.10345442.44583541303_at-1.34303064.540225-5.5968131.974284e-050.10345442.154635033791_at1.96479626.8379035.4004993.047498e-050.10345441.713558336131_at0.95742149.9453345.3677413.277762e-050.10345441.639622337636_at2.05340935.4786835.1205195.699454e-050.14391121.078831336122_at0.80086047.1462934.7767211.241402e-040.26121180.2922106
下面逐次介紹這個(gè)分析過程的六個(gè)關(guān)鍵步驟:構(gòu)建基因表達(dá)矩陣昔头、構(gòu)建實(shí)驗(yàn)設(shè)計(jì)矩陣饼问、構(gòu)建對比模型(對比矩陣)、線性模型擬合揭斧、貝葉斯檢驗(yàn)和生成結(jié)果報(bào)表莱革。
design
image.png
3.2 注釋
# 加載注釋工具包library(annotate)# 獲得基因芯片注釋包名稱affydb <- annPkgName(CLLbatch@annotation,type="db")affydb# 如果沒有安裝,先安裝biocLite(affydb)# 加載該包library(affydb, character.only = TRUE)# 根據(jù)每個(gè)探針組的ID獲取對應(yīng)基因Gene Symbol讹开,并作為新的一列dif$symbols<- getSYMBOL(rownames(dif), affydb)# 根據(jù)探針I(yè)D獲取對應(yīng)基因Entrez IDdif$EntrezID<- getEG(rownames(dif), affydb)# 顯示前幾行head(dif)
image.png
3.3 統(tǒng)計(jì)分析及可視化
# 加載包library(GOstats)# 提取HG_U95Av2芯片中所有探針組對應(yīng)的EntrezID盅视,注意保證uniqentrezUniverse <- unique(unlist(mget(rownames(eset), hgu95av2ENTREZID)))# 提取差異表達(dá)基因及其對應(yīng)的EntrezIDentrezSelected <- unique(dif[!is.na(dif$EntrezID),"EntrezID"])# 設(shè)置GO富集分析的所有參數(shù)params <-new("GOHyperGParams", geneIds=entrezSelected, universeGeneIds=entrezUniverse,? ? ? ? ? ? ? annotation=affydb, ontology="BP", pvalueCutoff=0.001, conditional=FALSE,? ? ? ? ? ? ? testDirection="over")# 對所有的GOterm根據(jù)params參數(shù)做超幾何檢驗(yàn)hgOver <- hyperGTest(params)# 生成所有GOterm的檢驗(yàn)結(jié)果報(bào)表bp <- summary(hgOver)# 同時(shí)生成所有GOterm的檢驗(yàn)結(jié)果文件,每個(gè)GOterm都有指向官方網(wǎng)站的鏈接旦万,以獲得詳細(xì)信息htmlReport(hgOver, file="ALL_go.html")# 顯示結(jié)果前幾行head(bp)
image.png
# 安裝并加載所需包biocLite("GeneAnswers")library(GeneAnswers)# 選取dif中的三列信息構(gòu)成新的矩陣闹击,新一列必須是EntrezIDhumanGeneInput <- dif[, c("EntrezID","logFC","P.Value")]# 獲得humanGeneInput中基因的表達(dá)值humanExpr <- eset[match(rownames(dif), rownames(eset)), ]humanExpr <- cbind(humanGeneInput[,"EntrezID"], humanExpr)# 去除NA數(shù)據(jù)humanGeneInput <- humanGeneInput[!is.na(humanGeneInput[,1]),]humanExpr <- humanExpr[!is.na(humanExpr[,1]),]# KEGG通路的超幾何檢驗(yàn)y <- geneAnswersBuilder(humanGeneInput,"org.Hs.eg.db", categoryType ="KEGG",? ? ? ? ? ? ? ? ? ? ? ? testType ="hyperG", pvalueT=0.1, geneExpressionProfile=humanExpr,? ? ? ? ? ? ? ? ? ? ? ? verbose = FALSE)getEnrichmentInfo(y)[1:6]
image.png
biocLite("pheatmap")library(pheatmap)# 從基因表達(dá)矩陣中,選取差異表達(dá)基因?qū)?yīng)的數(shù)據(jù)selected <- eset[rownames(dif), ]# 將selected矩陣每行的名稱由探針組ID轉(zhuǎn)換為對應(yīng)的基因symbolrownames(selected) <- dif$symbols# 考慮顯示問題成艘,這里只畫前20個(gè)基因的熱圖pheatmap(selected[1:20,], color = colorRampPalette(c("green","black","red"))(100),? ? ? ? fontsize_row = 4, scale ="row", border_color = NA)
image.png
biocLite("Rgraphviz")library(Rgraphviz)# 顯著富集的GO term的DAG關(guān)系圖ghandle <- goDag(hgOver)# 這個(gè)圖太大赏半,這里只能選一部分?jǐn)?shù)據(jù)構(gòu)建局部圖subGHandle <- subGraph(snodes=as.character(summary(hgOver)[,1]), graph = ghandle)plot(subGHandle)
image.png
source("https://bioconductor.org/biocLite.R")biocLite("KEGG.db")yy<- geneAnswersReadable(y)geneAnswersConceptNet(yy, colorValueColumn ="logFC", centroidSize ="pvalue", output="interactive")
這里我報(bào)錯(cuò)了,這個(gè)網(wǎng)站解決問題http://planspace.org/2013/01/17/fix-r-tcltk-dependency-problem-on-mac/
image.png
yyy<- geneAnswersSort(yy,sortBy ="pvalue")geneAnswersHeatmap(yyy)
image.png
最后輸出會話信息:
> sessionInfo()R version3.4.2(2017-09-28)Platform: x86_64-apple-darwin15.6.0(64-bit)Running under: macOS Sierra10.12.6Matrix products:defaultBLAS:/System/Library/Frameworks/Accelerate.framework/Versions/A/Frameworks/vecLib.framework/Versions/A/libBLAS.dylibLAPACK:/Library/Frameworks/R.framework/Versions/3.4/Resources/lib/libRlapack.dyliblocale:[1] en_US.UTF-8/en_US.UTF-8/en_US.UTF-8/C/en_US.UTF-8/en_US.UTF-8attached base packages: [1] grid? ? ? stats4? ? parallel? stats? ? graphics? grDevices utils? ? datasets? methods? base? ? other attached packages: [1] KEGG.db_3.2.3Rgraphviz_2.22.0pheatmap_1.0.8GeneAnswers_2.20.0RColorBrewer_1.1-2[6] Heatplus_2.24.0MASS_7.3-47RSQLite_2.0RCurl_1.95-4.8bitops_1.0-6[11] igraph_1.1.2GO.db_3.5.0GOstats_2.44.0graph_1.56.0Category_2.44.0[16] Matrix_1.2-12hgu95av2.db_3.2.3org.Hs.eg.db_3.5.0annotate_1.56.1XML_3.98-1.9[21] hgu95av2probe_2.18.0AnnotationDbi_1.40.0IRanges_2.12.0S4Vectors_0.16.0hgu95av2cdf_2.18.0[26] CLL_1.18.0gcrma_2.50.0affy_1.56.0Biobase_2.38.0BiocGenerics_0.24.0[31] limma_3.34.1loaded via a namespace (and not attached): [1] matrixStats_0.52.2bit64_0.9-7GenomeInfoDb_1.14.0tools_3.4.2[5] backports_1.1.1affyio_1.48.0rpart_4.1-11Hmisc_4.0-3[9] DBI_0.7lazyeval_0.2.1colorspace_1.3-2nnet_7.3-12[13] gridExtra_2.3DESeq2_1.18.1bit_1.1-12compiler_3.4.2[17] preprocessCore_1.40.0htmlTable_1.9DelayedArray_0.4.1scales_0.5.0[21] checkmate_1.8.5genefilter_1.60.0RBGL_1.54.0stringr_1.2.0[25] digest_0.6.12foreign_0.8-69DOSE_3.4.0AnnotationForge_1.20.0[29] XVector_0.18.0base64enc_0.1-3pkgconfig_2.0.1htmltools_0.3.6[33] htmlwidgets_0.9rlang_0.1.4BiocInstaller_1.28.0BiocParallel_1.12.0[37] acepack_1.4.1GOSemSim_2.4.0magrittr_1.5GenomeInfoDbData_0.99.1[41] Formula_1.2-2Rcpp_0.12.14munsell_0.4.3stringi_1.1.6[45] yaml_2.1.14SummarizedExperiment_1.8.0zlibbioc_1.24.0plyr_1.8.4[49] qvalue_2.10.0blob_1.1.0DO.db_2.9lattice_0.20-35[53] Biostrings_2.46.0splines_3.4.2locfit_1.5-9.1knitr_1.17[57] tcltk_3.4.2fgsea_1.4.0GenomicRanges_1.30.0geneplotter_1.56.0[61] reshape2_1.4.2fastmatch_1.1-0downloader_0.4latticeExtra_0.6-28[65] data.table_1.10.4-3gtable_0.2.0ggplot2_2.2.1xtable_1.8-2[69] survival_2.41-3tibble_1.3.4rvcheck_0.0.9memoise_1.1.0[73] cluster_2.0.6GSEABase_1.40.1
參考文獻(xiàn)
http://www.flypeom.site/bioinformatics/r/2017/10/09/microArray-data-analysis/
喜歡就點(diǎn)個(gè)贊淆两,留一些寶貴的意見也是最好的贊賞
作者:thinkando
鏈接:http://www.reibang.com/p/50bcf4ba9d8a
來源:簡書
簡書著作權(quán)歸作者所有断箫,任何形式的轉(zhuǎn)載都請聯(lián)系作者獲得授權(quán)并注明出處。