diff --git a/DESCRIPTION b/DESCRIPTION new file mode 100644 index 0000000..cc3e187 --- /dev/null +++ b/DESCRIPTION @@ -0,0 +1,12 @@ +Package: bimir +Type: Package +Title: Condition-Specific microRNA Target Prediction by Biclustering of Large Transcriptome Data +Version: 1.0 +Author: Sora Yoon +Maintainer: Sora Yoon +Description: Generates biclusters provided in BIMIR website , which is a bicluster database that provides the condition-specific microRNA target predictions. Because miRNAs repress the gene expression post-transcriptionally, mRNA-miRNA paired profilings have been commonly used to predict the condition-specific miRNA targets. However, it is costly, and hence, there are not many publicly available mRNA-miRNA paired profilings for various cell conditions. In this study, we solved these problems by utilizing a large collection of public mRNA microarray data. Using the data, we created a matrix of fold change (FC) values for 20,639 human genes in 5,158 cell conditions (test vs. control group). By biclustering this matrix, we derived 29,815 biclusters for 451 microRNAs. To create these biclusters, first we extracted the initial seed biclusters full of signals (e.g., FC>1.3), and progressively extended them using PBE algorithm including a small number of noises. This process resulted in large and quite dense biclusters compared to those generated by other existing methods. +License: GPL-2 +Encoding: UTF-8 +LazyData: true +RoxygenNote: 6.0.1 +Depends: biclust diff --git a/NAMESPACE b/NAMESPACE new file mode 100644 index 0000000..c49a8ad --- /dev/null +++ b/NAMESPACE @@ -0,0 +1,17 @@ +# Generated by roxygen2: do not edit by hand + +export(PBE) +export(PBE_MERGE) +export(bicluster_extension_process) +export(bicluster_trimming_process) +export(getGenelist) +export(getMIRprofile) +export(get_miR_target) +export(get_zero_rate) +export(getmiRNAlist) +export(load_FCtable) +export(make_biclust) +export(merge_bicluster) +import(biclust) +import(stats) +import(utils) diff --git a/R/MIRprofile_from_FCtable.R b/R/MIRprofile_from_FCtable.R new file mode 100644 index 0000000..fd5a46e --- /dev/null +++ b/R/MIRprofile_from_FCtable.R @@ -0,0 +1,123 @@ +#'@title load_FCtable +#' +#'@description Loading a large table of fold change values for 20,639 human genes in 5,158 cell conditions. +#'@return A fold change matrix of 5,158 rows and 20,639 columns. +#'@export +load_FCtable = function() +{ + cat('FC matrix is now loading ...\n') + f = system.file('extdata', 'FC1.rds', package = 'bimir') + fc = readRDS(f) + cat("1/10\n") + for(i in 2:10) + { + f = system.file('extdata', paste('FC',i,'.rds',sep=""), package = 'bimir') + fc_temp = readRDS(f) + fc = cbind(fc,fc_temp) + cat(i,"/10\n",sep="") + } + cat('Loaded!\n') + return(fc) +} + +#'@title Load human gene list +#'@description 20,639 human genes +#'@return A vector of 20,639 human genes +#'@export +#'@import utils +getGenelist = function() +{ + f = system.file('extdata','genelist.rds', package='bimir') + genelist = readRDS(f) + genelist = gsub('-','.',genelist,fixed = T) + return(genelist) +} + +#'@title Load human miRNA list +#'@description human mature miRNA list +#'@return A vector of 2,632 human mature miRNAs +#'@export +#'@import utils +getmiRNAlist = function() +{ + f = system.file('extdata', 'miRNAlist.rds', package='bimir') + miRNAlist = readRDS(f) + return(miRNAlist) +} + +#'@title Load human miRNA target index +#'@description human miRNA target index +#'@return A vector of human miRNA target index +#'@import utils +getAllmiRNATargetIndex = function() +{ + f = system.file('extdata', 'miRNATargets.rds', package='bimir') + index = readRDS(f) + return(index) +} + +#'Get sequence-based miRNA targets +#' +#'@description Returns miRNA targets predicted from three or more algorithms. +#' +#'@param miRNA miRNA name. One of miRNAs listed in "miRNAlist" data. +#'@return A vector of sequence-based miRNA targets +#'@examples get_miR_target('hsa-miR-1-3p') +#'@export +get_miR_target = function(miRNA) +{ + genelist = getGenelist() + miRNAlist = getmiRNAlist() + miRNATargets = getAllmiRNATargetIndex() + mir_index = which(miRNAlist%in%miRNA) + if(length(mir_index)==0){stop(paste(miRNA,'is not in the miRNAlist. Type getmiRNAlist() to refer to the available miRNAs'))} + index_target = miRNATargets[mir_index] + index_target = unlist(strsplit(index_target,split="\t")) + index_target = as.numeric(index_target) + index_target = unique(index_target) + targets = genelist[index_target] + return(targets) +} + +#'Get MIRprofile +#' +#'@description Returns MIR profile for input miRNA. +#' +#'@param miRNA miRNA name. One of miRNAs listed in "miRNAlist" data. +#'@param FCtable FC matrix of 20,639 genes for 5,158 conditions. If NULL, it will be loaded from the local. +#'@param FCcutoff Fold change cutoff in log2 scale. Default = log2(1.3). To extract MIR profile for target down-regulation in test condition, take negative value. +#'@return A matrix of fold change value of sequence-based miRNA targets under selected cell conditions. +#'@examples fc=load_FCtable(); MIRprofile = getMIRprofile('hsa-miR-1-3p',fc,log2(1.3)) +#'@import stats utils +#'@export +getMIRprofile = function(miRNA, FCtable=NULL, FCcutoff=log2(1.3)) +{ + if(is.null(miRNA)){stop('human miRNA name must be given. Refer to the list of miRNAs from "miRNAlist" data in the package.')} + if(is.null(FCtable)){ FCtable = load_FCtable() } + if(FCcutoff==0){stop('FCcutoff must be larger or lesser than 0.')} + miRNAlist = getmiRNAlist() + genelist = getGenelist() + mir_index = which(miRNAlist%in%miRNA) + if(length(mir_index)==0){stop('There is no such microRNA in the DB. Refer to the list of miRNAs by typing getmiRNAlist().')} + ConditionOverlapP = function(X, seqTar, FCcut) + { + seqTar = intersect(genelist, seqTar) + geneidx = if(FCcutoff>0){which(X>FCcut)}else{which(X= 2){ + n=n1 + modified_zero_rate = function(target){return((length(target[target == 0])+ceiling(n))/length(target))} + row_zero = apply(X=MIR_profile[-biclust_row, biclust_col], 1, modified_zero_rate) + col_zero = apply(X=MIR_profile[biclust_row, -biclust_col], 2, get_zero_rate) + } + if(n2 >= 2){ + n=n2 + modified_zero_rate = function(target){return((length(target[target == 0])+ceiling(n))/length(target))} + row_zero = apply(X = MIR_profile[-biclust_row, biclust_col], 1, get_zero_rate) + col_zero = apply(X = MIR_profile[biclust_row, -biclust_col], 2, modified_zero_rate) + } + if(n1 < 2 & n2 < 2){ + row_zero = apply(X = MIR_profile[-biclust_row, biclust_col], 1, get_zero_rate) + col_zero = apply(X = MIR_profile[biclust_row, -biclust_col], 2, get_zero_rate) + } + + min_row = min(row_zero) + min_col = min(col_zero) + + l1 = length(which(row_zero == min_row)) + l2 = length(which(col_zero == min_col)) + + if(min_row < min_col | (min_row == min_col & l1 >= l2)) + { + change = which(row_zero == min_row) + tt = MIR_profile[-biclust_row,biclust_col][change,] + if(is.null(dim(tt))) + { + biclust_row = c(biclust_row,as.integer(change)) + UPDATED = rbind(SEED,tt) + rownames(UPDATED)[dim(UPDATED)[1]] = names(change) + } + else + { + UPDATED=rbind(SEED,tt) + biclust_row = sort(c(biclust_row,as.integer(change))) + } + + if(get_zero_rate(UPDATED) min_col | (min_row == min_col & l1 < l2)) + { + change = which(col_zero == min_col) + tt = MIR_profile[biclust_row,-biclust_col][,change] + if(is.null(dim(tt))) + { + biclust_col = c(biclust_col,as.integer(change)) + UPDATED=cbind(SEED,tt) + colnames(UPDATED)[dim(UPDATED)[2]] = names(change) + } + else + { + UPDATED = cbind(SEED,tt) + biclust_col = sort(c(biclust_col,as.integer(change))) + } + + if(get_zero_rate(UPDATED) zero_ratio || max_col_zero_rate > zero_ratio ) + { + if( max_row_zero_rate >= max_col_zero_rate ) + { + delete_target = which(zero_rate_rows == max_row_zero_rate , arr.ind = T) + table=table[-delete_target,] + } + + else + { + delete_target = which(zero_rate_cols == max_col_zero_rate , arr.ind = T) + table=table[,-delete_target] + } + zero_rate_rows = apply(table,1,get_zero_rate); max_row_zero_rate = max(zero_rate_rows) + zero_rate_cols = apply(table,2,get_zero_rate); max_col_zero_rate = max(zero_rate_cols) + } + return(table) +} + +#'Progressive bicluster extension +#' +#' @param MIR_profile Binarized microRNA profile +#' @param biclust_row List of index of row in seed biclust +#' @param biclust_col List of index of columns in seed biclust +#' @param step_number The number of extension process +#' @param finalZR final zero rate allowed. +#' @return list of row and column symbols of extended bicluster +#' @export +PBE = function( MIR_profile, biclust_row, biclust_col, step_number, finalZR) +{ + nth_step = 1:step_number + intZRs = finalZR * nth_step / step_number + size_back = -1 + for ( intZR in intZRs ) + { + extended_seed = bicluster_extension_process(MIR_profile, biclust_row, biclust_col, intZR) + reducted_seed = bicluster_trimming_process(extended_seed, intZR) + + if(size_back > size(reducted_seed)){break} + else{size_back = size(reducted_seed)} + biclust_row = match( rownames( reducted_seed ), rownames( MIR_profile ) ) + biclust_col = match( colnames( reducted_seed ), colnames( MIR_profile ) ) + } + return( list(rows = rownames( reducted_seed ),cols = colnames( reducted_seed ))) +} + +#' Make all biclusters +#' +#' @param MIR_PROFILE A matrix of MIR profile. +#' @param FCcutoff Binarization fold change cutoff in log2-scale for MIR_PROFILE. Target up-regulation biclusters will be created for positive FC cutoff, and down-regulation biclusters will be generated with negative FC cutoff. +#' @param REPETITION The number of running ensemble bicluster function. +#' @param STEP_NUMBER The number of extension process +#' @param ZERORATE Final zero rate allowed. +#' @import biclust +#' @return list of seed and biclusters +#' @export +make_biclust = function(MIR_PROFILE, FCcutoff, REPETITION, STEP_NUMBER, ZERORATE) +{ + if(FCcutoff==0){stop('FCcutoff must be larger or lesser than zero.')} + if(FCcutoff>0){PROFILE_POS = TRUE; PROFILE_NEG=FALSE} + if(FCcutoff<0){PROFILE_NEG = TRUE; PROFILE_POS=FALSE} + ### set tab to make biclust + biclusts = list() + seedlist = list() + ##### DO ##### option set negative / positive + for(i in 1:REPETITION) + { + print(proc.time()) + if(PROFILE_NEG) + { + t=MIR_PROFILE + t=data.matrix(t) + t[is.na(t)] = 0 + + #Binarize the MIR profile + profile = t + index0 = which(t > FCcutoff) + index1 = which(t <= FCcutoff) + profile[index0] = 0 + profile[index1] = 1 + profile.seed = profile + + # Generation of seed biclusters using ensemble BIMAX algorithm + rn = runif(n = 1, min = 1, max = 1E8) + set.seed(rn) + ensembled = try(ensemble(profile.seed, bimax.grid(), bootstrap = FALSE),silent = T) + if(class(ensembled) == "try-error") {print("sorry. A seed cannot be found from the profile") + }else + { + for(iterator in 1:ensembled@Number) + { + seed = biclusternumber(ensembled, iterator) + biclust_row = seed[[1]]$Rows + biclust_col = seed[[1]]$Cols + + try({biclust_step = PBE(profile, biclust_row, biclust_col,STEP_NUMBER,ZERORATE); + seedlist[[length(seedlist)+1]] = list(rows = biclust_row, cols = biclust_col) + biclusts = append(biclusts,list(biclust_step)) + } ) + } + } + } + if(PROFILE_POS) + { + t=MIR_PROFILE + t=data.matrix(t) + t[is.na(t)] = 0 + + # Binarize the MIR profile + profile = t + index0 = which(t < FCcutoff) + index1 = which(t >= FCcutoff) + profile[index0] = 0 + profile[index1] = 1 + profile.seed = profile + + # Generation of the seed biclusters + rn = runif(n = 1, min = 1, max = 1E8) + set.seed(rn) + ensembled = try(ensemble(profile.seed,bimax.grid(), bootstrap = FALSE),silent = T) + if(class(ensembled) == "try-error") {print("sorry. A seed cannot be found from the profile") + }else + { + for(iterator in 1:ensembled@Number) + { + seed = biclusternumber(ensembled, iterator) + biclust_row = seed[[1]]$Rows + biclust_col = seed[[1]]$Cols + seed = profile[biclust_row,biclust_col] + + try({biclust_step = PBE(profile, biclust_row, biclust_col,STEP_NUMBER,ZERORATE); + seedlist[[length(seedlist)+1]] = list(rows=biclust_row, cols = biclust_col) + biclusts = append(biclusts,list(biclust_step)) + }) + } + } + } + } + return(list(biclusts = biclusts,seedlist = seedlist)) +} + +#' Calculate similarity of two biclusters +#' +#' @param biclust1 First bicluster matrix +#' @param biclust2 Second bicluster matrix +#' @return Similarity of two biclusters +similarity = function(biclust1,biclust2) # Pairwise distance of two biclusters +{ + introw = intersect(rownames(biclust1),rownames(biclust2)) + intcol = intersect(colnames(biclust1),colnames(biclust2)) + nr = length(introw) + nc = length(intcol) + minsize = min(size(biclust1), size(biclust2)) + if(!(length(introw)*length(intcol))) {return(1)} + return(1- (nr*nc / minsize )) +} + +#' Pariwise distance matrix for the entire list of biclusters +#' +#' @param biclusts Lists of biclusters. +#' @param MIR_profile binarized microRNA profile +#' @return pariwise distance matrix +comatrix = function(biclusts, MIR_profile) # Pairwise distance matrix for the entire list of biclusters +{ + profile = MIR_profile + cotab = matrix(0,length(biclusts),length(biclusts)) + + for(i in 1:length(biclusts)) + { + bicluster_1 = profile[which(rownames(profile)%in%biclusts[[i]]$rows),which(colnames(profile)%in%biclusts[[i]]$cols)] + for(j in i:length(biclusts)) { cotab[i,j] = similarity(bicluster_1, profile[ which(rownames(profile)%in%biclusts[[j]]$rows) , which(colnames(profile)%in%biclusts[[j]]$cols)]) } + } + ind=lower.tri(cotab) + cotab[ind]= t(cotab)[ind] + return(cotab) +} + +#' Merging similar biclusters +#' +#' @param cut A vector of bicluster classificatino +#' @param biclusts List of Biclusters to be merged +#' @param i iteration +#' @param MIR_profile Binarized microRNA profile +#' @param ZERORATE Final zero ratio allowed. +#' @return merged biclusters +merge = function(cut,biclusts,i, MIR_profile, ZERORATE) +{ + group_index = which(cut == i,arr.ind = T) + rowin = c() + colin = c() + for(i in group_index) + { + rowin = append(rowin,biclusts[[i]]$rows) + colin = append(colin,biclusts[[i]]$cols) + } + rowin = unique(rowin) + colin = unique(colin) + + rough = MIR_profile[which(rownames(MIR_profile)%in%rowin),which(colnames(MIR_profile)%in%colin)] + clear = bicluster_trimming_process(rough,ZERORATE) + return(list(rows = rownames(clear),cols = colnames(clear))) +} + +#' Merging similar biclusters +#' +#' @param MIR_profile binarized microRNA profile +#' @param tree_cutoff Similarity cutoff +#' @param biclusts list of extended biclusters +#' @param seedlist list of seeds +#' @param FCcutoff Fold change cutoff (in log2 sclale) for binarization of MIR profile +#' @param mir Name of miRNA +#' @param ZERORATE Final zero ratio allowed +#' @return Extended bicluster list +#' @export +merge_bicluster=function(MIR_profile, tree_cutoff = 0.5,biclusts, seedlist, FCcutoff=log2(1.3), mir='testmiRNA', ZERORATE) +{ + if(FCcutoff>0){PROFILE_POS = TRUE; PROFILE_NEG=FALSE} + if(FCcutoff<0){PROFILE_NEG = TRUE; PROFILE_POS=FALSE} + + biclusts_o = biclusts + if(length(biclusts)==0){stop('no biclusters to merge')} + dis = as.dist(comatrix(biclusts, MIR_profile)) + + if(max(dis)==0){ + biclusts = list() + biclusts[[1]] = list(rows = biclusts_o[[1]]$rows, cols = biclusts_o[[1]]$cols) + temp = rep(1, length(biclusts_o)) + }else if(min(dis) > tree_cutoff){ + biclusts = biclusts_o + temp = 1:length(biclusts) + }else{ + temp = list() + while(min(dis) < tree_cutoff) + { + cut = cutree(hclust(dis,method = "average"),h=tree_cutoff) + temp = append(temp, list(cut)) + + biclusts_new = list() + for(i in 1:length(unique(cut))) + { + biobject = merge(cut,biclusts,i, MIR_profile, ZERORATE) + biclusts_new = append(biclusts_new,list(biobject)) + } + biclusts = biclusts_new; rm(biclusts_new) + dis = as.dist(comatrix(biclusts,MIR_profile)) + } + } + + print(length(biclusts)) + + level = length(temp)-1 + + if(level>0) + { + for(i in level:1) + { + assign = temp[[(i+1)]][temp[[i]]] + } + }else if(level == 0){assign = unlist(temp)} + + return(biclusts) + # for(i in 1:length(biclusts)) + # { + # merged_row = biclusts[[i]]$rows + # merged_col = biclusts[[i]]$cols + # + # rowind = which(rownames(MIR_profile)%in%merged_row) + # colind = which(colnames(MIR_profile)%in%merged_col) + # + # bicluster_name = if(PROFILE_NEG){paste(mir, "_biclust_down_",i,'.txt',sep="") + # }else if(PROFILE_POS){paste(mir, "_biclust_up_",i,'.txt',sep="")} + # + # write.table(MIR_profile[rowind,colind], file = bicluster_name,quote = F) + # } + +} + +#' Progressive extension and merging of biclusters +#' +#' @param MIR_profile A matrix of microRNA profile where rows are cell conditions and columns are sequence-based miRNA targets. +#' @param biclust.path Directory where biclusts will be saved +#' @param mir Name of microRNA +#' @param FCcutoff Log2-fold change binarization cutoff for seed. Default = log2(1.3) +#' @param REPETITION The number of repetition that the ensemble function runs to extract seed biclusters. Default = 10 +#' @param STEP_NUMBER The number of extension process. Default = 10 +#' @param ZERORATE Final zero rate allowed. Default = 0.1 +#' @param tree_cutoff Similarity cutoff. Default = 0.5 +#' @return Extended and merged biclusters in the directory assigned to ‘biclust.path’. +#' @import biclust +#' @export +PBE_MERGE = function(MIR_profile, mir, biclust.path='./', FCcutoff=log2(1.3), REPETITION=10, STEP_NUMBER=10, ZERORATE=0.1, tree_cutoff=0.5) +{ + Expcond = expCondition() + if(FCcutoff>0){PROFILE_POS=TRUE; PROFILE_NEG=FALSE} + if(FCcutoff<0){PROFILE_POS=FALSE; PROFILE_NEG=TRUE} + MIR_profile = data.matrix(MIR_profile) + if(nrow(MIR_profile)==0){stop('Empty profile.')} + + biclusts_and_seeds = make_biclust(MIR_profile, FCcutoff, REPETITION, STEP_NUMBER, ZERORATE) + + if(length(biclusts_and_seeds$biclusts)==0){stop("No biclusters exnteded") + }else{ + # Merge the extended biclusters + setwd(biclust.path) + dir.create(mir, showWarnings = F) + MIR_profile_b = MIR_profile + if(PROFILE_POS){ + index0 = which(MIR_profile < FCcutoff) + index1 = which(MIR_profile >= FCcutoff) + MIR_profile_b[index0] = 0 + MIR_profile_b[index1] = 1 + } + if(PROFILE_NEG){ + index0 = which(MIR_profile > FCcutoff) + index1 = which(MIR_profile <= FCcutoff) + MIR_profile_b[index0] = 0 + MIR_profile_b[index1] = 1 + } + setwd(mir) + bclist = merge_bicluster(MIR_profile_b, tree_cutoff, biclusts=biclusts_and_seeds$biclusts, seedlist=biclusts_and_seeds$seedlist, FCcutoff, mir,ZERORATE) + + + for(i in 1:length(bclist)) + { + merged_row = bclist[[i]]$rows + merged_col = bclist[[i]]$cols + + rowind = which(rownames(MIR_profile)%in%merged_row) + colind = which(colnames(MIR_profile)%in%merged_col) + + bicluster_file = if(PROFILE_NEG){paste("biclust_down_",i,'.txt',sep="") + }else if(PROFILE_POS){paste("biclust_up_",i,'.txt',sep="")} + + condition_file = if(PROFILE_NEG){paste("Experimental_condition_down_",i,'.txt',sep="") + }else if(PROFILE_POS){paste("Experimental_condition_up_",i,'.txt',sep="")} + + genelist_file = if(PROFILE_NEG){paste("Targetlist_down_",i,'.txt',sep="") + }else if(PROFILE_POS){paste("Targetlist_up_",i,'.txt',sep="")} + + result_biclust = MIR_profile[rowind,colind] + biclust_exp_cond = Expcond[which(Expcond$Symbol%in%rownames(result_biclust)),] + biclust_genelist = colnames(result_biclust) + + write.table(result_biclust, file =bicluster_file,quote = F) + write.table(biclust_exp_cond, file = condition_file, quote = F, sep = "\t", row.names = F) + write(biclust_genelist, file = genelist_file, ncolumns = 1) + } + cat(paste('Finished. Check your folder:', biclust.path)) + } +} diff --git a/data/genelist.rda b/data/genelist.rda new file mode 100644 index 0000000..bdd2720 Binary files /dev/null and b/data/genelist.rda differ diff --git a/data/miRNATargets.rda b/data/miRNATargets.rda new file mode 100644 index 0000000..b2eb036 Binary files /dev/null and b/data/miRNATargets.rda differ diff --git a/data/miRNAlist.rda b/data/miRNAlist.rda new file mode 100644 index 0000000..1d0d85a Binary files /dev/null and b/data/miRNAlist.rda differ diff --git a/inst/extdata/Experimental_conditions.txt b/inst/extdata/Experimental_conditions.txt new file mode 100644 index 0000000..b51b5af --- /dev/null +++ b/inst/extdata/Experimental_conditions.txt @@ -0,0 +1,5566 @@ +Symbol Test Control +p_10006_1 "large airways, smoker, lung; tissue" "large airways, non-smoker, lung" +p_10006_2 "small airways, chronic obstructive pulmonary disease (COPD), lung; tissue" "small airways, non-smoker, lung" +p_10006_3 "small airways, smoker, lung; tissue" "small airways, non-smoker, lung" +p_10006_4 "small airways, early-chronic obstructive pulmonary disease (COPD), lung; tissue" "small airways, non-smoker, lung" +p_10041_1 "Healthy subject, 8 weeks of relaxation response practice" "healthy subject, No relaxation response practice" +p_10041_2 Long-term practitioner of daily relaxation response practice "healthy subject, No relaxation response practice" +p_10046_2 "MCF10A cell, co-cultured with breast cancer tissue" "MCF10A cell, control" +p_10046_3 "MCF10A, with breast cancer fibroblast treated" "MCF10A, with normal breast fibroblast" +p_10063_1 "MSK-Leuk1 cells, Tobacco Smoke treated, 0.5h" "MSK-Leuk1 cells, control, 0.5h" +p_10063_2 "MSK-Leuk1 cells, Tabacco Smoke treated, 3h" "MSK-Leuk1 cells, control, 3h" +p_10063_3 "MSK-Leuk1 cells, Tabacco Smoke treated, 6h" "MSK-Leuk1 cells, control, 6h" +p_10063_4 "MSK-Leuk1 cells, Tabacco Smoke treated, 12h" "MSK-Leuk1 cells, control, 12h" +p_10063_5 "MSK-Leuk1 cells, Tabacco Smoke treated, 24h" "MSK-Leuk1 cells, control, 24h" +p_10070_1 "MCF10A cell, Transwell treated, 1d" "MCF10A cell, control" +p_10070_2 "MCF10A cell, Transwell treated, 2d" "MCF10A cell, control" +p_10070_3 "MCF10A cell, Transwell treated, 3d" "MCF10A cell, control" +p_10138_1 "CLL lymphocytes, Chronic lymphocytic leukemia, progressive disease" "CLL lymphocytes, Chronic lymphocytic leukemia, stable disease" +p_10147_1 "pDC, IL-3 + p17 treated" "pDC, IL-3 treated" +p_10147_2 "pDC, IL-3 + CpG treated" "pDC, IL-3 treated" +p_10178_1 CD8+ CCR7- NKp80+ T cells CD8+ CCR7- NKp80- T cells +p_10196_1 "MCF10A, YAP-overexpressing cells" "MCF10A, control" +p_10232_1 "Jurkat cell line, cyclin T1 knockdown, PMA treated" "Jurkat cell line, control shRNA-transduced, PMA treated" +p_10234_1 "MM6 cell line, cyclin T1 knockdown, LPS treated" "Jurkat cell line, control shRNA-transduced, Mock treated" +p_10245_1 "NSCLC, adenocarcinoma" "NSCLC, squamous cell carcinoma" +p_10270_1 "Breast epithelial cells treated with 17-beta estradiol (E2), progesterone (PG)" "Breast epithelial cells, 17-beta estradiol (E2)" +p_10270_2 "Breast epithelial cells treated with 17-beta estradiol (E2), progesterone (PG), bisphenol A" "Breast epithelial cells, 17-beta estradiol (E2)" +p_10281_1 "breast tumor, Letrozole treated, 2.5mg/day,oral, 3 months" "breast tumor, pre-treatement" +p_10282_1 Braf mutant melanoma; skin cancer Braf wild-type melanoma; skin cancer +p_10282_2 Nras mutant mleanoma; skin cancer Nras wild-type mleanoma; skin cancer +p_10289_1 "Hep3B cells, transfected with plasmid siSDHB (SDHB siRNA containing vector)" "Hep3B cells, transfected with plasmid pU6" +p_10299_1 "SQ20B cells, Go6976 treated, 12h" "SQ20B cells, control" +p_10299_2 "SQ20B cells, Go6976 treated, 24h" "SQ20B cells, control" +p_10309_1 "CL1-5 cell, CLDN1 overexpressed" "CL1-5 cell, control" +p_10311_1 "Primary human osteoblast like cells (HOb), BMP2 induced, 2h" "Primary human osteoblast like cells (HOb), untreated, 2h" +p_10311_2 "Primary human osteoblast like cells (HOb), BMP2 induced, 24h" "Primary human osteoblast like cells (HOb), untreated, 24h" +p_10311_3 "Primary human osteoblast like cells (HOb), dexamethasone induced, 2h" "Primary human osteoblast like cells (HOb), untreated, 2h" +p_10311_4 "Primary human osteoblast like cells (HOb), dexamethasone induced, 24h" "Primary human osteoblast like cells (HOb), untreated, 24h" +p_10311_5 osteoblast HOb514 untreated 24h; time course HOb506_untreated_24h +p_10313_1 "Lymphoblastoid cell line, MNNG treated" "Lymphoblastoid cell line, control" +p_10315_1 "BM-MSC, BMP2-stimulated, day1" "BM-MSC, unstimulated, control" +p_10315_2 "BM-MSC, BMP2-stimulated, day3" "BM-MSC, unstimulated, control" +p_10315_3 "BM-MSC, BMP2-stimulated, day7" "BM-MSC, unstimulated, control" +p_10315_4 "BM-MSC, BMP2-stimulated, day21" "BM-MSC, unstimulated, control" +p_10315_5 "BM-MSC, TGFb3 -stimulated, day1" "BM-MSC, unstimulated, control" +p_10315_6 "BM-MSC, TGFb3 -stimulated, day3" "BM-MSC, unstimulated, control" +p_10315_7 "BM-MSC, TGFb3 -stimulated, day7" "BM-MSC, unstimulated, control" +p_10315_8 "BM-MSC, TGFb3 -stimulated, day21" "BM-MSC, unstimulated, control" +p_10316_11 "Dendritic cells, Schuler treated, 8h" "Immature dendritic cells, unstimulated" +p_10316_2 "Dendritic cells , LPS treated, 8h" "Immature dendritic cells, unstimulated" +p_10316_5 "Dendritic cells, CD40L treated, 8h" "Immature dendritic cells, unstimulated" +p_10316_8 "Dendritic cells, Poly(I:C) treated, 8h" "Immature dendritic cells, unstimulated" +p_10317_1 Parathyroid Tumour Normal Parathyroid Tissue +p_10327_1 desmoplastic medulloblastoma; brain cancer classic medulloblastoma +p_10334_1 "Gingival tissue, Affected site" "Gingival tissue, Unaffected site" +p_10406_1 Sinus mucosa tissue from cystic fibrosis-patient with chronic rhinosinusitis Normal sinus mucosa tissue +p_10406_2 Sinus mucosa tissue from the cystic fibrosis patient Normal sinus mucosa tissue +p_10406_3 Sinus mucosa tissue from patient with chronic rhinosinusitis Normal sinus mucosa tissue +p_10410_2 "hepatocyte, Myclobutanil, 30uM" "hepatocyte, DMSO 0.001, control" +p_10410_5 "hepatocyte, Propiconazole, 30uM" "hepatocyte, PB 1000uM, positive control" +p_10410_8 "hepatocyte, Triadimefon, 30uM" "hepatocyte, Rifampicin 30uM, positive control" +p_10437_1 "CD4+ Tcell, activated" "CD4+ Tcell, resting" +p_10444_1 "dental pulp cells, passage 10" "dental pulp cells, passage 4" +p_10463_1 "hMoDC, VAF347 stimulated, 8h" "hMoDC, control, 8h" +p_10479_1 "HUVEC, bg-CAT treated" "HUVEC, control" +p_10508_1 "Tesi cells, tetracycline treated" "Tesi cells, control" +p_10520_1 "U937 cells, expressing AML1/ETO" "U937 cells, empty vector" +p_10524_1 Testicular DLBCL Central nervous system DLBCL +p_10524_2 Nodal DLBCL Central nervous system DLBCL +p_10524_3 Nodal DLBCL Testicular DLBCL +p_10575_1 Chondrogenic progenitor cells from Osteoarthritis; tissue Healthy chondrocytes +p_10580_1 "U2OS cells, HA-tagged PRDM5 expression (doxycycline induced), 8h" "U2OS cells, empty vector, doxycycline induced, 8h" +p_10580_2 "U2OS cells, HA-tagged PRDM5 expression (doxycycline induced), 24h" "U2OS cells, empty vector, doxycycline induced, 24h" +p_10580_3 "U2OS cells, HA-tagged PRDM5 expression (doxycycline induced), 48h" "U2OS cells, empty vector, doxycycline induced, 48h" +p_10585_1 "M12 cell, UV treated" "M12 cell, control" +p_10586_1 Recent-onset T1D; Treg cells; blood tissue Healthy control +p_10591_1 "HepG2 cells, Tmprss6 transfection" "HepG2 cells, empty vector" +p_10591_2 "HepG2 cells, Mutant Tmprss6 transfection" "HepG2 cells, empty vector" +p_10592_2 "HBE cell, PBS treated, 24h" "HBE cell, control" +p_10592_4 "HBE cell, SMM treated, 24h" "HBE cell, control" +p_10592_6 "HBE cell, AZIT treated, 24h" "HBE cell, control" +p_10592_9 "HBE cell, AZIT treated, 72h, SMM treated, 24h" "HBE cell, control" +p_10595_1 "HS5 cell, MO co-cultured" "HS5 cell, control" +p_10595_2 "HS27a cell, MO co-cultured" "HS27a cell, control" +p_10609_4 "T-acute lymphoblastic leukemia, HOX11L2; blood cancer" "T-acute lymphoblastic leukemia, TAL1" +p_10609_5 "T-acute lymphoblastic leukemia, Unknown; blood cancer" "T-acute lymphoblastic leukemia, TAL1" +p_10616_1 "colon, only crohn's disease; tissue" "colon, healthy control" +p_10616_2 "colon, ileo-colonic crohn's disease; tissue" "colon, healthy control" +p_10616_3 "colon, ulcerative colitis; tissue" "colon, healthy control" +p_10650_2 "HCT116 cell, PCLKC expressed" "HCT116 cell, control" +p_10683_1 Vervet Limbus Vervet Cornea +p_10683_2 Vervet Limbus Vervet Conjunctiva +p_10685_1 "Human skeletal muscle biopsy, IL-6 infusion, 3h" "Human skeletal muscle biopsy, IL-6 infusion, 0h" +p_10685_2 "Human skeletal muscle biopsy, IL-6 infusion, 6h" "Human skeletal muscle biopsy, IL-6 infusion, 0h" +p_10696_1 "A431 cells, Gefitinib-resistant" "A431 cells, wild type" +p_10714_1 "human colonic biopsy sample, Hyperplastic polyp" "human colonic biopsy sample, normal control" +p_10714_2 "human colonic biopsy sample, CRC-B" "human colonic biopsy sample, normal control" +p_10714_3 "human colonic biopsy sample, CRC-CD" "human colonic biopsy sample, normal control" +p_10714_4 "human colonic biopsy sample, Crohn Disease" "human colonic biopsy sample, normal control" +p_10714_5 "human colonic biopsy sample, Adenoma with low-grade dysplasia" "human colonic biopsy sample, normal control" +p_10714_6 "human colonic biopsy sample, Ulcerative Colitis" "human colonic biopsy sample, normal control" +p_10714_7 colonic biopsy-UC (ulcerative colitis); tissue colonic biopsy-normal +p_10715_1 "PBMC, CRC patient stage duke A,B" "PBMC, control" +p_10715_2 "PBMC, CRC patient stage duke C,D" "PBMC, control" +p_10718_1 "NHBE cells, smoke exposed, 1h" "NHBE cells, mock exposed, 1h" +p_10718_2 "NHBE cells, smoke exposed, 2h" "NHBE cells, mock exposed, 2h" +p_10718_3 "NHBE cells, smoke exposed, 4h" "NHBE cells, mock exposed, 4h" +p_10718_4 "NHBE cells, smoke exposed, 24h" "NHBE cells, mock exposed, 24h" +p_10737_1 "Jurkat cell line, cyclin T1 knockdown" "Jurkat cell line, control shRNA-transduced" +p_10746_1 "Mucositis, pre-chemotherapy treated" "Mucositis, healthy control" +p_10746_2 "Mucositis, post-chemotherapy treated" "Mucositis, healthy control" +p_10767_1 "EBV-immortalized B-cells, BMPR2 mutation carrier, with clinical PAH (pulmonary arterial hypertension)" "EBV-immortalized B-cells, BMPR2 mutation carrier, with no clinical disease" +p_10780_1 Invasive ductal carcinoma (IDC) "Unremarkable breast ducts, Normal" +p_10791_1 "sigmoid colon biopsy, ulcerative colitis (UC)" "sigmoid colon biopsy, healthy control" +p_10792_1 C-acute lymphoblastic leukemia (ALL) with t(12;21); leukemia; blood cancer C-ALL-preB without t(9;22) +p_10792_2 C-acute lymphoblastic leukemia (ALL)-preB with t(9;22); leukemia; blood cancer C-ALL-preB without t(9;22) +p_10792_3 C-acute lymphoblastic leukemia (ALL)-preB without t(9;22) and TEL deleted; leukemia; blood cancer C-ALL-preB without t(9;22) +p_10792_4 prepreB-C-acute lymphoblastic leukemia (ALL) with MLL; leukemia; blood cancer C-ALL-preB without t(9;22) +p_10799_1 "Human pulmonary adenocarcinoma, bone marrow negative" "female pulmonary adenocarcinoma, normal tissue" +p_10799_2 "Human pulmonary adenocarcinoma, bone marrow positive" "female pulmonary adenocarcinoma, normal tissue" +p_10809_1 "CA1 HESC, SOX7 over-expression" "CA1 HESC, parental control" +p_10809_2 "CA2 HESC, SOX17 over-expression" "CA2 HESC, parental control" +p_10810_1 breast cancer "breast, control" +p_10810_2 "breast cancer, ki-67 > 25" "breast cancer, ki-67 < 25" +p_10810_3 "breast cancer, estrogen receptor (+)" "breast cancer, estrogen receptor (-)" +p_10820_1 "acute lymphoblastic leukemia (ALL), Poor prognosis; cancer" "acute lymphoblastic leukemia (ALL), Favorable prognosis" +p_10821_1 "GC B cells, LMP1-transfected" "GC B cells, pSC5-transfected, control" +p_10831_1 "HRS cell, L1236 HL Cell line" GC B cell +p_10831_2 "HRS cell, KMH2 HL Cell line" GC B cell +p_10831_3 "HRS cell, L428 HL Cell line" GC B cell +p_10831_4 "HRS cell, L591 HL Cell line" GC B cell +p_10832_1 "PC3 cell, sphere type" "PC3 cell, monolayer type" +p_10832_2 "DU145 cell, sphere type" "DU145 cell, monolayer type" +p_10846_1 "lymphoma, Rituximab-CHOP treated" "lymphoma, CHOP" +p_10847_1 "NCI-H522 cells, BRG1 expression, treated with TGFbeta, 2h." "NCI-H522 cells, BRG1 expression, untreated" +p_10847_2 "NCI-H522 cells, TGFbRII expression, treated with TGFbeta, 2h." "NCI-H522 cells, TGFbRII expression, untreated" +p_10847_3 "NCI-H522 cells, TGFbRII + BRG1 expression, TGFbeta treated, 2h" "NCI-H522 cells, TGFbRII + BRG1 expression, untreated" +p_10856_1 "MDM cells, DcR3 treated, 2 days" "MDM cells, hIgG1 treated, 2 days, control" +p_10879_1 "MCF-7:5C cells, Estrogen-deprived" "MCF-7 cells, wild type" +p_10879_2 "MCF-7:2A cells, Estrogen-deprived" "MCF-7 cells, wild type" +p_10880_1 "MRC cell, IFN gamma treated" MRC cell +p_10880_2 "MRC cell, IFN gamma treated" PGF cell +p_10896_1 "differentiated U937 cells, 1uM curcumin treated, 4h" "differentiated U937 cells, untreated, 4h" +p_10896_2 "differentiated U937 cells, ROS exposed, 1uM curcumin treated, 4h" "differentiated U937 cells, ROS exposed, 4h" +p_10896_3 "differentiated U937 cells, 1uM curcumin treated, 18h" "differentiated U937 cells, untreated, 18h" +p_10896_4 "differentiated U937 cells, ROS exposed, 1uM curcumin treated, 18h" "differentiated U937 cells, ROS exposed, 18h" +p_10916_1 "melanoma, melphalan & temozolomide treated" "melanoma, ,melphalan" +p_10916_2 Braf mutant melanoma; skin cancer Braf WT melanoma +p_10916_3 Nras mutant mleanoma; skin cancer Nras WT mleanoma +p_10927_1 adrenocortical Adenoma; cancer "adrenal Cortex, normal" +p_10927_2 adrenocortical Carcinoma; cancer "adrenal Cortex, normal" +p_10943_1 "ascitic fluid, ovarian cancer, IFN-alpha treated non-side population" "ascitic fluid, ovarian cancer, untreated non-side population" +p_10946_1 cumulus_PCOS_Obese; tissue cumulus_PCOS_Lean +p_10946_2 cumulus_nonPCOS_Obese; tissue cumulus_nonPCOS_Lean +p_10946_3 cumulus_PCOS_Obese; tissue cumulus_nonPCOS_Obese +p_10946_4 cumulus_PCOS_Lean; tissue cumulus_nonPCOS_Lean +p_10960_1 "HeLa cells, s/as" "HeLa cells, s/as mock" +p_10960_2 "HeLa cells, meT-s/as" "HeLa cells, s/as mock" +p_10960_3 "HeLa cells, s/meT-as" "HeLa cells, s/as mock" +p_10960_4 "HeLa cells, meT-a/meT-as" "HeLa cells, s/as mock" +p_10960_5 "HeLa cells, PIK3CB-6340" "HeLa cells, PIK3CB-6340 mock" +p_10961_1 Synchronous liver metastasis colorectal cancer Metachronous liver metastasis from colorectal cancer +p_10971_1 high grade serous carcinoma; ovary cancer non-malignant FTEn +p_10971_2 non-malignant FTEb; ovary cancer non-malignant FTEn +p_10979_1 "FL cell, 0.05uM BPDE treated, control, 1h" "FL cell, DMSO treated, control, 1h" +p_10979_2 "FL cell, 0.05uM BPDE treated, control, 10h" "FL cell, DMSO treated, control, 10h" +p_10979_3 "FL cell, 0.05uM BPDE treated, control, 22h" "FL cell, DMSO treated, control, 22h" +p_11001_1 ER+ breast cancer ER- breast cancer +p_11001_2 PR+ breast cancer PR- breast cancer +p_11001_3 HER2+ breast cancer HER2- breast cancer +p_11001_4 Node+ breast cancer Node- breast cancer +p_11024_1 "kidney, clear cell; cancer" "kidney, normal" +p_11024_2 "kidney, chromophobe; cancer" "kidney, normal" +p_11024_3 "kidney, papillary type1; cancer" "kidney, normal" +p_11024_4 "kidney, papillary type2; cancer" "kidney, normal" +p_11024_5 "kidney, oncocytoma; cancer" "kidney, normal" +p_11024_6 "kidney, wilms tumor; cancer" "kidney, normal" +p_11045_1 liver kidney +p_11057_1 Central memory cell "PMBC, control" +p_11057_2 Effector memory cell "PMBC, control" +p_11057_3 Naive cell "PMBC, control" +p_11083_1 "Neutrophil, JIA patient" "Neutrophil, healthy" +p_11083_2 "Neutrophil, JDM patient" "Neutrophil, healthy" +p_11083_3 "PBMC, JIA patient" "PBMC, healthy" +p_11083_4 "PBMC, JDM patient" "PBMC, healthy" +p_11092_1 "CD34- cells, stimulated by G-CSF" "CD34+ cells, stimulated by G-CSF" +p_11100_1 "Human GBM cell, tumor, post vaccination" "Human GBM cell, normal, post vaccination" +p_11100_2 "Human GBM cell, tumor, pre vaccination" "Human GBM cell, normal, pre vaccination" +p_11118_1 "Jurkat Cell, mitogen stimulated , 0.5h" "Jurkat Cell, control" +p_11118_2 "Jurkat Cell, mitogen stimulated , 1h" "Jurkat Cell, control" +p_11135_1 MILE training; blood cancer proficiency +p_11142_1 "T cell line, 10 nM nicotine, 1h" "T cell line, control" +p_11142_2 "T cell line, 10 uM nicotine, 1h" "T cell line, control" +p_11142_3 "T cell line, 1 mM nicotine, 1h" "T cell line, control" +p_11151_1 conventional renal cell cancer adult normal kidney +p_11151_2 papillary renal cell cancer adult normal kidney +p_11151_3 renal oncocytoma adult normal kidney +p_11151_4 rhabdoid tumor of kidney adult normal kidney +p_11151_5 WIlms' tumor adult normal kidney +p_11151_6 collecting duct carcinoma adult normal kidney +p_11151_7 clear cell sarcoma of the kidney adult normal kidney +p_11185_3 "293-tet-On, NOR1 with doxycycline treated" "293-tet-On, NOR1 without doxycycline" +p_11190_1 "blood cells, after interferon treatment" "blood cells, before interferon treatment" +p_11190_2 "blood cells, rapid-responder (RR) group, Post-interferon treatment" "blood cells, rapid-responder (RR) group, Pre-interferon treatment" +p_11190_3 "blood cells, non-rapid-responder (RR) group, Post-interferon treatment" "blood cells, non-rapid-responder (RR) group, Pre-interferon treatment" +p_11196_3 "non-contractile polyribosomal RNA, IPF treated" "non-contractile polyribosomal RNA, control" +p_11196_4 "non-contractile total RNA, IPF treated" "non-contractile total RNA, control" +p_11199_1 "Macrophage, LTB stimulated" "Macrophage, control" +p_11199_2 "Macrophage, PTB stimulated" "Macrophage, control" +p_11199_3 "Macrophage, TBM stimulated" "Macrophage, control" +p_11208_1 "peripheral ganglion, nicotine, 1hr" "peripheral ganglion, control, 1hr" +p_11208_2 "peripheral ganglion, nicotine, 24hr" "peripheral ganglion, control, 24hr" +p_11227_1 "Whole blood, after NHD (Nocturnal home hemodialysis) treatment" "Whole blood, before NHD treatment" +p_11238_23 "HeLa Cell Line, unknown: VVdelE3L, 9 HPI" "HeLa cell line, mock infected, 9HPI" +p_11238_24 "HeLa Cell Line, unknown: VVE3Ldel83N, 9 HPI" "HeLa cell line, mock infected, 9HPI" +p_11238_25 "HeLa Cell Line, unknown: VVE3Ldel26C, 9 HPI" "HeLa cell line, mock infected, 9HPI" +p_11238_26 "HeLa Cell Line, unknown: VVE3Ldel7C, 9 HPI" "HeLa cell line, mock infected, 9HPI" +p_11238_27 "HeLa Cell Line, unknown: VVE3L Y48A, 9 HPI" "HeLa cell line, mock infected, 9HPI" +p_11238_28 "HeLa Cell Line, unknown: VVE3L Y48F, 9 HPI" "HeLa cell line, mock infected, 9HPI" +p_11238_29 "HeLa Cell Line, unknown: VV-ATV, 9 HPI" "HeLa cell line, mock infected, 9HPI" +p_11238_30 "HeLa Cell Line, unknown: VV-ADAR/E3L, 9 HPI" "HeLa cell line, mock infected, 9HPI" +p_11238_31 "HeLa Cell Line, unknown: VVdel37N, 9 HPI" "HeLa cell line, mock infected, 9HPI" +p_11238_32 "HeLa Cell Line, unknown: VVdelK3L, 9 HPI" "HeLa cell line, mock infected, 9HPI" +p_11279_1 "SW480 cells, ezrin RNAi" "SW480 cells, luciferase RNAi, control" +p_11281_1 "PBMC, SEI treated, 100pg/ml" "PBMC, untreated, control" +p_11281_2 "PBMC, SEB treated, 100pg/ml" "PBMC, untreated, control" +p_11285_1 "U251 cells, Enzastaurin treated, 4h" "U251 cells, DMSO, 4h" +p_11285_2 "U251 cells, Enzastaurin treated, 10h" "U251 cells, DMSO, 10h" +p_11285_3 "U251 cells, Enzastaurin treated, 18h" "U251 cells, DMSO, 18h" +p_11292_1 "Human T cell, GARP overexpressed, 0m" "Human T cell, GPF expressed, 0m" +p_11292_2 "Human T cell, GARP overexpressed, 100m" "Human T cell, GPF expressed, 100m" +p_11292_3 "Human T cell, GARP overexpressed, 360m" "Human T cell, GPF expressed, 360m" +p_11309_1 "monocyte-differenciated dendritic cells, candida-,patient" "monocyte-differenciated dendritic cells, candida-,control" +p_11309_2 "monocyte-differenciated dendritic cells, candida+,patient" "monocyte-differenciated dendritic cells, candida+,control" +p_11324_1 "MCF-7 cells, estrogen treated, 3h" "MCF-7 cells, estrogen treated, 0h" +p_11324_2 "MCF-7 cells, estrogen treated, 6h" "MCF-7 cells, estrogen treated, 0h" +p_11324_3 "MCF-7 cells, estrogen treated, 12h" "MCF-7 cells, estrogen treated, 0h" +p_11327_1 "dendritic cell, LPS+IFNg treated, 6h" "dendritic cells, unstimulated control, 6h" +p_11327_2 "dendritic cell, LPS+IFNg treated, 12h" "dendritic cells, unstimulated control, 12h" +p_11327_3 "dendritic cell, LPS+IFNg treated, 24h" "dendritic cells, unstimulated control, 24h" +p_11327_4 "dendritic cell, LPS+IFNg treated, 48h" "dendritic cells, unstimulated control, 48h" +p_11330_1 "MCF-7 cell, SOX2 expressed" "MCF-7 cell, control" +p_11336_1 "CCRF-CEM-C7H2 cell line, treated with dexamethansone (a GC), 100nM, 6h" "CCRF-CEM-C7H2 cell line, treated with EtOH, 6h, control" +p_11336_2 "CCRF-CEM-C7H2 cell line, treated with dexamethansone (a GC), 100nM, 24h" "CCRF-CEM-C7H2 cell line, treated with EtOH, 24h, control" +p_11345_1 "T84 cell, IL17 stimulated" "T84 cell, control" +p_11345_2 "T84 cell, IL22 stimulated" "T84 cell, control" +p_11348_1 "Nasal epithelium, rhinovirus, infection 8hr, treatment; time course" "rhinovirus, preinfection" +p_11348_2 "Nasal epithelium, rhinovirus, infection 2day, treatment; time course" "rhinovirus, preinfection" +p_11350_1 "hGS cells from testis, cultivated with KO Medium+GDNF treated" "H1 cells from testis, cultivated in ES Medium+FGF2" +p_11350_2 "haGSC cells from testis, cultivated with KO Medium+GDNF treated" "H1 cells from testis, cultivated in ES Medium+FGF2" +p_11352_1 "MCF7 cells, E2 treated, 12h" "MCF7 cells, untreated, 12h" +p_11352_2 "MCF7 cells, E2 treated, 24h" "MCF7 cells, untreated, 24h" +p_11352_3 "MCF7 cells, E2 treated, 48h" "MCF7 cells, untreated, 48h" +p_11367_1 "VSMCs, IL-17 treated" "VSMCs, untreated, control" +p_11373_1 "PSF8 cells ,Fascin-knockdown" "PSC cells, vector control" +p_11375_1 Inpatient rehabilitation facility; blood leukocytes from trauma patients; tissue control +p_11375_2 Skilled nursing facility; blood leukocytes from trauma patients; tissue control +p_11375_3 Home with services; blood leukocytes from trauma patients; tissue control +p_11375_4 Home; blood leukocytes from trauma patients; tissue control +p_11375_5 Another acute care facility; blood leukocytes from trauma patients; tissue control +p_11375_6 Death; blood leukocytes from trauma patients; tissue control +p_11407_1 "MDA-MB-231 cell, C1OH-Ac3ManNAc" "MDA-MB-231 cell, EtOH , control" +p_11407_2 "MDA-MB-231 cell, C1OH-But3GalNAc" "MDA-MB-231 cell, EtOH , control" +p_11407_3 "MDA-MB-231 cell, C1OH-But3GlcNAc" "MDA-MB-231 cell, EtOH , control" +p_11407_4 "MDA-MB-231 cell, C1OH-But3ManlNAc" "MDA-MB-231 cell, EtOH , control" +p_11407_5 "MDA-MB-231 cell, C6OH-But3ManlNAc" "MDA-MB-231 cell, EtOH , control" +p_11407_6 "MDA-MB-231 cell, AC4ManNLev" "MDA-MB-231 cell, EtOH , control" +p_11418_1 "NHDF, passage 13, adult donor" "NHDF, passage 4, adult donor" +p_11418_2 "NHDF, passage 6, neonatal donor" "NHDF, passage 4, adult donor" +p_11428_1 "LNCaP cells, siRNA targeting Androgen Receptor" "LNCaP cells, siRNA control" +p_11428_2 "abl cells, siRNA targeting Androgen Receptor" "abl cells, siRNA control" +p_11428_3 "abl cells, DHT treated, 4h" "abl cells, ethanol treated" +p_11428_4 "abl cells, DHT treated, 16h" "abl cells, ethanol treated" +p_11430_1 "whole blood, monocyte" "whole blood, macrophage" +p_11440_1 "HT29 cell, resistant to methotrxate" "HT29 cell, sensitive to methotrxate" +p_11450_1 oocyte HEPG2 +p_11450_2 oocyte MCF7 +p_1145_1 idiopathic cardiomyopathy; heart tissue normal +p_1145_2 familial cardiomyopathy; heart tissue normal +p_1145_3 hypertrophic cardiomyopathy; heart tissue normal +p_1145_4 post-partum cardiomyopathy; heart tissue normal +p_1145_5 ischemic cardiomyopathy; heart tissue normal +p_1145_6 viral cardiomyopathy; heart tissue normal +p_11462_1 "MM6 cell, control, PMA treated" "MM6 cell, control, Mock treated" +p_11462_10 MM6 cyclin T1 shRNA PMA treated MM6 control shRNA PMA treated +p_11462_11 MM6 control shRNA LPS treated MM6 control shRNA Mock treated +p_11462_12 MM6 cyclin T1 shRNA LPS treated MM6 control shRNA LPS treated +p_11462_13 MM6 cyclin T1 shRNA LPS treated MM6 cyclin T1 shRNA Mock treated +p_11462_2 "MM6 cell, control, LPS treated" "MM6 cell, control, Mock treated" +p_11462_3 "MM6 cell, Cyclin T1 knockdown, PMA treated" "MM6 cell, Cyclin T1 knockdown, Mock treated" +p_11462_4 "MM6 cell, Cyclin T1 knockdown, LPS treated" "MM6 cell, Cyclin T1 knockdown, Mock treated" +p_11462_5 "MM6 cell, Control knockdown, PMA treated" "MM6 cell, Control knockdown, Mock treated" +p_11462_6 "MM6 cell, Control knockdown, LPS treated" "MM6 cell, Control knockdown, Mock treated" +p_11462_7 "Jurkat cell, control knockdown, PMA treated" "Jurkat cell, control knockdown, Mock treated" +p_11462_8 "Jurkat cell, cyclin T1 knockdown, PMA treated" "Jurkat cell, cyclin T1 knockdown, Mock treated" +p_11462_9 MM6 cyclin T1 shRNA PMA treated MM6 cyclin T1 shRNA Mock treated +p_11499_1 "peripheral blood, Ulcerative colitis" "peripheral blood, Crohn's disease" +p_11504_1 "Human composite bone marrow, 3 months" "Human composite bone marrow, 2 month" +p_11504_10 "Human composite bone marrow, 74 months" "Human composite bone marrow, 2 month" +p_11504_20 "Human composite bone marrow, 313 months" "Human composite bone marrow, 2 month" +p_11504_5 "Human composite bone marrow, 32 months" "Human composite bone marrow, 2 month" +p_11506_1 "MCF-7 cells, E2 treated, 3h" "MCF-7 cells, vehicle treated, 3h" +p_11506_2 "MCF-7 cells, E2 treated, 6h" "MCF-7 cells, vehicle treated, 3h" +p_11524_1 "platele, sickle cell patients" "platelet, control" +p_11550_1 "Hs 294T cell line, 0.01% DMSO treated, 6h" "Hs 294T cell line, untreated" +p_11550_2 "Hs 294T cell line, 100nM elesclomol treated ,6h" "Hs 294T cell line, untreated" +p_11550_3 "Hs 294T cell line, 250nM paclitaxel treated, 6h" "Hs 294T cell line, untreated" +p_11550_4 "Hs 294T cell line, 100nM elesclomol + 250nM paclitaxel treated, 6h" "Hs 294T cell line, untreated" +p_11551_1 "Hs 294T cell line, 100nM elesclomol treated at 6h" "Hs 294T cell line, 0.01% DMSO treated at 6h" +p_11551_2 "Hs 294T cell line, 5mM NAC treated at 6h" "Hs 294T cell line, 0.01% DMSO treated at 6h" +p_11551_3 "Hs 294T cell line, 100nM elesclomol + 5mM NAC treated at 6h" "Hs 294T cell line, 0.01% DMSO treated at 6h" +p_11581_1 "MCF-7 cells, siRNA targeting FAK" "MCF-7 cells, siRNA control" +p_11618_1 "HCT116, luciferase late passage; treated" "HCT116, luciferase early passage" +p_11618_2 "HCT116, XIAP late passage; treated" "HCT116, XIAP early passage" +p_11622_1 "Vaginal tissue, E2 treated" "Vaginal tissue, control" +p_11626_1 "H1299 cells, transduced with TAp73beta expressing adenovirus" "H1299 cells, transduced with GFP expressing adenovirus" +p_11670_1 "K562 cell, ICL670 10uM treated" "K562 cell, untreated" +p_11670_2 "K562 cell, ICL670 50uM treated" "K562 cell, untreated" +p_11673_1 "H1299 cells, transduced with TAp73beta expressing adenovirus, 5h" "H1299 cells, transduced with GFP expressing adenovirus, 5 h, control" +p_11683_1 MDA-MB-468GFP-LN MDA-MB-468GFP +p_11710_12 "HaCaT cells, siRNA targeting Smad2, TGF-beta stimulation, 24" "HaCaT cells, TGF-beta3 stimulation, control siRNA, 24h" +p_11710_15 "HaCaT cells, siRNA targeting Smad3,TGF-beta stimulation, 24" "HaCaT cells, TGF-beta3 stimulation, control siRNA, 24h" +p_11710_6 "HaCaT cells, siRNA targeting ETS1, TGF-beta3 stimulation, 24h" "HaCaT cells, TGF-beta3 stimulation, control siRNA, 24h" +p_11710_9 "HaCaT cells, siRNA targeting TFAP2A, TGF-beta3 stimulation, 24" "HaCaT cells, TGF-beta3 stimulation, control siRNA, 24h" +p_11729_12 "H1299 cell, EGFR-wt, EGF, Iressa treated, 10h" "H1299 cell, EGFR-wt, control" +p_11729_18 "H1299 cell, EGFR-wt, Iressa treated, 10h" "H1299 cell, EGFR-wt, control" +p_11729_24 "H1299_L858R cell, EGF treated, 10h" "H1299_L858R cell, control" +p_11729_30 "H1299_L858R cell, EGF, Iressa treated, 10h" "H1299_L858R cell, control" +p_11729_36 "H1299_L858R cell, Iressa treated, 10h" "H1299_L858R cell, control" +p_11729_42 "H1299 cell, EGF treated, 10h" "H1299 cell, control" +p_11729_48 "H1299 cell, EGF, Iressa treated, 10h" "H1299 cell, control" +p_11729_54 "H1299 cell, Iressa treated, 10h" "H1299 cell, control" +p_11729_6 "H1299 cell, EGFR-wt, EGF treated, 10h" "H1299 cell, EGFR-wt, control" +p_11755_10 Blood_T72; meningococcal sepsis; infection; time course Control_Blood +p_11755_2 Lymphocyte_T8; meningococcal sepsis; infection; time course Control_Lymphocyte +p_11755_4 Lymphocyte_T72; meningococcal sepsis; infection; time course Control_Lymphocyte +p_11755_6 Monocyte_T8; meningococcal sepsis; infection; time course Control_Monocyte +p_11761_1 "PBMCs, after exercisep treatment" "PBMCs, before exercise" +p_11783_1 "Bladder tissue, IC, non-ulcer tissue" "Bladder tissue, healthy" +p_11783_2 "Bladder tissue, IC, ulcer tissue" "Bladder tissue, healthy" +p_11791_1 "MCF-7 cells, ICI 182780 pretreatment, then treated with E2" "MCF-7 cells, ICI 182780 pretreatment, then treated with ethanol vehicle" +p_11791_2 "MCF-7 cells, Myc-containing vector, ICI 182780 pretreatment, then treated with Zn" "MCF-7 cells, empty vector, ICI 182780 pretreatment, then treated with Zn" +p_11791_3 "MCF-7 cells, Zip-containing vector, ICI 182780 pretreatment, then treated with Zn" "MCF-7 cells, empty vector, ICI 182780 pretreatment, then treated with Zn" +p_11791_4 "MCF7, Zip_Zn; treated" "MCF7, EtOH" +p_11839_1 "Interstial cystitis, differentiated; tissue" "Control, differentiated" +p_11839_2 "Interstial cystitis, differentiated; tissue" "Interstial cystitis, non-differentiated" +p_11839_3 "Control, differentiated; tissue" "Control, non-differentiated" +p_11839_4 "Interstial cystitis, non-differentiated; tissue" "Control, non-differentiated" +p_11854_1 "fibroblast, hCycle11, 1hr" "fibroblast, hCycle11, 0hr" +p_11854_12 "fibroblast, hCycle11, 12hr" "fibroblast, hCycle11, 0hr" +p_11854_6 "fibroblast, hCycle11, 6hr" "fibroblast, hCycle11, 0hr" +p_11864_1 "M-CSF, IFN-gamma" "M-CSF, control" +p_11864_2 "M-CSF, Pam3Cys" "M-CSF, control" +p_11864_3 "M-CSF, Pam3Cys + IFN-gamma" "M-CSF, control" +p_11864_4 "monocyte, M-CSF & IFN-gamma & Pam3Cys treated" "monocyte, control" +p_11869_1 "Ishikawa cell, 17alpha-ethynyl estradiol 8 h very low dose treated; time course" "Ishikawa cell, control 8 h" +p_11869_10 "Ishikawa cell, 17alpha-ethynyl estradiol 48 h low dose treated; time course" "Ishikawa cell, control 48 h" +p_11869_11 "Ishikawa cell, 17alpha-ethynyl estradiol 48 h high dose treated; time course" "Ishikawa cell, control 48 h" +p_11869_12 "Ishikawa cell, 17alpha-ethynyl estradiol 48 h very high dose treated; time course" "Ishikawa cell, control 48 h" +p_11869_2 "Ishikawa cell, 17alpha-ethynyl estradiol 8 h low dose treated; time course" "Ishikawa cell, control 8 h" +p_11869_3 "Ishikawa cell, 17alpha-ethynyl estradiol 8 h high dose treated; time course" "Ishikawa cell, control 8 h" +p_11869_4 "Ishikawa cell, 17alpha-ethynyl estradiol 8 h very high dose treated; time course" "Ishikawa cell, control 8 h" +p_11869_5 "Ishikawa cell, 17alpha-ethynyl estradiol 24 h very low dose treated; time course" "Ishikawa cell, control 24 h" +p_11869_6 "Ishikawa cell, 17alpha-ethynyl estradiol 24 h low dose treated; time course" "Ishikawa cell, control 24 h" +p_11869_7 "Ishikawa cell, 17alpha-ethynyl estradiol 24 h high dose treated; time course" "Ishikawa cell, control 24 h" +p_11869_8 "Ishikawa cell, 17alpha-ethynyl estradiol 24 h very high dose treated; time course" "Ishikawa cell, control 24 h" +p_11869_9 "Ishikawa cell, 17alpha-ethynyl estradiol 48 h very low dose treated; time course" "Ishikawa cell, control 48 h" +p_11877_1 "Acute lymphoblastic leukemia (ALL), congenital abnormality: Downs; cancer tissue" "Acute lymphoblastic leukemia (ALL), congenital abnormality: None" +p_11877_2 "Acute lymphoblastic leukemia (ALL), MLL(+), cancer tissue" "Acute lymphoblastic leukemia (ALL), MLL(-)" +p_11877_3 "Acute lymphoblastic leukemia (ALL), TEL-AML, t(12:21)(+); cancer tissue" "Acute lymphoblastic leukemia (ALL), TEL-AML, t(12:21)(-)" +p_11877_4 "Acute lymphoblastic leukemia (ALL), Trisomy 4 & 10 (+); cancer tissue" "Acute lymphoblastic leukemia (ALL), Trisomy 4 & 10 (-)" +p_11877_5 "Acute lymphoblastic leukemia (ALL), E2A-PBX, t(1,19) (+); cancer tissue" "Acute lymphoblastic leukemia (ALL), E2A-PBX, t(1,19) (-)" +p_11881_1 Tolerant PBMC; tissue Non-tolerant PBMC +p_11882_1 "brain HC, age_60-99; tissue" "brain HC, age_20-59" +p_11882_2 "brain EC, age_60-99; tissue" "brain EC, age_20-59" +p_11882_3 "brain SG, age_60-99; tissue" "brain SG, age_20-59" +p_11882_4 "brain PCG, age_60-99; tissue" "brain PCG, age_20-59" +p_11882_5 "brain HC, female; tissue" "brain HC, male" +p_11882_6 "brain EC, female; tissue" "brain EC, male" +p_11882_7 "brain SG, female; tissue" "brain SG, male" +p_11882_8 "brain PCG, female; tissue" "brain PCG, male" +p_11883_1 "Mz-ChA-1 cells, IL-6 over-expression" Mz-ChA-1 cells +p_11886_1 "Patient Macrophages, IFN treated" "Patient Macrophages, None" +p_11886_2 "Control Macrophages, IFN treated" "Control Macrophages, None" +p_11886_3 "Patient Macrophages, IFN treated" "Control Macrophages, IFN treated" +p_11886_4 "Patient Macrophages, None; tissue" "Control Macrophages, None" +p_11916_1 "Huh7 cells, stably expressing S33Y beta-catenin" "Huh7 Cells, control" +p_11919_1 "GM5659 cell, AA treated" "GM5659 cell, control" +p_11919_2 "GM5659 cell, AA2P treated" "GM5659 cell, control" +p_11940_1 "Primary human hepatocytes, Doxorubicin treated" "Primary human hepatocytes, control" +p_11941_1 "Hepatocyte , Trovafloxacin treated" "Hepatocyte , control" +p_11942_1 "Human Hepatocytes, Doxorubicin treated" "Human hepatocytes, control" +p_11942_2 "Human Hepatocytes, Trovofloxacin treated" "Human hepatocytes, control" +p_11951_1 "MDA-MB-231, transfected with a vector containing a shRNAs against CD146" "MDA-MB-231, transfected with the original vector plasmid" +p_11951_2 "MDA-MB-231, transfected with a vector containing a shRNAs against CD146" "MDA-MB-231, transfected with a vector containing a non-effective shRNA cassette against GFP" +p_11951_3 "MDA-MB-231, transfected with a vector containing a shRNAs against CD146" "MDA-MB-231, native cell" +p_11952_1 "small airways, smoker; lung tissue" "small airways, non-smoker" +p_11954_1 "hepatic stellate cells, Senescent" "hepatic stellate cells, Growing" +p_11956_1 High TCF activity Huh7 treated Control Huh7 +p_11959_1 "human SK-N-AS neuroblastoma xenografts, 10H5 treated, 24 hr" "human SK-N-AS neuroblastoma xenografts, vehicle" +p_11981_1 "pancreatic tumor xenograft, HhAntag treated" "pancreatic tumor xenograft, vehicle" +p_12034_1 human oocyte (Pool of 10 human oocytes) human reference (Pool of ten normal human tissues for reference) +p_12056_1 "K562 cell, CREB knock-out" "K562 cell, control" +p_12079_1 "CD3-CD4+ T cell, hypereosinophilic syndrome, 0y" "CD3-CD4+ T cell, control" +p_12079_2 "CD3-CD4+ T cell, hypereosinophilic syndrome, 4y" "CD3-CD4+ T cell, control" +p_12079_3 "CD3-CD4+ T cell, hypereosinophilic syndrome, 6y" "CD3-CD4+ T cell, control" +p_12079_4 "CD3-CD4+ T cell, hypereosinophilic syndrome, 0y, rhIL2 stimulated" "CD3-CD4+ T cell, hypereosinophilic syndrome, 0y" +p_12086_1 "Lymphoblast cell line, Recessive retinitis pigmentosa" "Lymphoblast cell line,control" +p_12086_2 Lymphoblast of Retinitis Pigmentosa Unrelated Patients; tissue Control Lymphoblast +p_12090_1 Chromophobe renal cell carcinoma (RCC) Benign Oncocytoma +p_12102_1 "EWD cell, relapse" "EWD cell, control" +p_12102_2 "EWD cell, metastasis" "EWD cell, control" +p_12108_1 "human monocyte, F.novicida infected" "human monocyte, uninfected" +p_12108_2 "human monocyte, Schu S4 infected" "human monocyte, uninfected" +p_12113_1 "Pancreatic Cancer cell, IPI-504" "Pancreatic Cancer cell, control" +p_12121_1 "HIGK cell, Streptococcous gordonii" "HIGK cell, Sham infected, control" +p_12121_2 "HIGK cell, Streptococcous gingivalis" "HIGK cell, Sham infected, control" +p_12121_3 "HIGK cell, Streptococcous gordonii + gingivalis" "HIGK cell, Sham infected, control" +p_12131_1 "HUVEC cell, intoxicated, 4h" "HUVEC cell, non intoxicated" +p_12131_2 "HUVEC cell, intoxicated, 8h" "HUVEC cell, non intoxicated" +p_12141_1 "Brain tumor, metastastic" "Brain tumor, ependymoma, non-metastatic" +p_12155_1 "Endothelial Progenitor Cells , after 3 months of exercise" "Endothelial Progenitor Cells , baseline" +p_12161_1 "HepG2 cells, TNF alpha treated" "HepG2 cells, control" +p_12172_1 "ovarian carcinoma, serous; ovary cancer" "ovarian tumor, serous LMP (low malignant potential) tumor" +p_12187_1 mild or moderate Chronic Allograft Nephropathy; kidney tissue severe Chronic Allograft Nephropathy +p_12195_1 DLBCL; blood cancer "CD10(+), CD77(-) B cells" +p_12195_2 DLBCL; blood cancer CD77(+) B cells +p_12198_1 NKAES-derived NK cell Primary human NK cell +p_12198_2 NKAES-derived NK cell "NK cell, stimulated by low dose IL2" +p_12198_3 NKAES-derived NK cell "NK cell, stimulated by high dose IL2" +p_12199_1 MDA-MB-231 "MCF-7, control" +p_12205_1 "HLF cell, 1um Cr(VI) treated" "HLF cell, control" +p_12205_2 "HLF cell, 10um SOV+ 1um Cr(VI) treated" "HLF cell, control" +p_12251_1 "colonic biopsy, week 8 Response to infliximab: Yes" "colonic biopsy, week 8 Response to infliximab: No" +p_12253_1 "airway epithelial cells, Ethanol treated, 50mM" "airway epithelial cells, untreated" +p_12253_2 "airway epithelial cells, Ethanol treated, 100mM" "airway epithelial cells, untreated" +p_12254_10 "liver tissue, LCMV-ARM infected but not diseased, day 5" "liver tissue, uninfected" +p_12254_5 "liver tissue, LCMV-WE infected, day 6" "liver tissue, uninfected" +p_12254_8 "liver tissue, LCMV-WE infected, day 12" "liver tissue, uninfected" +p_12261_1 "HASMC cell, ME treated, 4h" "HASMC cell, control, 4h" +p_12261_2 "HASMC cell, ME treated, 30h" "HASMC cell, control, 30h" +p_12267_1 "hOB, mineralization, 24h" hOB confluence +p_12267_10 "hMSC, mineralization, 10-14 days" "hMSC, confluence" +p_12267_3 "hOB, mineralization, 10-14 days" hOB confluence +p_12267_8 "hMSC, mineralization, 24h" "hMSC, confluence" +p_12276_1 breast tumor metastasized to brain; cancer local breast tumor +p_12276_2 breast tumor metastasized to other regions; cancer local breast tumor +p_12278_1 "Burkitt lymphoma cell line, miR26a transfection" "Burkitt lymphoma cell line, empty vector" +p_12287_1 "ATL cell line E10, 17AAG treated, 100nM" "ATL cell line E10, mock treated" +p_12287_2 "ATL cell line E10, 17AAG treated, 300nM" "ATL cell line E10, mock treated" +p_12287_3 "ATL cell line E10, 17DMAG treated, 150nM" "ATL cell line E10, mock treated" +p_12287_4 "ATL cell line MT-2, 17AAG treated, 700nM" "ATL cell line MT-2, mock treated" +p_12287_5 "ATL cell line MT-2, 17DMAG treated, 150nM" "ATL cell line MT-2, mock treated" +p_12287_6 "ATL cell line MT-4, 17AAG treated, 500nM" "ATL cell line MT-4, mock treated" +p_12287_7 "ATL cell line MT-4, 17DMAG treated, 150nM" "ATL cell line MT-4, mock treated" +p_12305_1 "U251 cells, glioblastoma" Normal Human Astrocytes from Lonza +p_12320_1 "GBS6 cell, POU5F1 siRNA transfected" "GBS6 cell, negative control siRNA" +p_12326_1 "CD34+ cells, Peripheral blood" "CD34+ cells, Bone marrow" +p_12336_1 Xenografted 2MLN-dnTbRII tumors Xenografted 2MLN-GFP tumors +p_12355_10 "Human B cell, EBNA2, 24h" "Human B cell, CAT, control, 24h" +p_12355_3 "Human B cell, N1, 24h" "Human B cell, CAT, control, 24h" +p_12355_7 "Human B cell, N2, 24h" "Human B cell, CAT, control, 24h" +p_12366_3 Memory B cells; tissue Germinal Center B cells +p_12368_1 "Adrenal cortex, Adrenocortical adenoma" "Adrenal cortex, normal" +p_12368_2 "Adrenal cortex, Adrenocortical carcinoma" "Adrenal cortex, normal" +p_12390_2 "BJ HiPS, 6p9" "HUES8 (human ESC line), 8p30, control" +p_12390_6 "BJ HiPS, 6p9" human BJ (Donor line) +p_12400_1 "Burkitt lymphoma cell line, Namalwa, miR26a, siRNA treatment" "Burkitt lymphoma cell line, Namalwa, empty" +p_12400_2 "Raji_miR26a, siRNA treatment" Raji_empty +p_12400_3 "Ramos_ miR26a, siRNA treatment" Ramos_empty +p_12408_1 Cornelia de Lange Syndrome (CdLS) patient; lymphoblastoid cell lines; tissue healthy control +p_12408_2 Alagille syndrome patient; tissue; lymphoblastoid cell lines healthy control +p_12408_3 RBS patient; tissue; lymphoblastoid cell lines healthy control +p_12427_1 "KM-H2 cell, EBER overexpressed" "KM-H2 cell, control" +p_12427_2 "L428 cell, EBER overexpressed" "L428 cell, control" +p_12444_1 "Human primary prostate stromal cells, siRNA targeting FOXF2" "Human primary prostate stromal cells, control siRNA" +p_12446_1 "Endometrium, postmenopausal, estradiol; treated" "Endometrium, postmenopausal, control" +p_12446_2 "Endometrium, postmenopausal, estradiol + MPA; treated" "Endometrium, postmenopausal, control" +p_12446_3 "Endometrium, postmenopausal, tibolone; treated" "Endometrium, postmenopausal, control" +p_12452_1 Nasopharyngeal carcinoma; cancer Normal nasopharyngeal tissue +p_12453_1 classical Hodgkin lymphoma; blood cancer Nomral plasma +p_12453_10 centroblasts; tissue Nomral plasma +p_12453_2 nodular lymphocte-predominant Hodgkin lymphoma; blood cancer Nomral plasma +p_12453_3 T-cell rich B-cell lymphoma; blood cancer Nomral plasma +p_12453_4 follicular lymphoma; blood cancer Nomral plasma +p_12453_5 Burkitt lymphoma; blood cancer Nomral plasma +p_12453_6 diffuse large B-cell lymphoma; blood cancer Nomral plasma +p_12453_7 naive B-cells; tissue Nomral plasma +p_12453_8 memory B cells; tissue Nomral plasma +p_12453_9 centrocytes; tissue Nomral plasma +p_12460_1 "neuroblastoma, MYCN amplified; brain cancer" "neuroblastoma, MYCN non-amplified" +p_12474_1 "Skeletal muscle cell, after heating" "Skeletal muscle cell, before heating" +p_12504_1 "left ventricle biopsy, Post operation off-pump cardiac surgery" "left ventricle biopsy, pre-operation off-pump cardiac surgery" +p_12504_2 "left ventricle biopsy, Post operation on-pump cardiac surgery" "left ventricle biopsy, pre-operation on-pump cardiac surgery" +p_12510_1 "Human Umbilical Cord lining Epithelial cells, GFP integrated using Phage Integrase" "Human Umbilical Cord lining Epithelial cells, control" +p_12524_1 "293 cell, OE/ZL3 treated" "293 cell, Control" +p_12548_1 "ARPE-19 cells, TGF and TNF-treated, 1h" "ARPE-19 cells, TGF and TNF-treated, 0h" +p_12548_2 "ARPE-19 cells, TGF and TNF-treated, 6h" "ARPE-19 cells, TGF and TNF-treated, 0h" +p_12548_3 "ARPE-19 cells, TGF and TNF-treated, 16h" "ARPE-19 cells, TGF and TNF-treated, 0h" +p_12548_4 "ARPE-19 cells, TGF and TNF-treated, 24h" "ARPE-19 cells, TGF and TNF-treated, 0h" +p_12548_5 "ARPE-19 cells, TGF and TNF-treated, 42h" "ARPE-19 cells, TGF and TNF-treated, 0h" +p_12548_6 "ARPE-19 cells, TGF and TNF-treated, 60h" "ARPE-19 cells, TGF and TNF-treated, 0h" +p_12583_1 "KiPSC, obtained from reprogramming human keratinocyte, 3 factors (Oct4+Sox2+Klf4) treated" human embryonic stem cell line +p_12583_2 "KiPSC, obtained from reprogramming human keratinocyte, 4 factors (Oct4+Sox2+Klf4+cMyc) treated" human embryonic stem cell line +p_12583_3 "KiPSC, obtained from reprogramming human keratinocyte, 3 factors (Oct4+Sox2+Klf4) treated" Human foreskin fibroblast +p_12583_4 "KiPSC, obtained from reprogramming human keratinocyte, 4 factors (Oct4+Sox2+Klf4+cMyc) treated" Human foreskin fibroblast +p_12583_5 "KiPSC, obtained from reprogramming human keratinocyte, 3 factors (Oct4+Sox2+Klf4) treated" Human foreskin keratinocyte +p_12583_6 "KiPSC, obtained from reprogramming human keratinocyte, 4 factors (Oct4+Sox2+Klf4+cMyc) treated" Human foreskin keratinocyte +p_12606_1 "Kidney cell, RCC, normal" "Kidney cell, normal" +p_12606_2 "Kidney cell, RCC, tumor" "Kidney cell, normal" +p_12606_3 "Kidney cell, RCC, metastatic" "Kidney cell, normal" +p_12621_1 "retina, macula; tissue" "retina, nasal" +p_12621_2 "retina, macula; tissue" "retina, surround" +p_12631_1 "human conjunctivae (HuCNJE), non-side population" "human conjunctivae (HuCNJE), side population" +p_12644_1 "aortic valve, calcified; tissue" "aortic valve, normal" +p_12650_1 "MCF-7 cells, 10ug/ml alpha-amanitin" MCF-7 cells +p_12662_1 M0 acute myeloid leukemia (AML); blood cancer CD34+ cells +p_12662_10 M3 acute myeloid leukemia (AML); blood cancer CD34+ cells +p_12662_11 M3 acute myeloid leukemia (AML); blood cancer PMNs +p_12662_12 M3 acute myeloid leukemia (AML); blood cancer Promyelocytes +p_12662_13 M4 acute myeloid leukemia (AML); blood cancer CD34+ cells +p_12662_14 M4 acute myeloid leukemia (AML); blood cancer PMNs +p_12662_15 M4 acute myeloid leukemia (AML); blood cancer Promyelocytes +p_12662_16 FLT3 D835 mutation acute myeloid leukemia (AML); blood cancer FLT3 D835 normal acute myeloid leukemia (AML) +p_12662_17 FLT3 ITD + acute myeloid leukemia (AML); blood cancer FLT3 ITD - acute myeloid leukemia (AML) +p_12662_18 NPM1 ins + acute myeloid leukemia (AML); blood cancer NPM1 ins - acute myeloid leukemia (AML) +p_12662_19 "PR-9 cells, zinc-induced 2 hrs; treat; time course" "PR-9 cells, resting (no Zinc induction)" +p_12662_2 M0 acute myeloid leukemia (AML); blood cancer PMNs +p_12662_20 "PR-9 cells, zinc-induced 4 hrs; treat; time course" "PR-9 cells, resting (no Zinc induction)" +p_12662_21 "PR-9 cells, zinc-induced 8 hrs; treat; time course" "PR-9 cells, resting (no Zinc induction)" +p_12662_22 "PR-9 cells, zinc-induced 16 hrs; treat; time course" "PR-9 cells, resting (no Zinc induction)" +p_12662_23 "PR-9 cells, zinc-induced 24 hrs; treat; time course" "PR-9 cells, resting (no Zinc induction)" +p_12662_3 M0 acute myeloid leukemia (AML); blood cancer Promyelocytes +p_12662_4 M1 acute myeloid leukemia (AML); blood cancer CD34+ cells +p_12662_5 M1 acute myeloid leukemia (AML); blood cancer PMNs +p_12662_6 M1 acute myeloid leukemia (AML); blood cancer Promyelocytes +p_12662_7 M2 acute myeloid leukemia (AML); blood cancer CD34+ cells +p_12662_8 M2 acute myeloid leukemia (AML); blood cancer PMNs +p_12662_9 M2 acute myeloid leukemia (AML); blood cancer Promyelocytes +p_12679_1 "dorsolateral prefrontal cortex, endothelial; tissue" "dorsolateral prefrontal cortex, neuron" +p_12710_1 "direct draw, tempus tube; tissue" "heparin, tempus tube" +p_12710_2 "direct draw, PAXgene tube; tissue" "heparin, PAXgene tube" +p_12720_1 "Liver biopsy, No manipulation, Deseased donor" "Liver biopsy, No manipulation, Living donor" +p_12720_2 "Liver biopsy, Post Reperfusion, Deseased donor" "Liver biopsy, Post Reperfusion, Living donor" +p_12720_3 "Liver biopsy, Cold Preservation, Deseased donor" "Liver biopsy, Cold Preservation, Living donor" +p_12734_1 chronic lymphocytic leukemia (CLL) patient ZAP70 low; blood cancer "chronic lymphocytic leukemia (CLL) patient, ZAP70 high" +p_12734_2 "chronic lymphocytic leukemia (CLL), ZAP70 mutated; blood cancer" "chronic lymphocytic leukemia (CLL), ZAP70 wild type" +p_12734_3 "chronic lymphocytic leukemia (CLL), LPL+; blood cancer" "chronic lymphocytic leukemia (CLL), LPL-" +p_12734_4 "chronic lymphocytic leukemia (CLL), CD38+; blood cancer" "chronic lymphocytic leukemia (CLL), CD38-" +p_12763_1 Her2 type breast cancer luminal type breast cancer +p_12763_2 basal-like breast cancer luminal type breast cancer +p_12764_1 "MCF10A cell, HRas vector treated" "MCF10A cell, null vector" +p_12764_2 "MCF10A cell, MEK1 vector treated" "MCF10A cell, null vector" +p_12767_1 "chorionic villus sampling, preeclamsia" "chorionic villus sampling, control" +p_12773_1 "monocyte-derive dendritic cells, differentiated without AEC" "monocyte-derive dendritic cells, control" +p_12777_1 Basal type breast cancer cell line Luminal type breast cancer cell line +p_12777_2 HER2 amplified breast cancer cell line HER2 non-amplified breast cancer cell line +p_12806_1 "Dendritic cells, Chlamydia pneumoniae infected" "Dendritic cells, non infected MOCK control" +p_12814_1 female non-del(7q) fibroid; uterus cancer female myometrium +p_12814_2 female with del(7q) fibroid; uterus cancer female myometrium +p_12843_1 LM6 cell AM3 cell +p_12846_1 "LEC, Prox1 silenced" "LEC, control" +p_12846_2 "LEC, NR2F2 silenced" "LEC, control" +p_12846_3 "LEC, NR2F2,Prox1 silenced" "LEC, control" +p_12854_1 "OVCAR8, RIA transfectant" "OVCAR8, control" +p_12854_2 "OVCAR8, RIIB transfectant" "OVCAR8, control" +p_12875_1 "CD4+ T-cell, novel ICOS patient" "CD4+ T-cell, normal" +p_12875_2 "CD4+ T-cell, novel ICOS patient, aCD28+aCD3 treated" "CD4+ T-cell, normal, aCD28+aCD3 treated" +p_12886_1 "PLC/PRF/5 cells, WT1 specific siRNA duplexes transfected" "PLC/PRF/5 cells, control siRNA duplexes transfected" +p_12891_1 "Outgrowth endothelial cell, differentiated from human umbilical cord blood derived-endothelial progenitor" "endothelial progenitor cell, human umbilical cord blood derived, control" +p_12917_1 "human mammary epithelial cell, RhoA G14V" "human mammary epithelial cell, control" +p_12917_2 "human mammary epithelial cell, RhoA T37A" "human mammary epithelial cell, control" +p_12917_3 "human mammary epithelial cell, RhoA wild type" "human mammary epithelial cell, control" +p_12949_1 Glioblastma Multiforme exposed to cilengitide for 8 hrs; treated Glioblastma Multiforme with no exposure to cilengtide +p_12949_2 Glioblastma Multiforme exposed to cilengitide for 4 hrs; treated Glioblastma Multiforme with no exposure to cilengtide +p_12963_1 "Human CD4+ T-lymphocyte, HIV Vpr- infected" "Human CD4+ T-lymphocyte, GFP treated" +p_12963_2 "Human CD4+ T-lymphocyte, HIV Vpr+ infected" "Human CD4+ T-lymphocyte, GFP treated" +p_12992_1 CTNNB1 mutant pediatric medulloblastoma; brain cancer CTNNB1 WT pediatric medulloblastoma +p_12992_2 large cell/anaplastic pediatric medulloblastoma; brain cancer classic pediatric medulloblastoma +p_12992_3 medullomyoblastoma; brain cancer classic pediatric medulloblastoma +p_12992_4 nodular demoplastic pediatric medulloblastoma; brain cancer classic pediatric medulloblastoma +p_13002_1 "multi oitent stromal cells, outside of colony" "multi oitent stromal cells, inside of colony" +p_13027_1 "Endometrium, on day of oocyte retrieval, dated as d4 of the luteal phase by Noyes' criteria, not pregnant" "Endometrium, on day of oocyte retrieval, dated as d2 or d3 of the luteal phase by Noyes' criteria, not pregnant" +p_13054_1 "HUVEC cell, empty adenovirus treated" "HUVEC cell, control" +p_13054_2 "HUVEC cell, HLX expressing adenovirus treated" "HUVEC cell, control" +p_13059_1 primary cells at 0h; tissue; time course tissue at reference +p_13059_2 primary cells at 24h; tissue; time course tissue at reference +p_13059_3 primary cells at 72h; tissue; time course tissue at reference +p_13067_1 "primary colorectal adenocarcinoma, Microsatellite Instable" "primary colorectal adenocarcinoma, Microsatellite Stable" +p_13073_1 "MSCs, Exposed to Keratinocyte Condition Medium, 30 days" "MSCs, Exposed to Keratinocyte Growth Medium, 30 days" +p_13122_1 Lcl-balanced Lcl-control +p_13122_2 Lcl-unbalanced Lcl-control +p_13124_1 "MCF-7 cells, NSC76022 (thaspine) treated" MCF-7 cells. DMSO control +p_13136_1 "MYC amplification, glioma; brain cancer" No MYC amplified glioma +p_13136_2 1p del glioma; brain cancer No 1p del glioma +p_13136_3 11q del glioma; brain cancer No 11q del glioma +p_13136_4 17q gain glioma; brain cancer No 17q gain glioma +p_13139_11 aortic endothelial cells treated with LOX1 oxLDL 24hr; time course LOX1 Untreated 24hr +p_13139_12 aortic endothelial cells treated with LOX1 oxLDL 2hr; time course LOX1 Untreated 2hr +p_13139_15 aortic endothelial cells LOX1 Untreated 24hr; time course GFP Untreated 24hr +p_13139_16 aortic endothelial cells LOX1 Untreated 2hr; time course GFP Untreated 2hr +p_13139_3 aortic endothelial cells treated with LOX1 oxLDL 24hr; time course GFP oxLDL 24hr +p_13139_4 aortic endothelial cells treated with LOX1 oxLDL 2hr; time course GFP oxLDL 2hr +p_13139_7 aortic endothelial cells treated with GFP oxLDL 24hr; time course GFP Untreated 24hr +p_13139_8 aortic endothelial cells treated with GFP oxLDL 2hr; time course GFP Untreated 2hr +p_13142_1 "HepG2/C3A cells, cultured in leucine-devoid DMEM (-LEU), 42h" "HepG2/C3A cells, cultured in complete DMEM (+LEU), 42h" +p_13205_1 "muscle, septic; tissue" "muscle, control" +p_13210_1 "Raji cell, CD9 transfected" "Raji cell, control" +p_13218_1 "MCF10A cell, YAP wt infected" "MCF10A cell, vector infected" +p_13218_2 "MCF10A cell, YAP-S94A infected" "MCF10A cell, vector infected" +p_13218_3 "MCF10A cell, YAP-W1W2 infected" "MCF10A cell, vector infected" +p_13218_4 MCF10A human mammary epithelial cell line with pQCXIH-YAP-S94A MCF10A human mammary epithelial cell line with pQCXIH-YAP-WT +p_13218_5 MCF10A human mammary epithelial cell line with pQCXIH-YAP-W1W2 MCF10A human mammary epithelial cell line with pQCXIH-YAP-WT +p_13234_1 "Treg cell, THU" "Treg cell, GFP , control" +p_13234_2 "Treg cell, FoxP3" "Treg cell, GFP , control" +p_13234_3 "Treg cell, Garp" "Treg cell, GFP , control" +p_13273_1 "SY5Y cell, control siLSD1 treated" "SY5Y cell, control siRNA treated" +p_13274_1 Quiescent Ad-HER2-ki infected HMECs Quiescent AD-GFP infected HMECs +p_13274_2 Quiescent Ad-HER2-ki infected HMECs Quiescent Ad-HER2wt infected HMECs +p_13284_1 "CD34-derived erythroid progenitors, BCL11A-targeting siRNA" "CD34-derived erythroid progenitors, non-targeting siRNA, control" +p_13294_1 "primary colorectal adenocarcinoma, Microsatellite Instable" "primary colorectal adenocarcinoma, Microsatellite Stable" +p_13296_1 "DC cell, Anti-miR-155" "DC cell, scramble LNA, control" +p_13296_2 "DC cell, Anti-miR-155, LPS treated" "DC cell, scramble LNA, control, LPS treated" +p_13300_1 "new emigrant B cells, non stimulated" "mature naive B cells, non stimulated" +p_13307_1 "hNPC cell, derived from VM" "hNPC cell, derived from CTX" +p_13309_1 "A549 cells, treated with Tobacco smoking condensate, 0.0005puffs/ml" "A549 cells, control" +p_13309_2 "A549 cells, treated with Tobacco smoking condensate, 0.001puffs/ml" "A549 cells, control" +p_13309_3 "A549 cells, treated with Tobacco smoking condensate, 0.003puffs/ml" "A549 cells, control" +p_13309_4 "Calu-6 cells, treated with Tobacco smoking condensate, 0.0005puffs/ml" "Calu-6 cells, control" +p_13309_5 "Calu-6 cells, treated with Tobacco smoking condensate, 0.001puffs/ml" "Calu-6 cells, control" +p_13309_6 "Calu-6 cells, treated with Tobacco smoking condensate, 0.003puffs/ml" "Calu-6 cells, control" +p_13314_1 "Pulmonary mucosa-associated lymphoid tissue (MALT), MALT lymphoma" "Pulmonary mucosa-associated lymphoid tissue (MALT), normal" +p_13314_2 IgH-MALT1 lymphoma; cancer None pulmonary lymphoma +p_13315_1 "721 lymphoblastoid cells, DomNeg1-encoding retroviral vector, EBNA1 inhibition" "721 lymphoblastoid cells, empty retroviral vector" +p_13319_1 Leiomyoma; uterus cancer Myometrium +p_13330_1 "Human Foreskin BJ fibroblasts, late passage" "Human Foreskin BJ fibroblasts, young passage" +p_13330_2 "Human Foreskin BJ fibroblasts, bleomycin treated" "Human Foreskin BJ fibroblasts, young passage" +p_13351_1 "precursor-B acute lymphoblastic leukemia (ALL), subtype: TEL-AML1; blood cancer" T-acute lymphoblastic leukemia (ALL) +p_13351_2 "precursor-B acute lymphoblastic leukemia (ALL), subtype: Hyperdiploid; blood cancer" T-acute lymphoblastic leukemia (ALL) +p_13351_3 "precursor-B acute lymphoblastic leukemia (ALL), subtype: E2A-rearranged; blood cancer" T-acute lymphoblastic leukemia (ALL) +p_13351_4 "precursor-B acute lymphoblastic leukemia (ALL), subtype: MLL; blood cancer" T-acute lymphoblastic leukemia (ALL) +p_13351_5 "precursor-B acute lymphoblastic leukemia (ALL), subtype: other; blood cancer" T-acute lymphoblastic leukemia (ALL) +p_13353_1 "aneurysm, ruptured aneurysm" "aneurysm, unruptured aneurysm" +p_13355_1 "non-lesional skin, psoriatic patient" Normal skin +p_13355_2 "lesional skin, psoriatic patient" Normal skin +p_13367_1 "Human colonic mucosa biopsy, UC inflamed" "Human colonic mucosa biopsy, control" +p_13367_2 "Human colonic mucosa biopsy, UC non-inflamed" "Human colonic mucosa biopsy, control" +p_13367_3 UC inflamed colonocyte normal colonocytes +p_13367_4 UC non-inflamed colonocyte normal colonocytes +p_13367_5 Collagen colitis colon tissue normal colon +p_13367_6 Collagen colitis colonocyte normal colonocytes +p_13378_1 "HET-1A cell, exposed to DCA, 4h" "HET-1A cell, control, 4h" +p_13378_2 "HET-1A cell, exposed to DCA, 8h" "HET-1A cell, control, 8h" +p_13378_3 "HET-1A cell, exposed to DCA, 12h" "HET-1A cell, control, 12h" +p_13378_4 "HET-1A cell, exposed to DCA, 24h" "HET-1A cell, control, 24h" +p_13396_1 "PBE cell, mock infected, asthmatic patient" "PBE cell, mock infected, normal" +p_13396_2 "PBE cell, HRV infected, asthmatic patient" "PBE cell, HRV infected, normal" +p_13396_3 "mock-infected PBE cells, asthmatic; treat" "mock-infected PBE cells, normal" +p_13396_4 "HRV-infected PBE cells, asthmatic; treat" "HRV-infected PBE cells, normal" +p_13401_1 "DLBCL cell, PU-H71 exposed , 6h" "DLBCL cell, control" +p_13401_2 "DLBCL cell, PU-H71 exposed , 12h" "DLBCL cell, control" +p_13434_1 "Hela cell, aiRNA treated" "Hela cell, mock treated" +p_13434_2 "Hela cell, siRNA treated" "Hela cell, mock treated" +p_13458_1 "MCF-7 cell, luciferase ko, Estradiol treated" "MCF-7 cell, luciferase ko, control" +p_13458_2 "MCF-7 cell, NMNAT1 ko, Estradiol treated" "MCF-7 cell, NMNAT1 ko, control" +p_13458_3 MCF-7 cells_NMNAT1 knockdown_E2; treated MCF-7 cells_luciferase knockdown_E2 +p_13458_4 MCF-7 cells_NMNAT1 knockdown_control; treated MCF-7 cells_luciferase knockdown_control +p_13471_1 Colon tumor Normal colon +p_13475_1 "choriocarcinoma cells, STOX1 overexpression" "choriocarcinoma cells, control" +p_13477_1 "MCF7 cells, ARC treated, 2uM, 24h" "MCF7 cells, control" +p_13477_2 "MCF7 cells, Sangivamycin treated, 2uM, 24h" "MCF7 cells, control" +p_13477_3 "MCF7 cells, Doxorubicin treated, 2uM, 24h" "MCF7 cells, control" +p_13487_1 RAF inhibitor-1 treatment of A375 parental cells DMSO treatment of A375 parental cells +p_13487_10 No treatment of A375 shBRAF-2 cells No treatment of A375 shGFP cells +p_13487_11 No treatment of A375 shBRAF-1 cells No treatment of A375 shGFP cells +p_13487_2 BAY-43-9006 treatment of A375 parental cells DMSO treatment of A375 parental cells +p_13487_3 RAF inhibitor-1 treatment of A375 shBRAF-2 cells No treatment of A375 shBRAF-2 cells +p_13487_4 BAY-43-9006 treatment of A375 shBRAF-2 cells No treatment of A375 shBRAF-2 cells +p_13487_5 Doxycycline treatment of A375 shBRAF-2 cells No treatment of A375 shBRAF-2 cells +p_13487_6 RAF inhibitor-1 treatment of A375 shBRAF-1 cells No treatment of A375 shBRAF-1 cells +p_13487_7 Doxycycline treatment of A375 shBRAF-1 cells No treatment of A375 shBRAF-1 cells +p_13487_8 RAF inhibitor #2 treatment of A375 shGFP cells No treatment of A375 shGFP cells +p_13487_9 Doxycycline treatment of A375 shGFP cells No treatment of A375 shGFP cells +p_13488_1 "peripheral blood leukocyte, late respiratory recovery" "peripheral blood leukocyte, early respiratory recovery" +p_13491_1 "Umbrilical cord blood derived MSC, differentiated state" "Umbrilical cord blood derived MSC, native state" +p_13501_1 "PBMC, enthesitis-related arthritis; tissue" "PBMC, control" +p_13501_2 "PBMC, persistent oligoarthritis; tissue" "PBMC, control" +p_13501_3 "PBMC, RF- polyarthritis; tissue" "PBMC, control" +p_13501_4 "PBMC, systemic; tissue" "PBMC, control" +p_13503_1 "U937 cells, hyperthermia treated, 0h" "U937 cells, control" +p_13503_2 "U937 cells, hyperthermia treated, 1h" "U937 cells, control" +p_13503_3 "U937 cells, hyperthermia treated, 3h" "U937 cells, control" +p_13503_4 "U937 cells, hyperthermia treated, 6h" "U937 cells, control" +p_13504_1 "Saos2 cell, p53 treated" "Saos2 cell, GFP treated" +p_13504_2 "Saos2 cell, TAp73beta treated" "Saos2 cell, GFP treated" +p_13525_1 "epithelial ovarian cancer, carboplatin 24hr; treat; time course" "epithelial ovarian cancer, control 24hr" +p_13525_2 "epithelial ovarian cancer, carboplatin 30hr; treat; time course" "epithelial ovarian cancer, control 30hr" +p_13525_3 "epithelial ovarian cancer, carboplatin 36hr; treat; time course" "epithelial ovarian cancer, control 36hr" +p_13548_1 "HeLa, glucose-free 15hr; treated; time course" "HeLa, normal growth 15hr" +p_13548_10 "HT29, glucose-free 18hr; treated; time course" "HT29, normal growth 18hr" +p_13548_11 "HT29, glucose-free & VST 18hr; treated; time course" "HT29, normal growth & VST 18hr" +p_13548_12 "HT1080, glucose-free 18hr; treated; time course" "HT1080, normal growth 18hr" +p_13548_13 "HT1080, glucose-free &VST 18hr; treated; time course" "HT1080, normal growth & VST 18hr" +p_13548_14 "HT1080, 2-deoxyglucose & buformin18hr; treated; time course" "HT1080, normal growth & buformin 18hr" +p_13548_15 "HT1080, 2-deoxyglucose & metformin 18hr; treated; time course" "HT1080, normal growth & metformin 18hr" +p_13548_16 "HT1080, 2-deoxyglucose & phenformin 18hr; treated; time course" "HT1080, normal growth & phenformin 18hr" +p_13548_17 "HT1080, 2-deoxyglucose & pyrvinium pamoate 18hr; treated; time course" "HT1080, normal growth & pyrvinium pamoate 18hr" +p_13548_18 "HT1080, 2-deoxyglucose & VST 18hr; treated; time course" "HT1080, 2-deoxyglucose 18hr" +p_13548_19 "HT1080, 2-deoxyglucose & buformin18hr; treated; time course" "HT1080, 2-deoxyglucose 18hr" +p_13548_2 "HeLa, glucose-free & buformin15hr; treated; time course" "HeLa, normal growth 15hr" +p_13548_20 "HT1080, 2-deoxyglucose & metformin 18hr; treated; time course" "HT1080, 2-deoxyglucose 18hr" +p_13548_21 "HT1080, 2-deoxyglucose & phenformin 18hr; treated; time course" "HT1080, 2-deoxyglucose 18hr" +p_13548_22 "HT1080, 2-deoxyglucose & pyrvinium pamoate 18hr; treated; time course" "HT1080, 2-deoxyglucose 18hr" +p_13548_23 "HT1080, tunicamycin & VST 18hr; treated; time course" "HT1080, tunicamycin 18hr" +p_13548_24 "MKN74, glucose-free" "MKN74, normal growth 18hr" +p_13548_25 "MKN74, glucose-free & VST 18hr; treated; time course" "MKN74, normal growth & VST 18hr" +p_13548_3 "HeLa, glucose-free & metformin15hr; treated; time course" "HeLa, normal growth 15hr" +p_13548_4 "HeLa, glucose-free & phenformin_15h; treated; time course" "HeLa, normal growth 15hr" +p_13548_5 "HeLa, glucose-free 18hr; treated; time course" "HeLa, normal growth 18hr" +p_13548_6 "HeLa, glucose-free & VST 18hr; treated; time course" "HeLa, normal growth & VST 18hr" +p_13548_7 "HeLa, 2-deoxyglucose 18h; treated; time course" "HeLa, normal growth 18hr" +p_13548_8 "HeLa, 2-deoxyglucose & VST 18h; treated; time course" "HeLa, 2-deoxyglucose 18h" +p_13548_9 "HeLa, tunicamycin_18h; treated; time course" "HeLa, normal growth 18hr" +p_13568_1 "M5 cells, enhanced metastatic abilities to liver" "SW480 cells, relatively low metastatic abilities to liver" +p_13576_1 "white blood cell, pediatric acute leukemia, early relapse" "white blood cell, pediatric acute leukemia, no relapse" +p_13576_2 "white blood cell, pediatric acute leukemia, late relapse" "white blood cell, pediatric acute leukemia, no relapse" +p_13576_3 "white blood cell, pediatric acute leukemia, late relapse" "white blood cell, pediatric acute leukemia, early relapse" +p_13604_1 "hMSC, BMP6 treated, 8h" "hMSC, control" +p_13606_1 "human dermal skin fibroblasts, treatead with PAPC, 100ug/ml, 4h" "human dermal skin fibroblasts, control" +p_13606_2 "human dermal skin fibroblasts, treatead with OXPAPC, 100ug/ml, 4h" "human dermal skin fibroblasts, control" +p_13606_3 "human dermal skin fibroblasts, treatead with UV-PAPC" "human dermal skin fibroblasts, control" +p_13606_4 "human dermal skin fibroblasts, treatead with UVA-1, 4h" "human dermal skin fibroblasts, control" +p_13606_5 "human dermal skin fibroblasts, treatead with RB-PAPC" "human dermal skin fibroblasts, control" +p_13637_1 "HUVEC, FPV-infected" "HUVEC, untreated control" +p_13637_10 FPV-infected IKK2kd-transfected HUVEC FPV-infected HUVEC +p_13637_11 FPV-infected pEGZ-transfected HUVEC FPV-infected HUVEC +p_13637_12 H5N1-infected IKK2kd-transfected HUVEC H5N1-infected HUVEC +p_13637_13 H5N1-infected pEGZ-transfected HUVEC H5N1-infected HUVEC +p_13637_14 PR8-infected IKK2kd-transfected HUVEC PR8-infected HUVEC +p_13637_15 PR8-infected pEGZ-transfected HUVEC PR8-infected HUVEC +p_13637_2 "HUVEC, PR8-infected" "HUVEC, untreated control" +p_13637_3 "HUVEC, H5N1-infected" "HUVEC, untreated control" +p_13637_4 "IKK2kd-transfected HUVEC, H5N1-infected," "pEGZ-transfected HUVEC,H5N1-infected, control" +p_13637_5 "IKK2kd-transfected HUVEC, FPV-infected," "pEGZ-transfected HUVEC, FPV-infected, control" +p_13637_6 "IKK2kd-transfected HUVEC, PR8-infected," "pEGZ-transfected HUVEC, PR8-infected, control" +p_13637_7 PR8-infected HUVEC HUVEC control +p_13637_8 PR8-infected IKK2kd-transfected HUVEC HUVEC control +p_13637_9 PR8-infected pEGZ-transfected HUVEC HUVEC control +p_13639_1 "HeLa, siDrosha 24hr; siRNA treated; time course" "HeLa, siGFP 24hr" +p_13639_2 "HeLa, siCGCR8 24hr; siRNA treated; time course" "HeLa, siGFP 24hr" +p_13639_3 "HeLa, siDrosha 48hr; siRNA treated; time course" "HeLa, siGFP 48hr" +p_13639_4 "HeLa, siCGCR8 48hr; siRNA treated; time course" "HeLa, siGFP 48hr" +p_13662_1 "MM1S, Zalypsis; treated" "MM1S, control" +p_13662_2 "OPM1, Zalypsis; treated" "OPM1, control" +p_13670_1 "human monocyte-derived macrophages, S. aureus-treated, 8h" "human monocyte-derived macrophages, control, 8h" +p_13670_2 "human monocyte-derived macrophages, S. aureus-treated, 24h" "human monocyte-derived macrophages, control, 24h" +p_13670_3 "human monocyte-derived macrophages, S. aureus-treated, 48h" "human monocyte-derived macrophages, control, 48h" +p_13671_1 "Breast epithelial cell, BRCA1 carrier" "Breast epithelial cell, control" +p_13712_1 "HUVEC, old, static" "HUVEC, young, static" +p_13712_2 "HUVEC, old, shear" "HUVEC, young, shear" +p_13712_3 "HUVECs, young & shear; tissue" "HUVECs, young & static" +p_13712_4 "HUVECs, old & shear; tissue" "HUVECs, old & static" +p_13715_1 "NP cell, 2d before differentiation" "NP cell, neural sphere" +p_13715_2 "NP cell, 3d before differentiation" "NP cell, neural sphere" +p_13715_3 "NP cell, 2d after differentiation" "NP cell, neural sphere" +p_13715_4 "NP cell, 3d after differentiation" "NP cell, neural sphere" +p_13732_1 "CD4+ Tcells, Clinically Isolated Syndrome (CIS)" "CD4+ Tcells, healthy control" +p_13732_2 "CD4+ Tcells, Clinically Isolated Syndrome (CIS), resampled after 1 year" "CD4+ Tcells, healthy control, resampled after 1 year" +p_13736_1 "HUVEC, S. aureus infected, septic patient" "HUVEC, positive control" +p_13736_2 "HUVEC, S. aureus infected, septic patient" "HUVEC, negative control" +p_13736_3 "HUVEC, S. aureus infected, septic patient" "HUVEC, S. aureus infected, normal people" +p_13738_1 "T cell, directly activated" "T cell, control" +p_13738_2 "T cell, bystander activated" "T cell, control" +p_13762_1 "5d immature dendritic cell, treated with 1,25-vitD, 10 nM, 5 days" "5d immature dendritic cell, treated with vehicle, 5 days" +p_13762_2 "26h differentiating human dendritic cell, treated with 1,25-vitD for 12h, 10 nM 1,25-vitD added 14h after separation" "26h differentiating human dendritic cell, vehicle treated, 12h, vehicle added 14h after separation" +p_13763_1 "IGROV cell, CXCR4 silenced" "IGROV cell, control" +p_13763_2 "IGROV-1, shCXCR4-2; shRNA treated" "IGROV-1, control" +p_13763_3 "IGROV-1, shCXCR4-1; shRNA treated" "IGROV-1, mock" +p_13763_4 "IGROV-1, shCXCR4-2; shRNA treated" "IGROV-1, mock" +p_13787_1 "Breast cancer sample, basal-like" "Breast cancer sample, her2+" +p_13791_1 Fibroblasts infected with T. cruzi Fibroblasts uninfected control +p_13791_2 Fibroblasts on infected transwell top Fibroblasts on control transwell top +p_13791_3 Endothelial cells infected with T. cruzil Endothelial cells uninfected control +p_13791_4 Endothelial cells on infected transwell top Endothelial cells on control transwell top +p_13791_5 Smooth muscle cells infected with T. cruzi for 24 h "Smooth muscle cells uninfected control, 24 h" +p_13791_6 Smooth muscle cells infected with T. cruzi for 48 h "Smooth muscle cells uninfected control, 48 h" +p_13806_1 "MDA-MB-231 cell, sFRP1 treated, in vitro" "MDA-MB-231 cell, control, in vitro" +p_13806_2 "MDA-MB-231 cell, sFRP1 treated, in vivo" "MDA-MB-231 cell, control, in vivo" +p_13811_1 "chronic lymphocytic leukemia (CLL), NLC 14days; treated" "chronic lymphocytic leukemia (CLL), control" +p_13816_1 "PBMC, from SJS patients" "blister cells, from SJS patients" +p_13818_1 786-O cells treated with compound 40 786-O cells treated with DMSO +p_13818_2 786-O cells treated with compound 41 786-O cells treated with DMSO +p_13818_3 786-O cells treated with compound 76 786-O cells treated with DMSO +p_13818_4 786-O cells treated with compound 77 786-O cells treated with DMSO +p_13818_5 HIF-2a shRNAi in 786-O cells; treated shRNA vector only control 786-O cells (pTV) +p_13818_6 VHL reconstituted 786-O cells (WT8); treated Vector only 786-O cells (PRC3) +p_13827_1 "Melanocyte, BRAF treated" "Melanocyte, control" +p_13828_1 iPSC derived from SMA (Spinal muscular atrophy) human embryonic stem cell line +p_13828_2 iPSC derived from SMA (Spinal muscular atrophy) "Human Fibroblast cells, SMA patients" +p_13837_1 "rheumatoid arthritis (RA) patient, TGF stimulated 1hr; treated; time course" "RA patient, TGF stimulated 0hr" +p_13837_10 "osteoarthritis (OA) patient, TNF stimulated 1hr; treated; time course" "OA patient, TNF stimulated 0hr" +p_13837_11 "osteoarthritis (OA) patient, TGF stimulated 2hr; treated; time course" "OA patient, TGF stimulated 0hr" +p_13837_12 "osteoarthritis (OA) patient, TNF stimulated 2hr; treated; time course" "OA patient, TNF stimulated 0hr" +p_13837_13 "osteoarthritis (OA) patient, TGF stimulated 4hr; treated; time course" "OA patient, TGF stimulated 0hr" +p_13837_14 "osteoarthritis (OA) patient, TNF stimulated 4hr; treated; time course" "OA patient, TNF stimulated 0hr" +p_13837_15 "osteoarthritis (OA) patient, TGF stimulated 12hr; treated; time course" "OA patient, TGF stimulated 0hr" +p_13837_16 "osteoarthritis (OA) patient, TNF stimulated 12hr; treated; time course" "OA patient, TNF stimulated 0hr" +p_13837_2 "rheumatoid arthritis (RA) patient, TNF stimulated 1hr; treated; time course" "RA patient, TNF stimulated 0hr" +p_13837_3 "rheumatoid arthritis (RA) patient, TGF stimulated 2hr; treated; time course" "RA patient, TGF stimulated 0hr" +p_13837_4 "rheumatoid arthritis (RA) patient, TNF stimulated 2hr; treated; time course" "RA patient, TNF stimulated 0hr" +p_13837_5 "rheumatoid arthritis (RA) patient, TGF stimulated 4hr; treated; time course" "RA patient, TGF stimulated 0hr" +p_13837_6 "rheumatoid arthritis (RA) patient, TNF stimulated 4hr; treated; time course" "RA patient, TNF stimulated 0hr" +p_13837_7 "rheumatoid arthritis (RA) patient, TGF stimulated 12hr; treated; time course" "RA patient, TGF stimulated 0hr" +p_13837_8 "rheumatoid arthritis (RA) patient, TNF stimulated 12hr; treated; time course" "RA patient, TNF stimulated 0hr" +p_13837_9 "osteoarthritis (OA) patient, TGF stimulated 1hr treated; time course" "OA patient, TGF stimulated 0hr" +p_13849_1 "PBMC, RF- polyarthritis; blood tissue" "PBMC, control" +p_13849_2 "PBMC, RF+ polyarthritis; blood tissue" "PBMC, control" +p_13887_1 "T cells, stimulated through CD3/CD28, 24h" "T cells, unstimulated" +p_13887_2 "T cells, stimulated through Nitric Oxide (NOC-18), 600uM, 24h" "T cells, unstimulated" +p_13887_3 "T cells, unstimulated, SLE (Lupus) patients" "T cells, unstimulated" +p_13896_1 "alveolar macrophages, chronic obstructive pulmonary disease (COPD); tissue" "alveolar macrophages, non-smoker" +p_13896_2 "alveolar macrophages, smoker; tissue" "alveolar macrophages, non-smoker" +p_13899_1 "CD14+ monocytes, daily supplimentation of quercetin, 150mg per day, 2 weeks" "CD14+ monocytes, untreated" +p_13904_1 "White blood cell, SIRS" "White blood cell, normal" +p_13904_2 "White blood cell, sepsis" "White blood cell, normal" +p_13904_3 "White blood cell, septic shock" "White blood cell, normal" +p_13904_4 children sepsis day3; treated "children, control" +p_13904_5 children septic shock day1; treated "children, control" +p_13904_6 children septic shock day3; treated "children, control" +p_13904_7 children SIRS resolved day3; treated "children, control" +p_13906_1 "Gamma delta T cell, nasal T cell lymphoma" "Gamma delta T cell, normal" +p_13906_2 "Gamma delta T cell, chronic active EBV infection" "Gamma delta T cell, normal" +p_13906_3 Gamma-delta T cell line derived from patient with nasal T cell lymphoma; treat Normal lymphocyte +p_13906_4 Gamma-delta T cell line derived from patient with chronic active EBV infection Normal lymphocyte +p_13909_1 IL-2 dependent normal PB T lymphocytes after IL-2 withdrawal treated IL-2 dependent normal peripheral blood T lymphocytes from IL-2-containing cultures +p_13909_2 spontaneously immortalised T lymphocytes after IL-2 withdrawal treated spontaneously immortalised normal spleen-derived T lymphocytes from IL-2-containing cultures +p_13909_3 "spontaneously immortalised T lymphocytes of NBS patient, after IL-2 withdrawal treated" "spontaneously immortalised PBMC-derived T lymphocytes of NBS patient, from IL-2-containing cultures" +p_13911_1 Gastric tumor tissue Adjacent normal tissue +p_13911_2 MSI gastric tumor; stomach cancer MSS gastric tumor +p_13917_1 "anergic naive B cells, Rheumatoid Arthritis patients, unstimulated" "mature naive B cells, Rheumatoid Arthritis patients, unstimulated" +p_13917_2 "anergic naive B cells, Common Variable Immunodeficiency Disease patients, unstimulated" "mature naive B cells, Common Variable Immunodeficiency Disease patients, unstimulated" +p_13931_1 "small airway epithelial cells, normal smokers" "small airway epithelial cells, healthy non-smokers" +p_13931_2 "alveolar macrophages, normal smoker" "alveolar macrophages, healthy non-smoker" +p_13933_1 "small airways, smoker; lung tissue" "small airways, non-smoker" +p_13933_2 "trachea, smoker; lung tissue" "trachea, non-smoker" +p_13975_1 MGIO labelled fMSC "fMSC, control" +p_13975_2 Ferucarbutran labelled fMSC "fMSC, control" +p_13985_1 "white blood cells, Familial hypercholesterolemia" "white blood cells, control" +p_13987_1 "chronic lymphocytic leukemia (CLL) donor, rolipram treated" "chronic lymphocytic leukemia (CLL) donor, control" +p_13987_2 "B cell donor, rolipram treated" "B cell donor, control" +p_13987_3 "T cell donor, rolipram treated" "T cell donor, control" +p_14000_1 "monocyte-derived dendritic cells, total RNA, 0h" "monocyte-derived dendritic cells, polysomal RNA, 0h" +p_14000_2 "monocyte-derived dendritic cells, total RNA, 4h" "monocyte-derived dendritic cells, polysomal RNA, 4h" +p_14000_3 "monocyte-derived dendritic cells, total RNA, 16h" "monocyte-derived dendritic cells, polysomal RNA, 16h" +p_14000_4 LPS stimulated monocyte-derived dendritic cells; 16h total RNA 0h_TotRNA +p_14001_1 "Ovarian serous carcinoma, low-grade" "human ovarian epithelial cells (HOSE), normal control" +p_14001_2 "Ovarian serous carcinoma, high-grade" "human ovarian epithelial cells (HOSE), normal control" +p_14011_1 "H929 cells, pristimerin treated, 500nM, 4h" "H929 cells, DMSO treated, 4h, control" +p_14017_1 "breast cancer, bone metastasis" "breast cancer, lung metastasis" +p_14017_2 "breast cancer, brain metastasis" "breast cancer, lung metastasis" +p_14017_3 "breast cancer, brain metastasis" "breast cancer, bone metastasis" +p_14054_1 "HeLa cell, Imp8siRNA, total RNA" "HeLa cell, control, total RNA" +p_14054_2 "HeLa cell, TNRC6Bsi, total RNA" "HeLa cell, control, total RNA" +p_14054_3 "HeLa cell, Imp8siRNA, Iped RNA" "HeLa cell, control, Iped RNA" +p_14062_1 "White blood cell, ALL with MLL" "White blood cell, ALL without MLL" +p_14062_2 "White blood cell, AML with MLL" "White blood cell, AML without MLL" +p_14103_1 "HCT116, Nocodazole 7hr; cell line treatment; time course" "HCT116, control 7hr" +p_14103_2 "HCT116, Nocodazole 8hr; cell line treatment; time course" "HCT116, control 8hr" +p_14103_3 "HCT116, Nocodazole 9hr; cell line treatment; time course" "HCT116, control 9hr" +p_14103_4 "HCT116, Nocodazole 10hr; cell line treatment; time course" "HCT116, control 10hr" +p_14231_1 "833K cell, cisplatin resistant" "833K cell, control" +p_14231_2 "GCT27 cell, cisplatin resistant" "GCT27 cell, control" +p_14231_3 "Susa cell, cisplatin resistant" "Susa cell, control" +p_14245_1 "saliva, early pancreatic cancer" "saliva, healthy control" +p_14257_1 "HT29 cells, HERV-HX knock-down" "HT29 cells, control" +p_14278_1 "CD4+ T cells, HIV resistant" "CD4+ T cells, HIV high-risk negative" +p_14302_1 "P493-6 cell, Lin28B vector, Tet- , Myc+" "P493-6 cell, empty vector, Tet- , Myc+" +p_14302_2 "P493-6 cell, Lin28B vector, Tet+ , Myc-" "P493-6 cell, empty vector, Tet+ , Myc-" +p_14302_3 P493-6 MSCV-Lin28B +tet (low Myc) treated "P493-6 MSCV-empty, low Myc" +p_14302_4 P493-6 MSCV-Lin28B -tet (high Myc) treated "P493-6 MSCV-empty, high Myc" +p_14315_1 "A549 cell line, aza treatment" "A549 cell line, untreated" +p_14315_10 "SW2 Cell line, aza treatment" "SW2 Cell line, untreated" +p_14315_2 "H460 Cell line, aza treatment" "H460 Cell line, untreated" +p_14315_3 "H125 Cell line, aza treatment" "H125 Cell line, untreated" +p_14315_4 "ZL25 Cell line, aza treatment" "ZL25 Cell line, untreated" +p_14315_5 "Calu3 Cell line, aza treatment" "Calu3 Cell line, untreated" +p_14315_6 "Hotz Cell line, aza treatment" "Hotz Cell line, untreated" +p_14315_7 "U1752 Cell line, aza treatment" "U1752 Cell line, untreated" +p_14315_8 "Calu1 Cell line, aza treatment" "Calu1 Cell line, untreated" +p_14315_9 "Calu6 Cell line, aza treatment" "Calu6 Cell line, untreated" +p_14328_1 "Kidney allograft biopsy, stable" "Kidney allograft biopsy, acute rejection" +p_14346_1 "Peripheral blood, kidney transplant recipients, AR(presence of acute rejection)" "Peripheral blood, kidney transplant recipients, STA(absence of acute rejection)" +p_14378_1 "pulmonary metastases, late; kidney cancer" "pulmonary metastases, early" +p_14378_2 "pulmonary metastases, multiple; kidney cancer" "pulmonary metastases, only few" +p_14380_1 "LS174T cell, CDX1 silenced" "LS174T cell, control" +p_14380_2 "HCT116 cell, CDX1 silenced" "HCT116 cell, control" +p_14386_1 "PBMC, CIS patients, Interferon beta-1a-induced" "PBMC, CIS patients, control" +p_14390_1 "Human alveolar macrophage, control" "Human alveolar macrophage, control" +p_14405_1 TEM4-18 cells; cell line PC3 cells +p_14405_2 TEM205 cells; cell line PC3 cells +p_14407_1 ovarian cancer epithelial cells "Ovarian Surface Epithelium, Normal" +p_14429_1 "HEK293 cell, Epoxomicin treatec, 1h" "HEK293 cell, control" +p_14429_2 "HEK293 cell, Epoxomicin treatec, 6h" "HEK293 cell, control" +p_14434_1 "HeLa cell,anti-PCSK9 silenced" "HeLa cell, control" +p_14434_2 "HeLa cell,anti-PCSK9 Adaptor treated" "HeLa cell, control" +p_14461_1 "normal human bronchial epithelial cells (BEAS-2B); cigarette smoking condensate treatment, 1 month" "BEAS-2B; DMSO treatment, 1 month" +p_14461_2 "normal human bronchial epithelial cells (BEAS-2B); cigarette smoking condensate treatment, 2 months" "BEAS-2B; DMSO treatment, 2 months" +p_14461_3 "normal human bronchial epithelial cells (BEAS-2B); cigarette smoking condensate treatment, 3 months" "BEAS-2B; DMSO treatment, 3 months" +p_14461_4 "normal human bronchial epithelial cells (BEAS-2B); cigarette smoking condensate treatment, 4 months" "BEAS-2B; DMSO treatment, 4 months" +p_14461_5 "normal human bronchial epithelial cells (BEAS-2B); cigarette smoking condensate treatment, 5-aza" normal human bronchial epithelial cells (BEAS-2B); cigarette smoking condensate treatment +p_14461_6 normal human bronchial epithelial cells (BEAS-2B); Treatment: dmso; Demethylation: aza normal human bronchial epithelial cells (BEAS-2B); Treatment: dmso; Demethylation: none +p_14461_7 normal human bronchial epithelial cells (BEAS-2B); Treatment: untreated; Demethylation: aza normal human bronchial epithelial cells (BEAS-2B); Treatment: untreated; Demethylation: none +p_14464_1 "PC3 cell, PUR alpha treated" "PC3 cell, mock treated" +p_14464_2 "LNCaP cell, PUR alpha treated" "LNCaP cell, vector treated" +p_14465_1 "PMN cell, inflammation" "PMN cell, control" +p_14465_2 "PMN cell, inflammation, CGS treated" "PMN cell, inflammation" +p_14465_3 "PMN cell, inflammation, PGE2 treated" "PMN cell, inflammation" +p_14465_4 "PMN cell, inflammation, RO, F_ treated" "PMN cell, inflammation" +p_14468_1 acute myeloid leukemia (AML) 11q23; blood cancer acute myeloid leukemia (AML) NN karyotype +p_14468_10 acute myeloid leukemia (AML) t(6;9); blood cancer acute myeloid leukemia (AML) NN karyotype +p_14468_11 acute myeloid leukemia (AML) t(8;21); blood cancer acute myeloid leukemia (AML) NN karyotype +p_14468_12 acute myeloid leukemia (AML) t(9;22); blood cancer acute myeloid leukemia (AML) NN karyotype +p_14468_3 acute myeloid leukemia (AML) -9q; blood cancer acute myeloid leukemia (AML) NN karyotype +p_14468_4 acute myeloid leukemia (AML) abn(3q); blood cancer acute myeloid leukemia (AML) NN karyotype +p_14468_5 acute myeloid leukemia (AML) Complex karyotype; blood cancer acute myeloid leukemia (AML) NN karyotype +p_14468_6 acute myeloid leukemia (AML) idt(16); blood cancer acute myeloid leukemia (AML) NN karyotype +p_14468_7 acute myeloid leukemia (AML) MDS -7(q); blood cancer acute myeloid leukemia (AML) NN karyotype +p_14468_8 acute myeloid leukemia (AML) MDS complex; blood cancer acute myeloid leukemia (AML) NN karyotype +p_14468_9 acute myeloid leukemia (AML) t(15;17); blood cancer acute myeloid leukemia (AML) NN karyotype +p_14474_1 "Human embryonic cell, magnetic field, 1d" "Human embryonic cell, control" +p_14474_2 "Human embryonic cell, magnetic field, continuous day" "Human embryonic cell, control" +p_14474_3 "Human embryonic cell, magnetic field, continuous day, recover 1d" "Human embryonic cell, control" +p_14479_1 "acute myeloid leukemia (AML), CEBPA mutant; blood cancer" "acute myeloid leukemia (AML), CEBPA silenced" +p_14479_2 acute myeloid leukemia (AML) blasts; blood cancer T-acute lymphoblastic leukemia (ALL) blasts +p_14491_1 "MDA-MB-231 cell, shGFP, TGF beta treated" "MDA-MB-231 cell, shGFP, untreated" +p_14491_2 "MDA-MB-231 cell, shp53, untreated" "MDA-MB-231 cell, shGFP, untreated" +p_14491_3 "MDA-MB-231 cell, shp53, TGF beta treated" "MDA-MB-231 cell, shGFP, untreated" +p_14491_4 "MDA shp53, TGFbeta treated; siRNA treatment" "MDA shGFP, TGFbeta treated" +p_14507_1 "A549 cell, miR-7 treated" "A549 cell, control" +p_14509_1 "Human pancreatic adenocarcinoma cells (BxPC3), on the chick-chorio-allantoic membrane, day6" "Human pancreatic adenocarcinoma cells (BxPC3), on the chick-chorio-allantoic membrane, day1" +p_14519_12 "KMS11 cell, DAR treated, 24h" KMS11 cell +p_14519_14 "KMS11 cell, ATO treated, 24h" KMS11 cell +p_14519_17 "8226/S cell, DAR treated, 24h" 8226/S cell +p_14519_19 "8226/S cell, ATO treated, 24h" 8226/S cell +p_14519_2 "U266 cell, DAR treated, 24h" "U266 cell, control" +p_14519_4 "U266 cell, ATO treated, 24h" "U266 cell, control" +p_14519_7 "MM.1s cell, DAR treated, 24h" MM.1s cell +p_14519_9 "MM.1s cell, ATO treated, 24h" MM.1s cell +p_14526_1 "SW480 cell, aza 0, tsa 0 treated" "HCT116 cell, aza 0, tsa 0 treated" +p_14526_2 "SW480 cell, aza 3, tsa 0 treated" "HCT116 cell, aza 3, tsa 0 treated" +p_14526_3 "SW480 cell, aza 3, tsa 300 treated" "HCT116 cell, aza 3, tsa 300 treated" +p_14526_4 SW480_aza3_tsa300; treat SW480_aza0_tsa0 +p_14526_5 Fetal colon Adult normal colon +p_14537_1 "HEK293 cells, MOCK, AGO2-IP RNA; treated" "HEK293 cells, MOCK, control" +p_14537_2 "HEK293 cells, miR-7 AGO2-IP RNA; siRNA treated" "HEK293 cells, miR-7, control" +p_14537_3 "HEK293 cells, miR-124, AGO2-IP RNA; siRNA treated" "HEK293 cells, miR-124, control" +p_14537_4 "HEK293 cells, miR-7 transfected; siRNA treated" "HEK293 cells, MOCK transfected" +p_14537_5 "HEK293 cells, miR-124 transfected; siRNA treated" "HEK293 cells, MOCK transfected" +p_14538_1 "Caco2 cell, 5-ASA treated" "Caco2 cell, control" +p_14580_1 "Colon cell, UC disease, infliximab response" "Colon cell, control" +p_14580_2 "Colon cell, UC disease, infliximab non-response" "Colon cell, control" +p_14596_1 "Primary T cells, 1-day activated T cells" "Primary T cell, Quiescent" +p_14596_2 "Primary T cells, 2-day activated (stimulated) T cells" "Primary T cell, Quiescent" +p_14615_1 "Primary T-acute lymphoblastic leukemia (ALL), no response (induction failture); blood cancer" "primary T-acute lymphoblastic leukemia (ALL), complete continuous remission" +p_14615_2 "Primary T-acute lymphoblastic leukemia (ALL), failure (relapse); blood cancer" "primary T-acute lymphoblastic leukemia (ALL), complete continuous remission" +p_14642_1 "PBMC, after exercise, early girls; treated" "PBMC, before exercise, early girls" +p_14642_2 "PBMC, after exercise, late girls; treated" "PBMC, before exercise, late girls" +p_14671_1 "CD34+ cells, CML patients, responder" "CD34+ cells, CML patients, non-responder" +p_14680_1 "OPM2 cell, lentiviral CS1 shRNA transfected" "OPM2 cell, control vector" +p_14680_2 "U266 cell, CS1 expression vector transfected" "U266 cell, control vector" +p_14701_1 "PaTu8988t, adenovirus sensitive pancreatic cancer cell line" "PaTu8988s, adenovirus insensitive pancreatic cancer cell line" +p_14711_1 "induced pluripotent stem cells , virus-carrying" fibroblasts +p_14711_2 "induced pluripotent stem cells , factor-free" fibroblasts +p_14711_3 "induced pluripotent stem cells , virus-carrying" Embryonic Stem Cells +p_14711_4 "induced pluripotent stem cells , factor-free" Embryonic Stem Cells +p_14746_1 "Hut 78 cells, suppression of AHI-1 expression" "Hut 78 cells, control vector" +p_14746_2 "hut78, AHI-1 clone; treated" "hut78, control" +p_14762_1 clear cell renal cell carcinoma; kidney cancer "Kidney, normal" +p_14773_1 "HT29 cell, 1st sphere type" "HT29 cell, parental , control" +p_14773_2 "SW480, snail overexpressed" "SW480, vector" +p_14801_1 "HUVEC, non-sense siRNA" "HUVEC, control" +p_14801_2 "HUVEC, ERG siRNA" "HUVEC, control" +p_14807_1 "HEK293 cell, ALXR treated" "HEK293 cell, control" +p_14807_2 "HEK293 cell, AC226 treated" "HEK293 cell, control" +p_14807_3 "HEK293 cell, Annexin1 treated" "HEK293 cell, control" +p_14825_1 "RD cells, MyoD~E heterodimers expression" "RD cells, control vector" +p_14834_1 B-acute lymphoblastic leukemia (ALL)_BCR/ABL; blood cancer B-acute lymphoblastic leukemia (ALL)_No molecular abnormalities +p_14834_2 B-acute lymphoblastic leukemia (ALL)_E2A/PBX1; blood cancer B-acute lymphoblastic leukemia (ALL)_No molecular abnormalities +p_14834_3 B-acute lymphoblastic leukemia (ALL)_MLL/AF4; blood cancer B-acute lymphoblastic leukemia (ALL)_No molecular abnormalities +p_14841_1 "Jejunal biopsy, baseline, diarrhea-IBS" "Jejunal biopsy, healthy" +p_14842_1 "Jejunal biopsy, diarrhea-IBS, baseline" "Jejunal biopsy, diarrhea-IBS, control" +p_14842_2 "Jejunal biopsy, diarrhea-IBS, oral cromoglycate treatment" "Jejunal biopsy, diarrhea-IBS, control" +p_14844_1 "whole blood, at 2.p.m., after 10 months" "whole blood, at 2.p.m., day one" +p_14844_2 "whole blood, at 10.a.m., after 10 months" "whole blood, at 10.a.m., day one" +p_14844_3 "10 am, 10 months; blood tissue" "10am, day one" +p_14844_4 "2pm, 10 months; tissue" "2pm, day one" +p_14858_1 "Bone marrow or peripheral blood cell, JMML, AML-like signature" "Bone marrow or peripheral blood cell, JMML, non-AML-like signature" +p_14879_1 ALK- ALCL; blood cancer tcr-cHL +p_14879_2 ALK+ ALCL; blood cancer tcr-cHL +p_14879_3 cALCL; blood cancer CD8R_T cells +p_14880_1 MYCN amplified neuroblastoma; brain cancer MYCN non-amplified neuroblastoma +p_14883_1 "BEAS-2B cells, SOX2 over-expression" "BEAS-2B cells, control" +p_14886_1 "HTETOP cell, doxycycline" "HTETOP cell, control" +p_14886_2 "HTETOP cell, dexrazoxane" "HTETOP cell, control" +p_14897_1 "WAO9 human ESC, undifferentiated" human foreskin fibroblasts +p_14897_2 "WAO9 human ESC, differentiated, day 20" human foreskin fibroblasts +p_14897_3 "ATCC CRL2097(iPSC derived from human foreskin fibroblasts), differentiated, day 20" human foreskin fibroblasts +p_14897_4 "ATCC CRL2097(iPSC derived from human foreskin fibroblasts), undifferentiated" human foreskin fibroblasts +p_14905_1 Uninvolved skin Normal skin +p_14905_2 Lesion skin Normal skin +p_14924_2 "CD8 T cell, acute myeloid leukemia (AML); blood cancer" "CD8 T cell, healthy" +p_14924_3 "CD4 T cell, acute myeloid leukemia (AML) intermediate prognosis; blood cancer" "CD4 T cell, acute myeloid leukemia (AML) favorable prognosis" +p_14924_4 "CD8 T cell, acute myeloid leukemia (AML) intermediate prognosis; blood cancer" "CD8 T cell, acute myeloid leukemia (AML) favorable prognosis" +p_14951_1 tissue: donor liver tissue: normal liver +p_14951_2 "tissue: transplanted liver, 2 hours after reperfusion" tissue: normal liver +p_14964_1 "HeLa cell, shYY1 expressed" "HeLa cell, control vector" +p_14964_2 "HeLa cell, shYY2 expressed" "HeLa cell, control vector" +p_14964_3 "HeLa cell, shYY1+shYY2 expressed" "HeLa cell, control vector" +p_14970_1 "Myocardial cell, cyanotic Tetralogy of Fallot" "Myocardial cell, acyanotic Tetralogy of Fallot" +p_14973_1 chronic lymphocytic leukemia (CLL) with 1mM VPA; cancer drug treatment chronic lymphocytic leukemia (CLL) without VPA +p_14975_1 "Left atrial myocardium cell, Atrial Fibirillation patient" "Left atrial myocardium cell, control" +p_14986_1 Fulvestrant treated MCF-7 vehicle treated MCF-7 +p_14987_1 "MCF10A cell, ERBB2 overexpressed" "MCF10A cell, control" +p_14987_2 "MCF10A cell, EGF overexpressed" "MCF10A cell, control" +p_14987_3 LNCaP DHT stimulation LNCaP +p_14988_1 "LNCap cell, DHT stimulated" "LNCap cell, control" +p_15013_1 MLL partial tandem duplication MLL translocation +p_15061_1 "Bone marrow cell, MDS patient" "Bone marrow cell, normal" +p_15061_2 "Bone marrow cell, AML patient" "Bone marrow cell, normal" +p_15061_3 MDS; blood cancer None of the targets +p_15065_1 "MCF-10A cell, C/EBPbeta-2 overexpressed" "MCF-10A cell, control" +p_15083_1 "Synovial fluid mononuclear cells, Extended oligoarticular JIA" "Synovial fluid mononuclear cells, Persistent oligoarticular JIA" +p_15090_1 "Muscle biopsies, FSHD patients; tissue" "Muscle biopsies, normal control" +p_15090_2 "Muscle biopsies, asymptomatic carriers; tissue" "Muscle biopsies, normal control" +p_15091_1 "PC3 cell, AR_ETOH treated" "PC3 cell, control" +p_15091_2 "PC3 cell, AR_1nM androgen treated" "PC3 cell, control" +p_15091_3 "PC3 cell, AR_10nM androgen treated" "PC3 cell, control" +p_15098_1 Nasopharyngeal carcinoma cell line (CNE1) "immortalized nasopharyngeal epithelial cell line (NP69), control" +p_15098_2 Nasopharyngeal carcinoma cell line (CNE2) "immortalized nasopharyngeal epithelial cell line (NP69), control" +p_15098_3 Nasopharyngeal carcinoma cell line (HONE1) "immortalized nasopharyngeal epithelial cell line (NP69), control" +p_15132_1 "Caco-2 cell, ribo deficient, 24h" "Caco-2 cell, control, 24h" +p_15132_2 "Caco-2 cell, ribo deficient, 48h" "Caco-2 cell, control, 48h" +p_15132_3 "Caco-2 cell, ribo deficient, 72h" "Caco-2 cell, control, 72h" +p_15148_1 iPS cells from episomal vectors human embryonic stem cell lines +p_15148_2 Embryonic Stem Cells Foreskin Cells Parental +p_15148_3 iPS cells from episomal vectors Foreskin Cells Parental +p_15151_1 "NOMO-1 cells, shRNA targeting STK33" "NOMO-1 cells, control" +p_15151_2 "SKM cells, shRNA targeting STK33" "SKM cells, control" +p_15162_1 "HepG2 cell, quercetin treated, 2h" "HepG2 cell, control 2h" +p_15162_2 "HepG2 cell, quercetin treated, 4h" "HepG2 cell, control 4h" +p_15162_3 "HepG2 cell, quercetin treated, 12h" "HepG2 cell, control 12h" +p_15162_4 "HepG2 cell, quercetin treated, 24h" "HepG2 cell, control 24h" +p_15175_1 iPS cells from episomal vectors human embryonic stem cell lines +p_15175_2 iPS cells from episomal vectors "Foreskin Cells, Parental Foreskin" +p_15176_1 iPS cells from episomal vectors human embryonic stem cell lines +p_15176_2 iPS cells from episomal vectors "Foreskin Cells, Parental Foreskin" +p_15192_1 CD44-/CD24+ cells CD44+/CD24- cells +p_15205_1 "ARPE-19 cell, TGF treated, 6h" "ARPE-19 cell, TNF treated, 6h" +p_15205_2 "ARPE-19 cell, TGF treated, 42h" "ARPE-19 cell, TNF treated, 42h" +p_15209_3 foetal cortex derived NS cell; brain tissue Non-malignant human cortex +p_15214_1 mutant MSCs from root "WT MSCs from root, control" +p_15220_1 Cancer testis cell Normal testis cell +p_15237_1 "Eol1 cells, cultured in presence of Glivec" "Eol1 cells, cultured in absence of Glivec" +p_15258_1 whole blood from rheumatoid arthritis patient; medium response; tissue whole blood from rheumatoid arthritis patient; no response +p_15258_2 whole blood from rheumatoid arthritis patient; response; tissue whole blood from rheumatoid arthritis patient; no response +p_15271_1 "centrocyte, tonsil" "centroblast, tonsil" +p_15322_1 "CCD-18Co fibroblasts, pre-digested orange extractrixh in flavanones, 24h" "CCD-18Co fibroblasts, control mixture, 24h" +p_15323_1 "Rhabdomyosarcoma cell, EV71 infected, 4h" "Rhabdomyosarcoma cell, uninfected" +p_15323_2 "Rhabdomyosarcoma cell, EV71 infected, 8h" "Rhabdomyosarcoma cell, uninfected" +p_15367_1 "Saos-2-null cell, Prima treated, 6h" "Saos-2-null cell, control" +p_15367_2 "Saos-2-null cell, Prima treated, 12h" "Saos-2-null cell, control" +p_15368_1 "Saos-2-His273 cell, Prima treated, 6h" "Saos-2-His273 cell, control" +p_15368_2 "Saos-2-His273 cell, Prima treated, 12h" "Saos-2-His273 cell, control" +p_15372_1 "Round5 A2780 cells, cisplatin-resistant" "Parental A2780 cells, cisplatin-sensitive" +p_15385_1 "T84 cell, miR-210, miR-338-3p, miR-33a,miR-451 treated, 5d" "T84 cell, negative control" +p_15385_2 "T84 cell, miR-338-3p, miR-451 treated, 5d" "T84 cell, negative control" +p_15389_1 "PMBC cell, IC90 treated, 2h" "PMBC cell, vehicle treated, 2h" +p_15389_2 "PMBC cell, IC90 treated, 24h" "PMBC cell, vehicle treated, 24h" +p_15389_3 "PMBC cell, 3*IC90 treated, 2h" "PMBC cell, vehicle treated, 2h" +p_15389_4 "PMBC cell, 3*IC90 treated, 24h" "PMBC cell, vehicle treated, 24h" +p_15392_1 "DU145 cell, IC50 treated, 2h" "DU145 cell, DMSO treated, 2h" +p_15392_3 "DU145 cell, IC50 treated, 24h" "DU145 cell, DMSO treated, 24h" +p_15392_4 "DU145 cell, IC90 treated, 2h" "DU145 cell, DMSO treated, 2h" +p_15392_6 "DU145 cell, IC90 treated, 24h" "DU145 cell, DMSO treated, 24h" +p_15392_7 "DU145 cell, 3*IC90 treated, 2h" "DU145 cell, DMSO treated, 2h" +p_15392_9 "DU145 cell, 3*IC90 treated, 24h" "DU145 cell, DMSO treated, 24h" +p_15395_1 "HCT116 cell, IC50 treated, 1h" "HCT116 cell, DMSO treated, 1h" +p_15395_10 "HCT116 cell, IC90 treated, 24h" "HCT116 cell, DMSO treated, 24h" +p_15395_11 "HCT116 cell, 3*IC90 treated, 1h" "HCT116 cell, DMSO treated, 1h" +p_15395_15 "HCT116 cell, 3*IC90 treated, 24h" "HCT116 cell, DMSO treated, 24h" +p_15395_5 "HCT116 cell, IC50 treated, 24h" "HCT116 cell, DMSO treated, 24h" +p_15395_6 "HCT116 cell, IC90 treated, 1h" "HCT116 cell, DMSO treated, 1h" +p_15396_1 "PBMCs, IC90 2hr treatment; time course" "PBMCs, control 2hr" +p_15396_10 "DU145 cell line, IC90 24hr treatment; time course" "DU145, control 24hr" +p_15396_11 "DU145 cell line, 3xIC90 2hr treatment; time course" "DU145, control 2hr" +p_15396_12 "DU145 cell line, 3xIC90 6hr treatment; time course" "DU145, control 6hr" +p_15396_13 "DU145 cell line, 3xIC90 24hr treatment; time course" "DU145, control 24hr" +p_15396_14 "HCT116 cell line, IC50 1hr treatment; time course" "HCT116, control 1hr" +p_15396_15 "HCT116 cell line, IC50 2hr treatment; time course" "HCT116, control 2hr" +p_15396_16 "HCT116 cell line, IC50 4hr treatment; time course" "HCT116, control 4hr" +p_15396_17 "HCT116 cell line, IC50 6hr treatment; time course" "HCT116, control 6hr" +p_15396_18 "HCT116 cell line, IC50 24hr treatment; time course" "HCT116, control 24hr" +p_15396_19 "HCT116 cell line, IC90 1hr treatment; time course" "HCT116, control 1hr" +p_15396_2 "PBMCs, IC90 24hr treatment; time course" "PBMCs, control 24hr" +p_15396_20 "HCT116 cell line, IC90 2hr treatment; time course" "HCT116, control 2hr" +p_15396_21 "HCT116 cell line, IC90 4hr treatment; time course" "HCT116, control 4hr" +p_15396_22 "HCT116 cell line, IC90 6hr treatment; time course" "HCT116, control 6hr" +p_15396_23 "HCT116 cell line, IC90 24hr treatment; time course" "HCT116, control 24hr" +p_15396_24 "HCT116 cell line, 3xIC90 1hr treatment; time course" "HCT116, control 1hr" +p_15396_25 "HCT116 cell line, 3xIC90 2hr treatment; time course" "HCT116, control 2hr" +p_15396_26 "HCT116 cell line, 3xIC90 4hr treatment; time course" "HCT116, control 4hr" +p_15396_27 "HCT116 cell line, 3xIC90 6hr treatment; time course" "HCT116, control 6hr" +p_15396_28 "HCT116 cell line, 3xIC90 24hr treatment; time course" "HCT116, control 24hr" +p_15396_3 "PBMCs, 3xIC90 2hr treatment; time course" "PBMCs, control 2hr" +p_15396_4 "PBMCs, 3xIC90 24hr treatment; time course" "PBMCs, control 24hr" +p_15396_5 "DU145 cell line, IC50 2hr treatment; time course" "DU145, control 2hr" +p_15396_6 "DU145 cell line, IC50 6hr treatment; time course" "DU145, control 6hr" +p_15396_7 "DU145 cell line, IC50 24hr treatment; time course" "DU145, control 24hr" +p_15396_8 "DU145 cell line, IC90 2hr treatment; time course" "DU145, control 2hr" +p_15396_9 "DU145 cell line, IC90 6hr treatment; time course" "DU145, control 6hr" +p_15400_1 D551 cell SDEC cell from hESC +p_15400_2 WI38 cell SDEC cell from hESC +p_15434_1 NPM1+ acute myeloid leukemia (AML); cancer NPM1- acute myeloid leukemia (AML) +p_15434_2 FLT3-ITD positive acute myeloid leukemia (AML); cancer FLT3-ITD negative acute myeloid leukemia (AML); cancer +p_15434_3 CEBPA+ acute myeloid leukemia (AML); cancer CEBPA- acute myeloid leukemia (AML); cancer +p_15464_1 "HUVEC, VEGF induced, 30m" "HUVEC, uninduced" +p_15464_2 "HUVEC, VEGF induced, 60m" "HUVEC, uninduced" +p_15464_3 "HUVEC, VEGF induced, 150m" "HUVEC, uninduced" +p_15471_1 "pancreatic cancer patients, pancreas; cancer" "pancreatic cancer patients., normal" +p_15477_1 ementine treated cell lines treated control treated cell lines +p_15481_1 "MCF-7 cells, AP-2 gamma targetting siRNA 1" "MCF-7 cells, non-silencing control siRNA" +p_15481_2 "MCF-7 cells, AP-2 gamma targetting siRNA 2" "MCF-7 cells, non-silencing control siRNA" +p_15481_3 "MCF-7 cells, AP-2 gamma targetting siRNA 3" "MCF-7 cells, non-silencing control siRNA" +p_15481_4 "MCF-7 cells, AP-2 gamma targetting siRNA 1" "MCF-7 cells, Transfection reagent only" +p_15481_5 "MCF-7 cells, AP-2 gamma targetting siRNA 2" "MCF-7 cells, Transfection reagent only" +p_15481_6 "MCF-7 cells, AP-2 gamma targetting siRNA 3" "MCF-7 cells, Transfection reagent only" +p_15490_1 "CD19 selected B cell, rituximab treated" "CD19 selected B cell, control" +p_15490_2 "CD19 selected B cell, fludarabine, cyclophosphamide treated" "CD19 selected B cell, control" +p_15490_3 "CD19 selected B cell, rituximab, fludarabine, cyclophosphamide treated" "CD19 selected B cell, control" +p_15495_1 "HCAE cell, S.agalactiae stimulated" "HCAE cell, control" +p_15499_1 "HUVEC, HDAC5 silenced, 24h" "HUVEC, control, 24h" +p_15520_1 "HG23 cells, Norwalk virus replicon-harboring cells" naive Huh-7 cells +p_15543_1 expanded islet cells fresh pancreatic islets +p_15543_2 re-differentiated cells fresh pancreatic islets +p_15553_1 "hESC, cultured in SB, cinhibit TGF-b" "hESC, cultured in EB, control" +p_15575_1 "HEK293 cells, in high glucose, 450mg/dl, 7 days" "HEK293 cells, in low glucose, 100mg/dl, 7 days" +p_15578_1 High risk ovarian epithelium Normal ovarian surface epithelium +p_15578_2 Epithelial ovarian cancer High risk ovarian epithelium +p_15583_1 "Neuroblastoma cell line, hypoxic treatment" "Neuroblastoma cell, normoxic" +p_15602_1 "RA Synovial biopsy, post-adalimumab therapy, Poor response" "RA Synovial biopsy, post-adalimumab therapy, moderate response" +p_15602_2 "RA Synovial biopsy, post-adalimumab therapy, Good response" "RA Synovial biopsy, post-adalimumab therapy, moderate response" +p_15605_1 primary melanoma normal skin +p_15615_1 "Fibroblast-like Synovial cell, RA patient, TNF alpha" "Fibroblast-like Synovial cell, RA patient, control" +p_15615_2 "Fibroblast-like Synovial cell, RA patient, IL1 beta" "Fibroblast-like Synovial cell, RA patient, control" +p_15636_1 "Caco-2 cell line, cocultured with L. acidophilus NCFM¢â, 8 h" "Caco-2 cell line, medium-only control, 8 h" +p_15636_2 "Caco-2 cell line, cocultured with B. lactis 420, 8 h" "Caco-2 cell line, medium-only control, 8 h" +p_15636_3 "Caco-2 cell line, cocultured with L. salivarius Ls-33, 8 h" "Caco-2 cell line, medium-only control, 8 h" +p_15636_4 "Caco-2 cell line, treated with L. acidophilus NCFM¢â cell-free supernatant, 24 h" "Caco-2 cell line, medium-only control, 24 h" +p_15636_5 "Caco-2 cell line, treated with B. lactis 420 cell-free supernatant, 24 h" "Caco-2 cell line, medium-only control, 24 h" +p_15636_6 "Caco-2 cell line, treated with L. salivarius Ls-33 cell-free supernatant, 24 h" "Caco-2 cell line, medium-only control, 24 h" +p_15636_7 "Caco-2 cell line, treated with E. coli O157:H7 cell-free supernatant, 24 h" "Caco-2 cell line, medium-only control, 24 h" +p_15645_1 "PBMC cell, JIA, active symptom" "PBMC cell, JIA, control" +p_15645_2 "PBMC cell, JIA, CR symptom" "PBMC cell, JIA, control" +p_15645_3 "PBMC cell, JIA, CRM symptom" "PBMC cell, JIA, control" +p_15658_1 "Saos-2 osteosarcoma, p53-His273, untreated" "Saos-2 osteosarcoma, p53-null, untreated" +p_15658_2 "Saos-2 osteosarcoma, p53-His273, 6 hours treatment" "Saos-2 osteosarcoma, p53-null, 6 hours treatment" +p_15658_3 "Saos-2 osteosarcoma, p53-His273, 12 hours treatment" "Saos-2 osteosarcoma, p53-null, 12 hours treatment" +p_15659_1 "CD4+ Tregs, Activated CD45RA- FoxP3high CD4+ Tregs treated" "CD4+ Tregs, Resting CD45RA+ FoxP3low" +p_15735_1 CD4-HDACi-2h; HDAC inhibitor treatment CD4-HDACi-0h +p_15735_2 CD4-HDACi-12h; HDAC inhibitor treatment CD4-HDACi-0h +p_15743_1 "Human NK cell, MHH1 treated, low, 6h" "Human NK cell, control" +p_15743_2 "Human NK cell, MHH1 treated, medium, 6h" "Human NK cell, control" +p_15743_3 "Human NK cell, MHH1 treated, high, 6h" "Human NK cell, control" +p_15749_1 "MCF-7 cells, transfected with miR-9" "MCF-7 cells, control" +p_15773_1 "subcutaneous adipose, insulin resistant patients" "subcutaneous adipose, insulin sensitive patients" +p_15773_2 "omental adipose tissue, insulin resistant patients" "omental adipose tissue, insulin sensitive patients" +p_15792_1 "LNCaP cells, siRNA targeting PCARNEQ" "LNCaP cells, control siRNA" +p_15799_1 "HT29 cells, NS398 treated" "HT29 cells, control" +p_15811_1 "CD34+ cord blood cells, expressing BCR/FGFR1" "CD34+ cord blood cells, expressing the empty MIG control vector, control" +p_15811_2 "CD34+ cord blood cells, expressing BCR/ABL1" "CD34+ cord blood cells, expressing the empty MIG control vector, control" +p_15811_3 "CD34+ cord blood cells, expressing ZMYM2/FGFR1" "CD34+ cord blood cells, expressing the empty MIG control vector, control" +p_15893_1 "MDA-MB-231 cell, express CXCR4" "MDA-MB-231 cell, not express CXCR4" +p_15893_2 "MDA-MB-231 cell, express CXCR4, SDF-1 alpha treated" "MDA-MB-231 cell, not express CXCR4" +p_15903_1 "NPC cell, 6-10B type" "NPC cell, 5-8F type" +p_15913_1 "chronic lymphocytic leukemia (CLL) patient, thalidomide treated; cancer treatment" "chronic lymphocytic leukemia (CLL) patient, untreated" +p_15913_2 "chronic lymphocytic leukemia (CLL), deletion 17p13; cancer" "chronic lymphocytic leukemia (CLL), No deletion 17p13; cancer" +p_15913_3 "chronic lymphocytic leukemia (CLL), deletion 11q22-q23; cancer" "chronic lymphocytic leukemia (CLL), No deletion 11q22-q23; cancer" +p_15918_1 "H295R cell, angiotensin II treated, 100nM" "H295R cell, control" +p_15918_2 "H295R cell, test compound CP-529414 treated, 100nM" "H295R cell, control" +p_15935_1 "Huh7 cell line, 5uM NIM811 12hr treatment; time course" "Huh7, control 12hr" +p_15935_10 "clone A cell line, 5uM CsA 12hr treatment; time course" "clone A, control 12hr" +p_15935_11 "clone A cell line, 5uM NIM811 24hr treatment; time course" "clone A, control 24hr" +p_15935_12 "clone A cell line, 1uM CsA 24hr treatment; time course" "clone A, control 24hr" +p_15935_13 "clone A cell line, 5uM CsA 24hr treatment; time course" "clone A, control 24hr" +p_15935_14 "clone A cell line, 1uM NIM811 48hr treatment; time course" "clone A, control 48hr" +p_15935_15 "clone A cell line, 5uM NIM811 48hr treatment; time course" "clone A, control 48hr" +p_15935_16 "clone A cell line, 5uM CsA 48hr treatment; time course" "clone A, control 48hr" +p_15935_2 "Huh7 cell line, 5uM CsA 12hr treatment; time course" "Huh7, control 12hr" +p_15935_3 "Huh7 cell line, 5uM NIM811 24hr treatment; time course" "Huh7, control 24hr" +p_15935_4 "Huh7 cell line, 5uM CsA 24hr treatment; time course" "Huh7, control 24hr" +p_15935_5 "Huh7 cell line, 1uM NIM811 48hr treatment; time course" "Huh7, control 48hr" +p_15935_6 "Huh7 cell line, 5uM NIM811 48hr treatment; time course" "Huh7, control 48hr" +p_15935_7 "Huh7 cell line, 1uM CsA 48hr treatment; time course" "Huh7, control 48hr" +p_15935_8 "Huh7 cell line, 5uM CsA 48hr treatment; time course" "Huh7, control 48hr" +p_15935_9 "clone A cell line, 5uM NIM811 12hr treatment; time course" "clone A, control 12hr" +p_15947_1 "RWPE1 cells, 100 nM of 1,25(OH)2D treated , 6h" "RWPE1 cells, EtOH treated, 6h" +p_15947_2 "RWPE1 cells, 100 nM of 1,25(OH)2D treated , 24h" "RWPE1 cells, EtOH treated, 24h" +p_15947_3 "RWPE1 cells, 100 nM of 1,25(OH)2D treated , 48h" "RWPE1 cells, EtOH treated, 48h" +p_15949_1 "MDM cell, hypoxia" "MDM cell, normoxia" +p_15960_1 "Colonic epithelial cell, adenoma" "Colonic epithelial cell, normal" +p_15960_2 "Colonic epithelial cell, colorectal cancer" "Colonic epithelial cell, normal" +p_15969_1 mixture of cultured adult human MSCs and NOD/scid mouse lung "lung tissue, NOD/scid mouse lung" +p_15969_2 "NOD/scid mouse lung, 10 h after IV infusion of hMSCs" "lung tissue, NOD/scid mouse lung" +p_16015_1 "Bone marrow cell, AML patient, NPM1 mutant" "Bone marrow cell, AML patient, NPM1 wt" +p_16015_2 "acute myeloid leukemia (AML), 3-positive(mutated); cancer" "acute myeloid leukemia (AML), 1-negative(wild)" +p_16020_1 autosomal dominant monocytopenia; polymorphonuclear leukocytes; cancer; Rneasy polymorphonuclear leukocytes; control +p_16020_2 autosomal dominant monocytopenia; polymorphonuclear leukocytes; cancer; STAT60 polymorphonuclear leukocytes; control +p_16028_1 "Venous blood, female 1day; tissue" "Venous blood, male 1day" +p_16028_2 "Venous blood, female 14day; tissue" "Venous blood, male 14day" +p_16028_3 "Venous blood, female 28day; tissue" "Venous blood, male 28day" +p_16028_4 "Venous blood, female 90day; tissue" "Venous blood, male 90day" +p_16028_5 "Venous blood, female 180day; tissue" "Venous blood, male 180day" +p_16032_1 "PBMC, Acute stage" "PBMC, convalescent stage" +p_16051_1 "HUVEC, transduced with MSCVneo expressing 4-OHT-inducible K13-ERTAM" "HUVEC, MSCVneo vector, control" +p_16051_2 "HUVEC_K13_ER_4OHT, treatment" HUVEC_K13_ER_UT +p_16051_3 HUVEC_K13_ER_UT treated HUVEC_Vector_UT +p_16051_4 "HUVEC_K13_ER_4OHT, treatment" HUVEC_Vector_4OHT treated +p_16054_1 "HEK293 cell, Delta Exon 4 mutant" "HEK293 cell, control" +p_16054_2 "HEK293 cell, L188Q mutant" "HEK293 cell, control" +p_16059_1 "PBLs, pair_CFS; chronic fatigue syndrome; blood tissue" "PBLs, pair_unaffected" +p_16059_2 "PBLs, pair_ICF; idiopathic fatigue syndrome; blood tissue" "PBLs, pair_unaffected" +p_16066_1 "Caco2 cells, resistant to methotrexate" "Caco2 cells, sensitive to methotrexate" +p_16070_1 "MCF7 cells, resistant to methotrexate" "MCF7 cells, sensitive to methotrexate" +p_16080_1 "MDA-MB-468 cells, resistant to methotrexate" "MDA-MB-468 cells, sensitive to methotrexate" +p_16082_1 "MIA PaCa2 cells, resistant to methotrexate" "MIA PaCa2 cells, sensitive to methotrexate" +p_16085_1 "K562 cells, resistant to methotrexate" "K562 cells, sensitive to methotrexate" +p_16089_1 "Saos-2 cells, resistant to methotrexate" "Saos-2 cells, sensitive to methotrexate" +p_16093_1 H9 Human Embryonic Stem Cell Human newborn fibroblast +p_16093_2 "Human iPSC, Direct Delivery of Reprogramming Proteins" Human newborn fibroblast +p_16093_3 "Human iPSC, retroviral transfection of Reprogramming genes" Human newborn fibroblast +p_16093_4 "iPS cell, retroviral transfection of reprogramming genes" "H9, embryonic stem cell" +p_16097_1 "HEK293 cell, BAHD1 silenced" "HEK293 cell, control" +p_16098_1 "PBM cell, p30 treated, total RNA" "PBM cell, control, total RNA" +p_16098_2 "PBM cell, p30 treated, Cytoplasmic RNA" "PBM cell, control, Cytoplasmic RNA" +p_16118_1 "U937 cell, Sonazoid treated" "U937 cell, control" +p_16118_2 "U937 cell, Ultrasound treated" "U937 cell, control" +p_16118_3 "U937 cell, Sonazoid, Ultrasound treated" "U937 cell, control" +p_16119_1 "Microglia, derived from glioblastoma" Glioblastoma +p_16130_1 CD4 T cell "DN T cell, control" +p_16130_2 CD8 T cell "DN T cell, control" +p_16134_1 "gingival tissue, periodontitis-affected site" "gingival tissue, unaffected site" +p_16149_1 "Buccal mucosa cells, smoker" "Buccal mucosa cells, non-smoker" +p_16155_1 "Ependymona cell, recurrent" "Ependymona cell , non-recurrent" +p_16161_1 atopic dermatitis (AD) skin; tissue normal skin +p_16176_1 "amniotic fluid, down syndrome female; tissue" "amniotic fluid, euploid female" +p_16176_2 "amniotic fluid, down syndrome male; tissue" "amniotic fluid, euploid male" +p_16179_1 "BT474 cell, Lap treated" "BT474 cell, DMSO treated" +p_16179_2 "BT474-J4 cell, GSK089 treated" "BT474-J4 cell, DMSO treated" +p_16179_3 "BT474-J4 cell, Lap treated" "BT474-J4 cell, DMSO treated" +p_16179_4 "BT474-J4 cell, Lap, GSK089 treated" "BT474-J4 cell, DMSO treated" +p_16191_1 "Cryptorchidism, unilateral" "Cryptorchidism, control" +p_16191_2 "Cryptorchidism, bilateral" "Cryptorchidism, control" +p_16193_1 "THP-1 cell, CO treated" "THP-1 cell, control" +p_16193_2 "THP-1 cell, LPS treated" "THP-1 cell, control" +p_16193_3 "THP-1 cell, CO, LPS treated" "THP-1 cell, control" +p_16194_1 H441 snail overexpressed "H441 cell, control" +p_16194_2 H292 snail overexpressed "H292 cell, control" +p_16194_3 H1437 snail overexpressed "H1437 cell, control" +p_16214_1 "PBMC, IFN beta treated" "PBMC, control" +p_16214_2 "PBMC, GA treated" "PBMC, control" +p_16219_1 "HuT-102 cells, shRNA targeting TAK1" "HuT-102 cells, vector control" +p_16226_3 "siLincIRX5, siRNA treatment" "Non-targetting siRNA Control, foot fibroblast" +p_16226_4 "siLincMTX2, siRNA treatment" "Non-targetting siRNA Control, foot fibroblast" +p_16226_5 "siLincSTXBP5, siRNA treatment" "Non-targetting siRNA Control, foot fibroblast" +p_16226_6 "siLincTNS1, siRNA treatment" "Non-targetting siRNA Control, lung fibroblast" +p_16226_7 "siLincZFP161, siRNA treatment" "Non-targetting siRNA Control, lung fibroblast" +p_16226_8 "siTUG1, siRNA treatment, lung" "Non-targetting siRNA Control, lung fibroblast" +p_16226_9 "siTUG1, siRNA treatment, foot" "Non-targetting siRNA Control, foot fibroblast" +p_16236_1 "Lesional myeloid cells, from MDS (Myelodysplastic Syndromes) patients" "Normal lymphoid cells, from MDS (Myelodysplastic Syndromes) patients" +p_16236_2 "Lesional blastic cells, from MDS (Myelodysplastic Syndromes) patients" "Normal lymphoid cells, from MDS (Myelodysplastic Syndromes) patients" +p_16236_3 "Lesional erythroid cells, from MDS (Myelodysplastic Syndromes) patients" "Normal lymphoid cells, from MDS (Myelodysplastic Syndromes) patients" +p_16236_4 "Normal lymphoid cells, from MDS (Myelodysplastic Syndromes) patients" "normal lymophoid cells, of normal person" +p_16237_1 "primary neuroblastoma, MYCN amplified; brain cancer" "primary neuroblastoma, MYCN single copy" +p_16237_2 "primary neuroblastoma, alive" "primary neuroblastoma, died of disease" +p_16238_1 "HTB-58 cell, AntiEvil1 silenced" "HTB-58 cell, control" +p_16238_2 "TF-1 cell, AntiEvil1 silenced" "TF-1 cell, control" +p_16249_1 "NZM15 cells, media only, siRNA targeting MITF, 30h" "NZM15 cells, media only, 30h, control" +p_16354_1 "LEC cell, KSHV treated , 72h" "LEC cell, control" +p_16354_2 "BEC cell, KSHV treated , 72h" "BEC cell, control" +p_16355_1 "lymphatic endothelial cells, KSHV microRNA cluster" "lymphatic endothelial cells, pSIN-MCS (empty vector)" +p_16356_1 "lymphatic endothelial cells, MAF-siRNA" "lymphatic endothelial cells, non-targeted-siRNA" +p_16357_1 "lymphatic endothelial cell, KSHV-infected, 72h" "lymphatic endothelial cell, uninfected control" +p_16357_2 "blood vessel endothelial cell, KSHV-infected, 72h" "blood vessel endothelial cell, uninfected control" +p_16357_3 "lymphatic endothelial cells, KSHV microRNA cluster" "lymphatic endothelial cells, empty vector" +p_16357_4 "lymphatic endothelial cells, MAF siRNA" "lymphatic endothelial cells, control siRNA" +p_16363_1 "HIV-1 infection, asymptomatic stages; blood tissue" "HIV-1 infection, uninfected" +p_16363_2 "HIV-1 infection, acute stages; blood tissue" "HIV-1 infection, uninfected" +p_16363_3 "HIV-1 infection, AIDS; blood tissue" "HIV-1 infection, uninfected" +p_16386_1 "CD14 macrophage, IL-4, Rosiglitazone treated" "CD14 macrophage, IL-4 treated" +p_16387_13 "macrophages,treated with IL-4 and Rosiglitazone, 24h" "macrophages, treated with Rosiglitazone, 24h" +p_16387_14 "macrophages,treated with IFNg+TNF and Rosiglitazone, 24h" "macrophages, treated with Rosiglitazone, 24h" +p_16387_5 "macrophages, treated with IL-4 and vehicle, 24h" "macrophages, treated with vehicle, 24h" +p_16387_6 "macrophages, treated with IFNg+TNF and vehicle, 24h" "macrophages, treated with vehicle, 24h" +p_16391_1 "breast cancer, postmenopausal" "breast cancer, premenopausal" +p_16391_2 "breast cancer, ER, PGR (+)" "breast cancer, ER, PGR (-)" +p_16391_3 "breast cancer, adj neoadj chemotherapy received" adj neoadj chemotherapy not received +p_16391_4 "breast cancer, node (+)" "breast cancer, node (-)" +p_16391_5 "breast cancer, HER2 (+)" "breast cancer, HER2 (-)" +p_16416_1 "Human foreskin fibroblast cell, medium as parasite conditioned" "Human foreskin fibroblast cell, medium as control" +p_16416_2 "Human foreskin fibroblast cell, treated TGF, medium as parasite conditioned" "Human foreskin fibroblast cell, treated TGF" +p_16447_1 "skin fibroblast, cerebral palsy" "skin fibroblast, control" +p_16450_1 "BE(2)-C cell line, immature, IFN treated, 6h" "BE(2)-C cell line, immature, untreatead control" +p_16450_2 "BE(2)-C cell line, immature, IFN treated, 12h" "BE(2)-C cell line, immature, untreatead control" +p_16450_3 "BE(2)-C cell line, mature, IFN treated, 6h" "BE(2)-C cell line, mature, untreatead control" +p_16450_4 "BE(2)-C cell line, mature, IFN treated, 12h" "BE(2)-C cell line, mature, untreatead control" +p_16451_1 "BE-C cell, immature, WEEV infected" "BE-C cell, immature, unstimulated" +p_16451_2 "BE-C cell, mature, WEEV infected" "BE-C cell, mature, unstimulated" +p_16452_1 "BE(2)-C, immature IFN 6hr treatment" "BE(2)-C, immature unstimulated" +p_16452_2 "BE(2)-C, immature IFN 12hr treatment" "BE(2)-C, immature unstimulated" +p_16452_3 "BE(2)-C, mature IFN 6hr treatment" "BE(2)-C, mature unstulated" +p_16452_4 "BE(2)-C, mature IFN 12hr treatment" "BE(2)-C, mature unstulated" +p_16452_5 "BE(2)-C, immature WEEV infection 6hr treatment" "BE(2)-C, immature unstimulated" +p_16452_6 "BE(2)-C, mature WEEV infection 6hr treatment" "BE(2)-C, mature unstulated" +p_16455_1 iMCL (indolent mantle cell lymphoma) cMCL (conventional mantle cell lymphoma) +p_16455_2 iMCL (indolent mantle cell lymphoma) HCL (Hairy Cell Leukemia) +p_16455_3 MCL (mantle cell lymphoma) SMLZ (Splenic Marginal Zone Lymphoma) +p_16455_4 MCL (mantle cell lymphoma) CLL (Chronic Lymphocytic Leukemia) +p_16455_5 MCL (mantle cell lymphoma) LF (follicular lymphoma) +p_16464_1 "Chondrocytes, OA patient, monolayer type" "Chondrocytes, normal, monolayer type" +p_16464_2 "Chondrocytes, OA patient, 3D-culture type" "Chondrocytes, normal, 3D-culture type" +p_16515_1 "pancreatic, tumor; pancreas cancer" "pancreatic, normal" +p_16524_1 "skin fibroblasts, Setleis Syndrome, Homozygous for the Q119X mutation in the TWIST2 gene" "skin fibroblasts, normal, Wild type for TWIST2" +p_16538_1 "Lung cell, Pulmonary sarcoidosis patient" "Lung cell, control" +p_16547_1 "LEC cell, pSin co-culture, DLL4 overexpressed" "LEC cell, pSin co-culture, control" +p_16547_2 "LEC cell, pSin co-culture, JAG1 overexpressed" "LEC cell, pSin co-culture, control" +p_16584_1 "meningioma tumor, grade 2" "meningioma tumor, grade 1" +p_16584_2 "meningioma tumor, grade 3" "meningioma tumor, grade 1" +p_16589_1 "Lin+ UCB cells, freshly isolated" "Lin- UCB cells, freshly isolated" +p_16589_2 "Lin+ UCB cells, cultured 4 days" "Lin- UCB cells, cultured 4 days" +p_16589_3 "Lin+ UCB cells, cultured 8 days, S/E at day 4" "Lin- UCB cells, cultured 8 days, S/E at day4" +p_16589_4 "Lin+ UCB cells, cultured 8 days, NS/NE at day4" "Lin- UCB cells, cultured 8 days, NS/NE at day 4" +p_16589_5 "Lin+ UCB cells, cultured 12 days" "Lin- UCB cells, cultured 12 days" +p_16615_1 CLA 1 adipocyte c9t11 treated CLA 1 adipocyte control +p_16615_2 CLA 1 adipocyte mixture treated CLA 1 adipocyte control +p_16615_3 CLA 1 adipocyte t10c12 treated CLA 1 adipocyte control +p_16625_1 "CD34+ cells, AML-TLD patients,5-azacytidine+entinostat treated, day 15" "CD34+ cells, AML-TLD patients, untreated, day 0" +p_16625_2 "CMMoL, 5-azacytidine & entinostat 15day treated; blood cancer" "CMMoL, 5-azacytidine & entinostat 0day" +p_16625_3 "MDS, 5-azacytidine & entinostat 15day treated; blood cancer" "MDS, 5-azacytidine & entinostat 0day" +p_16650_1 "BEAS2b cell, Stretch" "BEAS2b cell, control" +p_16650_2 "BEAS2b cell, LPS" "BEAS2b cell, control" +p_16650_3 "BEAS2b cell, TNF-alpha" "BEAS2b cell, control" +p_16650_4 "BEAS2b cell, Stretch + LPS" "BEAS2b cell, control" +p_16650_5 "BEAS2b cell, Stretch + TNF-alpha" "BEAS2b cell, control" +p_16659_1 "DU145N cell, HGF treated, 2h" "DU145N cell, control, 2h" +p_16659_2 "DU145N cell, HGF treated, 8h" "DU145N cell, control, 8h" +p_16659_3 "DU145N cell, HGF treated, 24h" "DU145N cell, control, 24h" +p_16674_1 "K562 cell, miR-34a treated, 24h" "K562 cell, control, 24h" +p_16677_1 Down Syndrome AMKL (acute megakaryoblastic leukemia or FAB M7 leukemia) Non-Down Syndrome AMKL (acute megakaryoblastic leukemia or FAB M7 leukemia) +p_16683_1 "HUVEC, estradiol treated, 1nM, 24h" "HUVEC, EtOH treated, control" +p_16694_1 CBiPS 2F (iPS from Cord Blood cells reprogrammed with Oct4 and Sox2) sorted Cord Blood cells (CD133+) +p_16694_2 "CBiPS 4F (iPS from Cord Blood cells reprogrammed with Oct4, Sox2, Klf4 and C-Myc)" sorted Cord Blood cells (CD133+) +p_16694_4 "CBiPS 4F 1 (iPS from Cord Blood cells reprogrammed with Oct4, Sox2, Klf4 and C-Myc - Sample" sorted Cord Blood cells CD133+ +p_16728_1 "peripheral blood, RNAprep: PAXgene Globin reduced, sickle-cell disease" "peripheral blood, RNAprep: PAXgene Globin reduced, Control" +p_16728_2 "peripheral blood, RNAprep: PAXgene, sickle-cell patients" "peripheral blood, RNAprep: PAXgene, Control" +p_16728_3 "peripheral blood, RNAprep: PBMC, sickle-cell patients" "peripheral blood, RNAprep: PBMC, Control" +p_16745_1 "CD34+ cell, MN1 transduced" "CD34+ cell, control" +p_16748_1 "Human chondrosarcoma cell, ET-743 treated" "Human chondrosarcoma cell, control" +p_16748_2 "Human chondrosarcoma cell, PM00104 treated" "Human chondrosarcoma cell, control" +p_16755_1 "primary macrophages, IFNa-treated" "primary macrophages, control" +p_16759_1 "Parietal lobe, Alzheimer's disease" "Parietal lobe, Control" +p_16797_1 "whold blood, IVIG-responsive, post" "whold blood, IVIG-responsive, pre" +p_16797_2 "whold blood, single-IVIG treatment, post" "whold blood, single-IVIG treatment, pre" +p_16797_3 "whold blood, IVIG-plus-IVMP combined therapy, post" "whold blood, IVIG-plus-IVMP combined therapy, pre" +p_16798_1 "U937 myelomonocytic cell line, PIR knock-down" "U937 myelomonocytic cell line, control" +p_16836_1 "Peripheral blood monocytes, CD16+" "Peripheral blood monocytes, CD16-" +p_16837_1 "Polymorphonuclear leukocytes, S.aureus-exposed, incubated at 37C, 1h" "Polymorphonuclear leukocytes, healthy donor" +p_16837_2 "Polymorphonuclear leukocytes, S.aureus-exposed, incubated at 37C, 2h" "Polymorphonuclear leukocytes, healthy donor" +p_16837_3 "Polymorphonuclear leukocytes, S.aureus-exposed, incubated at 37C, 3h" "Polymorphonuclear leukocytes, healthy donor" +p_16837_4 "Polymorphonuclear leukocytes, S.aureus-exposed, incubated at 37C, 6h" "Polymorphonuclear leukocytes, healthy donor" +p_16844_1 "Skin lesion cell, LL" "Skin lesion cell, ENL" +p_16856_1 "LNCaP cells, caffeine treated, 10mM" "LNCaP cells, untreated, control" +p_16856_2 "LNCaP cells, treated with both caffeine and actinomycin D after treatment with caffeine" "LNCaP cells, untreated, control" +p_16856_3 "LNCaP cells, treated with actinomycin D alone after treatment with caffeine" "LNCaP cells, untreated, control" +p_16856_4 "22Rv1 cells, caffeine treated, 10mM" "22Rv1 cells, untreated, control" +p_16856_5 "22Rv1 cells, treated with both caffeine and actinomycin D after treatment with caffeine" "22Rv1 cells, untreated, control" +p_16856_6 "22Rv1 cells, treated with actinomycin D alone after treatment with caffeine" "22Rv1 cells, untreated, control" +p_16870_7 "HeLa cell, BafA treated, 24h" "HeLa cell, control , 24h" +p_16870_8 "HeLa cell, DFO treated 24h" "HeLa cell, control , 24h" +p_16870_9 "HeLa cell, low LDL 24h" "HeLa cell, control , 24h" +p_16879_1 UC colon; tissue Normal colon +p_16879_2 CD colon; tissue Normal colon +p_16879_3 CD Ileum; tissue Normal Ileum Mucosa +p_16879_4 Infliximab responsive UC colon; tissue Infliximab non-responsive UC colon +p_16879_5 Infliximab responsive CD colon; tissue Infliximab non- responsive CD colon +p_16879_6 Infliximab responsive CD ileum; tissue Infliximab non-responsive CD ileum +p_16906_1 "Endometrial stromal cell, Jag1 retrovirus infected" "Endometrial stromal cell, control" +p_16910_1 "hES-T3, grown on MEF feeder" grown on feeder-free Matrigel in MEF-conditioned medium +p_16910_2 hES-T3 grown in hES medium (containing 4 ng/ml bFGF) supplemented with 5 ng/ml activin A grown on feeder-free Matrigel in MEF-conditioned medium +p_16924_1 "AGS cells, GFP and MIST1 transfected" "AGS cells, GFP and empty vector-transfected" +p_16924_2 "HGC-27 cells, GFP and MIST1 transfected" "HGC-27 cells, GFP and empty vector-transfected" +p_16924_3 HGC+MIST1; transfection treated HGC-27 parental +p_16924_4 HGC+MIST1; transfection treated HGC+GFP control +p_16934_1 "SW480 cell, High SCP51" "SW480 cell, EGFP" +p_16934_2 "SW480 cell, Low SCP58" "SW480 cell, EGFP" +p_16962_1 "Umbilical vein cell, miR-210 overexpressed" "Umbilical vein cell, control" +p_16962_2 "Umbilical vein cell, miR-210 downmodulated" "Umbilical vein cell, control" +p_16969_1 "Brain cell, tuberous sclerosis complex disease, cortical tuber" "Brain cell, control" +p_17007_1 "Kit225 cell, control ,NC1153 treated" "Kit225 cell, control , DMSO" +p_17009_1 "Human MM cell, Onconase treated" "Human MM cell, control" +p_17014_1 "Dermal cell isolate from 4 neonatal foreskin, HD-1dim" "Dermal cell isolate from 4 neonatal foreskin, HD-1bri" +p_17032_1 skin fibroblasts; tissue lung fibroblasts +p_17044_1 "LNCaP cell, Androgen treated" "LNCaP cell, control" +p_17054_1 Human acute myeloid leukemia stem cells Normal human bone marrow hematopoietic stem cells +p_17090_1 Adipose stem cells expanded in allogeneic human serum Adipose stem cells expanded in fetal bovine serum +p_17119_1 "HMVEC, PNF1-treated, 1h" "HMVEC, control, 1h" +p_17119_2 "HMVEC, PNF1-treated, 2h" "HMVEC, control, 2h" +p_17119_3 "HMVEC, PNF1-treated, 4h" "HMVEC, control, 4h" +p_17119_4 "HMVEC, PNF1-treated, 8h" "HMVEC, control, 8h" +p_17119_5 "HMVEC, PNF1-treated, 16h" "HMVEC, control, 16h" +p_17119_6 "HMVEC, PNF1-treated, 24h" "HMVEC, control, 24h" +p_17119_7 "HMVEC, PNF1-treated, 48h" "HMVEC, control, 48h" +p_17129_1 "BL Ramos cell line, transfected with pRTS-CA-IKK2" "BL Ramos cell line, transfected with pRTS-GFP (control)" +p_17183_1 liver biopsy after interferon treatment liver biopsy before treatment +p_17183_2 hepatocytes after interferon treatment hepatocytes before treatment +p_17183_3 lymphocytes after interferon treatment lymphocytes before treatment +p_17187_1 "gastric cancer, node stage: positive" "gastric cancer, node stage: negative" +p_17254_1 "primary hepatocyte, Wy14643 treated, 6 hr; time course" "primary hepatocyte, DMSO, 6 hr" +p_17254_2 "primary hepatocyte, Wy14643 treated, 24 hr; time course" "primary hepatocyte, DMSO, 24 hr" +p_17269_1 "Naive B cell, CVID patient" "Naive B cell, healthy" +p_17269_2 "CD21 low B cell, CVID patient" "Naive B cell, healthy" +p_17300_1 "HEK293T cell, USF1 overexpressed" "HEK293T cell, control" +p_17307_1 "A549 cell, dexamethasone, 6h" "A549 cell, control" +p_17307_2 "A549 cell, mifepriston + dexamethasone, 48h" "A549 cell, control" +p_17307_3 "A549 cell, match polyamide + dexamethasone, 48h" "A549 cell, control" +p_17307_4 "A549 cell, mismatch polyamide + dexamethasone, 48h" "A549 cell, control" +p_17347_1 "A459 cells, 3D culture" "A459 cells, 2D culture" +p_17347_2 "UT-15 cells, 3D culture" "UT-15 cells, 2D culture" +p_17351_1 esophageal squamous cell carcinoma (ESCC) "esophagus tissue, normal" +p_17353_1 "EPC2-hTERT cell, Hypoxia" "EPC2-hTERT cell, Normoxia, control" +p_17368_4 "Postnatal epiphyseal cartilage, passage 4" "Postnatal epiphyseal cartilage, primary" +p_17368_8 "Postnatal epiphyseal cartilage, passage 8" "Postnatal epiphyseal cartilage, primary" +p_17375_1 "colon cancer stem cells (CSC), high Wnt" "colon cancer stem cells (CSC), low Wnt" +p_17375_2 C200 Colon CSC culture high Wnt; overexpression C200 Colon CSC culture low Wnt +p_17385_1 "Multiple myeloma line (MM1.S), beta-catenin knockdown" "Multiple myeloma line (MM1.S), control" +p_17386_1 "CD133-HCC cell, miR-130b treated" "CD133-HCC cell, control" +p_17400_1 "Bronchial epithelial cell line (2B4), SARS-CoV-infected, 12h" "Bronchial epithelial cell line (2B4), mock-infected, 12h" +p_17400_2 "Bronchial epithelial cell line (2B4), DOHV-infected, 12h" "Bronchial epithelial cell line (2B4), mock-infected, 12h" +p_17400_3 "Bronchial epithelial cell line (2B4), SARS-CoV-infected, 24h" "Bronchial epithelial cell line (2B4), mock-infected, 24h" +p_17400_4 "Bronchial epithelial cell line (2B4), DOHV-infected, 24h" "Bronchial epithelial cell line (2B4), mock-infected, 24h" +p_17400_5 "Bronchial epithelial cell line (2B4), SARS-CoV-infected, 48h" "Bronchial epithelial cell line (2B4), mock-infected, 48h" +p_17400_6 "Bronchial epithelial cell line (2B4), DOHV-infected, 48h" "Bronchial epithelial cell line (2B4), mock-infected, 48h" +p_17407_1 "MM.1S cell, cultured with pDCs" "MM.1S cell, cultured alone, control" +p_17440_1 "Brain, frontal cortex, HIV patients, Major depressive disorder (MDD)" "Brain, frontal cortex, HIV patients, no MDD" +p_17466_1 "iPrEC cell, Empty vector" "iPrEC cell, control" +p_17466_2 "iPrEC cell, USP2A mutant" "iPrEC cell, control" +p_17476_1 "Heart, E161K mutant" "Heart, ISC Control" +p_17480_1 "CD34+ mononuclear cells, fenretinide treated, 4uM, 48h" "CD34+ mononuclear cells, untreated" +p_17482_1 "DU145 cells, Stat3 down-regulated" "DU145 cells, control" +p_17482_2 "DU145 cells, Stat5a/b down-regulated" "DU145 cells, control" +p_17482_3 "CWR22Rv1 cells, Stat3 down-regulated" "CWR22Rv1 cells, control" +p_17482_4 "CWR22Rv1 cells, Stat5a/b down-regulated" "CWR22Rv1 cells, control" +p_17483_1 "DU145 cell, Stat5a/b silenced" "DU145 cell, control" +p_17508_1 "MCF-7 cells, miR-22 duplex transfection, 24h" "MCF-7 cells, negative control RNA duplex transfection, 24h" +p_17539_1 "cultured skin substitute, in vitro, 3 days of culture" normal human skin +p_17539_3 "cultured skin substitute, in vitro, 14 days of culture" normal human skin +p_17539_4 "cultured skin substitute, in vivo, 3 days of culture" normal human skin +p_17539_9 "cultured skin substitute, in vivo, 56 days of culture" normal human skin +p_17540_1 "MCF7 cell, CEACAM1-4S treated" "MCF7 cell, control" +p_17543_1 "vascular smooth muscle cells, siRNA targeting FoxM1, 48h" "vascular smooth muscle cells, control siRNA" +p_17549_1 "CD14 cell, CHM patient" "CD14 cell, control" +p_17549_2 "Primary Fibroblast cell, CHM patient" "Primary Fibroblast cell, control" +p_17551_1 "WM-266 cells, Pirin knockdown" "WM-266 cells, transfected with control siRNA" +p_17551_2 "WM-266 cells, Pirin knockdown" "WM-266 cells, transfection without adding oligonucleotide" +p_17612_1 Brain BA10 post-mortem schizophrenic; tissue Brain BA10 post-mortem control +p_17624_11 Ishikawa_VeryLowDose_BPA_24h treated; time course Ishikawa_Control_24h +p_17624_2 Ishikawa_HighDose_BPA_24h treated; time course Ishikawa_Control_24h +p_17624_5 Ishikawa_LowDose_BPA_24h treated; time course Ishikawa_Control_24h +p_17624_8 Ishikawa_VeryHighDose_BPA_24h treated; time course Ishikawa_Control_24h +p_17625_1 "Caco-2 cell, co-cultured THP-1 cell, 1h" "Caco-2 cell, control" +p_17625_2 "Caco-2, coculture_3h" "Caco-2, coculture_0h" +p_17625_3 "Caco-2, coculture_6h" "Caco-2, coculture_0h" +p_17625_4 "Caco-2, coculture_24h" "Caco-2, coculture_0h" +p_17625_5 "Caco-2, coculture_48h" "Caco-2, coculture_0h" +p_17636_1 "MDA-MB-436 cells, NF1-C2 over-expression" "MDA-MB-436 cells, wildtype" +p_17639_1 "Reticulocytes, umbilical cord blood" "Reticulocytes, adult periperal blood" +p_17700_1 "breast cancer sample, lab: Jules Bordet Institute" "breast cancer sample, lab: MD Anderson Cancer Center" +p_17708_4 "A549 cell line, TGFB1 treated, 4h" "A549 cell line, untreated" +p_17708_7 "A549 cell line, TGFB1 treated, 24h" "A549 cell line, untreated" +p_17714_1 neuroblastoma cell line under hypoxic conditions neuroblastoma cell line under normoxic conditions +p_17718_1 "StED cell, HTLV-1 positive" Postmitotic CD4 T cell +p_17718_2 "MT-2 cell, HTLV-1 positive" Postmitotic CD4 T cell +p_17743_1 "gastrointestinal stromal tumor, KIT mutation detected" "gastrointestinal stromal tumor, wild type, control" +p_17743_2 "gastrointestinal stromal tumor, PDGFRA mutation detected" "gastrointestinal stromal tumor, wild type, control" +p_17763_1 "Lesion patent macrophage cell, BT lesion" "Lesion patent macrophage cell, LL lesion" +p_17763_2 "Lesion patent macrophage cell, RR lesion" "Lesion patent macrophage cell, LL lesion" +p_17768_1 "HCC38 cells, breast cancer cell line" "MCF10A cells, non-breast cancer cell line" +p_17768_2 "HCC1008 cells, breast cancer cell line" "MCF10A cells, non-breast cancer cell line" +p_17768_3 "HCC1143 cells, breast cancer cell line" "MCF10A cells, non-breast cancer cell line" +p_17768_4 "HCC1395 cells, breast cancer cell line" "MCF10A cells, non-breast cancer cell line" +p_17768_5 "HCC1599 cells, breast cancer cell line" "MCF10A cells, non-breast cancer cell line" +p_17768_6 "HCC1937 cells, breast cancer cell line" "MCF10A cells, non-breast cancer cell line" +p_17768_7 "HCC2218 cells, breast cancer cell line" "MCF10A cells, non-breast cancer cell line" +p_17768_8 "BT474 cells, breast cancer cell line" "MCF10A cells, non-breast cancer cell line" +p_17768_9 "MCF7 cells, breast cancer cell line" "MCF10A cells, non-breast cancer cell line" +p_17777_1 "HMVEC, VEGF treated" "HMVEC, control" +p_17777_2 "HMVEC, VEGF, 8CPT treated" "HMVEC, control" +p_17777_3 "HMVEC, VEGF, ET treated" "HMVEC, control" +p_17785_1 "MCF10A cell, PI3K mutate, DMSO treated" "MCF10A cell, WT, DMSO treated" +p_17785_2 "MCF10A cell, PI3K mutate, GDC0941 treated" "MCF10A cell, WT, GDC0941 treated" +p_17827_1 "IMR32, inducible MEIS1-shRNA, doxycycline induction, 24h" "IMR32, inducible MEIS1-shRNA, 0h" +p_17827_2 "IMR32, inducible MEIS1-shRNA, doxycycline induction, 48h" "IMR32, inducible MEIS1-shRNA, 0h" +p_17827_3 "IMR32, inducible MEIS1-shRNA, doxycycline induction, 96h" "IMR32, inducible MEIS1-shRNA, 0h" +p_17827_4 "IMR32, inducible MEIS1-shRNA, doxycycline induction, 192h" "IMR32, inducible MEIS1-shRNA, 0h" +p_17832_1 "MCF-7 cell, Desferrioxamine treated" "MCF-7 cell, control" +p_17832_2 "MCF-7 cell, 2-hydroxy-1-napthylaldehyde isonicotinoyl hydrazone treated" "MCF-7 cell, control" +p_17861_1 "Acute rejection biopsy grade Ib, IIA from human transplanted kidney" Biopsy from non-rejecting human transplanted kidney +p_17889_1 "MCF7-I6, highly invasive cells" "MCF7-I0, weakly invasive cells" +p_17906_1 prostate cancer normal prostate +p_17906_2 bladder cancer normal bladder tissues +p_17907_1 breast cancer normal breast +p_17907_10 IGF1R IHC+ breast cancer IGF1R IHC- breast cancer +p_17907_11 EGFR IHC+ breast cancer EGFR IHC- breast cancer +p_17907_12 TOP2A IHC+ breast cancer TOP2A IHC- breast cancer +p_17907_13 FOXA1 IHC+ breast cancer FOXA1 IHC- breast cancer +p_17907_2 ERBB2 type breast cancer normal type breast cancer +p_17907_3 luminalA type breast cancer normal type breast cancer +p_17907_4 Basal type breast cancer normal type breast cancer +p_17907_5 ERBB2 IHC+ breast cancer ERBB2 IHC- breast cancer +p_17907_6 ER IHC+ breast cancer ER IHC- breast cancer +p_17907_7 PR IHC+ breast cancer PR IHC- breast cancer +p_17907_8 P53 IHC+ breast cancer P53 IHC- breast cancer +p_17907_9 Ki67 IHC+ breast cancer Ki67 IHC- breast cancer +p_17913_1 "Buccal mucosa cell, Smoker" "Buccal mucosa cell, Non-smoker" +p_17920_1 chronic Hodgkin lymphoma; early relapse chronic Hodgkin lymphoma; refractory +p_17920_2 chronic Hodgkin lymphoma; late relapse chronic Hodgkin lymphoma; refractory +p_17938_1 "T cell, cocultured RPE" RPE cell +p_17938_2 "T cell, cocultured RPE, AMD disease" "RPE cell, AMD disease" +p_17938_3 "T cell, cocultured RPE, AMD disease" "T cell, AMD disease" +p_17938_4 AMD: RPE only t-cell co-culture: RPE only +p_17938_5 AMD: RPE co-Tcells t-cell co-culture: RPE co-Tcells +p_17939_1 "HUVEC cell, MEK5 activated" "HUVEC cell, control" +p_17951_1 prostate cancer normal prostate +p_17987_1 "MIA.PACA2 cell, masitinib treated" "MIA.PACA2 cell, control" +p_17987_2 "MIA.PACA2 cell, gemcitabine treated" "MIA.PACA2 cell, control" +p_17987_3 "MIA.PACA2 cell, masitinib,gemcitabine treated" "MIA.PACA2 cell, control" +p_18000_1 "Panc1 cell, syk-silenced" "Panc1 cell, control" +p_18015_1 "CD133/2+ cells, primary glioblastoma" "CD133/2- cells, primary glioblastoma" +p_18043_1 BM-mesenchymal stem cells (MSC) culture osteogenic induction for 1 day treated BM-mesenchymal stem cells (MSC) culture +p_18043_2 BM-mesenchymal stem cells (MSC) culture osteogenic induction for 3 days treated BM-mesenchymal stem cells (MSC) culture +p_18043_3 BM-mesenchymal stem cells (MSC) culture osteogenic induction for 7 days treated BM-mesenchymal stem cells (MSC) culture +p_18047_1 H929 transfected with IKKB treated H929 control +p_18047_2 H929 transfected with NIK treated H929 control +p_18047_3 SACHI transfected with IKKB treated SACHI control +p_18047_4 SACHI transfected with IKKB treated SACHI control +p_18070_1 cell line derived from a xenograft of the MCF10ATk.cl2(MII) cells in nude mice that progressed to carcinoma (MIIIpB) MCF10A H-Ras transformed cell line (MIIpB) +p_18070_2 "MCF10CA1h (MIII), overexpressing the inhibitory Smad8" cell line derived from a xenograft of the MCF10ATk.cl2(MII) cells in nude mice that progressed to carcinoma (MIIIpB) +p_18105_1 "colorectal tissue, cancer" "colorectal tissue, adjacent normal" +p_18105_2 colorectal cancer normal +p_18113_1 "HMVEC cell, co-cultured with LS180 cell" "HMVEC cell, quiescent" +p_18113_2 "HMVEC cell, co-cultured with HT-29 cell" "HMVEC cell, quiescent" +p_18113_3 "HMVEC cell, co-cultured with Blood component" "HMVEC cell, quiescent" +p_18113_4 "HMVEC cell, co-cultured with Blood component + LS180 cell" "HMVEC cell, quiescent" +p_18113_5 "HMVEC cell, co-cultured with Blood component + HT-29 cell" "HMVEC cell, quiescent" +p_18123_1 "peripheral blood, Autism Spectrum Disorder" "peripheral blood, control" +p_18140_1 "Endometrium, on day of oocyte retrieval, pregnant" "Endometrium, on day of oocyte retrieval, not pregnant" +p_18146_1 "T47D cells, testosterone tested" "T47D cells, untreated" +p_18146_2 "T47D cells, testosterone-BSA treated" "T47D cells, untreated" +p_18146_3 "MDA-MB-231 cells, testosterone tested" "MDA-MB-231 cells, untreated" +p_18146_4 "MDA-MB-231 cells, testosterone-BSA treated" "MDA-MB-231 cells, untreated" +p_18147_1 fully reprogrammed iPS cell line Human embryonic stem cells +p_18147_2 partial iPS cell line Human embryonic stem cells +p_18147_3 fully reprogrammed iPS cell line Human foreskin fibroblast (HFF1) +p_18150_1 "Gliospheres, DZNep treated" "Gliospheres, control" +p_18180_1 Human gut mesentery derived MCiPS Human gut mesentery derived MSC +p_18180_2 hESC Human gut mesentery derived MSC +p_18182_1 "A549 cell, NME2 silenced" "A549 cell, control" +p_18195_1 "Hec50co cell, avastin dosed" "Hec50co cell, undosed control" +p_18198_1 "KOPT-K1 cells, treated with SAHM1" "KOPT-K1 cells, treated with DMSO" +p_18198_2 "HPB-ALL cells, treated with SAHM1" "HPB-ALL cells, treated with DMSO" +p_18226_1 iPS fibroblast +p_18235_1 "Airway epithelial cell, tobacco type 1" "Airway epithelial cell, control" +p_18235_10 "Airway epithelial cell, tobacco type 10" "Airway epithelial cell, control" +p_18235_2 "Airway epithelial cell, tobacco type 2" "Airway epithelial cell, control" +p_18235_3 "Airway epithelial cell, tobacco type 3" "Airway epithelial cell, control" +p_18235_4 "Airway epithelial cell, tobacco type 4" "Airway epithelial cell, control" +p_18235_5 "Airway epithelial cell, tobacco type 5" "Airway epithelial cell, control" +p_18235_6 "Airway epithelial cell, tobacco type 6" "Airway epithelial cell, control" +p_18235_7 "Airway epithelial cell, tobacco type 7" "Airway epithelial cell, control" +p_18235_8 "Airway epithelial cell, tobacco type 8" "Airway epithelial cell, control" +p_18235_9 "Airway epithelial cell, tobacco type 9" "Airway epithelial cell, control" +p_18239_1 "T-ALL cells, JAK1 mutation" "T-ALL cells, wild type JAK1" +p_18269_1 Undifferentiated elongate HepaRG; treat Differentiated well-confluent HepaRG +p_18269_2 HepG2; treat Differentiated well-confluent HepaRG +p_18269_3 Primary hepatocyte; treat Differentiated well-confluent HepaRG +p_18269_4 Liver; treat Differentiated well-confluent HepaRG +p_18271_1 ganglioneuromas ganglioneuroblastomas +p_18277_1 MIAPaCa2 cells expressing alpha2 and maintained on collagenI MIAPaCa2 cells maintained under drug selection +p_18277_2 MIAPaCa2 cells expressing alpha2 and maintained in standard culture MIAPaCa2 cells maintained under drug selection +p_18277_3 MIAPaCa2 cells expressing alpha9alpha2 chimera and maintained on tenascin FNIII MIAPaCa2 cells maintained under drug selection +p_18277_4 MIAPaCa2 cells expressing alpha2 cytoplasmic deletion and maintained on collagenI MIAPaCa2 cells maintained under drug selection +p_18309_1 "PBMC, from Alzheimer's disease patient" "PBMC, from normal elder individuals" +p_18309_2 "PBMC, from mild cognitive impairment patients" "PBMC, from normal elder individuals" +p_18313_1 "CD57 positive T cell, paraproteinemia patients" "CD57 negative T cell, paraproteinemia patients" +p_18323_1 PBMC; Protected from malaria vaccine trial treated PBMC; NonProtected +p_18323_2 PBMC; Delay from malaria vaccine trial treated PBMC; NonProtected +p_18331_1 "Breast cancer cell, no-sensitive to Valproic acid" "Breast cancer cell, sensitive to Valproic acid" +p_18331_2 "Breast cancer cell, resistant to Valproic acid" "Breast cancer cell, sensitive to Valproic acid" +p_18349_1 "Fetal cortex, XY_trisomy 7" "Fetal cortex, XY_diploid" +p_18370_1 NTci PTci +p_18370_2 MT1 PTci +p_18370_3 MT1 NTci +p_18373_1 "HUVEC, MAGP2 treated" "HUVEC, control" +p_18373_2 "OVCA429 cell, MAGP2 treated" "OVCA429 cell, control" +p_18391_1 "Adipose-derived stromal/stem cells (ASC), adipogenic induced" "Adipose-derived stromal/stem cells (ASC), control" +p_18454_1 "Normal human bronchial epithelian cell, 5-aza treated" "Normal human bronchial epithelian cell, control" +p_18454_2 "Normal human small airway epithelian cell, 5-aza treated" "Normal human small airway epithelian cell, control" +p_18462_1 primary colorectal carcinoma normal colon +p_18462_2 liver metastasis normal liver +p_18476_1 "U937T cells, PLZF-RAR¥á induction, 48h" "U937T cells, no induction of PLZF-RAR¥á, control" +p_18486_1 "A2780 cell, CDk-125 treated" "A2780 cell, untreated" +p_18486_2 "A2780 cell, CDk-509 treated" "A2780 cell, untreated" +p_18494_1 HepG2 hypoxia (0.5%O2) treatment 4h; time course HepG2 normoxia +p_18494_3 HepG2 hypoxia (0.5%O2) treatment 12h; time course HepG2 normoxia +p_18494_4 U87 hypoxia (0.5%O2) treatment 4h; time course U87 normoxia +p_18494_6 U87 hypoxia (0.5%O2) treatment 12h; time course U87 normoxia +p_18494_7 MB231 hypoxia (0.5%O2) treatment 4h; time course MB231 normoxia +p_18494_9 MB231 hypoxia (0.5%O2) treatment 12h; time course MB231 normoxia +p_18497_1 Pre-B-ALL Common ALL +p_18497_2 T-ALL Common ALL +p_18498_1 "A2780 cells, CDK-887 treated" "A2780 cells, untreated" +p_18501_1 "MCF-7 cells, CDK-125 treated" "MCF-7 cells, untreated" +p_18504_1 "A2780 cells, Flavopiridol treated" "A2780 cells, untreated" +p_18521_1 HUVEC+MAGP2 treatment HUVEC control +p_18521_2 OVCA429+MAGP2 treatment OVCA429 control +p_18521_3 Ovarian Tumor; ovary cancer normal ovary +p_18557_1 "Endometrium, on the day of oocyte retrieval, hCG treated" "Endometrium, on the day of oocyte retrieval, rFSH treated" +p_18560_1 "Ls174T cell, pTER-B-catenin, dox treated" "Ls174T cell, pTER-B-catenin, control" +p_18560_2 "Ls174T cell, L8 treated dox treated" "Ls174T cell, L8 treated control" +p_18565_1 CD16+ monocytes CD16- monocytes +p_18571_1 "MDA-MB-468 cell line, Rapa-treated, 24 h" "MDA-MB-468 cell line, DMSO-treated, 24 h" +p_18571_2 "breast tumor xenograft, Rapamycin treated, 1 day" "breast tumor xenograft, DMSO-treated, 1 day" +p_18571_3 "breast tumor xenograft, Rapamycin treated, 22 day" "breast tumor xenograft, DMSO-treated, 22 day" +p_18590_1 "primary human keratinocytes, differentiated with addition of Ca2+ (1.2mM), 3 days" "primary human keratinocytes, undifferentiated" +p_18590_2 "primary human keratinocytes, DNMT1 knock down" "primary human keratinocytes, undifferentiated" +p_18590_3 primary keratinocytes; DNMT1 knockdown primary keratinocytes; differentiated +p_18608_1 "CD133 cell, coronary artery disease (CAD) patient, before exercise" "CD133 cell, healthy" +p_18608_2 "CD133 cell, coronary artery disease (CAD) patient, after exercise 3month" "CD133 cell, healthy" +p_18608_3 "CD133 cell, coronary artery disease (CAD) patient, after exercise 3month" "CD133 cell, coronary artery disease (CAD) patient, before exercise" +p_18618_1 hiPSC footprint-free clone1 Neural progenitor cells +p_18618_2 hiPSC footprint-free clone2 Neural progenitor cells +p_18618_3 HUES6 ES; Human Embryonic Stem Cells Neural progenitor cells +p_18618_4 Cythera ES; Human Embryonic Stem Cells Neural progenitor cells +p_18625_1 "DLD-1 cells, transfected with miR-145" "DLD-1 cells, mock transfected" +p_18632_1 "HEK293E cell, TDP-43 knockdown" "HEK293E cell, control" +p_18640_1 "CD34 cell, HPIP-wt" "CD34 cell, control" +p_18640_2 "CD34 cell, NRPID mutant" "CD34 cell, control" +p_18679_1 Human embryonic stem cells Human erythroblast +p_18680_1 "Ovarian cancer cell, low CXCR4" "Ovarian cancer cell, high CXCR4" +p_18681_1 ascites cell sample from non-responsive patient to infliximab; ovary cancer; treat ascites cell sample from responsive patient to infliximab +p_18728_1 breast cancer; responder breast cancer; non-responder +p_18728_2 "breast cancer, ER+" "breast cancer, ER-" +p_18728_3 "breast cancer, PR+" "breast cancer, PR-" +p_18728_4 "breast cancer, HER2+" "breast cancer, HER2-" +p_18736_1 "Lymph node, mantle cell lymphoma patient" "Lymph node, follicular lymphoma patient" +p_18739_1 "HEK293 cells, in vivo cell expansion (NOD.Scid mice), 3 weeks" "HEK293 cells, cultivated in DMEM" +p_18773_1 "CAL-51 cell, side population" "CAL-51 cell, non-side population" +p_18781_1 Blood - Axial Spondyloarthropathy; tissue Blood - Control +p_18781_2 Blood - Sarcoidosis; tissue Blood - Control +p_18791_10 "Dendritic cells infected with Newcastle disease virus (NDV), 18 hr" "Dendritic cells infected with allantoic fluid (AF), 18 hr" +p_18809_1 "Placenta, Preterm spontaneous delivery" "Placenta, Term spontaneous delivery" +p_18810_1 "neutrophils, exposed to E.coli strain MG1655, 60 min" "Neutrophile, mock treated, 60 min" +p_18810_2 "neutrophils, exposed to E.coli strain UTI89, 60 min" "Neutrophile, mock treated, 60 min" +p_18811_1 "retinal pigment epithelium (RPE), adult" "retinal pigment epithelium (RPE), fetal" +p_18826_1 "UMCL01-101 cell, cultured in RWV Bioreactor (3D assembly)" "UMCL01-101 cell, grown in suspension culture" +p_18842_1 "lung, tumor" "lung, control" +p_18850_1 "Placenta cell, Cesarean delivery" "Placenta cell, Labour spontaneous delivery" +p_18864_1 breast cancer p53 mutated breast cancer WT +p_18864_2 breast cancer ER+ breast cancer ER- +p_18864_3 breast cancer PR+ breast cancer PR- +p_18864_4 breast cancer HER2+ breast cancer HER2- +p_18864_5 breast cancer BRCA mutated breast cancer BRCA WT +p_18866_1 "CLL-I83E95 cells, miR-15a/16-1 expression" "CLL-I83E95 cells, empty vector" +p_18892_1 "U87MG glial cell, AEBP silenced with siRNA" "U87MG glial cell, scrambled siRNA" +p_18897_1 DietSensitive _1 day; blood DietResistant _1 day +p_18897_2 DietSensitive _3 weeks; blood DietResistant _3 weeks +p_18897_3 DietSensitive _6 weeks; blood DietResistant _6 weeks +p_18897_4 DietSensitive _1 day; blood Lean_1 day +p_18897_6 Human XYY triploid; tissue Human male diploid +p_18901_1 GBS6 cells transfected with POU5F1 siRNA-1 treated GBS6 cells transfected with negative control siRNA 2nd +p_18901_2 GBS6 cells transfected with POU5F1 siRNA-2 treated GBS6 cells transfected with negative control siRNA 2nd +p_18903_1 MCF-7 cell MCF-7-14 cell +p_18903_2 MDA-MB-231 cell MCF-7-14 cell +p_18906_1 "CD36+EPC cell, B19V NS1 treated, 12h" "CD36+EPC cell, control, 12h" +p_18906_2 "CD36+EPC cell, B19V NS1 treated, 24h" "CD36+EPC cell, control, 24h" +p_18906_3 "CD36+EPC cell, B19V NS1 treated, 48h" "CD36+EPC cell, control, 48h" +p_18912_1 MCF-7R4 cells MCF-7 cells +p_18913_1 "HUVEC, VEGF treated, siRNA targeting Egr-3, 0h" "HUVEC, VEGF treated, 0h" +p_18913_2 "HUVEC, VEGF treated, siRNA targeting Egr-3, 1h" "HUVEC, VEGF treated, 1h" +p_18913_3 "HUVEC, VEGF treated, siRNA targeting Egr-3, 4h" "HUVEC, VEGF treated, 4h" +p_18913_4 "HUVEC, Egr-3 siRNA #2, VEGF 0h treatment; time course" "control, VEGF 0h" +p_18913_5 "HUVEC, Egr-3 siRNA #2, VEGF 1h treatment; time course" "control, VEGF 1h" +p_18913_6 "HUVEC, Egr-3 siRNA #2, VEGF 4h treatment; time course" "control, VEGF 4h" +p_18914_1 "Somatic cell, GDNF-TSC" "Spermatogonia cell, GDNF-SSC" +p_18931_1 "Mammary epithelial cells, FACS sorted, PKH-Positive" "Mammary epithelial cells, FACS sorted, PKH-Negative" +p_18946_1 "DG75, miR-K10 treated" "DG75, miR-GFP treated" +p_18946_2 "DG75, miR-K12 treated" "DG75, miR-GFP treated" +p_18946_3 "EA.hy296 cell, miR-K10 treated" "EA.hy296 cell, miR-GFP treated" +p_18946_4 "EA.hy296 cell, miR-K12 treated" "EA.hy296 cell, miR-GFP treated" +p_18947_1 "Sosp-9607 cells, high metastatic potential" "Sosp-9607cells, low metastatic potential" +p_18947_2 "Saos-2 cells, high metastatic potential" "Saos-2 cells, low metastatic potential" +p_18959_1 "RA-specified astrocyte, 210d" "Neuroepithelial cell, 17d" +p_18959_2 "FGF8-specified astrocyte, 210d" "Neuroepithelial cell, 17d" +p_18959_3 Day-180 FGF8-specified astrocytes Day-17 neuroepithelial cells +p_18969_1 obstructed fetal kidney normal fetal kidney +p_18973_1 "HepG2 cell, HNF4a,g knockdown" "HepG2 cell, control" +p_18995_1 "Lung cell, Donation after cardiac death (DCD) patient, post-transplant" "Lung cell, Donation after cardian death (DCD) patient, pre-transplant" +p_18995_2 "Lung cell, Donation after brain death (DBD) patient, post-transplant" "Lung cell, Donation after brain death (DBD) patient, pre-transplant" +p_18997_1 "testicular biopsy,spermatogenic stage - score 3" "testicular biopsy,spermatogenic stage - score 2" +p_19018_1 "Imr 90 cell, old, 3% oxygen" "Imr 90 cell, young, 3% oxygen" +p_19018_2 "Imr 90 cell, senescent, 20% oxygen" "Imr 90 cell, young, 20% oxygen" +p_19060_1 "meniscal tissue, osteoarthritis" "meniscal tissue, normal" +p_19069_01 Adult T-cell leukemia/lymphoma Activated CD4+ T-cell +p_19069_02 Anapalstic Large cell lymphoma ALK- Activated CD4+ T-cell +p_19069_03 Anapalstic Large cell lymphoma ALK+ Activated CD4+ T-cell +p_19069_04 Angioimmunoblastic T-cell lymphoma Activated CD4+ T-cell +p_19069_05 "Peripheral T-Cell lymphoma, unspecified" Activated CD4+ T-cell +p_19069_06 Resting CD4+ T-cells Activated CD4+ T-cell +p_19069_07 "T-cell acute lymphoblastic leukemia, JURKAT" Activated CD4+ T-cell +p_19069_08 "T-cell acute lymphoblastic leukemia, MOLT3" Activated CD4+ T-cell +p_19069_09 "T-cell acute lymphoblastic leukemia, PEER" Activated CD4+ T-cell +p_19069_10 "T-cell line, Sezary syndrome" Activated CD4+ T-cell +p_19069_11 T-cell prolymphocytic leukemia Activated CD4+ T-cell +p_19098_1 "HUVEC cell, unspread, VEGF" "HUVEC cell, unspread, no VEGF" +p_19098_2 "HUVEC cell, spread, VEGF" "HUVEC cell, spread, no VEGF" +p_19123_1 "MCF7 cells, media with 25mM lactic acid, 1h" "MCF7 cells, control media, 1h" +p_19123_2 "MCF7 cells, media with 25mM lactic acid, 4h" "MCF7 cells, control media, 4h" +p_19123_3 "MCF7 cells, media with 25mM lactic acid, 12h" "MCF7 cells, control media, 12h" +p_19123_4 "MCF7 cells, media with 25mM lactic acid, 24h" "MCF7 cells, control media, 24h" +p_19123_5 "MCF7 cell, lactic acidosis" "MCF7 cells, control" +p_19123_6 "MCF7 cell, glucose deprivation" "MCF7 cells, control" +p_19123_7 "MCF7 cell, hypoxia" "MCF7 cells, control" +p_19128_1 "PBMC, Astragalus treated, 18h" "PBMC, untreated, 18h" +p_19128_2 "PBMC, Astragalus treated, 18h" "PBMC, EtOH treated, 18h" +p_19128_3 "PBMC, Sambucus treated, 18h" "PBMC, EtOH treated, 18h" +p_19128_4 "PBMC, Urtica treated, 18h" "PBMC, EtOH treated, 18h" +p_19128_5 "PBMC, Sambucus treated, 18h" "PBMC, untreated, 18h" +p_19128_6 "PBMC, Urtica treated, 18h" "PBMC, untreated, 18h" +p_19197_1 "SK-N-MC cells,hypoxia, grown as spheroid" "SK-N-MC cells, normoxia, grown as spheroid" +p_19197_2 "TC-252 cells, hypoxia, grown as spheroid" "TC-252 cells, normoxia, grown as spheroid" +p_19201_1 "NB4 cells, ATRA treated, 4h" "NB4 cells, untreatead" +p_19201_2 "NB4 cells, ATRA treated, 12h" "NB4 cells, untreatead" +p_19201_3 "NB4 cells, ATRA treated, 24h" "NB4 cells, untreatead" +p_19201_4 "NB4 cells, ATRA treated, 48h" "NB4 cells, untreatead" +p_19201_5 "NB4 cells, ATRA treated, 72h" "NB4 cells, untreatead" +p_19240_1 "Endothelial cell, IL-1 beta treated, 4h" "Endothelial cell, control" +p_19240_2 "Endothelial cell, IL-1 beta treated, 8h" "Endothelial cell, control" +p_19240_3 "Endothelial cell, IL-1 beta treated, 16h" "Endothelial cell, control" +p_19246_1 "B cell lymphoma, activated, fresh/frozen" "B cell lymphoma, unclassified, fresh/frozen" +p_19246_2 "B cell lymphoma, greminal center, fresh/frozen" "B cell lymphoma, unclassified, fresh/frozen" +p_19246_3 "B cell lymphoma, activated, formalin fixed paraffin embedded" "B cell lymphoma, unclassified, formalin fixed paraffin embedded" +p_19246_4 "B cell lymphoma, greminal center, formalin fixed paraffin embedded" "B cell lymphoma, unclassified, formalin fixed paraffin embedded" +p_19314_1 "peripheral blood mononuclear cells, Sarcoidosis" "peripheral blood mononuclear cells, healthy control" +p_19314_2 "peripheral blood mononuclear cells, hypersensitivity pneumonitis" "peripheral blood mononuclear cells, healthy control" +p_19315_1 "THP-1 cell, LPS treated" "THP-1 cell, control" +p_19315_2 "THP-1 cell, ST treated" "THP-1 cell, control" +p_19332_1 "motor neuron, CHMP2B mutant individual" "motor neuron, Neurologically normal control" +p_19339_1 "leukocyte, myocardial infarction" "leukocyte, normal" +p_19345_1 "Neural progenitor cell, HCMV infected, 4h" "Neural progenitor cell, control" +p_19345_2 "Neural progenitor cell, HCMV infected, 12h" "Neural progenitor cell, control" +p_19345_3 "Neural progenitor cell, HCMV infected, 24h" "Neural progenitor cell, control" +p_19352_1 ovary cancer Ovarian surface epithelium cells +p_19383_1 "Breast cell, BRCA1 mutant" "Breast cell, wild type" +p_19383_2 "Breast cell, BRCA2 mutant" "Breast cell, wild type" +p_19383_3 "Ovary cell, BRCA1 mutant" "Ovary cell, wild type" +p_19383_4 "Ovary cell, BRCA2 mutant" "Ovary cell, wild type" +p_19393_1 "Primary subcutaneous preadipocyte cell, exposed to glucocorticoid" "Primary subcutaneous preadipocyte cell, control" +p_19406_1 "FADU cell, expressed dODD" "FADU cell, expressed control" +p_19406_2 "FADU cell, expressed Twist1" "FADU cell, expressed control" +p_19406_3 "FADU cell, expressed Bmi1" "FADU cell, expressed control" +p_19445_1 "LNCaP cells, DHT treated" "LNCaP cells, serum starved, control" +p_19445_2 "LNCaP cells, DHT + Etoposide treated" "LNCaP cells, serum starved, control" +p_19445_3 "LNCaP cells, DHT + Merbarone treated" "LNCaP cells, serum starved, control" +p_19445_4 "LNCaP cells, control shRNA, DHT treated" "LNCaP cells, control shRNA" +p_19445_5 "LNCaP cells, shRNA targeting TOPO2B" "LNCaP cells, control shRNA" +p_19445_6 "LNCaP cells, shRNA targeting TOPO2B, DHT treated" "LNCaP cells, control shRNA" +p_19495_1 "Hepatocellular caicinoma cells, HisOH treated" "Hepatocellular carcinoma cells, control" +p_19510_1 "WI-38 cell, 0.1uM BPDE" "WI-38 cell, DMSO control" +p_19510_2 "WI-38 cell, 0.5uM BPDE" "WI-38 cell, DMSO control" +p_19510_3 "WI-38 cell, 1uM BPDE" "WI-38 cell, DMSO control" +p_19533_1 "Diaphargm muscle, after surgery" "Diaphargm muscle, before surgery" +p_19592_1 "H460 cell, DUSP1/MKP1 stimulated" "H460 cell, control" +p_19615_1 Recurrent breast cancer non-recurrent breast cancer +p_19615_2 ER+ breast cancer ER- breast cancer +p_19615_3 PR+ breast cancer PR- breast cancer +p_19615_4 HER2+ breast cancer HER2- breast cancer +p_19615_5 Node + breast cancer Node - breast cancer +p_19615_6 Ductal breast cancer lobular breast cancer +p_19625_1 "THP1 cell, LPS treated" "THP1 cell, control" +p_19625_2 "THP1 cell, LPS treated, Q10 treated" "THP1 cell, control" +p_19627_1 "THP1 cell, LPS treated" "THP1 cell, control" +p_19627_2 "THP1 cell, LPS treated, Q10H2 treated" "THP1 cell, control" +p_19638_1 "MCF cells, 17AAG treated" "MCF cells, untreated" +p_19638_2 "MCF cells, AUY922 treated" "MCF cells, untreated" +p_19638_3 "MCF cells, CDK-887 treated" "MCF cells, untreated" +p_19638_4 "MCF cells, doxorubicin treated" "MCF cells, untreated" +p_19638_5 "MCF cells, E973 treated" "MCF cells, untreated" +p_19638_6 "MCF cells, SN38 treated" "MCF cells, untreated" +p_19639_1 "MCF7 cell, Long-term estrogen-deprived" "MCF7 cell, control" +p_19639_2 "ZR75-1 cell, Long-term estrogen-deprived" "ZR75-1 cell, control" +p_19639_3 "MDA-361 cell, Long-term estrogen-deprived" "MDA-361 cell, control" +p_19639_4 "HCC-1428 cell, Long-term estrogen-deprived" "HCC-1428 cell, control" +p_19643_1 "MSC cell, PGC-1 alpha infected" "MSC cell, Ad-GFP infected" +p_19650_1 Intraductal papillary-mucinous adenoma cell Normal main pancreatic duct cell +p_19650_2 Intraductal papillary-mucinous carcinoma cell Normal main pancreatic duct cell +p_19650_3 Intraductal papillary-mucinous tumor Normal main pancreatic duct cell +p_19670_1 "SKBR3 cells, siRNA targeting p53" "SKBR3 cells, siRNA targeting LacZ, control" +p_19670_10 "SKBR3 cells knocked down for mutp53 expression, treated with vitamin D3 for50h; time course" SKBR3 control treated with vitamin D3 for 50h +p_19670_2 "SKBR3 cells, siRNA targeting p53., vitamin D3 treated, 8h" "SKBR3 cells, siRNA targeting LacZ, vitamin D3 treated, 8h, control" +p_19670_3 "SKBR3 cells, siRNA targeting p53, vitamin D3 treated, 20h" "SKBR3 cells, siRNA targeting LacZ, vitamin D3 treated, 20h, control" +p_19670_4 "SKBR3 cells, siRNA targeting p53, vitamin D3 treated, 50h" "SKBR3 cells, siRNA targeting LacZ, vitamin D3 treated, 50h, control" +p_19670_5 "SKBR3 cells knocked down for mutp53 expression, treated with vitamin D3 for 20h; time course" SKBR3 cells knocked down for mutp53 expression +p_19670_6 "SKBR3 cells knocked down for mutp53 expression, treated with vitamin D3 for50h; time course" SKBR3 cells knocked down for mutp53 expression +p_19670_7 SKBR3 cells knocked down for mutp53 expression; treat; time course SKBR3 control cells +p_19670_8 "SKBR3 cells knocked down for mutp53 expression, treated with vitamin D3 for 8h; time course" SKBR3 control treated with vitamin D3 for 8h +p_19670_9 "SKBR3 cells knocked down for mutp53 expression, treated with vitamin D3 for 20h; time course" SKBR3 control treated with vitamin D3 for 20h +p_19672_1 "CCSM cell, MaxiK silenced" "CCSM cell, control" +p_19678_1 "U87TR-Da cells, DACH1-induced, DMEMF (serum-containing)" "U87TR-Da cells, DACH1-silenced, DMEMF (serum-containing)" +p_19678_2 "U87TR-Da cells, DACH1-induced, NBE (serum-free)" "U87TR-Da cells, DACH1-silenced, NBE (serum-free)" +p_19680_1 "M07 cell line, anti-miR-125b treated" "M07 cell line, non-silencing control" +p_19680_2 "CMK cell line, anti-miR-125b treated" "CMK cell line, non-silencing control" +p_19680_3 "M07 cell line, anti-miR-125b; siRNA treat" "M07 cell line, non-silencing control" +p_19681_1 "Leukemic blast cell, ML, Down syndrome patient" "Leukemic blast cell, AML patient" +p_19681_2 "Leukemic blast cell, Down syndrome, transient leukemia" "Leukemic blast cell, AML patient" +p_19686_1 "Hs683 cell, shQk-2 infected" "Hs683 cell, shGFP infected" +p_19686_2 "Hs683 cell, shQk-5 infected" "Hs683 cell, shGFP infected" +p_19688_1 "Hs683 cell , QK-knockdown, miR-20a treated" "Hs683 cell , QK-knockdown, control" +p_19690_1 "U87 cell , QK-knockdown, miR-20a treated" "U87 cell , QK-knockdown, control" +p_19693_1 Hs683 cells infected with shQk-2; treat Hs683 cells infected with shGFP as control +p_19693_2 Hs683 cells infected with shQk-5; treat Hs683 cells infected with shGFP as control +p_19693_3 QK-knockdown Hs683 cells transduced with and miR-20a; siRNA treat QK-knockdown Hs683 cells transduced with a scrambled non-targeting microRNA (miR-NT) +p_19693_4 QK-knockdown U87 transduced with miR-20a; siRNA treat QK-knockdown U87 transduced with a scrambled non-targeting microRNA (miR-NT) +p_19697_1 HER2+ breast cancer HER2- breast cancer +p_19697_2 Node + breast cancer Node - breast cancer +p_19697_3 Recurrent breast cancer non-recurrent breast cancer +p_19703_1 "P493-6 B cell, Low Myc" "P493-6 B cell, No Myc" +p_19703_2 "P493-6 B cell, High Myc" "P493-6 B cell, No Myc" +p_19713_1 "PCSC-1 cell, sphere type" "PCSC-1 cell, parental" +p_19713_2 "PCSC-2 cell, sphere type" "PCSC-2 cell, parental" +p_19713_3 "PCSC-3 cell, sphere type" "PCSC-3 cell, parental" +p_19728_1 Apilocytic astrocytoma pooled normal brain tissue +p_19728_2 diffusely infiltrating astrocytic gliomas pooled normal brain tissue +p_19728_3 anaplastic astrocytomas pooled normal brain tissue +p_19728_4 Glioblastoma multiforme (GBM) glioblastomas pooled normal brain tissue +p_19735_1 hESC Ebs differentiated for 14 days in pro-angiogenic cytokines Human Umbilical Vein ECs cultured in serum free conditions for 48 hours +p_19735_2 purified hESC-derived ECs isolated at day 14 of differentiation in the presence of TGFbeta inhibition Human Umbilical Vein ECs cultured in serum free conditions for 48 hours +p_19735_3 purified hESC-derived ECs isolated at day 14 of differentiation and cultured for an additional 10 days in the presence of TGFbeta inhibition Human Umbilical Vein ECs cultured in serum free conditions for 48 hours +p_19735_4 Human Umbilical Vein Smooth Muscle Cells cultured in serum free conditions for 48 hours Human Umbilical Vein ECs cultured in serum free conditions for 48 hours +p_19735_5 isolated and Human Cord Blood CD34+ Cells Human Umbilical Vein ECs cultured in serum free conditions for 48 hours +p_19737_1 "MDA-MB-231 cell, miR-145 overexpress" "MDA-MB-231 cell, control" +p_19777_1 "Fulvestrant-resistant breast cancer cell, si221 treated" "Fulvestrant-resistant breast cancer cell, control" +p_19777_2 "Fulvestrant-resistant breast cancer cell, si222 treated" "Fulvestrant-resistant breast cancer cell, control" +p_19797_1 "HeLa cell, chicken HSF1" "HeLa cell, wt HSF1" +p_19797_2 "HeLa cell, mutated human HSF1" "HeLa cell, wt HSF1" +p_19804_1 lung cancer normal lung tissue +p_19810_1 "HTR-8 cell, P.gingivalis infected" "HTR-8 cell, control" +p_19816_1 "HUVEC cell, IL1-beta treated" "HUVEC cell, control" +p_19816_2 "HUVEC cell, Actinomycin D treated" "HUVEC cell, control" +p_19816_3 "HUVEC cell, Actinomycin D +IL1-beta treated" "HUVEC cell, control" +p_19816_4 "HUVEC cell, with Hank's buffered salt + vWF" "HUVEC cell, with Hank's buffered salt" +p_19826_1 "Gastric cell, cancer, stage 2" "Gastric adjacent tissue, non cancer" +p_19862_1 "colorectal cancer tissue, bevacizumab_non-responder" "colorectal cancer tissue, bevacizumab_responder" +p_19864_01 shRB (Growing) MLP (Growing) +p_19864_02 shp107 (Growing) MLP (Growing) +p_19864_03 shp130 (Growing) MLP (Growing) +p_19864_04 shRB (0.1% FBS) MLP (0.1% FBS) +p_19864_05 shp107 (0.1% FBS) MLP (0.1% FBS) +p_19864_06 shp130 (0.1% FBS) MLP (0.1% FBS) +p_19864_07 shRB (Confluent) MLP (Confluent) +p_19864_08 shp107 (Confluent) MLP (Confluent) +p_19864_09 shp130 (Confluent) MLP (Confluent) +p_19864_1 "IMR 90 cell, MLP treated, 0.1% FBS" "IMR 90 cell, MLP treated, growing" +p_19864_10 "IMR 90 cell, shRB treated, senescent" "IMR 90 cell, shRB treated, growing" +p_19864_11 "IMR 90 cell, shp107 silenced, senescent" "IMR 90 cell, shp107 silenced, growing" +p_19864_12 "IMR 90 cell, shp130 silenced, senescent" "IMR 90 cell, shp130 silenced, growing" +p_19864_2 "IMR 90 cell, shRB treated, 0.1% FBS" "IMR 90 cell, shRB treated, growing" +p_19864_3 "IMR 90 cell, shp107 silenced, 0.1% FBS" "IMR 90 cell, shp107 silenced, growing" +p_19864_4 "IMR 90 cell, shp130 silenced, 0.1% FBS" "IMR 90 cell, shp130 silenced, growing" +p_19864_5 "IMR 90 cell, MLP treated, confluent" "IMR 90 cell, MLP treated, growing" +p_19864_6 "IMR 90 cell, shRB treated, confluent" "IMR 90 cell, shRB treated, growing" +p_19864_7 "IMR 90 cell, shp107 silenced, confluent" "IMR 90 cell, shp107 silenced, growing" +p_19864_8 "IMR 90 cell, shp130 silenced, confluent" "IMR 90 cell, shp130 silenced, growing" +p_19864_9 "IMR 90 cell, MLP treated, senescent" "IMR 90 cell, MLP treated, growing" +p_19882_1 PTL ECs Reactive lymph node-derived ECs +p_19882_2 DLBCL ECs Reactive lymph node-derived ECs +p_19899_1 "IMR90 cells, growing, shRNA targeting RB" "IMR90 cells, growing, vector control" +p_19899_10 "IMR90 cells, ras-induced senescence, shRNA targeting RB" "IMR90 cells, ras-induced senescence, vector control" +p_19899_11 "IMR90 cells, ras-induced senescence, shRNA targeting p107" "IMR90 cells, ras-induced senescence, vector control" +p_19899_12 "IMR90 cells, ras-induced senescence, shRNA targeting p130" "IMR90 cells, ras-induced senescence, vector control" +p_19899_2 "IMR90 cells, growing, shRNA targeting p107" "IMR90 cells, growing, vector control" +p_19899_3 "IMR90 cells, growing, shRNA targeting p130" "IMR90 cells, growing, vector control" +p_19899_4 "IMR90 cells, low serum quiescence (0.1% FBS), shRNA targeting RB" "IMR90 cells, low serum quiescence (0.1% FBS), vector control" +p_19899_5 "IMR90 cells, low serum quiescence (0.1% FBS), shRNA targeting p107" "IMR90 cells, low serum quiescence (0.1% FBS), vector control" +p_19899_6 "IMR90 cells, low serum quiescence (0.1% FBS), shRNA targeting p130" "IMR90 cells, low serum quiescence (0.1% FBS), vector control" +p_19899_7 "IMR90 cells, confluent quiescence, shRNA targeting RB" "IMR90 cells, confluent quiescence, vector control" +p_19899_8 "IMR90 cells, confluent quiescence, shRNA targeting p107" "IMR90 cells, confluent quiescence, vector control" +p_19899_9 "IMR90 cells, confluent quiescence, shRNA targeting p130" "IMR90 cells, confluent quiescence, vector control" +p_19902_1 "T3 cell, MEF controled medium" "T3 cell, MEF medium" +p_19902_2 "T3 cell, HDF controled medium" "T3 cell, HDF medium" +p_19959_1 "Endometrium, on day of oocyte retrieval, hCG: 1-1.5 ng/ml" "Endometrium, on day of oocyte retrieval, hCG <=0.9ng/ml" +p_19959_2 "Endometrium, on day of oocyte retrieval, hCG > 1.5ng/ml" "Endometrium, on day of oocyte retrieval, hCG <=0.9ng/ml" +p_19963_1 "hyperplastic polyp, familial, proximal" "normal colonic mucosa cell, familial, proximal" +p_19963_2 "hyperplastic polyp, sporadic, proximal" "normal colonic mucosa cell, familial, proximal" +p_19963_3 "hyperplastic polyp, sporadic, distal" "normal colonic mucosa cell, familial, distal" +p_19963_4 "hyperplastic polyp, familial, distal" "normal colonic mucosa cell, familial, distal" +p_19982_1 Renal oncocytoma Chromophobe renal cell carcinoma +p_20033_1 "iPSC, derived from hASC, using minicircle reprogramming vector" hESC +p_20033_2 "iPSC, derived from hASC, using lentiviral reprogramming vector" hESC +p_20033_3 "iPSC, from episomal vectors" hESC +p_20033_4 "iPSC, from episomal vectors" "Foreskin Cells, Parental" +p_20033_5 "iPSC, derived from hASC, using minicircle reprogramming vector" "adipose stem cells, parental" +p_20033_6 "iPSC, derived from hASC, using lentiviral reprogramming vector" "adipose stem cells, parental" +p_20036_1 antler mesemchyme antler velvet +p_20036_2 antler pedicle skin antler velvet +p_20036_3 antler frontal skin antler velvet +p_20037_1 "HeLa cell, Cdr2 siRNA" "HeLa cell, control siRNA" +p_20058_1 "AGS cell, non-side population" "AGS cell, unsorted" +p_20058_2 "AGS cell, side population" "AGS cell, unsorted" +p_20070_1 "Seg-1 cells, siRNA targeting FGF-AS" "Seg-1 cells, negative control" +p_20081_1 "HeLa cell, SRA siRNA" "HeLa cell, control siRNA" +p_20081_2 "MCF-7 cell, SRA siRNA" "MCF-7 cell, control siRNA" +p_20081_3 "MCF-7 cell, E2 10nM treated, SRA siRNA" "MCF-7 cell, E2 10nM treated, control siRNA" +p_20081_4 MCF-7_minus E2_SRA siRNA MCF-7_minus E2_NT siRNA +p_20081_5 MCF-7_10 nM E2 (6h)_SRA siRNA MCF-7_10 nM E2 (6h)_NT siRNA +p_20086_1 "Fibroblast, breast carcinoma" "Fibroblast, adjacent normal breast tissue" +p_20089_1 "U87 cell, cell body fraction" "U87 cell, pseudopodial fraction" +p_20089_2 "U251 cell, cell body fraction" "U251 cell, pseudopodial fraction" +p_20089_3 "HT1080 cell, cell body fraction" "HT1080 cell, pseudopodial fraction" +p_20089_4 "DU145 cell, cell body fraction" "DU145 cell, pseudopodial fraction" +p_20089_5 "MDA231 cell, cell body fraction" "MDA231 cell, pseudopodial fraction" +p_20089_6 "MDA435 cell, cell body fraction" "MDA435 cell, pseudopodial fraction" +p_20114_1 "blood cell, vehicle treated, DHA treated" "blood cell, vehicle treated, control" +p_20114_2 "blood cell, LPS treated, DHA treated" "blood cell, LPS treated, control" +p_20115_1 "Reh cell, IKK treated" "Reh cell, mock treated" +p_20115_2 "Reh cell, shCBFA2T3 treated" "Reh cell, mock treated" +p_20115_3 "Reh cell, shCBFA2T3, IKK treated" "Reh cell, mock treated" +p_20125_1 "Wharton's jelly stem cell line, passage 3" "D551 cells, fetal fibroblast cell line" +p_20125_2 "Wharton's jelly stem cell line, passage 4" "D551 cells, fetal fibroblast cell line" +p_20125_3 "Wharton's jelly stem cell line, passage 5" "D551 cells, fetal fibroblast cell line" +p_20125_4 "Wharton's jelly stem cell line, passage 8" "D551 cells, fetal fibroblast cell line" +p_20125_5 "Wharton's jelly stem cell line, passage 20" "D551 cells, fetal fibroblast cell line" +p_20141_1 "Substantia Nigra pars compacta, Parkinson's disease" "Substantia Nigra pars compacta, control" +p_20146_1 "Gpi cell, Parkinson disease" "Gpi cell, Control" +p_20153_1 Parkinson's disease; B lymphocytes control; B lymphocytes +p_20193_1 "HEK293 cell, hMOF overexpressed" "HEK293 cell, control" +p_20193_2 "HEK293 cell, hMOF knock down" "HEK293 cell, control" +p_20196_1 "Synovial sarcoma tumor tissue, higtological subtype: PDSS" "Synovial sarcoma (SS) tumor tissue, higtological subtype: Monophasic SS" +p_20196_2 "Synovial sarcoma tumor tissue, higtological subtype: PDSS" "Synovial sarcoma tumor tissue (SS), higtological subtype: Biphasic SS" +p_20211_1 "CLL cells, LMP-420 treated" "CLL cell, control" +p_20238_1 "hepatocellular carcinoma, vascular invasion: YES" "hepatocellular carcinoma, vascular invasion: NO" +p_20266_1 "Saliva, Breast cancer patients" "Saliva, healthy control" +p_20272_1 "SKOV-3 cells, IL-6 treated" "SKOV-3 cells, control" +p_20272_2 "SKOV-3 cells, IL-6+CNTO328 treated" "SKOV-3 cells, control" +p_20272_3 "Caov-3 cells, IL-6 treated" "Caov-3 cells, control" +p_20272_4 "Caov-3 cells, IL-6+CNTO328 treated" "Caov-3 cells, control" +p_20285_1 "MCF-10A cell, full-length Notch 1" "MCF-10A cell, control" +p_20285_2 "MCF-10A cell, Notch1, L1601P+del P" "MCF-10A cell, control" +p_20285_3 "MCF-10A cell, NICD induced" "MCF-10A cell, control" +p_20297_1 "HaCat cell, TNF + IFNg" "HaCat cell, control" +p_20297_2 "HaCat cell, TNF + IFNg + terbutaline" "HaCat cell, control" +p_20297_3 "HaCat cell, TNF + IFNg + GW9508" "HaCat cell, control" +p_20300_1 "whole blood, acute rejection pediatric kidney transplant patients" "whole blood, stable pediatric kidney transplant patients" +p_20318_1 "CL1-0 cells, YWHAZ overexpressed" "CL1-0 cells, mock control" +p_20357_1 "RM82 cell, sh280 treated" "RM82 cell, control" +p_20357_2 "RM82 cell, sh2495 treated" "RM82 cell, control" +p_20357_3 "TC32 cell, sh280 treated" "TC32 cell, control" +p_20357_4 "TC32 cell, sh2495 treated" "TC32 cell, control" +p_20357_5 "STAET10 cell, sh280 treated" "STAET10 cell, control" +p_20357_6 "STAET10 cell, sh2495 treated" "STAET10 cell, control" +p_20361_1 "MCF7 cell, day 3" "MCF7 cell, day 0" +p_20361_2 "MCF7 cell, day 15" "MCF7 cell, day 0" +p_20361_3 "MCF7 cell, day 30" "MCF7 cell, day 0" +p_20361_4 "MCF7 cell, day 90" "MCF7 cell, day 0" +p_20361_5 "MCF7 cell, day 120" "MCF7 cell, day 0" +p_20361_6 "MCF7 cell, day 150" "MCF7 cell, day 0" +p_20361_7 "MCF7 cell, day 180" "MCF7 cell, day 0" +p_20368_1 "RM82 cell line, pLKO.1-280-shRNA" "RM82 cell line, non-targeting shRNA, control" +p_20368_2 "RM82 cell line, pLKO.1-2495-shRNA" "RM82 cell line, non-targeting shRNA, control" +p_20368_3 "TC32 cell line, pLKO.1-280-shRNA" "TC32 cell line, non-targeting shRNA, control" +p_20368_4 "TC32 cell line, pLKO.1-2495-shRNA" "TC32 cell line, non-targeting shRNA, control" +p_20368_5 "STAET10 cell line, pLKO.1-280-shRNA" "STAET10 cell line, non-targeting shRNA, control" +p_20368_6 "STAET10 cell line, pLKO.1-2495-shRNA" "STAET10 cell line, non-targeting shRNA, control" +p_20433_1 "LNCaP cells, siRNA targeting EZH2, 60h" "LNCaP cells, control siRNA, 60h" +p_20433_2 "LNCaP cells, siRNA targeting EZH2 + RNAi resistant EZH2 plasmid, 60h" "LNCaP cells, control siRNA, 60h" +p_20433_3 "LNCaP cells, siRNA targeting EZH2 + RNAi resistant T350A mutated EZH2 plasmid, 60h" "LNCaP cells, control siRNA, 60h" +p_20433_4 "LNCaP cells, TSA treated, 5uM, 24h" "LNCaP cells, DMSO treated, 24h" +p_20433_5 "LNCaP cells, Roscovitine treated, 10uM, 24h" "LNCaP cells, DMSO treated, 24h" +p_20436_1 "tarsal conjunctive, trachoma" "tarsal conjunctive, normal control" +p_20484_1 "primary human monocyte-derived macrophages, differentiation factor: CXCL4" "primary human monocyte-derived macrophages, differentiation factor: MCSF" +p_20499_1 Endometrial NK cell Decidual NK cell +p_20505_1 "CD34+ cells; S1 stimulation, 48 h" CD34+ cells; 0 hr +p_20505_2 "CD34+ cells; S2 stimulation, 48 h" CD34+ cells; 0 hr +p_20505_3 "CD34+ cells; S1 stimulation, 72 h" CD34+ cells; 0 hr +p_20505_4 "CD34+ cells; S2 stimulation, 72 h" CD34+ cells; 0 hr +p_20505_5 "CD34+ cells; S1 stimulation, 96 h" CD34+ cells; 0 hr +p_20505_6 "CD34+ cells; S2 stimulation, 96 h" CD34+ cells; 0 hr +p_20508_1 "THP-1 cell, SS2 infected" "THP-1 cell, control" +p_20538_1 "skin fibroblast, cultured with T3, 0nM, patients" "skin fibroblast, cultured with T3, 0nM, normal" +p_20538_2 "skin fibroblast, cultured with T3, 1nM, patients" "skin fibroblast, cultured with T3, 1nM, normal" +p_20538_3 "skin fibroblast, cultured with T3, 10nM, patients" "skin fibroblast, cultured with T3, 10nM, normal" +p_20540_1 "MM1S cell, co-cultured BMSCs" "MM1S cell, mono-cultured" +p_20540_2 "MM1R cell, co-cultured BMSCs" "MM1R cell, mono-cultured" +p_20540_3 "INA-6 cell, co-cultured BMSCs" "INA-6 cell, mono-cultured" +p_20543_1 "LNCaP prostate cells, miR-616 stably overexpressed" "LNCaP prostate cells, empty lentivirus vector" +p_20559_1 Liposarcoma; dedifferentiated Liposarcoma; well-differentiated +p_20559_2 Liposarcoma; myxoid Liposarcoma; well-differentiated +p_20559_3 Liposarcoma; myxoid round cell Liposarcoma; well-differentiated +p_20559_4 Liposarcoma; pleomorphic Liposarcoma; well-differentiated +p_20559_5 Liposarcoma; well-differentiated spindle cell Liposarcoma; well-differentiated +p_20569_1 "C33-A cell, CA 9 overexpressed" "C33-A cell, control" +p_20578_1 Lung tumor Adjacent normal tissue +p_20585_1 Lung cancer Adjacent normal +p_20615_1 "HEK293T cell, transfected" "HEK293T cell, control" +p_20615_2 "HEK293T cell, untransfected" "HEK293T cell, control" +p_20641_1 "primary fibroblasts, serum starved 48h + restimulated with 10% serum, 2h" "primary fibroblasts, serum starved 48h + restimulated with 10% serum, 0h" +p_20641_2 "primary fibroblasts, serum starved 48h + restimulated with 10% serum, 4h" "primary fibroblasts, serum starved 48h + restimulated with 10% serum, 0h" +p_20641_3 "primary fibroblasts, serum starved 48h + restimulated with 10% serum, 6h" "primary fibroblasts, serum starved 48h + restimulated with 10% serum, 0h" +p_20641_4 "primary fibroblasts, serum starved 48h + restimulated with 10% serum, 8h" "primary fibroblasts, serum starved 48h + restimulated with 10% serum, 0h" +p_20666_1 "DLBCL cell, trichostatin A treated" "DLBCL cell, control" +p_20667_1 "T-ALL1 cell line, IKK¥ã Nemo binding domain (NBD) inhibitory peptide treated, 100mM, 16h" "T-ALL1 cell line, control peptide treated" +p_20667_2 "CEM cell line, IKK¥ã Nemo binding domain (NBD) inhibitory peptide treated, 100mM, 16h" "CEM cell line, control peptide treated" +p_20667_3 "KOPT-K cell line, IKK¥ã Nemo binding domain (NBD) inhibitory peptide treated, 100mM, 16h" "KOPT-K cell line, control peptide treated" +p_20667_4 "DND41 cell line, IKK¥ã Nemo binding domain (NBD) inhibitory peptide treated, 100mM, 16h" "DND41 cell line, control peptide treated" +p_20667_5 "HPB-ALL cell line, IKK¥ã Nemo binding domain (NBD) inhibitory peptide treated, 100mM, 16h" "HPB-ALL cell line, control peptide treated" +p_20677_2 "PBMCs, AuNP EGFP oligonucleotide complex treated, 48h" "PBMCs, control" +p_20677_4 "PBMCs, infected with HIV" "PBMCs, treated with Oligofectamine without oligonucleotide" +p_20677_6 "293T cells, treated with AuNP EGFP oligonucleotide complex, 24 hours" "293T cells, control" +p_20689_1 "SW620 cell, SOX2 knockdown" "SW620 cell, control" +p_20697_1 "hASC cell, without FGF" "hASC cell, control" +p_20711_1 breast tumor normal breast tissue +p_20719_1 "T47D breast cancer cell, GDC-0941 treated, 1mM, 6h" "T47D breast cancer cell, control" +p_20736_1 "GBM cell, Differentitation, 4d" "GBM cell, control, 4d" +p_20745_1 "HUVEC, Pre-17 transfected, 24h" "HUVEC, control pre-miR transfected, 24h" +p_20752_3 "hASC pre-adipocyte, day 1" "hASC pre-adipocyte, day -2, no FGF" +p_20752_8 "hASC pre-adipocyte, day 9" "hASC pre-adipocyte, day -2, no FGF" +p_20847_1 lrpprc expression vs. control: 20% lrpprc expression vs. control: 100% +p_20847_2 lrpprc expression vs. control: 33% lrpprc expression vs. control: 100% +p_20847_3 lrpprc expression vs. control: 58% lrpprc expression vs. control: 100% +p_20847_4 lrpprc expression vs. control: 69% lrpprc expression vs. control: 100% +p_20847_5 lrpprc expression vs. control: 81% lrpprc expression vs. control: 100% +p_20847_6 lrpprc expression vs. control: 9% lrpprc expression vs. control: 100% +p_20854_1 "Ishikawa Hcells, undosed, 12 hr" "Hec50co cells, undosed, 12 hr" +p_20854_2 "Ishikawa Hcells, dosed with egf, 12 hr" "Hec50co cells, dosed with egf, 12 hr" +p_20854_3 "Ishikawa Hcells, dosed with iressa, 12 hr" "Hec50co cells, dosed with iressa, 12 hr" +p_20854_4 "Ishikawa Hcells, undosed, 24 hr" "Hec50co cells, undosed, 24 hr" +p_20854_5 "Ishikawa Hcells, dosed with egf, 24 hr" "Hec50co cells, dosed with egf, 24 hr" +p_20854_6 "Ishikawa Hcells, dosed with iressa, 24 hr" "Hec50co cells, dosed with iressa, 24 hr" +p_20854_7 "Ishikawa H cells, dosed with iressa, harvested at 12 hr" "Ishikawa H cells, undosed, harvested at 24 hr" +p_20854_8 "Ishikawa H cells, dosed with iressa, harvested at 24 hr" "Ishikawa H cells, undosed, harvested at 24 hr" +p_20891_1 "CORD BLOOD CD34+ CELLS, SDF-1 treated, 100ng/mL, 4h" "CORD BLOOD CD34+ CELLS, control" +p_20910_1 Down syndrome (DS) ALL cases non-Down syndrome (NDS) ALL cases +p_20915_1 "HBL2 cell, Borezomib-induced resistant" "HBL2 cell, parental" +p_20915_2 "JEKO cell, Borezomib-induced resistant" "JEKO cell, parental" +p_20916_1 "mucosa, colon tumor tissue, malignincy: adenoma" "mucosa, colon tumor tissue, malignincy: normal colon" +p_20916_2 "mucosa, colon tumor tissue, malignincy: carcinoma" "mucosa, colon tumor tissue, malignincy: normal colon" +p_20916_3 "mucosa, colon tumor tissue, malignincy: carcinoma" "mucosa, colon tumor tissue, malignincy: adenoma" +p_20923_1 "HT-29 cells, siRNA targeting IFITM1" "HT-29 cells, siRNA targeting luciferase" +p_20928_1 "K562 cells, calactin treated, 0.15mM, 12h" "K562 cells, untreated, 12h" +p_20948_1 "Huh7 cell, JFH-1 infected, 6h" "Huh7 cell, control, 6h" +p_20948_2 "Huh7 cell, JFH-1 infected, 12h" "Huh7 cell, control, 12h" +p_20948_3 "Huh7 cell, JFH-1 infected, 18h" "Huh7 cell, control, 18h" +p_20948_4 "Huh7 cell, JFH-1 infected, 24h" "Huh7 cell, control, 24h" +p_20948_5 "Huh7 cell, JFH-1 infected, 48h" "Huh7 cell, control, 48h" +p_20950_1 "subcutaneous adipose tissue, insulin resistant" "subcutaneous adipose tissue, insulin sensitive" +p_20950_2 "omental adipose tissue, insulin resistant" "omental adipose tissue, insulin sensitive" +p_21029_1 "CLL cells, bone marrow-derived" "CLL cells, peripheral blood-derived" +p_21029_2 "CLL cells, lymph node-derived" "CLL cells, peripheral blood-derived" +p_21039_1 "PBMC, 2hr processing delay" "PBMC, 0hr processing delay (immediate)" +p_21039_2 "PBMC, 4hr processing delay" "PBMC, 0hr processing delay (immediate)" +p_21066_1 "MCF 10A cell, radiation treated" "MCF 10A cell, control" +p_21066_2 "MCF 10A cell, smoke treated" "MCF 10A cell, control" +p_21066_3 "MCF 10A cell, smoke, radiation treated" "MCF 10A cell, control" +p_21094_1 "Bone marrow tissue, ALL, Down syndrome" "Bone marrow tissue, ALL, Non-Down syndrome" +p_21105_1 "DLD-1 cells, p53 expression" "DLD-1 cells, control" +p_21132_1 "Jurkat T FF3 cell, miR146a overexpressed" "Jurkat T FF3 cell, control" +p_21132_2 "Jurkat T FF3 cell, miR146a knock down" "Jurkat T FF3 cell, control" +p_21138_1 "BA46 cell, Haloperidol, Chlorpromazine, Clozapine treated" "BA46 cell, control" +p_21164_1 "Quadriceps muscle, arthroplasty treatment, 0h" "Quadriceps muscle, control, 0h" +p_21164_2 "Quadriceps muscle, arthroplasty treatment, 1h" "Quadriceps muscle, control, 1h" +p_21216_1 "DMS79, siRNA targeting ASCL1, 72h" "DMS79 cells, control" +p_21225_1 "endometrium, on the day of oocyte retrieval, pregnant" "endometrium, on the day of oocyte retrieval, not pregnant" +p_2125_1 "Human alveolar macrophage, smoker, koth" "Human alveolar macrophage, nonsmoker, koth" +p_2125_2 "Human alveolar macrophage, smoker, woodruff" "Human alveolar macrophage, nonsmoker, woodruff" +p_2125_3 "Human alveolar macrophage, asthmatic, woodruff" "Human alveolar macrophage, nonsmoker, woodruff" +p_21261_1 "mononuclear cells, AML-NOS plus AML-MLD-sole" "mononuclear cells, AML with MDS-related changes (AML-MRC)" +p_21306_1 "HT1080 cell, RECK overexpressed" "HT1080 cell, control" +p_21306_2 "HT1080 cell, RECK,4NQ overexpressed" "HT1080 cell, control" +p_21327_1 "Podocytes, GH treated, 2m" "Podocytes, control" +p_21327_2 "Podocytes, GH treated, 5m" "Podocytes, control" +p_21327_3 "Podocytes, GH treated, 15m" "Podocytes, control" +p_21327_4 "Podocytes, GH treated, 30m" "Podocytes, control" +p_21369_1 "Lung tissue, interstitial lung disease" "Lung tissue, control" +p_21422_1 Ductal carcinoma in situ "healthy breast cell, control" +p_21422_2 Invasive ductal carcinomas cell "healthy breast cell, control" +p_21483_1 "SCC1 cells, Cetuximab-resistant" "SCC1 cells, cetuximab-sensitive" +p_21496_1 "Muscle cell, Unroading, 48h" "Muscle cell, Unroading, 0h" +p_21496_2 "Muscle cell, Reroading, 24h" "Muscle cell, Unroading, 0h" +p_21497_1 "vastus laterlais muscle, spinal cord injury (SCI), 5 days after SCI" "vastus laterlais muscle, spinal cord injury (SCI), 2 days after SCI" +p_21514_1 "astrocyte, RISC-IP miRNA" "astrocyte, global miRNA" +p_21514_2 "astrocytoma, RISC-IP miRNA" "astrocytoma, global miRNA" +p_21547_1 "microvascular endothelial cells, DSG2 silenced, healthy subject" "microvascular endothelial cells, healthy control" +p_21550_1 "U937 transfected with GFP-PRWT, 6h" "U937 transfected with control GFP, 6h" +p_21550_2 "U937 transfected with GFP-PR2VR, 6h" "U937 transfected with control GFP, 6h" +p_21550_3 "U937 transfected with GFP-PRWT, 9h" "U937 transfected with control GFP, 9h" +p_21550_4 "U937 transfected with GFP-PR2VR, 9h" "U937 transfected with control GFP, 9h" +p_21567_1 CD200 + CD49 cell CD49 cell +p_21569_1 CD200-CD49+ keratinocytes CD200+CD49+ hair follicle keratinocytes +p_21570_1 "U87MG cell, non-invasive" "U87MG cell, Parental" +p_21570_2 "U87MG cell, invasive" "U87MG cell, Parental" +p_21574_1 "HEK 293 cells, QKI siRNA" "HEK 293 cells, mock-transfected" +p_21575_1 "HEK 293 cells, IGF2BP siRNA" "HEK 293 cells, mock-transfected" +p_21577_1 "HEK 293 cells, top 25 miRNAs are inhibited" "HEK 293 cells, mock-transfected" +p_21578_1 "HEK 293 cells, expressing FLAG/HA-tagged QKI, siRNA (targeting QKI) set A transfected" "HEK 293 cells, expressing FLAG/HA-tagged QKI, mock-transfected," +p_21578_2 "HEK 293 cells, expressing FLAG/HA-tagged QKI, siRNA (targeting QKI) set B transfected" "HEK 293 cells, expressing FLAG/HA-tagged QKI, mock-transfected," +p_21578_3 "HEK 293 cells expressing FLAG/HA-tagged IGF2BP1, siRNA (targeting IGF2BP1, IGF2BP2, IGF2BP3) -transfected" "HEK 293 cells expressing FLAG/HA-tagged IGF2BP1, mock-transfected," +p_21578_4 "HEK 293 cells, top 25 miRNAs inhibited, siRNA-transfected" "HEK 293 cells, mock-transfected" +p_21668_1 "hESC H9, Mesodermal progenitor population" "hESC H9, Undifferentiated embryonic stem cells" +p_21723_1 "endothelial cells, condition B" "endothelial cells, condition A" +p_21760_1 "HeLa cell, IFN-gamma treated, 2h" "HeLa cell, control" +p_21760_2 "HeLa cell, IFN-gamma treated, 4h" "HeLa cell, control" +p_21760_3 "HeLa cell, IFN-gamma treated, 6h" "HeLa cell, control" +p_21774_1 CD3- CD56dim CD62L+ CD3- CD56bright CD62L+ +p_21774_2 CD3- CD56dim CD62L- CD3- CD56bright CD62L+ +p_21826_1 "peripheral blood, Infected colitis" "peripheral blood, Diverticulitis" +p_21832_1 "MDA-MB-231 cell, trasfected with Qmimic" "MDA-MB-231 cell, trasfected with Allstar" +p_21832_2 "MDA-MB-231 cell, trasfected with Dmimic" "MDA-MB-231 cell, trasfected with Allstar" +p_21858_1 "parieto-temporal cortex, right side, 19 gestational weeks" "parieto-temporal cortex, right side, 17 gestational weeks" +p_21858_2 "parieto-temporal cortex, left side, 19 gestational weeks" "parieto-temporal cortex, left side, 17 gestational weeks" +p_21858_3 "prefrontal/orbito-frontal cortex, right side, 19 gestational weeks" "prefrontal/orbito-frontal cortex, right side, 17 gestational weeks" +p_21858_4 "prefrontal/orbito-frontal cortex, left side, 19 gestational weeks" "prefrontal/orbito-frontal cortex, left side, 17 gestational weeks" +p_21901_1 "HEK 293 cell, miR-212 overexpressed" "HEK 293 cell, control" +p_21930_1 "Caco-2 cell, control, 4h" "Caco-2 cell, control, 0h" +p_21942_1 "peripheral blood mononuclear cells, disease state: multiple sclerosis)" "peripheral blood mononuclear cells, healthy donors)" +p_21979_1 "Daoy medulloblastoma cell, Thapsigargin treated, 3h" "Daoy medulloblastoma cell, control" +p_21979_2 "Daoy medulloblastoma cell, Thapsigargin treated, 8h" "Daoy medulloblastoma cell, control" +p_21989_1 "HUVEC at 40 min., exposed to insulin" "HUVEC at 40 min., control" +p_21989_2 "HUVEC at 100 min., exposed to insulin" "HUVEC at 100 min., control" +p_21989_3 "HUVEC at 200 min., exposed to insulin" "HUVEC at 200 min., control" +p_21989_4 "HUVEC at 340 min., exposed to insulin" "HUVEC at 340 min., control" +p_21989_5 "HUVEC at 440 min., exposed to insulin" "HUVEC at 440 min., control" +p_22002_1 "HeLa cell, miR-155 transfected" "HeLa cell, mock-transfected" +p_22002_2 "HeLa cell, miR-1 transfected" "HeLa cell, mock-transfected" +p_22025_1 "CD4+ T cells, Cord blood, progesterone + IL-2 treated" "CD4+ T cells, Cord blood, control" +p_22025_2 "CD4+ T cells, Cord blood, TGFb1 + IL-2 treated" "CD4+ T cells, Cord blood, control" +p_22025_3 "CD4+ T cells, Cord blood, progesterone + TGFb1 + IL-2 treated" "CD4+ T cells, Cord blood, control" +p_22025_4 "CD4+ T cells, Peripheral blood, progesterone + IL-2 treated" "CD4+ T cells, Peripheral blood, control" +p_22025_5 "CD4+ T cells, Peripheral blood, TGFb1 + IL-2 treated" "CD4+ T cells, Peripheral blood, control" +p_22025_6 "CD4+ T cells, Peripheral blood, progesterone + TGFb1 + IL-2 treated" "CD4+ T cells, Peripheral blood, control" +p_22036_1 "HuT-102 cell, IRF4 siRNA" "HuT-102 cell, Luciferase siRNA" +p_22038_1 "GRANTA cells, AZA treated" "GRANTA cells, mock treated" +p_22038_10 "HBL2 cells, AZA+TSA treated" "HBL2 cells, mock treated" +p_22038_11 "Z138 cells, AZA treated" "Z138 cells, mock treated" +p_22038_12 "Z138 cells, AZA+TSA treated" "Z138 cells, mock treated" +p_22038_13 "MAVER cells, AZA treated" "MAVER cells, mock treated" +p_22038_14 "MAVER cells, AZA+TSA treated" "MAVER cells, mock treated" +p_22038_2 "GRANTA cells, AZA+TSA treated" "GRANTA cells, mock treated" +p_22038_3 "NCEB cells, AZA treated" "NCEB cells, mock treated" +p_22038_4 "NCEB cells, AZA+TSA treated" "NCEB cells, mock treated" +p_22038_5 "UPN1 cells, AZA treated" "UPN1 cells, mock treated" +p_22038_6 "UPN1 cells, AZA+TSA treated" "UPN1 cells, mock treated" +p_22038_7 "JEKO cells, AZA treated" "JEKO cells, mock treated" +p_22038_8 "JEKO cells, AZA+TSA treated" "JEKO cells, mock treated" +p_22038_9 "HBL2 cells, AZA treated" "HBL2 cells, mock treated" +p_22045_1 "nTreg cells, unstimulated" "naive CD4 cells, unstimulated" +p_22061_1 "HCT116 cell, FK228 treated" "HCT116 cell, control" +p_22061_2 "HCT116 cell, SAHA treated" "HCT116 cell, control" +p_22061_3 "HCT116 cell, Largazole treated" "HCT116 cell, control" +p_22106_1 "H4 cell, Hyrdocortisone treated, 12h" "H4 cell, control" +p_22106_2 "H4 cell, Hyrdocortisone treated, 1d" "H4 cell, control" +p_22106_3 "H4 cell, Hyrdocortisone treated, 2d" "H4 cell, control" +p_22106_4 "H4 cell, Hyrdocortisone treated, 5d" "H4 cell, control" +p_22109_1 "Human erythroid progenitor cells (HEPs), Hereditary Persistence of Fetal Hemoglobin (HPFH)" "Human erythroid progenitor cells (HEPs), wild type" +p_22132_1 "platelets, systemic lupus erythematosus (SLE) patients" "platelets, Normal" +p_22138_1 "Uveal Melanoma (eye), metastasis: YES" "Uveal Melanoma (eye), metastasis: NO" +p_22139_1 "DAOY cell, Empty vector infected" "DAOY cell, wt" +p_22139_2 "DAOY cell, siRNA scrambled" "DAOY cell, wt" +p_22139_3 "DAOY cell, siRNA cMYC treated" "DAOY cell, wt" +p_22152_1 "C7H2 cell, GC resistant, GC treated, 6h" "C7H2 cell, GC resistant, EtOH treated, 6h" +p_22152_2 "C7H2 cell, GC sensitive, TC treated, 6h" "C7H2 cell, GC sensitive, EtOH treated, 6h" +p_22217_1 "Human Osteoblasts, titanium grit-blasted, 24h" "Human Osteoblasts, titanium polished, 24h" +p_22217_2 "Human Osteoblasts, titanium grit-blasted, HF treated 24h" "Human Osteoblasts, titanium polished, 24h" +p_22229_1 "B cell, Tolerant" "B cell, Healthy control" +p_22229_2 "B cell, Standard Immunotherapy" "B cell, Healthy control" +p_22242_1 Colorectal adenoma biopsy specimens Normal colorectal mucosa +p_22242_2 Colorectal carcinoma biopsy specimens_stage of Duke's A Normal colorectal mucosa +p_22242_3 Colorectal carcinoma biopsy specimens_stage of Duke's B Normal colorectal mucosa +p_22242_4 Colorectal carcinoma biopsy specimens_stage of Duke's C/D Normal colorectal mucosa +p_22246_1 "hiPSC line, long term passage" Fibroblast cell line +p_22250_1 "MCF-7 cell line, 5-aza-2¡¯-deoxycytidine treated, 1M, 4 days" "MCF-7 cell line, wild type" +p_22250_2 "T47D cell line, 5-aza-2¡¯-deoxycytidine treated, 1M, 4 days" "T47D cell lne, wild type" +p_22250_3 "SKBR3 cell line, 5-aza-2¡¯-deoxycytidine treated, 1M, 4 days" "SKBR3 cell lne, wild type" +p_22250_4 "BT20 cell line, 5-aza-2¡¯-deoxycytidine treated, 1M, 4 days" "BT20 cell lne, wild type" +p_22250_5 "MDA-MB-231 cell line, 5-aza-2¡¯-deoxycytidine treated, 1M, 4 days" "MDA-MB-231 cell lne, wild type" +p_22250_6 "MDA-MB 361 cell line, 5-aza-2¡¯-deoxycytidine treated, 1M, 4 days" "MDA-MB-361 cell lne, wild type" +p_22250_7 "ZR-75-1 cell line, 5-aza-2¡¯-deoxycytidine treated, 1M, 4 days" "ZR-75-1 cell lne, wild type" +p_22256_1 "786-VHL cells, contains functional allele of VHL" "Renal cell carcinoma cell line (786-0), mutated allele of VHL" +p_22282_1 "Mature dendritic cells (mDC), hypoxia" "Mature denritic cells (mDC), normoxia" +p_22331_1 "Spermatozoa cell, asthenozoospermic men" "Spermatozoa cell, normozoospermic men" +p_22336_1 "Capan-I cells, siGNE-transfected" "Capan-1 cells, allStar-transfected" +p_22342_1 CD11cLO cells CD11cHI cells +p_22356_1 "PMBC, Idiopathic pulmonary arterial hypertension" "PMBC, control" +p_22356_2 "PMBC, Scleroderma with pulmonary hypertension" "PMBC, Scleroderma without pulmonary hypertension" +p_22373_1 "Macrophage, Flagellin stimulated" "Macrophage, unstimulated" +p_22373_2 "Monocyte, Flagellin stimulated" "Monocyte, unstimulated" +p_22377_1 "Gastric adenocarcinoma tissue, intestinal type" "Gastric adenocarcinoma tissue, diffuse type" +p_22392_1 "hiPSC line 3975 (p6), newly generated" "hiPSC line IMR90, already established" +p_22392_2 "hiPSC line 3975 (p9), newly generated" "hiPSC line IMR90, already established" +p_22467_1 "SK-N-AS cells, RE-EX1 expression construct, 24h" "SK-N-AS cells, RE-EX1 expression construct, 0h" +p_22467_2 "SK-N-AS cells, RE-EX1 expression construct, 48h" "SK-N-AS cells, RE-EX1 expression construct, 0h" +p_22467_3 "SK-N-AS cells, HZ4 expression construct, 24h" "SK-N-AS cells, HZ4 expression construct, 0h" +p_22467_4 "SK-N-AS cells, HZ4 expression construct, 48h" "SK-N-AS cells, HZ4 expression construct, 0h" +p_22483_1 "LNCaP cell, R1881 treated" "LNCaP cell, control" +p_22483_2 "LNCaP cell, AR knockdown" "LNCaP cell, control" +p_22490_1 "Placenta cell, recurrent miscarriage" "Placenta cell, elective termination" +p_22501_1 "Regulatory T Cell (T-reg), cord blood" "Regulatory T Cell (T-reg), peripheral blood" +p_22513_1 "breast needle biopsy, pretreatment, pathological complete response" "breast needle biopsy, pretreatment, No pathological complete response" +p_22522_1 "lymphatic endothelial cells (LEC) shperoid, KSHV infected (K-LEC)" "lymphatic endothelial cells (LEC) shperoid, control" +p_22533_1 "MCF-7/LTED cell, fulv treated" "MCF-7/LTED cell, Etoh treated" +p_22533_2 "HCC-1428/LTED cell, fulv treated" "HCC-1428/LTED cell, Etoh treated" +p_22544_1 "Breast cancer, infiltrating ductal carcinoma (IDC)" "Breast tissue, normal" +p_22552_1 "PBMC-derived erythroblasts, colony-forming unit-erythroid (CFU-E)" "PBMC-derived erythroblasts, late (Late-E) erythroblasts" +p_22552_2 "PBMC-derived erythroblasts, intermediate (Int-E)" "PBMC-derived erythroblasts, late (Late-E) erythroblasts" +p_22552_3 "PBMC-derived erythroblasts, late (Late-E) erythroblasts" "PBMC-derived erythroblasts, late (Late-E) erythroblasts" +p_22560_1 "HuCCT-1 cells, SPRR2a expression" "HuCCT-1 cells, vehicle" +p_22560_2 "SG231 cells, SPRR2a expression" "SG231 cells, vehicle" +p_22572_1 "Caco-2 cell, shCDX2-2 treated" "Caco-2 cell, shGFP treated" +p_22580_1 "hMECs, type 1 hTERT-immotalized" hMECs +p_22580_2 "hMECs, type 2 hTERT-immotalized" hMECs +p_22589_1 "Monocyte-derived dendritic cell, HIVGFP infected" "Monocyte-derived dendritic cell, control" +p_22589_2 "Monocyte-derived dendritic cell, SIVVLP infected" "Monocyte-derived dendritic cell, control" +p_22589_3 "Monocyte-derived dendritic cell, HIVGFP,SIVVLP infected" "Monocyte-derived dendritic cell, control" +p_22598_1 "colorectal tissue, cancerous cell" "colorectal tissue, non-cancerous cell" +p_22598_2 "HT29 cell line, 5aza treated" "HT29 cell line, control" +p_22598_3 "HCT15 cell line, 5aza treated" "HCT15 cell line, control" +p_22600_1 "2008 cell, Estrogen treated" "2008 cell, placebo control" +p_22600_2 "PEO4 cell, Estrogen treated" "PEO4 cell, placebo control" +p_22611_1 "HEK293 cells, NOD2 expression. Muramyl-dipeptide (MDP) treated, 10 g/ml, 0h" "HEK293 cells, mock-transfectant. Muramyl-dipeptide (MDP) treated, 10 g/ml, 0h" +p_22611_2 "HEK293 cells, NOD2L1007fsinsC expression. Muramyl-dipeptide (MDP) treated, 10 g/ml, 0h" "HEK293 cells, mock-transfectant. Muramyl-dipeptide (MDP) treated, 10 g/ml, 0h" +p_22611_3 "HEK293 cells, NOD2 expression. Muramyl-dipeptide (MDP) treated, 10 g/ml, 2h" "HEK293 cells, mock-transfectant. Muramyl-dipeptide (MDP) treated, 10 g/ml, 2h" +p_22611_4 "HEK293 cells, NOD2L1007fsinsC expression. Muramyl-dipeptide (MDP) treated, 10 g/ml, 2h" "HEK293 cells, mock-transfectant. Muramyl-dipeptide (MDP) treated, 10 g/ml, 2h" +p_22611_5 "HEK293 cells, NOD2 expression. Muramyl-dipeptide (MDP) treated, 10 g/ml, 6h" "HEK293 cells, mock-transfectant. Muramyl-dipeptide (MDP) treated, 10 g/ml, 6h" +p_22611_6 "HEK293 cells, NOD2L1007fsinsC expression. Muramyl-dipeptide (MDP) treated, 10 g/ml, 6h" "HEK293 cells, mock-transfectant. Muramyl-dipeptide (MDP) treated, 10 g/ml, 6h" +p_22619_1 "primary mucosal tissue, colon, diseased (ulcerative colitis)" "primary mucosal tissue, colon, healthy control" +p_22632_1 "PBMC cells, PCB138 treated" "PBMC cells, control" +p_22667_1 "PBMC cells, PCB153 treated, 48h" "PBMC cells, control" +p_22707_1 "PBMC, Kidney recipient, under immunosuppression, stable graft" "PBMC, Kidney recipient, under immunosuppression, deteriorating" +p_22707_2 "PBMC, Kidney recipient, not immunosuppression, stable graft" "PBMC, Kidney recipient, under immunosuppression, deteriorating" +p_22707_3 "PBMC, liver recipient, not immunosuppression, stable graft" "PBMC, liver recipient, under immunosuppression, acute reject" +p_22771_1 "neuroblastoma cell line, mutated ALK" "neuroblastoma cell line, wild type ALK" +p_22779_1 "Mononuclear cells, epilepsy patient, before administration of GC" "Mononuclear cells, healthy donor, before administration of GC" +p_22779_2 "Mononuclear cells, epilepsy patient, 2 hours after GC administration" "Mononuclear cells, healthy donor, 2 hours after GC administration" +p_22779_3 "Mononuclear cells, epilepsy patient, 6 hours after GC administration" "Mononuclear cells, healthy donor, 6 hours after GC administration" +p_22779_4 "Mononuclear cells, epilepsy patient, 24 hours after GC administration" "Mononuclear cells, healthy donor, 24 hours after GC administration" +p_22779_5 "Mononuclear cells, epilepsy patient, 24 hours after GC administration" "Mononuclear cells, epilepsy patient, before administration of GC" +p_22781_1 Renal Cell Carcinoma Cell line (SN19(3i)YY) Renal Cell Carcinoma Cell line (SN12C19) +p_22783_1 "MCF7 cell, p53 silenced" "MCF7 cell, control" +p_22810_1 "CL1-0 cell, HA-G9a expressed" "CL1-0 cell, control" +p_22810_2 "CL1-5 cell, G9a shRNA expressed" "CL1-5 cell, control" +p_22842_1 "SAOS cell, RB transfected" "SAOS cell, control" +p_22842_2 "SAOS cell, SMYD2 transfected" "SAOS cell, control" +p_22842_3 "SAOS cell, RB, SMYD2 transfected" "SAOS cell, control" +p_22845_1 "mononuclear cell, CEBPA single mutant" "mononuclear cell, wt" +p_22845_2 "mononuclear cell, CEBPA double mutant" "mononuclear cell, wt" +p_22853_1 "Ea.hy926 cell, TCF11 treated , DMSO" "Ea.hy926 cell, control , DMSO" +p_22853_2 "Ea.hy926 cell, TCF11 treated , epoxomicin" "Ea.hy926 cell, control , epoxomicin" +p_22859_1 "HeLa cell, LSD2 knockdown" "HeLa cell, control" +p_22865_1 "Hs578T cells, treated with oligonucleotide (unmethylated CDH13 sequence (CDH13 U))" "Hs578T cells, treated with oligonucleotide (methylated CDH13 sequence (CDH13 M))" +p_22865_2 "BT-20 cells, treated with oligonucleotide (unmethylated CDH13 sequence (CDH13 U))" "BT-20 cells, treated with oligonucleotide (methylated CDH13 sequence (CDH13 M))" +p_22868_1 "Blood cell, High PCB exposure" "Blood cell, control" +p_22872_1 "HeLa cells, LSD2 knockdown" "HeLa cells, scrambled control knockdown" +p_22919_1 "NK cell, IL-2, IL-12, IL-18 stimulated, 24h" "NK cell, unstimulated, 24h" +p_22927_1 "brainstem, low-grade glioma" "brainstem, normal" +p_22973_1 "AsPC-1 cell, PMA treated" "AsPC-1 cell, control" +p_22973_2 "BxPC-3 cell, PMA treated" "BxPC-3 cell, control" +p_22998_1 "skin, seborrheic keratosis" "skin, control" +p_23025_1 "peripheral blood stem cell, Therapy-related myelodysplasia or acute myeloid leukemia (t-MDS/AML)" "peripheral blood stem cell (CD34+ cells), control" +p_23025_2 "Bone marrow (CD34+ cells), Therapy-related myelodysplasia or acute myeloid leukemia (t-MDS/AML)" "Bone marrow (CD34+ cells), control" +p_23031_1 "Huh7.5.1 cell line, Ribavirin treated" "Huh7.5.1 cell line, PBS treated" +p_23035_1 "U2OS cell, BAP1 depleted" "U2OS cell, control" +p_23066_1 "human fibroblast, non small cell lung cancer (NSCLC) tissue" "human fibroblast, normal bronchial fibroblast" +p_23102_1 "HEK293 cell, WT, tetracycline treated" "HEK293 cell, WT, control" +p_23102_2 "HEK293 cell, TRPM7 overexpressed, tetracycline treated" "HEK293 cell, TRPM7 overexpressed, control" +p_23103_1 "HeLa cell line,SCY1-like 1 esiRNA" "HeLa cell line, control esiRNA" +p_23117_1 "non SS gland, advanced" "SS gland, control" +p_23117_2 "SS gland, advanced" "SS gland, control" +p_23117_3 "SS gland, early" "SS gland, control" +p_23117_4 "SS gland, moderate" "SS gland, control" +p_23183_1 "CD8+ cell, no soluble CD8 suppress" "CD8+ cell, soluble CD8 suppress" +p_23183_2 "CD8+ cell, HIV infected" "CD8+ cell, soluble CD8 suppress" +p_23205_1 "peripheral blood mononuclear cells, risk haplotype" "peripheral blood mononuclear cells, proteictive haplotype" +p_23206_1 "H322c cells, cultured in gefitinib, 1uM, 4 days" "H322c cells, cultured in DMSO, 4 days" +p_23295_1 "colon cancer SW620 cell line, CD133+" "colon cancer SW620 cell line, CD133-" +p_23332_1 "T cell, acute GvHD" "T cell, no GvHD" +p_23332_3 "T cell, GvHD" "T cell, no GvHD" +p_23360_1 "Human BLM (Bowes Lung Metastases) melanoma cells, P-cadherin overexpression" "Human BLM (Bowes Lung Metastases) melanoma cells, control" +p_23366_1 "Unrestricted Somatic Stem Cells (USSC), co-cultured with Dendritic cells" "Unrestricted Somatic Stem Cells (USSC), control" +p_23371_1 "Dendritic cell, Mature" "Dendritic cell, Immature" +p_23371_2 "Dendritic cell, Activated tolerogenic" "Dendritic cell, Tolerogenic" +p_23391_1 Serous ovarian cancer epithelia Ovarian surface epithelia +p_23399_1 "Breast cancer associatd fibroblasts (BCAFs), paclitaxol treated, collect RNA at day1" "Breast cancer associatd fibroblasts (BCAFs), untreated" +p_23399_2 "Breast cancer associatd fibroblasts (BCAFs), paclitaxol treated, collect RNA at day3" "Breast cancer associatd fibroblasts (BCAFs), untreated" +p_23399_3 "Breast cancer associatd fibroblasts (BCAFs), paclitaxol treated, collect RNA at day7" "Breast cancer associatd fibroblasts (BCAFs), untreated" +p_23399_4 "Breast cancer associatd fibroblasts (BCAFs), Doxorubicin treated, collect RNA at day1" "Breast cancer associatd fibroblasts (BCAFs), untreated" +p_23399_5 "Breast cancer associatd fibroblasts (BCAFs), Doxorubicin treated, collect RNA at day3" "Breast cancer associatd fibroblasts (BCAFs), untreated" +p_23399_6 "Breast cancer associatd fibroblasts (BCAFs), Doxorubicin treated, collect RNA at day7" "Breast cancer associatd fibroblasts (BCAFs), untreated" +p_23405_1 "U937 cells, treated with heat stress (42¡ÆC), 0h" "U937 cells, control" +p_23405_4 "U937 cells, treated with heat stress (42¡ÆC), 6h" "U937 cells, control" +p_23405_5 "U937 cells, treated with heat stress (44¡ÆC), 0h" "U937 cells, control" +p_23405_6 "U937 cells, treated with heat stress (44¡ÆC), 1h" "U937 cells, control" +p_23427_1 "MzChA1, felodipine, 20uM, 24h" "MzChA1, control" +p_23450_1 "Huh7 cell, CD133+" "Huh7 Cell, CD133-" +p_23451_1 "PLC8024 cell, CD133 +" "PLC8024 cell, CD133 -" +p_23494_1 "HK2 cells, PCB153 treated, 70uM, 0.5h" "HK2 cells, PCB153 treated, 70uM, 0h" +p_23494_2 "HK2 cells, PCB153 treated, 70uM, 6h" "HK2 cells, PCB153 treated, 70uM, 0h" +p_23494_3 "HK2 cells, PCB153 treated, 70uM, 24h" "HK2 cells, PCB153 treated, 70uM, 0h" +p_23494_4 "HK2 cells, PCB77 treated, 40uM, 0.5h" "HK2 cells, PCB77 treated, 40uM, 0h" +p_23494_5 "HK2 cells, PCB77 treated, 40uM, 6h" "HK2 cells, PCB77 treated, 40uM, 0h" +p_23494_6 "HK2 cells, PCB77 treated, 40uM, 24h" "HK2 cells, PCB77 treated, 40uM, 0h" +p_23501_1 "diffuse large B cell lymphoma, activated B-cell like (ABC)" "pooled normal cells (breast, gastric, lymph node, spleen and tonsil), from patients of free of DLBCL after initial treatment" +p_23501_2 "diffuse large B cell lymphoma,germinal center B cell-like (GCB)" "pooled normal cells (breast, gastric, lymph node, spleen and tonsil), from patients of free of DLBCL after initial treatment" +p_23579_1 "Human cerebral cortex, Ethanol treated" "Human cerebral cortex, control" +p_23583_1 "iPSC derived from dH1CF fibroblast, viral derived iPS" "dH1F fibroblast, untransfected" +p_23583_10 "RNA iPS cells derived from BJ fibroblast, RNA derived iPS" "pooled human ESC (H1, H9)" +p_23583_11 "iPS cells derived from MRC5 fibroblast, viral derived iPS" "pooled human ESC (H1, H9)" +p_23583_12 "RNA iPS cells derived from MRC5 fibroblast, RNA derived iPS" "pooled human ESC (H1, H9)" +p_23583_2 "RNA iPSC derived from dH1F fibroblast, RNA deribed iPS" "dH1F fibroblast, untransfected" +p_23583_3 "iPS cells derived from BJ fibroblast, viral derived iPS" "BJ fibroblast, untransfected" +p_23583_4 "RNA iPS cells derived from BJ fibroblast, RNA derived iPS" "BJ fibroblast, untransfected" +p_23583_5 "iPS cells derived from MRC5 fibroblast, viral derived iPS" "MRC5 fibroblast, untransfected" +p_23583_6 "RNA iPS cells derived from MRC5 fibroblast, RNA derived iPS" "MRC5 fibroblast, untransfected" +p_23583_7 "iPSC derived from dH1CF fibroblast, viral derived iPS" "pooled human ESC (H1, H9)" +p_23583_8 "RNA iPSC derived from dH1F fibroblast, RNA deribed iPS" "pooled human ESC (H1, H9)" +p_23583_9 "iPS cells derived from BJ fibroblast, viral derived iPS" "pooled human ESC (H1, H9)" +p_23586_1 "Gingiva cell, Periodontitis affected" "Gingiva cell, healthy state" +p_23593_1 "Breast tumor core needle biopsy, ER positive" "Breast tumor core needle biopsy, ER negative" +p_23593_2 "Breast tumor core needle biopsy, PR positive" "Breast tumor core needle biopsy, PR negative" +p_23597_1 "colonic biopsy, infliximab treated, 5mg/kg, week 0" "colonic biopsy, placebo treated, 5mg/kg, week 0" +p_23597_2 "colonic biopsy, infliximab treated, 5mg/kg, week 8" "colonic biopsy, placebo treated, 5mg/kg, week 8" +p_23597_3 "colonic biopsy, infliximab treated, 5mg/kg, week 30" "colonic biopsy, placebo treated, 5mg/kg, week 30" +p_23597_4 "colonic biopsy, infliximab treated, 10mg/kg, week 0" "colonic biopsy, infliximab treated, 5mg/kg, week 0" +p_23597_5 "colonic biopsy, infliximab treated, 10mg/kg, week 8" "colonic biopsy, infliximab treated, 5mg/kg, week 8" +p_23597_6 "colonic biopsy, Infliximab treated, 10mg/kg, week 30" "colonic biopsy, infliximab treated, 5mg/kg, week 30" +p_23603_1 "A2008 cell line, treatment schedule: A, cisplatin treated, 1ug/ml,treatment/expansion cycle number within schedule: 3" "A2008 cell line, untreated control" +p_23603_10 "A2780CP cell line, treatment schedule: B, cisplatin treated, 4ug/ml,treatment/expansion cycle number within schedule: 6" "A2780CP cell line, untreated control" +p_23603_11 "A2780CP cell line, treatment schedule: C, cisplatin treated, 3ug/ml,treatment/expansion cycle number within schedule: 3" "A2780CP cell line, untreated control" +p_23603_12 "A2780CP cell line, treatment schedule: C, cisplatin treated, 5ug/ml,treatment/expansion cycle number within schedule: 6" "A2780CP cell line, untreated control" +p_23603_13 "A2780S cell line, treatment schedule: A, cisplatin treated, 1ug/ml,treatment/expansion cycle number within schedule: 3" "A2780S cell line, untreated control" +p_23603_14 "A2780S cell line, treatment schedule: A, cisplatin treated, 3ug/ml,treatment/expansion cycle number within schedule: 6" "A2780S cell line, untreated control" +p_23603_15 "A2780S cell line, treatment schedule: B, cisplatin treated, 2ug/ml,treatment/expansion cycle number within schedule: 3" "A2780S cell line, untreated control" +p_23603_16 "A2780S cell line, treatment schedule: B, cisplatin treated, 4ug/ml,treatment/expansion cycle number within schedule: 6" "A2780S cell line, untreated control" +p_23603_17 "A2780S cell line, treatment schedule: C, cisplatin treated, 3ug/ml,treatment/expansion cycle number within schedule: 3" "A2780S cell line, untreated control" +p_23603_18 "A2780S cell line, treatment schedule: C, cisplatin treated, 5ug/ml,treatment/expansion cycle number within schedule: 6" "A2780S cell line, untreated control" +p_23603_19 "C13 cell line, treatment schedule: A, cisplatin treated, 1ug/ml,treatment/expansion cycle number within schedule: 3" "C13 cell line, untreated control" +p_23603_2 "A2008 cell line, treatment schedule: A, cisplatin treated, 3ug/ml,treatment/expansion cycle number within schedule: 6" "A2008 cell line, untreated control" +p_23603_20 "C13 cell line, treatment schedule: A, cisplatin treated, 3ug/ml,treatment/expansion cycle number within schedule: 6" "C13 cell line, untreated control" +p_23603_21 "C13 cell line, treatment schedule: B, cisplatin treated, 2ug/ml,treatment/expansion cycle number within schedule: 3" "C13 cell line, untreated control" +p_23603_22 "C13 cell line, treatment schedule: B, cisplatin treated, 4ug/ml,treatment/expansion cycle number within schedule: 6" "C13 cell line, untreated control" +p_23603_23 "C13 cell line, treatment schedule: C, cisplatin treated, 3ug/ml,treatment/expansion cycle number within schedule: 3" "C13 cell line, untreated control" +p_23603_24 "C13 cell line, treatment schedule: C, cisplatin treated, 5ug/ml,treatment/expansion cycle number within schedule: 6" "C13 cell line, untreated control" +p_23603_25 "IGROV1 cell line, treatment schedule: A, cisplatin treated, 1ug/ml,treatment/expansion cycle number within schedule: 3" "IGROV1 cell line, untreated control" +p_23603_26 "IGROV1 cell line, treatment schedule: A, cisplatin treated, 3ug/ml,treatment/expansion cycle number within schedule: 6" "IGROV1 cell line, untreated control" +p_23603_27 "IGROV1 cell line, treatment schedule: B, cisplatin treated, 2ug/ml,treatment/expansion cycle number within schedule: 3" "IGROV1 cell line, untreated control" +p_23603_28 "IGROV1 cell line, treatment schedule: B, cisplatin treated, 4ug/ml,treatment/expansion cycle number within schedule: 6" "IGROV1 cell line, untreated control" +p_23603_29 "IGROV1 cell line, treatment schedule: C, cisplatin treated, 3ug/ml,treatment/expansion cycle number within schedule: 3" "IGROV1 cell line, untreated control" +p_23603_3 "A2008 cell line, treatment schedule: B, cisplatin treated, 2ug/ml,treatment/expansion cycle number within schedule: 3" "A2008 cell line, untreated control" +p_23603_30 "IGROV1 cell line, treatment schedule: C, cisplatin treated, 5ug/ml,treatment/expansion cycle number within schedule: 6" "IGROV1 cell line, untreated control" +p_23603_31 "OV2008 cell line, treatment schedule: A, cisplatin treated, 1ug/ml,treatment/expansion cycle number within schedule: 3" "OV2008 cell line, untreated control" +p_23603_32 "OV2008 cell line, treatment schedule: A, cisplatin treated, 3ug/ml,treatment/expansion cycle number within schedule: 6" "OV2008 cell line, untreated control" +p_23603_33 "OV2008 cell line, treatment schedule: B, cisplatin treated, 2ug/ml,treatment/expansion cycle number within schedule: 3" "OV2008 cell line, untreated control" +p_23603_34 "OV2008 cell line, treatment schedule: B, cisplatin treated, 4ug/ml,treatment/expansion cycle number within schedule: 6" "OV2008 cell line, untreated control" +p_23603_35 "OV2008 cell line, treatment schedule: C, cisplatin treated, 3ug/ml,treatment/expansion cycle number within schedule: 3" "OV2008 cell line, untreated control" +p_23603_36 "OV2008 cell line, treatment schedule: C, cisplatin treated, 5ug/ml,treatment/expansion cycle number within schedule: 6" "OV2008 cell line, untreated control" +p_23603_37 "OVCAR5 cell line, treatment schedule: A, cisplatin treated, 1ug/ml,treatment/expansion cycle number within schedule: 3" "OVCAR5 cell line, untreated control" +p_23603_38 "OVCAR5 cell line, treatment schedule: A, cisplatin treated, 3ug/ml,treatment/expansion cycle number within schedule: 6" "OVCAR5 cell line, untreated control" +p_23603_39 "OVCAR5 cell line, treatment schedule: B, cisplatin treated, 2ug/ml,treatment/expansion cycle number within schedule: 3" "OVCAR5 cell line, untreated control" +p_23603_4 "A2008 cell line, treatment schedule: B, cisplatin treated, 4ug/ml,treatment/expansion cycle number within schedule: 6" "A2008 cell line, untreated control" +p_23603_40 "OVCAR5 cell line, treatment schedule: B, cisplatin treated, 4ug/ml,treatment/expansion cycle number within schedule: 6" "OVCAR5 cell line, untreated control" +p_23603_41 "OVCAR5 cell line, treatment schedule: C, cisplatin treated, 3ug/ml,treatment/expansion cycle number within schedule: 3" "OVCAR5 cell line, untreated control" +p_23603_42 "OVCAR5 cell line, treatment schedule: C, cisplatin treated, 5ug/ml,treatment/expansion cycle number within schedule: 6" "OVCAR5 cell line, untreated control" +p_23603_43 "T8 cell line, treatment schedule: A, cisplatin treated, 1ug/ml,treatment/expansion cycle number within schedule: 3" "T8 cell line, untreated control" +p_23603_44 "T8 cell line, treatment schedule: A, cisplatin treated, 3ug/ml,treatment/expansion cycle number within schedule: 6" "T8 cell line, untreated control" +p_23603_45 "T8 cell line, treatment schedule: B, cisplatin treated, 2ug/ml,treatment/expansion cycle number within schedule: 3" "T8 cell line, untreated control" +p_23603_46 "T8 cell line, treatment schedule: B, cisplatin treated, 4ug/ml,treatment/expansion cycle number within schedule: 6" "T8 cell line, untreated control" +p_23603_47 "T8 cell line, treatment schedule: C, cisplatin treated, 3ug/ml,treatment/expansion cycle number within schedule: 3" "T8 cell line, untreated control" +p_23603_48 "T8 cell line, treatment schedule: C, cisplatin treated, 5ug/ml,treatment/expansion cycle number within schedule: 6" "T8 cell line, untreated control" +p_23603_5 "A2008 cell line, treatment schedule: C, cisplatin treated, 3ug/ml,treatment/expansion cycle number within schedule: 3" "A2008 cell line, untreated control" +p_23603_6 "A2008 cell line, treatment schedule: C, cisplatin treated, 5ug/ml,treatment/expansion cycle number within schedule: 6" "A2008 cell line, untreated control" +p_23603_7 "A2780CP cell line, treatment schedule: A, cisplatin treated, 1ug/ml,treatment/expansion cycle number within schedule: 3" "A2780CP cell line, untreated control" +p_23603_8 "A2780CP cell line, treatment schedule: A, cisplatin treated, 3ug/ml,treatment/expansion cycle number within schedule: 6" "A2780CP cell line, untreated control" +p_23603_9 "A2780CP cell line, treatment schedule: B, cisplatin treated, 2ug/ml,treatment/expansion cycle number within schedule: 3" "A2780CP cell line, untreated control" +p_23610_1 "MCF-7 cell, Estradiol 0.1uM treated" "MCF-7 cell, 0.001% DMSO treated" +p_23610_2 "MCF-7 cell, Ferulic acid 0.1uM treated" "MCF-7 cell, 0.001% DMSO treated" +p_23610_3 "MCF-7 cell, Ferulic acid 1uM treated" "MCF-7 cell, 0.001% DMSO treated" +p_23610_4 "MCF-7 cell, Ferulic acid 10uM treated" "MCF-7 cell, 0.001% DMSO treated" +p_23610_5 "MCF-7 cell, Si-Wu-Tang 0.0256mg/ml treated" "MCF-7 cell, 0.001% DMSO treated" +p_23610_6 "MCF-7 cell, Si-Wu-Tang 0.256mg/ml treated" "MCF-7 cell, 0.001% DMSO treated" +p_23610_7 "MCF-7 cell, Si-Wu-Tang 2.56mg/ml treated" "MCF-7 cell, 0.001% DMSO treated" +p_23614_1 "UOK257-2 cell, FLCN silenced" "UOK257-2 cell, scrambled" +p_23614_2 "UOK257-2 cell, TFE3 silenced" "UOK257-2 cell, scrambled" +p_23614_3 "UOK257-2 cell, FLCN, TFE3 silenced" "UOK257-2 cell, scrambled" +p_23627_1 RCC Lung metastatic Genration 1 RCC parental cell line +p_23627_2 RCC Lung metastatic Genration 2 RCC parental cell line +p_23630_1 "Intestinal colon cell, Frozen" "Intestinal colon cell, control" +p_23630_2 "Intestinal colon cell, PMA/IO" "Intestinal colon cell, control" +p_23630_3 "Intestinal colon cell, PMA/IO, BL23 treated" "Intestinal colon cell, control" +p_23630_4 "Intestinal colon cell, PMA/IO, LP299v treated" "Intestinal colon cell, control" +p_23630_5 "Intestinal colon cell, PMA/IO, LP299v (A-) treated" "Intestinal colon cell, control" +p_23704_1 "BAL cells, inflammatory lung disease, liposomal ATRA treated, 5uM" "BAL cells, untreated" +p_23741_1 "normal dermal fibroblast, rottlerin treated, 50ug/ml, 24h" "normal dermal fibroblast, untreated" +p_23741_2 "systemic sclerosis fibroblast, rottlerin treated, 50ug/ml, 24h" systemic sclerosis fibroblast +p_23741_3 systemic sclerosis fibroblast "normal dermal fibroblast, untreated" +p_23741_4 "systemic sclerosis fibroblast, rottlerin treated, 50ug/ml, 24h" "normal dermal fibroblast, rottlerin treated, 50ug/ml, 24h" +p_23764_1 "A375M2, thin rigid collagen" "A375M2, thick deformable collagen" +p_23764_2 "A375P, thick deformable collagen" "A375M2, thick deformable collagen" +p_23764_3 "A375M2, thick deformable collagen, blebbistatin" "A375M2, thick deformable collagen" +p_23764_4 "A375M2, thick deformable collagen, Y27632" "A375M2, thick deformable collagen" +p_23764_5 "A375M2, thick deformable collagen, H1152" "A375M2, thick deformable collagen" +p_23849_1 "293T cell, EerI treated" "293T cell, control" +p_23849_2 "293T cell, CBU-028 treated" "293T cell, control" +p_23849_3 "293T cell, 5-NA treated" "293T cell, control" +p_23878_1 "colon, tumour" "colon, paired normal tissue" +p_23882_1 "HCT116 cell, T1G1A expressed" "HCT116 cell, control" +p_23882_2 "HCT116 cell, T1G1B expressed" "HCT116 cell, control" +p_23906_1 "MAQC sample B, i.e., Ambion Human Brain Reference RNA (HBRR, Catalog #6050)" "MAQC sample A, i.e., Stratagene Universal Human Reference RNA (UHRR, Catalog #740000)" +p_23935_1 "Glioblastoma, LY2109761 treated, 2mM, 3h" "Glioblastoma, untreated" +p_23952_1 "pancreatic cancer cell (Panc-1 cells), TGF¥â Treated, 48 hr" "panceratic cnacer cell (Panc-1 cells), untreated" +p_23968_1 MRC5-derived iPSC MRC5 fibroblasts +p_23968_2 BJ1-derived iPSC BJ1 fibroblasts +p_23968_3 hFib2-derived iPSC line hFib2 fibroblasts +p_23968_4 MRC5-derived iPSC "pooled human ESC (H9, BG01)" +p_23968_5 BJ1-derived iPSC "pooled human ESC (H9, BG01)" +p_23968_6 hFib2-derived iPSC line "pooled human ESC (H9, BG01)" +p_23973_1 "hFib2-iPS5 cell, lincRNA-ST8SIA3 targeting siRNA treated" "hFib2-iPS5 cell, control" +p_23984_1 "CD3+ T lymphocytes, TX527 treated, 10nM" "CD3+ T lymphocytes, EtOH treated, control" +p_23994_1 "LiFraumeni syndrome, epithelial" Normal epithelial +p_23994_2 "LiFraumeni syndrome, stromal" Normal stromal +p_24027_1 "MCF-7 cells, VLX50 treated, 6h" "MCF-7 cells, control" +p_24044_1 "GC B cell, transfected with KDM6B" "GC B cell, control vector" +p_24089_1 "Carcinoma cell , HPV infected" "Carcinoma cell , control" +p_24091_1 "SCC cell line, HPV positive" "SCC cell line, HPV negative" +p_24093_1 "Endothelial cell, Akt activated" "Endothelial cell, GFP infected" +p_24093_2 "Endothelial cell, PymT activated" "Endothelial cell, GFP infected" +p_24093_3 "Endothelial cell, MAPK activated" "Endothelial cell, GFP infected" +p_24132_1 "adult peripheral Dendritic cell, RSV infected" "adult peripheral Dendritic cell, mock infected" +p_24132_2 "Cord blood Dendritic cell, RSV infected" "Cord blood Dendritic cell, mock infected" +p_24150_1 "MCF-7 cells, b-AP15 treated, 6h" "MCF-7 cells, control" +p_24170_1 "U2OS cell, Wt-Set8b transfected" "U2OS cell, empty vector transfected" +p_24170_2 "U2OS cell, Set8b_deltaPIP2 transfected" "U2OS cell, empty vector transfected" +p_24188_1 "hepatocyte, atorvastatin treated, 24h" "hepatocyte, untreated" +p_24188_2 "hepatocyte, atorvastatin treated, 48h" "hepatocyte, untreated" +p_24188_3 "hepatocyte, Rifampicin treated, 24h" "hepatocyte, untreated" +p_24188_4 "hepatocyte, Rifampicin treated, 48h" "hepatocyte, untreated" +p_24188_5 "hepatocyte, Rosuvastatin treated, 24h" "hepatocyte, untreated" +p_24188_6 "hepatocyte, Rosuvastatin treated, 48h" "hepatocyte, untreated" +p_24199_1 "soft-tissue sarcoma, Non-side population" "soft-tissue sarcoma, Side population" +p_24223_11 "CD14 cell, 8 week after kidney transplant" "CD14 cell, kidney transplant, day 0" +p_24223_14 "CD19 cell, 2 week after kidney transplant" "CD19 cell, kidney transplant, day 0" +p_24223_15 "CD19 cell, 12 week after kidney transplant" "CD19 cell, kidney transplant, day 0" +p_24223_18 "CD4 cell, 2 week after kidney transplant" "CD4 cell, kidney transplant, day 0" +p_24223_2 "whole blood, 1 week after kidney transplant" "whole blood, kidney transplant, day 0" +p_24223_20 "CD4 cell, 8 week after kidney transplant" "CD4 cell, kidney transplant, day 0" +p_24223_23 "CD8 cell, 2 week after kidney transplant" "CD8 cell, kidney transplant, day 0" +p_24223_24 "CD8 cell, 8 week after kidney transplant" "CD8 cell, kidney transplant, day 0" +p_24223_26 "CD56 cell, 2 week after kidney transplant" "CD56 cell, kidney transplant, day 0" +p_24223_27 "CD56 cell, 12 week after kidney transplant" "CD56 cell, kidney transplant, day 0" +p_24223_5 "whole blood, 8 week after kidney transplant" "whole blood, kidney transplant, day 0" +p_24223_8 "CD14 cell, 1 week after kidney transplant" "CD14 cell, kidney transplant, day 0" +p_24224_1 "HL60 cell, decitabine" "HL60 cell, control" +p_24244_1 "CD133+, CD144+ cell, Brain GBM tumor" "CD133-, CD144- cell, Brain GBM tumor" +p_24249_1 "MDA-MB-231 cell, GATA3 expressed" "MDA-MB-231 cell, control" +p_24259_1 "A375SM cells, transduced with PAR-1 shRNA" "A375SM cells, transduced with NT shRNA, control" +p_2435_1 "Awells cell line, autophagy, 6h" "Awells cell line, control, 6h" +p_2435_2 "Awells cell line, autophagy, 24h" "Awells cell line, control, 24h" +p_24362_1 "LCL , EBNA3CHT permissive" "LCL, control" +p_24362_2 "LCL , EBNA3CHT non-permissive" "LCL, control" +p_24468_1 "mammary epithelial cell, R5020 treated, 10nM, 16h" "mammary epithelial cell, vehicle, 16h" +p_24473_1 "T47D cell, RASSF1C over-expression" "T47D cell, control" +p_24487_1 HGPS (Hutchinson-Gilford progeria syndrom) Fibroblast BJ (CRL-2522) fibroblasts +p_24487_2 "BJ-iPSC, iPSC from normal human fibroblast (CRL-2522)" H9 ESC +p_24487_3 "HGPS-iPSC, iPSC from HGPS (Hutchinson-Gilford progeria syndrom) Fibroblast" H9 ESC +p_24493_1 "KCL-22 cell, Imatinib treated" "KCL-22 cell, control" +p_24493_2 "KU-812 cell, Imatinib treated" "KU-812 cell, control" +p_24493_3 "JURL-MK1 cell, Imatinib treated" "JURL-MK1 cell, control" +p_24522_1 "MMS1 cell, miR16 knock-out" "MMS1 cell, control" +p_24522_2 "RPMI cell, miR16 knock-out" "RPMI cell, control" +p_24530_1 "H1 hESC, FACs sorted small subpopulation" "H1 hESC, FACs sorted large subpopulation" +p_24547_1 "MCF7 cells, Danusertib treated, 24h" "MCF7 cells, untreated, 24h" +p_24547_2 "MDA-MB-468 cell, Danusertib treated, 24 h" "MDA-MB-468 cell, untreated, 24 h" +p_24547_3 "HCT-116 cells, Danusertib treated, 24h" "HCT-116 cells, untreated, 24h" +p_24547_4 "Colo205 cell, Danusertib treated, 24 h" "Colo205 cell, untreated, 24 h" +p_24547_5 "A2780 cell, Danusertib treated, 24 h" "A2780 cell, untreated, 24 h" +p_24553_1 "Thyroid cell, SAGM treated" "Thyroid cell, control" +p_24584_1 "CL1-5 cells, Analogue 3, 4¡Ç-iodo-3,3,5-tripropyl-4-methoxy treated" "CL1-5 cells, DMSO treated" +p_24612_1 "Human synovial MSC, co-culture" "Human synovial MSC, mono-culture" +p_24733_1 "293T cells, transfected with pCMV-Aire expression vector" "293T cell, control" +p_24736_1 "Mature naive B cell, Allele C/T" "Mature naive B cell, Allele C/C" +p_24736_2 "Mature naive B cell, Allele T/T" "Mature naive B cell, Allele C/C" +p_24739_1 "CD34+ G0 cell, CML patient" "CD34+ G0 cell, normal" +p_24739_2 "CD34+ G1 cell, CML patient" "CD34+ G1 cell, normal" +p_24743_1 "U937 cells, treated with shikonin" "U937 cells, treated with DMSO" +p_24783_1 "Human oral squamous carcinoma cell line (HSC-3), treated with heat stress (42¡ÆC), 0h" "Human oral squamous carcinoma cell line (HSC-3), control" +p_24783_2 "Human oral squamous carcinoma cell line (HSC-3), treated with heat stress (42¡ÆC), 6h" "Human oral squamous carcinoma cell line (HSC-3), control" +p_24783_3 "Human oral squamous carcinoma cell line (HSC-3), treated with heat stress (42¡ÆC), 12h" "Human oral squamous carcinoma cell line (HSC-3), control" +p_24783_4 "Human oral squamous carcinoma cell line (HSC-3), treated with heat stress (44¡ÆC), 0h" "Human oral squamous carcinoma cell line (HSC-3), control" +p_24783_5 "Human oral squamous carcinoma cell line (HSC-3), treated with heat stress (44¡ÆC), 6h" "Human oral squamous carcinoma cell line (HSC-3), control" +p_24783_6 "Human oral squamous carcinoma cell line (HSC-3), treated with heat stress (44¡ÆC), 12h" "Human oral squamous carcinoma cell line (HSC-3), control" +p_24824_1 "liver metastasis sample, anti-miR-182 treated" "liver metastasis sample, control" +p_24849_1 "CD34+-derived Hematopoietic stem cells, Day10, Plasmodium falciparum (3D7) infection (GenePattern)" "CD34+-derived Hematopoietic stem cells , Day10, uninfected (GenePattern)" +p_24849_2 "CD34+-derived Hematopoietic stem cells, Plasmodium falciparum (3D7) infection, Day14 (GenePattern)" "CD34+-derived Hematopoietic stem cells, uninfected, Day14 (GenePattern)" +p_24849_3 "CD34+-derived Hematopoietic stem cells, Plasmodium falciparum (3D7) infection, Day10 (dChip)" "CD34+-derived Hematopoietic stem cells, uninfected, Day10 (dChip)" +p_24849_4 "CD34+-derived Hematopoietic stem cells, Plasmodium falciparum (3D7) infection, Day14 (dChip)" "CD34+-derived Hematopoietic stem cells, uninfected, Day14 (dChip)" +p_24868_1 PC-3/S cell line PC-3/Mc cell line +p_24869_1 "monocyte, LTB4 treated, 30 min" "monocyte, control" +p_24897_1 "Macrophage, treated P.gingivalis, control" "Macrophage, treated saline, control" +p_24897_2 "Macrophage, treated PG-LPS, control" "Macrophage, treated saline, control" +p_24897_3 "Macrophage, treated PG-fimbriae, control" "Macrophage, treated saline, control" +p_25012_1 "GBM cells, transplantation into zebrafish, 24 hours post" "GBM cells, transplantation into zebrafish, 4 hours post" +p_25012_2 "GBM cells, transplantation into zebrafish, 48 hours post" "GBM cells, transplantation into zebrafish, 4 hours post" +p_25014_1 "PMVEC, 5 mM heme treated" "PMVEC, vehicle, control" +p_25014_2 "PAEC, 5 mM heme treated" "PAEC, vehicle, control" +p_25085_1 Thymocyte from Adult BM HSC Thymocyte from Fetal BM HSC +p_25085_2 Thymocyte from Fetal Liver HSC Thymocyte from Fetal BM HSC +p_25086_1 "MIAPaCa-2 cells, NDRG1 transfected" "MIAPaCa-2 cells, control vector" +p_25087_1 "Naive CD4+ T cells, adult" "Naive CD4+ T cells, fetal" +p_25087_2 "CD4+CD25+ Treg, adult" "CD4+CD25+ Treg, fetal" +p_25090_1 iPS from CD34 cell hESCs +p_25090_2 hESCs CD34 cells +p_25118_1 "NCI-H2228 xenograft, CH5424802 4mg treated" "NCI-H2228 xenograft, vehicle" +p_25118_2 "NCI-H2228 xenograft, CH5424802 20mg treated" "NCI-H2228 xenograft, vehicle" +p_25127_1 "TC32 cell, mithramycin" "TC32 cell, control" +p_25127_2 "TC71 cell, mithramycin" "TC71 cell, control" +p_25146_1 "AGS cell, LPS treated" "AGS cell, control" +p_25147_1 "MKN45 cell, LPS treated" "MKN45 cell, control" +p_25148_1 "HEK-TLR2 cell, LPS treated 2h" "HEK-TLR2 cell, control 2h" +p_25148_2 "HEK-TLR2 cell, LPS treated 4h" "HEK-TLR2 cell, control 4h" +p_25148_3 "HEK-TLR2 cell, LPS treated 8h" "HEK-TLR2 cell, control 8h" +p_25148_4 "HEK-TLR2 cell, LPS treated 24h" "HEK-TLR2 cell, control 24h" +p_25148_5 "HEK-TLR2 cell, LPS treated 48h" "HEK-TLR2 cell, control 48h" +p_25156_1 "HRP1 cell, permissive to hcv" "Huh7 cell, non-permissive to hcv" +p_25157_1 "HCV Replicon containing Huh7-K2040 cells, transfected with pTracer-CREB3L1" "HCV Replicon containing Huh7-K2040 cells, transfected with pTracer, control" +p_25162_1 "MCF7 cell, overexpressing miR-210" "MCF7 cell, control" +p_25162_2 "MDA-MB-231 cell, overexpressing miR-210" "MDA-MB-231 cell, control" +p_25191_1 "IGROV1 cells, side population" "IGROV1 cells, non-side population" +p_25251_1 "primary lung cancer, Tumor cell line" "pulmonary lymph node, cell line" +p_25251_2 "primary lung cancer, Tumor tissue" "pulmonary lymph node, tissue" +p_25269_1 "HUVEC cell, Dexamethasone, 4h" "HUVEC cell, control, 4h" +p_25269_2 "HUVEC cell, Dexamethasone, 16h" "HUVEC cell, control, 16h" +p_25300_1 "Bone marrow cells, Evolution in AML" "Bone marrow cells, MDS patients at diagnosis" +p_25311_1 "Huh7 cell, FH HDL treated" "Huh7 cell, Normal HDL treated" +p_25320_1 "HMC-1 cell, exosome" "HMC-1 cell, control" +p_25330_1 "C2M cell, Lactobacillus salivarius treated" "C2M cell, control" +p_25330_2 "C2M cell, E.coli treated" "C2M cell, control" +p_25330_3 "C2M cell, Bacteroides fragilis treated" "C2M cell, control" +p_25330_4 "C2M cell, polystyrene beads treated" "C2M cell, control" +p_25332_1 "Hec50 cell, empty vector" "Hec50 cell, control" +p_25332_2 "Hec50 cell, miR-200C treated" "Hec50 cell, control" +p_25336_1 "Olfactory MSC, Transdifferentiated to Hematopoietic SC" Olfactory MSC +p_25407_1 "breast tumor, stage I, explant" breast reduction mammoplasty tissue explant +p_25417_1 "H9 cell, hepatic differentiated, 5d" "H9 cell, hepatic differentiated, 20d, HNF4a knockdown" +p_25417_2 "H9 cell, hepatic differentiated, 10d" "H9 cell, hepatic differentiated, 20d, HNF4a knockdown" +p_25417_3 "H9 cell, hepatic differentiated, 15d" "H9 cell, hepatic differentiated, 20d, HNF4a knockdown" +p_25427_1 "normal ovarian surface epithelium, pooled from five individuals, 5-AzaC treated, 5uM, 72h" "normal ovarian surface epithelium, pooled from five individuals, mock treated" +p_25427_2 "serous borderline ovarian cells, treated with 5-AzaC" "serous borderline ovarian cells, mock treated" +p_25427_3 "serous epithelial ovarian cancer cells, 5-AzaC treated, 5uM, 72h" "serous epithelial ovarian cancer cells, mock treated" +p_25429_1 "normal ovarian surface epithelium, 5-AzaC treated, 72h" "normal ovarian surface epithelium, mock treated" +p_25429_2 "serous borderline ovarian cells, treated with 5-AzaC" "serous borderline ovarian cells, mock treated" +p_25429_3 "serous epithelial ovarian cancer cells, treated with 5-AzaC" "serous epithelial ovarian cancer cells, mock treated" +p_25436_1 "Melanoma cell line, M202R1 cell lines, V600E BRAF mutant, PLX4032 resistant" "M202 cells, V600E BRAF mutant, PLX4032 sensitive" +p_25458_1 "Ishikawa cell, metastin-10 treated" "Ishikawa cell, control" +p_25458_2 "Ishikawa cell, GPR54 suppressed, metastin-10 treated" "Ishikawa cell, GPR54 suppressed" +p_25471_1 "HEK293T, ZAPS expression, 48h" "HEK293T, control" +p_25507_1 "lymphocyte, autism" "lymphocyte, healthy control" +p_25518_1 "testicular biopsies, cryptorchidism" "contralateral descended testes, control" +p_25547_1 "HepG2 cell, GW7647 treated, 6h" "HepG2 cell, control" +p_25547_2 "HepG2 cell, GW7647 treated, 24h" "HepG2 cell, control" +p_25550_1 "MALT lymphoma, t(11;18)-negative" normal spleen tissue +p_25550_2 "MALT lymphoma, t(11;18)-positive" normal spleen tissue +p_25550_3 "MALT lymphoma, t(11;18)-positive" "MALT lymphoma, t(11;18)-negative" +p_2555_1 "HEK293 cells, HCaRG transfected" "HEK293 cells, control" +p_25571_1 "PBMC, mononuclear cells, FISH (del 13q14)" "PBMC, mononuclear cells, FISH (no del 13q14, no del 11q22-23, no del 17p13, no trisomy 12)" +p_25571_2 "PBMC, mononuclear cells, FISH (del 11q22-23)" "PBMC, mononuclear cells, FISH (no del 13q14, no del 11q22-23, no del 17p13, no trisomy 12)" +p_25571_3 "PBMC, mononuclear cells, FISH (del 17q13)" "PBMC, mononuclear cells, FISH (no del 13q14, no del 11q22-23, no del 17p13, no trisomy 12)" +p_25571_4 "PBMC, mononuclear cells, FISH (trisomy 12)" "PBMC, mononuclear cells, FISH (no del 13q14, no del 11q22-23, no del 17p13, no trisomy 12)" +p_25613_1 "Mantel cell lymphoma cell line, resistant to ABT-737" "Mantel cell lymphoma cell line, sensitive to ABT-737" +p_25619_1 "mammary fibroblast, granulin treated" "mammary fibroblast, control" +p_25634_1 "second trimester amniotic fluid, trisomy 18" "second trimester amniotic fluid, euploid control" +p_25638_1 MALT lymphoma "naive B cells, tonsil, healthy control" +p_25638_10 "Diffuse large B cell lymphoma (DLBCL), frozen biopsy" "IgM+IgD+CD27+ cells, Peripheral Blood, healthy control" +p_25638_11 "Follicular B cell lymphoma (FCL), frozen biopsy" "IgM+IgD+CD27+ cells, Peripheral Blood, healthy control" +p_25638_12 "Splenic Marginal B Cell lymphoma, frozen biopsy" "IgM+IgD+CD27+ cells, Peripheral Blood, healthy control" +p_25638_13 MALT lymphoma "CD19+ cells, Peripheral Blood, healthy control" +p_25638_14 "Diffuse large B cell lymphoma (DLBCL), frozen biopsy" "CD19+ cells, Peripheral Blood, healthy control" +p_25638_15 "Follicular B cell lymphoma (FCL), frozen biopsy" "CD19+ cells, Peripheral Blood, healthy control" +p_25638_16 "Splenic Marginal B Cell lymphoma, frozen biopsy" "CD19+ cells, Peripheral Blood, healthy control" +p_25638_17 MALT lymphoma "CD19+ cells, Peripheral blood, activated, healthy control" +p_25638_18 "Diffuse large B cell lymphoma (DLBCL), frozen biopsy" "CD19+ cells, Peripheral blood, activated, healthy control" +p_25638_19 "Follicular B cell lymphoma (FCL), frozen biopsy" "CD19+ cells, Peripheral blood, activated, healthy control" +p_25638_2 "Diffuse large B cell lymphoma (DLBCL), frozen biopsy" "naive B cells, tonsil, healthy control" +p_25638_20 "Splenic Marginal B Cell lymphoma, frozen biopsy" "CD19+ cells, Peripheral blood, activated, healthy control" +p_25638_3 "Follicular B cell lymphoma (FCL), frozen biopsy" "naive B cells, tonsil, healthy control" +p_25638_4 "Splenic Marginal B Cell lymphoma, frozen biopsy" "naive B cells, tonsil, healthy control" +p_25638_5 MALT lymphoma "Memory B cells, tonsil, healthy control" +p_25638_6 "Diffuse large B cell lymphoma (DLBCL), frozen biopsy" "Memory B cells, tonsil, healthy control" +p_25638_7 "Follicular B cell lymphoma (FCL), frozen biopsy" "Memory B cells, tonsil, healthy control" +p_25638_8 "Splenic Marginal B Cell lymphoma, frozen biopsy" "Memory B cells, tonsil, healthy control" +p_25638_9 MALT lymphoma "IgM+IgD+CD27+ cells, Peripheral Blood, healthy control" +p_25725_1 "HEL cell, CEP701 treated" "HEL cell, DMSO treated" +p_25725_2 "HEL cell, shPRMT5 treated" "HEL cell, shControl treated" +p_25743_1 "Hs578T cell, EpCAM expressed" "Hs578T cell, control" +p_25861_1 "endothelial cells, Intra Uterine Growth Restriction" "endothelial cells, Preterm labour, control" +p_25941_1 "Muscle cell, Old, male" "Muscle cell, Young, male" +p_25941_2 "Muscle cell, Old, Female" "Muscle cell, Young, Female" +p_25986_1 Hodgkin lymphoma cell Germinal center +p_25987_1 "KM-H2 cells, CIITA-BX648577 knockdown" "KM-H2 cells, Non-silencing control" +p_2600_1 "NB4 cells, Anaplasma phagocytophilum infected" "NB4 cells, control" +p_26027_1 "Rectum tumor, one hour after a dose of 7.2 Gy (4th fraction) during radiotherapy" "Rectum tumor, before radiotherapy" +p_26049_1 "whole blood, Essential Thronbocythemia, RMA" "whole blood, control, RMA" +p_26049_2 "whole blood, Polycythemia Vera, RMA" "whole blood, control, RMA" +p_26049_3 "whole blood, Primary Myelofibrosis, RMA" "whole blood, control, RMA" +p_26049_4 "whole blood, Essential Thronbocythemia, dChip" "whole blood, control, dChip" +p_26049_5 "whole blood, Polycythemia Vera, dChip" "whole blood, control, dChip" +p_26049_6 "whole blood, Primary Myelofibrosis, dChip" "whole blood, control, dChip" +p_26050_1 "Peripheral Blood Mononuclear Cell, FHL, WT" "Peripheral Blood Mononuclear Cell, no-FHL, control" +p_26050_2 "Peripheral Blood Mononuclear Cell, FHL, PRF" "Peripheral Blood Mononuclear Cell, no-FHL, control" +p_26077_1 "PDL cell, mechanical stress 48h" "PDL cell, control" +p_26114_1 "MV4-11, ABT-869" "MV4-11, Control" +p_26114_2 "MV4-11, SAHA" "MV4-11, Control" +p_26114_3 "MV4-11, ABT-869 + SAHA" "MV4-11, Control" +p_26114_4 "MOLM-14, ABT-869" "MOLM-14, Control" +p_26114_5 "MOLM-14, SAHA" "MOLM-14, Control" +p_26114_6 "MOLM-14, ABT-869 + SAHA" "MOLM-14, Control" +p_26146_1 Human vascular adventital fibroblast Human lung cell derived fibroblast +p_26156_1 Double Positive CD4 T cells Single Positive CD4 T cells +p_26176_1 "W12 cervical ectokeratinocyte, passage 22" "W12 cervical ectokeratinocyte, passage 19" +p_26213_1 "early human hypertrophic scar, white, neck, 6.7 mpi, 19 yr" "early human hypertrophic scar, black, upper extremity, 10.8 mpi, 54 yr" +p_26272_1 "MSC, ZNF145 overexpressed" "MSC, control" +p_26298_1 "MCF-7 cell, scramble siRNA, 100nM 4-hydroxytamoxifen treated" "MCF-7 cell, scramble siRNA, vehicle" +p_26298_2 "MCF-7 cell, scramble siRNA, 500nM 4-hydroxytamoxifen treated" "MCF-7 cell, scramble siRNA, vehicle" +p_26298_3 "MCF-7 cell, ER siRNA, vehicle" "MCF-7 cell, scramble siRNA, vehicle" +p_26298_4 "MCF-7 cell, RARalpha siRNA, vehicle" "MCF-7 cell, scramble siRNA, vehicle" +p_26308_1 "Xenograft, treated" "Xenograft, untreated" +p_26308_2 A375 cell RNA on mouse A375 cell RNA on human +p_26332_1 "C4-2 cell, miR-99a transfected" "C4-2 cell, control" +p_2634_1 African green monkey whole blood human whole blood +p_2634_2 Rhesus monkey whole blood human whole blood +p_2634_3 cynomologus macaque whole blood human whole blood +p_26351_1 "mobilized peripheral blood CD34+ cell, BIO treated" "mobilized peripheral blood CD34+ cell, control" +p_26351_2 "mobilized peripheral blood CD34+ cell, BMP4 treated" "mobilized peripheral blood CD34+ cell, control" +p_26378_1 "whole blood, septic shock patients" "whole blood, normal control" +p_26440_1 "whole blood, septic shock patients" "whole blood, normal control" +p_26451_1 HES-3 FORESKIN +p_26451_2 "ES4SKIN, induced pluripotent stem cells" HES-3 +p_26453_1 HES-3 IMR90 +p_26453_2 "ESIMR90, induced pluripotent stem cells" HES-3 +p_26459_1 "MCF7 cell, estrogen treated, Tamoxifen sensitive" "MCF7 cell, control, Tamoxifen sensitive" +p_26459_2 "MCF7 cell, 4-OHT treated, Tamoxifen sensitive" "MCF7 cell, control, Tamoxifen sensitive" +p_26459_3 "MCF7 cell, estrogen+4-OHT treated, Tamoxifen sensitive" "MCF7 cell, control, Tamoxifen sensitive" +p_26459_4 "MCF7 cell, estrogen treated, Tamoxifen resistant" "MCF7 cell, control, Tamoxifen resistant" +p_26459_5 "MCF7 cell, 4-OHT treated, Tamoxifen resistant" "MCF7 cell, control, Tamoxifen resistant" +p_26459_6 "MCF7 cell, estrogen+4-OHT treated, Tamoxifen resistant" "MCF7 cell, control, Tamoxifen resistant" +p_26462_1 "MDA-MB-231 cell, WASF3 knockdown" "MDA-MB-231 cell, control" +p_26484_1 "PBMC, MS patient, low Sema4A" "PBMC, healthy, low Sema4A" +p_26484_2 "PBMC, MS patient, high Sema4A" "PBMC, MS patient, low Sema4A" +p_26495_1 PD-1 high CD8+ CD3+ T cells Naive CD8+ CD3+ T cells +p_26495_2 PD-1 low CD8+ CD3+ T cells Naive CD8+ CD3+ T cells +p_26525_1 "A549 cell, Geld IC50 treated, 24h" "A549 cell, DMSO treated, 24h" +p_26525_2 "A549 cell, Geld IC20 treated, 48h" "A549 cell, DMSO treated, 48h" +p_26525_3 "A549 cell, Geld IC50 treated, 48h" "A549 cell, DMSO treated, 48h" +p_26526_1 "flow-sorted CD19+ cells, peripheral blood,chronic lymphocytic leukemia patient, del11q present" "flow-sorted CD19+ cells, peripheral blood,chronic lymphocytic leukemia patient, non-del11q" +p_26541_1 "HMEC, shp53 , Ras, Epi treated" "HMEC, shp53 treated" +p_26541_2 "HMEC, shp53 , Ras, Mes treated" "HMEC, shp53 treated" +p_26567_1 "mouse lung, LPS-exposed, MSC treated" "mouse lung, LPS-exposed, PBS treated" +p_26567_2 "mouse lung, LPS-exposed, MSC treated" "mouse lung, PBS-exposed, MSC treated" +p_26567_3 "mouse lung, LPS-exposed, MSC in vitro mix" "mouse lung, PBS-exposed, MSC in vitro mix" +p_26569_1 "G3361 cell, ABCB5 negative" "G3361 cell, ABCB5 positive" +p_26569_2 "A375 cell, ABCB5 negative" "A375 cell, ABCB5 positive" +p_26569_3 "Melanoma cell, ABCB5 negative" "Melanoma cell, ABCB5 positive" +p_26594_1 "FS087 cell, Fas stimulated" "FS087 cell, control" +p_26594_2 "MRC5 cell, Fas stimulated" "MRC5 cell, control" +p_26594_3 "N78 cell, Fas stimulated" "N78 cell, control" +p_26599_1 "HB4a, Doxorubicin treated" "HB4a, DMSO treated" +p_26599_2 "HB4a, Rapamycin treated" "HB4a, DMSO treated" +p_26599_3 "HB4a, Doxorubicin, Rapamycin treated" "HB4a, DMSO treated" +p_26599_4 "C5.2 cell, Doxorubicin treated" "C5.2 cell, DMSO treated" +p_26599_5 "C5.2 cell, Rapamycin treated" "C5.2 cell, DMSO treated" +p_26599_6 "C5.2 cell, Doxorubicin, Rapamycin treated" "C5.2 cell, DMSO treated" +p_26599_7 "SKBR3, Doxorubicin treated" "SKBR3, DMSO treated" +p_26599_8 "SKBR3, Rapamycin treated" "SKBR3, DMSO treated" +p_26599_9 "SKBR3, Doxorubicin, Rapamycin treated" "SKBR3, DMSO treated" +p_26603_1 "M14 cell, ARHGAP8 activated, 2d" "M14 cell, GFP activated, 2d" +p_26603_2 "M14 cell, ARHGAP8 activated, 3d" "M14 cell, GFP activated, 3d" +p_26622_1 Liver biopsy after immunosuppressive therapy Liver biopsy before immunosuppressive therapy +p_26626_1 "ADSC, PUM2 repressed" "ADSC, control" +p_26637_1 "Adipose cell, Fasting, Insulin resistant" "Adipose cell, Fasting, Insulin sensitive" +p_26637_2 "Adipose cell, Hyperinsulinemic, Insulin resistant" "Adipose cell, Hyperinsulinemic, Insulin sensitive" +p_26656_1 "A375 melanoma cell-line, Wnt-1 overexpressed" "A375 melanoma cell-line, control" +p_26656_2 "A375 melanoma cell-line, treated CsA, Wnt-1 overexpressed" "A375 melanoma cell-line, treated CsA" +p_26656_3 "M24met melanoma cell-line, Wnt-1 overexpressing" "M24met melanoma cell-line, control" +p_26661_1 "BC-3 cell, treated si463" "BC-3 cell, treated siN, control" +p_26661_2 "BC-3 cell, treated si716s" "BC-3 cell, treated siN, control" +p_26673_1 "Immunodeficiency associated Burkitt lymphoma, HIV-infected European adult" "Burkitt lymphoma, African children" +p_26704_1 "H460 cell line, wild type, CCDP treated, 1h" "H460 cell line, wild type, control" +p_26704_10 "H460 cell line, DUSP1 knockdown, CCDP treated, 6h" "H460 cell line, wild type, CCDP treated, 6h" +p_26704_3 "H460 cell line, wild type, CCDP treated, 6h" "H460 cell line, wild type, control" +p_26704_4 "H460 cell line, DUSP1 knockdown, CCDP treated, 1h" "H460 cell line, DUSP1 knockdown, control" +p_26704_6 "H460 cell line, DUSP1 knockdown, CCDP treated, 6h" "H460 cell line, DUSP1 knockdown, control" +p_26704_8 "H460 cell line, DUSP1 knockdown, CCDP treated, 1h" "H460 cell line, wild type, CCDP treated, 1h" +p_26725_1 "peripheral blood, B-CLL patients" "peripheral blood, control" +p_26748_1 "SiHa cells, cidofovir treated, 50g/ml, 24h growth" "SiHa cells, 24h growth" +p_26748_2 "SiHa cells, cidofovir treated, 50g/ml, 48h growth" "SiHa cells, 48h growth" +p_26748_3 "SiHa cells, cidofovir treated, 50g/ml, 72h growth" "SiHa cells, 72h growth" +p_26748_4 "SiHa cells, cidofovir treated, 50g/ml, 72h growth" "SiHa cells, cidofovir resistant, 72h growth" +p_2677_1 "peripheral blood, CG treated, 6h" "peripheral blood, CG untreated, 0h" +p_2677_2 "peripheral blood, CG treated, 8h" "peripheral blood, CG untreated, 0h" +p_2677_3 "peripheral blood, CG treated, 24h" "peripheral blood, CG untreated, 0h" +p_26828_1 "UROtsa cell, Cadmium-transformed" "UROtsa cells, control" +p_26862_1 "H9 cell, SOX17 treated, stage 1" "H9 cell, control" +p_26862_2 "H9 cell, SOX17 treated, stage 2" "H9 cell, control" +p_26868_1 "HeLa cells, TNF-alpha treated, 10ng/mL, 2h" "HeLa cells, control" +p_26868_2 "THP1 cells, TNF-alpha treated, 10ng/mL, 2h" "THP1 cells, control" +p_26878_1 "acute lymphoblastic leukemia, subtype: High Hyperploidy" "acute lymphoblastic leukemia, subtype: dic(9;20)" +p_26878_10 "acute lymphoblastic leukemia, subtype: T-cell lineage ALL (T-ALL)" "acute lymphoblastic leukemia, subtype: t(9;22) BCR-ABL1" +p_26878_2 "acute lymphoblastic leukemia, subtype: t(12;21) ETV6-RUNX1" "acute lymphoblastic leukemia, subtype: dic(9;20)" +p_26878_3 "acute lymphoblastic leukemia, subtype: t(9;22) BCR-ABL1" "acute lymphoblastic leukemia, subtype: dic(9;20)" +p_26878_4 "acute lymphoblastic leukemia, subtype: T-cell lineage ALL (T-ALL)" "acute lymphoblastic leukemia, subtype: dic(9;20)" +p_26878_5 "acute lymphoblastic leukemia, subtype: t(12;21) ETV6-RUNX1" "acute lymphoblastic leukemia, subtype: High Hyperploidy" +p_26878_6 "acute lymphoblastic leukemia, subtype: t(9;22) BCR-ABL1" "acute lymphoblastic leukemia, subtype: High Hyperploidy" +p_26878_7 "acute lymphoblastic leukemia, subtype: T-cell lineage ALL (T-ALL)" "acute lymphoblastic leukemia, subtype: High Hyperploidy" +p_26878_8 "acute lymphoblastic leukemia, subtype: t(9;22) BCR-ABL1" "acute lymphoblastic leukemia, subtype: t(12;21) ETV6-RUNX1" +p_26878_9 "acute lymphoblastic leukemia, subtype: T-cell lineage ALL (T-ALL)" "acute lymphoblastic leukemia, subtype: t(12;21) ETV6-RUNX1" +p_26884_1 "MCF 10 cell, 10uM BPA treated" "MCF 10 cell, DMSO treated" +p_26884_2 "MCF 10 cell, 1uM BPA treated" "MCF 10 cell, DMSO treated" +p_26886_1 esophageal adenocarcinoma Barrett's esophagus +p_26886_2 esophageal squamous cell carcinoma esophageal squamous epithelium +p_26890_1 "Peripheral CD8+ T cells, cell phenotype: CXCR1+CD27-CD28-" "Peripheral CD8+ T cells, cell phenotype: CXCR1-CD27-CD28-" +p_26910_1 "Breast cell, tumor" "Breast cell, normal" +p_26910_2 "Prostate cell, tumor" "Prostate cell, normal" +p_26920_1 "DMS-53 cell, DFO treated" "DMS-53 cell, control" +p_26920_2 "DMS-53 cell, Dp44mT treated" "DMS-53 cell, control" +p_26921_1 "NCI-H929 cells, DZNep treated, 0.5uM, 48h" "NCI-H929 cells, DMSO treated, control" +p_26921_2 "MM.1S cells, DZNep treated, 0.5uM, 48h" "MM.1S cells, DMSO treated, control" +p_26921_3 "KMS18 cells, DZNep treated, 0.5uM, 48h" "KMS18 cells, DMSO treated, control" +p_26921_4 "OPM-2 cells, DZNep treated, 0.5uM, 48h" "OPM-2 cells, DMSO treated, control" +p_26966_1 Gonadotrope tumor Normal pituitary +p_26969_1 "arterial tissue, unruptured aneurysm" "arterial tissue, normal" +p_26994_1 "HeLa cells,, treated with TNF-alpha, 10ng/mL, 2h" "HeLa cells, untreated control" +p_26994_2 "THP1 cells, treated with TNF-alpha, 10ng/mL, 2h" "THP1 cells, untreated control" +p_27018_1 "Breast cancer tumor, tumor sample histological grade: low, co-cultured with fibroblast, 3 days" "Breast cancer tumor, tumor sample histological grade: low, untreated, 3 days" +p_27018_2 "Breast cancer tumor, tumor sample histological grade: high, co-cultured with fibroblast, 3 days" "Breast cancer tumor, tumor sample histological grade: high, untreated, 3 days" +p_27071_1 "Monocyte cell, serum, treated" "Monocyte cell, control" +p_27071_2 "Monocyte cell, serum, U0126 treated" "Monocyte cell, control" +p_27120_1 "Fibroblast, co-cultured with: BT474" "Fibroblast, co-cultured with: n/a" +p_27120_10 "MSC, co-cultured with: MCF7" "MSC, co-cultured with: n/a" +p_27120_11 "MSC, co-cultured with: MDA-MB-231" "MSC, co-cultured with: n/a" +p_27120_12 "MSC, co-cultured with: MDA-MB-361" "MSC, co-cultured with: n/a" +p_27120_13 "MSC, co-cultured with: SKBR3" "MSC, co-cultured with: n/a" +p_27120_14 "MSC, co-cultured with: T47D" "MSC, co-cultured with: n/a" +p_27120_15 "Myoepithelial, co-cultured with: BT474" "Myoepithelial, co-cultured with: n/a" +p_27120_16 "Myoepithelial, co-cultured with: LY2" "Myoepithelial, co-cultured with: n/a" +p_27120_17 "Myoepithelial, co-cultured with: MCF7" "Myoepithelial, co-cultured with: n/a" +p_27120_18 "Myoepithelial, co-cultured with: MDA-MB-231" "Myoepithelial, co-cultured with: n/a" +p_27120_19 "Myoepithelial, co-cultured with: MDA-MB-361" "Myoepithelial, co-cultured with: n/a" +p_27120_2 "Fibroblast, co-cultured with: LY2" "Fibroblast, co-cultured with: n/a" +p_27120_20 "Myoepithelial, co-cultured with: SKBR3" "Myoepithelial, co-cultured with: n/a" +p_27120_21 "Myoepithelial, co-cultured with: T47D" "Myoepithelial, co-cultured with: n/a" +p_27120_3 "Fibroblast, co-cultured with: MCF7" "Fibroblast, co-cultured with: n/a" +p_27120_4 "Fibroblast, co-cultured with: MDA-MB-231" "Fibroblast, co-cultured with: n/a" +p_27120_5 "Fibroblast, co-cultured with: MDA-MB-361" "Fibroblast, co-cultured with: n/a" +p_27120_6 "Fibroblast, co-cultured with: SKBR3" "Fibroblast, co-cultured with: n/a" +p_27120_7 "Fibroblast, co-cultured with: T47D" "Fibroblast, co-cultured with: n/a" +p_27120_8 "MSC, co-cultured with: BT474" "MSC, co-cultured with: n/a" +p_27120_9 "MSC, co-cultured with: LY2" "MSC, co-cultured with: n/a" +p_27128_1 "Human airway epithelial Calu-3 cells, strained at 30%, 24h" "Human airway epithelial Calu-3 cells, non strained" +p_27157_1 "tumor tissue, p53 mutant" "tumor tissue, p53 wild type" +p_27160_1 "HUVEC cell, matrigel 8h" "HUVEC cell, matrigel 0.5h" +p_27160_2 "HUVEC cell, matrigel 18h" "HUVEC cell, matrigel 0.5h" +p_27186_1 Induced pluripotent stem cells from umbilical cord blood Umbilical cord blood +p_27186_2 Induced pluripotent stem cell from keratinocyte Keratinocyte +p_27187_1 "AML-M5 patients, DNMT3A mutation" "AML-M5 patients, DNMT3A wild type" +p_27206_1 "iPS cells, SMA patient" "iPS cells, 19.9 control" +p_27206_2 "Fibroblast, SMA patient" "Fibroblast, healthy" +p_27220_1 "breast cancer, vitaminD, 0.5nM, 24h" "breast cancer, control, 24h" +p_27220_2 "breast cancer, vitaminD, 100nM, 24h" "breast cancer, control, 24h" +p_27224_1 iPSC derived from Cord Blood Cord Blood +p_27224_2 iPSC derived from Keratinocyte Keratinocyte +p_27263_1 "nasal biopsy, after inhalation (0.7 ppm Formaldehyde), 0h" "nasal biopsy, before inhalation" +p_27263_2 "nasal biopsy, after inhalation (0.7 ppm Formaldehyde), 24h" "nasal biopsy, before inhalation" +p_27263_3 "nasal biopsy, after inhalation (0.7 ppm Formaldehyde), 72h" "nasal biopsy, before inhalation" +p_27263_4 "Blood, after inhalation (0.7 ppm Formaldehyde), 0h" "Blood, before inhalation" +p_27263_5 "Blood, after inhalation (0.7 ppm Formaldehyde), 24h" "Blood, before inhalation" +p_27263_6 "Blood, after inhalation (0.7 ppm Formaldehyde), 72h" "Blood, before inhalation" +p_27263_7 "Blood cells, exposed to 200uM Formaldehyde, 4h" "Blood cells, before exposure" +p_27280_1 "iPSC, Pompe disease" "Human fibroblast, Pompe disease" +p_27280_2 "CMLC derived from iPSC, Pompe disease" CMLC derived from hESC +p_27313_1 "hMSC, WNT3a treated, 6h" "hMSC, control" +p_27313_2 "hMSC, WNT3a treated, 24h" "hMSC, control" +p_27316_1 "HEK293 cell, MosIR plasmid" "HEK293 cell, control plasmid" +p_27316_2 "Hela cell, MosIR plasmid" "Hela cell, control plasmid" +p_27318_1 "NPC 5-8F cells, NESG1 overexpression" "NPC 5-8F cells, NESG1-negative expression" +p_27328_1 "SKOV3 cell, express LHR" "SKOV3 cell, control" +p_27328_2 "SKOV3 cell, express LHR, LH treated, 1h" "SKOV3 cell, control" +p_27328_3 "SKOV3 cell, express LHR, LH treated, 4h" "SKOV3 cell, control" +p_27328_4 "SKOV3 cell, express LHR, LH treated, 8h" "SKOV3 cell, control" +p_27328_5 "SKOV3 cell, express LHR, LH treated, 20h" "SKOV3 cell, control" +p_27372_1 "HOB-01 pre-osteocytes cells, transwell JJN3" "HOB-01 pre-osteocytes cells, control" +p_27424_1 "Kelatinocytes, Notch3 shRNA, low" "Kelatinocytes, scramble shRNA, low" +p_27424_2 "Kelatinocytes, Notch3 shRNA, high" "Kelatinocytes, scramble shRNA, high" +p_27431_1 "ovarian cancer cell, miR-7 treated" "ovarian cancer cell, control miRNA treated" +p_27431_2 "ovarian cancer cell, miR-128 treated" "ovarian cancer cell, control miRNA treated" +p_27444_1 "MCF7 cells, retroviral transduction: ZF-TF 115, 1st infection" "MCF7 cells, 1st infection, control" +p_27444_10 "MCF7 cells, retroviral transduction: ZF-TF 70, 2nd infection" "MCF7 cells, 2nd infection, control" +p_27444_11 "MCF7 cells, retroviral transduction: ZF-TF 7, 2nd infection" "MCF7 cells, 2nd infection, control" +p_27444_12 "MCF7 cells, retroviral transduction: ZF-TF 83, 2nd infection" "MCF7 cells, 2nd infection, control" +p_27444_2 "MCF7 cells, retroviral transduction: ZF-TF 19, 1st infection" "MCF7 cells, 1st infection, control" +p_27444_3 "MCF7 cells, retroviral transduction: ZF-TF 64, 1st infection" "MCF7 cells, 1st infection, control" +p_27444_4 "MCF7 cells, retroviral transduction: ZF-TF 70, 1st infection" "MCF7 cells, 1st infection, control" +p_27444_5 "MCF7 cells, retroviral transduction: ZF-TF 7, 1st infection" "MCF7 cells, 1st infection, control" +p_27444_6 "MCF7 cells, retroviral transduction: ZF-TF 83, 1st infection" "MCF7 cells, 1st infection, control" +p_27444_7 "MCF7 cells, retroviral transduction: ZF-TF 115, 2nd infection" "MCF7 cells, 2nd infection, control" +p_27444_8 "MCF7 cells, retroviral transduction: ZF-TF 19, 2nd infection" "MCF7 cells, 2nd infection, control" +p_27444_9 "MCF7 cells, retroviral transduction: ZF-TF 64, 2nd infection" "MCF7 cells, 2nd infection, control" +p_27473_1 "MCF-7 cells, silenced Estrogen Receptor" "MCF-7 cells, control" +p_27489_1 "ELF cell, contralateral site" "ELF cell, nodule site" +p_27515_1 MDA231 cell "B6TC cell, hybrided MDA231,ZR75" +p_27515_2 ZR75 cell "B6TC cell, hybrided MDA231,ZR75" +p_27526_1 "A2780 cell, TGF - beta treated, SMAD4 stimulated" "A2780 cell, TGF - beta treated" +p_27529_1 "L428 cells, miR-9 LNA treatead" "L428 cells, scrambled LNA treated" +p_27554_1 "endobronchial epithelial lining fluid, nodule site, adenocarcinoma" "endobronchial epithelial lining fluid, nodule site, control patients" +p_27554_2 "endobronchial epithelial lining fluid, nodule site, squamous cell carcinoma" "endobronchial epithelial lining fluid, nodule site, control patients" +p_27554_3 "endobronchial epithelial lining fluid, contralateral site, adenocarcinoma" "endobronchial epithelial lining fluid, contralateral site, control patients" +p_27554_4 "endobronchial epithelial lining fluid, contralateral site, squamous cell carcinoma" "endobronchial epithelial lining fluid, contralateral site, control patients" +p_27562_1 "PBMCs, patients with diagnosis of invasive breast cancer, confirmed by diagnostic biopsy" "PBMCs, patients with normal mammogram" +p_27562_2 "PBMCs, patients with benign diagnosis, confirmed by diagnostic biopsy" "PBMCs, patients with normal mammogram" +p_27562_3 "PBMCs, patients with other cancer types (e.g., gastrointestinal and brain" "PBMCs, patients with normal mammogram" +p_27631_1 "HUVEC, BMP6 treated, 6h" "HUVEC, control" +p_27631_2 "HUVEC, BMP6 treated, 24h" "HUVEC, control" +p_27631_3 "HUVEC, BMP9 treated, 6h" "HUVEC, control" +p_27631_4 "HUVEC, BMP9 treated, 24h" "HUVEC, control" +p_27651_1 Serous borderline ovarian tumor cell "Human ovrian surface epithelia cell, control" +p_27651_2 "Serous borderline ovarian carcinoma, low grade serous" "Human ovrian surface epithelia cell, control" +p_27651_3 "Serous borderline ovarian carcinoma, high grade serous" "Human ovrian surface epithelia cell, control" +p_27657_1 Perithyroid adipose tissue Subcutaneous adipose tissue +p_27659_1 "serous borderline tumors, BRAF mutation" "serous borderline tumors, wild type" +p_27670_1 "GC B cell, pcDNA3.1-pRDM1A transfected" "GC B cell, empty vector" +p_27670_2 "GC B cell, pcDNA3.1-LMP1 transfected" "GC B cell, empty vector" +p_27718_1 "4L melanoma cell, miR-30d treated" "4L melanoma cell, scrambled miR treated" +p_27718_2 "5B1 melanoma cell, miR-30d treated" "5B1 melanoma cell, scrambled miR treated" +p_27820_1 "HUMSC, active" "HUMSC, inactive" +p_27820_2 "HUMSC, active, culture in hypoxia condition" "HUMSC, inactive" +p_27854_1 "colorectal cancer, metastasis" "colorectal cancer, non-metastasis" +p_27909_1 "Trophoblast, side population" "Trophoblast, non-side population" +p_27914_1 "LNCaP cell, COP1 siRNA" "LNCaP cell, control siRNA" +p_27914_2 "LNCaP cell, COP1, ETV1 siRNA" "LNCaP cell, control siRNA" +p_27914_3 "LNCaP cell, COP1, c-JUN siRNA" "LNCaP cell, control siRNA" +p_27914_4 "LNCaP cell, COP1, ETV1, c-JUN siRNA" "LNCaP cell, control siRNA" +p_27928_1 "CD4 cell, Tonsil patient" "CD4 cell, FL patient" +p_27928_2 "CD8 cell, Tonsil patient" "CD8 cell, FL patient" +p_27931_1 "GBM cell, TRRAP knockdown" "GBM cell, control" +p_28050_1 "HEK 293T cells, esiRNA targeting BACH1, 24h" "HEK 293T cells, mock transfection, 24h" +p_28050_2 "HEK 293T cells, siRNA1 targeting BACH1, 24h" "HEK 293T cells, mock transfection, 24h" +p_28050_3 "HEK 293T cells, siRNA2 targeting BACH1, 24h" "HEK 293T cells, mock transfection, 24h" +p_28050_4 "HEK 293T cells, esiRNA targeting BACH1, 72h" "HEK 293T cells, mock transfection, 72h" +p_28050_5 "HEK 293T cells, siRNA1 targeting BACH1, 72h" "HEK 293T cells, mock transfection, 72h" +p_28050_6 "HEK 293T cells, siRNA2 targeting BACH1, 72h" "HEK 293T cells, mock transfection, 72h" +p_28053_1 "HEK293T cell, BACH1 esiRNA treated, 24h" "HEK293T cell, control" +p_28053_2 "HEK293T cell, BACH1 siRNA treated, 24h" "HEK293T cell, control" +p_28053_3 "HEK293T cell, BACH1 esiRNA treated, 72h" "HEK293T cell, control" +p_28053_4 "HEK293T cell, BACH1 siRNA treated, 72h" "HEK293T cell, control" +p_28057_1 "Huh7 cell, CD24 knock down" "Huh7 cell, control" +p_28059_1 "Huh7 cell, DEGS1 silenced" "Huh7 cell, control silenced" +p_28059_2 "Huh7 cell, SPTLC123 silenced" "Huh7 cell, control silenced" +p_28160_1 "Brain cell, Untreated HAND" "Brain cell, control" +p_28160_2 "Brain cell, treated HAND" "Brain cell, control" +p_2816_1 "primary human monocyte, cMyb virus-infected" "primary human monocyte, control virus-infected" +p_2816_2 "primary human monocyte, vMyb virus-infected" "primary human monocyte, control virus-infected" +p_28167_1 "Brain U251MG glioma cells, cultured on highly-aligned electrospun nanofibers of poly-caprolactone" "Brain U251MG glioma cells, cultured on randomly-oriented electrospun nanofibers of poly-caprolactone" +p_2817_1 alive glioma; brain cancer recurrent glioma +p_28177_1 "jejunum, HIV-infected" "jejunum, uninfected control" +p_28274_1 "MCF7 cell, glycolysis induced" "MCF7 cell, control" +p_28274_2 "MCF7 cell, beginning of death" "MCF7 cell, control" +p_28304_1 Human dermal microvascular endothelial cell si-GATA2 Human dermal microvascular endothelial cell +p_28305_1 "MDA-MB-453 cell, DHT treated, 4h" "MDA-MB-453 cell, vehicle" +p_28305_2 "MDA-MB-453 cell, DHT treated, 16h" "MDA-MB-453 cell, vehicle" +p_28305_3 "MDA-MB-453 cell, DHT treated, 48h" "MDA-MB-453 cell, vehicle" +p_28317_1 "CD34+ cell, MIGR1, AML1, ETO infected" "CD34+ cell, MIGR1 infected" +p_28317_2 "CD34+ cell, MIGR1, AML1, ETOdNHR1 infected" "CD34+ cell, MIGR1 infected" +p_28331_1 Myeloma tumor "Endothelial progenitor cell, Advanced multiple myeloma" +p_28335_1 "Melanoma, invasive" "Melanoma, proliferative" +p_28339_1 "HeLa cell, Cyclin T1 shRNA" "HeLa cell, control" +p_28339_2 "HeLa cell, Cyclin T2 shRNA" "HeLa cell, control" +p_28359_1 "Hematopoietic stem cell (HSC), SR1 treated, 30nM, 24h" "Hematopoietic stem cell (HSC), SR1 treated, 0nM, 24h" +p_28359_2 "Hematopoietic stem cell (HSC), SR1 treated, 100nM, 24h" "Hematopoietic stem cell (HSC), SR1 treated, 0nM, 24h" +p_28359_3 "Hematopoietic stem cell (HSC), SR1 treated, 300nM, 24h" "Hematopoietic stem cell (HSC), SR1 treated, 0nM, 24h" +p_28359_4 "Hematopoietic stem cell (HSC), SR1 treated, 1000nM, 24h" "Hematopoietic stem cell (HSC), SR1 treated, 0nM, 24h" +p_28359_5 "Hematopoietic stem cell (HSC), LGC006 treated, 30nM, 24h" "Hematopoietic stem cell (HSC), SR1 treated, 0nM, 24h" +p_28359_6 "Hematopoietic stem cell (HSC), LGC006 treated, 300nM, 24h" "Hematopoietic stem cell (HSC), SR1 treated, 0nM, 24h" +p_28359_7 "Hematopoietic stem cell (HSC), LGC006 treated, 1000nM, 24h" "Hematopoietic stem cell (HSC), SR1 treated, 0nM, 24h" +p_28392_1 "vastus lateralis muscle, Young Female, trained" "vastus lateralis muscle, Young Female, untrained" +p_28392_2 "vastus lateralis muscle, Old Female, trained" "vastus lateralis muscle, Old Female, untrained" +p_28406_1 induced pluripotency cells from DPC dermal papilla cells (DPC) +p_28406_2 induced pluripotency cells from granulosa cells primary granulosa cells +p_28406_3 induced pluripotency cells from foreskin cells primary foreskin cells +p_28413_1 "MCF7VP cells, etoposide-resistant" "MCF-7 cells, control" +p_28414_1 "MCF7VP cell, RUNX2 knockdown" "MCF7VP cell, control" +p_2842_1 acute lymphoblastic leukemia (ALL)-6h GC treated; time course acute lymphoblastic leukemia (ALL)-0h +p_2842_2 acute lymphoblastic leukemia (ALL)-24h GC treated; time course acute lymphoblastic leukemia (ALL)-0h +p_2842_3 S-Line-6h GC treated; time course S-Line-6h EtOH +p_2842_4 S-Line-24h GC treated; time course S-Line-6h EtOH +p_2842_5 C-Line-6h GC treated; time course C-Line-6h EtOH +p_2842_6 C-Line-24h GC treated; time course C-Line-24h EtOH +p_2842_7 R-Line-6h GC treated; time course R-Line-6h EtOH +p_2842_8 R-Line-24h GC treated; time course R-Line-6h EtOH +p_28442_1 "lymphnode, metastatic" "lymphnode, negative" +p_28448_1 "HMEC-TR cell, scrambbled siRNA, TGF B+" "HMEC-TR cell, scrambbled siRNA, TGF B-" +p_28448_2 "HMEC-TR cell, Smad4 silenced with siRNA, TGF B+" "HMEC-TR cell, Smad4 silenced with siRNA, TGF B-" +p_28448_3 "HMEC-TR cell, T1F1y silenced with siRNA, TGF B+" "HMEC-TR cell, T1F1y silenced with siRNA, TGF B-" +p_28460_1 "acute lymphoblastic leukemia (ALL), late relapse" "acute lymphoblastic leukemia (ALL), early relapse" +p_28460_2 "Bone marrow cell, diagnosis, late" "Bone marrow cell, relapse, late" +p_28476_1 "Adrenocortical adenoma, CTNNB1 mutation" "Adrenocortical adenoma, wt" +p_28502_1 "HUVSMC cell line, Triptolide treated, 24h" "HUVSMC cell line, control" +p_28503_1 "MCF7 cells, POLRMT knockdown" "MCF7 cells, non-targeting siRNA, control" +p_28503_2 "MCF7 cells, PolII knockdown" "MCF7 cells, non-targeting siRNA, control" +p_28548_1 "HEK293 cell, stimulated with TNF alpha" "HEK293 cell, control" +p_28548_2 "HEK293 cell, sirtuin 6 transfected" "HEK293 cell, control" +p_28548_3 "HEK293 cell, stimulated with TNF alpha + sirtuin 6 transfected" "HEK293 cell, control" +p_28548_4 "HEK293 cell, mutant sirtuin 6 transfected" "HEK293 cell, control" +p_28548_5 "HEK293 cell, stimulated with TNF alpha + mutant sirtuin 6 transfected" "HEK293 cell, control" +p_28548_6 "HEK293 cell, pCDNA3 transfected" "HEK293 cell, control" +p_28548_7 "HEK293 cell, stimulated with TNF alpha + pCDNA3 transfected" "HEK293 cell, control" +p_28583_1 "breast tumor biopsy, Postchemotherapy" "breast tumor biopsy, Prechemotherapy" +p_28590_1 "HepG2 cell, siHNF4a, 0h" "HepG2 cell, siControl, 0h" +p_28590_2 "HepG2 cell, siHNF4a, TGF-beta treated, 1.5h" "HepG2 cell, siControl, TGF-beta treated, 1.5h" +p_28590_3 "HepG2 cell, siHNF4a, TGF-beta treated, 24h" "HepG2 cell, siControl, TGF-beta treated, 24h" +p_28603_1 "SGBS cell, hypoxia, 3h" "SGBS cell, control" +p_28603_2 "SGBS cell, hypoxia, 6h" "SGBS cell, control" +p_28603_3 "SGBS cell, hypoxia, 9h" "SGBS cell, control" +p_28618_1 "U87 cells, HOXD9 siRNA" "U87 cells, control siRNA" +p_28619_1 "Liver, Alcoholic hepatitis" "Liver, control" +p_2864_1 "SH-SY5Y/TrkA cells, dnEgr (dominant negative Egr)/EGFP infected" "SH-SY5Y/TrkA cells, EGFP infected" +p_28645_1 "LYC2 cell, SRC1 siRNA, control" "LYC2 cell, control siRNA, control" +p_28645_2 "LYC2 cell, SRC1 siRNA, tamoxifen treated" "LYC2 cell, control siRNA, tamoxifen treated" +p_28646_1 CP70 cells A2780 cells +p_28646_2 "CP70 cells, Decitabine treated" CP70 cells +p_28646_3 "CP70 cells, Decitabine+PXD101 treated" CP70 cells +p_28646_4 "CP70 cells, PXD101 treated" CP70 cells +p_28681_1 "HMLE cells, mesenchymal subpopulation" "HMLE cells, epithelial subpopulation" +p_28694_1 "breast tumor biopsy, Postchemotherapy" "breast tumor biopsy, Prechemotherapy" +p_28698_1 "CD34+ HSC, TEL-PDGFRb oncogene expression, Glivec treatead, 4h" "CD34+ HSC, TEL-PDGFRb oncogene expression" +p_28715_1 "HEK293T cell, siRNA Med26" "HEK293T cell, wt" +p_28726_1 "CD4 cell, stimulated, after 18d" "CD4 cell, stimulated, after 3d" +p_28726_2 "NKT cell, stimulated, after 18d" "NKT cell, stimulated, after 3d" +p_28726_3 "Va24 cell, stimulated, after 18d" "Va24 cell, stimulated, after 3d" +p_28750_1 "whole blood cell, Sepsis patient" "whole blood cell, healthy" +p_28750_2 "whole blood cell, post surgical , sepsis patient" "whole blood cell, healthy" +p_28789_1 "MDA-MB-453 cells, 5a-dihydrotestosterone (DHT) treated, 10nM, 4h" "MDA-MB-453 cells, vehicle treated" +p_28789_2 "MDA-MB-453 cells, 5a-dihydrotestosterone (DHT) treated, 10nM, 16h" "MDA-MB-453 cells, vehicle treated" +p_28789_3 "MDA-MB-453 cells, 5a-dihydrotestosterone (DHT) treated, 10nM, 48h" "MDA-MB-453 cells, vehicle treated" +p_28792_1 "Caco-2 cell, 100mM Nacl" "Caco-2 cell, control" +p_28792_2 "Caco-2 cell, 5mM butyrate" "Caco-2 cell, control" +p_28792_3 "Caco-2 cell, 0% polydextrose" "Caco-2 cell, control" +p_28792_4 "Caco-2 cell, 1% polydextrose" "Caco-2 cell, control" +p_28792_5 "Caco-2 cell, 2% polydextrose" "Caco-2 cell, control" +p_28799_1 OVCAR-3 derived stem cell-like cells parental OVCAR-3 cells +p_28807_1 "primary Wilms tumor cells (ws568li), ATRA treated" "primary Wilms tumor cells (ws568li), untreated" +p_28810_1 "U251, miR-31 over-expression" "U251, control" +p_28815_1 "hiPSC conventional, from IMR-90 cell" IMR-90 cell +p_28815_2 "hiPSC SMC4, from IMR-90 cell" IMR-90 cell +p_28815_3 "hiPSC conventional, from FTC1 Foreskin Fibroblast cell" FTC1 Foreskin Fibroblast cell +p_28815_4 "hiPSC SMC4, from FTC1 Foreskin Fibroblast cell" FTC1 Foreskin Fibroblast cell +p_28842_1 "PBMC, non inmunotolerant patients" "PBMC, inmunetolerant patients" +p_28842_2 "PBMC, non inmunotolerant patients, a year after weaning" "PBMC, inmunetolerant patients, a year after weaning" +p_28846_1 "231MFP cells, aggressive breast cancer cell type" "MCF7 cells, non-agressive breast cancer cell type" +p_28846_2 "SKOV3 cells, agressive ovarian cancer cell type" "OVCAR3 cells, non-agressive ovarian cancer cell type" +p_28846_3 "C8161 cells, agressive melanoma cancer cell type" "MUM2C cells, non-agressive melanoma cancer cell type" +p_28846_4 "DU145 cells, agressive prostate cancer cell type" "LNCaP, non-agressive prostate cancer cell type" +p_28846_5 PC3 cellsm agressive prostate cancer cell type "LNCaP, non-agressive prostate cancer cell type" +p_28847_1 "PASMC, BMP4 treated, 2h" "PASMC, control" +p_28847_2 "PASMC, BMP4 treated, 24h" "PASMC, control" +p_28882_1 "HeLa, ip antibody: rabbit anti-DZIP1 polyclonal" "HeLa, ip antibody: rabbit IgG, control" +p_28914_1 "Skin cell, acute wound" "Skin cell, intact" +p_28914_2 "Skin cell, 3rd post-operative day" "Skin cell, intact" +p_28914_3 "Skin cell, 7th post-operative day" "Skin cell, intact" +p_28995_1 "Myeloid cell, RA treated" "Myeloid cell, control" +p_28995_2 "Myeloid cell, TNF alpha treated" "Myeloid cell, control" +p_28995_3 "Myeloid cell, RA, TNF alpha treated" "Myeloid cell, control" +p_28995_4 "Myeloid cell, RA treated 2h" "Myeloid cell, control" +p_28995_5 "Myeloid cell, RA treated 6h" "Myeloid cell, control" +p_28995_6 "Myeloid cell, RA treated 16h" "Myeloid cell, control" +p_28995_7 "Myeloid cell, RA treated 40h" "Myeloid cell, control" +p_28998_1 "Biceps, trained" "Biceps, untrained" +p_29008_1 "Hct8 cell, TcdA treated, 2h" "Hct8 cell, control , 2h" +p_29008_2 "Hct8 cell, TcdB treated, 2h" "Hct8 cell, control , 2h" +p_29008_3 "Hct8 cell, TcdA treated, 6h" "Hct8 cell, control , 6h" +p_29008_4 "Hct8 cell, TcdB treated, 6h" "Hct8 cell, control , 6h" +p_29008_5 "Hct8 cell, TcdA treated, 24h" "Hct8 cell, control , 24h" +p_29008_6 "Hct8 cell, TcdB treated, 24h" "Hct8 cell, control , 24h" +p_29060_1 "HT-29 cell, Aza treated" "HT-29 cell, control" +p_29061_1 Huh7 cells transduced with Ad-HEV ORF2 "Huh7 cells, transduced with Ad-GFP" +p_29084_1 "HepG2 cells, HNF4a RNAi treated" "HepG2 cells, control" +p_29115_1 "H9 cell, diff, KDR, CD31, sorted, 4d" "H9 cell, undiff, unsorted, 0d" +p_29115_2 "H9 cell, diff, KDR, CD31, sorted, 6d" "H9 cell, undiff, unsorted, 0d" +p_29115_3 "H9 cell, diff, KDR, CD31, sorted, 8d" "H9 cell, undiff, unsorted, 0d" +p_29133_1 "human distal lung, Alveolar epithelial type II, COPD" "human distal lung, Alveolar epithelial type II, non COPD" +p_29137_1 "MCF7 cells, GFP-Numb4 transfected" "MCF7 cells, GFP vector control" +p_29137_2 "MCF7 cells, GFP-Numb5 transfected" "MCF7 cells, GFP vector control" +p_29137_3 "MCF7 cells, GFP-Numb6 transfected" "MCF7 cells, GFP vector control" +p_29137_4 "MDA-MB-231 cells, GFP-Numb4 transfected" "MDA-MB-231 cells, GFP vector control" +p_29137_5 "MDA-MB-231 cells, GFP-Numb5 transfected" "MDA-MB-231 cells, GFP vector control" +p_29137_6 "MDA-MB-231 cells, GFP-Numb6 transfected" "MDA-MB-231 cells, GFP vector control" +p_29220_1 "Ovarian cancer, 3C stage" "Healthy, control" +p_29220_2 "Ovarian cancer, 3B stage" "Healthy, control" +p_29232_1 "RWPE-1 AR cell, R1881 treated, 3h" "RWPE-1 AR cell, control, 3h" +p_29232_2 "RWPE-1 AR cell, R1881 treated, 24h" "RWPE-1 AR cell, control, 24h" +p_29237_1 "retinal progenitor cells, derived from human embryonic stem cells" "forebrain progenitor cells, derived from human embryonic stem cells" +p_29246_1 "macrophages, infected with Leishmania donovani, monastrol treated" "macrophages, infected with Leishmania donovani" +p_29297_1 "HEK-293 cells with inducible LMP1 TES2+IkBa super-repressor, 0hours doxycycline/4HT" "HEK-293 cells, inducible LMP1 TES2, 0hours doxycyline/4HT" +p_29297_2 "HEK-293 cells with inducible LMP1 TES2+IkBa super-repressor, 6hours doxycycline/4HT" "HEK-293 cells, inducible LMP1 TES2, 6hours doxycyline/4HT" +p_29297_3 "HEK-293 cells with inducible LMP1 TES2+IkBa super-repressor, 9hours doxycycline/4HT" "HEK-293 cells, inducible LMP1 TES2, 9hours doxycyline/4HT" +p_29297_4 "HEK-293 cells with inducible LMP1 TES2+IkBa super-repressor, 12hours doxycycline/4HT" "HEK-293 cells, inducible LMP1 TES2, 12hours doxycyline/4HT" +p_29297_5 "HEK-293 cells with inducible LMP1 TES2+IkBa super-repressor, 24hours doxycycline/4HT" "HEK-293 cells, inducible LMP1 TES2, 24hours doxycyline/4HT" +p_29301_1 "Lymphoblastoid Cell Line, EBV-infected, monoclonal" "Purified B Cells, from negative selection of PBMCs" +p_29313_1 "HeLa cell, EWS inhibited" "HeLa cell, control" +p_29313_2 "Whole cell, EWS inhibited" "Whole cell, control" +p_29316_1 "CCD-18Co, SHH treated" "CCD-18Co, untreated" +p_29327_1 "MCF10A cells, miR-221/222" "MCF10A cells, miR-control" +p_29367_1 "HARA cell, highly bone metastatic subline" "HARA cell, control" +p_29368_1 "GPC, CD140a positive" "GPC, CD140a negative" +p_29375_1 "HepG2 cell, APRIL treated, 2h" "HepG2 cell, APRIL treated, 0h" +p_29375_2 "HepG2 cell, APRIL treated, 6h" "HepG2 cell, APRIL treated, 0h" +p_29375_3 "HepG2 cell, APRIL treated, 12h" "HepG2 cell, APRIL treated, 0h" +p_29384_1 "LN229 cells, Cyr61 expression" "LN229 cells, control" +p_29402_1 Cornea Conjunctiva +p_29410_1 omental adipose tissue subcutaneous adipose tissue +p_29431_1 "Breast tumor tissue, with HER2 IHC3+ score" "Normal breast tissue, from breast cancer patients" +p_29431_2 "Breast tumor tissue, with HER2 IHC3+ score and proved amplification" "Normal breast tissue, from breast cancer patients" +p_29431_3 "Breast tumor tissue, with HER2 IHC2+ score and proved amplification" "Normal breast tissue, from breast cancer patients" +p_29431_4 "Breast tumor tissue, with HER2 IHC2+ score and proved no-amplification" "Normal breast tissue, from breast cancer patients" +p_29431_5 "Breast tumor tissue, with HER2 IHC0/1 score and proved no-amplification" "Normal breast tissue, from breast cancer patients" +p_29431_6 "Breast tumor tissue, with HER2 IHC0/1 score" "Normal breast tissue, from breast cancer patients" +p_29431_7 "Breast tumor tissue, with HER2 IHC3+ score and proved amplification" "Normal breast tissue, from breast cancer patients" +p_29435_1 "IKPRAB36 cell line, cultured in 1nm MPA, 48h" "IKPRAB36 cell line, cultured in absence of 1nm MPA, 48h" +p_29436_1 "Endometrial Cancer Specimen, Progressive" "Endometrial Cancer Specimen, Non-progressive" +p_29450_1 Primary tumors from clear cell ovarian cancer Normal ovarian surface epithelium +p_29459_1 "CD34+ cells, GAR-treated, 7 days" "CD34+ cells, DMSO-treated, 7 days" +p_29523_1 "CD34+CD45RA+Lin- HPCs, transduced with A2M" "CD34+CD45RA+Lin- HPCs, empty vector" +p_29524_1 "CD34+CD45RA+Lin- HPCs, empty vector, Delta1ext-IgG cultured , 2g" "CD34+CD45RA+Lin- HPCs, empty vector, BSA cultured" +p_29524_2 "CD34+CD45RA+Lin- HPCs, A2M transduced, Delta1ext-IgG cultured, 2g" "CD34+CD45RA+Lin- HPCs, A2M transduced, BSA cultured" +p_29524_3 "CD34+CD45RA+Lin- HPCs, empty vector, Delta1ext-IgG cultured , 5g" "CD34+CD45RA+Lin- HPCs, empty vector, Delta1ext-IgG cultured , 2g" +p_29524_4 "CD34+CD45RA+Lin- HPCs, A2M transduced, Delta1ext-IgG cultured, 5g" "CD34+CD45RA+Lin- HPCs, A2M transduced, BSA cultured" +p_29539_1 "OECM1, transfected with pmCherry-let7i" "OECM1, pmR-mCherry empty vector" +p_29544_1 "CUTLL1 cell, GSI treated" "CUTLL1 cell, DMSO treated" +p_29544_2 "CUTLL1 cell, GSI treated, 3day" "CUTLL1 cell, DMSO treated" +p_29544_3 "CUTLL1 cell, wash 2h, +CHX treated" "CUTLL1 cell, wash 2h, -CHX treated" +p_29544_4 "CUTLL1 cell, wash 4h, +CHX treated" "CUTLL1 cell, wash 4h, -CHX treated" +p_29544_5 "CUTLL1 cell, GSI-mockwah-CHX2h treated" "CUTLL1 cell, DMSO treated" +p_29544_6 "CUTLL1 cell, GSI-mockwah-CHX4h treated" "CUTLL1 cell, DMSO treated" +p_29544_7 "CUTLL1 cell, MigR1 GSI" "CUTLL1 cell, DNMAML1, GSI" +p_29544_8 "CUTLL1 cell, MigR1 GSI , wash 2h" "CUTLL1 cell, DNMAML1, GSI, wash 2h" +p_29544_9 "CUTLL1 cell, MigR1 GSI , wash 4h" "CUTLL1 cell, DNMAML1, GSI, wash 4h" +p_29605_1 "CLL B cell, low miR-155, unmutated IgVH" "CLL B cell, high miR-155, unmutated IgVH" +p_29605_2 "CLL B cell, low miR-155, mutated IgVH" "CLL B cell, high miR-155, mutated IgVH" +p_29619_1 "Peripheral blood mononuclear cells, vaccinated with Influenza vaccine , day 3" "Peripheral blood mononuclear cells, vaccinated with Influenza vaccine , day 0" +p_29619_2 "Peripheral blood mononuclear cells, vaccinated with Influenza vaccine , day 7" "Peripheral blood mononuclear cells, vaccinated with Influenza vaccine , day 0" +p_29630_1 "gastric cancer cell line (AGS), galectin-3 silenced" "gastric cancer cell line (AGS), control" +p_29639_1 "AT2 cell, shG1 treated" "AT2 cell, control" +p_29639_2 "REH cell, shG1 treated" "REH cell, control" +p_29652_1 "Astrocyte, Braak 1-2 stage, APOE e4-" "Astrocyte, Braak 1-2 stage, APOE e4+" +p_29652_2 "Astrocyte, Braak 3-4 stage, APOE e4-" "Astrocyte, Braak 3-4 stage, APOE e4+" +p_29652_3 "Astrocyte, Braak 5-6 stage, APOE e4-" "Astrocyte, Braak 5-6 stage, APOE e4+" +p_29700_1 "BL-2 cell line, LPS treated, 6h" "BL-2 cell line, control" +p_29721_1 Hepatocellular carcinoma (HCC) normal liver +p_29807_1 "Umblical Cord Blood cell, LBW newborn" "Umblical Cord Blood cell, NBW newborn" +p_29850_1 "HUVEC, transduced with N1IC" "HUVEC, control vector" +p_29868_1 "Primary human hepatocytes, atorvastatin treated, 6h" "Primary human hepatocytes, DMSO, 6h" +p_29868_2 "Primary human hepatocytes, atorvastatin treated, 12h" "Primary human hepatocytes, DMSO, 12h" +p_29868_3 "Primary human hepatocytes, atorvastatin treated, 24h" "Primary human hepatocytes, DMSO, 24h" +p_29868_4 "Primary human hepatocytes, atorvastatin treated, 48h" "Primary human hepatocytes, DMSO, 48h" +p_29868_5 "Primary human hepatocytes, atorvastatin treated, 72h" "Primary human hepatocytes, DMSO, 72h" +p_29881_1 "HUAEC cell, Estradiol treated" "HUAEC cell, control" +p_29881_2 "HUAEC cell, oxLDL treated" "HUAEC cell, control" +p_29881_3 "HUAEC cell, Estradiol + oxLDL treated" "HUAEC cell, control" +p_29883_1 "mononuclear cells from bone marrow, inv(16)/t(16;16)" "mononuclear cells from bone marrow, t(8;21)" +p_29908_1 "peripheral blood mononuclear cell, after AHST treatment, 6 month" "peripheral blood mononuclear cell, before AHST treatment" +p_29981_1 "Human endometrium, days from lh peak: -14" "Human endometrium, days from lh peak: -1" +p_29986_1 "Bone marrow cell, ALL patient" "Bone marrow cell, common" +p_29986_2 "Biopsy, lymphoblastic tumor" "Bone marrow cell, common" +p_30010_1 "human breast biopsy, parous" "human breast biopsy, nulliparous" +p_30063_1 "small airway epithelium, smokers with Chronic Obstructive Lung Disease" "small airway epithelium, healthy non-smokers" +p_30063_2 "small airway epithelium, healthy smokers" "small airway epithelium, healthy non-smokers" +p_30161_1 "ovarian cancer cells, formalin-fixed paraffin embedded (FFPE) tissue, complete response to Carboplatin/Taxol" "ovarian cancer cells, formalin-fixed paraffin embedded (FFPE) tissue, partial response to Carboplatin/Taxol" +p_30174_1 "white blood cells, non-metastatic prostate cancer, baseline" "white blood cells, healthy matched control" +p_30174_2 "white blood cells, non-metastatic prostate cancer, external beam radiation therapy (EBRT) treated, time of wbc and fatigue score collection: D1" "white blood cells, healthy matched control" +p_30174_3 "white blood cells, non-metastatic prostate cancer, external beam radiation therapy (EBRT) treated, time of wbc and fatigue score collection: D7" "white blood cells, healthy matched control" +p_30174_4 "white blood cells, non-metastatic prostate cancer, external beam radiation therapy (EBRT) treated, time of wbc and fatigue score collection: D14" "white blood cells, healthy matched control" +p_30174_5 "white blood cells, non-metastatic prostate cancer,external beam radiation therapy (EBRT) treated, time of wbc and fatigue score collection: D21" "white blood cells, healthy matched control" +p_30174_6 "white blood cells, non-metastatic prostate cancer, external beam radiation therapy (EBRT) treated, time of wbc and fatigue score collection: D42" "white blood cells, healthy matched control" +p_30174_7 "white blood cells, non-metastatic prostate cancer, external beam radiation therapy (EBRT) treated, time of wbc and fatigue score collection: D72 (30days post-EBRT)" "white blood cells, healthy matched control" +p_30201_1 "Hematopoietic stem cells, low risk myelodysplastic syndrome" "Hematopoietic stem cells, healthy control" +p_30296_1 "SKOV3 cell , BRCA1 stable expression" "SKOV3 cell, neo clone" +p_30304_1 "RWPE-1 cell, 3D cultured" "RWPE-1 cell, 2D cultured" +p_30304_2 "LNCaP cell, 3D cultured" "LNCaP cell, 2D cultured" +p_30355_1 Normal keratinocyte Normal skin epidermal cell +p_30355_2 Sorted keratinocyte Normal skin epidermal cell +p_30391_1 "Umbilical cord Wharton's jelly stem cells , passage 2" "Umbilical cord Wharton's jelly stem cells , passage 1" +p_30391_9 "Umbilical cord Wharton's jelly stem cells , passage 10" "Umbilical cord Wharton's jelly stem cells , passage 1" +p_30423_1 "hypopharyngeal cancer cell line (FADU), rCTFG treated" "hypopharyngeal cancer cell line (FADU), citric buffer treated" +p_30439_1 CFBE41o- F508-CFTR CFBE41o- wt-CFTR +p_30439_2 "CFBE41o- F508-CFTR, exposed to PA01" "CFBE41o- wt-CFTR, exposed to PA01" +p_30442_1 "mononuclear cells, AML, BCOR mutation" "mononuclear cells, AML, BCOR wild type" +p_30478_1 "HCT116 cell, UHRF-1 shRNA treated" "HCT116 cell, control" +p_30494_1 "A549 cell, siFFluc" "A549 cell, siEGFP" +p_30494_2 "A549 cell, siKDM3A" "A549 cell, siEGFP" +p_30494_3 "SW780 cell, siFFluc" "SW780 cell, siEGFP" +p_30494_4 "SW780 cell, siKDM3A" "SW780 cell, siEGFP" +p_30499_13 "U2OScells, hypoxia, 4.5 h" "U2OS cells, control, 4.5 h" +p_30499_14 "U2OScells, tunicamycin treated, 4.5 h" "U2OS cells, control, 4.5 h" +p_30499_15 "U2OScells, emetine treated, 4.5 h" "U2OS cells, control, 4.5 h" +p_30499_16 "U2OScells, shRent1 treated, 4.5 h" "U2OS cells, control, 4.5 h" +p_30501_1 "TOV21G cell, PLKO-1 shRNA treated" "TOV21G cell, non-target shRNA treated" +p_30501_2 "TOV21G cell, PAX shRNA treated" "TOV21G cell, non-target shRNA treated" +p_30516_1 "BT20 cells, erlotinib treated, 10uM, 0.5h" "BT20 cells, erlotinib treated, 10uM, 0h" +p_30516_2 "BT20 cells, erlotinib treated, 10uM, 6h" "BT20 cells, erlotinib treated, 10uM, 0h" +p_30516_3 "BT20 cells, erlotinib treated, 10uM, 24h" "BT20 cells, erlotinib treated, 10uM, 0h" +p_30516_4 "MDA-MB-453 cells, erlotinib treated, 10uM, 24h" "MDA-MB-453 cells, erlotinib treated, 10uM, 0h" +p_30516_5 "MCF cells, erlotinib treated, 10uM, 24h" "MCF cells, erlotinib treated, 10uM, 0h" +p_30522_1 "Prostate tissue, cancer" "Prostate tissue, normal" +p_30522_2 Bladder cancer-associated stromal cells Normal bladder stromal cells +p_30522_3 Embryonal carcinoma cell line NCCIT Normal bladder basal cells +p_30524_1 "RPMI 8266 cell, PPP 6h treated" "RPMI 8266 cell, untreated" +p_30524_2 "RPMI 8266 cell, PPP 24h treated" "RPMI 8266 cell, untreated" +p_30524_3 "RPMI 8266 cell, LBH 6h treated" "RPMI 8266 cell, untreated" +p_30524_4 "RPMI 8266 cell, LBH 24h treated" "RPMI 8266 cell, untreated" +p_30524_5 "RPMI 8266 cell, PPP+LBH 6h treated" "RPMI 8266 cell, untreated" +p_30524_6 "RPMI 8266 cell, PPP+LBH 24h treated" "RPMI 8266 cell, untreated" +p_30531_1 "A375 cells, MLN4924 treated, 650nM, 1h" "A375 cells, DMSO treated,1h" +p_30531_2 "A375 cells, MLN4924 treated, 650nM, 2h" "A375 cells, DMSO treated,2h" +p_30531_3 "A375 cells, MLN4924 treated, 650nM, 4h" "A375 cells, DMSO treated,4h" +p_30531_4 "A375 cells, MLN4924 treated, 650nM, 8h" "A375 cells, DMSO treated,8h" +p_30531_5 "A375 cells, MLN4924 treated, 650nM, 24h" "A375 cells, DMSO treated,24h" +p_30563_1 "Human brain tumor, glioblastoma" Human normal brain +p_30563_2 "Human brain tumor, ganglioglioma" Human normal brain +p_30563_3 "Human brain tumor, schwannoma" Human normal brain +p_30585_1 "CD34+ cord blood cell, CID -" "CD34+ cord blood cell, CID +" +p_30585_2 "CD34+ cord blood cell, Tpo +" "CD34+ cord blood cell, CID +" +p_30585_3 "CD34+ cord blood cell, Epo +" "CD34+ cord blood cell, CID +" +p_30589_1 "Vero E6 cells, infected with SARS-CoV (WT), 7hpi" "Vero E6 cells, mock-infected, 7hpi" +p_30589_2 "Vero E6 cells, infected with SARS-CoV-DeltaE, 7hpi" "Vero E6 cells, mock-infected, 7hpi" +p_30589_7 "MA-104 cells, infected with SARS-CoV (WT), 65hpi" "MA-104 cells, mock-infected, 0hpi" +p_30589_8 "MA-104 cells, infected with SARS-CoV-DeltaE, 65hpi" "MA-104 cells, mock-infected, 0hpi" +p_30599_1 "mononuclear cells, T-cell ALL, PICALM-MLLT10 fusion" "mononuclear cells, T-cell ALL, No PICALM-MLLT10 fusion" +p_30644_1 "MM1S cell, Salmeterol treated" "MM1S cell, untreated" +p_30644_2 "MM1S cell, Low dose Dexomethasone treated" "MM1S cell, untreated" +p_30644_3 "MM1S cell, High dose Dexomethasone treated" "MM1S cell, untreated" +p_30644_4 "MM1S cell, Low dose Dexomethasone + Salmeterol treated" "MM1S cell, untreated" +p_30644_5 "MM1S cell, CGS-21680 treated" "MM1S cell, untreated" +p_30644_6 "MM1S cell, Low dose Dexomethasone + CGS-21680 treated" "MM1S cell, untreated" +p_30660_1 "LEC, smoker" "LEC, control" +p_30775_1 "MDA-MB-231 cells, siRNA targeting LSD1" "MDA-MB-231 cells, control siRNA" +p_30781_1 "HCEC, Cyclin treated" "HCEC, control" +p_30781_2 "HCEC, Cyclin E6/E7 treated" "HCEC, control" +p_30784_1 oral squamous cell carcinoma normal oral tissue +p_30784_2 dysplasia normal oral tissue +p_30792_1 Wild-type iPSCs SNCA triplication iPSCs +p_30806_1 "muscle Vastus lateralis, IBMPFD affected" "muscle Vastus lateralis, normal" +p_30807_1 osteosarcoma U2OS derived cell line UT2 bone marrow mesenchymal stem cells +p_30807_2 osteosarcoma U2OS cells bone marrow mesenchymal stem cells +p_30903_1 "AML blast cell, ATP treated" "AML blast cell, untreated" +p_30950_1 "Natural killer cell, IL-2 + BCG treated" "Natural killer cell, IL-2 treated" +p_30950_2 "Natural killer cell, IL-2 + H37Rv treated" "Natural killer cell, IL-2 treated" +p_30950_3 "Natural killer cell, IL-12 + BCG treated" "Natural killer cell, IL-12 treated" +p_30950_4 "Natural killer cell, IL-12 + H37Rv treated" "Natural killer cell, IL-12 treated" +p_30985_1 "HCT116 cell, DAC 5um treated" "HCT116 cell, DMSO treated" +p_30985_10 "HCT116 cell, Aza_G669043 1500nm treated" "HCT116 cell, DMSO treated" +p_30985_2 "HCT116 cell, DAC 120nm treated" "HCT116 cell, DMSO treated" +p_30985_3 "HCT116 cell, Aza 1500nm treated" "HCT116 cell, DMSO treated" +p_30985_4 "HCT116 cell, Aza 150nm treated" "HCT116 cell, DMSO treated" +p_30985_5 "HCT116 cell, Ester_G668684 7um treated" "HCT116 cell, DMSO treated" +p_30985_6 "HCT116 cell, Ester_G668684 150nm treated" "HCT116 cell, DMSO treated" +p_30985_7 "HCT116 cell, phos_G669071 6um treated" "HCT116 cell, DMSO treated" +p_30985_8 "HCT116 cell, phos_G669071 63um treated" "HCT116 cell, DMSO treated" +p_30985_9 "HCT116 cell, Aza_G669043 150nm treated" "HCT116 cell, DMSO treated" +p_30988_1 "Hela cell, Doxorubicin treated, 24h" "Hela cell, control, 24h" +p_30988_2 "Hela cell, Doxorubicin treated, 48h" "Hela cell, control, 48h" +p_30999_1 "Skin biopsy, moderate-to-severe psoriasis, psoriasis lesion" "Skin biopsy, moderate-to-severe psoriasis, non-lesion" +p_31040_1 "cultured lymphoblastoid cells, young, starvation" "cultured lymphoblastoid cells, young, basal" +p_31040_2 "cultured lymphoblastoid cells, centenarian, starvation" "cultured lymphoblastoid cells, centenarian, basal" +p_31084_1 "HCT116 cell, wt, high glucose" "HCT116 cell, wt, low glucose" +p_31084_2 "HCT116 G13D cell, wt, high glucose" "HCT116 G13D cell, wt, low glucose" +p_31122_1 "BT12 cells, treated with IC25 of SNDX275" "BT12 cells, not treated" +p_31122_2 "BT16 cells, treated with IC25 of SNDX275" "BT16 cells, not treated" +p_31138_1 "blood vessels, invasiave ductal carcinoma breast tissue" "blood vessels, Normal breast tissue" +p_31172_1 "HeLa cell, S34F mutant" "HeLa cell, mock" +p_31172_2 "TF1 cell, S34F mutant" "TF1 cell, mock" +p_31180_1 "MCF7 cell line, transfected with SNCA" "MCF-7 cells,transfected with GFP" +p_31189_1 cancer urothelia non-cancer urothelia +p_31193_1 "liver, IFN, 6hr" "liver, control" +p_31193_2 "liver, IFN, 24hr" "liver, control" +p_31193_3 "liver, IL28B, 6hr" "liver, control" +p_31193_4 "liver, IL28B, 24hr" "liver, control" +p_31210_1 "primary lung tumor, gene alteration status: EGFR/KRAS/ALK -" "normal lung tissue, control" +p_31210_2 "primary lung tumor, gene alteration status: EGFR mutation" "normal lung tissue, control" +p_31210_3 "primary lung tumor, gene alteration status KRAS mutation" "normal lung tissue, control" +p_31210_4 "primary lung tumor, gene alteration status: EML4-ALK fusion" "normal lung tissue, control" +p_31215_1 "hpMSCs, EWS-FLI-1 overexpression" "hpMSCs, empty vector" +p_31229_1 "CLB-GA cell, DAC treated" "CLB-GA cell, untreated" +p_31229_2 "IMR-32 cell, DAC treated" "IMR-32 cell, untreated" +p_31229_3 "SH-SY5Y cell, DAC treated" "SH-SY5Y cell, untreated" +p_31229_4 "N206 cell, DAC treated" "N206 cell, untreated" +p_31229_5 "CHP-902R cell, DAC treated" "CHP-902R cell, untreated" +p_31229_6 "LAN-2 cell, DAC treated" "LAN-2 cell, untreated" +p_31229_7 "SK-N-AS cell, DAC treated" "SK-N-AS cell, untreated" +p_31229_8 "SJNB-1 cell, DAC treated" "SJNB-1 cell, untreated" +p_31255_1 "Normal human mucosa, EPHB2-low" "Normal human mucosa, EPHB2 neg" +p_31255_2 "Normal human mucosa, EPHB2-medium" "Normal human mucosa, EPHB2 neg" +p_31255_3 "Normal human mucosa, EPHB2-high" "Normal human mucosa, EPHB2 neg" +p_31264_1 "Primary hepatocyte, IFNalpha treated, 6h" "Primary hepatocyte, control" +p_31264_2 "Primary hepatocyte, IFNalpha treated, 24h" "Primary hepatocyte, control" +p_31264_3 "Primary hepatocyte, IL28B treated, 6h" "Primary hepatocyte, control" +p_31264_4 "Primary hepatocyte, IL28B treated, 24h" "Primary hepatocyte, control" +p_31264_5 "Primary hepatocyte, T Poly IC treated, 24h" "Primary hepatocyte, control" +p_31264_6 "primary hepatocyte, JFH1 recombinant, MOI of 5 treated, 36h" "Primary hepatocyte, control" +p_31264_7 "primary hepatocyte, IL28B recombinant, 24h" "primary hepatocyte, untreated" +p_31287_1 "SCCHN cell, after figitumumab" "SCCHN cell, before figitumumab" +p_31315_1 "A549 cells, non-side population, anti-EpCAM treated" "A549 cells, non-side population, control" +p_31315_2 "A549 cells, side population, anti-EpCAM treated" "A549 cells, side population, control" +p_31323_1 "Epithelium cell , Benign Prostatic Hyperplasia" "Stromal cell , Benign Prostatic Hyperplasia" +p_31348_1 "Blood, Tuberculosis, conventional combination therapy (2HRZE/4HR), week 1" "Blood, Tuberculosis, at the day of diagnosis (week 0)" +p_31348_2 "Blood, Tuberculosis, conventional combination therapy (2HRZE/4HR), week 2" "Blood, Tuberculosis, at the day of diagnosis (week 0)" +p_31348_3 "Blood, Tuberculosis, conventional combination therapy (2HRZE/4HR), week 4" "Blood, Tuberculosis, at the day of diagnosis (week 0)" +p_31348_4 "Blood, Tuberculosis, conventional combination therapy (2HRZE/4HR), week 26" "Blood, Tuberculosis, at the day of diagnosis (week 0)" +p_31355_1 "CLB-GA neuroblastoma cell line, DAC (2'-deoxy-5'-cytydine) treated" "CLB-GA neuroblastoma cell line, control" +p_31355_2 "IMR-32 neuroblastoma cell line, DAC (2'-deoxy-5'-cytydine) treated" "IMR-32 neuroblastoma cell line, control" +p_31355_3 "SH-SY5Y neuroblastoma cell line, DAC (2'-deoxy-5'-cytydine) treated" "SH-SY5Y neuroblastoma cell line, control" +p_31355_4 "N206 neuroblastoma cell line, DAC (2'-deoxy-5'-cytydine) treated" "N206 neuroblastoma cell line, control" +p_31355_5 "CHP-902R neuroblastoma cell line, DAC (2'-deoxy-5'-cytydine) treated" "CHP-902R neuroblastoma cell line, control" +p_31355_6 "LAN-2 neuroblastoma cell line, DAC (2'-deoxy-5'-cytydine) treated" "LAN-2 neuroblastoma cell line, control" +p_31355_7 "SK-N-AS neuroblastoma cell line, DAC (2'-deoxy-5'-cytydine) treated" "SK-N-AS neuroblastoma cell line, control" +p_31355_8 "SJNB-1 neuroblastoma cell line, DAC (2'-deoxy-5'-cytydine) treated" "SJNB-1 neuroblastoma cell line, control" +p_31397_1 "MCF-7 cell, miR-101 transfected" "MCF-7 cell, scramble control" +p_31412_1 "HeLa cells, siRNA against HCFC1, control" "HeLa cells, siRNA against Luciferase, control" +p_31434_1 "Hela cell, SLC44A5 transfected" "Hela cell, Negative control" +p_31434_2 "Hela cell, siSLC44A5 transfected" "Hela cell, Negative control" +p_31440_1 "Colon cancer cell, SPARCL1 transfected , on Plastic" "Colon cancer cell, control on Plastic" +p_31440_2 "Colon cancer cell, SPARCL1 transfected , on Matrigel" "Colon cancer cell, control on Matrigel" +p_31447_1 "LCL cells, Thapsigargin treated, 24h" "LCL cells, DMSO treated, 24h, control" +p_31447_2 "LCL cells, Salubrinal treated, 24h" "LCL cells, DMSO treated, 24h, control" +p_31447_3 "LCL cells, Thapsigargin+Salubrinal treated, 24h" "LCL cells, DMSO treated, 24h, control" +p_31469_1 "A549 cell, H1N1 infected, 2h" "A549 cell, control" +p_31469_2 "A549 cell, H1N1 infected, 4h" "A549 cell, control" +p_31469_3 "A549 cell, H1N1 infected, 6h" "A549 cell, control" +p_31470_1 "A549 cells,H1N1 infected, 10hpi" "A549 cells, mock infected" +p_31471_1 "A549, H9N2 infected, 2H" "A549, H9N2 infected, 0H" +p_31471_2 "A549, H9N2 infected, 4H" "A549, H9N2 infected, 0H" +p_31471_3 "A549, H9N2 infected, 6H" "A549, H9N2 infected, 0H" +p_31471_4 "A549, H9N2 infected, 8H" "A549, H9N2 infected, 0H" +p_31471_5 "A549, H9N2 infected, 10H" "A549, H9N2 infected, 0H" +p_31472_1 "A549, H5N2 infected, 2H" "A549, H5N2 infected, 0H" +p_31472_2 "A549, H5N2 infected, 4H" "A549, H5N2 infected, 0H" +p_31472_3 "A549, H5N2 infected, 6H" "A549, H5N2 infected, 0H" +p_31472_4 "A549, H5N2 infected, 8H" "A549, H5N2 infected, 0H" +p_31472_5 "A549, H5N2 infected, 10H" "A549, H5N2 infected, 0H" +p_31518_1 "A549, pH1N1 infected, 2H" "A549, pH1N1 infected, 0H" +p_31518_2 "A549, pH1N1 infected, 4H" "A549, pH1N1 infected, 0H" +p_31518_3 "A549, pH1N1 infected, 6H" "A549, pH1N1 infected, 0H" +p_31518_4 "A549, pH1N1 infected, 8H" "A549, pH1N1 infected, 0H" +p_31518_5 "A549, pH1N1 infected, 10H" "A549, pH1N1 infected, 0H" +p_31641_1 "human melanocytes, 4TBP treated, 3h" "human melanocytes, untreated" +p_31641_2 "human melanocytes, 4TBP treated, 6h" "human melanocytes, untreated" +p_31641_3 "human melanocytes, 4TBP treated, 24h" "human melanocytes, untreated" +p_31641_4 "human melanocytes, MBEH treated, 3h" "human melanocytes, untreated" +p_31641_5 "human melanocytes, MBEH treated, 6h" "human melanocytes, untreated" +p_31641_6 "human melanocytes, MBEH treated, 24h" "human melanocytes, untreated" +p_31681_1 "Cumulus cell, stage metaphase I" "Cumulus cell, Germinal vesicle" +p_31681_2 "Cumulus cell, stage metaphase II" "Cumulus cell, Germinal vesicle" +p_31683_1 "Human endometrial stromal cell, nontarget silenced" "Human endometrial stromal cell, empty vector" +p_31683_2 "Human endometrial stromal cell, KLF9 , silenced" "Human endometrial stromal cell, empty vector" +p_31683_3 "Human endometrial stromal cell, PGR, silenced" "Human endometrial stromal cell, empty vector" +p_31683_4 "Human endometrial stromal cell, KLF9 + PGR, silenced" "Human endometrial stromal cell, empty vector" +p_31735_1 "Lung cancer cell, Nugen FF method" "Lung cancer cell, AFFY method" +p_31735_2 "Lung cancer cell, Nugen Pico method" "Lung cancer cell, AFFY method" +p_31735_3 "Lung cancer cell, Nugen V2 method" "Lung cancer cell, AFFY method" +p_31782_1 "MDA-MB231, JMJD6 Knock-down" "MDA-MB231, JMJD6 control (scrambled siRNA)" +p_31782_2 "MCF-7, JMJD6 Knock-down" "MCF-7, JMJD6 control (scrambled siRNA)" +p_31782_3 "MCF-7, JMJD6 over-expressed" "MCF-7, JMJD6 control (scrambled siRNA)" +p_31787_1 "Gastric cancer, Epstein-Barr virus treated" "Gastric cancer, Epstein-Barr virus minus" +p_31831_1 "MCF7, tamoxifen-resistant, tamoxifen treated" "MCF7 cells, tamoxifen-sensitive, tamoxifen treated" +p_31831_2 "MCF7 cells, tamoxifen-resistant, AMD3100 + tamoxifen treated" "MCF7 cells, tamoxifen-sensitive, AMD3100 + tamoxifen treated" +p_31831_3 "MCF7, tamoxifen-resistant, estrogen treated" "MCF7 cells, tamoxifen-sensitive, estrogen treated" +p_31831_4 "MCF7 cells, tamoxifen-resistant, AMD3100 + estrogen treated" "MCF7 cells, tamoxifen-sensitive, AMD3100 + estrogen treated" +p_31864_1 "Human bladder carcinoma, relatively fast grow" "Urothelial cell, normal" +p_31864_2 "Human bladder carcinoma, fast grow" "Urothelial cell, normal" +p_31879_1 melanoma tumor "melanocyte, normal" +p_31908_1 "lung adenocarcinoma, EGFR mutation" "lung adenocarcinoma, EGFR wild type" +p_31912_1 "MCF-7 cells, siRNA targeting ABL1, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_10 "MCF-7 cells, siRNA targeting CCNA2, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_11 "MCF-7 cells, siRNA targeting CCNB1, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_12 "MCF-7 cells, siRNA targeting CCND3, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_13 "MCF-7 cells, siRNA targeting CCNG2, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_14 "MCF-7 cells, siRNA targeting CDC16, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_15 "MCF-7 cells, siRNA targeting CDC2, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_16 "MCF-7 cells, siRNA targeting CDC20, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_17 "MCF-7 cells, siRNA targeting CDC25A, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_18 "MCF-7 cells, siRNA targeting CDC25B, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_19 "MCF-7 cells, siRNA targeting CDC34, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_2 "MCF-7 cells, siRNA targeting AKT1, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_20 "MCF-7 cells, siRNA targeting CDK2, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_21 "MCF-7 cells, siRNA targeting CDK4, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_22 "MCF-7 cells, siRNA targeting CDKN2A, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_23 "MCF-7 cells, siRNA targeting CEBPA, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_24 "MCF-7 cells, siRNA targeting CEBPB, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_25 "MCF-7 cells, siRNA targeting CEBPD, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_26 "MCF-7 cells, siRNA targeting CENPE, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_27 "MCF-7 cells, siRNA targeting CENPF, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_28 "MCF-7 cells, siRNA targeting CHEK1, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_29 "MCF-7 cells, siRNA targeting CREBBP, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_3 "MCF-7 cells, siRNA targeting ARHGEF1, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_30 "MCF-7 cells, siRNA targeting CTNNB1, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_31 "MCF-7 cells, siRNA targeting E2F1, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_32 "MCF-7 cells, siRNA targeting E2F5, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_33 "MCF-7 cells, siRNA targeting ERBB2, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_34 "MCF-7 cells, siRNA targeting ERF, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_35 "MCF-7 cells, siRNA targeting ESR1, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_36 "MCF-7 cells, siRNA targeting ESRRA, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_37 "MCF-7 cells, siRNA targeting FOS, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_38 "MCF-7 cells, siRNA targeting FOXC1, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_39 "MCF-7 cells, siRNA targeting FOXJ2, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_4 "MCF-7 cells, siRNA targeting ATR, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_40 "MCF-7 cells, siRNA targeting FOXO1A, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_41 "MCF-7 cells, siRNA targeting FOXO3A, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_42 "MCF-7 cells, siRNA targeting FOXP1, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_43 "MCF-7 cells, siRNA targeting GATA3, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_44 "MCF-7 cells, siRNA targeting HDAC3, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_45 "MCF-7 cells, siRNA targeting HDAC5, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_46 "MCF-7 cells, siRNA targeting HIF1A, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_47 "MCF-7 cells, siRNA targeting HOXB7, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_48 "MCF-7 cells, siRNA targeting HSF2, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_49 "MCF-7 cells, siRNA targeting ID1, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_5 "MCF-7 cells, siRNA targeting BCL2, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_50 "MCF-7 cells, siRNA targeting JUN, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_51 "MCF-7 cells, siRNA targeting JUND, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_52 "MCF-7 cells, siRNA targeting MAPK1, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_53 "MCF-7 cells, siRNA targeting MAPK14, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_54 "MCF-7 cells, siRNA targeting MAX, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_55 "MCF-7 cells, siRNA targeting MCM2, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_56 "MCF-7 cells, siRNA targeting MYBL2, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_57 "MCF-7 cells, siRNA targeting MYC, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_58 "MCF-7 cells, siRNA targeting NCOR2, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_59 "MCF-7 cells, siRNA targeting NFKB1, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_6 "MCF-7 cells, siRNA targeting BCL6, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_60 "MCF-7 cells, siRNA targeting NMI, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_61 "MCF-7 cells, siRNA targeting PAX3, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_62 "MCF-7 cells, siRNA targeting PCNA, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_63 "MCF-7 cells, siRNA targeting PIAS, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_64 "MCF-7 cells, siRNA targeting POLR2A, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_65 "MCF-7 cells, siRNA targeting RB1, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_66 "MCF-7 cells, siRNA targeting RBL2, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_67 "MCF-7 cells, siRNA targeting RELA, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_68 "MCF-7 cells, siRNA targeting SKP2, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_69 "MCF-7 cells, siRNA targeting SLC2A3, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_7 "MCF-7 cells, siRNA targeting BRCA1, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_70 "MCF-7 cells, siRNA targeting SMAD7, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_71 "MCF-7 cells, siRNA targeting SP100, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_72 "MCF-7 cells, siRNA targeting STAT1, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_73 "MCF-7 cells, siRNA targeting STAT5B, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_74 "MCF-7 cells, siRNA targeting TCEA1, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_75 "MCF-7 cells, siRNA targeting TEL2, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_76 "MCF-7 cells, siRNA targeting TOP2A, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_77 "MCF-7 cells, siRNA targeting TP53, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_8 "MCF-7 cells, siRNA targeting BRCA2, 48h" "MCF-7 cells, control siRNA, 48h" +p_31912_9 "MCF-7 cells, siRNA targeting CCL5, 48h" "MCF-7 cells, control siRNA, 48h" +p_31980_1 "synovial MSC-aggregates, MSC-aggregates" "synovial MSCs, MSCs in a monolayer" +p_3202_1 "H720 cell line, MK886 1 uM, 24h, serum free" "H720 cell line, control" +p_3202_2 "A549 cell line, MK886 1 uM, 24h, serum free" "A549 cell line, control" +p_3202_3 "A549 cell line, treated by HNRPA2B1, silenced" "A549 cell line, treated by HNRPA2B1 construct, control" +p_3202_4 "H720 treated by HNRPA2B1 construct, silenced" "H720 cell line, treated by HNRPA2B1, control" +p_3202_5 "H209 treated by HNRPA2B1 construct, silenced" "H209 cell line, treated by HNRPA2B1, control" +p_3202_6 "A549 cell line,treated by FLAP (ALOX5AP) siRNA, sielnced" "A549 cell line, treated by FLAP (ALOX5AP) siRNA, control" +p_32052_1 "MDA-MB 231 cells, S100A7 overexpression" "MDA-MB 231 cells, control vector" +p_32056_1 "HSC-3 cell, trypsin-2 over-expressed, 48h" "HSC-3 cell, control vector, 48h" +p_32108_1 "HeLa cell, siRNA CDK8-1" "HeLa cell, control" +p_32108_2 "HeLa cell, siRNA CDK8-2" "HeLa cell, control" +p_32108_3 "HeLa cell, siRNA CDK19-1" "HeLa cell, control" +p_32108_4 "HeLa cell, siRNA CDK19-2" "HeLa cell, control" +p_32142_1 "Human oral squamous cell carcinoma cell, HAI-1 knock down" "Human oral squamous cell carcinoma cell, control" +p_32158_1 "HuBEC,1uM BPA treated" "HuBEC, control" +p_32158_2 "HuBEC,10uM BPA treated" "HuBEC, control" +p_32161_1 "MCF-7 cell, tRA treated , 12h" "MCF-7 cell, DMSO treated , 12h" +p_32161_2 "MCF-7 cell, tRA + H treated , 12h" "MCF-7 cell, DMSO treated , 12h" +p_32169_1 "trabecular meshwork cells, E. coli, 5% oxygen" "trabecular meshwork cells, 5% oxygen" +p_32169_2 "trabecular meshwork cells, Pigment, 5% oxygen" "trabecular meshwork cells, 5% oxygen" +p_32169_3 "trabecular meshwork cells, E. coli, 40% oxygen" "trabecular meshwork cells, 40% oxygen" +p_32169_4 "trabecular meshwork cells, Pigment, 40% oxygen" "trabecular meshwork cells, 40% oxygen" +p_32171_1 "hMSC, co-culture with rat neonatal cardiomyocyte, 4 days" "hMSC, control" +p_32175_1 "saliva, lung cancer" "saliva, healthy control" +p_32178_1 "Myometrium cell, Dystocia" "Myometrium cell, control" +p_32374_1 congenital GBM tumor pediatric GBM tumor +p_32374_2 congenital GBM tumor adult GBM tumor +p_32448_1 "Homoprostate tumor, well defferentiaed" "Homoprostate normal, well defferentiaed" +p_32448_2 "Homoprostate tumor, partially defferentiaed" "Homoprostate normal, partially defferentiaed" +p_32482_1 "Human glioblastoma stem cell, ALK suppress" "Human glioblastoma stem cell, control" +p_32482_2 "Human glioblastoma stem cell, PTN suppress" "Human glioblastoma stem cell, control" +p_32496_1 "A549 cells, Aza-dC treated" "A549 cells, untreated" +p_32496_2 "A549 cells, Aza-dC/TSA treated" "A549 cells, untreated" +p_32496_3 "H1993 cells, Aza-dC treated" "H1993 cells, untreated" +p_32496_4 "H1993 cells, Aza-dC/TSA treated" "H1993 cells, untreated" +p_32496_5 "H2073 cells, Aza-dC treated" "H2073 cells, untreated" +p_32496_6 "H2073 cells, Aza-dC/TSA treated" "H2073 cells, untreated" +p_32523_1 "Human T-cell Acute Lymphoblastic Leukemia cell line (CEM), shRNA against ZMIZ1" "Human T-cell Acute Lymphoblastic Leukemia cell line (CEM), scrambled shRNA" +p_32526_1 "S2N cell, sphere type" "S2 cell, sphere type" +p_32526_2 "S2N cell, monolayer type" "S2 cell, monolayer type" +p_32534_1 "peritumoral cortex, ganglioglioma, Epilepsy" "peritumoral cortex, ganglioglioma, no epilepsy" +p_32540_1 "Gastric tubular adenocarcinoma cell, CDH1 overexpressed" "Gastric tubular adenocarcinoma cell, empty vector" +p_32547_1 "HUVEC, statin treated, 4h" "HUVEC, control" +p_32666_1 "T47D cell, Ethanol" "T47D cell, control" +p_32666_2 "T47D cell, Estradiol" "T47D cell, control" +p_32666_3 "T47D cell, E2-BSA" "T47D cell, control" +p_32666_4 "T47D cell, ICI" "T47D cell, control" +p_32666_5 "T47D cell, G15" "T47D cell, control" +p_32666_6 "T47D cell, E2-BSA + ICI" "T47D cell, control" +p_32666_7 "T47D cell, E2-BSA + G15" "T47D cell, control" +p_32666_8 "T47D cell, BSA" "T47D cell, control" +p_32667_1 "MCF-7 cell, Estradiol" "MCF-7 cell, control" +p_32667_2 "MCF-7 cell, E2-BSA" "MCF-7 cell, control" +p_32667_3 "MCF-7 cell, E2-BSA + ICI" "MCF-7 cell, control" +p_32667_4 "MCF-7 cell, E2-BSA + G15" "MCF-7 cell, control" +p_32667_5 "MCF-7 cell, BSA" "MCF-7 cell, control" +p_32668_1 "MDA-MB-231 cell, Ethanol" "MDA-MB-231 cell, control" +p_32668_2 "MDA-MB-231 cell, Estradiol" "MDA-MB-231 cell, control" +p_32668_3 "MDA-MB-231 cell, E2-BSA" "MDA-MB-231 cell, control" +p_32668_4 "MDA-MB-231 cell, ICI" "MDA-MB-231 cell, control" +p_32668_5 "MDA-MB-231 cell, G15" "MDA-MB-231 cell, control" +p_32668_6 "MDA-MB-231 cell, E2-BSA+ICI" "MDA-MB-231 cell, control" +p_32668_7 "MDA-MB-231 cell, E2-BSA+G15" "MDA-MB-231 cell, control" +p_32668_8 "MDA-MB-231 cell, BSA" "MDA-MB-231 cell, control" +p_32669_1 "SKBR3 cell, Ethanol treated" "SKBR3 cell, control" +p_32669_2 "SKBR3 cell, Estradiol treated" "SKBR3 cell, control" +p_32669_3 "SKBR3 cell, E2-BSA treated" "SKBR3 cell, control" +p_32669_4 "SKBR3 cell, E2-BSA + ICI treated" "SKBR3 cell, control" +p_32669_5 "SKBR3 cell, BSA treated" "SKBR3 cell, control" +p_32669_6 "SKBR3 cell, G15 treated" "SKBR3 cell, control" +p_32669_7 "SKBR3 cell, E2-BSA + G15 treated" "SKBR3 cell, control" +p_32676_1 pancreatic cancer "pancreas, non-malignant" +p_32685_1 "Keratinocyte, KLF4 induced" "Keratinocyte, control" +p_32685_2 "Keratinocyte, ZNF750 induced" "Keratinocyte, control" +p_32693_1 "HUVEC, siRNA targeting KLF4, statin treated" "HUVEC, siRNA targeting KLF2, statin treated" +p_32725_1 "Bone marrow cell, eldery" "Bone marrow cell, Young" +p_32727_1 "HMEC, hTert, transduced with Twist1+Ras" "HMEC, hTert, control" +p_32727_2 "HMEC, hTert, transduced with Zeb1+Ras" "HMEC, hTert, control" +p_32727_3 "HMEC, hTert, transduced with Zeb2+Ras" "HMEC, hTert, control" +p_32727_4 "HMEC, hTert, transduced with Twist1+Ras+TGF" "HMEC, hTert, control" +p_32727_5 "HMEC, hTert, transduced with Zeb2+Ras+TGF" "HMEC, hTert, control" +p_32727_6 "HMEC, hTert, transduced with Ras" "HMEC, hTert, control" +p_32727_7 "HMEC, hTert, transduced with Zeb1" "HMEC, hTert, control" +p_32727_8 "HMEC, hTert, transduced with Zeb2" "HMEC, hTert, control" +p_32727_9 "HMEC, hTert, transduced with Twist1" "HMEC, hTert, control" +p_3284_1 blood cells after LPS 2 h (gpl570); treated blood cells after before LPS (gpl570) +p_3284_2 blood cells after LPS 6 h (gpl570); treated blood cells after before LPS (gpl570) +p_32876_1 "Neurosphere cell, miR124 transfected" "Neurosphere cell, control" +p_32876_2 "Neurosphere cell, miR132 transfected" "Neurosphere cell, control" +p_32876_3 "Neurosphere cell, miR380 transfected" "Neurosphere cell, control" +p_32876_4 "Neurosphere cell, miR433 transfected" "Neurosphere cell, control" +p_32876_5 "Neurosphere cell, miR448 transfected" "Neurosphere cell, control" +p_32893_1 "BEAS2-B cells, exposed to A.alternata spores" "BEAS2-B cells, negative control" +p_32911_1 "HT1080 cell, normal growth condition + compound C 18h" "HT1080 cell, normal growth condition" +p_32911_2 "HT1080 cell, normal growth condition + versipelostatin 18h" "HT1080 cell, normal growth condition" +p_32911_3 "HT1080 cell, normal growth condition + phenformin 18h" "HT1080 cell, normal growth condition" +p_32911_4 "HT1080 cell, 10mM 2-deoxyglucose + compound C 18h" "HT1080 cell, 10mM 2-deoxyglucose 18h" +p_32911_5 "HT1080 cell, 10mM 2-deoxyglucose + versipelostatin 18h" "HT1080 cell, 10mM 2-deoxyglucose 18h" +p_32911_6 "HT1080 cell, 10mM 2-deoxyglucose + phenformin 18h" "HT1080 cell, 10mM 2-deoxyglucose 18h" +p_3292_1 "HNCCC, HPV+; treated" "HNCCC, HPV-" +p_32939_1 "Human peripheral blood monocytes, sMHC II treated, 3h" "Human peripheral blood monocytes, medium only treated" +p_32959_10 "CD4+ T cell, after treat + IL-4 24h" "CD4+ T cell , no treat" +p_32959_12 "CD4+ T cell, after treat + IL-4 72h" "CD4+ T cell , no treat" +p_32959_2 "CD4+ T cell , after treat 24h" "CD4+ T cell , no treat" +p_32959_4 "CD4+ T cell , after treat 72h" "CD4+ T cell , no treat" +p_32959_6 "CD4+ T cell, after treat + IL-12 24h" "CD4+ T cell , no treat" +p_32959_8 "CD4+ T cell, after treat + IL-12 72h" "CD4+ T cell , no treat" +p_32962_1 "Primary infant ALL cells, resistant to prednosolone" "Primary infant ALL cells, sensitive to prednosolone" +p_32982_1 prostate cancer tissue from radical prostatectomy specimen prostate tissue from castrated subject +p_32982_2 prostate benign tissue from radical prostatectomy specimen prostate tissue from castrated subject +p_32984_1 "HUVEC cell, Erg antisence treated , 24h" "HUVEC cell, untreated , 0h" +p_32984_2 "HUVEC cell, Erg antisence treated , 24h" "HUVEC cell, control antisence treated , 24h" +p_32984_3 "HUVEC cell, Erg antisence treated , 48h" "HUVEC cell, control antisence treated , 48h" +p_33006_1 hepatocellular carcinoma (HCC) Adjacent normal liver +p_33050_1 "HeLa cell, cultured without glucose" "HeLa cell, cultured with FBS" +p_33050_2 "HeLa cell, cultured with High glucose" "HeLa cell, cultured with FBS" +p_33051_1 "Hela Cell, cultured without glucose" "Hela Cell, cultured with FBS" +p_33051_2 "Hela Cell, cultured with High glucose" "Hela Cell, cultured with FBS" +p_33066_1 "HUF-1, SSEA3-Pos" "HUF-1, SSEA3-Neg" +p_33109_1 "Human Neural cell, expose to VS 0.1um 6h" "Human Neural cell, control, 0h" +p_33109_2 "Human Neural cell, expose to VS 0.1um 6h" "Human Neural cell, control, 6h" +p_33109_3 "Human Neural cell, expose to VS 0.1um 24h" "Human Neural cell, control, 24h" +p_33109_4 "Human Neural cell, expose to VS 0.1um 72h" "Human Neural cell, control, 72h" +p_33109_5 "Human Neural cell, expose to VS 6um 6h" "Human Neural cell, control, 6h" +p_33109_6 "Human Neural cell, expose to VS 6um 24h" "Human Neural cell, control, 24h" +p_33109_7 "Human Neural cell, expose to VS 6um 72h" "Human Neural cell, control, 72h" +p_33112_1 "Colo200 cells, Low Wnt responsive contstuct" "Colo200 cells, High Wnt responsive contstuct" +p_33112_2 "LM003 cells, Low Wnt responsive contstuct" "LM003 cells, High Wnt responsive contstuct" +p_33112_3 "LM23 cells, Low Wnt responsive contstuct" "LM23 cells, High Wnt responsive contstuct" +p_33112_4 "co108 cells, Low Wnt responsive contstuct" "co108 cells, High Wnt responsive contstuct" +p_33112_5 "Colo100.1 cells, Low Wnt responsive contstuct" "Colo100.1 cells, High Wnt responsive contstuct" +p_33113_1 primary tumor resection normal colon mucosa +p_33135_1 "peripheral blood mononuclear cells, dexamethasone treated, 6h, Unmutated IGHV gene / high ZAP-70 expresssion" "peripheral blood mononuclear cells, untreated, Unmutated IGHV gene / high ZAP-70 expresssion" +p_33135_2 "peripheral blood mononuclear cells, dexamethasone treated, 6h, Mutated IGHV gene / low ZAP-70 expresssion" "peripheral blood mononuclear cells, untreated, Mutated IGHV gene / low ZAP-70 expresssion" +p_33143_1 "DLD1 cells, SAH-BCL9B treated" "DLD1 cells, vehicle" +p_33145_1 HMEC cell DKAT cell +p_33145_2 MDA-MB-231 cell DKAT cell +p_33146_1 "Human breast cancer-derived cell line (DKAT), cultured in SCGM, 14 days" "Human breast cancer-derived cell line (DKAT), cultured in MEGM, 14 days" +p_33169_1 "intact skin, negative pressure treated, 0d" "intact skin, control, 0d" +p_33169_2 "intact skin, negative pressure treated, 7d" "intact skin, 7d" +p_33182_1 "PC3 cells, COUP-TFII siRNA, 48h" "PC3 cells, control siRNA, 48h" +p_33243_1 "AML cell, Fenretinide treated , 6h" "AML cell, control" +p_33243_2 "AML cell, Fenretinide treated , 12h" "AML cell, control" +p_3325_1 Clinically localized primary prostate cancer Benign Prostate tissue +p_3325_2 Metastatic prostate cancer Benign Prostate tissue +p_33316_1 androgen-deprived LuCaP35 cell "LuCaP35 cell, control" +p_33325_1 "cardiomyocyte cell, expose to VX 0.1um, 6h" "cardiomyocyte cell, control 0h" +p_33325_2 "cardiomyocyte cell, expose to VX 0.1um, 6h" "cardiomyocyte cell, control 6h" +p_33325_3 "cardiomyocyte cell, expose to VX 0.1um, 24h" "cardiomyocyte cell, control 24h" +p_33325_4 "cardiomyocyte cell, expose to VX 0.1um, 72h" "cardiomyocyte cell, control 72h" +p_33325_5 "cardiomyocyte cell, expose to VX 6um, 6h" "cardiomyocyte cell, control 6h" +p_33325_6 "cardiomyocyte cell, expose to VX 6um, 24h" "cardiomyocyte cell, control 24h" +p_33325_7 "cardiomyocyte cell, expose to VX 6um, 72h" "cardiomyocyte cell, control 72h" +p_33356_1 "lung tissue, primary tumor" "lung tissue, paired normal adjacent" +p_33358_1 "U937 cell, Tan IIA treated, 12h" "U937 cell, DMSO treated" +p_33358_2 "U937 cell, Tan IIA treated, 24h" "U937 cell, DMSO treated" +p_33363_1 microdissected non-small cell lung cancer tissue non-small cell lung cancer tissue +p_33371_1 Adrenocortical Adenoma Normal Adrenal Cortex +p_33371_2 Adrenocortical Carcinoma Normal Adrenal Cortex +p_33374_1 CD161++CD8ab T cells CD161++CD8aa T cells +p_33420_1 "DLD-1, miR-143" "DLD-1, mock treated" +p_33424_1 "T cell, CD8+ , CD161 +" "T cell, CD8+ , CD161 -" +p_33424_2 "T cell, CD8+ , CD161 ++" "T cell, CD8+ , CD161 -" +p_33455_1 "DU-145 cell, docetaxel resistant" "DU-145 cell, control" +p_33455_2 "PC3 cell, docetaxel resistant" "PC3 cell, control" +p_33458_1 "143B cell, TIC" "143B cell, non-TIC" +p_33458_2 "MNNG/HOS cell, TIC" "MNNG/HOS cell, non-TIC" +p_33495_1 "primary neonatal keratinocytes, TP63 knock down" "primary neonatal keratinocytes, control" +p_33495_2 "rimary neonatal keratinocytes, ¥ÄNp63¥á(I482T) Overexpression" "primary neonatal keratinocytes, control" +p_33495_3 "rimary neonatal keratinocytes, ¥ÄNp63¥á(R500P) Overexpression" "primary neonatal keratinocytes, control" +p_33495_4 "rimary neonatal keratinocytes, ¥ÄNp63¥á Overexpression" "primary neonatal keratinocytes, control" +p_33504_1 "HMC1 cells, CD2+ expression" "HMC1 cells, CD2- expression" +p_33539_1 "ALLSIL cell line, TLX1 knockdown" "ALLSIL cell line, control" +p_33540_1 "HPBALL cell line, TLX3 knockdown" "HPBALL cell line, control" +p_33562_1 "CUTLL1 cell, 1uM PF-03084014 treated" "CUTLL1 cell, DMSO treated" +p_33562_2 "CUTLL1 cell, 1uM dexamethasone treated" "CUTLL1 cell, DMSO treated" +p_33562_3 "CUTLL1 cell, 1uM dexamethasone + PF-03084014 treated" "CUTLL1 cell, DMSO treated" +p_33572_1 "primary neonatal keratinocytes, TP63 knock down" "primary neonatal keratinocytes, control siRNA" +p_33572_2 "primary neonatal keratinocytes, ¥ÄNp63¥á(I482T) Overexpression" "primary neonatal keratinocytes, control siRNA" +p_33572_3 "primary neonatal keratinocytes, ¥ÄNp63¥á(R500P) Overexpression" "primary neonatal keratinocytes, control siRNA" +p_33572_4 "primary neonatal keratinocytes, ¥ÄNp63¥á(Wild type) Overexpression" "primary neonatal keratinocytes, control siRNA" +p_33577_1 "MM.1S cell, MLN4924 treated,8h" "MM.1S cell, control" +p_33577_2 "MM.1S cell, MLN4924 treated,16h" "MM.1S cell, control" +p_33577_3 "MM.1S cell, MLN4924 treated,24h" "MM.1S cell, control" +p_33580_1 "whole blood, HIV resistant women" "whole blood, HIV negative women" +p_33585_1 THP1-cells stimulated with Infliximab for 6h "THP1-cells, unstimulated, 0h" +p_33585_2 THP1-cells stimulated with Infliximab for 24h "THP1-cells, unstimulated, 0h" +p_33585_3 THP1-cells stimulated with CDP870 for 6h "THP1-cells, unstimulated, 0h" +p_33585_4 THP1-cells stimulated with CDP870 for 24h "THP1-cells, unstimulated, 0h" +p_33606_1 "hNHEP cell, 0.1uM, 6h" "hNHEP cell, control, 6h" +p_33606_2 "hNHEP cell, 10uM, 6h" "hNHEP cell, control, 6h" +p_33630_1 anaplastic thyroid carcinomas (ATC) non-tumoral thyroid tissues +p_33630_2 papillary thyroid carcinomas (PTC) non-tumoral thyroid tissues +p_33780_1 "A1555G cell, hyper-methylated overexpressed" "A1555G cell, control" +p_33780_2 "Hela cell, mtTFB1 overexpressed, hyper-methylated" "Hela cell, mtTFB1 overexpressed" +p_33810_1 "Esophagus cell, tumor" "Esophagus cell, non-tumor" +p_33810_2 "Esophagus cell, tumor with familly history" "Esophagus cell, non-tumor" +p_33827_1 "MDA-MB-231 cell, T2 tumor, treated SM-164" "MDA-MB-231 cell, parental, treated SM-164" +p_33827_2 "MDA-MB-231 cell, T3 tumor, treated SM-164" "MDA-MB-231 cell, parental, treated SM-164" +p_33827_3 "MDA-MB-231 cell, T6 tumor, treated SM-164" "MDA-MB-231 cell, parental, treated SM-164" +p_33827_4 "MDA-MB-231 cell, T8 tumor, treated SM-164" "MDA-MB-231 cell, parental, treated SM-164" +p_33831_1 "Mesenchymal stem cell, 6h" "Mesenchymal stem cell, 0h" +p_33831_2 "Mesenchymal stem cell, 12h" "Mesenchymal stem cell, 0h" +p_33831_3 "Mesenchymal stem cell, 24h" "Mesenchymal stem cell, 0h" +p_33831_4 "Mesenchymal stem cell, 48h" "Mesenchymal stem cell, 0h" +p_33845_1 "Lung cancer, low invasive, Electric Fields" "Lung cancer, low invasive, control" +p_33845_2 "Lung cancer, High invasive, Electric Fields" "Lung cancer, High invasive, control" +p_33864_1 "HSF-6 cell, Butyrate, DZNep treated" "HSF-6 cell, control" +p_33870_1 "HEK293 cell, FTO overexpressed, 0h" "HEK293 cell, control, 0h" +p_33870_2 "HEK293 cell, FTO overexpressed, 1d" "HEK293 cell, control, 1d" +p_33870_3 "HEK293 cell, FTO overexpressed, 2d" "HEK293 cell, control, 2d" +p_33870_4 "HEK293 cell, FTO knockout" "HEK293 cell, control" +p_33939_1 Polymorphonuclear leukocyte cell control time : 30 "Polymorphonuclear leukocyte cell, PVL treated time : 30" +p_33939_2 Polymorphonuclear leukocyte cell control time : 60 "Polymorphonuclear leukocyte cell, PVL treated time : 60" +p_33939_3 Polymorphonuclear leukocyte cell control time : 180 "Polymorphonuclear leukocyte cell, PVL treated time : 180" +p_33939_4 Polymorphonuclear leukocyte cell control time : 30 Polymorphonuclear leukocyte cell + iPVL treated time : 30 +p_33939_5 Polymorphonuclear leukocyte cell control time : 60 Polymorphonuclear leukocyte cell + iPVL treated time : 60 +p_33939_6 Polymorphonuclear leukocyte cell control time : 180 Polymorphonuclear leukocyte cell + iPVL treated time : 180 +p_33950_1 "MDA-MB-231 cell, shHIF treated" "MDA-MB-231 cell, shGFP, control" +p_33950_2 "MDA-MB-231 cell, Sharp1 overexpressed" "MDA-MB-231 cell, shGFP, control" +p_33984_1 "EAHY cells, HSHV-infected" "EAHY cells, non-infected control" +p_34022_1 "Huh-7 cell, IFN alpha treated" "Huh-7 cell, control" +p_34025_1 "Monocyte, DEP treated" "Monocyte, control" +p_34027_1 "TC-71 cell, expose to AEW" "TC-71 cell, control" +p_34027_2 "TC-71 cell, expose to AVE" "TC-71 cell, control" +p_34027_3 "TC-71 cell, expose to CP" "TC-71 cell, control" +p_34042_1 "M12 cell, 5-AZA treated" "M12 cell, control" +p_34042_2 "P69 cell, 5-AZA treated" "P69 cell, control" +p_34042_3 "RD cell, 5-AZA treated" "RD cell, control" +p_34042_4 "Rh30 cell, 5-AZA treated" "Rh30 cell, control" +p_34053_1 "Carcinoma cell, CD133-" Carcinoma associated fibroblast +p_34053_2 "Carcinoma cell, CD133+" Carcinoma associated fibroblast +p_34055_1 "HMEC, Myc overexpressed" "HMEC, control" +p_34055_2 "HMEC, SUMO depleted" "HMEC, control" +p_34055_3 "HMEC, Myc overexpressed, SUMO depleted" "HMEC, control" +p_34112_1 "PC3 cells, hypoxia, sulindac treated" "PC3 cells, hypoxia, DMSO treated" +p_34112_2 "PC3 cells, hypoxia, NO-sulindac treated" "PC3 cells, hypoxia, DMSO treated" +p_34112_3 "PC3 cells, normoxia, sulindac treated" "PC3 cells, nomroxia, DMSO treated" +p_34112_4 "PC3 cells, normoxia, NO-sulindac treated" "PC3 cells, normoxia, DMSO treated" +p_34200_1 "ESC, UNDIFF LINE (BG02), PASSAGE 50" UniRef Processing Control +p_34200_3 "ESC UNDIFF LINE (ES02), PASSAGE 45" UniRef Processing Control +p_34200_5 "ESC UNDIFF LINE (TE03), PASSAGE 66" UniRef Processing Control +p_34200_7 "ESC UNDIFF LINE (UC01), PASSAGE 56" UniRef Processing Control +p_34200_9 "ESC UNDIFF LINE (WA01), PASSAGE 52" UniRef Processing Control +p_34205_1 "PBMC, infected by influenze" "PBMC, no-infection, control" +p_34205_2 "PBMC, infected by acute RSV" "PBMC, no-infection, control" +p_34298_1 "K562 cells, Shikonin resistant" "K562 cells, control" +p_34299_1 "HT29RC cell, PLX4720 resistant" "HT29 parental cell, control" +p_34299_2 "Colo 205 cell, PLX4720 resistant" "Colo 205 parental cell, control" +p_34308_1 "dermal fibroblast, CCALD patient" "dermal fibroblast, healthy control" +p_34331_1 "MCF-7 cells, F05 5 ¥ìM, 6h" "MCF-7 cells, DMSO 0.05%, 6h" +p_34339_1 "Diffuse Large B-cell Lymphoma, Swedish" "Diffuse Large B-cell Lymphoma, Egyptian" +p_34407_1 "Human peripheral monocyte, toxin treated" "Human peripheral monocyte, control" +p_34454_1 "SW1783 cell, miR-376a*A treated, 24h" "SW1783 cell, control , 24h" +p_34454_2 "SW1783 cell, miR-376a*G treated, 24h" "SW1783 cell, control , 24h" +p_34455_1 "U87 cell, miR-376a*A treated, 24h" "U87 cell, control , 24h" +p_34455_2 "U87 cell, miR-376a*G treated, 24h" "U87 cell, control , 24h" +p_34456_1 "U87 cell, miR-376a*A treated, 72h" "U87 cell, control , 72h" +p_34456_2 "U87 cell, miR-376a*G treated, 72h" "U87 cell, control , 72h" +p_34482_1 "SW1783 cells, transfected with miR-376a*A, 24h" "SW1783 cells, control miRNA, 24h" +p_34482_2 "SW1783 cells, transfected with miR-376a*G, 24h" "SW1783 cells, control miRNA, 24h" +p_34482_3 "U87 cells, transfected with miR-376a*A, 24h" "U87 cells, control miRNA, 24h" +p_34482_4 "U87 cells, transfected with miR-376a*G, 24h" "U87 cells, control miRNA, 24h" +p_34482_5 "U87 cells, transfected with miR-376a*A, 72h" "U87 cells, control miRNA, 72h" +p_34482_6 "U87 cells, transfected with miR-376a*G, 72h" "U87 cells, control miRNA, 72h" +p_34489_1 "colorectal cancer tissue, chromosome instability (cin) phenotype: CIN-high" "colorectal cancer tissue, chromosome instability (cin) phenotype: CIN-low" +p_34512_1 "HMVEC-LBI, siRNA targeting PBEF treated" "primary HMVEC-LBI, scrambled siRNA treated" +p_34514_1 "Sperm cell, Normal" "Sperm cell, Asthenozoospemic patient" +p_34515_1 "HBMCS, cd16 positive" "HBMCS, cd16 negative" +p_34515_2 "HBMCS, cd1c positive" "HBMCS, cd16 negative" +p_34526_1 "granulosa cells, PCOS women" "granulosa cells, normal women" +p_34528_1 "Keratinocyte, ANCR silenced" "Keratinocyte, siRNA control" +p_34573_1 "NPC biopsy, nasopharyngeal carcinoma" normal nasopharyngeal biopsy +p_34602_1 "Mino cell, GSI treated" "Mino cell, mock treated" +p_34602_2 "Rec-1 cell, GSI treated" "Rec-1 cell, mock treated" +p_34602_3 "SP-49 cell, GSI treated" "SP-49 cell, mock treated" +p_34628_1 "primary human umbilical vein endothelial cells, DV infected" "primary human umbilical vein endothelial cells, control" +p_34635_1 "bronchioepithelial cells (BEAS-2B), N-OH-PhIP treatead, 500nM, 24h" "bronchioepithelial cells (BEAS-2B), DMSO treatead, 24h, control" +p_34635_4 "bronchioepithelial cells (BEAS-2B), N-OH-PhIP treatead, 50nM, 24h" "bronchioepithelial cells (BEAS-2B), DMSO treatead, 24h, control" +p_34635_6 "bronchioepithelial cells (BEAS-2B), N-OH-PhIP treatead, 5nM, 24h" "bronchioepithelial cells (BEAS-2B), DMSO treatead, 24h, control" +p_34635_8 "bronchioepithelial cells (BEAS-2B), N-OH-PhIP treatead, 500pM, 24h" "bronchioepithelial cells (BEAS-2B), DMSO treatead, 24h, control" +p_34715_1 "HEK293cell, dox treated" "HEK293cell, dox untreated" +p_34776_1 "lymphoblast tissue, Nicotine dependent" "lymphoblast tissue, control" +p_34781_1 "white blood cell of venous blood, unstable angina" "white blood cell of venous blood, control" +p_34789_1 "Calu-3 cell, stretched" "Calu-3 cell, non-stretched" +p_34846_1 "RPE1 cell, transfected with M129 oligo, 72h" "RPE1 cell, transfected with control oligo, 72h" +p_34880_1 "Reh cells, vorinostat treated, 0.5uM" "Reh cells, control" +p_34880_2 "Reh cells, vorinostat treated, 1uM" "Reh cells, control" +p_34880_3 "Reh cells, vorinostat treated, 2.5M" "Reh cells, control" +p_34880_4 "RS4 cells, vorinostat treated, 1uM" "RS4 cells, control" +p_34880_5 "MV4 cells, vorinostat treated, 1uM" "MV4 cells, control" +p_34880_6 "ALL patients, vorinostat treated, 1uM" "ALL patients, control" +p_34972_1 "HPSCs, 12h" "HPSCs, 0 day" +p_34972_2 "HPSCs, 2 weeks" "HPSCs, 0 day" +p_34972_3 "HPSCs, 5 weeks" "HPSCs, 0 day" +p_35014_1 "bladder cancer cells (UM-UC-3), transfected with GFP-tagged RhoGDI2" "bladder cancer cells (UM-UC-3), transfected with GFP (control)" +p_35082_1 "Mononuclear cells, Splenic Marginal Zone Lymphoma patient, 7q32 deleted" "Mononuclear cells, Splenic Marginal Zone Lymphoma patient" +p_35084_1 "HEK293 cells, LPA treated" "HEK293 cells, untreated" +p_35169_1 "U87-2M1 cell, hypoxia" "U87-2M1 cell, control" +p_35170_1 "U87-2M1 cell, miR-10b silencing" "U87-2M1 cell, control" +p_35249_1 "Fibroblast cell, CAF patient" "Fibroblast cell, aNOF patient" +p_35250_1 "Fibroblast cell, coCAF patient" "Fibroblast cell, NOF patient" +p_35251_1 "Normal omental fibroblast transfected with 3 miRNAs (miR-155, anti-miR-31 and anti-miR-214), 2d" Normal omental fibroblast +p_35252_1 "Normal omental fibroblast, transfected with 3 miRNAs (miR-155, anti-miR-31 and anti-miR-214), 4d" normal omental fibroblast +p_35324_1 "C4-2B cell, B-DIM treated, 6h" "C4-2B cell, control" +p_35324_2 "C4-2B cell, B-DIM treated, 48h" "C4-2B cell, control" +p_35324_3 "C4-2B cell, Isoflavone treated, 6h" "C4-2B cell, control" +p_35324_4 "C4-2B cell, Isoflavone treated, 72h" "C4-2B cell, control" +p_35330_1 "primary natural killer (NK) cells, anti-CD158d mAb, 4 hr" "primary natural killer (NK) cells, 4 hr, control" +p_35330_2 "primary natural killer (NK) cells, anti-CD158d mAb, 16 hr" "primary natural killer (NK) cells, 16 hr, control" +p_35330_3 "primary natural killer (NK) cells, anti-CD158d mAb, 64 hr" "primary natural killer (NK) cells, 64 hr, control" +p_35331_1 "Bone-Marrow Mesenchymal Stromal Cells, Follicular Lymphoma patient, untreated" "Bone-Marrow Mesenchymal Stromal Cells, healthy donors, untreated" +p_35331_2 "Bone-Marrow Mesenchymal Stromal Cells, healthy donors, Stimulated by TNF+LT, 3 days" "Bone-Marrow Mesenchymal Stromal Cells, healthy donors, untreated" +p_35340_1 "CD207+, CD1a+ LCH (Langerhans cell histiocytosis) cells" epidermal Langerhans cells +p_35340_2 "CD207+, CD1a+ LCH (Langerhans cell histiocytosis) cells" myeloid dendritic cells (mDC1) +p_35340_3 "CD207+, CD1a+ LCH (Langerhans cell histiocytosis) cells" plasmacytoid dendritic cells (pDC) +p_35369_1 "Gene expression in gastric epithelial cells: CDX1 induction -, 24 h" "Gene expression in gastric epithelial cells: control induction -, 24 h" +p_35369_2 "Gene expression in gastric epithelial cells: CDX1 induction +, 24 h" "Gene expression in gastric epithelial cells: control induction -, 24 h" +p_35374_1 "Cord blood CD45RAlow+CD34+CD38-CD90+ cells, SCF+CCL28 treated, 18h" "Cord blood CD45RAlow+CD34+CD38-CD90+ cells, SCF treated, 18h" +p_35383_1 "Mononuclear cells, splenic marginal zone lymphoma, without 7q32 deletion" "Mononuclear cells, splenic marginal zone lymphoma, 7q32 deletion" +p_35388_1 "A375 cell, exosome" "A375 cell, normal" +p_35388_2 "HEMa-LP cell, exosome" "HEMa-LP cell, normal" +p_35414_1 "Human Multiple Myeloma cell line MM1S, FK866 at concentration of 10nM , 6h" "Human Multiple Myeloma cell line MM1S, untreated" +p_35414_2 "Human Multiple Myeloma cell line MM1S, FK866 at concentration of 10nM , 24h" "Human Multiple Myeloma cell line MM1S, untreated" +p_35428_1 "MCF-7 cells, co-treatment: E2_ethanol" "MCF-7 cells, co-treatment: ethanol_ethanol" +p_35428_2 "MCF-7 cells, co-treatment: E2_4OHT" "MCF-7 cells, co-treatment: ethanol_4OHT" +p_35428_3 "MCF-7 cells, co-treatment: E2_ICI 182,780" "MCF-7 cells, co-treatment: ethanol_ICI 182,780" +p_35428_4 "MCF-7 cells, co-treatment: E2_Bazedoxifene" "MCF-7 cells, co-treatment: ethanol_Bazedoxifene" +p_35428_5 "MCF-7 cells, co-treatment: E2_Raloxifene" "MCF-7 cells, co-treatment: ethanol_Raloxifene" +p_35452_1 "rectal cancer, response to preoperative chemoradiotherapy: Responder" "rectal cancer, response to preoperative chemoradiotherapy: Non-responder" +p_35493_1 "brain tumor, atypical teratoid / rhabdoid tumor" "brain tumor, glioblastoma" +p_35493_2 "brain tumor, atypical teratoid / rhabdoid tumor" "brain tumor, medulloblastoma, large-cell" +p_35493_3 "brain tumor, atypical teratoid / rhabdoid tumor" "brain tumor, primitive neuroectodermal tumor" +p_35493_4 "brain tumor, atypical teratoid / rhabdoid tumor" "normal brain control, cerebellum, pediatric" +p_35493_5 "brain tumor, atypical teratoid / rhabdoid tumor" "normal brain control, frontal, pediatric" +p_35493_6 "brain tumor, atypical teratoid / rhabdoid tumor" "normal brain control, occipital, pediatric" +p_35493_7 "brain tumor, atypical teratoid / rhabdoid tumor" "normal brain control, parietal, pediatric" +p_35493_8 "brain tumor, atypical teratoid / rhabdoid tumor" "normal brain control, temporal, pediatric" +p_35503_1 "hMSC, GW9662 treated, 1wk" "hMSC, DMSO treated, 1wk" +p_35503_2 "hMSC, GW9662 treated, 2wk" "hMSC, DMSO treated, 2wk" +p_35511_1 "MDA-MB-231, transfected with pcDNA6/V5-His-ZNF217 plasmid" "MDA-MB-231 cells, transfected with pcDNA6/V5-His plasmid" +p_35546_1 "MSC cell, Kartogenin 1nm treated , 6h" "MSC cell, DMSO treated" +p_35546_2 "MSC cell, Kartogenin 1nm treated , 24h" "MSC cell, DMSO treated" +p_35546_3 "MSC cell, Kartogenin 10nm treated , 6h" "MSC cell, DMSO treated" +p_35546_4 "MSC cell, Kartogenin 10nm treated , 24h" "MSC cell, DMSO treated" +p_35546_5 "MSC cell, Kartogenin 100nm treated , 6h" "MSC cell, DMSO treated" +p_35546_6 "MSC cell, Kartogenin 100nm treated , 24h" "MSC cell, DMSO treated" +p_35551_1 SD8 skin fibro blast "human Skin fibroblasts, control" +p_35551_2 SD60 skin fibro blast "human Skin fibroblasts, control" +p_35554_1 "skin fibroblast, chimke immuno-osseous dysplasia" "skin fibroblast, control" +p_35620_1 "human skin fibroblast cells, transfected with miR-941 mimics-Lipofectamine 2000 complexes" "human skin fibroblast cells, mock treated" +p_35620_2 "human embryonic kidney cells (HEK cells), ransfected with miR-941 mimics-Lipofectamine 2000 complexes" "human embryonic kidney cells (HEK cells), mock treated" +p_35620_3 "human embryonic kidney cells (293T cell), transfected with mock oligonucleotides" "human embryonic kidney cells (293T cell), transfected with mock oligonucleotides" +p_35620_4 "LLCM2 cells, transfected with miR-941 mimics-Lipofectamine 2000 complexes" "LLCM2 cells, transfected with mock oligonucleotides" +p_35620_5 "fetal rhesus monkey kidney (FRhK-4) cells, transfected with miR-941 mimics-Lipofectamine 2000 complexes" "fetal rhesus monkey kidney (FRhK-4) cells, transfected with mock oligonucleotides" +p_35620_6 "MSF cells, transfected with miR-941 mimics-Lipofectamine 2000 complexes" "MSF cells, transfected with mock oligonucleotides" +p_35621_1 "293T cells, transfected with Synthetic miR-941" "293T cells, transfected with scrambled oligonucleotide, control" +p_35683_1 "Umbilical Cord blood Monocytes, LPS+DEX" "Umbilical Cord blood Monocytes, LPS" +p_35683_2 "Umbilical Cord blood Monocytes, LPS+IL-10" "Umbilical Cord blood Monocytes, LPS" +p_35683_3 "Umbilical Cord blood Polymorphonucler cells, LPS+DEX" "Umbilical Cord blood Polymorphonucler cells, LPS" +p_35683_4 "Umbilical Cord blood Polymorphonucler cells, LPS+IL-10" "Umbilical Cord blood Polymorphonucler cells, LPS" +p_35696_1 "MCF7 cell, RL silenced , LIF treated" "MCF7 cell, RL silenced , NS" +p_35696_2 "MCF7 cell, SIN3a silenced, LIF treated" "MCF7 cell, SIN3a silenced, NS" +p_35809_1 "Gastric Cancer cell, proliferative" "Gastric Cancer cell, metabolic" +p_35809_2 "Gastric Cancer cell, Invasive" "Gastric Cancer cell, metabolic" +p_35830_1 "Ect1 cell, 10% seminal plasma treated" "Ect1 cell, control" +p_35830_2 "Ect1 cell, TGFB treated" "Ect1 cell, control" +p_35864_1 "Brain white matter, HIV infected" "Brain white matter, control" +p_35864_2 "Brain white matter, HIV inefected with neurocognitive impairment" "Brain white matter, control" +p_35864_3 "Brain white matter, HIV infected with both neurocognitive impairment and encephalitis patients" "Brain white matter, control" +p_35864_4 "Brain white matter, HIV infected" Brain frontal cortex +p_35864_5 "Brain white matter, HIV inefected with neurocognitive impairment" Brain frontal cortex +p_35864_6 "Brain white matter, HIV infected with both neurocognitive impairment and encephalitis patients" Brain frontal cortex +p_35864_7 "Brain white matter, HIV infected" Brain basal ganglia +p_35864_8 "Brain white matter, HIV inefected with neurocognitive impairment" Brain basal ganglia +p_35864_9 "Brain white matter, HIV infected with both neurocognitive impairment and encephalitis patients" Brain basal ganglia +p_35955_1 "Mesenchymal stem cell, bone marrow, from elderly-aged donor" "Mesenchymal stem cell, bone marrow, from middle-aged donor" +p_35957_1 "Mesenchymal stem cell, bone marrow, cellular senescence state" "Mesenchymal stem cell, bone marrow, control" +p_35958_1 "Mesenchymal stem cell, bone marrow, from old donor with primary osteoporosis" "Mesenchymal stem cell, bone marrow, from old donor, control" +p_35972_1 "TOV112D cells, NSC319726 treated" "TOV112D cells, untreated" +p_35973_1 "DKS5 cell, hyposia, 12h" "DKS5 cell, normoxia" +p_35973_2 "DKO3 cell, hyposia, 12h" "DKO3 cell, normoxia" +p_36083_1 "placenta, 8 weeks, antiphospholipid antibody" "placenta, 8 weeks, control" +p_36098_1 "HIDEMs (human iPS cell-derived mesoangioblasts), Limb-girdle muscular dystrophy 2D (LGMD2D) derived" "human mesoangioblasts, wild type adult skeletal muscle derived, control" +p_36098_2 "HIDEMs (human iPS cell-derived mesoangioblasts), Wild-type" "human mesoangioblasts, wild type adult skeletal muscle derived, control" +p_36135_1 "DU145 cell, Docetaxel resistant" "DU145 cell, parental sensitive" +p_36135_2 "22Rv1 cell, Docetaxel resistant" "22Rv1 cell, parental sensitive" +p_36149_1 "Acute Lymphoblastic Leukemia cell line RS4:11, obatoclax, 72h EC50" "Acute Lymphoblastic Leukemia cell line RS4:11, control" +p_36149_2 "Acute Lymphoblastic Leukemia cell line RS4:11, obatoclax, 3x 72h EC50" "Acute Lymphoblastic Leukemia cell line RS4:11, control" +p_36149_3 "Acute Lymphoblastic Leukemia cell line SEM-K2, obatoclax, 72h EC50" "Acute Lymphoblastic Leukemia cell line SEM-K2, control" +p_36149_4 "Acute Lymphoblastic Leukemia cell line SEM-K2, obatoclax, 3x 72h EC50" "Acute Lymphoblastic Leukemia cell line SEM-K2, control" +p_36222_1 "primary neonatal keratinocytes, ACTL6a knock down" "primary neonatal keratinocytes, control" +p_36238_1 "Blood, Tuberculosis patients, Week 26" "Blood, Tuberculosis patients, at diagnosis (Week0)" +p_36287_1 "primary keratinocytes, IFNa-treated" "primary keratinocytes, untreated control" +p_36287_2 "primary keratinocytes, IFNg-treated" "primary keratinocytes, untreated control" +p_36287_3 "primary keratinocytes, IL13-treated" "primary keratinocytes, untreated control" +p_36287_4 "primary keratinocytes, IL17-treated" "primary keratinocytes, untreated control" +p_36287_5 "primary keratinocytes, IL4-treated" "primary keratinocytes, untreated control" +p_36287_6 "primary keratinocytes, TNF-treated" "primary keratinocytes, untreated control" +p_36547_1 "CD34+ cell, prostaglandin treated, 4deg, 1h" "CD34+ cell, vehicle treated, 4deg, 1h" +p_36547_2 "CD34+ cell, prostaglandin treated, 37deg, 2h" "CD34+ cell, vehicle treated, 37deg, 2h" +p_36609_1 "H181 cell, without bFGF" "H181 cell, with bFGF" +p_36609_2 "H181 cell, without bFGF, NO treated" "H181 cell, with bFGF" +p_36666_1 "HCT116 cell, wt, spheroid type" "HCT116/GFP cell, wt, spheroid type" +p_36666_2 "HCT116 cell, wt, monolayer type" "HCT116/GFP cell, wt, monolayer type" +p_36667_1 100-01#16 iPSC 201B7 iPSC +p_36668_1 "Ovary cell, borderline tumor" "Ovary cell, normal" +p_36668_2 "Ovary cell, carcinoma" "Ovary cell, normal" +p_36701_1 "Rectal colon biopsy, IBS-C (Constipation predominant IBS subjects)" "Rectal colon biopsy, healthy control" +p_36701_2 "Rectal colon biopsy, IBS-D (Constipation predominant IBS subjects)" "Rectal colon biopsy, healthy control" +p_36701_3 "Rectal colon biopsy, PIBD (post Campylobacter infection with IBS (within 6 months))" "Rectal colon biopsy, healthy control" +p_36701_4 "Rectal colon biopsy, PIBS (post infection IBS (unknown time point and organism))" "Rectal colon biopsy, healthy control" +p_36701_5 "Rectal colon biopsy, PINIBS (post Campylobacter infection with no resulting IBS)" "Rectal colon biopsy, healthy control" +p_36754_1 "Shef3 cell line, hESCs differentiating in the presence of FGF3 and 10, day 14" "Shef3 cell line, hESC" +p_36754_2 "H14 cell line, hESCs differentiating in the presence of FGF3 and 10, day 14" "H14 cell line, hESC" +p_36754_3 "Shef1 cell line, hESCs differentiating in the presence of FGF3 and 10, day 14" "Shef1 cell line, hESC" +p_36771_1 "Primary breast tumor, erstrogen receptor status: ER+" "Primary breast tumor, erstrogen receptor status: ER-" +p_36771_2 "Primary breast tumor, progesterone receptor status: PgR+" "Primary breast tumor, progesterone receptor status: PgR-" +p_36771_3 "Primary breast tumor, lymph node metastasis LN+" "Primary breast tumor, lymph node metastasis: LN-" +p_36771_4 "Primary breast tumor, Tumor histological grade: 3" "Primary breast tumor, Tumor histological grade: 2" +p_3678_1 thyroid containing tumor cells "human thyroid, control" +p_36809_1 "white blood cell, hours since injury<12h" "white blood cell, control" +p_36809_2 "white blood cell, 12h 1 arsenic exposure < 1 +p_8023_1 "AML1-ETO expressing cord blood cell, grown serum-free, CD34" "Cord blood cells, grown serum-free, CD34 purified" +p_8023_2 "AML1-ETO expressing cord blood cell, clone 13.2" Cord blood cells +p_8023_3 "AML1-ETO expressing cord blood cell, clone 9" Cord blood cells +p_8045_1 "A549 cells, siRNA targeting ALDH1A1+ALDH3A1 (Lenti 1+3 cells)" "A549 cells, control siRNA" +p_8045_2 "A549 cells, siRNA targeting ALDH1A1+ALDH3A1 (Lenti 1+3 cells)" "A549 cells, wild type" +p_8049_1 "GSf cell line, glioblastoma derived neurosphere cultures" "GSr cell line, glioblastoma derived neurosphere cultures" +p_8050_1 "RCC099 cell, tumor" "RCC099 cell, normal" +p_8050_2 "RCC110 cell, tumor" "RCC110 cell, normal" +p_8052_1 Asthma control +p_8056_1 "Burn wound margin of human skin, 0-3 days post-thermal injury" "Normal human skin, no thermal injury" +p_8056_2 "Burn wound margin of human skin, 4-7 days post-thermal injury" "Normal human skin, no thermal injury" +p_8056_3 "Burn wound margin of human skin, >7 days post-thermal injury" "Normal human skin, no thermal injury" +p_8059_1 "Natural killer cells, stimulated by IL2, 100IU/ml, 2h" "Natural Killer cells, heathy control" +p_8059_2 "Natural killer cells, stimulated by IL2, 100IU/ml, 8h" "Natural Killer cells, heathy control" +p_8059_3 "Natural killer cells, stimulated by IL2, 100IU/ml, 24h" "Natural Killer cells, heathy control" +p_8066_1 "SKNAS cell, NmycER expressed" "SKNAS cell, Control" +p_8066_10 "SHEP-21N, t=8 hrs; time course" "SHEP-21N, t=0" +p_8066_12 "SHEP-21N, t=120 hrs; time course" "SHEP-21N, t=0" +p_8066_3 "SHEP-21N cell, MYCN expressed" "SHEP-21N cell, control" +p_8066_4 "IMR32-DKK1 c63, t=24 hrs; time course" "IMR32-DKK1 c63, t=0" +p_8066_6 "IMR32-DKK1 c63, t=288 hrs; time course" "IMR32-DKK1 c63, t=0" +p_8066_7 "IMR32-DKK1 c66, t=24 hrs; time course" "IMR32-DKK1 c66, t=0" +p_8066_9 "IMR32-DKK1 c66, t=288 hrs; time course" "IMR32-DKK1 c66, t=0" +p_8121_1 Septic Shock 1 day Normal +p_8121_2 Septic Shock 3 day Normal +p_8140_1 "MCF7 cell, Fulv treated" "MCF7 cell, E2+G treated" +p_8140_2 "MCF7 cell, ED treated" "MCF7 cell, E2+G treated" +p_8140_3 "MCF7 cell, Tam+G treated" "MCF7 cell, E2+G treated" +p_8141_1 "MCF7, E2+G treated" "MCF7, Fulv treated" +p_8141_10 "MCF7/HER2-18, E2+G treated" "MCF7/HER2-18, E2 treated" +p_8141_11 "MCF7/HER2-18, ED+G treated" "MCF7/HER2-18, ED treated" +p_8141_12 "MCF7/HER2-18, Tam+G treated" "MCF7/HER2-18, Tam treated" +p_8141_13 "MCF7/HER2-18, E2+Tam treated" "MCF7/HER2-18, E2 treated" +p_8141_14 "MCF7/HER2-18, E2+Tam treated" "MCF7/HER2-18, Tam treated" +p_8141_2 "MCF7, ED treated" "MCF7, Fulv treated" +p_8141_3 "MCF7, Tam+G treated" "MCF7, Fulv treated" +p_8141_4 "MCF/HER2-18, late E2 treated" "MCF7/HER2-18, early E2 treated" +p_8141_5 "MCF7/HER2-18, res ED treated" "MCF7/HER2-18, sen ED treated" +p_8141_6 "MCF7/HER2-18, late E2+G treated" "MCF7/HER2-18, small E2+G treated" +p_8141_7 "MCF7/HER2-18, res ED+G treated" "MCF7/HER2-18, sen ED+G treated" +p_8141_8 "MCF7/HER2-18, late Tam treated" "MCF7/HER2-18, early Tam treated" +p_8141_9 "MCF7/HER2-18, res Tam+G treated" "MCF7/HER2-18, sen Tam+G treated" +p_8157_1 "skeletal muscle of PCOS, pioglitazone treated" "skeletal muscle of PCOS, pioglitazone not treated" +p_8157_2 "skeletal muscle of PCOS, pioglitazone not treated" "skeletal muscle, healthy control" +p_8157_3 "Muscle PCOS, case" "Muscle PCOS, control" +p_8166_1 HUVEC vs CAN34 3hr exposure ; time course HUVEC vs M199 3hr exposure (U133P2) +p_8166_2 HUVEC vs SC5314 3hr exposure ; time course HUVEC vs M199 3hr exposure (U133P2) +p_8166_3 HUVEC vs TNF -alpha 3hr ; time course HUVEC vs M199 3hr exposure (U133P2) +p_8166_4 HUVEC vs CAN34 8hr exposure ; time course HUVEC vs M199 3hr exposure (U133P2) +p_8166_5 HUVEC vs SC5314 8hr exposure ; time course HUVEC vs M199 3hr exposure (U133P2) +p_8166_6 HUVEC vs TNF -alpha 8hr ; time course HUVEC vs M199 3hr exposure (U133P2) +p_8167_1 Kit mutation GIST Kit wild type GIST +p_8192_10 "HeLa, shLuc-, 30min" "HeLa, shLuc-, 0min" +p_8192_13 "HeLa, shLuc-, 120min" "HeLa, shLuc-, 0min" +p_8192_15 "HeLa, shLuc+, 30min" "HeLa, shLuc+, 0min" +p_8192_18 "HeLa, shLuc+, 120min" "HeLa, shLuc+, 0min" +p_8192_2 "HeLa, shRHAU-,30min" "HeLa, shRHAU-, 0min" +p_8192_4 "HeLa, shRHAU-, 120 min" "HeLa, shRHAU-, 0min" +p_8192_6 "HeLa, shRHAU+, 30min" "HeLa, shRHAU+, 0min" +p_8192_8 "HeLa, shRHAU+, 120min" "HeLa, shRHAU+, 0min" +p_8289_1 "HEK293 cell line, induced HNF4a2 WT" "HEK293 cell line, noninduced HNF4a2 WT" +p_8289_2 "HEK293 cell line, induced HNF4a2 mutant C106R" "HEK293 cell line, noninduced HNF4a2 mutant C106R" +p_8289_3 "HEK293 cell line, induced HNF4a2 mutant R154X" "HEK293 cell line, noninduced HNF4a2 mutant R154X" +p_8302_1 "hepatocyte, WY14643 treated, 12h" "hepatocyte, control" +p_8316_1 human_hepatocytes_WY12h human_hepatocytes_control +p_8331_1 "Left ventricle myocytes, isolated from congestive heart failure patient" Left Ventricle Myocytes. isolated from high ejection fraction patient +p_8437_1 "HEK293 cells, Staufen2-HA (59kDa) over-expression" "HEK293 cells, mock-transfected" +p_8437_2 "HEK293 cells, Staufen2-HA (62kDa) over-expression" "HEK293 cells, mock-transfected" +p_8438_1 "HEK293 cells, Staufen1-HA over-expression" "HEK293 cells, mock-transfected" +p_8442_1 Angiotensin II Basal +p_8442_2 Angiotensin II Angiotensin II + cycloheximide +p_8471_1 "MCF-7 cell, heregulin, 2h" "MCF-7 cell, control" +p_8507_1 PMN_LB_180_min PMN_control_180_min +p_8507_2 PMN_LB_360_min PMN_control_360_min +p_8507_3 MO_LB_180_min MO_control_180_min +p_8514_1 Aldosterone-producing adenoma "adrenal gland, normal" +p_8527_1 "Detroit 562 cells, infected with D39WT" "Detroit 562 cells (Pharyngeal epithelial cells), uninfected" +p_8527_2 "Detroit 562 cells, infected with D39delta-cps" "Detroit 562 cells (Pharyngeal epithelial cells), uninfected" +p_8527_3 "Detroit 562 cells, infected with G54delta-cps" "Detroit 562 cells (Pharyngeal epithelial cells), uninfected" +p_8527_4 "Detroit 562 cells, infected with G54WT" "Detroit 562 cells (Pharyngeal epithelial cells), uninfected" +p_8527_5 "Detroit 562 cells, infected with TIGR4WT" "Detroit 562 cells (Pharyngeal epithelial cells), uninfected" +p_8527_6 "Detroit 562 cells, infected with TIGR4delta-cps" "Detroit 562 cells (Pharyngeal epithelial cells), uninfected" +p_8527_7 "Detroit 562 cells, infected with D39delta-cps_low" "Detroit 562 cells (Pharyngeal epithelial cells), uninfected" +p_8527_8 "Detroit 562 cells, infected with Type2cps" "Detroit 562 cells (Pharyngeal epithelial cells), uninfected" +p_8537_1 "T98G cells, G0 arrested" "T98G cells, actively growing" +p_8537_2 "T98G cells, G1 stage" "T98G cells, G0 arrested" +p_8537_3 "T98G cells, S phase" "T98G cells, G1 stage" +p_8545_1 "Small Airway, smoker" "Small Airway, non-smoker" +p_8545_2 "Small Airway, smoker with chronic obstructive pulmonary disease (COPD)" "Small Airway, non-smoker" +p_8565_1 "MCF-7 cells, bortezomib treated, 14h" "MCF-7 cells, untreated" +p_8565_3 "MCF-7 cells, bortezomib treated, 48h" "MCF-7 cells, untreated" +p_8565_4 "MCF-7 cells, Argyrin A treated, 12h" "MCF-7 cells, untreated" +p_8565_7 "MCF-7 cells, Argyrin A treated, 48h" "MCF-7 cells, untreated" +p_8581_1 "Lung, chronic obstructive pulmonary disease (COPD)" "Lung, control" +p_8586_1 "umbilical cord tissue, BPD (bronchopulmonary dysplasia), low gestational age" "umbilical cord tissue, no BPD (bronchopulmonary dysplasia), low gestational age" +p_8586_2 "umbilical cord tissue, BPD (bronchopulmonary dysplasia), high gestational age" "umbilical cord tissue, no BPD (bronchopulmonary dysplasia), high gestational age" +p_8588_1 "H295R cell, 2OHBDE47" "H295R cell, control" +p_8588_2 "H295R cell, 2OHBDE85" "H295R cell, control" +p_8597_1 "MCF7, CHE, E2 treated, 24h" "MCF7, E2 treated, 24h" +p_8597_2 "MCF7, CHE, EtOH treated, 24h" "MCF7, EtOH treated, 24h" +p_8597_3 MCF7_CHX_E2_24h MCF7_E2_24h +p_8597_4 MCF7_CHX_EtOH_24h MCF7_EtOH_24h +p_8608_1 "monocyte-derived macrophages, COPD patients, LPS treated" "monocyte-derived macrophages, COPD patients, untreated" +p_8608_2 humanMDM_Healthy_Particles humanMDM_Healthy_untreated +p_8615_1 "post ILI, ADH-1 4hr; time course" "post ILI, saline 4hr" +p_8615_2 "post ILI, ADH-1 24hr; time course" "post ILI, saline 24hr" +p_8615_3 "post ILI, ADH-1 48hr; time course" "post ILI, saline 48hr" +p_8640_1 "MCF7 cell, siRNA TFAP2A treated, Estrogen" "MCF7 cell, control, Estrogen" +p_8640_2 "MCF7 cell, siRNA TFAP2C treated, Estrogen" "MCF7 cell, control, Estrogen" +p_8640_3 "MCF7 cell, siRNA TFAP2A treated, noEstrogen" "MCF7 cell, control, noEstrogen" +p_8640_4 "MCF7 cell, siRNA TFAP2C treated, noEstrogen" "MCF7 cell, control, noEstrogen" +p_8640_5 MCF7_TFAP2AsiRNA_noEstrogen MCF7_nosiRNA_Estrogen +p_8646_1 "H1299 cells, TAp63 alpha 24h induction" "H1299 cells, TAp63 alpha 24h without induction" +p_8646_2 "H1299 cells, TAp63 alpha Q540L 24h induction" "H1299 cells, TAp63 alpha Q540L 24h without induction" +p_8646_3 TAp63 alpha Q540L 24h induction TAp63 alpha Q540L 24h without induction +p_8646_4 TAp63 alpha 24h induction TAp63 alpha 24h without induction +p_8658_1 "Monocyte derived dendritic cells, rosiglitazone (RSG) treated, 1uM, 6h" "Monocyte derived dendritic cells, vehicle treated, 6h" +p_8658_2 "Monocyte derived dendritic cells, cultured in human AB serum, 6h" "Monocyte derived dendritic cells, vehicle treated, 6h" +p_8658_3 "Monocyte derived dendritic cells, rosiglitazone (RSG) treated, 1uM, 5d" "Monocyte derived dendritic cells, vehicle treated, 5d" +p_8658_4 "Monocyte derived dendritic cells, cultured in human AB serum, 5d" "Monocyte derived dendritic cells, vehicle treated, 5d" +p_8658_5 5d DC RSG 5d DC +p_8658_6 5d DC HS 5d DC +p_8665_1 UET-13TR-EWS/FLI1 24hr tet+; time course UET-13TR-EWS/FLI1 24hr +p_8665_2 UET-13TR-EWS/FLI1 48hr tet+; time course UET-13TR-EWS/FLI1 48hr +p_8665_3 UET-13TR-EWS/FLI1 72hr tet+; time course UET-13TR-EWS/FLI1 72hr +p_8665_4 UET-13TR-EWS/ERG 24hr tet+; time course UET-13TR-EWS/ERG 24hr +p_8665_5 UET-13TR-EWS/ERG 48hr tet+; time course UET-13TR-EWS/ERG 48hr +p_8665_6 UET-13TR-EWS/ERG 72hr tet+; time course UET-13TR-EWS/ERG 72hr +p_8668_1 "Neutrophils, after 30min bout of exercise" "Neutrophils, before exercise" +p_8671_1 Colorectal adenoma Normal mucosa of the colon +p_8685_1 "Sez-4 cells, starved of IL-2, activated with IL-2" "Sez-4 cells, starved of IL-2" +p_8685_2 "Sez-4 cells, starved of IL-2, activated with IL-15" "Sez-4 cells, starved of IL-2" +p_8685_3 "Sez-4 cells, starved of IL-2, activated with IL-21" "Sez-4 cells, starved of IL-2" +p_8687_1 "Sez-4 cell line, starved of IL-2, activated with IL-2" "Sez-4 cell line, starved of IL-2" +p_8687_2 "Sez-4 cell line, starved of IL-2, pre-treated with pan-Jak inhibitor, activated with IL-2" "Sez-4 cell line, starved of IL-2" +p_8687_3 "Sez-4 cell line, starved of IL-2, pre-treated with Jak3 inhibitor, activated with IL-2" "Sez-4 cell line, starved of IL-2" +p_8699_1 "HUVEC, co-cultured with 1205Lu melanoma cells, RFP-labeled" "HUVEC, grown alone, RFP-labeled" +p_8699_2 "1205Lu melanoma cells, co-cultured with HUVEC cells, GFP-labeled" "1205Lu melanoma cells, grown alone, GFP-labeled" +p_8702_3 LNCaP_AndrogenDeprived_5month LNCaP_Control_5month +p_8702_4 LNCaP_AndrogenDeprived_12month LNCaP_Control_12month +p_8702_5 LNCaP_AndrogenDeprived_11month LNCaP_Control_12month +p_8717_1 90-8_Infect 90-8_Mock +p_8717_2 S462_Infect S462_Mock +p_8717_3 malignant peripheral nerve sheath tumor (MPNST) 26T cells infected with G207 and oncolytic HSV 26T_Mock +p_8717_4 T265_Infect T265_Mock +p_8730_1 1h TGF-beta treated odontoblasts; time course 1h -TGF-beta odontoblasts +p_8730_2 24h TGF-beta treated odontoblasts; time course 24h -TGF-beta odontoblasts +p_8742_1 "SK-MEL-5 cells, PEP008 treated, 24h" "SK-MEL-5 cells, mock treated, control" +p_8742_2 "SK-MEL-5 cells, PEP008 treated 24h+drug removed+ recovery of drug at 72h" "SK-MEL-5 cells, mock treated, control" +p_8742_3 "MCF7 cells, PEP008 treated, 24h" "MCF7 cells, mock treated, control" +p_8742_4 "MCF7 cells, PEP008 treated 24h+drug removed+ recovery of drug at 72h" "MCF7 cells, mock treated, control" +p_8742_5 "COLO-205 cells, PEP008 treated, 24h" "COLO-205 cells, mock treated, control" +p_8742_6 "COLO-205 cells, PEP008 treated 24h+drug removed+ recovery of drug at 72h" "COLO-205 cells, mock treated, control" +p_8742_7 "SK-MEL-5 cells, TPA treated, 24h" "SK-MEL-5 cells, mock treated, control" +p_8762_1 lymphocytes_HD_F lymphocytes_ctl_F +p_8762_2 lymphocytes_HD_M lymphocytes_ctl_M +p_8764_1 "Parotid people, female" "Parotid people, male" +p_8764_2 "Parotid, female" "Parotid, male" +p_8772_1 "melanoma cells, KINK-1, 12hrs" "melanoma cells, control" +p_8772_2 "melanoma cells, KINK-1, 24hrs" "melanoma cells, control" +p_8784_1 "HeLa cells, induced with doxycycline+exposed to TNF-alpha (40ng/ml)" "HeLa cells, no doxycycline" +p_8784_2 "HeLa cells bearing the delta CS construct , induced with doxycycline+exposed to TNF-alpha (40ng/ml)" "HeLa cells, no doxycycline" +p_8823_1 "alveolar macrophage, smoker" "alveolar macrophage, non-smoker" +p_8832_1 "K562 cells, 1R-Chl treated, 250nM, 24h" "K562 cells, no treatment control, 24h" +p_8837_1 "normal human bronchial epithelial (NHBE) , siRhoBTG2.1" "normal human bronchial epithelial (NHBE) , siCyclophilin" +p_8837_2 "normal human bronchial epithelial (NHBE) , siRhoBTG2.1" "normal human bronchial epithelial (NHBE) , Lamin" +p_8837_3 "normal human bronchial epithelial (NHBE) , siRhoBTG2.2" "normal human bronchial epithelial (NHBE) , sicyclophilin" +p_8837_4 "normal human bronchial epithelial (NHBE) , siRhoBTG2.2" "normal human bronchial epithelial (NHBE) , Lamin" +p_8840_1 alveolar rhabdomyosarcoma cell line embryonal rhabdomyosarcoma cell line +p_8853_1 "Esophageal cell, IL-13 treated" "Esophageal cell, control" +p_8866_1 "IMR-32 cells, ccnd1 siRNA transfected, 48hr" "IMR-32 cells, 0hr" +p_8866_2 "IMR-32 cells, cdk siRNA transfected, 48hr" "IMR-32 cells, 0hr" +p_8866_3 "IMR-32 cells, ccnd1 siRNA transfected, 48hr" "IMR-32 cells, GFP siRNA transfected, 48hr" +p_8866_4 "IMR-32 cells, cdk siRNA transfected, 48hr" "IMR-32 cells, GFP siRNA transfected, 48hr" +p_8928_1 "MonoMac6 cell line, stimulated with leukotriene" "MonoMac6 cell line, unstimulated" +p_8928_2 "MonoMac6 cell line, stimulated with lipoxin A4" "MonoMac6 cell line, unstimulated" +p_8928_3 "MonoMac6, lipoxin A4" "MonoMac6, unstimulated" +p_8928_4 "MonoMac6, lipoxin B4" "MonoMac6, unstimulated" +p_8961_1 "A549 cell, hMPV infected, 6h" "A549 cell, control" +p_8961_2 "A549 cell, hMPV infected, 12h" "A549 cell, control" +p_8961_3 "A549 cell, hMPV infected, 24h" "A549 cell, control" +p_8961_4 "A549 cell, hMPV infected, 48h" "A549 cell, control" +p_8961_5 "A549 cell, hMPV infected, 72h" "A549 cell, control" +p_8977_1 Stroma tumor Stroma normal breast +p_9008_1 "A549, 25 mM resveratrol, 48 h" "A549 cell, ethanol control, 48 h" +p_9031_1 Lymphoma cell line Myeloma cell line +p_9031_2 Mantle cell lymphoma Myeloma +p_9055_16 "HUVEC, TNFa treated, 4h00m" "HUVEC, TNFa treated, 0h00m" +p_9055_2 "HUVEC, TNFa treated, 0h30m" "HUVEC, TNFa treated, 0h00m" +p_9055_24 "HUVEC, TNFa treated, 8h00m" "HUVEC, TNFa treated, 0h00m" +p_9055_8 "HUVEC, TNFa treated, 2h00m" "HUVEC, TNFa treated, 0h00m" +p_9077_1 "TERT5-71, TERT transfected" "TIG-1-45, parent" +p_9093_1 "MCF-7 cells, transfected with pIRES-TGFBR1*6A-HA-FLAG (6A-SA5)" "MCF-7 cells, transfected with pIRES-TGFBR1-HA-FLAG (WT-WB1)" +p_9101_1 "Human THP-1 macrophages, stimulated with HDL" "Human THP-1 macrophages, unstimulated" +p_9101_2 "Human THP-1 macrophages, stimulated with VLDL" "Human THP-1 macrophages, unstimulated" +p_9101_3 "Human THP-1 macrophages, stimulated with LDL" "Human THP-1 macrophages, unstimulated" +p_9103_1 "Vastus Lateralis muscle,old trained subject" "Vastus Lateralis muscle,old sedentary subject" +p_9103_2 "Vastus Lateralis muscle,young trained subject" "Vastus Lateralis muscle,young sedentary subject" +p_9103_3 Old trained subject Young trained subject +p_9103_4 Old sedentary subject Young sedentary subject +p_9119_1 "Primary peripheral blood B cell, antiIgM, 1hr" Primary peripheral blood B cell +p_9119_2 "Primary peripheral blood B cell, antiIgM, 3hr" Primary peripheral blood B cell +p_9150_1 "nasal epithelial cells, house dust mite exposed, 24h" "nasal epithelial cells, saline exposed, 24h, control" +p_9150_2 "Control, house dust mite" "Control, saline" +p_9150_3 "Allergic, house dust mite" "Control, house dust mite" +p_9150_4 "Allergic, saline" "Control, saline" +p_9151_1 "epithelial cell line, house dust mite exposed, 24h" "epithelial cell line, saline exposed, 24h" +p_9159_1 Myometrium_term no labor Myometrium_term labor +p_9159_2 Myometrium_preterm no labor Myometrium_preterm labor +p_9169_12 "SH-SY5Y(ECACC) cell, RA treated, 5d" "SH-SY5Y(ECACC) cell, RA inhibited, 5d" +p_9169_13 "SH-SY5Y(ECACC) cell, BDNF treated, 6h" "SH-SY5Y(ECACC) cell, RA treated, 6h" +p_9169_16 "SH-SY5Y(ECACC) cell, BDNF treated, 3d" "SH-SY5Y(ECACC) cell, RA treated, 3d" +p_9169_17 "SK-N-SH cell, BDNF treated, 6h" "SK-N-SH cell, RA treated, 6h" +p_9169_2 "SH-SY5Y(ATCC) cell, RA treated, 6h" "SH-SY5Y(ATCC) cell, RA inhibited, 6h" +p_9169_20 "SK-N-SH cell, BDNF treated, 3d" "SK-N-SH cell, RA treated, 3d" +p_9169_6 "SH-SY5Y(ATCC) cell, RA treated, 5d" "SH-SY5Y(ATCC) cell, RA inhibited, 5d" +p_9169_8 "SH-SY5Y(ECACC) cell, RA treated, 6h" "SH-SY5Y(ECACC) cell, RA inhibited, 6h" +p_9195_1 PgR+ breast cancer PgR- breast cancer +p_9195_2 Node + breast cancer Node - breast cancer +p_9196_1 H1 undifferentiated embryonic stem cells bulk normal breast or normal breast organoid +p_9196_10 H9 undifferentiated embryonic stem cells "CD31+ cell, normal prostate, endothelial study" +p_9196_11 H9 day3.5 embryoid bodies "CD31+ cell, normal prostate, endothelial study" +p_9196_12 H9 blast cells "CD31+ cell, normal prostate, endothelial study" +p_9196_13 H1 undifferentiated embryonic stem cells "CD49a+ cell, normal prostate, stromal study" +p_9196_14 H1 day3.5 embryoid bodies "CD49a+ cell, normal prostate, stromal study" +p_9196_15 H1 blast cells "CD49a+ cell, normal prostate, stromal study" +p_9196_16 H9 undifferentiated embryonic stem cells "CD49a+ cell, normal prostate, stromal study" +p_9196_17 H9 day3.5 embryoid bodies "CD49a+ cell, normal prostate, stromal study" +p_9196_18 H9 blast cells "CD49a+ cell, normal prostate, stromal study" +p_9196_19 H1 undifferentiated embryonic stem cells "whole blood, leukocyte study" +p_9196_2 H1 day3.5 embryoid bodies bulk normal breast or normal breast organoid +p_9196_20 H1 day3.5 embryoid bodies "whole blood, leukocyte study" +p_9196_21 H1 blast cells "whole blood, leukocyte study" +p_9196_22 H9 undifferentiated embryonic stem cells "whole blood, leukocyte study" +p_9196_23 H9 day3.5 embryoid bodies "whole blood, leukocyte study" +p_9196_24 H9 blast cells "whole blood, leukocyte study" +p_9196_3 H1 blast cells bulk normal breast or normal breast organoid +p_9196_4 H9 undifferentiated embryonic stem cells bulk normal breast or normal breast organoid +p_9196_5 H9 day3.5 embryoid bodies bulk normal breast or normal breast organoid +p_9196_6 H9 blast cells bulk normal breast or normal breast organoid +p_9196_7 H1 undifferentiated embryonic stem cells "CD31+ cell, normal prostate, endothelial study" +p_9196_8 H1 day3.5 embryoid bodies "CD31+ cell, normal prostate, endothelial study" +p_9196_9 H1 blast cells "CD31+ cell, normal prostate, endothelial study" +p_9200_1 Glioblastoma tumor Glioblastoma cell line +p_9212_1 "Lung cell, PAX9 overexpressed" "Lung cell, control" +p_9212_2 "Lung cell, TTF1 overexpressed" "Lung cell, control" +p_9212_3 "Lung cell, NKX2-8 overexpressed" "Lung cell, control" +p_9234_1 "HT29 cell lines, hypoxia" "HT29 cell lines, normoxia" +p_9250_1 "chronic lymphocytic leukemia (CLL), 13q deletion" "chronic lymphocytic leukemia (CLL), no 13q deletion" +p_9253_1 "MCF7 cells, 17beta-estradiol (E2) treated" "MCF7 cells, EtOH treated, control" +p_9254_1 "Colorectal mucosa, Ascending segment" "Colorectal mucosa, Cecum" +p_9254_2 "Colorectal mucosa, Transverse segment" "Colorectal mucosa, Cecum" +p_9254_3 "Colorectal mucosa, Sigmoid" "Colorectal mucosa, Cecum" +p_9254_4 "Colorectal mucosa, Rectum" "Colorectal mucosa, Cecum" +p_9254_5 "Colorectal mucosa, Distal part" "Colorectal mucosa, Proximal part" +p_9264_1 "Human embryonic kidney cell, miR-155" "Human embryonic kidney cell, control" +p_9264_2 "Human embryonic kidney cell, miR-K12-11" "Human embryonic kidney cell, control" +p_9339_1 "SJNB8-MSX1 cells(clone K5) , 24h" "SJNB8-MSX1 cells(clone K5) , 0h" +p_9339_2 "SJNB8-MSX1 cells(clone K5) , 48h" "SJNB8-MSX1 cells(clone K5) , 0h" +p_9339_3 "SJNB8-MSX1 cells(clone K5) , 192h" "SJNB8-MSX1 cells(clone K5) , 0h" +p_9348_1 early stage CRC patient's tumor healthy control +p_9350_1 "FG cell, hypoxic, control" "FG cell, normoxic, control" +p_9350_2 "L3.6pl cell, hypoxic, control" "L3.6pl cell, normoxic, control" +p_9361_1 "HEK293 cells, StarPap specific siRNA" "HEK293 cells, control siRNA" +p_9361_2 "HEK293 cells, PIPKIalpha specific siRNA" "HEK293 cells, control siRNA" +p_9390_1 "CD14+ cell, cultured in conditioned medium (collected from HS5), 48h" "CD14+ cells, freshly isolated" +p_9390_2 "CD14+ cell, cultured in conditioned medium (collected from HS27a), 48h" "CD14+ cells, freshly isolated" +p_9419_1 "vastus lateralis, old protein 0.50g/kg" "vastus lateralis, young protein 0.50g/kg" +p_9419_2 "vastus lateralis, old protein 0.75g/kg" "vastus lateralis, young protein 0.75g/kg" +p_9419_3 "vastus lateralis, old protein 1.00g/kg" "vastus lateralis, young protein 1.00g/kg" +p_9437_1 "human B-LCL cell line, TAP1/2 +/+ (TAP expressing)" "human B-LCL cell line, TAP1/2 -/- (TAP deficient )" +p_9438_1 "Brain meningioma cell, ER treated" "Brain meningioma cell, control" +p_9438_2 "Brain meningioma cell, PR treated" "Brain meningioma cell, control" +p_9438_3 "Brain meningioma cell, PR,ER treated" "Brain meningioma cell, control" +p_9440_1 hES-T3 derived embryoid bodies Human embryonic stem cell line T3ES +p_9440_2 Human fibroblast-like cells Human embryonic stem cell line T3ES +p_9451_1 chondrocyte adipocyte +p_9451_10 fibroblast iliac MSC +p_9451_2 osteoblast adipocyte +p_9451_3 iliac MSC adipocyte +p_9451_4 fibroblast adipocyte +p_9451_5 osteoblast chondrocyte +p_9451_6 iliac MSC chondrocyte +p_9451_7 fibroblast chondrocyte +p_9451_8 iliac MSC osteoblast +p_9451_9 fibroblast osteoblast +p_9452_1 "Ulcerative colitis patient, descending colon, macroscopic inflammation vissible" "Colonic mucosal endoscopic pinch biopsy, Ulcerative colitis patient, no macroscopic signs of inflammation" +p_9452_2 UC smaples without macroscopic signs of inflammation control subjects +p_9481_1 "Overian cancer, IFN-alpha treated Side Population" "Ovarian cancer, untreated Side Population" +p_9489_1 "renal graft, AR IA" "kidney, control" +p_9489_10 "renal graft, CAN I" "kidney, control" +p_9489_11 "renal graft, CAN II" "kidney, control" +p_9489_12 "renal graft, CAN III" "kidney, control" +p_9489_13 "renal graft, non-rejecting" "kidney, control" +p_9489_14 "renal graft, AR & CAN" "kidney, control" +p_9489_2 "renal graft, AR IB" "kidney, control" +p_9489_3 "renal graft, AR & CAN" "renal graft, AR" +p_9489_4 "renal graft, AR & CAN" "renal graft, CAN" +p_9489_5 "kidney, without clamping" "kidney, with clamping" +p_9489_6 "kidney, cortex & medulla" "kidney, cortex" +p_9489_7 "renal graft, AR IIA" "kidney, control" +p_9489_8 "renal graft, AR IIB" "kidney, control" +p_9489_9 "renal graft, borderline changes" "kidney, control" +p_9492_1 "Chronic allograft nephropathy biopsy, grade I" "adult kidney sample, control" +p_9492_2 "Chronic allograft nephropathy biopsy, grade I" Biopsy from non-rejecting human kidney allograft +p_9517_1 "HepG2/C3A cells, cys depletion followed by 6 h +Cys (Short +Cys)" "HepG2/C3A cells, cysteine depletion for 42 h (long -Cys)" +p_9517_2 "HepG2/C3A cells, complete medium followed by 6 h of cysteine deprivation (Short -Cys)" "HepG2/C3A cells, control medium for 42 h (Long +Cys)" +p_9520_1 "human MSC, grown for 7 days, passage2" "human MSC, grown for 2 days, passage2" +p_9526_1 "cumulus cells, late cleavage" "cumulus cells, early cleavage" +p_9576_1 Scraped off mucosal layer Normal Ileum Mucosa +p_9576_2 Midgut carinoid Liver Metastasis Midgut carinoid primary tumor +p_9593_1 "BM-mesenchymal stem cells (MSC), passage 3" "BM-mesenchymal stem cells (MSC), passage 2" +p_9593_2 "BM-mesenchymal stem cells (MSC), passage 4" "BM-mesenchymal stem cells (MSC), passage 2" +p_9593_3 "BM-mesenchymal stem cells (MSC), passage 5" "BM-mesenchymal stem cells (MSC), passage 2" +p_9593_4 "BM-mesenchymal stem cells (MSC), passage 6" "BM-mesenchymal stem cells (MSC), passage 2" +p_9593_5 "BM-mesenchymal stem cells (MSC), passage 7" "BM-mesenchymal stem cells (MSC), passage 2" +p_9593_6 "BM-mesenchymal stem cells (MSC), passage 8" "BM-mesenchymal stem cells (MSC), passage 2" +p_9593_7 "BM-mesenchymal stem cells (MSC), passage 10" "BM-mesenchymal stem cells (MSC), passage 2" +p_9599_1 "pancreatic tumor, resistant to EGFR" "pancreatic tumor, sensitive to EGFR" +p_9600_1 "FFPE cell, normal adjacent epithelia" "FFPE cell, HNSCC" +p_9600_2 "FFPE cell, HNSCC, radiation, treated" "FFPE cell, HNSCC" +p_9600_3 "FFPE cell, HNSCC, radiation, cetuximab treated" "FFPE cell, HNSCC" +p_9600_4 "FFPE cell, HNSCC, radiation, cetuximab treated, AMG 479 treated" "FFPE cell, HNSCC" +p_9613_1 HeLa CTCF RNAi HeLa Control RNAi +p_9613_2 HeLa hScc1 RNAi HeLa Control RNAi +p_9624_1 "Omental adipose tissue, obese" "Omental adipose tissue, control" +p_9647_1 "HUVEC, exposed to dp3.9 apple procyanidins extract, 4h" "HUVEC, DMSO treated, 4h, control" +p_9647_2 "HUVEC, exposed to dp3.9 apple procyanidins extract+TNF-¥á treated, 4h" "HUVEC, DMSO+TNF-¥á treated, 6h, control" +p_9647_3 HUVEC_DMSO+TNF _6h HUVEC_DMSO_4h +p_9649_1 "Human Mammary Epithelial Cell, media with 25mM lactic acidosis, normoxia" "Human Mammary Epithelial Cell, normoxia, control media" +p_9649_2 "Human Mammary Epithelial Cell, hypoxia" "Human Mammary Epithelial Cell, normoxia, control media" +p_9649_3 "Human Mammary Epithelial Cell, media with 25mM lactic acidosis, hypoxia" "Human Mammary Epithelial Cell, hypoxia, control media" +p_9649_4 "Human Mammary Epithelial Cell, media with 25mM sodium lactate, normoxia" "Human Mammary Epithelial Cell, normoxia, control media" +p_9649_5 "Human Mammary Epithelial Cell, acidosis media, normoxia" "Human Mammary Epithelial Cell, normoxia, control media" +p_9666_1 "LNCaP cells, Androgen independent-fiber model" "LNCaP cells, Androgen dependent-fiber model" +p_9666_2 "LNCaP cells, Androgen ablation-fiber model" "LNCaP cells, Androgen dependent-fiber model" +p_9677_1 "HUVEC, stimulated with Angiopoietin, 1h" "HUVEC, unstimulated" +p_9677_2 Angiopoietin-1(sparse) unstimulated(sparse) +p_9686_1 Crohn Disease Colon Normal Colon +p_9686_2 Treated Crohn Disease Colon Normal Colon +p_9686_3 Ulcerative Colitis Colon Normal Colon +p_9692_1 Septic Shock Control +p_9709_1 "Human iPSC, cultured in mTeSR1" Human neonatal dermal fibroblast +p_9709_2 "Human iPSC, cultured in MEF" Human neonatal dermal fibroblast +p_9709_3 "Human iPSC, cultured in ESM" Human neonatal dermal fibroblast +p_9709_4 "Human iPSC, cultured in mTeSR1, freeze-thaw treated" Human neonatal dermal fibroblast +p_9709_5 Human induced pluripotent stem cell clone 2-4 cultured in mTeSR1 on Matrigel Human neonatal dermal fibroblast +p_9709_6 Human induced pluripotent stem cell clone 2-4 cultured in ESM on MEF Human neonatal dermal fibroblast +p_9709_7 Human induced pluripotent stem cell clone 3-2 cultured in mTeSR1 on Matrigel Human neonatal dermal fibroblast +p_9731_1 "Vasectomised epididimus, 45 years-old, corpus segment" "Vasectomised epididimus, 1980, corpus segment" +p_9731_2 "Vasectomised epididimus, 47 years-old, corpus segment" "Vasectomised epididimus, 1980, corpus segment" +p_9731_3 "Vasectomised epididimus, 45 years-old, caput segment" "Vasectomised epididimus, 1980, caput segment" +p_9731_4 "Vasectomised epididimus, 47 years-old, caput segment" "Vasectomised epididimus, 1980, caput segment" +p_9731_5 "Vasectomised epididimus, 45 years-old, cauda segment" "Vasectomised epididimus, 1980, cauda segment" +p_9731_6 "Vasectomised epididimus, 47 years-old, cauda segment" "Vasectomised epididimus, 1980, cauda segment" +p_9747_1 "MDA-MB-231 cells, vector containing PARVB, 2D, bovine type I collagen" "MDA-MB-231 cells, vector control, 2D, bovine type I collagen" +p_9747_2 "MDA-MB-231 cells, vector containing PARVB, 3D, 40% Matrigel" "MDA-MB-231 cells, vector control, 3D, 40% Matrigel" +p_9747_3 "MDA-MB-231 cells, vector containing PARVB, 3D, bovine type I collagen" "MDA-MB-231 cells, vector control, 3D, bovine type I collagen" +p_9757_1 "MDA-MB-231 cells, Era infected" "MDA-MB-231 cells, CMV infected" +p_9758_1 "MDA-MB-231 cells, Era3411 infected" "MDA-MB-231 cells, CMV infected" +p_9759_1 "MDA-MB-231 cells, infected with recombinant adenovirus bearing cDNA for ERbeta" "MDA-MB-231 cells, infected with the recombinant adenovirus bearing no cDNA (CMV)" +p_9759_2 "MDA-MB-231 cells, infected with recombinant adenovirus bearing cDNA for ERbeta mutant defective in" "MDA-MB-231 cells, infected with the recombinant adenovirus bearing no cDNA (CMV)" +p_9762_1 "fibroblast, trisomy 21 fibroblast" "fibroblast, eupliod fibroblast" +p_9762_2 monosomy 21 cells control cells +p_9764_1 "hMSCs, exposed to 5-Azacytidine" "hMSC, control DMEM media" +p_9764_2 "hMSCs, exposed to breast cancer condition media" "hMSC, control DMEM media" +p_9764_3 "hMSCs, exposed to 5-Azacytidine" "hMSCs, control alpha MEM media" +p_9764_4 "hMSCs, exposed to breast cancer condition media" "hMSCs, control alpha MEM media" +p_9768_1 "CP-A hTERT Barrett's oesophagus cell line, deoxycholic acid pH 4.5, 2h" "CP-A hTERT Barrett's oesophagus cell line, control" +p_9768_2 "CP-A hTERT Barrett's oesophagus cell line, deoxycholic acid pH 4.5, 6h" "CP-A hTERT Barrett's oesophagus cell line, control" +p_9768_3 "CP-A hTERT Barrett's oesophagus cell line, primary bile mixture pH 4.5, 2h" "CP-A hTERT Barrett's oesophagus cell line, control" +p_9768_4 "CP-A hTERT Barrett's oesophagus cell line, primary bile mixture pH 4.5, 6h" "CP-A hTERT Barrett's oesophagus cell line, control" +p_9768_5 "CP-A hTERT Barrett's oesophagus cell line, acid pH 4.5, 2h" "CP-A hTERT Barrett's oesophagus cell line, control" +p_9768_6 "CP-A hTERT Barrett's oesophagus cell line, acid pH 4.5, 6h" "CP-A hTERT Barrett's oesophagus cell line, control" +p_9770_1 "hippocampus, non-demented individual with intermediate Alzheimer's pathologies" "entorhinal cortex, non-demented individual with intermediate Alzheimer's pathologies" +p_9770_10 "posterior cingulate cortex, non-demented individual with intermediate Alzheimer's pathologies" "middle temporal gyrus, non-demented individual with intermediate Alzheimer's pathologies" +p_9770_11 "primary visual cortex, non-demented individual with intermediate Alzheimer's pathologies" "middle temporal gyrus, non-demented individual with intermediate Alzheimer's pathologies" +p_9770_12 "superior frontal gyrus, non-demented individual with intermediate Alzheimer's pathologies" "middle temporal gyrus, non-demented individual with intermediate Alzheimer's pathologies" +p_9770_13 "primary visual cortex, non-demented individual with intermediate Alzheimer's pathologies" "posterior cingulate cortex, non-demented individual with intermediate Alzheimer's pathologies" +p_9770_14 "superior frontal gyrus, non-demented individual with intermediate Alzheimer's pathologies" "posterior cingulate cortex, non-demented individual with intermediate Alzheimer's pathologies" +p_9770_15 "superior frontal gyrus, non-demented individual with intermediate Alzheimer's pathologies" "primary visual cortex, non-demented individual with intermediate Alzheimer's pathologies" +p_9770_2 "middle temporal gyrus, non-demented individual with intermediate Alzheimer's pathologies" "entorhinal cortex, non-demented individual with intermediate Alzheimer's pathologies" +p_9770_3 "posterior cingulate cortex, non-demented individual with intermediate Alzheimer's pathologies" "entorhinal cortex, non-demented individual with intermediate Alzheimer's pathologies" +p_9770_4 "superior frontal gyrus, non-demented individual with intermediate Alzheimer's pathologies" "entorhinal cortex, non-demented individual with intermediate Alzheimer's pathologies" +p_9770_5 "primary visual cortex, non-demented individual with intermediate Alzheimer's pathologies" "entorhinal cortex, non-demented individual with intermediate Alzheimer's pathologies" +p_9770_6 "middle temporal gyrus, non-demented individual with intermediate Alzheimer's pathologies" "hippocampus, non-demented individual with intermediate Alzheimer's pathologies" +p_9770_7 "posterior cingulate cortex, non-demented individual with intermediate Alzheimer's pathologies" "hippocampus, non-demented individual with intermediate Alzheimer's pathologies" +p_9770_8 "primary visual cortex, non-demented individual with intermediate Alzheimer's pathologies" "hippocampus, non-demented individual with intermediate Alzheimer's pathologies" +p_9770_9 "superior frontal gyrus, non-demented individual with intermediate Alzheimer's pathologies" "hippocampus, non-demented individual with intermediate Alzheimer's pathologies" +p_9807_1 "SH-SY5Y cells, siRNA targeting SNCA" "SH-SY5Y cells, control siRNA" +p_9826_1 compound A 1 hr; time course control 1 hr +p_9826_12 compound B 6 hr; time course control 6 hr +p_9826_6 compound A 6 hr; time course control 6 hr +p_9826_7 compound B 1 hr; time course control 1 hr +p_9832_1 dH1f - iPS dH1f fibroblast +p_9832_2 dH1f - iPS H1-OGN hES +p_9832_3 MRC5 - iPS MRC5 fibroblast +p_9832_4 MRC5 - iPS H1-OGN hES +p_9832_5 BJ1 - iPS BJ1 fibroblast +p_9832_6 BJ1 - iPS H1-OGN hES +p_9834_1 "Normal Human Astrocytes (NHA), Baculoviral Vector Transduction" "Normal Human Astrocytes (NHA), control" +p_9835_1 "neuronal cells, Baculoviral Vector Transduction" "neuronal cells, control" +p_9843_1 TP53 mutation + HCC TP53 mutation - HCC +p_9843_2 CTNNB1 mutation + HCC CTNNB1 mutation - HCC +p_9843_3 pRPS56 + HCC pRPS56 - HCC +p_9843_4 pIGFR1 + HCC pIGFR1 - HCC +p_9843_5 pAkT + HCC pAkT - HCC +p_9843_6 CTNNB1 + HCC CTNNB1 - HCC +p_9844_1 Oral Tongue Squamous Cell Carcinoma Tongue Squamous Cells from control subjects +p_9865_1 Human Embryonic Stem Cells passage 49 HSF1 Human embryonic stem cell line H9 +p_9865_10 Partially reprgrammed clone Hips24 Human embryonic stem cell line H9 +p_9865_11 Partially reprogrammed clone Clone100 Human embryonic stem cell line H9 +p_9865_12 Partially reprogrammed clone Hips29 Human embryonic stem cell line H9 +p_9865_2 Human embryonic stem cell line H9 Fibroblasts with GFP virus NHDF1 + GFP +p_9865_3 Human embryonic stem cell line H9 Fibroblasts NHDF1 +p_9865_4 Reprogrammed clone Hips1 Human embryonic stem cell line H9 +p_9865_5 Fibroblasts and 5 factors after 18 days NHDF1 +5V Human embryonic stem cell line H9 +p_9865_6 Reprogrammed clone 5 hips5 Human embryonic stem cell line H9 +p_9865_7 Reprogrammed clone 2 Hips2 Human embryonic stem cell line H9 +p_9865_8 Reprogrammed clone 7 Hips7 Human embryonic stem cell line H9 +p_9865_9 Reprogrammed Clone54 Human embryonic stem cell line H9 +p_9890_1 "Carcinoma of ovary, stroma" "Carcinoma of ovary, epithelial cell" +p_9894_1 CD235a+ cells bone marrow MSC +p_9894_2 CD11b+ cells bone marrow MSC +p_9894_3 CD45+ cells bone marrow MSC +p_9916_1 "Human Mononuclear cell, Heat shock treated" "Human Mononuclear cell, control" +p_9916_2 "Human Mononuclear cell, LPS treated" "Human Mononuclear cell, control" +p_9916_3 "Human Mononuclear cell, Heat shock, LPS treated" "Human Mononuclear cell, control" +p_9927_1 "CD4+ T-cells, HIV+ donor" "CD4+ T-cells, normal HIV- donor" +p_9940_1 "hESC, H9 derived day 6 EBs pool from H9p27, H9p28, H9p31" "a pool of hESCs from H9p27, H9p28, H9p31" +p_9940_2 H9 hES cell derived day 10 primitive neural epithelial pool "a pool of hESCs from H9p27, H9p28, H9p31" +p_9940_3 "H9 hES cell derived day 10 primitive neural epithelial pool, treated with bFGF" "a pool of hESCs from H9p27, H9p28, H9p31" +p_9940_4 H9 hES cell derived day 17 definitive neural epithelial pool "a pool of hESCs from H9p27, H9p28, H9p31" +p_9940_5 "H9 hES cell derived day 17 primitive neural epithelial pool, treated with bFGF" "a pool of hESCs from H9p27, H9p28, H9p31" +p_9941_2 "transduced hMSC with lentivirus, low signal" "hMSC, control" +p_9947_3 "transduced hMSC with lentivirus, high signal" "hMSC, control" +p_9951_1 "Prostate tissue,exposed to Cadmium, 2.5uM, 0h" "Prostate tissue, control, 0h" +p_9951_2 "Prostate tissue, exposed to Cadmium, 2.5uM, 4h" "Prostate tissue, control, 4h" +p_9951_3 "Prostate tissue,exposed to Cadmium, 2.5uM, 8h" "Prostate tissue, control, 8h" +p_9951_4 "Prostate tissue,exposed to Cadmium, 2.5uM, 16h" "Prostate tissue, control, 16h" +p_9951_5 "Prostate tissue,exposed to Cadmium, 2.5uM, 32h" "Prostate tissue, control, 32h" +p_9960_1 "Circulating mononuclear cells, Spesis" "Circulating mononuclear cells, control" +p_9960_2 "Circulating mononuclear cells, Spesis, Gram-negative" "Circulating mononuclear cells, Spesis, Gram-positive" +p_9960_3 "critically ill patients, sepsis gram-negative" "critically ill patients, control" +p_9960_4 "critically ill patients, sepsis mixed infection" "critically ill patients, control" +p_9960_5 "critically ill patients, sepsis gram-positive" "critically ill patients, sepsis gram-negative" +p_9973_1 Burkitt lymphoma (BL41) 60 min nt treated; time course BL41 60 min tc +p_9973_2 Burkitt lymphoma (BL41) 60 min p treated; time course BL41 60 min tc +p_9974_1 "SEG-1 cell line, OSU-HDAC42 pretreated, acid pulsed, 3 hr" "SEG-1 cell line, vehicle pretreated, acid pulsed, 3 hr" +p_9974_2 "SEG-1 cell line, OSU-HDAC42 pretreated, acid pulsed, 6 hr" "SEG-1 cell line, vehicle pretreated, acid pulsed, 6 hr" +p_9974_3 "SEG-1 cell line, OSU-HDAC42 pretreated, acid pulsed, 24 hr" "SEG-1 cell line, vehicle pretreated, acid pulsed, 24 hr" +p_9984_1 "placenta, second trimester" "placenta, First trimester" +p_9984_2 "placenta, C-section term" "placenta, First trimester" +p_9987_1 "SEG1 cell, OSU-HDAC42 treated, 3h" "SEG1 cell, vehicle treated, 3h" +p_9987_2 "SEG1 cell, OSU-HDAC42 treated, 6h" "SEG1 cell, vehicle treated, 6h" +p_9987_3 "SEG1 cell, OSU-HDAC42 treated, 24h" "SEG1 cell, vehicle treated, 24h" +p_9988_1 "monocyte, TREM1 antibody, 2hrs" "monocyte, isotype control antibody, 2hrs" +p_9988_2 "monocyte, LPS low, 2hrs" "monocyte, vehicle treated, 2hrs" +p_9988_3 "monocyte, TREM1 antibody+LPS, 2hrs" "monocyte, control antibody+LPS, 2hrs" + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + + \ No newline at end of file diff --git a/inst/extdata/FC1.rds b/inst/extdata/FC1.rds new file mode 100644 index 0000000..ba42bb9 Binary files /dev/null and b/inst/extdata/FC1.rds differ diff --git a/inst/extdata/FC10.rds b/inst/extdata/FC10.rds new file mode 100644 index 0000000..1854aa3 Binary files /dev/null and b/inst/extdata/FC10.rds differ diff --git a/inst/extdata/FC2.rds b/inst/extdata/FC2.rds new file mode 100644 index 0000000..8a37ada Binary files /dev/null and b/inst/extdata/FC2.rds differ diff --git a/inst/extdata/FC3.rds b/inst/extdata/FC3.rds new file mode 100644 index 0000000..252943e Binary files /dev/null and b/inst/extdata/FC3.rds differ diff --git a/inst/extdata/FC4.rds b/inst/extdata/FC4.rds new file mode 100644 index 0000000..e7c9ad4 Binary files /dev/null and b/inst/extdata/FC4.rds differ diff --git a/inst/extdata/FC5.rds b/inst/extdata/FC5.rds new file mode 100644 index 0000000..4fbd31f Binary files /dev/null and b/inst/extdata/FC5.rds differ diff --git a/inst/extdata/FC6.rds b/inst/extdata/FC6.rds new file mode 100644 index 0000000..b776e99 Binary files /dev/null and b/inst/extdata/FC6.rds differ diff --git a/inst/extdata/FC7.rds b/inst/extdata/FC7.rds new file mode 100644 index 0000000..554c902 Binary files /dev/null and b/inst/extdata/FC7.rds differ diff --git a/inst/extdata/FC8.rds b/inst/extdata/FC8.rds new file mode 100644 index 0000000..224c658 Binary files /dev/null and b/inst/extdata/FC8.rds differ diff --git a/inst/extdata/FC9.rds b/inst/extdata/FC9.rds new file mode 100644 index 0000000..00fe0e4 Binary files /dev/null and b/inst/extdata/FC9.rds differ diff --git a/inst/extdata/genelist.rds b/inst/extdata/genelist.rds new file mode 100644 index 0000000..640fbd1 Binary files /dev/null and b/inst/extdata/genelist.rds differ diff --git a/inst/extdata/miRNATargets.rds b/inst/extdata/miRNATargets.rds new file mode 100644 index 0000000..fea9999 Binary files /dev/null and b/inst/extdata/miRNATargets.rds differ diff --git a/inst/extdata/miRNAlist.rds b/inst/extdata/miRNAlist.rds new file mode 100644 index 0000000..a9fabcc Binary files /dev/null and b/inst/extdata/miRNAlist.rds differ diff --git a/man/PBE.Rd b/man/PBE.Rd new file mode 100644 index 0000000..0660890 --- /dev/null +++ b/man/PBE.Rd @@ -0,0 +1,25 @@ +% Generated by roxygen2: do not edit by hand +% Please edit documentation in R/biclust_extension_merging.R +\name{PBE} +\alias{PBE} +\title{Progressive bicluster extension} +\usage{ +PBE(MIR_profile, biclust_row, biclust_col, step_number, finalZR) +} +\arguments{ +\item{MIR_profile}{Binarized microRNA profile} + +\item{biclust_row}{List of index of row in seed biclust} + +\item{biclust_col}{List of index of columns in seed biclust} + +\item{step_number}{The number of extension process} + +\item{finalZR}{final zero rate allowed.} +} +\value{ +list of row and column symbols of extended bicluster +} +\description{ +Progressive bicluster extension +} diff --git a/man/PBE_MERGE.Rd b/man/PBE_MERGE.Rd new file mode 100644 index 0000000..8eed7f9 --- /dev/null +++ b/man/PBE_MERGE.Rd @@ -0,0 +1,32 @@ +% Generated by roxygen2: do not edit by hand +% Please edit documentation in R/biclust_extension_merging.R +\name{PBE_MERGE} +\alias{PBE_MERGE} +\title{Progressive extension and merging of biclusters} +\usage{ +PBE_MERGE(MIR_profile, mir, biclust.path = "./", FCcutoff = log2(1.3), + REPETITION = 10, STEP_NUMBER = 10, ZERORATE = 0.1, tree_cutoff = 0.5) +} +\arguments{ +\item{MIR_profile}{A matrix of microRNA profile where rows are cell conditions and columns are sequence-based miRNA targets.} + +\item{mir}{Name of microRNA} + +\item{biclust.path}{Directory where biclusts will be saved} + +\item{FCcutoff}{Log2-fold change binarization cutoff for seed. Default = log2(1.3)} + +\item{REPETITION}{The number of repetition that the ensemble function runs to extract seed biclusters. Default = 10} + +\item{STEP_NUMBER}{The number of extension process. Default = 10} + +\item{ZERORATE}{Final zero rate allowed. Default = 0.1} + +\item{tree_cutoff}{Similarity cutoff. Default = 0.5} +} +\value{ +Extended and merged biclusters in the directory assigned to ‘biclust.path’. +} +\description{ +Progressive extension and merging of biclusters +} diff --git a/man/bicluster_extension_process.Rd b/man/bicluster_extension_process.Rd new file mode 100644 index 0000000..d67da03 --- /dev/null +++ b/man/bicluster_extension_process.Rd @@ -0,0 +1,23 @@ +% Generated by roxygen2: do not edit by hand +% Please edit documentation in R/biclust_extension_merging.R +\name{bicluster_extension_process} +\alias{bicluster_extension_process} +\title{Bicluster extension process} +\usage{ +bicluster_extension_process(MIR_profile, seed_row, seed_col, zero_ratio) +} +\arguments{ +\item{MIR_profile}{A binarized microRNA profile} + +\item{seed_row}{List of a seed row index} + +\item{seed_col}{List of a seed column index} + +\item{zero_ratio}{Zero ratio to be allowed.} +} +\value{ +extended matrix +} +\description{ +Bicluster extension process +} diff --git a/man/bicluster_trimming_process.Rd b/man/bicluster_trimming_process.Rd new file mode 100644 index 0000000..58b7c45 --- /dev/null +++ b/man/bicluster_trimming_process.Rd @@ -0,0 +1,19 @@ +% Generated by roxygen2: do not edit by hand +% Please edit documentation in R/biclust_extension_merging.R +\name{bicluster_trimming_process} +\alias{bicluster_trimming_process} +\title{Bicluster trimming process} +\usage{ +bicluster_trimming_process(table, zero_ratio) +} +\arguments{ +\item{table}{A matrix that will be reduced} + +\item{zero_ratio}{Zero ratio allowed.} +} +\value{ +Reduced matrix +} +\description{ +Bicluster trimming process +} diff --git a/man/comatrix.Rd b/man/comatrix.Rd new file mode 100644 index 0000000..e4cc617 --- /dev/null +++ b/man/comatrix.Rd @@ -0,0 +1,19 @@ +% Generated by roxygen2: do not edit by hand +% Please edit documentation in R/biclust_extension_merging.R +\name{comatrix} +\alias{comatrix} +\title{Pariwise distance matrix for the entire list of biclusters} +\usage{ +comatrix(biclusts, MIR_profile) +} +\arguments{ +\item{biclusts}{Lists of biclusters.} + +\item{MIR_profile}{binarized microRNA profile} +} +\value{ +pariwise distance matrix +} +\description{ +Pariwise distance matrix for the entire list of biclusters +} diff --git a/man/expCondition.Rd b/man/expCondition.Rd new file mode 100644 index 0000000..cf79f30 --- /dev/null +++ b/man/expCondition.Rd @@ -0,0 +1,14 @@ +% Generated by roxygen2: do not edit by hand +% Please edit documentation in R/biclust_extension_merging.R +\name{expCondition} +\alias{expCondition} +\title{Get experimantal condition information} +\usage{ +expCondition() +} +\value{ +Experimental condition table +} +\description{ +Get experimantal condition information +} diff --git a/man/genelist.Rd b/man/genelist.Rd new file mode 100644 index 0000000..e83953b --- /dev/null +++ b/man/genelist.Rd @@ -0,0 +1,18 @@ +\name{genelist} +\alias{genelist} +\docType{data} +\title{A list of genes} +\description{This is a list of 20639 gene symbols from GPL570.} +\usage{data("genelist")} +\format{ + The format is: + chr "genelist" +} +\details{ [HG-U133_Plus_2] Affymetrix Human Genome U133 Plus 2.0 Array } +\source{ [HG-U133_Plus_2] Affymetrix Human Genome U133 Plus 2.0 Array } +\references{ [HG-U133_Plus_2] Affymetrix Human Genome U133 Plus 2.0 Array } +\examples{ +data(genelist) +## maybe str(genelist) ; plot(genelist) ... +} +\keyword{datasets} diff --git a/man/getAllmiRNATargetIndex.Rd b/man/getAllmiRNATargetIndex.Rd new file mode 100644 index 0000000..42d45a3 --- /dev/null +++ b/man/getAllmiRNATargetIndex.Rd @@ -0,0 +1,14 @@ +% Generated by roxygen2: do not edit by hand +% Please edit documentation in R/MIRprofile_from_FCtable.R +\name{getAllmiRNATargetIndex} +\alias{getAllmiRNATargetIndex} +\title{Load human miRNA target index} +\usage{ +getAllmiRNATargetIndex() +} +\value{ +A vector of human miRNA target index +} +\description{ +human miRNA target index +} diff --git a/man/getGenelist.Rd b/man/getGenelist.Rd new file mode 100644 index 0000000..76da18a --- /dev/null +++ b/man/getGenelist.Rd @@ -0,0 +1,14 @@ +% Generated by roxygen2: do not edit by hand +% Please edit documentation in R/MIRprofile_from_FCtable.R +\name{getGenelist} +\alias{getGenelist} +\title{Load human gene list} +\usage{ +getGenelist() +} +\value{ +A vector of 20,639 human genes +} +\description{ +20,639 human genes +} diff --git a/man/getMIRprofile.Rd b/man/getMIRprofile.Rd new file mode 100644 index 0000000..d4eeddf --- /dev/null +++ b/man/getMIRprofile.Rd @@ -0,0 +1,24 @@ +% Generated by roxygen2: do not edit by hand +% Please edit documentation in R/MIRprofile_from_FCtable.R +\name{getMIRprofile} +\alias{getMIRprofile} +\title{Get MIRprofile} +\usage{ +getMIRprofile(miRNA, FCtable = NULL, FCcutoff = log2(1.3)) +} +\arguments{ +\item{miRNA}{miRNA name. One of miRNAs listed in "miRNAlist" data.} + +\item{FCtable}{FC matrix of 20,639 genes for 5,158 conditions. If NULL, it will be loaded from the local.} + +\item{FCcutoff}{Fold change cutoff in log2 scale. Default = log2(1.3). To extract MIR profile for target down-regulation in test condition, take negative value.} +} +\value{ +A matrix of fold change value of sequence-based miRNA targets under selected cell conditions. +} +\description{ +Returns MIR profile for input miRNA. +} +\examples{ +fc=load_FCtable(); MIRprofile = getMIRprofile('hsa-miR-1-3p',fc,log2(1.3)) +} diff --git a/man/get_miR_target.Rd b/man/get_miR_target.Rd new file mode 100644 index 0000000..2c6684a --- /dev/null +++ b/man/get_miR_target.Rd @@ -0,0 +1,20 @@ +% Generated by roxygen2: do not edit by hand +% Please edit documentation in R/MIRprofile_from_FCtable.R +\name{get_miR_target} +\alias{get_miR_target} +\title{Get sequence-based miRNA targets} +\usage{ +get_miR_target(miRNA) +} +\arguments{ +\item{miRNA}{miRNA name. One of miRNAs listed in "miRNAlist" data.} +} +\value{ +A vector of sequence-based miRNA targets +} +\description{ +Returns miRNA targets predicted from three or more algorithms. +} +\examples{ +get_miR_target('hsa-miR-1-3p') +} diff --git a/man/get_zero_rate.Rd b/man/get_zero_rate.Rd new file mode 100644 index 0000000..4a92ef3 --- /dev/null +++ b/man/get_zero_rate.Rd @@ -0,0 +1,17 @@ +% Generated by roxygen2: do not edit by hand +% Please edit documentation in R/biclust_extension_merging.R +\name{get_zero_rate} +\alias{get_zero_rate} +\title{Get zero rate} +\usage{ +get_zero_rate(target) +} +\arguments{ +\item{target}{a matrix} +} +\value{ +The ratio of zero in a binarized matrix +} +\description{ +Get zero rate +} diff --git a/man/getmiRNAlist.Rd b/man/getmiRNAlist.Rd new file mode 100644 index 0000000..cfb8dca --- /dev/null +++ b/man/getmiRNAlist.Rd @@ -0,0 +1,14 @@ +% Generated by roxygen2: do not edit by hand +% Please edit documentation in R/MIRprofile_from_FCtable.R +\name{getmiRNAlist} +\alias{getmiRNAlist} +\title{Load human miRNA list} +\usage{ +getmiRNAlist() +} +\value{ +A vector of 2,632 human mature miRNAs +} +\description{ +human mature miRNA list +} diff --git a/man/load_FCtable.Rd b/man/load_FCtable.Rd new file mode 100644 index 0000000..c7ab05d --- /dev/null +++ b/man/load_FCtable.Rd @@ -0,0 +1,14 @@ +% Generated by roxygen2: do not edit by hand +% Please edit documentation in R/MIRprofile_from_FCtable.R +\name{load_FCtable} +\alias{load_FCtable} +\title{load_FCtable} +\usage{ +load_FCtable() +} +\value{ +A fold change matrix of 5,158 rows and 20,639 columns. +} +\description{ +Loading a large table of fold change values for 20,639 human genes in 5,158 cell conditions. +} diff --git a/man/make_biclust.Rd b/man/make_biclust.Rd new file mode 100644 index 0000000..48aacae --- /dev/null +++ b/man/make_biclust.Rd @@ -0,0 +1,25 @@ +% Generated by roxygen2: do not edit by hand +% Please edit documentation in R/biclust_extension_merging.R +\name{make_biclust} +\alias{make_biclust} +\title{Make all biclusters} +\usage{ +make_biclust(MIR_PROFILE, FCcutoff, REPETITION, STEP_NUMBER, ZERORATE) +} +\arguments{ +\item{MIR_PROFILE}{A matrix of MIR profile.} + +\item{FCcutoff}{Binarization fold change cutoff in log2-scale for MIR_PROFILE. Target up-regulation biclusters will be created for positive FC cutoff, and down-regulation biclusters will be generated with negative FC cutoff.} + +\item{REPETITION}{The number of running ensemble bicluster function.} + +\item{STEP_NUMBER}{The number of extension process} + +\item{ZERORATE}{Final zero rate allowed.} +} +\value{ +list of seed and biclusters +} +\description{ +Make all biclusters +} diff --git a/man/merge.Rd b/man/merge.Rd new file mode 100644 index 0000000..9a4dd7c --- /dev/null +++ b/man/merge.Rd @@ -0,0 +1,25 @@ +% Generated by roxygen2: do not edit by hand +% Please edit documentation in R/biclust_extension_merging.R +\name{merge} +\alias{merge} +\title{Merging similar biclusters} +\usage{ +merge(cut, biclusts, i, MIR_profile, ZERORATE) +} +\arguments{ +\item{cut}{A vector of bicluster classificatino} + +\item{biclusts}{List of Biclusters to be merged} + +\item{i}{iteration} + +\item{MIR_profile}{Binarized microRNA profile} + +\item{ZERORATE}{Final zero ratio allowed.} +} +\value{ +merged biclusters +} +\description{ +Merging similar biclusters +} diff --git a/man/merge_bicluster.Rd b/man/merge_bicluster.Rd new file mode 100644 index 0000000..9da61e7 --- /dev/null +++ b/man/merge_bicluster.Rd @@ -0,0 +1,30 @@ +% Generated by roxygen2: do not edit by hand +% Please edit documentation in R/biclust_extension_merging.R +\name{merge_bicluster} +\alias{merge_bicluster} +\title{Merging similar biclusters} +\usage{ +merge_bicluster(MIR_profile, tree_cutoff = 0.5, biclusts, seedlist, + FCcutoff = log2(1.3), mir = "testmiRNA", ZERORATE) +} +\arguments{ +\item{MIR_profile}{binarized microRNA profile} + +\item{tree_cutoff}{Similarity cutoff} + +\item{biclusts}{list of extended biclusters} + +\item{seedlist}{list of seeds} + +\item{FCcutoff}{Fold change cutoff (in log2 sclale) for binarization of MIR profile} + +\item{mir}{Name of miRNA} + +\item{ZERORATE}{Final zero ratio allowed} +} +\value{ +Extended bicluster list +} +\description{ +Merging similar biclusters +} diff --git a/man/miRNATargets.Rd b/man/miRNATargets.Rd new file mode 100644 index 0000000..a8cc58d --- /dev/null +++ b/man/miRNATargets.Rd @@ -0,0 +1,18 @@ +\name{miRNATargets} +\alias{miRNATargets} +\docType{data} +\title{miRNA binding targets} +\description{These microRNA target candidates were predicted from 3 or more prediction database.} +\usage{data("miRNATargets")} +\format{ + The format is: + chr "miRNATargets" +} +\details{Each number represents the gene. Corresponding gene symbols exist in 'genelist' data.} +\source{Seven miRNA target prediction database. DIANA-microt-CDS, miRanda-microCosm, mirSVR, miRTargets, TargetRank, PITA, TargetScan} +\references{Seven miRNA target prediction database. DIANA-microt-CDS, miRanda-microCosm, mirSVR, miRTargets, TargetRank, PITA, TargetScan} +\examples{ +data(miRNATargets) +## maybe str(miRNATargets); ... +} +\keyword{datasets} diff --git a/man/miRNAlist.Rd b/man/miRNAlist.Rd new file mode 100644 index 0000000..e6c9ba9 --- /dev/null +++ b/man/miRNAlist.Rd @@ -0,0 +1,18 @@ +\name{miRNAlist} +\alias{miRNAlist} +\docType{data} +\title{A list of microRNAs} +\description{These are a list of microRNA names.} +\usage{data("miRNAlist")} +\format{ + The format is: + chr "miRNAlist" +} +\details{List of 2632 microRNAs.} +\source{This data was obtained from miRBase.} +\references{This data was obtained from miRBase.} +\examples{ +data(miRNAlist) +## maybe str(miRNAlist) ; plot(miRNAlist) ... +} +\keyword{datasets} diff --git a/man/similarity.Rd b/man/similarity.Rd new file mode 100644 index 0000000..a3d2a44 --- /dev/null +++ b/man/similarity.Rd @@ -0,0 +1,19 @@ +% Generated by roxygen2: do not edit by hand +% Please edit documentation in R/biclust_extension_merging.R +\name{similarity} +\alias{similarity} +\title{Calculate similarity of two biclusters} +\usage{ +similarity(biclust1, biclust2) +} +\arguments{ +\item{biclust1}{First bicluster matrix} + +\item{biclust2}{Second bicluster matrix} +} +\value{ +Similarity of two biclusters +} +\description{ +Calculate similarity of two biclusters +} diff --git a/man/size.Rd b/man/size.Rd new file mode 100644 index 0000000..8f0b035 --- /dev/null +++ b/man/size.Rd @@ -0,0 +1,17 @@ +% Generated by roxygen2: do not edit by hand +% Please edit documentation in R/biclust_extension_merging.R +\name{size} +\alias{size} +\title{Get matrix size} +\usage{ +size(target) +} +\arguments{ +\item{target}{a matrix} +} +\value{ +The size of input matrix +} +\description{ +Get matrix size +}