diff --git a/.gitattributes b/.gitattributes index 11c5925..c287fb8 100644 --- a/.gitattributes +++ b/.gitattributes @@ -1,2 +1,3 @@ input/GA_illumina_expression.rv144pilot.matrix_non_norm.csv filter=lfs diff=lfs merge=lfs -text *.RData filter=lfs diff=lfs merge=lfs -text +GA_illumina_expression.rv144.matrix_non_norm.csv filter=lfs diff=lfs merge=lfs -text diff --git a/README.md b/README.md index 0a1696f..1b093e1 100644 --- a/README.md +++ b/README.md @@ -6,7 +6,7 @@ ### Fig. 2 ![Fig. 2](figure/20150201_RV144pilot.Fig2.png) -Fig. 1: [R code [MD]](code/20160510_RV144pilot.Fig2.code.md), [Input file [RData]](output/rv144pilot.gsSetVehSubstracted.RData) +Fig. 2: [R code [MD]](code/20160510_RV144pilot.Fig2.code.md), [Input file [RData]](output/rv144pilot.gsSetVehSubstracted.RData) ### Fig. 3 ![Fig. 3](figure/20150201_RV144pilot.Fig3.png) @@ -40,3 +40,21 @@ output: - MArrayLM list: [[RDA]](output/rv144pilot.fits.RData) - gsea result table: [[RDA]](output/rv144pilot.gseaOutput.RData) - slea ExpressionSet: [[RDA]](output/rv144pilot.gsSetVehSubstracted.RData) + +### b. transcriptomic case/control study: +code: +- preprocessing: [[MD]](code/20151007_RV144.preprocessing.code.md) +- geneset-analysis: + +input: +- non-normalized matrix: [[CSV]](input/GA_illumina_expression.rv144.matrix_non_norm.csv) +- arrays/samples annotation: [[CSV]](input/GA_illumina_expression.rv144.metadata.csv) +- features annotation: [[TSV]](input/Illumina_HumanHT12_V4.hg19.chip) + +output: +- non-normalized ExpressionSet: [[RDA]](output/rv144.esetRaw.RData) +- quantile normalized ExpressionSet: [[RDA]](output/rv144.eset.RData) +- DMSO-substracted ExpressionSet: [[RDA]](output/rv144.esetBaselined.RData) +- MArrayLM list: [[RDA]](output/rv144.fits.RData) +- gsea result table: +- slea ExpressionSet: diff --git a/code/20151007_RV144.preprocessing.code.md b/code/20151007_RV144.preprocessing.code.md new file mode 100644 index 0000000..da5249d --- /dev/null +++ b/code/20151007_RV144.preprocessing.code.md @@ -0,0 +1,683 @@ +--- +title: RV144 case-control gene-expression analysis +author: Slim Fourati +date: October 7, 2015 +output: github_documents +--- + +loading require packages + +```r +suppressPackageStartupMessages(library(package = "readr")) +suppressPackageStartupMessages(library(package = "Biobase")) +suppressPackageStartupMessages(library(package = "impute")) +suppressPackageStartupMessages(library(package = "org.Hs.eg.db")) +suppressPackageStartupMessages(library(package = "ggplot2")) +suppressPackageStartupMessages(library(package = "limma")) +suppressPackageStartupMessages(library(package = "knitr")) +suppressPackageStartupMessages(library(package = "pheatmap")) +suppressPackageStartupMessages(library(package = "grid")) +suppressPackageStartupMessages(library(package = "gtable")) +suppressPackageStartupMessages(library(package = "RCurl")) +suppressPackageStartupMessages(library(package = "dplyr")) +suppressPackageStartupMessages(library(package = "tidyr")) +suppressPackageStartupMessages(library(package = "tibble")) +``` + +set default options/variables + +```r +workDir <- dirname(getwd()) +opts_chunk$set(tidy = FALSE, fig.path = "../figure/") +options(stringsAsFactors = FALSE, + width = 80, + mc.cores = detectCores() - 1, + readr.num_columns = 0) +``` + +read non-normalized matrix + +```r +rawFile <- file.path(workDir, + "input/GA_illumina_expression.rv144.matrix_non_norm.csv") +rawMat <- read_csv(file = rawFile, progress = FALSE) +``` + +read arrays annotation + +```r +arraysAnnotFile <- file.path(workDir, + "input", + "GA_illumina_expression.rv144.metadata.csv") +arraysAnnotation <- read_csv(file = arraysAnnotFile, progress = FALSE) +# remove unused phenotypic information +arraysAnnotation <- select(arraysAnnotation, + -title, + -`source name`, + -organism, + -molecule, + -label, + -description, + -platform) +# remove prefix 'characteristics` of column names +names(arraysAnnotation) <- gsub(pattern = "^[^:]+: (.+)$", + replacement = "\\1", + names(arraysAnnotation)) +``` + +read features annotation + +```r +featuresAnnotFile <- file.path(workDir, + "input/Illumina_HumanHT12_V4.hg19.chip") +featuresAnnotation <- read_tsv(file = featuresAnnotFile, progress = FALSE) %>% + as.data.frame() +rownames(featuresAnnotation) <- featuresAnnotation$IlmnID +``` + +read clinical annotation + +```r +clinicalAnnotFile <- file.path(workDir, + "input/rv144.master_wk26.csv") +clinicalAnnotation <- read_csv(file = clinicalAnnotFile, + col_types = paste(rep("c", times = 21), + collapse = "")) +clinicalAnnotation <- lapply(clinicalAnnotation, + FUN = type.convert, + as.is = TRUE) %>% + data.frame(check.names = FALSE) +# remove unused columns +clinicalAnnotation <- clinicalAnnotation %>% + select(-v7, -v9) +rownames(clinicalAnnotation) <- clinicalAnnotation$pin +``` + +create non-normalized ExpressionSet + +```r +# format raw matrix +rNames <- rawMat$"ID_REF" +rawMat <- rawMat[, -grep(pattern = "ID_REF|Detection Pval", + colnames(rawMat))] +rawMat <- as.matrix(rawMat) +rownames(rawMat) <- rNames +# format phenodata +arraysAnnotation <- as.data.frame(arraysAnnotation) +rownames(arraysAnnotation) <- arraysAnnotation$"Sample name" +arraysAnnotation <- arraysAnnotation[colnames(rawMat), ] +# format feature annotation +featuresAnnotation <- as.data.frame(featuresAnnotation) +featuresAnnotation <- featuresAnnotation[rownames(rawMat), ] +# create ExpressionSet +esetRaw <- ExpressionSet(assayData = rawMat, + phenoData = AnnotatedDataFrame(arraysAnnotation), + featureData = AnnotatedDataFrame(featuresAnnotation)) +# save raw ExpressionSet +save(esetRaw, file = file.path(workDir, "output/rv144.esetRaw.RData")) +``` + +quality control: kernel densities plot + +```r +intensities <- as.vector(exprs(esetRaw)) +# log2 transform (replace intensities < 1 by 1 to prevent -Inf) +intensities <- log2(pmax(intensities, 1)) +arrays <- rep(sampleNames(esetRaw), each = nrow(esetRaw)) +scanNote <- rep(esetRaw$"scanning note", + each = nrow(esetRaw)) +plotDF <- data.frame(intensities, arrays, scanNote) +plotDens <- ggplot(data = plotDF, + mapping = aes(x = intensities, + group = factor(arrays), + color = scanNote)) + + scale_color_discrete(name = "scanning note") + + stat_density(geom = "path", position = "identity") + + labs(x = "log2 intensity", + title = "density plot [log2 raw intensities]") + + theme_bw() + + theme(legend.key = element_blank()) +print(plotDens) +``` + +![plot of chunk density-plot](../figure/density-plot-1.png) + +```r +# print problematic array name +outlierArrays <- filter(pData(esetRaw), + `scanning note` != "ok") %>% + .$"Sample name" +print(outlierArrays) +``` + +``` +## [1] "RV144_d305968_DMSO" +``` + +```r +# exclude arrays from raw ExpressionSet +esetRaw <- esetRaw[, setdiff(sampleNames(esetRaw), outlierArrays)] +``` + +quality control: multidimentional scaling plot + +```r +# create tempory ExpressionSet and normalize the data +esetTemp <- esetRaw +# exclude problematic arrays +esetTemp <- esetTemp[, setdiff(sampleNames(esetTemp), outlierArrays)] +rawMat <- exprs(esetTemp) +normMat <- normalizeBetweenArrays(rawMat, method = "quantile") +normMat <- log2(normMat) +# generate a multidimensional scaling plot +distMat <- dist(t(normMat)) +mds <- cmdscale(d = distMat, k = ncol(normMat) - 1, eig = TRUE) +mdsStDev <- apply(mds$points, MARGIN = 2, FUN = sd) +mdsPercVar <- round((mdsStDev^2)/sum(mdsStDev^2) * 100) +plotDF <- data.frame(V1 = mds$points[, 1], + V2 = mds$points[, 2]) +# color dots by whether a sample is a hybridization control +plotDF$controlSamples <- grepl(pattern = "control", + rownames(plotDF)) +qcMdS <- ggplot(data = plotDF, + mapping = aes(x = V1, y = V2, color = controlSamples)) + + geom_point(size = 3) + + labs(x = paste0("1st dimension (", mdsPercVar[1], "%)"), + y = paste0("2nd dimension (", mdsPercVar[2], "%)"), + title = "Multidimentional scaling plot") + + theme_bw() + + theme(legend.key = element_blank()) +print(qcMdS) +``` + +![plot of chunk mds-plot-3](../figure/mds-plot-3-1.png) + +```r +# print control array names +controlArrays <- filter(pData(esetRaw), + grepl(pattern = "control", `Sample name`)) %>% + .$"Sample name" +print(controlArrays) +``` + +``` +## [1] "RV144_control" "RV144_control_rep12" "RV144_control_rep8" +## [4] "RV144_control_rep11" "RV144_control_rep1" "RV144_control_rep6" +## [7] "RV144_control_rep7" "RV144_control_rep2" "RV144_control_rep10" +## [10] "RV144_control_rep14" "RV144_control_rep13" "RV144_control_rep9" +## [13] "RV144_control_rep5" "RV144_control_rep4" "RV144_control_rep3" +``` + +quality control: multidimentional scaling plot excluding hybridization controls + +```r +# create tempory ExpressionSet and normalize the data +esetTemp <- esetRaw +# exclude problematic arrays +esetTemp <- esetTemp[, setdiff(sampleNames(esetTemp), + c(outlierArrays, controlArrays))] +rawMat <- exprs(esetTemp) +normMat <- normalizeBetweenArrays(rawMat, method = "quantile") +normMat <- log2(normMat) +# generate a multidimensional scaling plot +distMat <- dist(t(normMat)) +mds <- cmdscale(d = distMat, k = ncol(normMat) - 1, eig = TRUE) +mdsStDev <- apply(mds$points, MARGIN = 2, FUN = sd) +mdsPercVar <- round((mdsStDev^2)/sum(mdsStDev^2) * 100) +plotDF <- data.frame(V1 = mds$points[, 1], + V2 = mds$points[, 2]) +# color dots by protocol used for RNA extraction +plotDF$RNAextractionProtocol <- + pData(esetTemp)[rownames(plotDF), "RNA extraction protocol"] +qcMdS <- ggplot(data = plotDF, + mapping = aes(x = V1, y = V2, color = RNAextractionProtocol)) + + geom_point(size = 3) + + scale_color_manual(name = + "RNA extraction protocol", + values = c("orange", "red")) + + labs(x = paste0("1st dimension (", mdsPercVar[1], "%)"), + y = paste0("2nd dimension (", mdsPercVar[2], "%)"), + title = "Multidimentional scaling plot") + + theme_bw() + + theme(legend.key = element_blank()) +print(qcMdS) +``` + +![plot of chunk mds-plot-4](../figure/mds-plot-4-1.png) + +```r +# print control array generated with different RNA extraction protocol +rnaExtractionArrays <- filter(pData(esetRaw), + grepl( + pattern = "Rneasy", + `RNA extraction protocol`)) %>% + .$"Sample name" +print(rnaExtractionArrays) +``` + +``` +## [1] "RV144_d825482_92TH023ENV" "RV144_d824374_92TH023ENV" +## [3] "RV144_d849655_92TH023ENV" "RV144_d723863_92TH023ENV" +## [5] "RV144_d203143_92TH023ENV" "RV144_d827158_92TH023ENV" +## [7] "RV144_d736104_92TH023ENV" "RV144_d603208_92TH023ENV" +## [9] "RV144_d627156_92TH023ENV" "RV144_d431442_92TH023ENV" +## [11] "RV144_d127852_92TH023ENV" "RV144_d513999_92TH023ENV" +``` + +normalizing raw expression + +```r +eset <- esetRaw +# order esetRaw by idat file name and features by ProbeID +eset <- eset[order(as.numeric(fData(eset)$ProbeID)), + order(eset$"idat file")] +# impute missing intensities (intensities = 0) +rawMat <- exprs(eset) +rawMat[rawMat == 0] <- NA +suppressWarnings(capture.output(rawMat <- impute.knn(data = rawMat)$data, + file = "/dev/null")) +exprs(eset) <- rawMat +# remove outlier +outlierArrays <- sampleNames(eset)[eset$outlierFlag != ""] +eset <- eset[, setdiff(sampleNames(eset), + c(outlierArrays, controlArrays, rnaExtractionArrays))] +# quantile normalized and log2 transform expression +normMat <- normalizeBetweenArrays(exprs(eset), method = "quantile") +# surrogate remplacement +normMat[normMat < 2^0.1] <- 2^0.1 +normMat <- log2(normMat) +exprs(eset) <- normMat +# save normalized ExpressionSet +save(eset, file = file.path(workDir, "output/rv144.eset.RData")) +``` + +quality control: gender check + +```r +symbol2chr <- merge(as.data.frame(org.Hs.egSYMBOL), + as.data.frame(org.Hs.egCHR), + by = "gene_id") +pb2symbol <- strsplit(fData(eset)$SYMBOL, split = " /// ") %>% + setNames(fData(eset)$IlmnID) %>% + stack() %>% + mutate(ind = as.vector(ind)) +pb2chr <- merge(symbol2chr, pb2symbol, by.x = "symbol", by.y = "values") + +pbY <- filter(pb2chr, chromosome %in% "Y") %>% + .$ind + +plotDF <- data.frame(mu = colMeans(exprs(eset)[pbY, ])) %>% + rownames_to_column() %>% + merge(pData(eset), by.x = "rowname", by.y = "Sample name") %>% + merge(clinicalAnnotation, by.x = "donor", by.y = "pin") +ggplot(data = plotDF, mapping = aes(x = dem_sex, y = mu)) + + geom_jitter() + + labs(y = "Average expression of chr.Y probes") + + theme_bw() +``` + +![plot of chunk boxplot-chry-2](../figure/boxplot-chry-2-1.png) + +exploratory analysis: heatmap based on top 100 most varying transcripts + +```r +bluered <- colorRampPalette(colors = c("blue", "white", "red")) +varList <- apply(exprs(eset), MARGIN = 1, FUN = var) +esetTemp <- eset[order(varList, decreasing = TRUE)[1:100], ] +esetTemp$donor <- factor(esetTemp$donor) +exploHeat <- pheatmap(mat = exprs(esetTemp), + color = bluered(100), + scale = "row", + treeheight_row = 0, + annotation_col = pData(esetTemp)[, + c("donor", + "stimulation")], + show_colnames = FALSE, + show_rownames = FALSE, + main = paste0("top 100 varying probes", + "[Euclidean distance, complete linkage]"), + silent = TRUE) +colorName <- textGrob("z-score", x = 0.5, y = 1.05, gp = gpar(fontface = "bold")) +exploHeat$gtable <- gtable_add_grob(exploHeat$gtable, + colorName, + t = 3, + l = 5, + b = 5, + clip = "off", + name = "colorName") +grid.draw(exploHeat$gtable) +``` + +![plot of chunk exploratory-heatmap-2](../figure/exploratory-heatmap-2-1.png) + +```r +# test association with stimulation +tab <- table(cutree(exploHeat$tree_col, k = 2), + esetTemp$stimulation) +fit <- fisher.test(tab) +print(tab) +``` + +``` +## +## 92TH023ENV DMSO +## 1 29 122 +## 2 171 90 +``` + +```r +print(fit) +``` + +``` +## +## Fisher's Exact Test for Count Data +## +## data: tab +## p-value < 2.2e-16 +## alternative hypothesis: true odds ratio is not equal to 1 +## 95 percent confidence interval: +## 0.07483947 0.20646421 +## sample estimates: +## odds ratio +## 0.1258127 +``` + +```r +# test for clustering of samples by participants +participantList <- esetTemp$donor[exploHeat$tree_col$order] +y <- sum(participantList[-length(participantList)] == participantList[-1]) +# derive p-value using a 1000 fold permutation test +B <- 1000 +yhat <- mclapply(1:B, function(seed) { + set.seed(seed = seed) + participantList <- sample(esetTemp$donor) + return(value = sum(participantList[-length(participantList)] == + participantList[-1])) +}) +print(paste0("permutation test: p<=", max(mean(unlist(yhat) >= y), 1/B))) +``` + +``` +## [1] "permutation test: p<=0.001" +``` + +create a ENV-DMSO ExpressionSet + +```r +# identify complete pair of ENV-DMSO stimulated samples +flag <- dplyr::select(pData(eset), + `Sample name`, + donor, + stimulation) %>% + spread(stimulation, `Sample name`) %>% + filter(!is.na(`92TH023ENV`) & !is.na(DMSO)) +esetBaselined <- eset[, flag$"92TH023ENV"] +exprs(esetBaselined) <- exprs(esetBaselined) - exprs(eset[, flag$DMSO]) +# save ENV-DMSO expression +save(esetBaselined, file = file.path(workDir, "output/rv144.esetBaselined.RData")) +``` + +differential expression analysis: stimulation effect + +```r +# create list to save linear models +fits <- list() +# identify samples stimulated both by ENV and DMSO +flag <- pData(eset) %>% + select(`Sample name`, donor, stimulation) %>% + spread(stimulation, `Sample name`) %>% + filter(!is.na(`92TH023ENV`) & !is.na(DMSO)) %>% + gather(stimulation, `Sample name`, -donor) +esetTemp <- eset[, flag$"Sample name"] +# identify genes differently expressed separetly for the VACCINE and PLACEBO +# treatment groups +TreatmentStim <- interaction(esetTemp$treatment, + esetTemp$stimulation, + sep = "_") +design <- model.matrix(~0+TreatmentStim) +colnames(design) <- gsub(pattern = "TreatmentStim", + replacement = "", + colnames(design)) +rownames(design) <- sampleNames(esetTemp) +# fit a fixed effect to the treatment/strim and a random effect to the donor in +# the linear regression model +donor <- factor(esetTemp$donor) +corfit <- duplicateCorrelation(exprs(esetTemp), + design = design, + block = esetTemp$donor) +fit <- lmFit(esetTemp, + design = design, + block = donor, + correlation = corfit$consensus) +contrastLS <- c("PLACEBO_92TH023ENV-PLACEBO_DMSO", + "VACCINE_92TH023ENV-VACCINE_DMSO") +contrastMat <- makeContrasts(contrasts = contrastLS, levels = fit$design) +fit2 <- contrasts.fit(fit = fit, contrasts = contrastMat) +fit2 <- eBayes(fit = fit2) +fits[["stimulation"]] <- list(fit = fit, fit2 = fit2) + +# differential expression analysis: HIV case vs. control +TreatmentInfect <- interaction(esetBaselined$treatment, + esetBaselined$"HIV infection", + sep = "_", + lex.order = TRUE) +design <- model.matrix(~0+TreatmentInfect) +colnames(design) <- gsub(pattern = "TreatmentInfect", + replacement = "", + colnames(design)) +rownames(design) <- sampleNames(esetBaselined) +fit <- lmFit(esetBaselined, design = design) +contrastLS <- c("PLACEBO_No-PLACEBO_Yes", + "VACCINE_No-VACCINE_Yes") +contrastMat <- makeContrasts(contrasts = contrastLS, levels = fit$design) +fit2 <- contrasts.fit(fit = fit, contrasts = contrastMat) +fit2 <- eBayes(fit = fit2) +# top 10 differently expressed transcript in the placebo group +topTable(fit = fit2, coef = 1) %>% + select(SYMBOL, logFC, t, P.Value, adj.P.Val) %>% + print() +``` + +``` +## SYMBOL logFC t P.Value adj.P.Val +## ILMN_1896145 --- 0.3017263 4.652130 5.976632e-06 0.2828321 +## ILMN_1711883 HTR3D -0.2017627 -4.159871 4.730030e-05 0.9988950 +## ILMN_1677374 --- -0.1844982 -4.068273 6.819273e-05 0.9988950 +## ILMN_1717324 --- 0.2424789 3.875968 1.440693e-04 0.9988950 +## ILMN_3239480 UCA1 -0.1652911 -3.821776 1.769920e-04 0.9988950 +## ILMN_3299441 --- -0.2514595 -3.790279 1.992803e-04 0.9988950 +## ILMN_1691361 --- -0.1809396 -3.727657 2.517173e-04 0.9988950 +## ILMN_1685045 CHI3L2 -0.1708355 -3.724162 2.549989e-04 0.9988950 +## ILMN_1725139 CA9 -0.1671642 -3.704351 2.743727e-04 0.9988950 +## ILMN_1684897 SPDYE1 /// SPDYE5 -0.2025732 -3.684547 2.951235e-04 0.9988950 +``` + +```r +# top 10 differently expressed transcript in the vaccine group +topTable(fit = fit2, coef = 2) %>% + select(SYMBOL, logFC, t, P.Value, adj.P.Val) %>% + print() +``` + +``` +## SYMBOL logFC t P.Value adj.P.Val +## ILMN_2140990 CAMK1 0.4370108 4.388951 1.845103e-05 0.3459782 +## ILMN_2376133 KIAA1191 -0.1687398 -4.310844 2.554186e-05 0.3459782 +## ILMN_1759787 THBD -0.2611175 -4.301246 2.657524e-05 0.3459782 +## ILMN_2093027 MYO1B -0.1768234 -4.278022 2.924398e-05 0.3459782 +## ILMN_1664602 --- -0.1857514 -3.939602 1.128235e-04 0.5696287 +## ILMN_1655230 --- -0.0997451 -3.935295 1.147168e-04 0.5696287 +## ILMN_1787680 VIMP -0.1504375 -3.926250 1.187913e-04 0.5696287 +## ILMN_3238859 FAM120AOS -0.1350209 -3.852309 1.576563e-04 0.5696287 +## ILMN_1657234 CCL20 -0.7692402 -3.850290 1.588705e-04 0.5696287 +## ILMN_2105919 FGF2 -0.1026889 -3.846069 1.614375e-04 0.5696287 +``` + +```r +# save MArrayLM in list +fits[["infection"]] <- list(fit = fit, fit2 = fit2) + +#save MArrayLM list +save(fits, file = file.path(workDir, "output/rv144.fits.RData")) +``` + + +```r +modelName <- "stimulation" +fit2 <- fits[[modelName]][["fit2"]] +for (coefName in colnames(fit2)) { + coefLS <- unlist(strsplit(coefName, split = "-")) %>% + gsub(pattern = "\\(|\\)", replacement = "") + sampleLS <- fit2$design %>% + as.data.frame() %>% + rownames_to_column() %>% + select_(.dots = c("rowname", coefLS)) %>% + filter(apply(., MARGIN = 1, FUN = function(x) any(x %in% 1))) + top <- topTable(fit = fit2, + coef = coefName, + number = Inf) %>% + mutate(SYMBOL = gsub(pattern = "^([^ ]+) ///.+", + replacement = "\\1", + SYMBOL)) %>% + filter(SYMBOL != "---") %>% + top_n(n = 50, wt = abs(t)) + exprsMat <- exprs(eset)[top$IlmnID, sampleLS$rowname] %>% + (function(x) return(value = t(scale(t(x))))) + breakLS <- c(-1 * max(abs(exprsMat)), + seq(from = -1 * min(abs(range(exprsMat))), + to = min(abs(range(exprsMat))), + length.out = 99), + max(abs(exprsMat))) + colAnnotDF <- pData(eset) %>% + .[, c("stimulation", "treatment")] + rowAnnotDF <- top %>% + mutate(`fold-change sign` = ifelse(test = sign(logFC) %in% 1, + yes = "UP", + no = "DN"), + `-log10 P.Value` = -1 * log10(P.Value), + `adj. p <= 0.05` = factor(adj.P.Val <= 0.05)) %>% + select(IlmnID, `fold-change sign`, `-log10 P.Value`, `adj. p <= 0.05`) + rownames(rowAnnotDF) <- rowAnnotDF$IlmnID + rowAnnotDF$IlmnID <- NULL + colorAnnotLS <- list(treatment = c(PLACEBO = "blue", VACCINE = "green"), + "fold-change sign" = c(UP = "red", DN = "blue")) + pheat <- pheatmap(mat = exprsMat, + color = bluered(100), + breaks = breakLS, + cellwidth = 2, + cellheight = 2, + treeheight_row = 0, + annotation_col = colAnnotDF, + annotation_row = rowAnnotDF, + annotation_colors = colorAnnotLS, + show_colnames = FALSE, + main = coefName, + fontsize_row = 2, + labels_row = top$SYMBOL) +} +``` + +![plot of chunk heatmap-top50-stim](../figure/heatmap-top50-stim-1.png)![plot of chunk heatmap-top50-stim](../figure/heatmap-top50-stim-2.png) + + +```r +modelName <- "infection" +fit2 <- fits[[modelName]][["fit2"]] +for (coefName in colnames(fit2)) { + coefLS <- unlist(strsplit(coefName, split = "-")) %>% + gsub(pattern = "\\(|\\)", replacement = "") + sampleLS <- fit2$design %>% + as.data.frame() %>% + rownames_to_column() %>% + select_(.dots = c("rowname", coefLS)) %>% + filter(apply(., MARGIN = 1, FUN = function(x) any(x %in% 1))) + top <- topTable(fit = fit2, + coef = coefName, + number = Inf) %>% + mutate(SYMBOL = gsub(pattern = "^([^ ]+) ///.+", + replacement = "\\1", + SYMBOL)) %>% + filter(SYMBOL != "---") %>% + top_n(n = 50, wt = abs(t)) + exprsMat <- exprs(eset)[top$IlmnID, sampleLS$rowname] %>% + (function(x) return(value = t(scale(t(x))))) + breakLS <- c(-1 * max(abs(exprsMat)), + seq(from = -1 * min(abs(range(exprsMat))), + to = min(abs(range(exprsMat))), + length.out = 99), + max(abs(exprsMat))) + colAnnotDF <- pData(eset) %>% + .[, c("treatment", "HIV infection")] + rowAnnotDF <- top %>% + mutate(`fold-change sign` = ifelse(test = sign(logFC) %in% 1, + yes = "UP", + no = "DN"), + `-log10 P.Value` = -1 * log10(P.Value), + `adj. p <= 0.05` = factor(adj.P.Val <= 0.05)) %>% + select(IlmnID, `fold-change sign`, `-log10 P.Value`, `adj. p <= 0.05`) + rownames(rowAnnotDF) <- rowAnnotDF$IlmnID + rowAnnotDF$IlmnID <- NULL + colorAnnotLS <- list(treatment = c(PLACEBO = "blue", VACCINE = "green"), + "HIV infection" = c(No = "black", Yes = "red"), + "fold-change sign" = c(UP = "red", DN = "blue")) + pheat <- pheatmap(mat = exprsMat, + color = bluered(100), + breaks = breakLS, + cellwidth = 4, + cellheight = 4, + treeheight_row = 0, + annotation_col = colAnnotDF, + annotation_row = rowAnnotDF, + annotation_colors = colorAnnotLS, + show_colnames = FALSE, + main = coefName, + fontsize_row = 4, + labels_row = top$SYMBOL) +} +``` + +![plot of chunk heatmap-top50-infection](../figure/heatmap-top50-infection-1.png)![plot of chunk heatmap-top50-infection](../figure/heatmap-top50-infection-2.png) + +print session info + +```r +sessionInfo() +``` + +``` +## R version 3.5.1 (2018-07-02) +## Platform: x86_64-apple-darwin17.6.0 (64-bit) +## Running under: macOS High Sierra 10.13.6 +## +## Matrix products: default +## BLAS: /System/Library/Frameworks/Accelerate.framework/Versions/A/Frameworks/vecLib.framework/Versions/A/libBLAS.dylib +## LAPACK: /System/Library/Frameworks/Accelerate.framework/Versions/A/Frameworks/vecLib.framework/Versions/A/libLAPACK.dylib +## +## locale: +## [1] en_US.UTF-8/en_US.UTF-8/en_US.UTF-8/C/en_US.UTF-8/en_US.UTF-8 +## +## attached base packages: +## [1] grid stats4 parallel stats graphics grDevices utils +## [8] datasets methods base +## +## other attached packages: +## [1] bindrcpp_0.2.2 tibble_1.4.2 tidyr_0.8.1 +## [4] dplyr_0.7.6 RCurl_1.95-4.11 bitops_1.0-6 +## [7] gtable_0.2.0 pheatmap_1.0.10 limma_3.36.2 +## [10] ggplot2_3.0.0 org.Hs.eg.db_3.6.0 AnnotationDbi_1.42.1 +## [13] IRanges_2.14.10 S4Vectors_0.18.3 impute_1.54.0 +## [16] Biobase_2.40.0 BiocGenerics_0.26.0 readr_1.1.1 +## [19] knitr_1.20 +## +## loaded via a namespace (and not attached): +## [1] Rcpp_0.12.18 highr_0.7 RColorBrewer_1.1-2 bindr_0.1.1 +## [5] pillar_1.3.0 compiler_3.5.1 plyr_1.8.4 tools_3.5.1 +## [9] statmod_1.4.30 digest_0.6.15 bit_1.1-14 RSQLite_2.1.1 +## [13] evaluate_0.11 memoise_1.1.0 pkgconfig_2.0.1 rlang_0.2.1 +## [17] DBI_1.0.0 withr_2.1.2 stringr_1.3.1 hms_0.4.2 +## [21] tidyselect_0.2.4 bit64_0.9-7 glue_1.3.0 R6_2.2.2 +## [25] purrr_0.2.5 blob_1.1.1 magrittr_1.5 scales_1.0.0 +## [29] assertthat_0.2.0 colorspace_1.3-2 labeling_0.3 stringi_1.2.4 +## [33] lazyeval_0.2.1 munsell_0.5.0 crayon_1.3.4 +``` diff --git a/code/20160509_RV144pilot.preprocessing.code.md b/code/20160509_RV144pilot.preprocessing.code.md index 54c088c..0451e5e 100644 --- a/code/20160509_RV144pilot.preprocessing.code.md +++ b/code/20160509_RV144pilot.preprocessing.code.md @@ -1,7 +1,7 @@ --- title: RV144 pilot gene-expression analysis author: Slim Fourati -date: May, 9 2016 +date: May 9, 2016 output: github_documents --- diff --git a/figure/boxplot-chry-2-1.png b/figure/boxplot-chry-2-1.png new file mode 100644 index 0000000..0f7cf5d Binary files /dev/null and b/figure/boxplot-chry-2-1.png differ diff --git a/figure/density-plot-1.png b/figure/density-plot-1.png new file mode 100644 index 0000000..a3492b6 Binary files /dev/null and b/figure/density-plot-1.png differ diff --git a/figure/exploratory-heatmap-2-1.png b/figure/exploratory-heatmap-2-1.png new file mode 100644 index 0000000..6c44dd1 Binary files /dev/null and b/figure/exploratory-heatmap-2-1.png differ diff --git a/figure/heatmap-top50-infection-1.png b/figure/heatmap-top50-infection-1.png new file mode 100644 index 0000000..08eaac9 Binary files /dev/null and b/figure/heatmap-top50-infection-1.png differ diff --git a/figure/heatmap-top50-infection-2.png b/figure/heatmap-top50-infection-2.png new file mode 100644 index 0000000..33c025b Binary files /dev/null and b/figure/heatmap-top50-infection-2.png differ diff --git a/figure/heatmap-top50-stim-1.png b/figure/heatmap-top50-stim-1.png new file mode 100644 index 0000000..75e896f Binary files /dev/null and b/figure/heatmap-top50-stim-1.png differ diff --git a/figure/heatmap-top50-stim-2.png b/figure/heatmap-top50-stim-2.png new file mode 100644 index 0000000..7c75667 Binary files /dev/null and b/figure/heatmap-top50-stim-2.png differ diff --git a/figure/mds-plot-3-1.png b/figure/mds-plot-3-1.png new file mode 100644 index 0000000..5a2294a Binary files /dev/null and b/figure/mds-plot-3-1.png differ diff --git a/figure/mds-plot-4-1.png b/figure/mds-plot-4-1.png new file mode 100644 index 0000000..5d4f6ed Binary files /dev/null and b/figure/mds-plot-4-1.png differ diff --git a/input/GA_illumina_expression.rv144.matrix_non_norm.csv b/input/GA_illumina_expression.rv144.matrix_non_norm.csv new file mode 100644 index 0000000..efce380 --- /dev/null +++ b/input/GA_illumina_expression.rv144.matrix_non_norm.csv @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:5d262a028cce5e5c8adfea098d3db1a73d611b8d180ccc5a14d4cfaf9829622d +size 323948186 diff --git a/input/GA_illumina_expression.rv144.metadata.csv b/input/GA_illumina_expression.rv144.metadata.csv new file mode 100644 index 0000000..361e592 --- /dev/null +++ b/input/GA_illumina_expression.rv144.metadata.csv @@ -0,0 +1,441 @@ +Sample name,title,source name,organism,idat file,characteristics: donor,characteristics: scanning note,characteristics: RNA extraction protocol,characteristics: stimulation,characteristics: stimulation time,characteristics: stimulation time unit,characteristics: treatment,characteristics: HIV infection,molecule,label,description,platform +RV144_d107034_DMSO,post-vaccination blood sample from donor 107034 stimulate 15 hours with DMSO,Blood sample from donor 107034,Homo Sapiens,8381645005_L_Grn.idat,107034,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d107034_92TH023ENV,post-vaccination blood sample from donor 107034 stimulate 15 hours with 92TH023ENV,Blood sample from donor 107034,Homo Sapiens,8381661022_H_Grn.idat,107034,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d109816_92TH023ENV,post-vaccination blood sample from donor 109816 stimulate 15 hours with 92TH023ENV,Blood sample from donor 109816,Homo Sapiens,8381661021_F_Grn.idat,109816,ok,Micro kit,92TH023ENV,15,hours,PLACEBO,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d109816_DMSO,post-vaccination blood sample from donor 109816 stimulate 15 hours with DMSO,Blood sample from donor 109816,Homo Sapiens,8381653037_C_Grn.idat,109816,ok,Micro kit,DMSO,15,hours,PLACEBO,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with DMSO,GPL10558 +RV144_d110256_92TH023ENV,post-vaccination blood sample from donor 110256 stimulate 15 hours with 92TH023ENV,Blood sample from donor 110256,Homo Sapiens,8363885006_B_Grn.idat,110256,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d110256_DMSO,post-vaccination blood sample from donor 110256 stimulate 15 hours with DMSO,Blood sample from donor 110256,Homo Sapiens,8381661002_B_Grn.idat,110256,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d110780_DMSO,post-vaccination blood sample from donor 110780 stimulate 15 hours with DMSO,Blood sample from donor 110780,Homo Sapiens,8381645069_D_Grn.idat,110780,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d110780_92TH023ENV,post-vaccination blood sample from donor 110780 stimulate 15 hours with 92TH023ENV,Blood sample from donor 110780,Homo Sapiens,8381661027_G_Grn.idat,110780,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d112906_92TH023ENV,post-vaccination blood sample from donor 112906 stimulate 15 hours with 92TH023ENV,Blood sample from donor 112906,Homo Sapiens,8381645076_G_Grn.idat,112906,ok,Micro kit,92TH023ENV,15,hours,PLACEBO,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d112906_DMSO,post-vaccination blood sample from donor 112906 stimulate 15 hours with DMSO,Blood sample from donor 112906,Homo Sapiens,8324350075_I_Grn.idat,112906,ok,Micro kit,DMSO,15,hours,PLACEBO,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with DMSO,GPL10558 +RV144_d116229_92TH023ENV,post-vaccination blood sample from donor 116229 stimulate 15 hours with 92TH023ENV,Blood sample from donor 116229,Homo Sapiens,8381653013_L_Grn.idat,116229,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d116229_DMSO,post-vaccination blood sample from donor 116229 stimulate 15 hours with DMSO,Blood sample from donor 116229,Homo Sapiens,8381661022_G_Grn.idat,116229,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d117102_DMSO,post-vaccination blood sample from donor 117102 stimulate 15 hours with DMSO,Blood sample from donor 117102,Homo Sapiens,8381661022_L_Grn.idat,117102,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d117102_92TH023ENV,post-vaccination blood sample from donor 117102 stimulate 15 hours with 92TH023ENV,Blood sample from donor 117102,Homo Sapiens,8363877074_E_Grn.idat,117102,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d119450_DMSO,post-vaccination blood sample from donor 119450 stimulate 15 hours with DMSO,Blood sample from donor 119450,Homo Sapiens,8381645049_L_Grn.idat,119450,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d119450_92TH023ENV,post-vaccination blood sample from donor 119450 stimulate 15 hours with 92TH023ENV,Blood sample from donor 119450,Homo Sapiens,8381645049_F_Grn.idat,119450,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d124155_92TH023ENV,post-vaccination blood sample from donor 124155 stimulate 15 hours with 92TH023ENV,Blood sample from donor 124155,Homo Sapiens,8381645070_C_Grn.idat,124155,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d124155_DMSO,post-vaccination blood sample from donor 124155 stimulate 15 hours with DMSO,Blood sample from donor 124155,Homo Sapiens,8363877065_I_Grn.idat,124155,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d127241_92TH023ENV,post-vaccination blood sample from donor 127241 stimulate 15 hours with 92TH023ENV,Blood sample from donor 127241,Homo Sapiens,8363877065_L_Grn.idat,127241,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d127241_DMSO,post-vaccination blood sample from donor 127241 stimulate 15 hours with DMSO,Blood sample from donor 127241,Homo Sapiens,8381653024_C_Grn.idat,127241,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d127852_92TH023ENV,post-vaccination blood sample from donor 127852 stimulate 15 hours with 92TH023ENV,Blood sample from donor 127852,Homo Sapiens,8381661021_K_Grn.idat,127852,ok,Rneasy plus Mini kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d127852_DMSO,post-vaccination blood sample from donor 127852 stimulate 15 hours with DMSO,Blood sample from donor 127852,Homo Sapiens,8381645049_J_Grn.idat,127852,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d129364_92TH023ENV,post-vaccination blood sample from donor 129364 stimulate 15 hours with 92TH023ENV,Blood sample from donor 129364,Homo Sapiens,8381653011_A_Grn.idat,129364,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d129364_DMSO,post-vaccination blood sample from donor 129364 stimulate 15 hours with DMSO,Blood sample from donor 129364,Homo Sapiens,8381645070_H_Grn.idat,129364,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d129872_92TH023ENV,post-vaccination blood sample from donor 129872 stimulate 15 hours with 92TH023ENV,Blood sample from donor 129872,Homo Sapiens,8363885006_G_Grn.idat,129872,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d129872_DMSO,post-vaccination blood sample from donor 129872 stimulate 15 hours with DMSO,Blood sample from donor 129872,Homo Sapiens,8381653011_L_Grn.idat,129872,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d129898_92TH023ENV,post-vaccination blood sample from donor 129898 stimulate 15 hours with 92TH023ENV,Blood sample from donor 129898,Homo Sapiens,8381645097_K_Grn.idat,129898,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d129898_DMSO,post-vaccination blood sample from donor 129898 stimulate 15 hours with DMSO,Blood sample from donor 129898,Homo Sapiens,8381653013_D_Grn.idat,129898,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d132483_DMSO,post-vaccination blood sample from donor 132483 stimulate 15 hours with DMSO,Blood sample from donor 132483,Homo Sapiens,8363877093_L_Grn.idat,132483,ok,Micro kit,DMSO,15,hours,PLACEBO,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with DMSO,GPL10558 +RV144_d132483_92TH023ENV,post-vaccination blood sample from donor 132483 stimulate 15 hours with 92TH023ENV,Blood sample from donor 132483,Homo Sapiens,8363885094_A_Grn.idat,132483,ok,Micro kit,92TH023ENV,15,hours,PLACEBO,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d132689_DMSO,post-vaccination blood sample from donor 132689 stimulate 15 hours with DMSO,Blood sample from donor 132689,Homo Sapiens,8363877065_H_Grn.idat,132689,ok,Micro kit,DMSO,15,hours,PLACEBO,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with DMSO,GPL10558 +RV144_d132689_92TH023ENV,post-vaccination blood sample from donor 132689 stimulate 15 hours with 92TH023ENV,Blood sample from donor 132689,Homo Sapiens,8381653013_F_Grn.idat,132689,ok,Micro kit,92TH023ENV,15,hours,PLACEBO,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d135177_92TH023ENV,post-vaccination blood sample from donor 135177 stimulate 15 hours with 92TH023ENV,Blood sample from donor 135177,Homo Sapiens,8363877102_J_Grn.idat,135177,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d135177_DMSO,post-vaccination blood sample from donor 135177 stimulate 15 hours with DMSO,Blood sample from donor 135177,Homo Sapiens,8381645049_D_Grn.idat,135177,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d137319_DMSO,post-vaccination blood sample from donor 137319 stimulate 15 hours with DMSO,Blood sample from donor 137319,Homo Sapiens,8363877086_I_Grn.idat,137319,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d137319_92TH023ENV,post-vaccination blood sample from donor 137319 stimulate 15 hours with 92TH023ENV,Blood sample from donor 137319,Homo Sapiens,8363877087_F_Grn.idat,137319,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d203143_DMSO,post-vaccination blood sample from donor 203143 stimulate 15 hours with DMSO,Blood sample from donor 203143,Homo Sapiens,8381645076_F_Grn.idat,203143,ok,Micro kit,DMSO,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d203143_92TH023ENV,post-vaccination blood sample from donor 203143 stimulate 15 hours with 92TH023ENV,Blood sample from donor 203143,Homo Sapiens,8381645076_L_Grn.idat,203143,ok,Rneasy plus Mini kit,92TH023ENV,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d206284_DMSO,post-vaccination blood sample from donor 206284 stimulate 15 hours with DMSO,Blood sample from donor 206284,Homo Sapiens,8381653015_J_Grn.idat,206284,ok,Micro kit,DMSO,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d206284_92TH023ENV,post-vaccination blood sample from donor 206284 stimulate 15 hours with 92TH023ENV,Blood sample from donor 206284,Homo Sapiens,8381645082_J_Grn.idat,206284,ok,Micro kit,92TH023ENV,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d209055_92TH023ENV,post-vaccination blood sample from donor 209055 stimulate 15 hours with 92TH023ENV,Blood sample from donor 209055,Homo Sapiens,8363885025_B_Grn.idat,209055,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d209055_DMSO,post-vaccination blood sample from donor 209055 stimulate 15 hours with DMSO,Blood sample from donor 209055,Homo Sapiens,8381645047_G_Grn.idat,209055,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d209743_DMSO,post-vaccination blood sample from donor 209743 stimulate 15 hours with DMSO,Blood sample from donor 209743,Homo Sapiens,8363885094_I_Grn.idat,209743,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d209743_92TH023ENV,post-vaccination blood sample from donor 209743 stimulate 15 hours with 92TH023ENV,Blood sample from donor 209743,Homo Sapiens,8363877086_L_Grn.idat,209743,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d211365_92TH023ENV,post-vaccination blood sample from donor 211365 stimulate 15 hours with 92TH023ENV,Blood sample from donor 211365,Homo Sapiens,8381645069_F_Grn.idat,211365,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d211365_DMSO,post-vaccination blood sample from donor 211365 stimulate 15 hours with DMSO,Blood sample from donor 211365,Homo Sapiens,8381653002_K_Grn.idat,211365,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d211484_DMSO,post-vaccination blood sample from donor 211484 stimulate 15 hours with DMSO,Blood sample from donor 211484,Homo Sapiens,8381661027_B_Grn.idat,211484,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d211484_92TH023ENV,post-vaccination blood sample from donor 211484 stimulate 15 hours with 92TH023ENV,Blood sample from donor 211484,Homo Sapiens,8363877074_C_Grn.idat,211484,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d212341_DMSO,post-vaccination blood sample from donor 212341 stimulate 15 hours with DMSO,Blood sample from donor 212341,Homo Sapiens,8381645070_B_Grn.idat,212341,ok,Micro kit,DMSO,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d212341_92TH023ENV,post-vaccination blood sample from donor 212341 stimulate 15 hours with 92TH023ENV,Blood sample from donor 212341,Homo Sapiens,8381653016_L_Grn.idat,212341,ok,Micro kit,92TH023ENV,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d214329_DMSO,post-vaccination blood sample from donor 214329 stimulate 15 hours with DMSO,Blood sample from donor 214329,Homo Sapiens,8381661002_D_Grn.idat,214329,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d214329_92TH023ENV,post-vaccination blood sample from donor 214329 stimulate 15 hours with 92TH023ENV,Blood sample from donor 214329,Homo Sapiens,8363877087_H_Grn.idat,214329,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d215765_DMSO,post-vaccination blood sample from donor 215765 stimulate 15 hours with DMSO,Blood sample from donor 215765,Homo Sapiens,8363877047_E_Grn.idat,215765,ok,Micro kit,DMSO,15,hours,PLACEBO,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with DMSO,GPL10558 +RV144_d215765_92TH023ENV,post-vaccination blood sample from donor 215765 stimulate 15 hours with 92TH023ENV,Blood sample from donor 215765,Homo Sapiens,8381653011_K_Grn.idat,215765,ok,Micro kit,92TH023ENV,15,hours,PLACEBO,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d220187_DMSO,post-vaccination blood sample from donor 220187 stimulate 15 hours with DMSO,Blood sample from donor 220187,Homo Sapiens,8363885094_J_Grn.idat,220187,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d220187_92TH023ENV,post-vaccination blood sample from donor 220187 stimulate 15 hours with 92TH023ENV,Blood sample from donor 220187,Homo Sapiens,8324350075_L_Grn.idat,220187,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d220293_92TH023ENV,post-vaccination blood sample from donor 220293 stimulate 15 hours with 92TH023ENV,Blood sample from donor 220293,Homo Sapiens,8381653013_A_Grn.idat,220293,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d220293_DMSO,post-vaccination blood sample from donor 220293 stimulate 15 hours with DMSO,Blood sample from donor 220293,Homo Sapiens,8381661027_E_Grn.idat,220293,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d221716_92TH023ENV,post-vaccination blood sample from donor 221716 stimulate 15 hours with 92TH023ENV,Blood sample from donor 221716,Homo Sapiens,8381645082_E_Grn.idat,221716,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d221716_DMSO,post-vaccination blood sample from donor 221716 stimulate 15 hours with DMSO,Blood sample from donor 221716,Homo Sapiens,8363885094_C_Grn.idat,221716,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d222271_92TH023ENV,post-vaccination blood sample from donor 222271 stimulate 15 hours with 92TH023ENV,Blood sample from donor 222271,Homo Sapiens,8363885006_E_Grn.idat,222271,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d222271_DMSO,post-vaccination blood sample from donor 222271 stimulate 15 hours with DMSO,Blood sample from donor 222271,Homo Sapiens,8381661041_A_Grn.idat,222271,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d222570_DMSO,post-vaccination blood sample from donor 222570 stimulate 15 hours with DMSO,Blood sample from donor 222570,Homo Sapiens,8381653015_H_Grn.idat,222570,ok,Micro kit,DMSO,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d222570_92TH023ENV,post-vaccination blood sample from donor 222570 stimulate 15 hours with 92TH023ENV,Blood sample from donor 222570,Homo Sapiens,8381653037_K_Grn.idat,222570,ok,Micro kit,92TH023ENV,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d223884_92TH023ENV,post-vaccination blood sample from donor 223884 stimulate 15 hours with 92TH023ENV,Blood sample from donor 223884,Homo Sapiens,8363877038_I_Grn.idat,223884,ok,Micro kit,92TH023ENV,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d223884_DMSO,post-vaccination blood sample from donor 223884 stimulate 15 hours with DMSO,Blood sample from donor 223884,Homo Sapiens,8363877087_J_Grn.idat,223884,ok,Micro kit,DMSO,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d224172_DMSO,post-vaccination blood sample from donor 224172 stimulate 15 hours with DMSO,Blood sample from donor 224172,Homo Sapiens,8381645047_K_Grn.idat,224172,ok,Micro kit,DMSO,15,hours,PLACEBO,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with DMSO,GPL10558 +RV144_d224172_92TH023ENV,post-vaccination blood sample from donor 224172 stimulate 15 hours with 92TH023ENV,Blood sample from donor 224172,Homo Sapiens,8363885025_E_Grn.idat,224172,ok,Micro kit,92TH023ENV,15,hours,PLACEBO,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d224574_DMSO,post-vaccination blood sample from donor 224574 stimulate 15 hours with DMSO,Blood sample from donor 224574,Homo Sapiens,8381653037_L_Grn.idat,224574,ok,Micro kit,DMSO,15,hours,PLACEBO,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with DMSO,GPL10558 +RV144_d224574_92TH023ENV,post-vaccination blood sample from donor 224574 stimulate 15 hours with 92TH023ENV,Blood sample from donor 224574,Homo Sapiens,8363877038_L_Grn.idat,224574,ok,Micro kit,92TH023ENV,15,hours,PLACEBO,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d225473_DMSO,post-vaccination blood sample from donor 225473 stimulate 15 hours with DMSO,Blood sample from donor 225473,Homo Sapiens,8381653002_H_Grn.idat,225473,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d225473_92TH023ENV,post-vaccination blood sample from donor 225473 stimulate 15 hours with 92TH023ENV,Blood sample from donor 225473,Homo Sapiens,8363877074_D_Grn.idat,225473,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d225769_92TH023ENV,post-vaccination blood sample from donor 225769 stimulate 15 hours with 92TH023ENV,Blood sample from donor 225769,Homo Sapiens,8363877096_H_Grn.idat,225769,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d225769_DMSO,post-vaccination blood sample from donor 225769 stimulate 15 hours with DMSO,Blood sample from donor 225769,Homo Sapiens,8381661027_H_Grn.idat,225769,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d226150_DMSO,post-vaccination blood sample from donor 226150 stimulate 15 hours with DMSO,Blood sample from donor 226150,Homo Sapiens,8363877065_C_Grn.idat,226150,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d226150_92TH023ENV,post-vaccination blood sample from donor 226150 stimulate 15 hours with 92TH023ENV,Blood sample from donor 226150,Homo Sapiens,8381645047_I_Grn.idat,226150,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d226385_DMSO,post-vaccination blood sample from donor 226385 stimulate 15 hours with DMSO,Blood sample from donor 226385,Homo Sapiens,8381645070_G_Grn.idat,226385,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d226385_92TH023ENV,post-vaccination blood sample from donor 226385 stimulate 15 hours with 92TH023ENV,Blood sample from donor 226385,Homo Sapiens,8381661022_E_Grn.idat,226385,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d229455_92TH023ENV,post-vaccination blood sample from donor 229455 stimulate 15 hours with 92TH023ENV,Blood sample from donor 229455,Homo Sapiens,8381653024_K_Grn.idat,229455,ok,Micro kit,92TH023ENV,15,hours,PLACEBO,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d229455_DMSO,post-vaccination blood sample from donor 229455 stimulate 15 hours with DMSO,Blood sample from donor 229455,Homo Sapiens,8363885073_F_Grn.idat,229455,ok,Micro kit,DMSO,15,hours,PLACEBO,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with DMSO,GPL10558 +RV144_d232545_DMSO,post-vaccination blood sample from donor 232545 stimulate 15 hours with DMSO,Blood sample from donor 232545,Homo Sapiens,8381653002_E_Grn.idat,232545,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d232545_92TH023ENV,post-vaccination blood sample from donor 232545 stimulate 15 hours with 92TH023ENV,Blood sample from donor 232545,Homo Sapiens,8363877087_I_Grn.idat,232545,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d232709_DMSO,post-vaccination blood sample from donor 232709 stimulate 15 hours with DMSO,Blood sample from donor 232709,Homo Sapiens,8363885006_L_Grn.idat,232709,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d232709_92TH023ENV,post-vaccination blood sample from donor 232709 stimulate 15 hours with 92TH023ENV,Blood sample from donor 232709,Homo Sapiens,8363885073_G_Grn.idat,232709,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d233042_DMSO,post-vaccination blood sample from donor 233042 stimulate 15 hours with DMSO,Blood sample from donor 233042,Homo Sapiens,8363877086_D_Grn.idat,233042,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d233042_92TH023ENV,post-vaccination blood sample from donor 233042 stimulate 15 hours with 92TH023ENV,Blood sample from donor 233042,Homo Sapiens,8381661002_F_Grn.idat,233042,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d233994_DMSO,post-vaccination blood sample from donor 233994 stimulate 15 hours with DMSO,Blood sample from donor 233994,Homo Sapiens,8324350075_D_Grn.idat,233994,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d233994_92TH023ENV,post-vaccination blood sample from donor 233994 stimulate 15 hours with 92TH023ENV,Blood sample from donor 233994,Homo Sapiens,8363877096_C_Grn.idat,233994,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d234549_DMSO,post-vaccination blood sample from donor 234549 stimulate 15 hours with DMSO,Blood sample from donor 234549,Homo Sapiens,8363877093_D_Grn.idat,234549,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d234549_92TH023ENV,post-vaccination blood sample from donor 234549 stimulate 15 hours with 92TH023ENV,Blood sample from donor 234549,Homo Sapiens,8363877074_I_Grn.idat,234549,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d235525_DMSO,post-vaccination blood sample from donor 235525 stimulate 15 hours with DMSO,Blood sample from donor 235525,Homo Sapiens,8363885025_J_Grn.idat,235525,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d235525_92TH023ENV,post-vaccination blood sample from donor 235525 stimulate 15 hours with 92TH023ENV,Blood sample from donor 235525,Homo Sapiens,8363877074_K_Grn.idat,235525,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d236961_DMSO,post-vaccination blood sample from donor 236961 stimulate 15 hours with DMSO,Blood sample from donor 236961,Homo Sapiens,8363877093_I_Grn.idat,236961,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d236961_92TH023ENV,post-vaccination blood sample from donor 236961 stimulate 15 hours with 92TH023ENV,Blood sample from donor 236961,Homo Sapiens,8363877102_L_Grn.idat,236961,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d237169_92TH023ENV,post-vaccination blood sample from donor 237169 stimulate 15 hours with 92TH023ENV,Blood sample from donor 237169,Homo Sapiens,8363877038_E_Grn.idat,237169,ok,Micro kit,92TH023ENV,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d237169_DMSO,post-vaccination blood sample from donor 237169 stimulate 15 hours with DMSO,Blood sample from donor 237169,Homo Sapiens,8381645097_C_Grn.idat,237169,ok,Micro kit,DMSO,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d238682_92TH023ENV,post-vaccination blood sample from donor 238682 stimulate 15 hours with 92TH023ENV,Blood sample from donor 238682,Homo Sapiens,8381661041_G_Grn.idat,238682,ok,Micro kit,92TH023ENV,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d238682_DMSO,post-vaccination blood sample from donor 238682 stimulate 15 hours with DMSO,Blood sample from donor 238682,Homo Sapiens,8363877086_F_Grn.idat,238682,ok,Micro kit,DMSO,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d240503_92TH023ENV,post-vaccination blood sample from donor 240503 stimulate 15 hours with 92TH023ENV,Blood sample from donor 240503,Homo Sapiens,8363885006_C_Grn.idat,240503,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d240503_DMSO,post-vaccination blood sample from donor 240503 stimulate 15 hours with DMSO,Blood sample from donor 240503,Homo Sapiens,8381653029_J_Grn.idat,240503,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d241248_DMSO,post-vaccination blood sample from donor 241248 stimulate 15 hours with DMSO,Blood sample from donor 241248,Homo Sapiens,8381645091_D_Grn.idat,241248,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d241248_92TH023ENV,post-vaccination blood sample from donor 241248 stimulate 15 hours with 92TH023ENV,Blood sample from donor 241248,Homo Sapiens,8363877047_G_Grn.idat,241248,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d242385_DMSO,post-vaccination blood sample from donor 242385 stimulate 15 hours with DMSO,Blood sample from donor 242385,Homo Sapiens,8381661071_E_Grn.idat,242385,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d243046_92TH023ENV,post-vaccination blood sample from donor 243046 stimulate 15 hours with 92TH023ENV,Blood sample from donor 243046,Homo Sapiens,8363885025_D_Grn.idat,243046,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d243046_DMSO,post-vaccination blood sample from donor 243046 stimulate 15 hours with DMSO,Blood sample from donor 243046,Homo Sapiens,8381645082_C_Grn.idat,243046,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d243615_92TH023ENV,post-vaccination blood sample from donor 243615 stimulate 15 hours with 92TH023ENV,Blood sample from donor 243615,Homo Sapiens,8381661041_I_Grn.idat,243615,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d243615_DMSO,post-vaccination blood sample from donor 243615 stimulate 15 hours with DMSO,Blood sample from donor 243615,Homo Sapiens,8381645005_E_Grn.idat,243615,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d244363_92TH023ENV,post-vaccination blood sample from donor 244363 stimulate 15 hours with 92TH023ENV,Blood sample from donor 244363,Homo Sapiens,8363885073_L_Grn.idat,244363,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d244363_DMSO,post-vaccination blood sample from donor 244363 stimulate 15 hours with DMSO,Blood sample from donor 244363,Homo Sapiens,8381653002_F_Grn.idat,244363,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d247912_DMSO,post-vaccination blood sample from donor 247912 stimulate 15 hours with DMSO,Blood sample from donor 247912,Homo Sapiens,8381645070_L_Grn.idat,247912,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d247912_92TH023ENV,post-vaccination blood sample from donor 247912 stimulate 15 hours with 92TH023ENV,Blood sample from donor 247912,Homo Sapiens,8381645076_A_Grn.idat,247912,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d300003_DMSO,post-vaccination blood sample from donor 300003 stimulate 15 hours with DMSO,Blood sample from donor 300003,Homo Sapiens,8381661022_C_Grn.idat,300003,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d300003_92TH023ENV,post-vaccination blood sample from donor 300003 stimulate 15 hours with 92TH023ENV,Blood sample from donor 300003,Homo Sapiens,8363877096_J_Grn.idat,300003,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d304085_92TH023ENV,post-vaccination blood sample from donor 304085 stimulate 15 hours with 92TH023ENV,Blood sample from donor 304085,Homo Sapiens,8381661041_B_Grn.idat,304085,ok,Micro kit,92TH023ENV,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d304085_DMSO,post-vaccination blood sample from donor 304085 stimulate 15 hours with DMSO,Blood sample from donor 304085,Homo Sapiens,8381661021_C_Grn.idat,304085,ok,Micro kit,DMSO,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d305968_92TH023ENV,post-vaccination blood sample from donor 305968 stimulate 15 hours with 92TH023ENV,Blood sample from donor 305968,Homo Sapiens,8363877074_G_Grn.idat,305968,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d305968_DMSO,post-vaccination blood sample from donor 305968 stimulate 15 hours with DMSO,Blood sample from donor 305968,Homo Sapiens,8363877087_A_Grn.idat,305968,problem when scanning array,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d307100_DMSO,post-vaccination blood sample from donor 307100 stimulate 15 hours with DMSO,Blood sample from donor 307100,Homo Sapiens,8381653013_J_Grn.idat,307100,ok,Micro kit,DMSO,15,hours,PLACEBO,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with DMSO,GPL10558 +RV144_d307100_92TH023ENV,post-vaccination blood sample from donor 307100 stimulate 15 hours with 92TH023ENV,Blood sample from donor 307100,Homo Sapiens,8363877086_C_Grn.idat,307100,ok,Micro kit,92TH023ENV,15,hours,PLACEBO,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d308250_DMSO,post-vaccination blood sample from donor 308250 stimulate 15 hours with DMSO,Blood sample from donor 308250,Homo Sapiens,8381661021_J_Grn.idat,308250,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d308250_92TH023ENV,post-vaccination blood sample from donor 308250 stimulate 15 hours with 92TH023ENV,Blood sample from donor 308250,Homo Sapiens,8363877096_F_Grn.idat,308250,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d308845_DMSO,post-vaccination blood sample from donor 308845 stimulate 15 hours with DMSO,Blood sample from donor 308845,Homo Sapiens,8363885094_K_Grn.idat,308845,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d308845_92TH023ENV,post-vaccination blood sample from donor 308845 stimulate 15 hours with 92TH023ENV,Blood sample from donor 308845,Homo Sapiens,8363877047_D_Grn.idat,308845,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d313180_DMSO,post-vaccination blood sample from donor 313180 stimulate 15 hours with DMSO,Blood sample from donor 313180,Homo Sapiens,8324350075_J_Grn.idat,313180,ok,Micro kit,DMSO,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d313180_92TH023ENV,post-vaccination blood sample from donor 313180 stimulate 15 hours with 92TH023ENV,Blood sample from donor 313180,Homo Sapiens,8381653015_D_Grn.idat,313180,ok,Micro kit,92TH023ENV,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d313212_DMSO,post-vaccination blood sample from donor 313212 stimulate 15 hours with DMSO,Blood sample from donor 313212,Homo Sapiens,8363885094_E_Grn.idat,313212,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d313212_92TH023ENV,post-vaccination blood sample from donor 313212 stimulate 15 hours with 92TH023ENV,Blood sample from donor 313212,Homo Sapiens,8363877093_J_Grn.idat,313212,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d316340_92TH023ENV,post-vaccination blood sample from donor 316340 stimulate 15 hours with 92TH023ENV,Blood sample from donor 316340,Homo Sapiens,8363877074_F_Grn.idat,316340,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d316340_DMSO,post-vaccination blood sample from donor 316340 stimulate 15 hours with DMSO,Blood sample from donor 316340,Homo Sapiens,8363877087_C_Grn.idat,316340,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d317175_DMSO,post-vaccination blood sample from donor 317175 stimulate 15 hours with DMSO,Blood sample from donor 317175,Homo Sapiens,8381661002_E_Grn.idat,317175,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d317175_92TH023ENV,post-vaccination blood sample from donor 317175 stimulate 15 hours with 92TH023ENV,Blood sample from donor 317175,Homo Sapiens,8363885073_I_Grn.idat,317175,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d318225_DMSO,post-vaccination blood sample from donor 318225 stimulate 15 hours with DMSO,Blood sample from donor 318225,Homo Sapiens,8381653037_E_Grn.idat,318225,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d318225_92TH023ENV,post-vaccination blood sample from donor 318225 stimulate 15 hours with 92TH023ENV,Blood sample from donor 318225,Homo Sapiens,8363885025_A_Grn.idat,318225,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d320249_92TH023ENV,post-vaccination blood sample from donor 320249 stimulate 15 hours with 92TH023ENV,Blood sample from donor 320249,Homo Sapiens,8363877093_H_Grn.idat,320249,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d320249_DMSO,post-vaccination blood sample from donor 320249 stimulate 15 hours with DMSO,Blood sample from donor 320249,Homo Sapiens,8381653015_C_Grn.idat,320249,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d320355_92TH023ENV,post-vaccination blood sample from donor 320355 stimulate 15 hours with 92TH023ENV,Blood sample from donor 320355,Homo Sapiens,8381645005_D_Grn.idat,320355,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d320355_DMSO,post-vaccination blood sample from donor 320355 stimulate 15 hours with DMSO,Blood sample from donor 320355,Homo Sapiens,8381653002_C_Grn.idat,320355,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d322089_DMSO,post-vaccination blood sample from donor 322089 stimulate 15 hours with DMSO,Blood sample from donor 322089,Homo Sapiens,8381645047_B_Grn.idat,322089,ok,Micro kit,DMSO,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d322089_92TH023ENV,post-vaccination blood sample from donor 322089 stimulate 15 hours with 92TH023ENV,Blood sample from donor 322089,Homo Sapiens,8363877047_A_Grn.idat,322089,ok,Micro kit,92TH023ENV,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d324610_DMSO,post-vaccination blood sample from donor 324610 stimulate 15 hours with DMSO,Blood sample from donor 324610,Homo Sapiens,8381645005_C_Grn.idat,324610,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d324610_92TH023ENV,post-vaccination blood sample from donor 324610 stimulate 15 hours with 92TH023ENV,Blood sample from donor 324610,Homo Sapiens,8381653011_C_Grn.idat,324610,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d331692_DMSO,post-vaccination blood sample from donor 331692 stimulate 15 hours with DMSO,Blood sample from donor 331692,Homo Sapiens,8381645097_F_Grn.idat,331692,ok,Micro kit,DMSO,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d331692_92TH023ENV,post-vaccination blood sample from donor 331692 stimulate 15 hours with 92TH023ENV,Blood sample from donor 331692,Homo Sapiens,8363877038_B_Grn.idat,331692,ok,Micro kit,92TH023ENV,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d332469_92TH023ENV,post-vaccination blood sample from donor 332469 stimulate 15 hours with 92TH023ENV,Blood sample from donor 332469,Homo Sapiens,8363877047_K_Grn.idat,332469,ok,Micro kit,92TH023ENV,15,hours,PLACEBO,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d332469_DMSO,post-vaccination blood sample from donor 332469 stimulate 15 hours with DMSO,Blood sample from donor 332469,Homo Sapiens,8363877086_A_Grn.idat,332469,ok,Micro kit,DMSO,15,hours,PLACEBO,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with DMSO,GPL10558 +RV144_d333162_DMSO,post-vaccination blood sample from donor 333162 stimulate 15 hours with DMSO,Blood sample from donor 333162,Homo Sapiens,8363885006_D_Grn.idat,333162,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d333162_92TH023ENV,post-vaccination blood sample from donor 333162 stimulate 15 hours with 92TH023ENV,Blood sample from donor 333162,Homo Sapiens,8363877096_G_Grn.idat,333162,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d334122_DMSO,post-vaccination blood sample from donor 334122 stimulate 15 hours with DMSO,Blood sample from donor 334122,Homo Sapiens,8324350075_F_Grn.idat,334122,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d334122_92TH023ENV,post-vaccination blood sample from donor 334122 stimulate 15 hours with 92TH023ENV,Blood sample from donor 334122,Homo Sapiens,8363885025_I_Grn.idat,334122,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d335179_DMSO,post-vaccination blood sample from donor 335179 stimulate 15 hours with DMSO,Blood sample from donor 335179,Homo Sapiens,8381645091_F_Grn.idat,335179,ok,Micro kit,DMSO,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d335179_92TH023ENV,post-vaccination blood sample from donor 335179 stimulate 15 hours with 92TH023ENV,Blood sample from donor 335179,Homo Sapiens,8363877096_L_Grn.idat,335179,ok,Micro kit,92TH023ENV,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d337366_92TH023ENV,post-vaccination blood sample from donor 337366 stimulate 15 hours with 92TH023ENV,Blood sample from donor 337366,Homo Sapiens,8381645069_J_Grn.idat,337366,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d337366_DMSO,post-vaccination blood sample from donor 337366 stimulate 15 hours with DMSO,Blood sample from donor 337366,Homo Sapiens,8381661027_D_Grn.idat,337366,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d338098_92TH023ENV,post-vaccination blood sample from donor 338098 stimulate 15 hours with 92TH023ENV,Blood sample from donor 338098,Homo Sapiens,8363877096_B_Grn.idat,338098,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d338098_DMSO,post-vaccination blood sample from donor 338098 stimulate 15 hours with DMSO,Blood sample from donor 338098,Homo Sapiens,8381661027_A_Grn.idat,338098,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d339360_DMSO,post-vaccination blood sample from donor 339360 stimulate 15 hours with DMSO,Blood sample from donor 339360,Homo Sapiens,8381653024_A_Grn.idat,339360,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d339360_92TH023ENV,post-vaccination blood sample from donor 339360 stimulate 15 hours with 92TH023ENV,Blood sample from donor 339360,Homo Sapiens,8363877096_I_Grn.idat,339360,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d343047_92TH023ENV,post-vaccination blood sample from donor 343047 stimulate 15 hours with 92TH023ENV,Blood sample from donor 343047,Homo Sapiens,8381653002_G_Grn.idat,343047,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d343047_DMSO,post-vaccination blood sample from donor 343047 stimulate 15 hours with DMSO,Blood sample from donor 343047,Homo Sapiens,8324350075_G_Grn.idat,343047,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d343793_DMSO,post-vaccination blood sample from donor 343793 stimulate 15 hours with DMSO,Blood sample from donor 343793,Homo Sapiens,8381661071_B_Grn.idat,343793,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d343793_92TH023ENV,post-vaccination blood sample from donor 343793 stimulate 15 hours with 92TH023ENV,Blood sample from donor 343793,Homo Sapiens,8363885025_G_Grn.idat,343793,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d345025_92TH023ENV,post-vaccination blood sample from donor 345025 stimulate 15 hours with 92TH023ENV,Blood sample from donor 345025,Homo Sapiens,8381645049_G_Grn.idat,345025,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d345025_DMSO,post-vaccination blood sample from donor 345025 stimulate 15 hours with DMSO,Blood sample from donor 345025,Homo Sapiens,8381645091_C_Grn.idat,345025,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d345102_92TH023ENV,post-vaccination blood sample from donor 345102 stimulate 15 hours with 92TH023ENV,Blood sample from donor 345102,Homo Sapiens,8381645082_D_Grn.idat,345102,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d345102_DMSO,post-vaccination blood sample from donor 345102 stimulate 15 hours with DMSO,Blood sample from donor 345102,Homo Sapiens,8381653015_K_Grn.idat,345102,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d348298_DMSO,post-vaccination blood sample from donor 348298 stimulate 15 hours with DMSO,Blood sample from donor 348298,Homo Sapiens,8381661021_B_Grn.idat,348298,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d348298_92TH023ENV,post-vaccination blood sample from donor 348298 stimulate 15 hours with 92TH023ENV,Blood sample from donor 348298,Homo Sapiens,8363877065_G_Grn.idat,348298,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d349290_92TH023ENV,post-vaccination blood sample from donor 349290 stimulate 15 hours with 92TH023ENV,Blood sample from donor 349290,Homo Sapiens,8381661041_C_Grn.idat,349290,ok,Micro kit,92TH023ENV,15,hours,PLACEBO,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d349290_DMSO,post-vaccination blood sample from donor 349290 stimulate 15 hours with DMSO,Blood sample from donor 349290,Homo Sapiens,8363885025_H_Grn.idat,349290,ok,Micro kit,DMSO,15,hours,PLACEBO,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with DMSO,GPL10558 +RV144_d354609_92TH023ENV,post-vaccination blood sample from donor 354609 stimulate 15 hours with 92TH023ENV,Blood sample from donor 354609,Homo Sapiens,8363885025_L_Grn.idat,354609,ok,Micro kit,92TH023ENV,15,hours,PLACEBO,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d354609_DMSO,post-vaccination blood sample from donor 354609 stimulate 15 hours with DMSO,Blood sample from donor 354609,Homo Sapiens,8381653024_H_Grn.idat,354609,ok,Micro kit,DMSO,15,hours,PLACEBO,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with DMSO,GPL10558 +RV144_d355698_DMSO,post-vaccination blood sample from donor 355698 stimulate 15 hours with DMSO,Blood sample from donor 355698,Homo Sapiens,8381653015_G_Grn.idat,355698,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d355698_92TH023ENV,post-vaccination blood sample from donor 355698 stimulate 15 hours with 92TH023ENV,Blood sample from donor 355698,Homo Sapiens,8381653037_F_Grn.idat,355698,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d355894_92TH023ENV,post-vaccination blood sample from donor 355894 stimulate 15 hours with 92TH023ENV,Blood sample from donor 355894,Homo Sapiens,8363877038_K_Grn.idat,355894,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d355894_DMSO,post-vaccination blood sample from donor 355894 stimulate 15 hours with DMSO,Blood sample from donor 355894,Homo Sapiens,8381645091_A_Grn.idat,355894,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d357229_92TH023ENV,post-vaccination blood sample from donor 357229 stimulate 15 hours with 92TH023ENV,Blood sample from donor 357229,Homo Sapiens,8363877047_C_Grn.idat,357229,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d357229_DMSO,post-vaccination blood sample from donor 357229 stimulate 15 hours with DMSO,Blood sample from donor 357229,Homo Sapiens,8381653011_H_Grn.idat,357229,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d402558_92TH023ENV,post-vaccination blood sample from donor 402558 stimulate 15 hours with 92TH023ENV,Blood sample from donor 402558,Homo Sapiens,8381653029_H_Grn.idat,402558,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d402558_DMSO,post-vaccination blood sample from donor 402558 stimulate 15 hours with DMSO,Blood sample from donor 402558,Homo Sapiens,8363877086_B_Grn.idat,402558,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d403068_DMSO,post-vaccination blood sample from donor 403068 stimulate 15 hours with DMSO,Blood sample from donor 403068,Homo Sapiens,8381661002_J_Grn.idat,403068,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d403068_92TH023ENV,post-vaccination blood sample from donor 403068 stimulate 15 hours with 92TH023ENV,Blood sample from donor 403068,Homo Sapiens,8381653016_E_Grn.idat,403068,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d404343_92TH023ENV,post-vaccination blood sample from donor 404343 stimulate 15 hours with 92TH023ENV,Blood sample from donor 404343,Homo Sapiens,8381645076_I_Grn.idat,404343,ok,Micro kit,92TH023ENV,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d404343_DMSO,post-vaccination blood sample from donor 404343 stimulate 15 hours with DMSO,Blood sample from donor 404343,Homo Sapiens,8381661022_B_Grn.idat,404343,ok,Micro kit,DMSO,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d405017_DMSO,post-vaccination blood sample from donor 405017 stimulate 15 hours with DMSO,Blood sample from donor 405017,Homo Sapiens,8381653024_E_Grn.idat,405017,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d405017_92TH023ENV,post-vaccination blood sample from donor 405017 stimulate 15 hours with 92TH023ENV,Blood sample from donor 405017,Homo Sapiens,8381653002_L_Grn.idat,405017,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d405464_92TH023ENV,post-vaccination blood sample from donor 405464 stimulate 15 hours with 92TH023ENV,Blood sample from donor 405464,Homo Sapiens,8363877087_D_Grn.idat,405464,ok,Micro kit,92TH023ENV,15,hours,PLACEBO,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d405464_DMSO,post-vaccination blood sample from donor 405464 stimulate 15 hours with DMSO,Blood sample from donor 405464,Homo Sapiens,8381645070_I_Grn.idat,405464,ok,Micro kit,DMSO,15,hours,PLACEBO,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with DMSO,GPL10558 +RV144_d405686_92TH023ENV,post-vaccination blood sample from donor 405686 stimulate 15 hours with 92TH023ENV,Blood sample from donor 405686,Homo Sapiens,8381645097_H_Grn.idat,405686,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d405686_DMSO,post-vaccination blood sample from donor 405686 stimulate 15 hours with DMSO,Blood sample from donor 405686,Homo Sapiens,8381653011_B_Grn.idat,405686,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d411547_92TH023ENV,post-vaccination blood sample from donor 411547 stimulate 15 hours with 92TH023ENV,Blood sample from donor 411547,Homo Sapiens,8381645047_J_Grn.idat,411547,ok,Micro kit,92TH023ENV,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d411547_DMSO,post-vaccination blood sample from donor 411547 stimulate 15 hours with DMSO,Blood sample from donor 411547,Homo Sapiens,8363877086_J_Grn.idat,411547,ok,Micro kit,DMSO,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d412134_92TH023ENV,post-vaccination blood sample from donor 412134 stimulate 15 hours with 92TH023ENV,Blood sample from donor 412134,Homo Sapiens,8381645005_J_Grn.idat,412134,ok,Micro kit,92TH023ENV,15,hours,PLACEBO,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d412134_DMSO,post-vaccination blood sample from donor 412134 stimulate 15 hours with DMSO,Blood sample from donor 412134,Homo Sapiens,8363877086_H_Grn.idat,412134,ok,Micro kit,DMSO,15,hours,PLACEBO,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with DMSO,GPL10558 +RV144_d413107_92TH023ENV,post-vaccination blood sample from donor 413107 stimulate 15 hours with 92TH023ENV,Blood sample from donor 413107,Homo Sapiens,8363877093_A_Grn.idat,413107,ok,Micro kit,92TH023ENV,15,hours,PLACEBO,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d413107_DMSO,post-vaccination blood sample from donor 413107 stimulate 15 hours with DMSO,Blood sample from donor 413107,Homo Sapiens,8381645097_B_Grn.idat,413107,ok,Micro kit,DMSO,15,hours,PLACEBO,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with DMSO,GPL10558 +RV144_d417372_DMSO,post-vaccination blood sample from donor 417372 stimulate 15 hours with DMSO,Blood sample from donor 417372,Homo Sapiens,8381661022_J_Grn.idat,417372,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d417372_92TH023ENV,post-vaccination blood sample from donor 417372 stimulate 15 hours with 92TH023ENV,Blood sample from donor 417372,Homo Sapiens,8363877038_J_Grn.idat,417372,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d419202_92TH023ENV,post-vaccination blood sample from donor 419202 stimulate 15 hours with 92TH023ENV,Blood sample from donor 419202,Homo Sapiens,8381661071_I_Grn.idat,419202,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d419202_DMSO,post-vaccination blood sample from donor 419202 stimulate 15 hours with DMSO,Blood sample from donor 419202,Homo Sapiens,8363885094_H_Grn.idat,419202,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d419318_DMSO,post-vaccination blood sample from donor 419318 stimulate 15 hours with DMSO,Blood sample from donor 419318,Homo Sapiens,8381653016_C_Grn.idat,419318,ok,Micro kit,DMSO,15,hours,PLACEBO,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with DMSO,GPL10558 +RV144_d419318_92TH023ENV,post-vaccination blood sample from donor 419318 stimulate 15 hours with 92TH023ENV,Blood sample from donor 419318,Homo Sapiens,8381653024_B_Grn.idat,419318,ok,Micro kit,92TH023ENV,15,hours,PLACEBO,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d420459_DMSO,post-vaccination blood sample from donor 420459 stimulate 15 hours with DMSO,Blood sample from donor 420459,Homo Sapiens,8363885073_D_Grn.idat,420459,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d420459_92TH023ENV,post-vaccination blood sample from donor 420459 stimulate 15 hours with 92TH023ENV,Blood sample from donor 420459,Homo Sapiens,8381653029_G_Grn.idat,420459,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d424589_92TH023ENV,post-vaccination blood sample from donor 424589 stimulate 15 hours with 92TH023ENV,Blood sample from donor 424589,Homo Sapiens,8363885025_K_Grn.idat,424589,ok,Micro kit,92TH023ENV,15,hours,PLACEBO,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d424589_DMSO,post-vaccination blood sample from donor 424589 stimulate 15 hours with DMSO,Blood sample from donor 424589,Homo Sapiens,8381653037_A_Grn.idat,424589,ok,Micro kit,DMSO,15,hours,PLACEBO,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with DMSO,GPL10558 +RV144_d425938_92TH023ENV,post-vaccination blood sample from donor 425938 stimulate 15 hours with 92TH023ENV,Blood sample from donor 425938,Homo Sapiens,8363877093_C_Grn.idat,425938,ok,Micro kit,92TH023ENV,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d425938_DMSO,post-vaccination blood sample from donor 425938 stimulate 15 hours with DMSO,Blood sample from donor 425938,Homo Sapiens,8381645049_B_Grn.idat,425938,ok,Micro kit,DMSO,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d431442_DMSO,post-vaccination blood sample from donor 431442 stimulate 15 hours with DMSO,Blood sample from donor 431442,Homo Sapiens,8381645082_I_Grn.idat,431442,ok,Micro kit,DMSO,15,hours,PLACEBO,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with DMSO,GPL10558 +RV144_d431442_92TH023ENV,post-vaccination blood sample from donor 431442 stimulate 15 hours with 92TH023ENV,Blood sample from donor 431442,Homo Sapiens,8381661021_G_Grn.idat,431442,ok,Rneasy plus Mini kit,92TH023ENV,15,hours,PLACEBO,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d432132_DMSO,post-vaccination blood sample from donor 432132 stimulate 15 hours with DMSO,Blood sample from donor 432132,Homo Sapiens,8381645069_A_Grn.idat,432132,ok,Micro kit,DMSO,15,hours,PLACEBO,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with DMSO,GPL10558 +RV144_d432132_92TH023ENV,post-vaccination blood sample from donor 432132 stimulate 15 hours with 92TH023ENV,Blood sample from donor 432132,Homo Sapiens,8381661041_D_Grn.idat,432132,ok,Micro kit,92TH023ENV,15,hours,PLACEBO,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d434239_DMSO,post-vaccination blood sample from donor 434239 stimulate 15 hours with DMSO,Blood sample from donor 434239,Homo Sapiens,8381661027_L_Grn.idat,434239,ok,Micro kit,DMSO,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d434239_92TH023ENV,post-vaccination blood sample from donor 434239 stimulate 15 hours with 92TH023ENV,Blood sample from donor 434239,Homo Sapiens,8363877093_F_Grn.idat,434239,ok,Micro kit,92TH023ENV,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d438697_92TH023ENV,post-vaccination blood sample from donor 438697 stimulate 15 hours with 92TH023ENV,Blood sample from donor 438697,Homo Sapiens,8381645076_H_Grn.idat,438697,ok,Micro kit,92TH023ENV,15,hours,PLACEBO,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d438697_DMSO,post-vaccination blood sample from donor 438697 stimulate 15 hours with DMSO,Blood sample from donor 438697,Homo Sapiens,8381645097_A_Grn.idat,438697,ok,Micro kit,DMSO,15,hours,PLACEBO,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with DMSO,GPL10558 +RV144_d444217_92TH023ENV,post-vaccination blood sample from donor 444217 stimulate 15 hours with 92TH023ENV,Blood sample from donor 444217,Homo Sapiens,8381661002_H_Grn.idat,444217,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d444217_DMSO,post-vaccination blood sample from donor 444217 stimulate 15 hours with DMSO,Blood sample from donor 444217,Homo Sapiens,8363877065_A_Grn.idat,444217,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d444725_DMSO,post-vaccination blood sample from donor 444725 stimulate 15 hours with DMSO,Blood sample from donor 444725,Homo Sapiens,8381645049_H_Grn.idat,444725,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d444725_92TH023ENV,post-vaccination blood sample from donor 444725 stimulate 15 hours with 92TH023ENV,Blood sample from donor 444725,Homo Sapiens,8363877087_G_Grn.idat,444725,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d449394_DMSO,post-vaccination blood sample from donor 449394 stimulate 15 hours with DMSO,Blood sample from donor 449394,Homo Sapiens,8381661071_K_Grn.idat,449394,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d449394_92TH023ENV,post-vaccination blood sample from donor 449394 stimulate 15 hours with 92TH023ENV,Blood sample from donor 449394,Homo Sapiens,8363877074_J_Grn.idat,449394,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d500256_92TH023ENV,post-vaccination blood sample from donor 500256 stimulate 15 hours with 92TH023ENV,Blood sample from donor 500256,Homo Sapiens,8381661071_C_Grn.idat,500256,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d500256_DMSO,post-vaccination blood sample from donor 500256 stimulate 15 hours with DMSO,Blood sample from donor 500256,Homo Sapiens,8381645076_D_Grn.idat,500256,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d500375_DMSO,post-vaccination blood sample from donor 500375 stimulate 15 hours with DMSO,Blood sample from donor 500375,Homo Sapiens,8381653016_F_Grn.idat,500375,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d500375_92TH023ENV,post-vaccination blood sample from donor 500375 stimulate 15 hours with 92TH023ENV,Blood sample from donor 500375,Homo Sapiens,8363877065_B_Grn.idat,500375,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d505018_92TH023ENV,post-vaccination blood sample from donor 505018 stimulate 15 hours with 92TH023ENV,Blood sample from donor 505018,Homo Sapiens,8363877093_E_Grn.idat,505018,ok,Micro kit,92TH023ENV,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d505018_DMSO,post-vaccination blood sample from donor 505018 stimulate 15 hours with DMSO,Blood sample from donor 505018,Homo Sapiens,8381645070_K_Grn.idat,505018,ok,Micro kit,DMSO,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d505690_92TH023ENV,post-vaccination blood sample from donor 505690 stimulate 15 hours with 92TH023ENV,Blood sample from donor 505690,Homo Sapiens,8363885094_L_Grn.idat,505690,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d505690_DMSO,post-vaccination blood sample from donor 505690 stimulate 15 hours with DMSO,Blood sample from donor 505690,Homo Sapiens,8381645049_A_Grn.idat,505690,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d507430_92TH023ENV,post-vaccination blood sample from donor 507430 stimulate 15 hours with 92TH023ENV,Blood sample from donor 507430,Homo Sapiens,8363877096_K_Grn.idat,507430,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d507430_DMSO,post-vaccination blood sample from donor 507430 stimulate 15 hours with DMSO,Blood sample from donor 507430,Homo Sapiens,8381645076_C_Grn.idat,507430,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d508522_92TH023ENV,post-vaccination blood sample from donor 508522 stimulate 15 hours with 92TH023ENV,Blood sample from donor 508522,Homo Sapiens,8381661071_A_Grn.idat,508522,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d508522_DMSO,post-vaccination blood sample from donor 508522 stimulate 15 hours with DMSO,Blood sample from donor 508522,Homo Sapiens,8381661041_F_Grn.idat,508522,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d508696_92TH023ENV,post-vaccination blood sample from donor 508696 stimulate 15 hours with 92TH023ENV,Blood sample from donor 508696,Homo Sapiens,8363877102_I_Grn.idat,508696,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d508696_DMSO,post-vaccination blood sample from donor 508696 stimulate 15 hours with DMSO,Blood sample from donor 508696,Homo Sapiens,8363877102_B_Grn.idat,508696,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d509119_92TH023ENV,post-vaccination blood sample from donor 509119 stimulate 15 hours with 92TH023ENV,Blood sample from donor 509119,Homo Sapiens,8381661071_F_Grn.idat,509119,ok,Micro kit,92TH023ENV,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d509119_DMSO,post-vaccination blood sample from donor 509119 stimulate 15 hours with DMSO,Blood sample from donor 509119,Homo Sapiens,8381653037_B_Grn.idat,509119,ok,Micro kit,DMSO,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d511159_DMSO,post-vaccination blood sample from donor 511159 stimulate 15 hours with DMSO,Blood sample from donor 511159,Homo Sapiens,8381661002_L_Grn.idat,511159,ok,Micro kit,DMSO,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d511159_92TH023ENV,post-vaccination blood sample from donor 511159 stimulate 15 hours with 92TH023ENV,Blood sample from donor 511159,Homo Sapiens,8381645082_F_Grn.idat,511159,ok,Micro kit,92TH023ENV,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d511908_92TH023ENV,post-vaccination blood sample from donor 511908 stimulate 15 hours with 92TH023ENV,Blood sample from donor 511908,Homo Sapiens,8381661027_I_Grn.idat,511908,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d511908_DMSO,post-vaccination blood sample from donor 511908 stimulate 15 hours with DMSO,Blood sample from donor 511908,Homo Sapiens,8381661002_I_Grn.idat,511908,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d512209_DMSO,post-vaccination blood sample from donor 512209 stimulate 15 hours with DMSO,Blood sample from donor 512209,Homo Sapiens,8381645091_H_Grn.idat,512209,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d512209_92TH023ENV,post-vaccination blood sample from donor 512209 stimulate 15 hours with 92TH023ENV,Blood sample from donor 512209,Homo Sapiens,8363877038_F_Grn.idat,512209,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d513494_DMSO,post-vaccination blood sample from donor 513494 stimulate 15 hours with DMSO,Blood sample from donor 513494,Homo Sapiens,8381645091_B_Grn.idat,513494,ok,Micro kit,DMSO,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d513494_92TH023ENV,post-vaccination blood sample from donor 513494 stimulate 15 hours with 92TH023ENV,Blood sample from donor 513494,Homo Sapiens,8363877087_B_Grn.idat,513494,ok,Micro kit,92TH023ENV,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d513999_DMSO,post-vaccination blood sample from donor 513999 stimulate 15 hours with DMSO,Blood sample from donor 513999,Homo Sapiens,8381653002_D_Grn.idat,513999,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d513999_92TH023ENV,post-vaccination blood sample from donor 513999 stimulate 15 hours with 92TH023ENV,Blood sample from donor 513999,Homo Sapiens,8381661071_H_Grn.idat,513999,ok,Rneasy plus Mini kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d515964_92TH023ENV,post-vaccination blood sample from donor 515964 stimulate 15 hours with 92TH023ENV,Blood sample from donor 515964,Homo Sapiens,8381661071_D_Grn.idat,515964,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d515964_DMSO,post-vaccination blood sample from donor 515964 stimulate 15 hours with DMSO,Blood sample from donor 515964,Homo Sapiens,8363885025_F_Grn.idat,515964,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d517106_DMSO,post-vaccination blood sample from donor 517106 stimulate 15 hours with DMSO,Blood sample from donor 517106,Homo Sapiens,8381645070_F_Grn.idat,517106,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d517106_92TH023ENV,post-vaccination blood sample from donor 517106 stimulate 15 hours with 92TH023ENV,Blood sample from donor 517106,Homo Sapiens,8381661027_J_Grn.idat,517106,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d517997_92TH023ENV,post-vaccination blood sample from donor 517997 stimulate 15 hours with 92TH023ENV,Blood sample from donor 517997,Homo Sapiens,8363885006_I_Grn.idat,517997,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d517997_DMSO,post-vaccination blood sample from donor 517997 stimulate 15 hours with DMSO,Blood sample from donor 517997,Homo Sapiens,8381645047_L_Grn.idat,517997,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d520270_92TH023ENV,post-vaccination blood sample from donor 520270 stimulate 15 hours with 92TH023ENV,Blood sample from donor 520270,Homo Sapiens,8381653016_B_Grn.idat,520270,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d520270_DMSO,post-vaccination blood sample from donor 520270 stimulate 15 hours with DMSO,Blood sample from donor 520270,Homo Sapiens,8381645097_L_Grn.idat,520270,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d521571_92TH023ENV,post-vaccination blood sample from donor 521571 stimulate 15 hours with 92TH023ENV,Blood sample from donor 521571,Homo Sapiens,8381661022_I_Grn.idat,521571,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d521571_DMSO,post-vaccination blood sample from donor 521571 stimulate 15 hours with DMSO,Blood sample from donor 521571,Homo Sapiens,8363877093_B_Grn.idat,521571,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d524834_92TH023ENV,post-vaccination blood sample from donor 524834 stimulate 15 hours with 92TH023ENV,Blood sample from donor 524834,Homo Sapiens,8363877065_F_Grn.idat,524834,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d524834_DMSO,post-vaccination blood sample from donor 524834 stimulate 15 hours with DMSO,Blood sample from donor 524834,Homo Sapiens,8381645005_B_Grn.idat,524834,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d526076_92TH023ENV,post-vaccination blood sample from donor 526076 stimulate 15 hours with 92TH023ENV,Blood sample from donor 526076,Homo Sapiens,8363885094_D_Grn.idat,526076,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d526076_DMSO,post-vaccination blood sample from donor 526076 stimulate 15 hours with DMSO,Blood sample from donor 526076,Homo Sapiens,8363877086_E_Grn.idat,526076,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d526452_DMSO,post-vaccination blood sample from donor 526452 stimulate 15 hours with DMSO,Blood sample from donor 526452,Homo Sapiens,8363877047_F_Grn.idat,526452,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d526452_92TH023ENV,post-vaccination blood sample from donor 526452 stimulate 15 hours with 92TH023ENV,Blood sample from donor 526452,Homo Sapiens,8381645005_K_Grn.idat,526452,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d526526_DMSO,post-vaccination blood sample from donor 526526 stimulate 15 hours with DMSO,Blood sample from donor 526526,Homo Sapiens,8381645069_E_Grn.idat,526526,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d526526_92TH023ENV,post-vaccination blood sample from donor 526526 stimulate 15 hours with 92TH023ENV,Blood sample from donor 526526,Homo Sapiens,8381653037_H_Grn.idat,526526,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d526915_92TH023ENV,post-vaccination blood sample from donor 526915 stimulate 15 hours with 92TH023ENV,Blood sample from donor 526915,Homo Sapiens,8363877096_D_Grn.idat,526915,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d526915_DMSO,post-vaccination blood sample from donor 526915 stimulate 15 hours with DMSO,Blood sample from donor 526915,Homo Sapiens,8381653013_H_Grn.idat,526915,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d600125_DMSO,post-vaccination blood sample from donor 600125 stimulate 15 hours with DMSO,Blood sample from donor 600125,Homo Sapiens,8381661021_D_Grn.idat,600125,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d600125_92TH023ENV,post-vaccination blood sample from donor 600125 stimulate 15 hours with 92TH023ENV,Blood sample from donor 600125,Homo Sapiens,8381645049_K_Grn.idat,600125,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d601024_92TH023ENV,post-vaccination blood sample from donor 601024 stimulate 15 hours with 92TH023ENV,Blood sample from donor 601024,Homo Sapiens,8381653013_B_Grn.idat,601024,ok,Micro kit,92TH023ENV,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d601024_DMSO,post-vaccination blood sample from donor 601024 stimulate 15 hours with DMSO,Blood sample from donor 601024,Homo Sapiens,8363877047_L_Grn.idat,601024,ok,Micro kit,DMSO,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d603208_DMSO,post-vaccination blood sample from donor 603208 stimulate 15 hours with DMSO,Blood sample from donor 603208,Homo Sapiens,8381645047_E_Grn.idat,603208,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d603208_92TH023ENV,post-vaccination blood sample from donor 603208 stimulate 15 hours with 92TH023ENV,Blood sample from donor 603208,Homo Sapiens,8381661002_C_Grn.idat,603208,ok,Rneasy plus Mini kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d603880_DMSO,post-vaccination blood sample from donor 603880 stimulate 15 hours with DMSO,Blood sample from donor 603880,Homo Sapiens,8381653013_G_Grn.idat,603880,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d603880_92TH023ENV,post-vaccination blood sample from donor 603880 stimulate 15 hours with 92TH023ENV,Blood sample from donor 603880,Homo Sapiens,8363877047_H_Grn.idat,603880,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d603909_92TH023ENV,post-vaccination blood sample from donor 603909 stimulate 15 hours with 92TH023ENV,Blood sample from donor 603909,Homo Sapiens,8363877102_F_Grn.idat,603909,ok,Micro kit,92TH023ENV,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d603909_DMSO,post-vaccination blood sample from donor 603909 stimulate 15 hours with DMSO,Blood sample from donor 603909,Homo Sapiens,8381653011_J_Grn.idat,603909,ok,Micro kit,DMSO,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d604004_92TH023ENV,post-vaccination blood sample from donor 604004 stimulate 15 hours with 92TH023ENV,Blood sample from donor 604004,Homo Sapiens,8363877065_E_Grn.idat,604004,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d604004_DMSO,post-vaccination blood sample from donor 604004 stimulate 15 hours with DMSO,Blood sample from donor 604004,Homo Sapiens,8381645069_H_Grn.idat,604004,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d605125_92TH023ENV,post-vaccination blood sample from donor 605125 stimulate 15 hours with 92TH023ENV,Blood sample from donor 605125,Homo Sapiens,8381653029_K_Grn.idat,605125,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d605125_DMSO,post-vaccination blood sample from donor 605125 stimulate 15 hours with DMSO,Blood sample from donor 605125,Homo Sapiens,8381653029_L_Grn.idat,605125,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d608822_DMSO,post-vaccination blood sample from donor 608822 stimulate 15 hours with DMSO,Blood sample from donor 608822,Homo Sapiens,8363885094_G_Grn.idat,608822,ok,Micro kit,DMSO,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d608822_92TH023ENV,post-vaccination blood sample from donor 608822 stimulate 15 hours with 92TH023ENV,Blood sample from donor 608822,Homo Sapiens,8381653024_F_Grn.idat,608822,ok,Micro kit,92TH023ENV,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d610309_DMSO,post-vaccination blood sample from donor 610309 stimulate 15 hours with DMSO,Blood sample from donor 610309,Homo Sapiens,8381653037_I_Grn.idat,610309,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d610309_92TH023ENV,post-vaccination blood sample from donor 610309 stimulate 15 hours with 92TH023ENV,Blood sample from donor 610309,Homo Sapiens,8381653002_B_Grn.idat,610309,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d614918_92TH023ENV,post-vaccination blood sample from donor 614918 stimulate 15 hours with 92TH023ENV,Blood sample from donor 614918,Homo Sapiens,8381653013_E_Grn.idat,614918,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d614918_DMSO,post-vaccination blood sample from donor 614918 stimulate 15 hours with DMSO,Blood sample from donor 614918,Homo Sapiens,8381653011_G_Grn.idat,614918,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d619127_92TH023ENV,post-vaccination blood sample from donor 619127 stimulate 15 hours with 92TH023ENV,Blood sample from donor 619127,Homo Sapiens,8381653029_E_Grn.idat,619127,ok,Micro kit,92TH023ENV,15,hours,PLACEBO,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d619127_DMSO,post-vaccination blood sample from donor 619127 stimulate 15 hours with DMSO,Blood sample from donor 619127,Homo Sapiens,8381645091_E_Grn.idat,619127,ok,Micro kit,DMSO,15,hours,PLACEBO,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with DMSO,GPL10558 +RV144_d621813_DMSO,post-vaccination blood sample from donor 621813 stimulate 15 hours with DMSO,Blood sample from donor 621813,Homo Sapiens,8363877087_L_Grn.idat,621813,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d621813_92TH023ENV,post-vaccination blood sample from donor 621813 stimulate 15 hours with 92TH023ENV,Blood sample from donor 621813,Homo Sapiens,8381645070_J_Grn.idat,621813,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d625525_92TH023ENV,post-vaccination blood sample from donor 625525 stimulate 15 hours with 92TH023ENV,Blood sample from donor 625525,Homo Sapiens,8381653016_H_Grn.idat,625525,ok,Micro kit,92TH023ENV,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d625525_DMSO,post-vaccination blood sample from donor 625525 stimulate 15 hours with DMSO,Blood sample from donor 625525,Homo Sapiens,8381661002_G_Grn.idat,625525,ok,Micro kit,DMSO,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d626077_92TH023ENV,post-vaccination blood sample from donor 626077 stimulate 15 hours with 92TH023ENV,Blood sample from donor 626077,Homo Sapiens,8363877102_H_Grn.idat,626077,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d626077_DMSO,post-vaccination blood sample from donor 626077 stimulate 15 hours with DMSO,Blood sample from donor 626077,Homo Sapiens,8381653016_D_Grn.idat,626077,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d627156_92TH023ENV,post-vaccination blood sample from donor 627156 stimulate 15 hours with 92TH023ENV,Blood sample from donor 627156,Homo Sapiens,8381661021_E_Grn.idat,627156,ok,Rneasy plus Mini kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d627156_DMSO,post-vaccination blood sample from donor 627156 stimulate 15 hours with DMSO,Blood sample from donor 627156,Homo Sapiens,8324350075_H_Grn.idat,627156,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d627323_92TH023ENV,post-vaccination blood sample from donor 627323 stimulate 15 hours with 92TH023ENV,Blood sample from donor 627323,Homo Sapiens,8381661027_K_Grn.idat,627323,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d627323_DMSO,post-vaccination blood sample from donor 627323 stimulate 15 hours with DMSO,Blood sample from donor 627323,Homo Sapiens,8363877102_K_Grn.idat,627323,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d627783_92TH023ENV,post-vaccination blood sample from donor 627783 stimulate 15 hours with 92TH023ENV,Blood sample from donor 627783,Homo Sapiens,8381645049_C_Grn.idat,627783,ok,Micro kit,92TH023ENV,15,hours,PLACEBO,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d627783_DMSO,post-vaccination blood sample from donor 627783 stimulate 15 hours with DMSO,Blood sample from donor 627783,Homo Sapiens,8363877047_I_Grn.idat,627783,ok,Micro kit,DMSO,15,hours,PLACEBO,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with DMSO,GPL10558 +RV144_d628859_DMSO,post-vaccination blood sample from donor 628859 stimulate 15 hours with DMSO,Blood sample from donor 628859,Homo Sapiens,8381645069_I_Grn.idat,628859,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d628859_92TH023ENV,post-vaccination blood sample from donor 628859 stimulate 15 hours with 92TH023ENV,Blood sample from donor 628859,Homo Sapiens,8381661041_J_Grn.idat,628859,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d629581_92TH023ENV,post-vaccination blood sample from donor 629581 stimulate 15 hours with 92TH023ENV,Blood sample from donor 629581,Homo Sapiens,8363885006_J_Grn.idat,629581,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d629581_DMSO,post-vaccination blood sample from donor 629581 stimulate 15 hours with DMSO,Blood sample from donor 629581,Homo Sapiens,8381645082_H_Grn.idat,629581,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d629639_92TH023ENV,post-vaccination blood sample from donor 629639 stimulate 15 hours with 92TH023ENV,Blood sample from donor 629639,Homo Sapiens,8381661002_K_Grn.idat,629639,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d629639_DMSO,post-vaccination blood sample from donor 629639 stimulate 15 hours with DMSO,Blood sample from donor 629639,Homo Sapiens,8381645076_B_Grn.idat,629639,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d631103_92TH023ENV,post-vaccination blood sample from donor 631103 stimulate 15 hours with 92TH023ENV,Blood sample from donor 631103,Homo Sapiens,8381653016_J_Grn.idat,631103,ok,Micro kit,92TH023ENV,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d631103_DMSO,post-vaccination blood sample from donor 631103 stimulate 15 hours with DMSO,Blood sample from donor 631103,Homo Sapiens,8381645047_A_Grn.idat,631103,ok,Micro kit,DMSO,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d633033_DMSO,post-vaccination blood sample from donor 633033 stimulate 15 hours with DMSO,Blood sample from donor 633033,Homo Sapiens,8363885094_B_Grn.idat,633033,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d633033_92TH023ENV,post-vaccination blood sample from donor 633033 stimulate 15 hours with 92TH023ENV,Blood sample from donor 633033,Homo Sapiens,8381645070_E_Grn.idat,633033,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d635989_92TH023ENV,post-vaccination blood sample from donor 635989 stimulate 15 hours with 92TH023ENV,Blood sample from donor 635989,Homo Sapiens,8381661041_H_Grn.idat,635989,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d635989_DMSO,post-vaccination blood sample from donor 635989 stimulate 15 hours with DMSO,Blood sample from donor 635989,Homo Sapiens,8363877087_E_Grn.idat,635989,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d637295_DMSO,post-vaccination blood sample from donor 637295 stimulate 15 hours with DMSO,Blood sample from donor 637295,Homo Sapiens,8381653016_A_Grn.idat,637295,ok,Micro kit,DMSO,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d637295_92TH023ENV,post-vaccination blood sample from donor 637295 stimulate 15 hours with 92TH023ENV,Blood sample from donor 637295,Homo Sapiens,8381645097_I_Grn.idat,637295,ok,Micro kit,92TH023ENV,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d639556_92TH023ENV,post-vaccination blood sample from donor 639556 stimulate 15 hours with 92TH023ENV,Blood sample from donor 639556,Homo Sapiens,8381645097_J_Grn.idat,639556,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d639556_DMSO,post-vaccination blood sample from donor 639556 stimulate 15 hours with DMSO,Blood sample from donor 639556,Homo Sapiens,8381661041_E_Grn.idat,639556,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d641088_92TH023ENV,post-vaccination blood sample from donor 641088 stimulate 15 hours with 92TH023ENV,Blood sample from donor 641088,Homo Sapiens,8381645069_B_Grn.idat,641088,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d641088_DMSO,post-vaccination blood sample from donor 641088 stimulate 15 hours with DMSO,Blood sample from donor 641088,Homo Sapiens,8381645047_D_Grn.idat,641088,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d641673_92TH023ENV,post-vaccination blood sample from donor 641673 stimulate 15 hours with 92TH023ENV,Blood sample from donor 641673,Homo Sapiens,8363877074_B_Grn.idat,641673,ok,Micro kit,92TH023ENV,15,hours,PLACEBO,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d641673_DMSO,post-vaccination blood sample from donor 641673 stimulate 15 hours with DMSO,Blood sample from donor 641673,Homo Sapiens,8381653016_I_Grn.idat,641673,ok,Micro kit,DMSO,15,hours,PLACEBO,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with DMSO,GPL10558 +RV144_d644521_DMSO,post-vaccination blood sample from donor 644521 stimulate 15 hours with DMSO,Blood sample from donor 644521,Homo Sapiens,8363877038_C_Grn.idat,644521,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d644521_92TH023ENV,post-vaccination blood sample from donor 644521 stimulate 15 hours with 92TH023ENV,Blood sample from donor 644521,Homo Sapiens,8381661071_G_Grn.idat,644521,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d645909_DMSO,post-vaccination blood sample from donor 645909 stimulate 15 hours with DMSO,Blood sample from donor 645909,Homo Sapiens,8381653002_I_Grn.idat,645909,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d645909_92TH023ENV,post-vaccination blood sample from donor 645909 stimulate 15 hours with 92TH023ENV,Blood sample from donor 645909,Homo Sapiens,8363877038_H_Grn.idat,645909,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d701472_92TH023ENV,post-vaccination blood sample from donor 701472 stimulate 15 hours with 92TH023ENV,Blood sample from donor 701472,Homo Sapiens,8381645069_K_Grn.idat,701472,ok,Micro kit,92TH023ENV,15,hours,PLACEBO,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d701472_DMSO,post-vaccination blood sample from donor 701472 stimulate 15 hours with DMSO,Blood sample from donor 701472,Homo Sapiens,8381661027_F_Grn.idat,701472,ok,Micro kit,DMSO,15,hours,PLACEBO,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with DMSO,GPL10558 +RV144_d703357_92TH023ENV,post-vaccination blood sample from donor 703357 stimulate 15 hours with 92TH023ENV,Blood sample from donor 703357,Homo Sapiens,8381645076_J_Grn.idat,703357,ok,Micro kit,92TH023ENV,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d703357_DMSO,post-vaccination blood sample from donor 703357 stimulate 15 hours with DMSO,Blood sample from donor 703357,Homo Sapiens,8381653011_E_Grn.idat,703357,ok,Micro kit,DMSO,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d704410_92TH023ENV,post-vaccination blood sample from donor 704410 stimulate 15 hours with 92TH023ENV,Blood sample from donor 704410,Homo Sapiens,8381653029_C_Grn.idat,704410,ok,Micro kit,92TH023ENV,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d704410_DMSO,post-vaccination blood sample from donor 704410 stimulate 15 hours with DMSO,Blood sample from donor 704410,Homo Sapiens,8381645049_I_Grn.idat,704410,ok,Micro kit,DMSO,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d704526_92TH023ENV,post-vaccination blood sample from donor 704526 stimulate 15 hours with 92TH023ENV,Blood sample from donor 704526,Homo Sapiens,8363877065_K_Grn.idat,704526,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d704526_DMSO,post-vaccination blood sample from donor 704526 stimulate 15 hours with DMSO,Blood sample from donor 704526,Homo Sapiens,8381653024_G_Grn.idat,704526,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d705306_92TH023ENV,post-vaccination blood sample from donor 705306 stimulate 15 hours with 92TH023ENV,Blood sample from donor 705306,Homo Sapiens,8363877086_K_Grn.idat,705306,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d705306_DMSO,post-vaccination blood sample from donor 705306 stimulate 15 hours with DMSO,Blood sample from donor 705306,Homo Sapiens,8381645005_F_Grn.idat,705306,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d707432_DMSO,post-vaccination blood sample from donor 707432 stimulate 15 hours with DMSO,Blood sample from donor 707432,Homo Sapiens,8363877102_E_Grn.idat,707432,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d707432_92TH023ENV,post-vaccination blood sample from donor 707432 stimulate 15 hours with 92TH023ENV,Blood sample from donor 707432,Homo Sapiens,8363877047_J_Grn.idat,707432,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d710339_92TH023ENV,post-vaccination blood sample from donor 710339 stimulate 15 hours with 92TH023ENV,Blood sample from donor 710339,Homo Sapiens,8363885006_K_Grn.idat,710339,ok,Micro kit,92TH023ENV,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d710339_DMSO,post-vaccination blood sample from donor 710339 stimulate 15 hours with DMSO,Blood sample from donor 710339,Homo Sapiens,8381653011_D_Grn.idat,710339,ok,Micro kit,DMSO,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d713113_92TH023ENV,post-vaccination blood sample from donor 713113 stimulate 15 hours with 92TH023ENV,Blood sample from donor 713113,Homo Sapiens,8363877093_G_Grn.idat,713113,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d713113_DMSO,post-vaccination blood sample from donor 713113 stimulate 15 hours with DMSO,Blood sample from donor 713113,Homo Sapiens,8381661021_I_Grn.idat,713113,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d716238_92TH023ENV,post-vaccination blood sample from donor 716238 stimulate 15 hours with 92TH023ENV,Blood sample from donor 716238,Homo Sapiens,8363885006_H_Grn.idat,716238,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d716238_DMSO,post-vaccination blood sample from donor 716238 stimulate 15 hours with DMSO,Blood sample from donor 716238,Homo Sapiens,8363877102_C_Grn.idat,716238,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d718988_DMSO,post-vaccination blood sample from donor 718988 stimulate 15 hours with DMSO,Blood sample from donor 718988,Homo Sapiens,8381645082_K_Grn.idat,718988,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d718988_92TH023ENV,post-vaccination blood sample from donor 718988 stimulate 15 hours with 92TH023ENV,Blood sample from donor 718988,Homo Sapiens,8381645097_G_Grn.idat,718988,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d719498_DMSO,post-vaccination blood sample from donor 719498 stimulate 15 hours with DMSO,Blood sample from donor 719498,Homo Sapiens,8381645082_G_Grn.idat,719498,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d719498_92TH023ENV,post-vaccination blood sample from donor 719498 stimulate 15 hours with 92TH023ENV,Blood sample from donor 719498,Homo Sapiens,8363885073_H_Grn.idat,719498,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d720317_92TH023ENV,post-vaccination blood sample from donor 720317 stimulate 15 hours with 92TH023ENV,Blood sample from donor 720317,Homo Sapiens,8381653029_F_Grn.idat,720317,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d720317_DMSO,post-vaccination blood sample from donor 720317 stimulate 15 hours with DMSO,Blood sample from donor 720317,Homo Sapiens,8381645097_E_Grn.idat,720317,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d723863_DMSO,post-vaccination blood sample from donor 723863 stimulate 15 hours with DMSO,Blood sample from donor 723863,Homo Sapiens,8381645082_B_Grn.idat,723863,ok,Micro kit,DMSO,15,hours,PLACEBO,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with DMSO,GPL10558 +RV144_d723863_92TH023ENV,post-vaccination blood sample from donor 723863 stimulate 15 hours with 92TH023ENV,Blood sample from donor 723863,Homo Sapiens,8381645070_D_Grn.idat,723863,ok,Rneasy plus Mini kit,92TH023ENV,15,hours,PLACEBO,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d725838_DMSO,post-vaccination blood sample from donor 725838 stimulate 15 hours with DMSO,Blood sample from donor 725838,Homo Sapiens,8381653013_K_Grn.idat,725838,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d725838_92TH023ENV,post-vaccination blood sample from donor 725838 stimulate 15 hours with 92TH023ENV,Blood sample from donor 725838,Homo Sapiens,8381661071_L_Grn.idat,725838,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d725896_DMSO,post-vaccination blood sample from donor 725896 stimulate 15 hours with DMSO,Blood sample from donor 725896,Homo Sapiens,8381653037_D_Grn.idat,725896,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d725896_92TH023ENV,post-vaccination blood sample from donor 725896 stimulate 15 hours with 92TH023ENV,Blood sample from donor 725896,Homo Sapiens,8363885073_C_Grn.idat,725896,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d726168_DMSO,post-vaccination blood sample from donor 726168 stimulate 15 hours with DMSO,Blood sample from donor 726168,Homo Sapiens,8381645005_G_Grn.idat,726168,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d726168_92TH023ENV,post-vaccination blood sample from donor 726168 stimulate 15 hours with 92TH023ENV,Blood sample from donor 726168,Homo Sapiens,8381653015_L_Grn.idat,726168,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d726599_92TH023ENV,post-vaccination blood sample from donor 726599 stimulate 15 hours with 92TH023ENV,Blood sample from donor 726599,Homo Sapiens,8363885006_F_Grn.idat,726599,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d726599_DMSO,post-vaccination blood sample from donor 726599 stimulate 15 hours with DMSO,Blood sample from donor 726599,Homo Sapiens,8381645005_I_Grn.idat,726599,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d729489_92TH023ENV,post-vaccination blood sample from donor 729489 stimulate 15 hours with 92TH023ENV,Blood sample from donor 729489,Homo Sapiens,8363885094_F_Grn.idat,729489,ok,Micro kit,92TH023ENV,15,hours,PLACEBO,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d729489_DMSO,post-vaccination blood sample from donor 729489 stimulate 15 hours with DMSO,Blood sample from donor 729489,Homo Sapiens,8381653029_D_Grn.idat,729489,ok,Micro kit,DMSO,15,hours,PLACEBO,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with DMSO,GPL10558 +RV144_d733526_92TH023ENV,post-vaccination blood sample from donor 733526 stimulate 15 hours with 92TH023ENV,Blood sample from donor 733526,Homo Sapiens,8363877038_D_Grn.idat,733526,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d733526_DMSO,post-vaccination blood sample from donor 733526 stimulate 15 hours with DMSO,Blood sample from donor 733526,Homo Sapiens,8381653037_G_Grn.idat,733526,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d736104_92TH023ENV,post-vaccination blood sample from donor 736104 stimulate 15 hours with 92TH023ENV,Blood sample from donor 736104,Homo Sapiens,8381653015_E_Grn.idat,736104,ok,Rneasy plus Mini kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d736104_DMSO,post-vaccination blood sample from donor 736104 stimulate 15 hours with DMSO,Blood sample from donor 736104,Homo Sapiens,8381661022_D_Grn.idat,736104,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d737450_DMSO,post-vaccination blood sample from donor 737450 stimulate 15 hours with DMSO,Blood sample from donor 737450,Homo Sapiens,8324350075_K_Grn.idat,737450,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d737450_92TH023ENV,post-vaccination blood sample from donor 737450 stimulate 15 hours with 92TH023ENV,Blood sample from donor 737450,Homo Sapiens,8381653024_L_Grn.idat,737450,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d800976_DMSO,post-vaccination blood sample from donor 800976 stimulate 15 hours with DMSO,Blood sample from donor 800976,Homo Sapiens,8381661022_K_Grn.idat,800976,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d800976_92TH023ENV,post-vaccination blood sample from donor 800976 stimulate 15 hours with 92TH023ENV,Blood sample from donor 800976,Homo Sapiens,8381653013_I_Grn.idat,800976,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d803985_DMSO,post-vaccination blood sample from donor 803985 stimulate 15 hours with DMSO,Blood sample from donor 803985,Homo Sapiens,8363885073_E_Grn.idat,803985,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d803985_92TH023ENV,post-vaccination blood sample from donor 803985 stimulate 15 hours with 92TH023ENV,Blood sample from donor 803985,Homo Sapiens,8363877102_D_Grn.idat,803985,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d804495_92TH023ENV,post-vaccination blood sample from donor 804495 stimulate 15 hours with 92TH023ENV,Blood sample from donor 804495,Homo Sapiens,8381653016_K_Grn.idat,804495,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d804495_DMSO,post-vaccination blood sample from donor 804495 stimulate 15 hours with DMSO,Blood sample from donor 804495,Homo Sapiens,8381661021_H_Grn.idat,804495,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d808390_92TH023ENV,post-vaccination blood sample from donor 808390 stimulate 15 hours with 92TH023ENV,Blood sample from donor 808390,Homo Sapiens,8381645049_E_Grn.idat,808390,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d808390_DMSO,post-vaccination blood sample from donor 808390 stimulate 15 hours with DMSO,Blood sample from donor 808390,Homo Sapiens,8381653015_F_Grn.idat,808390,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d809408_92TH023ENV,post-vaccination blood sample from donor 809408 stimulate 15 hours with 92TH023ENV,Blood sample from donor 809408,Homo Sapiens,8363877096_A_Grn.idat,809408,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d809408_DMSO,post-vaccination blood sample from donor 809408 stimulate 15 hours with DMSO,Blood sample from donor 809408,Homo Sapiens,8381645097_D_Grn.idat,809408,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d809604_DMSO,post-vaccination blood sample from donor 809604 stimulate 15 hours with DMSO,Blood sample from donor 809604,Homo Sapiens,8324350075_B_Grn.idat,809604,ok,Micro kit,DMSO,15,hours,PLACEBO,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with DMSO,GPL10558 +RV144_d809604_92TH023ENV,post-vaccination blood sample from donor 809604 stimulate 15 hours with 92TH023ENV,Blood sample from donor 809604,Homo Sapiens,8363885025_C_Grn.idat,809604,ok,Micro kit,92TH023ENV,15,hours,PLACEBO,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d811303_92TH023ENV,post-vaccination blood sample from donor 811303 stimulate 15 hours with 92TH023ENV,Blood sample from donor 811303,Homo Sapiens,8363877065_D_Grn.idat,811303,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d811303_DMSO,post-vaccination blood sample from donor 811303 stimulate 15 hours with DMSO,Blood sample from donor 811303,Homo Sapiens,8381653011_I_Grn.idat,811303,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d816004_DMSO,post-vaccination blood sample from donor 816004 stimulate 15 hours with DMSO,Blood sample from donor 816004,Homo Sapiens,8363877086_G_Grn.idat,816004,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d816004_92TH023ENV,post-vaccination blood sample from donor 816004 stimulate 15 hours with 92TH023ENV,Blood sample from donor 816004,Homo Sapiens,8381653016_G_Grn.idat,816004,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d816763_92TH023ENV,post-vaccination blood sample from donor 816763 stimulate 15 hours with 92TH023ENV,Blood sample from donor 816763,Homo Sapiens,8363885073_B_Grn.idat,816763,ok,Micro kit,92TH023ENV,15,hours,PLACEBO,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d816763_DMSO,post-vaccination blood sample from donor 816763 stimulate 15 hours with DMSO,Blood sample from donor 816763,Homo Sapiens,8324350075_E_Grn.idat,816763,ok,Micro kit,DMSO,15,hours,PLACEBO,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with DMSO,GPL10558 +RV144_d822158_DMSO,post-vaccination blood sample from donor 822158 stimulate 15 hours with DMSO,Blood sample from donor 822158,Homo Sapiens,8381653024_J_Grn.idat,822158,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d822158_92TH023ENV,post-vaccination blood sample from donor 822158 stimulate 15 hours with 92TH023ENV,Blood sample from donor 822158,Homo Sapiens,8363877065_J_Grn.idat,822158,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d823668_DMSO,post-vaccination blood sample from donor 823668 stimulate 15 hours with DMSO,Blood sample from donor 823668,Homo Sapiens,8381653029_B_Grn.idat,823668,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d823668_92TH023ENV,post-vaccination blood sample from donor 823668 stimulate 15 hours with 92TH023ENV,Blood sample from donor 823668,Homo Sapiens,8381653037_J_Grn.idat,823668,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d824374_DMSO,post-vaccination blood sample from donor 824374 stimulate 15 hours with DMSO,Blood sample from donor 824374,Homo Sapiens,8381645082_L_Grn.idat,824374,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d824374_92TH023ENV,post-vaccination blood sample from donor 824374 stimulate 15 hours with 92TH023ENV,Blood sample from donor 824374,Homo Sapiens,8381645047_F_Grn.idat,824374,ok,Rneasy plus Mini kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d825482_DMSO,post-vaccination blood sample from donor 825482 stimulate 15 hours with DMSO,Blood sample from donor 825482,Homo Sapiens,8381645076_E_Grn.idat,825482,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d825482_92TH023ENV,post-vaccination blood sample from donor 825482 stimulate 15 hours with 92TH023ENV,Blood sample from donor 825482,Homo Sapiens,8381645047_C_Grn.idat,825482,ok,Rneasy plus Mini kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d825617_92TH023ENV,post-vaccination blood sample from donor 825617 stimulate 15 hours with 92TH023ENV,Blood sample from donor 825617,Homo Sapiens,8363885073_K_Grn.idat,825617,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d825617_DMSO,post-vaccination blood sample from donor 825617 stimulate 15 hours with DMSO,Blood sample from donor 825617,Homo Sapiens,8381653002_J_Grn.idat,825617,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d826468_92TH023ENV,post-vaccination blood sample from donor 826468 stimulate 15 hours with 92TH023ENV,Blood sample from donor 826468,Homo Sapiens,8381645069_G_Grn.idat,826468,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d826468_DMSO,post-vaccination blood sample from donor 826468 stimulate 15 hours with DMSO,Blood sample from donor 826468,Homo Sapiens,8381661041_K_Grn.idat,826468,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d827158_92TH023ENV,post-vaccination blood sample from donor 827158 stimulate 15 hours with 92TH023ENV,Blood sample from donor 827158,Homo Sapiens,8381653011_F_Grn.idat,827158,ok,Rneasy plus Mini kit,92TH023ENV,15,hours,PLACEBO,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d827158_DMSO,post-vaccination blood sample from donor 827158 stimulate 15 hours with DMSO,Blood sample from donor 827158,Homo Sapiens,8381661022_F_Grn.idat,827158,ok,Micro kit,DMSO,15,hours,PLACEBO,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with DMSO,GPL10558 +RV144_d827743_DMSO,post-vaccination blood sample from donor 827743 stimulate 15 hours with DMSO,Blood sample from donor 827743,Homo Sapiens,8324350075_C_Grn.idat,827743,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d827743_92TH023ENV,post-vaccination blood sample from donor 827743 stimulate 15 hours with 92TH023ENV,Blood sample from donor 827743,Homo Sapiens,8363877038_G_Grn.idat,827743,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d835280_DMSO,post-vaccination blood sample from donor 835280 stimulate 15 hours with DMSO,Blood sample from donor 835280,Homo Sapiens,8381653013_C_Grn.idat,835280,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d835280_92TH023ENV,post-vaccination blood sample from donor 835280 stimulate 15 hours with 92TH023ENV,Blood sample from donor 835280,Homo Sapiens,8363877074_L_Grn.idat,835280,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d839288_92TH023ENV,post-vaccination blood sample from donor 839288 stimulate 15 hours with 92TH023ENV,Blood sample from donor 839288,Homo Sapiens,8381645005_H_Grn.idat,839288,ok,Micro kit,92TH023ENV,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d839288_DMSO,post-vaccination blood sample from donor 839288 stimulate 15 hours with DMSO,Blood sample from donor 839288,Homo Sapiens,8381653024_I_Grn.idat,839288,ok,Micro kit,DMSO,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d841530_92TH023ENV,post-vaccination blood sample from donor 841530 stimulate 15 hours with 92TH023ENV,Blood sample from donor 841530,Homo Sapiens,8381661041_L_Grn.idat,841530,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d841530_DMSO,post-vaccination blood sample from donor 841530 stimulate 15 hours with DMSO,Blood sample from donor 841530,Homo Sapiens,8381653015_I_Grn.idat,841530,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d842921_92TH023ENV,post-vaccination blood sample from donor 842921 stimulate 15 hours with 92TH023ENV,Blood sample from donor 842921,Homo Sapiens,8381645091_G_Grn.idat,842921,ok,Micro kit,92TH023ENV,15,hours,PLACEBO,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d842921_DMSO,post-vaccination blood sample from donor 842921 stimulate 15 hours with DMSO,Blood sample from donor 842921,Homo Sapiens,8381653015_B_Grn.idat,842921,ok,Micro kit,DMSO,15,hours,PLACEBO,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 placebo and stimulated 15 hours with DMSO,GPL10558 +RV144_d843994_92TH023ENV,post-vaccination blood sample from donor 843994 stimulate 15 hours with 92TH023ENV,Blood sample from donor 843994,Homo Sapiens,8363885073_J_Grn.idat,843994,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d843994_DMSO,post-vaccination blood sample from donor 843994 stimulate 15 hours with DMSO,Blood sample from donor 843994,Homo Sapiens,8381645076_K_Grn.idat,843994,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d844343_92TH023ENV,post-vaccination blood sample from donor 844343 stimulate 15 hours with 92TH023ENV,Blood sample from donor 844343,Homo Sapiens,8381661071_J_Grn.idat,844343,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d844343_DMSO,post-vaccination blood sample from donor 844343 stimulate 15 hours with DMSO,Blood sample from donor 844343,Homo Sapiens,8381645069_L_Grn.idat,844343,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d844459_DMSO,post-vaccination blood sample from donor 844459 stimulate 15 hours with DMSO,Blood sample from donor 844459,Homo Sapiens,8381645069_C_Grn.idat,844459,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d844459_92TH023ENV,post-vaccination blood sample from donor 844459 stimulate 15 hours with 92TH023ENV,Blood sample from donor 844459,Homo Sapiens,8363877074_H_Grn.idat,844459,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d845316_DMSO,post-vaccination blood sample from donor 845316 stimulate 15 hours with DMSO,Blood sample from donor 845316,Homo Sapiens,8363877102_G_Grn.idat,845316,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d845316_92TH023ENV,post-vaccination blood sample from donor 845316 stimulate 15 hours with 92TH023ENV,Blood sample from donor 845316,Homo Sapiens,8363877093_K_Grn.idat,845316,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d849475_DMSO,post-vaccination blood sample from donor 849475 stimulate 15 hours with DMSO,Blood sample from donor 849475,Homo Sapiens,8363877047_B_Grn.idat,849475,ok,Micro kit,DMSO,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d849475_92TH023ENV,post-vaccination blood sample from donor 849475 stimulate 15 hours with 92TH023ENV,Blood sample from donor 849475,Homo Sapiens,8381653029_I_Grn.idat,849475,ok,Micro kit,92TH023ENV,15,hours,VACCINE,Yes,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d849655_DMSO,post-vaccination blood sample from donor 849655 stimulate 15 hours with DMSO,Blood sample from donor 849655,Homo Sapiens,8381661021_L_Grn.idat,849655,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d849655_92TH023ENV,post-vaccination blood sample from donor 849655 stimulate 15 hours with 92TH023ENV,Blood sample from donor 849655,Homo Sapiens,8381645047_H_Grn.idat,849655,ok,Rneasy plus Mini kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d851396_DMSO,post-vaccination blood sample from donor 851396 stimulate 15 hours with DMSO,Blood sample from donor 851396,Homo Sapiens,8363877087_K_Grn.idat,851396,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d851396_92TH023ENV,post-vaccination blood sample from donor 851396 stimulate 15 hours with 92TH023ENV,Blood sample from donor 851396,Homo Sapiens,8363877096_E_Grn.idat,851396,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_d852086_DMSO,post-vaccination blood sample from donor 852086 stimulate 15 hours with DMSO,Blood sample from donor 852086,Homo Sapiens,8381653024_D_Grn.idat,852086,ok,Micro kit,DMSO,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with DMSO,GPL10558 +RV144_d852086_92TH023ENV,post-vaccination blood sample from donor 852086 stimulate 15 hours with 92TH023ENV,Blood sample from donor 852086,Homo Sapiens,8381661027_C_Grn.idat,852086,ok,Micro kit,92TH023ENV,15,hours,VACCINE,No,total RNA,biotin,transcriptional profilling of blood taken 2 weeks after vaccination with the RV144 vaccine and stimulated 15 hours with 92TH023ENV,GPL10558 +RV144_control,hybridization control,Control sample,Homo Sapiens,8324350075_A_Grn.idat,NA,ok,NA,NA,,,NA,NA,total RNA,biotin,hybridization control,GPL10558 +RV144_control_rep1,hybridization control,Control sample,Homo Sapiens,8363885006_A_Grn.idat,NA,ok,NA,NA,,,NA,NA,total RNA,biotin,hybridization control,GPL10558 +RV144_control_rep2,hybridization control,Control sample,Homo Sapiens,8381645070_A_Grn.idat,NA,ok,NA,NA,,,NA,NA,total RNA,biotin,hybridization control,GPL10558 +RV144_control_rep3,hybridization control,Control sample,Homo Sapiens,8381661022_A_Grn.idat,NA,ok,NA,NA,,,NA,NA,total RNA,biotin,hybridization control,GPL10558 +RV144_control_rep4,hybridization control,Control sample,Homo Sapiens,8381661021_A_Grn.idat,NA,ok,NA,NA,,,NA,NA,total RNA,biotin,hybridization control,GPL10558 +RV144_control_rep5,hybridization control,Control sample,Homo Sapiens,8381661002_A_Grn.idat,NA,ok,NA,NA,,,NA,NA,total RNA,biotin,hybridization control,GPL10558 +RV144_control_rep6,hybridization control,Control sample,Homo Sapiens,8363885073_A_Grn.idat,NA,ok,NA,NA,,,NA,NA,total RNA,biotin,hybridization control,GPL10558 +RV144_control_rep7,hybridization control,Control sample,Homo Sapiens,8381645005_A_Grn.idat,NA,ok,NA,NA,,,NA,NA,total RNA,biotin,hybridization control,GPL10558 +RV144_control_rep8,hybridization control,Control sample,Homo Sapiens,8363877074_A_Grn.idat,NA,ok,NA,NA,,,NA,NA,total RNA,biotin,hybridization control,GPL10558 +RV144_control_rep9,hybridization control,Control sample,Homo Sapiens,8381653029_A_Grn.idat,NA,ok,NA,NA,,,NA,NA,total RNA,biotin,hybridization control,GPL10558 +RV144_control_rep10,hybridization control,Control sample,Homo Sapiens,8381645082_A_Grn.idat,NA,ok,NA,NA,,,NA,NA,total RNA,biotin,hybridization control,GPL10558 +RV144_control_rep11,hybridization control,Control sample,Homo Sapiens,8363877102_A_Grn.idat,NA,ok,NA,NA,,,NA,NA,total RNA,biotin,hybridization control,GPL10558 +RV144_control_rep12,hybridization control,Control sample,Homo Sapiens,8363877038_A_Grn.idat,NA,ok,NA,NA,,,NA,NA,total RNA,biotin,hybridization control,GPL10558 +RV144_control_rep13,hybridization control,Control sample,Homo Sapiens,8381653015_A_Grn.idat,NA,ok,NA,NA,,,NA,NA,total RNA,biotin,hybridization control,GPL10558 +RV144_control_rep14,hybridization control,Control sample,Homo Sapiens,8381653002_A_Grn.idat,NA,ok,NA,NA,,,NA,NA,total RNA,biotin,hybridization control,GPL10558 diff --git a/output/rv144.eset.RData b/output/rv144.eset.RData new file mode 100644 index 0000000..1531521 --- /dev/null +++ b/output/rv144.eset.RData @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:a0092b983dd98c98986cbd0189482bbe368722819c4fcce9d7428f883ad533a5 +size 47436900 diff --git a/output/rv144.esetBaselined.RData b/output/rv144.esetBaselined.RData new file mode 100644 index 0000000..a7f991c --- /dev/null +++ b/output/rv144.esetBaselined.RData @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:7ad0656dc6f02d9c2999564952eb7c0b2459ef564aad15083dc135908add363d +size 44576236 diff --git a/output/rv144.esetRaw.RData b/output/rv144.esetRaw.RData new file mode 100644 index 0000000..b770248 --- /dev/null +++ b/output/rv144.esetRaw.RData @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:6a7459254b0931b4cfd40875df13a31e22f63b6f896085c5c6bba520a516b86a +size 33232225 diff --git a/output/rv144.fits.RData b/output/rv144.fits.RData new file mode 100644 index 0000000..ea41b6b --- /dev/null +++ b/output/rv144.fits.RData @@ -0,0 +1,3 @@ +version https://git-lfs.github.com/spec/v1 +oid sha256:fc46f40b7f7dfa6e0d80b3092680156c5867cde89d8e81854c6c4bc5ccb46d7e +size 22164467